repo_id
stringlengths
21
96
file_path
stringlengths
31
155
content
stringlengths
1
92.9M
__index_level_0__
int64
0
0
rapidsai_public_repos/code-share/maxflow/galois/apps/avi/libElm
rapidsai_public_repos/code-share/maxflow/galois/apps/avi/libElm/libShape/Linear.h
/** * Linear.h: a set of linear shape functions * DG++ * * Created by Adrian Lew on 9/4/06. * * Copyright (c) 2006 Adrian Lew * * 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 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. */ #ifndef LINEAR #define LINEAR #include "Shape.h" /** \brief set of linear shape functions in SPD dimensions The linear shape functions in SPD dimensions are precisely the barycentric coordinates of a point in the simplex defined by SPD+1 points. Since quadrature points are often expressed in baricentric coordinates, this class was implemented to take the SPD+1 barycentric coordinates of a point as arguments only. Since barycentric coordinates are linearly dependent, the class chooses SPD coordinates as arguments of the shape functions. This choice is made by shuffling the coordinates so that the first SPD coordinates are the linearly independent ones. The possibility of shuffling becomes useful, for example, in tetrahedra. Without shuffling the class would have \f[ N_a(\lambda_0,\lambda_1,\lambda_2), \qquad a=0,1,2,3 \f] and the derivatives of the shape function with respect to the same arguments. With a shuffling of the form \f$(\lambda_0,\lambda_1,\lambda_2,\lambda_3)\f$ to \f$(\lambda_0,\lambda_1,\lambda_3,\lambda_2)\f$ it is possible to have \f[ N_a(\lambda_0,\lambda_1,\lambda_3), \qquad a=0,1,2,3. \f] The derivatives returned here, are clearly different that in the previous case. The reason that this is useful is that these derivatives are precisely the derivatives with respect to the Cartesian coordinates of the shape functions in a standard parametric tet ( with vertices at (1,0,0), (0,1,0), (0,0,0), (0,0,1) ) */ template <size_t SPD> class Linear: public Shape { public: //! Constructor \n //! \param iMap Shuffle of the barycentric coordinates. iMap[a] returns the position of the original //! a-th barycentric coordinate after shuffling. //! If not provided, an identity mapping is assumed iMap[a]=a //! \warning No way to know if iMap has the proper length. Linear (const size_t * iMap = 0); inline virtual ~Linear () {} Linear (const Linear<SPD> &); virtual inline Linear<SPD> * clone () const { return new Linear<SPD> (*this); } // Accessors/Mutators inline size_t getNumFunctions () const { return SPD + 1; } inline size_t getNumVariables () const { return SPD; } // Functionality //! @param a shape function number //! @param x first SPD barycentric coordinates of the point //! \warning Does not check range for parameter a double getVal (size_t a, const double *x) const; //! @param a shape function number //! @param x first spartial_dimension barycentric coordinates of the point //! @param i partial derivative number //! Returns derivative with respect to the barycentric coordinates //! \warning Does not check range for parameters a and i double getDVal (size_t a, const double *x, size_t i) const; private: size_t bctMap[SPD + 1]; }; template<size_t SPD> Linear<SPD>::Linear (const size_t * iMap) { for (size_t a = 0; a < SPD + 1; a++) bctMap[a] = a; if (iMap != 0) { for (size_t a = 0; a < SPD + 1; a++) { bctMap[a] = iMap[a]; } } return; } template<size_t SPD> Linear<SPD>::Linear (const Linear<SPD> &Lin) { for (size_t a = 0; a < SPD + 1; a++) { bctMap[a] = Lin.bctMap[a]; } } template<size_t SPD> double Linear<SPD>::getVal (size_t a, const double *x) const { if (bctMap[a] != SPD) { return x[bctMap[a]]; } else { double va = 0; for (size_t k = 0; k < SPD; k++) { va += x[k]; } return 1 - va; } } template<size_t SPD> double Linear<SPD>::getDVal (size_t a, const double *x, size_t i) const { if (bctMap[a] != SPD) { return bctMap[a] == i ? 1 : 0; } else { return -1; } } #endif
0
rapidsai_public_repos/code-share/maxflow/galois/apps/avi/libElm
rapidsai_public_repos/code-share/maxflow/galois/apps/avi/libElm/libShape/Shape.h
/** * Shape.h * DG++ * * Created by Adrian Lew on 9/4/06. * * Copyright (c) 2006 Adrian Lew * * 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 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. */ #ifndef SHAPE #define SHAPE #include <cstddef> /** \brief base class for any set of basis (or shape) functions and its first derivatives A set of basis functions permits the evaluation of any of the functions in the basis at any point Notice that two Shape classes differ if they span the same space but have different bases. */ class Shape { public: inline Shape () {} inline virtual ~Shape () {} inline Shape (const Shape &) {} virtual Shape * clone () const = 0; // Accessors/Mutators virtual size_t getNumFunctions () const = 0; virtual size_t getNumVariables () const = 0; //!< Number of arguments of the functions //! Value of shape \f$N_a(x)\f$ //! @param a node id //! @param x coordinates of the point x //! //! We have purposedly left the type of coordinates the point should have unspecified, for flexibility. //! Barycentric and Cartesian coordinates are adopted thoughout the code. //! //! \todo It'd be nice to have some form of Coordinate object, which may derive Barycentric and Cartesian //! coordinates, and that would guarantee that the argument to each function is always the correct one. virtual double getVal (size_t a, const double *x) const = 0; //! Value of \f$\frac{\partial N_a}{\partial x_i}(x)\f$ //! @param a node id //! @param x coordinates of the point a //! @param i coordinate number //! //! We have purposedly left the type of coordinates the point should have unspecified, for flexibility. //! Barycentric and Cartesian coordinates are adopted thoughout the code. virtual double getDVal (size_t a, const double *x, size_t i) const = 0; //! Consistency test for getVal and getDVal //! @param x coordinates of the point at which to test //! @param Pert size of the perturbation with which to compute numerical //! derivatives (x->x+Pert) bool consistencyTest (const double *x, const double Pert) const; }; #endif
0
rapidsai_public_repos/code-share/maxflow/galois/apps/avi/libElm/libShape
rapidsai_public_repos/code-share/maxflow/galois/apps/avi/libElm/libShape/test/testLinear.cpp
/* * testLinear.cpp * DG++ * * Created by Adrian Lew on 9/9/06. * * Copyright (c) 2006 Adrian Lew * * 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 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 "Linear.h" #include <iostream> int main() { /* 2D test */ double coord2[] = {0.1,0.8}; Linear<2> Linear2D; std::cout << Linear2D.getNumberOfFunctions() << " should be " << 3 << "\n"; std::cout << Linear2D.getNumberOfVariables() << " should be " << 2 << "\n"; if(Linear2D.consistencyTest(coord2,1.e-6)) std::cout << "Consistency test successful" << "\n"; else std::cout << "Consistency test failed" << "\n"; std::cout << "Copy Constructor\n"; Linear<2> Linear2DCopy(Linear2D); double flag = 0; for(int a=0; a<Linear2D.getNumberOfFunctions(); a++) if(Linear2DCopy.Val(a,coord2) != Linear2D.Val(a,coord2)) flag = 1; if(flag) std::cout << "Copy constructor failed" << "\n"; else std::cout << "Copy constructor successful" << "\n"; std::cout << "Cloning and virtual mechanisms\n"; Shape *Linear2DClone = Linear2D.clone(); for(int a=0; a<Linear2D.getNumberOfFunctions(); a++) if(Linear2DClone->getVal(a,coord2) != Linear2D.Val(a,coord2)) flag = 1; if(flag) std::cout << "Cloning failed" << "\n"; else std::cout << "Cloning successful" << "\n"; /* 3D test */ std::cout << "3D test\n"; double coord3[] = {1.2, 0.1, -0.4}; Linear<3> Linear3D; std::cout << Linear3D.getNumberOfFunctions() << " should be " << 4 << "\n"; std::cout << Linear3D.getNumberOfVariables() << " should be " << 3 << "\n\n"; if(Linear3D.consistencyTest(coord3,1.e-6)) std::cout << "Consistency test successful" << "\n"; else std::cout << "Consistency test failed" << "\n"; }
0
rapidsai_public_repos/code-share/maxflow/galois/apps/avi
rapidsai_public_repos/code-share/maxflow/galois/apps/avi/libAVI/StandardAVI.cpp
/* * AVI.h * DG++ * * Created by Mark Potts on 3/25/09. * * Copyright (c) 2009 Adrian Lew * * 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 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 "StandardAVI.h" #include "util.h" bool StandardAVI::gather ( const LocalToGlobalMap& L2G, const VecDouble& Qval, const VecDouble& Vval, const VecDouble& Vbval, const VecDouble& Tval, MatDouble& q, MatDouble& v, MatDouble& vb, MatDouble& ti) const { // double *Q, *V, *Vb, *T; // // VecGetArray (Qval,& Q); // VecGetArray (Vval,& V); // VecGetArray (Vbval,& Vb); // VecGetArray (Tval,& T); if (q.size () < nfields) q.resize (nfields); if (v.size () < nfields) v.resize (nfields); if (vb.size () < nfields) vb.resize (nfields); if (ti.size () < nfields) ti.resize (nfields); for (size_t f = 0; f < nfields; f++) { size_t fieldDof = getFieldDof (f); if (q[f].size () < fieldDof) q[f].resize (fieldDof); if (v[f].size () < fieldDof) v[f].resize (fieldDof); if (vb[f].size () < fieldDof) vb[f].resize (fieldDof); if (ti[f].size () < fieldDof) ti[f].resize (fieldDof); for (size_t a = 0; a < fieldDof; a++) { size_t index = L2G.map (f, a, this->globalIdx); q[f][a] = Qval[index]; v[f][a] = Vval[index]; vb[f][a] = Vbval[index]; ti[f][a] = Tval[index]; } } // VecRestoreArray (Qval,& Q); // VecRestoreArray (Vval,& V); // VecRestoreArray (Vbval,& Vb); // VecRestoreArray (Tval,& T); return (true); } void StandardAVI::computeLocalTvec (MatDouble& tnew) const { assert (tnew.size () == nfields); for (size_t f = 0; f < nfields; f++) { size_t fieldDof = getFieldDof (f); assert (tnew[f].size () == fieldDof); for (size_t a = 0; a < fieldDof; a++) { tnew[f][a] = getNextTimeStamp (); } } } bool StandardAVI::assemble (const LocalToGlobalMap& L2G, const MatDouble& qnew, const MatDouble& vnew, const MatDouble& vbnew, const MatDouble& tnew, VecDouble& Qval, VecDouble& Vval, VecDouble& Vbval, VecDouble& Tval, VecDouble& LUpdate) const { // double * resvals = new double[localsize]; // double * vvals = new double[localsize]; // double * vbvals = new double[localsize]; // double * tvals = new double[localsize]; // size_t * indices = new size_t[localsize]; // double * updates = new double[localsize]; for (size_t f = 0, i = 0; f < nfields; f++) { for (size_t a = 0; a < getFieldDof (f); a++, i++) { size_t index = L2G.map (f, a, globalIdx); Qval[index] = qnew[f][a]; Vval[index] = vnew[f][a]; Vbval[index] = vbnew[f][a]; Tval[index] = tnew[f][a]; LUpdate[index] = (double) globalIdx; } } // VecSetValues (*Qval, localsize, indices, resvals, INSERT_VALUES); // VecSetValues (*Vval, localsize, indices, vvals, INSERT_VALUES); // VecSetValues (*Vbval, localsize, indices, vbvals, INSERT_VALUES); // VecSetValues (*Tval, localsize, indices, tvals, INSERT_VALUES); // VecSetValues (*LUpdate, localsize, indices, updates, INSERT_VALUES); // delete[] resvals; // delete[] vvals; // delete[] vbvals; // delete[] tvals; // delete[] indices; // delete[] updates; return (true); } bool StandardAVI::update (const MatDouble& q, const MatDouble& v, const MatDouble& vb, const MatDouble& ti, const MatDouble& tnew, MatDouble& qnew, MatDouble& vnew, MatDouble& vbnew, MatDouble& forcefield, MatDouble& funcval, MatDouble& deltaV ) const { for (size_t f = 0; f < nfields; f++) { for (size_t a = 0; a < getFieldDof (f); a++) { #if 0 if(imposedFlags[f][a] == true) { qnew[f][a]=imposedValues[f][a]; } else { qnew[f][a]=q[f][a] + (getNextTimeStamp() - ti[f][a]) * vb[f][a]; } #else if (imposedTypes[f][a] == ONE) { double t = ti[f][a]; qnew[f][a] = ((avi_bc_func)[a]) (f, a, t); } else { qnew[f][a] = q[f][a] + (tnew[f][a] - ti[f][a]) * vb[f][a]; } #endif } } // MatDouble funcval (nfields); getForceField (qnew, forcefield); if (funcval.size () != nfields) { funcval.resize (nfields); } for (size_t f = 0; f < nfields; f++) { size_t fieldDof = getFieldDof (f); if (funcval[f].size () != fieldDof) { funcval[f].resize (fieldDof); } for (size_t a = 0; a < fieldDof; a++) { funcval[f][a] = -(getTimeStep ()) * (forcefield)[f][a]; } } // MatDouble DeltaV; computeDeltaV (funcval, deltaV); for (size_t f = 0; f < nfields; f++) { for (size_t a = 0; a < getFieldDof (f); a++) { if (imposedTypes[f][a] == ZERO) { vnew[f][a] = vb[f][a] + deltaV[f][a] / 2.0; vbnew[f][a] = vb[f][a] + deltaV[f][a]; } else if (imposedTypes[f][a] == ONE) { vnew[f][a] = 0.0; vbnew[f][a] = 0.0; } else if (imposedTypes[f][a] == TWO) { double t = ti[f][a]; vnew[f][a] = ((avi_bc_func)[a]) (f, a, t); vbnew[f][a] = ((avi_bc_func)[a]) (f, a, t); } } } // XXX (amber) Commented, must make explicit call to incTimeStamp in main loop // setTimeStamp (getNextTimeStamp ()); return (true); } bool StandardAVI::vbInit ( const MatDouble& q, const MatDouble& v, const MatDouble& vb, const MatDouble& ti, const MatDouble& tnew, MatDouble& qnew, MatDouble& vbinit, MatDouble& forcefield, MatDouble& funcval, MatDouble& deltaV ) const { // MatDouble qnew; // qnew.resize ((q).size ()); assert (qnew.size () == q.size ()); for (size_t f = 0; f < nfields; f++) { assert (qnew[f].size () == q[f].size ()); for (size_t a = 0; a < getFieldDof (f); a++) { if (imposedFlags[f][a] == true) { qnew[f][a] = imposedValues[f][a]; } else { qnew[f][a] = (q)[f][a] + (tnew[f][a] - ti[f][a]) / 2.0 * vb[f][a]; } } } getForceField ((qnew), forcefield); #ifdef DEBUG std::cerr << "forcefield = "; for (size_t f = 0; f < nfields; ++f) { printIter(std::cerr, forcefield[f].begin(), forcefield[f].end()); } #endif // MatDouble funcval (nfields); if (funcval.size () != nfields) { funcval.resize (nfields); } for (size_t f = 0; f < nfields; f++) { size_t fieldDof = getFieldDof (f); if (funcval[f].size () != fieldDof) { funcval[f].resize (fieldDof); } for (size_t a = 0; a < fieldDof; a++) { funcval[f][a] = -(getTimeStep ()) * (forcefield)[f][a]; } } // MatDouble DeltaV; computeDeltaV (funcval, deltaV); #ifdef DEBUG std::cerr << "funcval = "; for (size_t f = 0; f < nfields; ++f) { printIter(std::cerr, funcval[f].begin(), funcval[f].end()); } std::cerr << "DeltaV = "; for (size_t f = 0; f < nfields; ++f) { printIter(std::cerr, DeltaV[f].begin(), DeltaV[f].end()); } #endif for (size_t f = 0; f < nfields; f++) { for (size_t a = 0; a < getFieldDof (f); a++) { vbinit[f][a] = (vb[f][a] + deltaV[f][a] / 2.0); } } return (true); } void StandardAVI::computeDeltaV(const MatDouble& funcval, MatDouble& DeltaV) const { if(DeltaV.size()<nfields) { DeltaV.resize(nfields); } for(size_t f=0;f<nfields;f++) { size_t fieldDof = getFieldDof (f); if(DeltaV[f].size() < fieldDof) { DeltaV[f].resize (fieldDof); } for(size_t a=0;a<fieldDof;a++) { DeltaV[f][a] = funcval[f][a]/(MMdiag[f][a]); } } } bool StandardAVI::getImposedValues (const GlobalElementIndex& ElementIndex, const LocalToGlobalMap& L2G, size_t field, size_t dof, double& qvalue, double& vvalue) const { if (imposedFlags[field][dof] == true) { qvalue = imposedValues[field][dof]; vvalue = 0.0; //this needs to be re-worked return (true); } else { return (false); } } void StandardAVI::setBCs (const MatBool& IFlag, const MatDouble& IVal) { if (imposedFlags.size () != IFlag.size ()) { imposedFlags.resize (IFlag.size ()); } if (imposedValues.size () != IVal.size ()) { imposedValues.resize (IVal.size ()); } for (size_t f = 0; f < IFlag.size (); f++) { if (imposedFlags[f].size () != IFlag[f].size ()) { imposedFlags[f].resize (IFlag[f].size ()); } if (imposedValues[f].size () != IVal[f].size ()) { imposedValues[f].resize (IVal[f].size ()); } for (size_t a = 0; a < IFlag[f].size (); a++) { imposedValues[f][a] = IVal[f][a]; imposedFlags[f][a] = IFlag[f][a]; } } } void StandardAVI::setDiagVals (const VecDouble& MassVec, const LocalToGlobalMap& L2G, const GlobalElementIndex& elem_index) { size_t localsize = 0; // double *MMVec; // // VecGetArray (MassVec,& MMVec); const VecDouble& MMVec = MassVec; MMdiag.resize (getFields ().size ()); for (size_t f = 0; f < getFields ().size (); f++) { size_t fieldDof = getFieldDof (f); localsize += fieldDof; MMdiag[f].resize (fieldDof, 0.); for (size_t a = 0; a < fieldDof; a++) { MMdiag[f][a] = MMVec[L2G.map (f, a, elem_index)]; } } #ifdef DEBUG std::cerr << "MMdiag = " << std::endl; for (size_t f = 0; f < getFields().size(); ++f) { printIter (std::cerr, MMdiag[f].begin(), MMdiag[f].end()); } #endif // VecRestoreArray (MassVec,& MMVec); } /* void StandardAVI::print(const MatDouble& q) { for(size_t f=0;f < nfields; f++) { for(size_t a=0;a < getFieldDof(f); a++) { printf("elem %d, q[%d][%d] = %f \n",elem_index,f,a,q[f][a]); } } }; void StandardAVI::print(void) const { printf("elem %d, update time = %f \n",elem_index,getNextTimeStamp()); }; void StandardAVI::print_vals(void) const { size_t myid; MPI_Comm_rank(MPI_COMM_WORLD,& myid); printf("myid = %d, elem = %d, timeStep = %e, update_time = %e\n", myid,elem_index,timeStep,timeStamp); printf("connectivity = "); for(size_t i = 0; i < operation->getElement(). getGeometry().getConnectivity().size(); i++) { printf("%d ",operation->getElement().getGeometry().getConnectivity()[i]); } printf("\n"); for(size_t i = 0; i < MMdiag.size(); i++) { for(size_t j = 0; j < MMdiag[i].size(); j++) printf("%e ",MMdiag[i][j]); printf("\n"); } }; */
0
rapidsai_public_repos/code-share/maxflow/galois/apps/avi
rapidsai_public_repos/code-share/maxflow/galois/apps/avi/libAVI/AVI.h
/** * AVI.h * DG++ * * Created by Adrian Lew on 9/23/08. * * Copyright (c) 2008 Adrian Lew * * 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 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. */ #ifndef AVI_CLASS #define AVI_CLASS #include <vector> #include <list> #include <queue> #include <string> #include <sstream> #include <iostream> #include <cstdio> #include <cassert> #include <cmath> #include <cstring> #include "AuxDefs.h" #include "ElementalOperation.h" #include "DiagonalMassForSW.h" #include "StressWork.h" #include "util.h" /** \brief AVI: abstract base class for AVI An AVI object consists of: 1) A force field \f$f_a(q_1,\ldots,q_N,t)\f$, where \f$q_a\f$ are degrees of freedom, and \f$f_a\f$ is the force acting on degree of freedom "a".\n 2) A mass matrix for the degrees of freedom of the potential. \n 3) A time step \n 4) The last time at which the force field was updated\n 5) The last time each degree of freedom was updated\n The AVI class assumes that there exists four provided global arrays, accessed through a LocalToGlobalMap: 1) An array Qval with the value of each degree of freedom at its last update, \f$q_a^{i-1}\f$\n 2) An array Vval with the latest value of the time derivative of the degrees of freedom at its last update, \f$v_a^{i-1}\f$.\n 3) An array Vbval with the latest value of the time derivative of the degree of freedom at the middle of a time step, \f$v_a^{i-1/2}\f$.\n 4) An array Tval with the last time at which a degree of freedom was updated, \f$t_a^{i-1}\f$. Given \f$q_a^{i-1}\f$, \f$v_a^{i-1/2}\f$ and \f$t_a^{i-1}\f$, the class computes \f$q_a^i\f$, \f$v_a^i\f$ and \f$v_a^{i+1/2}\f$ for each degree of freedom of the object's force field. It also updates the values of \f$t_a^i\f$ and the objects latest time. The update is as follows: If \f$q_a\f$ does not have imposed values \f$q_a(t)\f$ (e.g., Dirichlet bounday conditions), then 1) Compute \f$q_a^i = q_a^{i-1} + (t-t_a^i) v_a^{i-1/2}\f$ for each \f$a\f$, where \f$t\f$ is the current time of the object.\n 2) Solve \f$ M_{ab} \Delta v_b = - \Delta t f_a(q_a^i)\f$ for \f$\Delta v_b\f$, where \f$f_a(t)\f$ is the force on node \f$a\f$ by the force field in the object computed with \f$q_a^i\f$.\n 3) Compute \f$ v_a^i = v_a^{i-1/2} + \Delta v_b/2\f$\n 4) Compute \f$ v_a^{i+1/2} = v_a^{i-1/2} + \Delta v_b\f$ Else, set \f$q_a^i=q_a(t_a^i)\f$, \f$v_a^i=\dot{q}_a(t_a^i)\f$ and \f$v_a^{i+1/2}\f$ is defined to any value, it is not guaranteed to have any meaning. The class also has an initialization procedure to compute the initial values of \f$v_a^{1/2}\f$. Following the convention elsewhere in the code, degrees of freedom are labeled with field number f and degree of freedom number for that field, b. Even thought it is not the most natural numbering in the context of ODEs, it simplifies the communication with the rest of the code. Field and degree of freedom numbers begin from zero. The class separates the update process into three different functions: gather, update, assemble. In this way more flexibility is provided to be able to work with force fields that depend, perhaps, on sets of internal variables that are not necessarily updated with AVI. Imposed values need to be provided separately. A virtual procedure is constructed to this end. \todo The update routine does not take further arguments that may not need to be updated but may be needed to compute the force field, such as when dealing with plasticity or a coupled heat conduction problem. We will need to deal with this eventually. */ class AVI { protected: double timeStamp; double timeStep; public: AVI (double timeStamp): timeStamp(timeStamp) { } virtual ~AVI () { } virtual AVI * clone () const = 0; // virtual int getElemIndex(void) const = 0; //! Returns the current value of the time step for the potential double getTimeStep () const { return timeStep; } //! Returns the last time at which the force field was updated double getTimeStamp () const { return timeStamp; } //! set the last update time. Returns true upon success. \n //! //! @param timeval value of the last update time bool setTimeStamp (double timeval) { assert (timeval >= 0.0); timeStamp = timeval; return true; } //! Returns the next time at which the force field will be updated double getNextTimeStamp () const { return getTimeStamp() + getTimeStep(); } //! increment the time stamp void incTimeStamp () { setTimeStamp(getNextTimeStamp()); } //! Returns the field numbers used whose degrees of freedom participate in the force field computation //! //! getFields()[i] returns the field number beginning from zero.\n //! If the degree of freedom \f$q_a\f$ is indexed with [f][b] locally, then it corresponds to field //! getFields()[f] in the Global arrays. virtual const std::vector<size_t>& getFields () const = 0; //! Returns the number of degrees of freedom per field used //! for the computation \n //! //! getFieldDof(fieldnum) returns the number of deegrees of freedom //! in the participating field number "fieldnumber". The argument //! fieldnumber begins from zero.\n // virtual size_t getFieldDof (size_t fieldnumber) const = 0; //! Returns the global element index for the AVI object virtual size_t getGlobalIndex (void) const = 0; virtual const DResidue& getOperation () const = 0; virtual const Element& getElement () const = 0; virtual const ElementGeometry& getGeometry () const = 0; //! write the updated time vector into the argument provided //! value filled in is the one obtained from getNextTimeStamp () //! @param tnew virtual void computeLocalTvec (MatDouble& tnew) const = 0; //! Initialization routine to set values at the half time step //! This function is called only once per element and is called after gather //! and before update and assemble. //! @param q used to calculate the velocity at the half step. //! local vector with the last known values of the degrees of freedom, \f$q_a^{i-1}\f$ in //! the notation above. \n //! @param v previous values of the time derivatives of velocity //! @param vb previous values of the time derivatives at the //! middle of a time step //! of the degrees of freedom, \f$v_a^{i-1/2}\f$ in the notation above.\n //! @param ti local vector with the last update time of a the degrees of freedom, //! \f$t_a^{i-1}\f$ in the notation above.\n //! //! @param tnew updated local time vector @see AVI::computeLocalTvec () //! @param qnew updated value of q vector //! @param vbinit initialized value of vb vector //! @param forcefield temporary intermediate vector //! @param funcval temporary intermediate vector //! @param deltaV temporary intermediate vector //! For example, q[f][b] = Q[L2G.map(ElementIndex,getFields()[f],b)] //! //! This function uses getImposedValues to fill the imposed values arrays. virtual bool vbInit ( const MatDouble& q, const MatDouble& v, const MatDouble& vb, const MatDouble& ti, const MatDouble& tnew, MatDouble& qnew, MatDouble& vbinit, MatDouble& forcefield, MatDouble& funcval, MatDouble& deltaV ) const = 0; //! Computes the value of the force field at a given configuration. Returns true upon success. //! //! @param argval values of the degrees of freedom for the force field of the object. //! argval[f][a] contains the value of the degree of freedom indexed with field "f" //! and degree of freedom number in that field "a". //! //! @param forcefield values of \f$f_b\f$ upon exit. forcefield[f][a] contains the value //! of \f$f_b\f$ for the degree of freedom indexed with field "f" and degree of //! freedom number in that field "a". virtual bool getForceField (const MatDouble& argval, MatDouble& forcefield) const = 0; //! update of the given forcefield. It returns the new values for the degrees of freedom //! and its time derivatives. These need yet to be assembled. Returns true upon success. //! //! The forcefield time is updated. Of course, this does not happen with the last update time of each //! degree of freedom, which are updated in the assemble part. //! //! In the following vectors, index [f][b] indicates the value for the "b"-th degree of freedom //! of field "f". //! //! @param q vector with the last known values of the degrees of freedom, \f$q_a^{i-1}\f$ in //! the notation above. \n //! @param v vector with the last known values of the time derivatives of the degrees of freedom, //! \f$v_a^{i-1}\f$ in the notation above.\n //! @param vb vector with the last known values of the time derivatives at the middle of a time step //! of the degrees of freedom, \f$v_a^{i-1/2}\f$ in the notation above.\n //! @param ti vector with the last update time of a the degrees of freedom, \f$t_a^{i-1}\f$ in //! the notation above.\n //! @param tnew vector with the updated time of a the degrees of freedom, \f$t_a^{i}\f$ in //! @param qnew Upon exit, new values of the degrees of freedom, \f$q_a^{i}\f$ in //! the notation above.\n //! @param vnew Upon exit, new values of the time derivatives of the degrees of freedom, //! \f$v_a^{i}\f$ in the notation above.\n //! @param vbnew Upon exit, new values of the time derivatives at the middle of a time step //! of the degrees of freedom, \f$v_a^{i+1/2}\f$ in the notation above.\n //! //! @param forcefield temporary intermediate vector //! @param funcval temporary intermediate vector //! @param deltaV temporary intermediate vector //! virtual bool update ( const MatDouble& q, const MatDouble& v, const MatDouble& vb, const MatDouble& ti, const MatDouble& tnew, MatDouble& qnew, MatDouble& vnew, MatDouble& vbnew, MatDouble& forcefield, MatDouble& funcval, MatDouble& deltaV ) const = 0; //! Gathers the values needed from the global arrays to perform the force field computation. //! //! //! identify its global degrees of freedom. This information is not embedded in the object. \n //! @param L2G Local to Global map used to find the values in the Global arrays\n //! @param Qval Global array with the last updated values of the degrees of freedom.\n //! @param Vval Global array with the last updated values of the time derivatives of the //! degrees of freedom.\n //! @param Vbval Global array with the last updated values of the time derivatives of the //! degrees of freedom at the middle of the time step.\n //! @param Tval Global array with the times at which the degrees of freedom were last updated.\n //! @param q Upon exit, local vector with the last known values of the degrees of freedom, \f$q_a^{i-1}\f$ in //! the notation above. \n //! @param v Upon exit, local vector with the last known values of the time derivatives of the //! degrees of freedom, //! \f$v_a^{i-1}\f$ in the notation above.\n //! @param vb Upon exit, local vector with the last known values of the time derivatives at the //! middle of a time step //! of the degrees of freedom, \f$v_a^{i-1/2}\f$ in the notation above.\n //! @param ti Upon exit, local vector with the last update time of a the degrees of freedom, //! \f$t_a^{i-1}\f$ in the notation above.\n //! //! For example, q[f][b] = Q[L2G.map(ElementIndex,getFields()[f],b)] //! //! This function uses getImposedValues to fill the imposed values arrays. virtual bool gather ( const LocalToGlobalMap& L2G, const VecDouble& Qval, const VecDouble& Vval, const VecDouble& Vbval, const VecDouble& Tval, MatDouble& q, MatDouble& v, MatDouble& vb, MatDouble& ti) const = 0; //! Assembles the updated values in the global array, including the latest time of update of the //! degrees of freedom in the object. //! //! //! identify its global degrees of freedom. This information is not embedded in the object. \n //! @param L2G Local to Global map used to find the values in the Global arrays\n //! @param qnew local vector with the updated values of the degrees of freedom, \f$q_a^{i}\f$ in //! the notation above. \n //! @param vnew Upon exit, local vector with the updated values of the time derivatives of the //! degrees of freedom, //! \f$v_a^{i}\f$ in the notation above.\n //! @param vbnew Upon exit, local vector with the updated values of the time derivatives at the //! middle of a time step //! of the degrees of freedom, \f$v_a^{i+1/2}\f$ in the notation above.\n //! @param tnew updated values of time vector //! @param Qval Global array where to assemble the updated values of the degrees of freedom.\n //! @param Vval Global array where to assemble the time derivatives of the //! degrees of freedom.\n //! @param Vbval Global array where to assemble the time derivatives of the //! degrees of freedom at the middle of the time step.\n //! @param Tval Global array where to assemble the times at which the degrees of freedom were last //! updated.\n //! @param LUpdate Global array to keep track of which element updated the Dof last. This is used //! to keep Dofs from being updated out of order due to messaging delays. contains the global //! elem index of the last element to update each Dof. //! //! For example, Q[L2G.map(ElementIndex,getFields()[f],b)]=q[f][b] //! virtual bool assemble (const LocalToGlobalMap& L2G, const MatDouble& qnew, const MatDouble& vnew, const MatDouble& vbnew, const MatDouble& tnew, VecDouble& Qval, VecDouble& Vval, VecDouble& Vbval, VecDouble& Tval, VecDouble& LUpdate) const = 0; protected: virtual void setTimeStep (double epsilon = 1.0) = 0; //! Solves the system of equations with the mass matrix for \f$\Delta v_b\f$. \n //! This is made a virtual function so that, if the mass matrix happens to be //! diagonal, it is done efficiently. //! //! @param funcval values of \f$\Delta t f_a(q_a^i)\f$. //! Notice that the multiplication by \f$\Delta t\f$ is already included. //! funcval[f][b] contains the value of \f$\Delta t f_a(q_a^i)\f$ for the degree of //! freedom indexed with field "f" and degree of freedom number in that field "b". //! //! @param DeltaV values of \f$\Delta v_a\f$ upon exit. DeltaV[f][b] contains the value //! of \f$\Delta v_a\f$ for the degree of freedom indexed with field "f" and degree of //! freedom number in that field "b". virtual void computeDeltaV (const MatDouble& funcval, MatDouble& DeltaV) const = 0; //! Imposed values of the degrees of freedom and its time derivative //! //! @param ElementIndex GlobalElementIndex or index of the force field in the AVI object, used to //! identify its global degrees of freedom. This information is not embedded in the object. \n //! @param L2G Local to Global map used to find the values in the Global arrays\n //! @param field field number for which the imposed values are sought, starting from zero.\n //! @param dof degree of freedom number within field "field" for which the imposed values are sought, //! starting from zero.\n //! @param qvalue upon exit, imposed value of the degree of freedom\n //! @param vvalue upon exit, imposed value of the time derivative of the degree of freedom\n //! //! The values of ElementIndex and L2G are not always needed, but they are included here to provide //! a general interface. //! //! \todo There has to be a cleaner way to deal with the value of the boundary condition other //! than providing a general interface to code them in the derived classes. virtual bool getImposedValues (const GlobalElementIndex& ElementIndex, const LocalToGlobalMap& L2G, size_t field, size_t dof, double& qvalue, double& vvalue) const = 0; public: //! @return string representation for printing debugging etc virtual const std::string toString () const { std::ostringstream ss; ss << "AVI(id: " << getGlobalIndex() << ", " << getNextTimeStamp() << " )"; return ss.str (); } //! @return for use with std::ostream friend std::ostream& operator << (std::ostream& out, const AVI& avi) { out << avi.toString (); return out; } }; /** * A comparator class for comparing two AVI objects * according to their time stamps */ struct AVIComparator { // static const double EPS = 1e-12; //! tie break comparison //! @param left pointer to first AVI object //! @param right pointer to second AVI object static inline int compare (const AVI* const left, const AVI* const right) { int result = DoubleComparator::compare (left->getNextTimeStamp (), right->getNextTimeStamp ()); if (result == 0) { result = left->getGlobalIndex() - right->getGlobalIndex(); } return result; } //! return true if left < right //! @param left pointer to first AVI object //! @param right pointer to second AVI object bool operator () (const AVI* const left, const AVI* const right) const { return compare (left, right) < 0; } }; //! since C++ priority_queue is a max heap, this //! comparator allows using C++ priority_queue as a //! min heap by inverting the comparison struct AVIReverseComparator: public AVIComparator { //! @returns true if left > right //! @param left pointer to first AVI object //! @param right pointer to second AVI object bool operator () (const AVI* const left, const AVI* const right) const { return compare (left, right) > 0; } }; #endif
0
rapidsai_public_repos/code-share/maxflow/galois/apps/avi
rapidsai_public_repos/code-share/maxflow/galois/apps/avi/libAVI/StandardAVI.h
/** * StandardAVI.h * DG++ * * Created by Adrian Lew on 9/23/08. * * Copyright (c) 2008 Adrian Lew * * 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 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. */ #ifndef _STANDARD_AVI_H_ #define _STANDARD_AVI_H_ #include "AVI.h" /** \brief StandardAVI class implementation of AVI base class */ class StandardAVI: public AVI { public: //! function used for obtaining value of boundary conditions typedef double (*BCFunc) (int, int, double); //! type of boundary conditions imposed //! ZERO means no boundary conditions enum BCImposedType { ZERO, ONE, TWO }; //! StandardAVI constructor designed to handle integration of an individual element //! //! @param L2G local to global map for access to Petsc vectors //! @param MyRes ref to a Stresswork for this element //! @param MassVec ref to the assembled mass vector for the mesh //! @param globalIdx is the Element's unique global index //! @param IFlag is a ref to the Boundary values indicator //! @param IVal is a ref to the actual values of boundary conditions, if IFlag is not false //! @param delta is a double that is used as a safety factor in computing the times step for an element //! @param time allows the AVI object's time to be set to some value //! StandardAVI( const LocalToGlobalMap& L2G, const DResidue& MyRes, const VecDouble& MassVec, size_t globalIdx, const MatBool& IFlag, const MatDouble& IVal, const double delta, const double time) : AVI (time), operation (MyRes), globalIdx (globalIdx), imposedFlags (IFlag), imposedValues (IVal), delta (delta) { init(L2G, MassVec); imposedTypes = std::vector< std::vector<BCImposedType> > (IFlag.size (), std::vector<BCImposedType> ()); for (size_t f = 0; f < IFlag.size (); ++f) { for (size_t a = 0; a < IFlag[f].size (); ++f) { if (!IFlag[f][a]) { imposedTypes[f].push_back (StandardAVI::ONE); } else { imposedTypes[f].push_back (StandardAVI::ZERO); } } } } //! StandardAVI constructor designed to handle integration of an individual element //! //! @param MyRes ref to a Stresswork for this element //! @param MassVec ref to the assembled mass vector for the mesh //! @param L2G local to global map for access to Petsc vectors //! @param globalIdx is the Element's unique global index //! @param IType is a vector containing types of imposed boundary conditons @see StandardAVI::BCImposedType //! @param bcfunc_vec is a vector of function pointers used to obtain the value of boundary conditions //! @param delta is a double that is used as a safety factor in computing the times step for an element //! @param time allows the AVI object's time to be set to some value //! StandardAVI( const LocalToGlobalMap& L2G, const DResidue& MyRes, const VecDouble& MassVec, size_t globalIdx, const std::vector<std::vector<BCImposedType> >& IType, const std::vector<BCFunc>& bcfunc_vec, const double delta, const double time) : AVI (time), operation (MyRes), globalIdx (globalIdx), imposedTypes (IType), delta (delta) { init (L2G, MassVec); if(imposedFlags.size() != IType.size()) { imposedFlags.resize(IType.size()); } if(imposedValues.size() != IType.size()) { imposedValues.resize(IType.size()); } if(imposedTypes.size() != IType.size()) { imposedTypes.resize(IType.size()); } for(size_t f = 0;f < IType.size();f++){ if(imposedFlags[f].size() != IType[f].size()) { imposedFlags[f].resize(IType[f].size()); } if(imposedValues[f].size() != IType[f].size()) { imposedValues[f].resize(IType[f].size()); } if(imposedTypes[f].size() != IType[f].size()) { imposedTypes[f].resize(IType[f].size()); } for(size_t a = 0;a < IType[f].size();a++){ if(IType[f][a] != StandardAVI::ZERO){ imposedFlags[f][a] = false; }else{ imposedFlags[f][a] = true; } imposedValues[f][a] = 0.0; imposedTypes[f][a] = IType[f][a]; } } for(size_t a = 0;a < bcfunc_vec.size();a++){ avi_bc_func.push_back(bcfunc_vec[a]); } } //! Copy constructor StandardAVI (const StandardAVI& that) : AVI (that), operation (that.operation), MMdiag (that.MMdiag), globalIdx (that.globalIdx), avi_bc_func (that.avi_bc_func), imposedTypes (that.imposedTypes), imposedFlags (that.imposedFlags), imposedValues (that.imposedValues), nfields (that.nfields), delta (that.delta) { setTimeStep (); } virtual StandardAVI* clone () const { return new StandardAVI (*this); } virtual const DResidue& getOperation () const { return operation; } size_t getFieldDof (size_t fieldnumber) const { return operation.getFieldDof (fieldnumber); } const std::vector<size_t>& getFields () const { return operation.getFields (); } //! returns the element geometry const ElementGeometry& getGeometry () const { return operation.getElement ().getGeometry (); } //! returns the element const Element& getElement () const { return operation.getElement (); } //! Updates the force field through the operation Stresswork class bool getForceField (const MatDouble& argval, MatDouble& forcefield) const { operation.getVal (argval, forcefield); return (true); } size_t getGlobalIndex (void) const { return (globalIdx); } //! write the updated time vector into the argument provided //! value filled in is the one obtained from getNextTimeStamp () virtual void computeLocalTvec (MatDouble& tnew) const; virtual bool vbInit ( const MatDouble& q, const MatDouble& v, const MatDouble& vb, const MatDouble& ti, const MatDouble& tnew, MatDouble& qnew, MatDouble& vbinit, MatDouble& forcefield, MatDouble& funcval, MatDouble& deltaV ) const; virtual bool update (const MatDouble& q, const MatDouble& v, const MatDouble& vb, const MatDouble& ti, const MatDouble& tnew, MatDouble& qnew, MatDouble& vnew, MatDouble& vbnew, MatDouble& forcefield, MatDouble& funcval, MatDouble& deltaV ) const ; bool gather ( const LocalToGlobalMap& L2G, const VecDouble& Qval, const VecDouble& Vval, const VecDouble& Vbval, const VecDouble& Tval, MatDouble& q, MatDouble& v, MatDouble& vb, MatDouble& ti ) const; bool assemble (const LocalToGlobalMap& L2G, const MatDouble& qnew, const MatDouble& vnew, const MatDouble& vbnew, const MatDouble& tnew, VecDouble& Qval, VecDouble& Vval, VecDouble& Vbval, VecDouble& Tval, VecDouble& LUpdate) const; protected: //! Sets the time step for the element based upon the element geometry and sound speed. The safety factor, delta, is set //! during the construction of the AVI object. The optional parameter, epsilon, allows the time step to be adjusted further. //! @param epsilon: optional parameter which allows the time step to be set to a fraction of its normal value. virtual void setTimeStep (double epsilon = 1.0) { timeStep = epsilon * delta * (operation.getElement ().getGeometry ().getInRadius ()) / operation.getMaterial ().getSoundSpeed (); } virtual void computeDeltaV (const MatDouble& funcval, MatDouble& DeltaV) const; virtual bool getImposedValues (const GlobalElementIndex& ElementIndex, const LocalToGlobalMap& L2G, size_t field, size_t dof, double& qvalue, double& vvalue) const; //! Option to round the time step in order to address round-off error. Not currently used //! @param min_ts -- the smallest time step in mesh. Every time step will be rounded to a value 3 significant digits //! smaller than the min_ts void roundTimeStep (double min_ts) { char val[80], val2[80]; sprintf (val, "%0.3e", min_ts / 1000.); double cut_off = strtod (val, NULL); strncpy (val2, val, 5); cut_off = cut_off / strtod (val2, NULL); timeStep = floor (timeStep / cut_off) * cut_off; } private: // disabling assignment StandardAVI& operator = (const StandardAVI& that) { return *this; } void init(const LocalToGlobalMap& L2G, const VecDouble& MassVec) { nfields = operation.getFields().size(); setTimeStep(); setDiagVals(MassVec, L2G, globalIdx); //set the diagonal values of the Mass Matrix } //! This function sets the Mass Matrix diagonal values for the element after they have //! been computed using DiagonalMassForSW and place into the petsc vector MassVec //! @param MassVec -- input in the form of petsc vector computed using DiagonalMassForSW //! @param L2G -- localtoglobal map for petsc vectors //! @param elem_index -- needed for proper indexing into the L2G map contains the element index locally void setDiagVals (const VecDouble& MassVec, const LocalToGlobalMap& L2G, const GlobalElementIndex& elem_index); //! set the boundary conditions on the local element //! @param IFlag is set to true for each bc that is imposed //! \todo --Modify this to reflect changes to constructor //! @param IVal is set to value for each bc that is imposed void setBCs (const MatBool&IFlag, const MatDouble& IVal); const DResidue& operation; MatDouble MMdiag; size_t globalIdx; // MatDouble forcefield; std::vector<BCFunc> avi_bc_func; std::vector<std::vector<BCImposedType> > imposedTypes; MatBool imposedFlags; MatDouble imposedValues; size_t nfields; double delta; // safety factor in time step computation }; #endif // _STANDARD_AVI_H_
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/pta/CMakeLists.txt
app(pta)
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/pta/PointsTo.cpp
/** Points-to Analysis application -*- C++ -*- * @file * * An inclusion-based points-to analysis algorithm to demostrate the Galois system. * * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2012, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @author rupesh nasre. <[email protected]> */ #include "Galois/Galois.h" #include "Galois/Bag.h" #include "Galois/SparseBitVector.h" #include "Galois/Statistic.h" #include "Galois/Graph/Graph.h" #include "Galois/Graph/FileGraph.h" #include "Galois/WorkList/WorkList.h" #include "llvm/Support/CommandLine.h" #include "Lonestar/BoilerPlate.h" #include <vector> #include <iostream> #include <fstream> #include <string> #include <cstdlib> #include <stack> namespace cll = llvm::cl; namespace { const char* name = "Points-to Analysis"; const char* desc = "Performs inclusion-based points-to analysis over the input constraints."; const char* url = NULL; static cll::opt<std::string> input(cll::Positional, cll::desc("<constraints>"), cll::Required); const unsigned THRESHOLD_LOADSTORE = 500; // no of nodes to be processed before adding load/store edges. const unsigned THRESHOLD_OCD = 500; struct Node { unsigned id; unsigned priority; Node() { id = 0; priority = 0; } Node(unsigned lid): id(lid) { priority = 0; } }; typedef Galois::Graph::FirstGraph<Node,void,true> Graph; typedef Graph::GraphNode GNode; /* copied from Andrew's SSSP. */ struct UpdateRequest { GNode n; unsigned int w; UpdateRequest(GNode& N, unsigned int W) :n(N), w(W) {} }; struct UpdateRequestIndexer : std::binary_function<UpdateRequest, unsigned int, unsigned int> { unsigned int operator() (const UpdateRequest& val) const { unsigned int t = val.w; return t; } }; //typedef std::pair<GNode,GNode> Edge; typedef std::vector<UpdateRequest> WorkList; typedef Galois::WorkList::OrderedByIntegerMetric<UpdateRequestIndexer, Galois::WorkList::dChunkedFIFO<1024> > OBIM; class PtsToCons { public: typedef enum {AddressOf = 0, Copy, Load, Store} ConstraintType; PtsToCons(ConstraintType tt, unsigned ss, unsigned dd) { src = ss; dst = dd; type = tt; } void getSrcDst(unsigned &ss, unsigned &dd) { ss = src; dd = dst; } ConstraintType getType() { return type; } void print() { if (type == Store) { std::cerr << "*"; } std::cerr << "v" << dst; std::cerr << " = "; if (type == Load) { std::cerr << "*"; } else if (type == AddressOf) { std::cerr << "&"; } std::cerr << "v" << src; std::cerr << std::endl; } private: unsigned src, dst; ConstraintType type; }; typedef std::vector<PtsToCons> PointsToConstraints; typedef std::vector<Galois::SparseBitVector> PointsToInfo; Graph graph; std::vector<GNode> nodes; PointsToInfo result; PointsToConstraints addrcopyconstraints, loadstoreconstraints; unsigned numNodes = 0; class OCD { // Online Cycle Detection and elimination. public: OCD() { } void init() { NoRepresentative = numNodes; representative.resize(numNodes); visited.resize(numNodes); for (unsigned ii = 0; ii < numNodes; ++ii) { representative[ii] = NoRepresentative; } } void process(WorkList &worklist) { // worklist of nodes that are sources of new edges. for (unsigned ii = 0; ii < numNodes; ++ii) { visited[ii] = false; } unsigned cyclenode = numNodes; // set to invalid id. for (WorkList::iterator ii = worklist.begin(); ii != worklist.end(); ++ii) { Node &nn = graph.getData(ii->n, Galois::MethodFlag::NONE); unsigned nodeid = nn.id; //std::cout << "debug: cycle process " << nodeid << std::endl; if (cycleDetect(nodeid, cyclenode)) { cycleCollapse(cyclenode); } } } bool cycleDetect(unsigned nodeid, unsigned &cyclenode) { // it is okay not to detect all cycles as it is only an efficiency concern. nodeid = getFinalRepresentative(nodeid); if (isAncestor(nodeid)) { cyclenode = nodeid; return true; } if (visited[nodeid]) { return false; } visited[nodeid] = true; ancestors.push_back(nodeid); GNode nn = nodes[nodeid]; for (Graph::edge_iterator ii = graph.edge_begin(nn, Galois::MethodFlag::NONE), ei = graph.edge_end(nn, Galois::MethodFlag::NONE); ii != ei; ++ii) { Node &nn = graph.getData(graph.getEdgeDst(ii), Galois::MethodFlag::NONE); unsigned iiid = nn.id; if (cycleDetect(iiid, cyclenode)) { //return true; // don't pop from ancestors. cycleCollapse(cyclenode); } } ancestors.pop_back(); return false; } void cycleCollapse(unsigned repr) { // assert(repr is present in ancestors). //static unsigned ncycles = 0; unsigned reprrepr = getFinalRepresentative(repr); for (std::vector<unsigned>::iterator ii = ancestors.begin(); ii != ancestors.end(); ++ii) { if (*ii == repr) { //std::cout << "debug: collapsing cycle for " << repr << std::endl; // cycle exists between nodes ancestors[*ii..end]. for (std::vector<unsigned>::iterator jj = ii; jj != ancestors.end(); ++jj) { unsigned jjrepr = getFinalRepresentative(*jj); // jjrepr has no representative. makeRepr(jjrepr, reprrepr); } //std::cout << "debug: cycles collapsed = " << ++ncycles << std::endl; break; } } //ancestors.clear(); // since collapse is called from top level process(), the ancestors need to be cleared for the next element in the worklist. } void makeRepr(unsigned nodeid, unsigned repr) { // make repr the representative of nodeid. if (repr != nodeid) { //std::cout << "debug: repr[" << nodeid << "] = " << repr << std::endl; representative[nodeid] = repr; if (!result[repr].isSubsetEq(result[nodeid])) { //graph.getData(nodes[repr]); // lock it. result[repr].unify(result[nodeid]); } } } unsigned getFinalRepresentative(unsigned nodeid) { unsigned lnnid = nodeid; while (representative[lnnid] != NoRepresentative) { lnnid = representative[lnnid]; } // path compression. unsigned repr = representative[nodeid]; while (repr != NoRepresentative) { representative[nodeid] = lnnid; nodeid = repr; repr = representative[nodeid]; } return lnnid; } private: bool isAncestor(unsigned nodeid) { for (std::vector<unsigned>::iterator ii = ancestors.begin(); ii != ancestors.end(); ++ii) { if (*ii == nodeid) { return true; } } return false; } std::vector<unsigned> ancestors; std::vector<bool> visited; std::vector<unsigned> representative; unsigned NoRepresentative; }; OCD ocd; void checkReprPointsTo() { for (unsigned ii = 0; ii < result.size(); ++ii) { unsigned repr = ocd.getFinalRepresentative(ii); if (repr != ii && !result[ii].isSubsetEq(result[repr])) { std::cout << "ERROR: pointsto(" << ii << ") is not less than its representative pointsto(" << repr << ").\n"; } } } unsigned countPointsToFacts() { unsigned count = 0; for (PointsToInfo::iterator ii = result.begin(); ii != result.end(); ++ii) { unsigned repr = ocd.getFinalRepresentative(ii - result.begin()); count += result[repr].count(); } return count; } void printPointsToInfo(PointsToInfo &result) { std::string prefix = "v"; for (PointsToInfo::iterator ii = result.begin(); ii != result.end(); ++ii) { std::cout << prefix << ii - result.begin() << ": "; unsigned repr = ocd.getFinalRepresentative(ii - result.begin()); result[repr].print(std::cout, prefix); } } void processLoadStoreSerial(PointsToConstraints &constraints, WorkList &worklist, Galois::MethodFlag flag = Galois::MethodFlag::NONE) { // add edges to the graph based on points-to information of the nodes // and then add the source of each edge to the worklist. for (PointsToConstraints::iterator ii = constraints.begin(); ii != constraints.end(); ++ii) { unsigned src, dst; //std::cout << "debug: Processing constraint: "; ii->print(); ii->getSrcDst(src, dst); unsigned srcrepr = ocd.getFinalRepresentative(src); unsigned dstrepr = ocd.getFinalRepresentative(dst); if (ii->getType() == PtsToCons::Load) { GNode &nndstrepr = nodes[dstrepr]; std::vector<unsigned> ptstoOfSrc; result[srcrepr].getAllSetBits(ptstoOfSrc); for (std::vector<unsigned>::iterator pointee = ptstoOfSrc.begin(); pointee != ptstoOfSrc.end(); ++pointee) { unsigned pointeerepr = ocd.getFinalRepresentative(*pointee); if (pointeerepr != dstrepr && graph.findEdge(nodes[pointeerepr], nodes[dstrepr]) == graph.edge_begin(nodes[pointeerepr])) { GNode &nn = nodes[pointeerepr]; graph.addEdge(nn, nndstrepr, flag); //std::cout << "debug: adding edge from " << *pointee << " to " << dst << std::endl; worklist.push_back(UpdateRequest(nn, graph.getData(nn, Galois::MethodFlag::NONE).priority)); } } } else { // store. std::vector<unsigned> ptstoOfDst; bool newedgeadded = false; GNode &nnsrcrepr = nodes[srcrepr]; result[dstrepr].getAllSetBits(ptstoOfDst); for (std::vector<unsigned>::iterator pointee = ptstoOfDst.begin(); pointee != ptstoOfDst.end(); ++pointee) { unsigned pointeerepr = ocd.getFinalRepresentative(*pointee); if (srcrepr != pointeerepr && graph.findEdge(nodes[srcrepr],nodes[pointeerepr]) == graph.edge_end(nodes[srcrepr])) { graph.addEdge(nnsrcrepr, nodes[pointeerepr], flag); //std::cout << "debug: adding edge from " << src << " to " << *pointee << std::endl; newedgeadded = true; } } if (newedgeadded) { worklist.push_back(UpdateRequest(nnsrcrepr, graph.getData(nnsrcrepr, Galois::MethodFlag::NONE).priority)); } } } } void processAddressOfCopy(PointsToConstraints &constraints, WorkList &worklist) { for (PointsToConstraints::iterator ii = constraints.begin(); ii != constraints.end(); ++ii) { unsigned src, dst; //std::cout << "debug: Processing constraint: "; ii->print(); ii->getSrcDst(src, dst); if (ii->getType() == PtsToCons::AddressOf) { if (result[dst].set(src)) { //std::cout << "debug: saving v" << dst << "->v" << src << std::endl; } } else if (src != dst) { // copy. GNode &nn = nodes[src]; graph.addEdge(nn, nodes[dst], Galois::MethodFlag::NONE); //std::cout << "debug: adding edge from " << src << " to " << dst << std::endl; worklist.push_back(UpdateRequest(nn, graph.getData(nn, Galois::MethodFlag::NONE).priority)); } } } unsigned propagate(GNode &src, GNode &dst, Galois::MethodFlag flag = Galois::MethodFlag::ALL) { unsigned srcid = graph.getData(src, Galois::MethodFlag::NONE).id; unsigned dstid = graph.getData(dst, Galois::MethodFlag::NONE).id; unsigned newptsto = 0; if (srcid != dstid) { unsigned srcreprid = ocd.getFinalRepresentative(srcid); unsigned dstreprid = ocd.getFinalRepresentative(dstid); if (srcreprid != dstreprid && !result[srcreprid].isSubsetEq(result[dstreprid])) { //std::cout << "debug: unifying " << dstreprid << " by " << srcreprid << std::endl; graph.getData(nodes[dstreprid], flag); newptsto = result[dstreprid].unify(result[srcreprid]); //newptsto = 0; } } return newptsto; } void processLoadStore(PointsToConstraints &constraints, WorkList &worklist, Galois::MethodFlag flag = Galois::MethodFlag::ALL) { // add edges to the graph based on points-to information of the nodes // and then add the source of each edge to the worklist. for (PointsToConstraints::iterator ii = constraints.begin(); ii != constraints.end(); ++ii) { unsigned src, dst; //std::cout << "debug: Processing constraint: "; ii->print(); ii->getSrcDst(src, dst); unsigned srcrepr = ocd.getFinalRepresentative(src); unsigned dstrepr = ocd.getFinalRepresentative(dst); if (ii->getType() == PtsToCons::Load) { GNode &nndstrepr = nodes[dstrepr]; std::vector<unsigned> ptstoOfSrc; result[srcrepr].getAllSetBits(ptstoOfSrc); for (std::vector<unsigned>::iterator pointee = ptstoOfSrc.begin(); pointee != ptstoOfSrc.end(); ++pointee) { unsigned pointeerepr = ocd.getFinalRepresentative(*pointee); if (pointeerepr != dstrepr && graph.findEdge(nodes[pointeerepr], nodes[dstrepr]) == graph.edge_end(nodes[pointeerepr])) { GNode &nn = nodes[pointeerepr]; graph.addEdge(nn, nndstrepr, flag); //std::cout << "debug: adding edge from " << *pointee << " to " << dst << std::endl; worklist.push_back(UpdateRequest(nn, graph.getData(nn, Galois::MethodFlag::ALL).priority)); } } } else { // store. std::vector<unsigned> ptstoOfDst; bool newedgeadded = false; GNode &nnsrcrepr = nodes[srcrepr]; result[dstrepr].getAllSetBits(ptstoOfDst); for (std::vector<unsigned>::iterator pointee = ptstoOfDst.begin(); pointee != ptstoOfDst.end(); ++pointee) { unsigned pointeerepr = ocd.getFinalRepresentative(*pointee); if (srcrepr != pointeerepr && graph.findEdge(nodes[srcrepr],nodes[pointeerepr]) == graph.edge_end(nodes[srcrepr])) { graph.addEdge(nnsrcrepr, nodes[pointeerepr], flag); //std::cout << "debug: adding edge from " << src << " to " << *pointee << std::endl; newedgeadded = true; } } if (newedgeadded) { worklist.push_back(UpdateRequest(nnsrcrepr, graph.getData(nnsrcrepr, Galois::MethodFlag::ALL).priority)); } } } } unsigned nfired; //unsigned niter; struct Process { Process() { } template<typename Context> void operator()(UpdateRequest &req, Context& ctx) { if (++nfired < THRESHOLD_LOADSTORE) { GNode &src = req.n; for (Graph::edge_iterator ii = graph.edge_begin(src, Galois::MethodFlag::NONE), ei = graph.edge_end(src, Galois::MethodFlag::NONE); ii != ei; ++ii) { GNode dst = graph.getEdgeDst(ii); unsigned newptsto = propagate(src, dst, Galois::MethodFlag::ALL); if (newptsto) { ctx.push(UpdateRequest(dst, newptsto)); } } } else { nfired = 0; WorkList wl; processLoadStore(loadstoreconstraints, wl, Galois::MethodFlag::ALL); /*if (wl.size() > THRESHOLD_OCD) { ocd.process(wl); }*/ for (WorkList::iterator ii = wl.begin(); ii != wl.end(); ++ii) { ctx.push(*ii); } } /*if (nfired % 500 == 0) { std::cout << ++niter << std::endl; }*/ } }; void runSerial(PointsToConstraints &addrcopyconstraints, PointsToConstraints &loadstoreconstraints) { WorkList worklist; //unsigned niteration = 0; //bool changed = false; unsigned nnodesprocessed = 0; processAddressOfCopy(addrcopyconstraints, worklist); processLoadStoreSerial(loadstoreconstraints, worklist, Galois::MethodFlag::NONE); // required when there are zero copy constraints which keeps worklist empty. //std::cout << "debug: no of addr+copy constraints = " << addrcopyconstraints.size() << ", no of load+store constraints = " << loadstoreconstraints.size() << std::endl; //std::cout << "debug: no of nodes = " << nodes.size() << std::endl; while (!worklist.empty()) { //std::cout << "debug: Iteration " << ++niteration << ", worklist.size=" << worklist.size() << "\n"; GNode src = worklist.back().n; worklist.pop_back(); //std::cout << "debug: processing worklist element " << graph.getData(src, Galois::MethodFlag::NONE).id << std::endl; for (Graph::edge_iterator ii = graph.edge_begin(src, Galois::MethodFlag::NONE), ei = graph.edge_end(src, Galois::MethodFlag::NONE); ii != ei; ++ii) { GNode dst = graph.getEdgeDst(ii); unsigned newptsto = propagate(src, dst, Galois::MethodFlag::NONE); if (newptsto) { worklist.push_back(UpdateRequest(dst, newptsto)); } } if (++nnodesprocessed > THRESHOLD_LOADSTORE || worklist.empty()) { nnodesprocessed = 0; processLoadStoreSerial(loadstoreconstraints, worklist); // add edges to graph, add their sources to worklist. if (worklist.size() > THRESHOLD_OCD) { ocd.process(worklist); } } } } void runParallel(PointsToConstraints &addrcopyconstraints, PointsToConstraints &loadstoreconstraints) { WorkList worklist; //unsigned niteration = 0; processAddressOfCopy(addrcopyconstraints, worklist); processLoadStore(loadstoreconstraints, worklist, Galois::MethodFlag::NONE); //using namespace Galois::Runtime::WorkList; //Galois::for_each<LocalQueues<dChunkedFIFO<1024> > >(worklist.begin(), worklist.end(), Process()); //Galois::for_each<FIFO<> >(worklist.begin(), worklist.end(), Process()); //Galois::for_each<ChunkedFIFO<1024> >(worklist.begin(), worklist.end(), Process()); //Galois::for_each<dChunkedFIFO<1024> >(worklist.begin(), worklist.end(), Process()); //Galois::for_each<ChunkedLIFO<32> >(worklist.begin(), worklist.end(), Process()); //Galois::for_each<LocalQueues<ChunkedLIFO<32> > >(worklist.begin(), worklist.end(), Process()); //Galois::for_each<LocalQueues<FIFO<1024> > >(worklist.begin(), worklist.end(), Process()); //Galois::for_each<LocalQueues<ChunkedFIFO<32> > >(worklist.begin(), worklist.end(), Process()); //Galois::for_each<LocalQueues<dChunkedLIFO<32>, FIFO<> > >(worklist.begin(), worklist.end(), Process()); //Galois::for_each<LocalQueues<ChunkedLIFO<1024>, FIFO<> > >(worklist.begin(), worklist.end(), Process()); //Galois::for_each<LocalQueues<ChunkedFIFO<1024>, FIFO<> > >(worklist.begin(), worklist.end(), Process()); Galois::for_each(worklist.begin(), worklist.end(), Process()); } unsigned readConstraints(const char *file, PointsToConstraints &addrcopyconstraints, PointsToConstraints &loadstoreconstraints) { unsigned numNodes = 0; unsigned nconstraints = 0; std::ifstream cfile(file); std::string cstr; getline(cfile, cstr); // no of vars. sscanf(cstr.c_str(), "%d", &numNodes); getline(cfile, cstr); // no of constraints. sscanf(cstr.c_str(), "%d", &nconstraints); addrcopyconstraints.clear(); loadstoreconstraints.clear(); unsigned consno, src, dst, offset; PtsToCons::ConstraintType type; for (unsigned ii = 0; ii < nconstraints; ++ii) { getline(cfile, cstr); union { int as_int; PtsToCons::ConstraintType as_ctype; } type_converter; sscanf(cstr.c_str(), "%d,%d,%d,%d,%d", &consno, &src, &dst, &type_converter.as_int, &offset); type = type_converter.as_ctype; PtsToCons cc(type, src, dst); if (type == PtsToCons::AddressOf || type == PtsToCons::Copy) { addrcopyconstraints.push_back(cc); } else if (type == PtsToCons::Load || PtsToCons::Store) { loadstoreconstraints.push_back(cc); } } cfile.close(); return numNodes; } void printConstraints(PointsToConstraints &constraints) { for (PointsToConstraints::iterator ii = constraints.begin(); ii != constraints.end(); ++ii) { ii->print(); } } } int main(int argc, char** argv) { LonestarStart(argc, argv, name, desc, url); numNodes = readConstraints(input.c_str(), addrcopyconstraints, loadstoreconstraints); //printConstraints(addrcopyconstraints); //printConstraints(loadstoreconstraints); result.resize(numNodes); nodes.resize(numNodes); ocd.init(); unsigned nodeid = 0; for (PointsToInfo::iterator ii = result.begin(); ii != result.end(); ++ii, ++nodeid) { ii->init(numNodes); GNode src = graph.createNode(Node(nodeid)); graph.addNode(src); nodes[nodeid] = src; } Galois::StatTimer T; T.start(); //numThreads = 0; if (numThreads) { std::cout << "-------- Parallel version: " << numThreads << " threads.\n"; runParallel(addrcopyconstraints, loadstoreconstraints); } else { std::cout << "-------- Sequential version.\n"; runSerial(addrcopyconstraints, loadstoreconstraints); } T.stop(); //std::cout << "No of points-to facts computed = " << countPointsToFacts() << std::endl; //checkReprPointsTo(); //printPointsToInfo(result); /*if (!skipVerify && !verify(result)) { std::cerr << "If graph was connected, verification failed\n"; assert(0 && "If graph was connected, verification failed"); abort(); }*/ return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/boruvka/Boruvka.cpp
/** Spanning-tree application -*- C++ -*- * @file * * A minimum spanning tree algorithm to demonstrate the Galois system. * * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2012, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @author Donald Nguyen <[email protected]> */ #include "Galois/config.h" #include "Galois/Galois.h" #include "Galois/Accumulator.h" #include "Galois/Bag.h" #include "Galois/Statistic.h" #include "Galois/UnionFind.h" #include "Galois/Graph/LCGraph.h" #include "Galois/ParallelSTL/ParallelSTL.h" #include "llvm/Support/CommandLine.h" #ifdef GALOIS_USE_EXP #include "Galois/Runtime/BulkSynchronousWork.h" #endif #include "Lonestar/BoilerPlate.h" #include GALOIS_CXX11_STD_HEADER(atomic) #include <utility> #include <algorithm> #include <iostream> namespace cll = llvm::cl; static const char* name = "Boruvka's Minimum Spanning Tree Algorithm"; static const char* desc = "Computes the minimum spanning forest of a graph"; static const char* url = "mst"; enum Algo { parallel, exp_parallel }; static cll::opt<std::string> inputFilename(cll::Positional, cll::desc("<input file>"), cll::Required); static cll::opt<bool> symmetricGraph("symmetricGraph", cll::desc("Graph already symmetric"), cll::init(false)); static cll::opt<Algo> algo("algo", cll::desc("Choose an algorithm:"), cll::values( clEnumVal(parallel, "Parallel"), #ifdef GALOIS_USE_EXP clEnumVal(exp_parallel, "Parallel (exp)"), #endif clEnumValEnd), cll::init(parallel)); typedef int EdgeData; struct Node: public Galois::UnionFindNode<Node> { std::atomic<EdgeData*> lightest; }; typedef Galois::Graph::LC_CSR_Graph<Node,EdgeData> ::with_numa_alloc<true>::type ::with_no_lockable<true>::type Graph; typedef Graph::GraphNode GNode; Graph graph; std::ostream& operator<<(std::ostream& os, const Node& n) { os << "[id: " << &n << ", c: " << n.find() << "]"; return os; } struct Edge { GNode src; GNode dst; const EdgeData* weight; Edge(const GNode& s, const GNode& d, const EdgeData* w): src(s), dst(d), weight(w) { } }; Galois::InsertBag<Edge> mst; EdgeData inf; EdgeData heaviest; /** * Boruvka's algorithm. Implemented bulk-synchronously in order to avoid the * need to merge edge lists. */ template<bool useExp> struct ParallelAlgo { struct WorkItem { Edge edge; int cur; WorkItem(const GNode& s, const GNode& d, const EdgeData* w, int c): edge(s, d, w), cur(c) { } }; typedef Galois::InsertBag<WorkItem> WL; WL wls[3]; WL* current; WL* next; WL* pending; EdgeData limit; /** * Find lightest edge between components leaving a node and add it to the * worklist. */ template<bool useLimit, typename Context, typename Pending> static void findLightest(ParallelAlgo* self, const GNode& src, int cur, Context& ctx, Pending& pending) { Node& sdata = graph.getData(src, Galois::MethodFlag::NONE); Graph::edge_iterator ii = graph.edge_begin(src, Galois::MethodFlag::NONE); Graph::edge_iterator ei = graph.edge_end(src, Galois::MethodFlag::NONE); std::advance(ii, cur); for (; ii != ei; ++ii, ++cur) { GNode dst = graph.getEdgeDst(ii); Node& ddata = graph.getData(dst, Galois::MethodFlag::NONE); EdgeData& weight = graph.getEdgeData(ii); if (useLimit && weight > self->limit) { pending.push(WorkItem(src, dst, &weight, cur)); return; } Node* rep; if ((rep = sdata.findAndCompress()) != ddata.findAndCompress()) { //const EdgeData& weight = graph.getEdgeData(ii); EdgeData* old; ctx.push(WorkItem(src, dst, &weight, cur)); while (weight < *(old = rep->lightest)) { if (rep->lightest.compare_exchange_strong(old, &weight)) break; } return; } } } /** * Merge step specialized for first round of the algorithm. */ struct Initialize { ParallelAlgo* self; Initialize(ParallelAlgo* s): self(s) { } void operator()(const GNode& src) const { (*this)(src, *self->next, *self->pending); } template<typename Context> void operator()(const GNode& src, Context& ctx) const { (*this)(src, ctx, *self->pending); } template<typename Context,typename Pending> void operator()(const GNode& src, Context& ctx, Pending& pending) const { Node& sdata = graph.getData(src, Galois::MethodFlag::NONE); sdata.lightest = &inf; findLightest<false>(self, src, 0, ctx, pending); } }; struct Merge { // NB: tells do_all_bs this operator implicitly calls ctx.push(x) for each // call to (*this)(x); typedef int tt_does_not_need_push; ParallelAlgo* self; Merge(ParallelAlgo* s): self(s) { } void operator()(const WorkItem& item) const { (*this)(item, *self->next, *self->pending); } template<typename Context> void operator()(const WorkItem& item, Context& ctx) const { (*this)(item, ctx, *self->pending); } template<typename Context, typename Pending> void operator()(const WorkItem& item, Context& ctx, Pending& pending) const { GNode src = item.edge.src; Node& sdata = graph.getData(src, Galois::MethodFlag::NONE); Node* rep = sdata.findAndCompress(); int cur = item.cur; if (rep->lightest == item.edge.weight) { GNode dst = item.edge.dst; Node& ddata = graph.getData(dst, Galois::MethodFlag::NONE); if ((rep = sdata.merge(&ddata))) { rep->lightest = &inf; mst.push(Edge(src, dst, item.edge.weight)); } ++cur; } } }; struct Find { ParallelAlgo* self; Find(ParallelAlgo* s): self(s) { } void operator()(const WorkItem& item) const { (*this)(item, *self->next, *self->pending); } template<typename Context> void operator()(const WorkItem& item, Context& ctx) const { (*this)(item, ctx, *self->pending); } template<typename Context, typename Pending> void operator()(const WorkItem& item, Context& ctx, Pending& pending) const { findLightest<true>(self, item.edge.src, item.cur, ctx, pending); } }; void init() { current = &wls[0]; next = &wls[1]; pending = &wls[2]; EdgeData delta = std::max(heaviest / 5, 1); limit = delta; } void process() { Galois::Statistic rounds("Rounds"); init(); Galois::do_all_local(graph, Initialize(this)); while (true) { while (true) { rounds += 1; std::swap(current, next); Galois::do_all_local(*current, Merge(this)); Galois::do_all_local(*current, Find(this)); current->clear(); if (next->empty()) break; } if (pending->empty()) break; std::swap(next, pending); limit *= 2; } } #if defined(GALOIS_USE_EXP) && !defined(GALOIS_HAS_NO_BULKSYNCHRONOUS_EXECUTOR) void processExp() { typedef boost::fusion::vector<WorkItem,WorkItem> Items; init(); Galois::do_all_bs_local<Items>(graph, boost::fusion::make_vector(Merge(this), Find(this)), Initialize(this)); while (!pending->empty()) { std::swap(next, pending); Galois::do_all_bs_local<Items>(*next, boost::fusion::make_vector(Merge(this), Find(this))); next->clear(); limit *= 2; } } #else void processExp() { GALOIS_DIE("not supported"); } #endif void operator()() { if (useExp) { processExp(); } else { process(); } } }; struct is_bad_graph { bool operator()(const GNode& n) const { Node& me = graph.getData(n); for (Graph::edge_iterator ii = graph.edge_begin(n), ei = graph.edge_end(n); ii != ei; ++ii) { GNode dst = graph.getEdgeDst(ii); Node& data = graph.getData(dst); if (me.findAndCompress() != data.findAndCompress()) { std::cerr << "not in same component: " << me << " and " << data << "\n"; return true; } } return false; } }; struct is_bad_mst { bool operator()(const Edge& e) const { return graph.getData(e.src).findAndCompress() != graph.getData(e.dst).findAndCompress(); } }; struct CheckAcyclic { struct Accum { Galois::GAccumulator<unsigned> roots; }; Accum* accum; void operator()(const GNode& n) { Node& data = graph.getData(n); if (data.isRep()) accum->roots += 1; } bool operator()() { Accum a; accum = &a; Galois::do_all_local(graph, *this); unsigned numRoots = a.roots.reduce(); unsigned numEdges = std::distance(mst.begin(), mst.end()); if (graph.size() - numRoots != numEdges) { std::cerr << "Generated graph is not a forest. " << "Expected " << graph.size() - numRoots << " edges but " << "found " << numEdges << "\n"; return false; } std::cout << "Num trees: " << numRoots << "\n"; std::cout << "Tree edges: " << numEdges << "\n"; return true; } }; struct SortEdges { struct Accum { Galois::GReduceMax<EdgeData> heavy; }; Accum* accum; void operator()(const GNode& src) { graph.sortEdgesByEdgeData(src, std::less<EdgeData>(), Galois::MethodFlag::NONE); Graph::edge_iterator ii = graph.edge_begin(src, Galois::MethodFlag::NONE); Graph::edge_iterator ei = graph.edge_end(src, Galois::MethodFlag::NONE); ptrdiff_t dist = std::distance(ii, ei); if (dist == 0) return; std::advance(ii, dist - 1); accum->heavy.update(graph.getEdgeData(ii)); } EdgeData operator()() { Accum a; accum = &a; Galois::do_all_local(graph, *this); return a.heavy.reduce(); } }; struct get_weight { EdgeData operator()(const Edge& e) const { return *e.weight; } }; template<typename Algo> void run() { Algo algo; return algo(); } bool verify() { if (Galois::ParallelSTL::find_if(graph.begin(), graph.end(), is_bad_graph()) == graph.end()) { if (Galois::ParallelSTL::find_if(mst.begin(), mst.end(), is_bad_mst()) == mst.end()) { CheckAcyclic c; return c(); } } return false; } void initializeGraph() { Galois::Graph::FileGraph origGraph; Galois::Graph::FileGraph symGraph; origGraph.structureFromFileInterleaved<EdgeData>(inputFilename); if (!symmetricGraph) Galois::Graph::makeSymmetric<EdgeData>(origGraph, symGraph); else symGraph.swap(origGraph); Galois::Graph::readGraph(graph, symGraph); Galois::StatTimer Tsort("InitializeSortTime"); Tsort.start(); SortEdges sortEdges; heaviest = sortEdges(); if (heaviest == std::numeric_limits<EdgeData>::max() || heaviest == std::numeric_limits<EdgeData>::min()) { GALOIS_DIE("Edge weights of graph out of range"); } inf = heaviest + 1; Tsort.stop(); std::cout << "Nodes: " << graph.size() << " edges: " << graph.sizeEdges() << " heaviest edge: " << heaviest << "\n"; } int main(int argc, char** argv) { Galois::StatManager statManager; LonestarStart(argc, argv, name, desc, url); Galois::StatTimer Tinitial("InitializeTime"); Tinitial.start(); initializeGraph(); Tinitial.stop(); Galois::preAlloc(Galois::Runtime::MM::numPageAllocTotal() * 10); Galois::reportPageAlloc("MeminfoPre"); Galois::StatTimer T; T.start(); switch (algo) { case parallel: run<ParallelAlgo<false> >(); break; case exp_parallel: run<ParallelAlgo<true> >(); break; default: std::cerr << "Unknown algo: " << algo << "\n"; } T.stop(); Galois::reportPageAlloc("MeminfoPost"); std::cout << "MST weight: " << Galois::ParallelSTL::map_reduce(mst.begin(), mst.end(), get_weight(), 0.0, std::plus<double>()) << " (" << Galois::ParallelSTL::map_reduce(mst.begin(), mst.end(), get_weight(), 0UL, std::plus<size_t>()) << ")\n"; if (!skipVerify && !verify()) { GALOIS_DIE("verification failed"); } return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/boruvka/CMakeLists.txt
app(boruvka Boruvka.cpp) app(boruvka-merge BoruvkaMerge.cpp)
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/boruvka/BoruvkaMerge.cpp
/** Boruvka application -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @author Donald Nguyen <[email protected]> * @author Rashid Kaleem <[email protected]> */ #include "Galois/Statistic.h" #include "Galois/Graph/Graph.h" #include "Galois/Timer.h" #include "Galois/Galois.h" #include "Galois/Graph/LCGraph.h" #include "llvm/Support/CommandLine.h" #include "Lonestar/BoilerPlate.h" #ifdef GALOIS_USE_EXP #include "Galois/PriorityScheduling.h" #endif #include <string> #include <sstream> #include <limits> #include <iostream> #include <fstream> #include <map> #include <set> #include <vector> #define BORUVKA_DEBUG 0 #define COMPILE_STATISICS 0 #if BORUVKA_DEBUG #include "UnionFind.h" #endif #if COMPILE_STATISICS #include <time.h> int BORUVKA_SAMPLE_FREQUENCY= 1000000; #endif using namespace std; namespace cll = llvm::cl; static const char* name = "Boruvka's Minimum Spanning Tree Algorithm"; static const char* desc = "Computes a minimum weight spanning tree of a graph"; static const char* url = "mst"; static cll::opt<std::string> inputfile(cll::Positional, cll::desc("<input file>"), cll::Required); static cll::opt<bool> use_weighted_rmat("wrmat",cll::desc("Weighted RMAT"), cll::Optional,cll::init(false)); static cll::opt<bool> verify_via_kruskal("verify",cll::desc("Verify MST result via Serial Kruskal"), cll::Optional,cll::init(false)); static int nodeID = 0; /////////////////////////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////////////////////// struct Node { //Do not include node data if not debugging since //it is a useless overhead. Useful for debugging though. #if BORUVKA_DEBUG int id; Node(int i=-1) : id(i) { } std::string toString() { std::ostringstream s; s << "N(" << id << ")"; return s.str(); } #else Node(int){}; Node(){}; #endif }; std::ostream& operator<<(std::ostream& s, Node& n) { #if BORUVKA_DEBUG s << n.toString(); #endif return s; } /////////////////////////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////////////////////// typedef long NodeDataType; typedef int EdgeDataType; typedef Galois::Graph::FirstGraph<Node, EdgeDataType, false> Graph; typedef Graph::GraphNode GNode; //The graph. Graph graph; /////////////////////////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////////////////////// #if COMPILE_STATISICS struct GraphStats{ std::vector<float> average_degrees; std::vector<int> time_vals; std::vector<unsigned long> max_degrees; unsigned long counter; GraphStats(){ counter=0; } GraphStats & tick(){ ++counter; return *this; } void snap(){ unsigned long num_nodes=0; unsigned long num_edges=0; unsigned long current_degree = 0; unsigned long max_degree=0; for(Graph::iterator it = graph.begin(), end_it = graph.end(); it!=end_it; ++it){ ++num_nodes; current_degree=0; for(Graph::edge_iterator e_it = graph.edge_begin(*it, Galois::MethodFlag::NONE), e_it_end = graph.edge_end(*it, Galois::MethodFlag::NONE); e_it!=e_it_end; ++e_it){ ++num_edges; ++current_degree; } if(current_degree > max_degree) max_degree = current_degree; } time_vals.push_back(time(0)); average_degrees.push_back((float)(num_edges)/(num_nodes)); max_degrees.push_back(max_degree); } void dump(ostream & out){ out<<"\nMax degrees,"; for(size_t i=0;i<max_degrees.size(); ++i){ out << " " << max_degrees[i]<<","; } out<<"\nAverage degrees,"; for(size_t i=0;i<average_degrees.size(); ++i){ out << " " << average_degrees[i]<<","; } out<<"\nTime, "; for(size_t i=0;i<time_vals.size(); ++i){ out << " " << time_vals[i]<<","; } out<<"\n"; } }; GraphStats stat_collector; #endif ///////////////////////////////////////////////////////////////////////////////////////// void printGraph() { int numEdges = 0; for (Graph::iterator src = graph.begin(), esrc = graph.end(); src != esrc; ++src) { Node& sdata = graph.getData(*src, Galois::MethodFlag::NONE); if (graph.containsNode(*src)) for (Graph::edge_iterator dst = graph.edge_begin(*src, Galois::MethodFlag::NONE), edst = graph.edge_end(*src, Galois::MethodFlag::NONE); dst != edst; ++dst) { EdgeDataType w = graph.getEdgeData(dst); assert(w>=0); Node & ddata = graph.getData(graph.getEdgeDst(dst)); std::cout << "1) " << sdata << " => " << ddata << " [ " << w << " ] " << std::endl; numEdges++; } } std::cout << "Num edges " << numEdges << std::endl; } /////////////////////////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////////////////////// Galois::Runtime::PerThreadStorage<long long> MSTWeight; struct process { template<typename ContextTy> void operator()(GNode& src, ContextTy& lwl) { if (graph.containsNode(src) == false) return; graph.getData(src, Galois::MethodFlag::ALL); GNode * minNeighbor = 0; #if BORUVKA_DEBUG std::cout<<"Processing "<<graph.getData(src).toString()<<std::endl; #endif EdgeDataType minEdgeWeight = std::numeric_limits<EdgeDataType>::max(); //Acquire locks on neighborhood. for (Graph::edge_iterator dst = graph.edge_begin(src, Galois::MethodFlag::ALL), edst = graph.edge_end(src, Galois::MethodFlag::ALL); dst != edst; ++dst) { graph.getData(graph.getEdgeDst(dst)); } //Find minimum neighbor for (Graph::edge_iterator e_it = graph.edge_begin(src, Galois::MethodFlag::NONE), edst = graph.edge_end(src, Galois::MethodFlag::NONE); e_it != edst; ++e_it) { EdgeDataType w = graph.getEdgeData(e_it, Galois::MethodFlag::NONE); assert(w>=0); if (w < minEdgeWeight) { minNeighbor = &((*e_it).first()); minEdgeWeight = w; } } //If there are no outgoing neighbors. if (minEdgeWeight == std::numeric_limits<EdgeDataType>::max()) { graph.removeNode(src, Galois::MethodFlag::NONE); return; } #if BORUVKA_DEBUG std::cout << " Min edge from "<<graph.getData(src) << " to "<<graph.getData(*minNeighbor)<<" " <<minEdgeWeight << " "<<std::endl; #endif //Acquire locks on neighborhood of min neighbor. for (Graph::edge_iterator e_it = graph.edge_begin(*minNeighbor, Galois::MethodFlag::ALL), edst = graph.edge_end(*minNeighbor, Galois::MethodFlag::ALL); e_it != edst; ++e_it) { graph.getData(graph.getEdgeDst(e_it)); } assert(minEdgeWeight>=0); //update MST weight. *MSTWeight.getLocal() += minEdgeWeight; typedef std::pair<GNode, EdgeDataType> EdgeData; typedef std::set<EdgeData, std::less<EdgeData>, Galois::PerIterAllocTy::rebind<EdgeData>::other> edsetTy; edsetTy toAdd(std::less<EdgeData>(), Galois::PerIterAllocTy::rebind<EdgeData>::other(lwl.getPerIterAlloc())); for (Graph::edge_iterator mdst = graph.edge_begin(*minNeighbor, Galois::MethodFlag::NONE), medst = graph.edge_end(*minNeighbor, Galois::MethodFlag::NONE); mdst != medst; ++mdst) { GNode dstNode = graph.getEdgeDst(mdst); int edgeWeight = graph.getEdgeData(mdst,Galois::MethodFlag::NONE); if (dstNode != src) { //Do not add the edge being contracted Graph::edge_iterator dup_edge = graph.findEdge(src, dstNode, Galois::MethodFlag::NONE); if (dup_edge != graph.edge_end(src, Galois::MethodFlag::NONE)) { EdgeDataType dup_wt = graph.getEdgeData(dup_edge,Galois::MethodFlag::NONE); graph.getEdgeData(dup_edge,Galois::MethodFlag::NONE) = std::min<EdgeDataType>(edgeWeight, dup_wt); assert(std::min<EdgeDataType>(edgeWeight, dup_wt)>=0); } else { toAdd.insert(EdgeData(dstNode, edgeWeight)); assert(edgeWeight>=0); } } } graph.removeNode(*minNeighbor, Galois::MethodFlag::NONE); for (edsetTy::iterator it = toAdd.begin(), endIt = toAdd.end(); it != endIt; it++) { graph.getEdgeData(graph.addEdge(src, it->first, Galois::MethodFlag::NONE)) = it->second; } lwl.push(src); #if COMPILE_STATISICS if(stat_collector.tick().counter%BORUVKA_SAMPLE_FREQUENCY==0) stat_collector.snap(); #endif } }; /////////////////////////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////////////////////// struct Indexer: public std::unary_function<const GNode&, unsigned> { unsigned operator()(const GNode& n) { return std::distance(graph.edge_begin(n, Galois::MethodFlag::NONE), graph.edge_end(n, Galois::MethodFlag::NONE)); } static unsigned foo(const GNode& n) { return std::distance(graph.edge_begin(n, Galois::MethodFlag::NONE), graph.edge_end(n, Galois::MethodFlag::NONE)); } }; struct seq_less: public std::binary_function<const GNode&, const GNode&, bool> { bool operator()(const GNode& lhs, const GNode& rhs) const { if (Indexer::foo(lhs) < Indexer::foo(rhs)) return true; if (Indexer::foo(lhs) > Indexer::foo(rhs)) return false; return lhs < rhs; } }; struct seq_gt: public std::binary_function<const GNode&, const GNode&, bool> { bool operator()(const GNode& lhs, const GNode& rhs) const { if (Indexer::foo(lhs) > Indexer::foo(rhs)) return true; if (Indexer::foo(lhs) < Indexer::foo(rhs)) return false; return lhs > rhs; } }; //End body of for-each. /////////////////////////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////////////////////// EdgeDataType runBodyParallel() { using namespace Galois::WorkList; typedef dChunkedFIFO<64> dChunk; typedef ChunkedFIFO<64> Chunk; typedef OrderedByIntegerMetric<Indexer, dChunk> OBIM; #if BORUVKA_DEBUG std::cout<<"Graph size "<<graph.size()<<std::endl; #endif #if COMPILE_STATISICS BORUVKA_SAMPLE_FREQUENCY = graph.size()/200;//200 samples should be sufficient. #endif for (size_t i = 0; i < MSTWeight.size(); i++){ *MSTWeight.getRemote(i) = 0; } cout << "Starting loop body\n"; Galois::StatTimer T; T.start(); #ifdef GALOIS_USE_EXP Exp::PriAuto<64, Indexer, OBIM, seq_less, seq_gt>::for_each(graph.begin(), graph.end(), process()); #else Galois::for_each_local(graph, process(), Galois::wl<OBIM>()); #endif T.stop(); EdgeDataType res = 0; for (size_t i = 0; i < MSTWeight.size(); i++) { #if BORUVKA_DEBUG std::cout<<"MST +=" << *MSTWeight.getRemote(i)<<std::endl; #endif res += *MSTWeight.getRemote(i); } // std::cout << "MST Weight is " << res <<std::endl; return res; } ///////////////////////////////////////////////////////////////////////////////////////// static void makeGraph(const char* input) { std::vector<GNode> nodes; //Create local computation graph. typedef Galois::Graph::LC_CSR_Graph<Node, EdgeDataType> InGraph; typedef InGraph::GraphNode InGNode; InGraph in_graph; //Read graph from file. Galois::Graph::readGraph(in_graph, input); std::cout << "Read " << in_graph.size() << " nodes\n"; //A node and a int is an element. typedef std::pair<InGNode, EdgeDataType> Element; //A vector of element is 'Elements' typedef std::vector<Element> Elements; //A vector of 'Elements' is a 'Map' typedef std::vector<Elements> Map; //'in_edges' is a vector of vector of pairs of nodes and int. Map edges(in_graph.size()); // int numEdges = 0; for (InGraph::iterator src = in_graph.begin(), esrc = in_graph.end(); src != esrc; ++src) { for (InGraph::edge_iterator dst = in_graph.edge_begin(*src, Galois::MethodFlag::NONE), edst = in_graph.edge_end(*src, Galois::MethodFlag::NONE); dst != edst; ++dst) { if (*src == *dst) { #if BORUVKA_DEBUG std::cout<<"ERR:: Self loop at "<<*src<<std::endl; #endif continue; } EdgeDataType w = in_graph.getEdgeData(dst); Element e(*src, w); edges[in_graph.getEdgeDst(dst)].push_back(e); numEdges++; } } #if BORUVKA_DEBUG std::cout<<"Number of edges "<<numEdges<<std::endl; #endif nodes.resize(in_graph.size()); for (Map::iterator i = edges.begin(), ei = edges.end(); i != ei; ++i) { Node n(nodeID); GNode node = graph.createNode(n); graph.addNode(node); nodes[nodeID] = node; nodeID++; } int id = 0; numEdges = 0; EdgeDataType edge_sum = 0; int numDups = 0; for (Map::iterator i = edges.begin(), ei = edges.end(); i != ei; ++i) { GNode src = nodes[id]; for (Elements::iterator j = i->begin(), ej = i->end(); j != ej; ++j) { Graph::edge_iterator it = graph.findEdge(src, nodes[j->first], Galois::MethodFlag::NONE); if (it != graph.edge_end(src, Galois::MethodFlag::NONE)) { numDups++; EdgeDataType w = (graph.getEdgeData(it)); if (j->second < w) { graph.getEdgeData(it) = j->second; edge_sum += (j->second-w); } } else { graph.getEdgeData(graph.addEdge(src, nodes[j->first], Galois::MethodFlag::NONE)) = j->second; edge_sum += j->second; } numEdges++; assert(edge_sum < std::numeric_limits<EdgeDataType>::max()); } id++; } #if BORUVKA_DEBUG std::cout << "Final num edges " << numEdges << " Dups " << numDups << " sum :" << edge_sum << std::endl; #endif } ////////////////////////////////////////////////////////////////////////////////////////// //////////////////////////////////RMAT Reading function////////////////////////////////// template<typename NdTy, typename EdTy> struct EdgeTuple{ NdTy src; NdTy dst; EdTy wt; EdgeTuple(NdTy s, NdTy d, EdTy w):src(s),dst(d),wt(w){}; void print()const{ cout << "[" << src << ", " << dst << " , " << wt << "]\n"; } }; template<typename NdTy, typename EdTy> struct LessThanEdgeTuple{ bool operator()(const EdgeTuple<NdTy,EdTy> & o1, const EdgeTuple<NdTy,EdTy> &o2){ return (o1.wt==o2.wt)? o1.src < o2.src : o1.wt<o2.wt; } }; template<typename NdTy, typename EdTy> std::ostream & operator << (std::ostream & out , const EdgeTuple<NdTy,EdTy> & e ){ e.print(); return out; } static void readWeightedRMAT(const char* input) { std::vector<EdgeTuple<NodeDataType,EdgeDataType> > et; et.reserve(100000000); ifstream inFile (input); NodeDataType src, dst; EdgeDataType wt; char header[30]; inFile.seekg(0, ios::beg); inFile>>header; NodeDataType max_id=0; while(inFile.eof()==false){ inFile>>src; inFile>>dst; inFile>>wt; max_id = max(max_id, (src>dst?src:dst)); et.push_back(EdgeTuple<NodeDataType, EdgeDataType>(src,dst,wt)); } std::vector<GNode> nodes; nodes.resize(max_id+1); for (NodeDataType l = 0; l < max_id+1 ; ++l) { Node n(nodeID); GNode node = graph.createNode(n); nodes[nodeID] = node; nodeID++; } long numEdges = 0; EdgeDataType edge_sum = 0; int numDups = 0; for (std::vector<EdgeTuple<NodeDataType, EdgeDataType> >::iterator eIt = et.begin(), end = et.end(); eIt!=end; ++eIt) { EdgeTuple<NodeDataType,EdgeDataType> e = *eIt; Graph::edge_iterator it = graph.findEdge(nodes[e.src], nodes[e.dst], Galois::MethodFlag::NONE); if (it != graph.edge_end(nodes[e.src], Galois::MethodFlag::NONE)) { numDups++; EdgeDataType w = (graph.getEdgeData(it)); if (e.wt < w) { graph.getEdgeData(it) = e.wt; edge_sum += (e.wt-w); } } else { graph.getEdgeData(graph.addEdge(nodes[e.src], nodes[e.dst], Galois::MethodFlag::NONE)) = e.wt; edge_sum += e.wt; } numEdges++; assert(edge_sum < std::numeric_limits<EdgeDataType>::max()); } } ////////////////////////////End READ WRMAT//////////////////////////////////////////////// ////////////////////////////Kruskal//////////////////////////////////////////////// #if BORUVKA_DEBUG typedef EdgeTuple<NodeDataType, EdgeDataType> KEdgeTuple; typedef std::vector<KEdgeTuple> KruskalGraph; KruskalGraph read_edges(Graph &g){ KruskalGraph * ret = new KruskalGraph (); for(Graph::iterator it = g.begin(), e = g.end(); it!=e; ++it){ for(Graph::edge_iterator e_it = g.edge_begin(*it), e_end = g.edge_end(*it); e_it!=e_end; ++e_it){ ret->push_back(KEdgeTuple(g.getData(*it).id,g.getData(g.getEdgeDst(e_it)).id, g.getEdgeData(e_it) )); } } std::cout<<"Number of edge tuples " << ret->size() << "\n"; return *ret; } EdgeDataType kruskal_impl(const size_t num_nodes, KruskalGraph kg){ std::sort(kg.begin(), kg.end(), LessThanEdgeTuple<NodeDataType,EdgeDataType>()); UnionFind<NodeDataType,-1> uf(num_nodes); size_t mst_size = 0; EdgeDataType mst_sum = 0; for(size_t i = 0; i < kg.size(); ++i){ KEdgeTuple e = kg[i]; NodeDataType src = uf.uf_find(e.src); NodeDataType dst = uf.uf_find(e.dst); if(src!=dst){ uf.uf_union(src,dst); mst_sum+=e.wt; mst_size++; if(mst_size>=num_nodes-1) return mst_sum; } } return -1; } EdgeDataType verify(Graph & g){ return kruskal_impl(g.size(), read_edges(g)); } #endif ////////////////////////////////////////////////////////////////////////////////////////// int main(int argc, char **argv) { Galois::StatManager M; LonestarStart(argc, argv, name, desc, url); if(use_weighted_rmat) readWeightedRMAT(inputfile.c_str()); else makeGraph(inputfile.c_str()); #if BORUVKA_DEBUG EdgeDataType kruskal_wt; if(verify_via_kruskal){ kruskal_wt= verify(graph); cout<<"Kruskal MST Result is " << kruskal_wt <<"\n"; } #endif cout << "Starting loop body\n"; EdgeDataType mst_wt = runBodyParallel(); cout<<"Boruvka MST Result is " << mst_wt <<"\n"; #if BORUVKA_DEBUG if(verify_via_kruskal){ assert(kruskal_wt==mst_wt); } #endif #if COMPILE_STATISICS cout<< " \n==================================================\n"; stat_collector.dump(cout); cout<< " \n==================================================\n"; #endif return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/boruvka/UnionFind.h
#ifndef GALOIS_UNION_FIND #define GALOIS_UNION_FIND template<typename ElTy, ElTy initializer> struct UnionFind { ElTy * parents; const size_t size; UnionFind(size_t sz) : size(sz) { parents = new ElTy [size]; for (size_t s = 0; s < sz; s++) parents[s] = initializer; } ElTy uf_find(ElTy e) { if(parents[e]==initializer) return e; ElTy tmp = e; ElTy rep = initializer; while (parents[tmp] != initializer) tmp = parents[tmp]; rep = tmp; tmp = e; while (parents[tmp] != initializer) { parents[tmp] = rep; tmp = parents[tmp]; } return rep; } void uf_union(ElTy e1, ElTy e2) { parents[e1]=e2; } ~UnionFind() { delete parents; } }; void test_uf(){ UnionFind<int, -1> sample(10000); } #endif // def GALOIS_UNION_FIND
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/kruskal/KruskalSerial.h
/** Kruskal Serial ordered version -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Kruskal Serial ordered version. * * @author <[email protected]> */ #ifndef KRUSKAL_SERIAL_H_ #define KRUSKAL_SERIAL_H_ #include "Kruskal.h" namespace kruskal { class KruskalSerial: public Kruskal { protected: // #define EDGE_FRAC (4/3); virtual const std::string getVersion () const { return "Serial Ordered Kruskal"; } virtual void runMSTsplit (const size_t numNodes, const VecEdge& in_edges, size_t& mstWeight, size_t& totalIter) { Galois::TimeAccumulator t_run; Galois::TimeAccumulator t_init; Galois::TimeAccumulator t_sort; Galois::TimeAccumulator t_loop; t_init.start (); VecEdge edges (in_edges); VecRep repVec (numNodes, -1); t_init.stop (); t_run.start (); // size_t splitSize = EDGE_FRAC * numNodes; size_t splitSize = numNodes; t_sort.start (); VecEdge::iterator splitPoint = edges.begin () + splitSize; std::nth_element (edges.begin (), splitPoint, edges.end (), Edge::Comparator ()); std::sort (edges.begin (), splitPoint, Edge::Comparator ()); t_sort.stop (); size_t mstSum = 0; size_t iter = 0; t_loop.start (); for (VecEdge::const_iterator i = edges.begin (), ei = splitPoint; i != ei; ++i) { ++iter; int rep1 = findPCiter_int (i->src, repVec); int rep2 = findPCiter_int (i->dst, repVec); if (rep1 != rep2) { unionByRank_int (rep1, rep2, repVec); mstSum += i->weight; } } VecEdge remaining; for (VecEdge::const_iterator i = splitPoint, ei = edges.end (); i != ei; ++i) { int rep1 = findPCiter_int (i->src, repVec); int rep2 = findPCiter_int (i->dst, repVec); if (rep1 != rep2) { remaining.push_back (*i); } } t_loop.stop (); std::cout << "Number of remaining edges needing to be processed: " << remaining.size () << std::endl; t_sort.start (); std::sort (remaining.begin (), remaining.end (), Edge::Comparator ()); t_sort.stop (); t_loop.start (); for (VecEdge::const_iterator i = remaining.begin (), ei = remaining.end (); i != ei; ++i) { ++iter; int rep1 = findPCiter_int (i->src, repVec); int rep2 = findPCiter_int (i->dst, repVec); if (rep1 != rep2) { unionByRank_int (rep1, rep2, repVec); mstSum += i->weight; } } t_loop.stop (); mstWeight = mstSum; totalIter = iter; t_run.stop (); std::cout << "Running time excluding initialization and destruction: " << t_run.get () << std::endl; std::cout << "Initialization time: " << t_init.get () << std::endl; std::cout << "Sorting time: " << t_sort.get () << std::endl; std::cout << "Loop time: " << t_loop.get () << std::endl; } virtual void runMSTsimple (const size_t numNodes, const VecEdge& in_edges, size_t& mstWeight, size_t& totalIter) { Galois::StatTimer t_run("Running time excluding initialization & destruction: "); Galois::StatTimer t_init("initialization time: "); Galois::StatTimer t_sort("serial sorting time: "); Galois::StatTimer t_loop("serial loop time: "); t_init.start (); VecRep repVec (numNodes, -1); VecEdge edges (in_edges); t_init.stop (); t_run.start (); t_sort.start (); std::sort (edges.begin (), edges.end (), Edge::Comparator ()); t_sort.stop (); size_t mstSum = 0; size_t iter = 0; t_loop.start (); for (VecEdge::const_iterator i = edges.begin (), ei = edges.end (); i != ei; ++i) { ++iter; int rep1 = findPCiter_int (i->src, repVec); int rep2 = findPCiter_int (i->dst, repVec); if (rep1 != rep2) { unionByRank_int (rep1, rep2, repVec); mstSum += i->weight; } } mstWeight = mstSum; totalIter = iter; t_loop.stop (); t_run.stop (); } virtual void runMST (const size_t numNodes, const VecEdge& edges, size_t& mstWeight, size_t& totalIter) { runMSTsplit (numNodes, edges, mstWeight, totalIter); } }; } // end namespace kruskal #endif // KRUSKAL_SERIAL_H_
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/kruskal/CMakeLists.txt
app (KruskalSerial KruskalSerial.cpp) app (KruskalHand KruskalHand.cpp) app (KruskalOrdered KruskalOrdered.cpp)
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/kruskal/KruskalHand.cpp
/** Parallel Handwritten Kruskal -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Parallel Handwritten version of Kruskal. * * @author <[email protected]> */ #include "KruskalHand.h" int main (int argc, char* argv[]) { kruskal::KruskalHand k; k.run (argc, argv); return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/kruskal/KruskalParallel.h
/** Kruskal MST -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Kruskal MST. * * @author <[email protected]> */ #ifndef KRUSKAL_PARALLEL_H #define KRUSKAL_PARALLEL_H #include "Galois/Atomic.h" #include "Galois/Accumulator.h" #include "Galois/Runtime/PerThreadWorkList.h" #include "Galois/Runtime/ll/CompilerSpecific.h" #include "Kruskal.h" namespace kruskal { struct EdgeCtx; typedef VecRep VecRep_ty; typedef Galois::Runtime::PerThreadVector<Edge> EdgeWL; typedef Galois::Runtime::PerThreadVector<EdgeCtx> EdgeCtxWL; typedef Galois::Runtime::MM::FSBGaloisAllocator<EdgeCtx> EdgeCtxAlloc; typedef Edge::Comparator Cmp; typedef Galois::GAccumulator<size_t> Accumulator; // typedef Galois::GAtomicPadded<EdgeCtx*> AtomicCtxPtr; typedef Galois::GAtomic<EdgeCtx*> AtomicCtxPtr; typedef std::vector<AtomicCtxPtr> VecAtomicCtxPtr; static const int NULL_EDGE_ID = -1; struct EdgeCtx: public Edge { bool srcFail; bool dstFail; EdgeCtx (const Edge& e) : Edge (e) , srcFail (false), dstFail(false) {} void setFail (const int rep) { assert (rep != NULL_EDGE_ID); if (rep == src) { srcFail = true; } else if (rep == dst) { dstFail = true; } else { abort (); } } void resetStatus () { srcFail = false; dstFail = false; } bool isSrcFail () const { return srcFail; } bool isDstFail () const { return dstFail; } bool isSelf () const { return src == dst; } bool statusIsReset () const { return (!srcFail && !dstFail); } }; struct FindLoop { // typedef char tt_does_not_need_push; VecRep_ty& repVec; VecAtomicCtxPtr& repOwnerCtxVec; Accumulator& findIter; FindLoop ( VecRep_ty& repVec, VecAtomicCtxPtr& repOwnerCtxVec, Accumulator& findIter) : repVec (repVec), repOwnerCtxVec (repOwnerCtxVec), findIter (findIter) {} GALOIS_ATTRIBUTE_PROF_NOINLINE void claimAsMin (EdgeCtx& ctx, const int rep) { bool succ = repOwnerCtxVec[rep].cas (NULL, &ctx); assert (repOwnerCtxVec[rep] != NULL); if (!succ) { for (EdgeCtx* curr = repOwnerCtxVec[rep]; Cmp::compare (*curr, ctx) > 0; curr = repOwnerCtxVec[rep]) { assert (curr != NULL); succ = repOwnerCtxVec[rep].cas (curr, &ctx); if (succ) { curr->setFail (rep); assert (Cmp::compare (*repOwnerCtxVec[rep], ctx) <= 0); break; } } } if (!succ) { ctx.setFail (rep); } } GALOIS_ATTRIBUTE_PROF_NOINLINE void operator () (EdgeCtx& ctx) { findIter += 1; assert (ctx.statusIsReset ()); ctx.src = kruskal::findPCiter_int (ctx.src, repVec); ctx.dst = kruskal::findPCiter_int (ctx.dst, repVec); if (ctx.src != ctx.dst) { claimAsMin (ctx, ctx.src); claimAsMin (ctx, ctx.dst); } } template <typename C> GALOIS_ATTRIBUTE_PROF_NOINLINE void operator () (EdgeCtx& ctx, C&) { (*this) (ctx); } GALOIS_ATTRIBUTE_PROF_NOINLINE void operator () (EdgeCtx& ctx) const { const_cast<FindLoop*>(this)->operator () (ctx); } }; template <bool usingOrderedRuntime=false> struct LinkUpLoop { // typedef char tt_does_not_need_push; VecRep_ty& repVec; VecAtomicCtxPtr& repOwnerCtxVec; EdgeCtxWL& nextWL; Accumulator& mstSum; Accumulator& linkUpIter; LinkUpLoop ( VecRep_ty& repVec, VecAtomicCtxPtr& repOwnerCtxVec, EdgeCtxWL& nextWL, Accumulator& mstSum, Accumulator& linkUpIter) : repVec (repVec), repOwnerCtxVec (repOwnerCtxVec), nextWL (nextWL), mstSum (mstSum), linkUpIter (linkUpIter) {} GALOIS_ATTRIBUTE_PROF_NOINLINE bool updateODG_test (EdgeCtx& ctx, const int rep) { assert (rep >= 0 && size_t (rep) < repOwnerCtxVec.size ()); if (usingOrderedRuntime) { return ((EdgeCtx*) repOwnerCtxVec[rep])->id == ctx.id; } else { return (repOwnerCtxVec[rep] == &ctx); } } GALOIS_ATTRIBUTE_PROF_NOINLINE void updateODG_reset (EdgeCtx& ctx, const int rep) { assert (rep >= 0 && size_t (rep) < repOwnerCtxVec.size ()); assert (updateODG_test (ctx, rep)); repOwnerCtxVec[rep] = NULL; } GALOIS_ATTRIBUTE_PROF_NOINLINE void operator () (EdgeCtx& ctx) { if (!ctx.isSelf () ) { if (ctx.isSrcFail () && ctx.isDstFail ()) { ctx.resetStatus (); if (usingOrderedRuntime) { Galois::Runtime::signalConflict (NULL); } else { nextWL.get ().push_back (ctx); } } else { if (!ctx.isSrcFail ()) { assert (updateODG_test (ctx, ctx.src)); linkUp_int (ctx.src, ctx.dst, repVec); } else if (!ctx.isDstFail ()) { assert (updateODG_test (ctx, ctx.dst)); linkUp_int (ctx.dst, ctx.src, repVec); } linkUpIter += 1; mstSum += ctx.weight; if (!ctx.isSrcFail ()) { updateODG_reset (ctx, ctx.src); } if (!ctx.isDstFail ()) { updateODG_reset (ctx, ctx.dst); } } // end else } } template <typename C> GALOIS_ATTRIBUTE_PROF_NOINLINE void operator () (EdgeCtx& ctx, C&) { (*this) (ctx); } GALOIS_ATTRIBUTE_PROF_NOINLINE void operator () (EdgeCtx& ctx) const { const_cast<LinkUpLoop*>(this)->operator () (ctx); } }; template <typename WL> struct PreSort { WL& wl; PreSort (WL& wl): wl (wl) {} GALOIS_ATTRIBUTE_PROF_NOINLINE void operator () (unsigned tid, unsigned numT) { assert (tid < wl.numRows ()); for (unsigned i = numT; i < wl.numRows (); ++i) { assert (wl[i].empty ()); } std::sort (wl[tid].begin (), wl[tid].end (), Cmp ()); } }; template <typename WL> void presort (WL& wl, Galois::TimeAccumulator& sortTimer) { sortTimer.start (); Galois::on_each (PreSort<WL> (wl), "pre_sort"); sortTimer.stop (); } template <typename Iter> struct Range { typedef typename std::iterator_traits<Iter>::difference_type difference_type; typedef typename std::iterator_traits<Iter>::value_type value_type; typedef Galois::Runtime::PerThreadStorage<Range> PTS; Iter m_beg; Iter m_end; Range (): m_beg (), m_end () {} Range (Iter b, Iter e): m_beg (b), m_end (e) {} // TODO: improve for non-random iterators const value_type* atOffset (difference_type d) { if (m_beg == m_end) { return NULL; } else { if (d >= std::distance (m_beg, m_end)) { d = std::distance (m_beg, m_end) - 1; } Iter i (m_beg); std::advance (i, d); return &(*i); } } }; template <typename T, typename I, typename WL> struct RefillWorkList { const T* windowLimit; typename Range<I>::PTS& ranges; WL& wl; RefillWorkList ( const T* windowLimit, typename Range<I>::PTS& ranges, WL& wl) : windowLimit (windowLimit), ranges (ranges), wl (wl) {} void operator () (unsigned tid, unsigned numT) { assert (tid < ranges.size ()); for (unsigned i = numT; i < ranges.size (); ++i) { Range<I>& r = *ranges.getRemote (i); assert (r.m_beg == r.m_end); } Range<I>& r = *ranges.getRemote (tid); for (;r.m_beg != r.m_end; ++r.m_beg) { if (Cmp::compare (*r.m_beg, *windowLimit) <= 0) { wl.get ().push_back (*r.m_beg); } else { break; } } } // end method }; template <typename WL, typename I> void refillWorkList (WL& wl, typename Range<I>::PTS& ranges, const size_t windowSize, const size_t numT) { typedef typename Range<I>::value_type T; size_t perThrdSize = windowSize / numT; const T* windowLimit = NULL; for (unsigned i = 0; i < numT; ++i) { assert (i < ranges.size ()); const T* lim = ranges.getRemote (i)->atOffset (perThrdSize); if (lim != NULL) { if (windowLimit == NULL || (Cmp::compare (*lim, *windowLimit) > 0)) { windowLimit = lim; } } } Galois::Runtime::LL::gDebug("size before refill: ", wl.size_all ()); if (windowLimit != NULL) { Galois::Runtime::LL::gDebug("new window limit: ", windowLimit->str ().c_str ()); Galois::on_each (RefillWorkList<T, I, WL> (windowLimit, ranges, wl), "refill"); for (unsigned i = 0; i < ranges.size (); ++i) { Range<I>& r = *ranges.getRemote (i); if (r.m_beg != r.m_end) { // assuming that ranges are sorted // after refill, the first element in each range should be bigger // than windowLimit assert (Cmp::compare (*r.m_beg, *windowLimit) > 0); } } } else { for (unsigned i = 0; i < ranges.size (); ++i) { Range<I>& r = *ranges.getRemote (i); assert (r.m_beg == r.m_end); } } Galois::Runtime::LL::gDebug("size after refill: ", wl.size_all ()); } struct UnionFindWindow { size_t maxRounds; size_t lowThresh; UnionFindWindow (): maxRounds (64), lowThresh (2) {} UnionFindWindow (size_t maxRounds, size_t lowThresh) : maxRounds (maxRounds), lowThresh (lowThresh) {} void operator () ( EdgeCtxWL& perThrdWL, VecRep_ty& repVec, VecAtomicCtxPtr& repOwnerCtxVec, size_t& mstWeight, size_t& totalIter, Galois::TimeAccumulator& sortTimer, Galois::TimeAccumulator& findTimer, Galois::TimeAccumulator& linkUpTimer, Accumulator& findIter, Accumulator& linkUpIter) const { typedef EdgeCtxWL::local_iterator Iter; typedef Range<Iter> Range_ty; typedef Range_ty::PTS PerThrdRange; typedef Range_ty::difference_type Diff_ty; PerThrdRange ranges; presort (perThrdWL, sortTimer); for (unsigned i = 0; i < ranges.size (); ++i) { *ranges.getRemote (i) = Range_ty (perThrdWL[i].begin (), perThrdWL[i].end ()); } const size_t numT = Galois::getActiveThreads (); const size_t totalDist = perThrdWL.size_all (); const size_t windowSize = totalDist / maxRounds; const size_t lowThreshSize = windowSize / lowThresh; unsigned round = 0; size_t numUnions = 0; Accumulator mstSum; EdgeCtxWL* currWL = new EdgeCtxWL (); EdgeCtxWL* nextWL = new EdgeCtxWL (); while (true) { ++round; std::swap (nextWL, currWL); nextWL->clear_all (); if (currWL->size_all () <= lowThreshSize) { // size_t s = lowThreshSize - currWL->size_all () + 1; sortTimer.start (); refillWorkList<EdgeCtxWL, Iter> (*currWL, ranges, windowSize, numT); sortTimer.stop (); } if (currWL->empty_all ()) { break; } // Galois::Runtime::beginSampling (); findTimer.start (); Galois::do_all (currWL->begin_all (), currWL->end_all (), FindLoop (repVec, repOwnerCtxVec, findIter), Galois::loopname("find_loop")); findTimer.stop (); // Galois::Runtime::endSampling (); // Galois::Runtime::beginSampling (); linkUpTimer.start (); Galois::do_all (currWL->begin_all (), currWL->end_all (), LinkUpLoop<false> (repVec, repOwnerCtxVec, *nextWL, mstSum, linkUpIter), Galois::loopname("link_up_loop")); linkUpTimer.stop (); // Galois::Runtime::endSampling (); int u = linkUpIter.reduce () - numUnions; numUnions = linkUpIter.reduce (); if (!nextWL->empty_all ()) { assert (u > 0 && "no unions, no progress?"); } } totalIter += findIter.reduce (); mstWeight += mstSum.reduce (); std::cout << "Number of rounds: " << round << std::endl; delete currWL; delete nextWL; } }; struct FillUp { EdgeCtxWL& wl; explicit FillUp (EdgeCtxWL& wl): wl (wl) {} GALOIS_ATTRIBUTE_PROF_NOINLINE void operator () (const Edge& edge) { wl.get ().push_back (edge); } }; template <typename UF> void runMSTsimple (const size_t numNodes, const VecEdge& edges, size_t& mstWeight, size_t& totalIter, UF ufLoop) { totalIter = 0; mstWeight = 0; Galois::TimeAccumulator runningTime; Galois::TimeAccumulator sortTimer; Galois::TimeAccumulator findTimer; Galois::TimeAccumulator linkUpTimer; Galois::TimeAccumulator fillUpTimer; Accumulator findIter; Accumulator linkUpIter; VecRep_ty repVec (numNodes, -1); VecAtomicCtxPtr repOwnerCtxVec (numNodes, AtomicCtxPtr (NULL)); fillUpTimer.start (); EdgeCtxWL initWL; unsigned numT = Galois::getActiveThreads (); for (unsigned i = 0; i < numT; ++i) { initWL[i].reserve ((edges.size () + numT - 1) / numT); } Galois::do_all (edges.begin (), edges.end (), FillUp (initWL), Galois::loopname("fill_init")); fillUpTimer.stop (); runningTime.start (); ufLoop (initWL, repVec, repOwnerCtxVec, mstWeight, totalIter, sortTimer, findTimer, linkUpTimer, findIter, linkUpIter); runningTime.stop (); std::cout << "Number of FindLoop iterations = " << findIter.reduce () << std::endl; std::cout << "Number of LinkUpLoop iterations = " << linkUpIter.reduce () << std::endl; std::cout << "MST running time without initialization/destruction: " << runningTime.get () << std::endl; std::cout << "Time taken by sortTimer: " << sortTimer.get () << std::endl; std::cout << "Time taken by FindLoop: " << findTimer.get () << std::endl; std::cout << "Time taken by LinkUpLoop: " << linkUpTimer.get () << std::endl; std::cout << "Time taken by FillUp: " << fillUpTimer.get () << std::endl; } }// end namespace kruskal #endif // KRUSKAL_PARALLEL_H
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/kruskal/Kruskal.h
/** Kruskal MST -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Kruskal MST. * * @author <[email protected]> */ #ifndef _KRUSKAL_H_ #define _KRUSKAL_H_ #include "Galois/config.h" #include <vector> #include <string> #include <sstream> #include <limits> #include <iostream> #include <set> #include GALOIS_CXX11_STD_HEADER(unordered_set) #include <cstdlib> #include <cstdio> #include <boost/iterator/counting_iterator.hpp> #include "Galois/Timer.h" #include "Galois/Statistic.h" #include "Galois/Galois.h" #include "Galois/Graph/LCGraph.h" #include "Galois/WorkList/WorkList.h" #include "Galois/Runtime/Sampling.h" #include "llvm/Support/CommandLine.h" #include "Lonestar/BoilerPlate.h" namespace cll = llvm::cl; static const char* const name = "Kruskal's Minimum Spanning Tree Algorithm "; static const char* const desc = "Computes minimum weight spanning tree of an undirected graph"; static const char* const url = "mst"; static cll::opt<std::string> filename(cll::Positional, cll::desc("<input file>"), cll::Required); static cll::opt<unsigned> numPages ( "preAlloc", cll::desc ("number of pages(per thread) to pre-allocate from OS for Galois allocators "), cll::init (32)); namespace kruskal { typedef unsigned Weight_ty; typedef std::vector<int> VecRep; struct Edge; typedef std::vector<Edge> VecEdge; struct InEdge { int src; int dst; Weight_ty weight; InEdge (int _src, int _dst, Weight_ty _weight) : src (_src), dst (_dst), weight (_weight) { if (src == dst) { fprintf (stderr, "Self edges not allowed\n"); abort (); } // nodes in an edge ordered so that reverse edges can be detected as duplicates if (src > dst) { std::swap (src, dst); } assert (src <= dst); } // equals function purely based on src and dst to detect duplicates friend bool operator == (const InEdge& left, const InEdge& right) { return (left.src == right.src) && (left.dst == right.dst); } struct Hash { // hash function purely based on src and dst to find and remove duplicates size_t operator () (const InEdge& edge) const { return (size_t (edge.src) << 32) ^ size_t(edge.dst); } }; }; struct Edge: public InEdge { unsigned id; Edge (unsigned _id, int _src, int _dst, Weight_ty _weight) : InEdge (_src, _dst, _weight), id (_id) {} friend bool operator == (const Edge& left, const Edge& right) { return (left.id == right.id) && (left.src == right.src) && (left.dst == right.dst) && (left.weight == right.weight); } std::string str () const { char s[256]; sprintf (s, "(id=%d,src=%d,dst=%d,weight=%d)", id, src, dst, weight); return std::string (s); } friend std::ostream& operator << (std::ostream& out, const Edge& edge) { return (out << edge.str ()); } struct Comparator { static inline int compare (const Edge& left, const Edge& right) { int d = left.weight - right.weight; return (d != 0) ? d : (left.id - right.id); } bool operator () (const Edge& left, const Edge& right) const { return compare (left, right) < 0; } }; }; template <typename V> static void unionByRank_int (int rep1, int rep2, V& repVec) { assert (rep1 >= 0 && size_t (rep1) < repVec.size ()); assert (rep2 >= 0 && size_t (rep2) < repVec.size ()); assert (repVec[rep1] < 0); assert (repVec[rep2] < 0); if (repVec[rep2] < repVec[rep1]) { std::swap (rep1, rep2); } assert (repVec[rep1] <= repVec[rep2]); repVec[rep1] += repVec[rep2]; repVec[rep2] = rep1; assert (repVec[rep1] < 0); } template <typename V> static void linkUp_int (int other, int master, V& repVec) { assert (other >= 0 && size_t (other) < repVec.size ()); assert (master >= 0 && size_t (master) < repVec.size ()); assert (repVec[other] < 0); // assert (repVec[master] < 0); // can't check this in parallel repVec[other] = master; } template <typename V> int findPCiter_int (const int node, V& repVec) { assert (node >= 0 && size_t (node) < repVec.size ()); if (repVec[node] < 0) { return node; } assert (repVec[node] >= 0); int rep = repVec[node]; if (repVec[rep] < 0) { return rep; } while (repVec[rep] >= 0) { rep = repVec[rep]; } // path compress for (int n = node; n != rep;) { repVec[n] = rep; n = repVec[n]; } assert (rep >= 0 && size_t (rep) < repVec.size ()); return rep; } template <typename V> int getRep_int (const int node, const V& repVec) { assert (node >= 0 && size_t (node) < repVec.size ()); if (repVec[node] < 0) { return node; } int rep = repVec[node]; while (repVec[rep] >= 0) { rep = repVec[rep]; } assert (repVec[rep] < 0); return rep; } class Kruskal { public: typedef std::vector<Edge> VecEdge; typedef std::unordered_set<InEdge, InEdge::Hash> SetInEdge; protected: virtual const std::string getVersion () const = 0; //! doesn't do anything by default. Sub-classes may choose to override //! in order to to specific initialization virtual void initRemaining (const size_t numNodes, const VecEdge& edges) { }; virtual void runMST (const size_t numNodes, const VecEdge& edges, size_t& mstWeight, size_t& totalIter) = 0; void readGraph (const std::string& filename, size_t& numNodes, SetInEdge& edgeSet) { typedef Galois::Graph::LC_CSR_Graph<unsigned, uint32_t> InGraph; typedef InGraph::GraphNode InGNode; InGraph ingraph; Galois::Graph::readGraph (ingraph, filename); // numbering nodes 0..N-1, where N is number of nodes // in the graph unsigned idCntr = 0; for (InGraph::iterator n = ingraph.begin (), endn = ingraph.end (); n != endn; ++n) { ingraph.getData (*n, Galois::MethodFlag::NONE) = idCntr++; } numNodes = ingraph.size (); size_t numEdges = 0; edgeSet.clear (); for (InGraph::iterator n = ingraph.begin (), endn = ingraph.end (); n != endn; ++n) { unsigned src = ingraph.getData (*n, Galois::MethodFlag::NONE); for (InGraph::edge_iterator e = ingraph.edge_begin (src, Galois::MethodFlag::NONE), ende = ingraph.edge_end (src, Galois::MethodFlag::NONE); e != ende; ++e) { unsigned dst = ingraph.getData (ingraph.getEdgeDst (e), Galois::MethodFlag::NONE); if (src != dst) { const Weight_ty& w = ingraph.getEdgeData (e); InEdge ke (src, dst, w); std::pair<SetInEdge::iterator, bool> res = edgeSet.insert (ke); if (res.second) { ++numEdges; } else if (w < res.first->weight) { edgeSet.insert (edgeSet.erase (res.first), ke); } } else { Galois::Runtime::LL::gDebug("Warning: Ignoring self edge (", src, ",", dst, ",", ingraph.getEdgeData (*e), ")"); } } } std::cout << "Graph read with nodes=" << ingraph.size () << ", edges=" << numEdges << std::endl; } virtual void readPBBSfile (const std::string& filename, size_t& numNodes, SetInEdge& edgeSet) { typedef unsigned NodeData; typedef float EdgeData; static const unsigned WEIGHT_SCALE = 1000000; std::cout << "Reading input from: " << filename << std::endl; // std::ifstream inFile (filename.c_str ()); FILE* inFile = fopen (filename.c_str (), "r"); // std::string header; char header[128]; // inFile >> header; fscanf (inFile, "%s", header); // inFile.seekg (0, std::ios::beg); size_t numEdges = 0; numNodes = 0; edgeSet.clear (); // while (!inFile.eof ()) { while (!feof (inFile)) { NodeData srcIdx; NodeData dstIdx; EdgeData w; // inFile >> srcIdx; // inFile >> dstIdx; // inFile >> w; fscanf (inFile, "%d", &srcIdx); fscanf (inFile, "%d", &dstIdx); fscanf (inFile, "%g", &w); Weight_ty integ_wt = (WEIGHT_SCALE * w); if (srcIdx != dstIdx) { InEdge ke (srcIdx, dstIdx, integ_wt); std::pair<SetInEdge::iterator, bool> res = edgeSet.insert (ke); //edges.push_back (ke); if (res.second) { ++numEdges; } else if (integ_wt < res.first->weight) { edgeSet.insert (edgeSet.erase (res.first), ke); } } else { std::fprintf (stderr, "Warning: Ignoring self edge (%d, %d, %d)\n", srcIdx, dstIdx, integ_wt); } // find max node id; numNodes = std::max (numNodes, size_t (std::max (srcIdx, dstIdx))); } // inFile.close (); fclose (inFile); ++numNodes; // nodes number from 0 ... N-1 std::cout << "PBBS graph read with nodes = " << numNodes << ", edges = " << numEdges << std::endl; } void writePBBSfile (const std::string& filename, const SetInEdge& edgeSet) { FILE* outFile = std::fopen (filename.c_str (), "w"); assert (outFile != NULL); fprintf (outFile, "WeightedEdgeArray\n"); for (SetInEdge::const_iterator i = edgeSet.begin () , endi = edgeSet.end (); i != endi; ++i) { fprintf (outFile, "%d %d %e\n", i->src, i->dst, double (i->weight)); } fclose (outFile); } public: virtual void run (int argc, char* argv[]) { Galois::StatManager stat; LonestarStart (argc, argv, name, desc, url); size_t numNodes; SetInEdge edgeSet; size_t mstWeight = 0; size_t totalIter = 0; Galois::StatTimer t_read ("InitializeTime"); t_read.start (); readGraph (filename, numNodes, edgeSet); // readPBBSfile (filename, numNodes, edgeSet); // writePBBSfile ("edgeList.pbbs", edgeSet); // std::exit (0); VecEdge edges; unsigned edgeIDcntr = 0; for (SetInEdge::const_iterator i = edgeSet.begin () , endi = edgeSet.end (); i != endi; ++i) { edges.push_back (Edge (edgeIDcntr++, i->src, i->dst, i->weight)); } assert (edges.size () == edgeSet.size ()); t_read.stop (); initRemaining (numNodes, edges); // pre allocate memory from OS for parallel runs Galois::preAlloc (numPages*Galois::getActiveThreads ()); Galois::StatTimer t; t.start (); // GaloisRuntime::beginSampling (); runMST (numNodes, edges, mstWeight, totalIter); // GaloisRuntime::endSampling (); t.stop (); printResults (mstWeight, totalIter); if (!skipVerify) { verify (numNodes, edgeSet, mstWeight); } } private: void printResults (const size_t mstSum, const size_t iter) const { std::cout << getVersion () << ", MST sum=" << mstSum << ", iterations=" << iter << std::endl; } template <typename T> static void freeVecPtr (std::vector<T*>& vec) { for (typename std::vector<T*>::iterator i = vec.begin (), ei = vec.end (); i != ei; ++i) { delete *i; *i = NULL; } } struct PrimNode { typedef std::vector<PrimNode*> VecPNode_ty; typedef std::vector<Weight_ty> VecWeight_ty; typedef boost::counting_iterator<unsigned> Adj_iterator_ty; unsigned id; Weight_ty weight; bool inMST; VecPNode_ty adj; VecWeight_ty adjWts; PrimNode (unsigned id): id (id), weight (std::numeric_limits<Weight_ty>::max ()), inMST (false) {} void addEdge (PrimNode* pn, Weight_ty w) { assert (pn != NULL); assert (std::find (adj.begin (), adj.end (), pn) == adj.end ()); adj.push_back (pn); adjWts.push_back (w); assert (adj.size () == adjWts.size ()); } Adj_iterator_ty adj_begin () const { return Adj_iterator_ty (0); } Adj_iterator_ty adj_end () const { return Adj_iterator_ty (adj.size ()); } PrimNode* getDst (Adj_iterator_ty i) const { return adj[*i]; } Weight_ty getWeight (Adj_iterator_ty i) const { return adjWts[*i]; } }; struct PrimUpdate { PrimNode* dst; Weight_ty weight; PrimUpdate (PrimNode* dst, Weight_ty weight) : dst (dst), weight (weight) { assert (dst != NULL); } bool operator < (const PrimUpdate& that) const { if (this->weight == that.weight) { return (this->dst->id < that.dst->id); } else { return (this->weight < that.weight); } } }; size_t runPrim (const size_t numNodes, const SetInEdge& edgeSet) const { std::vector<PrimNode*> primNodes (numNodes, NULL); for (size_t i = 0; i < numNodes; ++i) { primNodes[i] = new PrimNode (i); } for (SetInEdge::const_iterator e = edgeSet.begin (), ende = edgeSet.end (); e != ende; ++e) { assert (primNodes[e->src] != NULL); assert (primNodes[e->dst] != NULL); // add undirected edge primNodes[e->src]->addEdge (primNodes[e->dst], e->weight); primNodes[e->dst]->addEdge (primNodes[e->src], e->weight); } std::set<PrimUpdate> workset; PrimNode* root = primNodes[0]; PrimUpdate upd (root, 0); workset.insert (upd); size_t iter = 0; size_t mstSum = 0; while (!workset.empty ()) { ++iter; PrimUpdate upd = *(workset.begin ()); workset.erase (workset.begin ()); PrimNode& src = *(upd.dst); if (!src.inMST) { src.inMST = true; src.weight = upd.weight; mstSum += upd.weight; for (PrimNode::Adj_iterator_ty i = src.adj_begin (), endi = src.adj_end (); i != endi; ++i) { PrimNode& dst = *(src.getDst (i)); Weight_ty wt = src.getWeight (i); if (!dst.inMST) { PrimUpdate addUpd (&dst, wt); workset.insert (addUpd); } } } // end if; } std::cout << "Number of iterations taken by Prim = " << iter << std::endl; freeVecPtr (primNodes); return mstSum; } bool verify (const size_t numNodes, const SetInEdge& edgeSet, const size_t kruskalSum) const { Galois::StatTimer pt("PrimTime"); pt.start (); size_t primSum = runPrim (numNodes, edgeSet); pt.stop (); if (primSum != kruskalSum) { std::cerr << "ERROR. Incorrect MST weight=" << kruskalSum << ", weight computed by Prim is=" << primSum << std::endl; abort (); } else { std::cout << "OK. Correct MST weight=" << kruskalSum << std::endl; } return false; } }; } // namespace kruskal #endif // _KRUSKAL_H_
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/kruskal/KruskalOrdered.h
/** Kruskal MST -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Kruskal MST. * * @author <[email protected]> */ #ifndef KRUSKAL_ORDERED_H #define KRUSKAL_ORDERED_H #include "Kruskal.h" #include "KruskalParallel.h" namespace kruskal { struct UnionFindUsingRuntime { void operator () ( EdgeCtxWL& perThrdWL, VecRep_ty& repVec, VecAtomicCtxPtr& repOwnerCtxVec, size_t& mstWeight, size_t& totalIter, Galois::TimeAccumulator& sortTimer, Galois::TimeAccumulator& findTimer, Galois::TimeAccumulator& linkUpTimer, Accumulator& findIter, Accumulator& linkUpIter) const { EdgeCtxWL* nextWL = NULL; // not used actually Accumulator mstSum; Galois::for_each_ordered (perThrdWL.begin_all (), perThrdWL.end_all (), Edge::Comparator (), FindLoop (repVec, repOwnerCtxVec, findIter), LinkUpLoop<true> (repVec, repOwnerCtxVec, *nextWL, mstSum, linkUpIter)); totalIter += findIter.reduce (); mstWeight += mstSum.reduce (); } }; class KruskalOrdered: public Kruskal { protected: virtual const std::string getVersion () const { return "Parallel Kruskal using Ordered Runtime"; } virtual void runMST (const size_t numNodes, const VecEdge& edges, size_t& mstWeight, size_t& totalIter) { runMSTsimple (numNodes, edges, mstWeight, totalIter, UnionFindUsingRuntime ()); } }; }// end namespace kruskal #endif // KRUSKAL_ORDERED_H
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/kruskal/KruskalSerial.cpp
/** Serial Kruskal -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Serial version of Kruskal. * * @author <[email protected]> */ #include "KruskalSerial.h" int main (int argc, char* argv[]) { kruskal::KruskalSerial ks; ks.run (argc, argv); return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/kruskal/KruskalHand.h
/** Kruskal MST -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Kruskal MST. * * @author <[email protected]> */ #ifndef KRUSKAL_HAND_H #define KRUSKAL_HAND_H #include "Kruskal.h" #include "KruskalParallel.h" static cll::opt<unsigned> maxRounds ( "maxRounds", cll::desc ("number of rounds for window executor"), cll::init (600)); static cll::opt<unsigned> lowThresh ( "lowThresh", cll::desc ("low parallelism factor for workList refill in window executor"), cll::init (16)); namespace kruskal { class KruskalHand: public Kruskal { protected: virtual const std::string getVersion () const { return "Handwritten using window-based two-phase union-find"; } virtual void runMST (const size_t numNodes, const VecEdge& edges, size_t& mstWeight, size_t& totalIter) { runMSTsimple (numNodes, edges, mstWeight, totalIter, UnionFindWindow (maxRounds, lowThresh)); } }; }// end namespace kruskal #endif // KRUSKAL_HAND_H
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/kruskal/KruskalOrdered.cpp
/** Parallel Kruskal -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Parallel version of Kruskal. * * @author <[email protected]> */ #include "KruskalOrdered.h" int main (int argc, char* argv[]) { kruskal::KruskalOrdered k; k.run (argc, argv); return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/matching/CMakeLists.txt
app(bipartite-mcm bipartite-mcm.cpp)
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/matching/bipartite-mcm.cpp
/** Maximum Cardinality Matching in Bipartite Graphs -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2012, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Maximum cardinality matching in bipartite graphs. For more information see * * K. Mehlhorn and S. Naeher. LEDA: A Platform for Combinatorial and Geometric * Computing. Cambridge University Press, 1999. * * @author Donald Nguyen <[email protected]> */ // TODO(ddn): Needs a graph implementation that supports reversing edges more efficiently #include "Galois/Galois.h" #include "Galois/Timer.h" #include "Galois/Statistic.h" #include "Galois/Graph/Graph.h" #include "Galois/Graph/FileGraph.h" #include "llvm/Support/CommandLine.h" #include "Lonestar/BoilerPlate.h" #ifdef GALOIS_USE_EXP #include "Galois/PriorityScheduling.h" #endif #include <string> #include <vector> #include <algorithm> #include <iostream> namespace cll = llvm::cl; static const char* name = "Maximum cardinality matching in bipartite graphs"; static const char* desc = "Computes maximum cardinality matching in bipartite graphs. " "A matching of G is a subset of edges that do not share an endpoint. " "The maximum cardinality matching is the matching with the most number of edges."; static const char* url = "bipartite_mcm"; enum MatchingAlgo { pfpAlgo, ffAlgo, abmpAlgo }; enum ExecutionType { serial, parallel }; static cll::opt<MatchingAlgo> algo(cll::desc("Choose an algorithm:"), cll::values( clEnumVal(pfpAlgo, "Preflow-push"), clEnumVal(ffAlgo, "Ford-Fulkerson augmenting paths"), clEnumVal(abmpAlgo, "Alt-Blum-Mehlhorn-Paul"), clEnumValEnd), cll::init(abmpAlgo)); static cll::opt<ExecutionType> executionType(cll::desc("Choose execution type:"), cll::values( clEnumVal(serial, "Serial"), clEnumVal(parallel, "Parallel"), clEnumValEnd), cll::init(parallel)); static cll::opt<int> N(cll::Positional, cll::desc("<N>"), cll::Required); static cll::opt<int> numEdges(cll::Positional, cll::desc("<numEdges>"), cll::Required); static cll::opt<int> numGroups(cll::Positional, cll::desc("<numGroups>"), cll::Required); static cll::opt<int> seed(cll::Positional, cll::desc("<seed>"), cll::Required); template<typename NodeTy,typename EdgeTy> struct BipartiteGraph: public Galois::Graph::FirstGraph<NodeTy,EdgeTy,true> { typedef Galois::Graph::FirstGraph<NodeTy,EdgeTy,true> Super; typedef std::vector<typename Super::GraphNode> NodeList; typedef NodeTy node_type; typedef EdgeTy edge_type; NodeList A; NodeList B; void addNode(const typename Super::GraphNode& n, bool isA, Galois::MethodFlag mflag = Galois::MethodFlag::ALL) { if (isA) { A.push_back(n); } else { B.push_back(n); } Super::addNode(n, mflag); } void addNode(const typename Super::GraphNode& n, Galois::MethodFlag mflag = Galois::MethodFlag::ALL) { Super::addNode(n, mflag); } }; //******************************** Common ************************ template<typename G, template<typename,bool> class Algo> struct Exists { bool operator()(G& g, const typename G::edge_iterator&) { return true; } }; template<typename G> struct GraphTypes { typedef typename G::GraphNode GraphNode; typedef std::pair<GraphNode,GraphNode> Edge; typedef std::vector<Edge> Matching; }; struct BaseNode { size_t id; int degree; bool covered; bool free; bool reachable; // for preparing node cover BaseNode(): id(-1) { } BaseNode(size_t i): id(i), degree(0), covered(false), free(true), reachable(false) { } }; template<typename G> struct MarkReachable { typedef typename G::GraphNode GraphNode; typedef typename G::edge_iterator edge_iterator; void operator()(G& g, const GraphNode& root) { std::deque<GraphNode> queue; queue.push_back(root); while (!queue.empty()) { GraphNode cur = queue.front(); queue.pop_front(); if (g.getData(cur).reachable) continue; g.getData(cur).reachable = true; for (edge_iterator ii = g.edge_begin(cur), ei = g.edge_end(cur); ii != ei; ++ii) { GraphNode dst = g.getEdgeDst(ii); queue.push_back(dst); } } } }; template<typename G,template<typename,bool> class Algo> struct PrepareForVerifier { typedef typename GraphTypes<G>::Edge Edge; typedef typename GraphTypes<G>::Matching Matching; typedef typename G::GraphNode GraphNode; typedef typename G::NodeList NodeList; typedef typename G::node_type node_type; typedef typename G::edge_iterator edge_iterator; void operator()(G& g, Matching* matching) { Exists<G,Algo> exists; for (typename NodeList::iterator src = g.B.begin(), esrc = g.B.end(); src != esrc; ++src) { for (edge_iterator ii = g.edge_begin(*src), ei = g.edge_end(*src); ii != ei; ++ii) { GraphNode dst = g.getEdgeDst(ii); if (exists(g, ii)) { matching->push_back(Edge(*src, dst)); } } } for (typename NodeList::iterator ii = g.A.begin(), ei = g.A.end(); ii != ei; ++ii) { if (g.getData(*ii).free) MarkReachable<G>()(g, *ii); } for (typename Matching::iterator ii = matching->begin(), ei = matching->end(); ii != ei; ++ii) { if (g.getData(ii->first).reachable) { // Reachable from a free node in A g.getData(ii->first).covered = true; } else { g.getData(ii->second).covered = true; } } } }; //********************** FF Algorithm ************************** struct FFNode: public BaseNode { int pred; bool reached; FFNode(): BaseNode() { } FFNode(size_t i): BaseNode(i), pred(-1), reached(false) { } }; //! Switch between concurrent and serial instances template<typename T1,typename T2,bool B> struct InstanceWrapper; template<typename T1,typename T2> struct InstanceWrapper<T1,T2,true> { T1& m_t1; T2& m_t2; typedef T2 Type; InstanceWrapper(T1& t1, T2& t2): m_t1(t1), m_t2(t2) { } T2& get() { return m_t2; } }; template<typename T1,typename T2> struct InstanceWrapper<T1,T2,false> { T1& m_t1; T2& m_t2; typedef T1 Type; InstanceWrapper(T1& t1, T2& t2): m_t1(t1), m_t2(t2) { } T1& get() { return m_t1; } }; //! Switch between concurrent and serial types template<typename T1,typename T2,bool B> struct TypeWrapper; template<typename T1,typename T2> struct TypeWrapper<T1,T2,true> { typedef T2 Type; }; template<typename T1,typename T2> struct TypeWrapper<T1,T2,false> { typedef T1 Type; }; //! Matching algorithm of Ford and Fulkerson template<typename G, bool Concurrent> struct MatchingFF { typedef typename G::GraphNode GraphNode; typedef typename G::NodeList NodeList; typedef typename G::node_type node_type; typedef typename G::edge_iterator edge_iterator; typedef typename GraphTypes<G>::Edge Edge; typedef std::vector<Edge> SerialRevs; typedef std::vector<GraphNode> SerialReached; typedef std::vector<Edge, typename Galois::PerIterAllocTy::rebind<Edge>::other> ParallelRevs; typedef std::vector<GraphNode, typename Galois::PerIterAllocTy::rebind<GraphNode>::other> ParallelReached; typedef InstanceWrapper<SerialRevs,ParallelRevs,Concurrent> RevsWrapper; typedef InstanceWrapper<SerialReached,ParallelReached,Concurrent> ReachedWrapper; typedef std::deque<GraphNode, typename Galois::PerIterAllocTy::rebind<GraphNode>::other> Queue; typedef std::vector<GraphNode, typename Galois::PerIterAllocTy::rebind<GraphNode>::other> Preds; static const Galois::MethodFlag flag = Concurrent ? Galois::MethodFlag::CHECK_CONFLICT : Galois::MethodFlag::NONE; std::string name() { return std::string(Concurrent ? "Concurrent" : "Serial") + " Ford-Fulkerson"; } bool findAugmentingPath(G& g, const GraphNode& root, Galois::UserContext<GraphNode>& ctx, typename RevsWrapper::Type& revs, typename ReachedWrapper::Type& reached) { Queue queue(ctx.getPerIterAlloc()); Preds preds(ctx.getPerIterAlloc()); // Order matters between (1) and (2) g.getData(root, flag).reached = true; // (1) reached.push_back(root); // (2) queue.push_back(root); while (!queue.empty()) { GraphNode src = queue.front(); queue.pop_front(); for (edge_iterator ii = g.edge_begin(src, flag), ei = g.edge_end(src, flag); ii != ei; ++ii) { GraphNode dst = g.getEdgeDst(ii); node_type& ddst = g.getData(dst, Galois::MethodFlag::NONE); if (ddst.reached) continue; ddst.reached = true; reached.push_back(dst); ddst.pred = preds.size(); preds.push_back(src); if (ddst.free) { // Fail-safe point modulo ``reached'' which is handled separately ddst.free = false; GraphNode cur = dst; while (cur != root) { GraphNode pred = preds[g.getData(cur, Galois::MethodFlag::NONE).pred]; revs.push_back(Edge(pred, cur)); cur = pred; } return true; } else { assert(std::distance(g.edge_begin(dst), g.edge_end(dst)) == 1); for (edge_iterator jj = g.edge_begin(dst, flag), ej = g.edge_end(dst, flag); jj != ej; ++jj) { GraphNode cur = g.getEdgeDst(jj); g.getData(cur, Galois::MethodFlag::NONE).pred = preds.size(); preds.push_back(dst); g.getData(cur, Galois::MethodFlag::NONE).reached = true; reached.push_back(cur); queue.push_back(cur); } } } } return false; } //! Makes sure that ``reached'' to properly reset even if we get aborted struct ReachedCleanup: public Galois::Runtime::Releasable { G& g; typename ReachedWrapper::Type& reached; ReachedCleanup(G& _g, typename ReachedWrapper::Type& r): g(_g), reached(r) { } ~ReachedCleanup() { cleanup(); } virtual void release() { cleanup(); } void cleanup() { // In non-concurrent case, we can continue reusing reached if (Concurrent) clear(); } void clear() { for (typename ReachedWrapper::Type::iterator ii = reached.begin(), ei = reached.end(); ii != ei; ++ii) { assert(g.getData(*ii, Galois::MethodFlag::NONE).reached); g.getData(*ii, Galois::MethodFlag::NONE).reached = false; } reached.clear(); } }; void operator()(G& g, const GraphNode& src, Galois::UserContext<GraphNode>& ctx, typename RevsWrapper::Type& revs, typename ReachedWrapper::Type& reached) { ReachedCleanup cleanup(g, reached); if (findAugmentingPath(g, src, ctx, revs, reached)) { g.getData(src, Galois::MethodFlag::NONE).free = false; // Reverse edges in augmenting path for (typename RevsWrapper::Type::iterator jj = revs.begin(), ej = revs.end(); jj != ej; ++jj) { g.removeEdge(jj->first, g.findEdge(jj->first, jj->second, Galois::MethodFlag::NONE), Galois::MethodFlag::NONE); g.addEdge(jj->second, jj->first, Galois::MethodFlag::NONE); } revs.clear(); cleanup.clear(); } } //! Main entry point for Galois::for_each struct Process { typedef int tt_needs_per_iter_alloc; MatchingFF<G,Concurrent>& parent; G& g; SerialRevs& serialRevs; SerialReached& serialReached; Process(MatchingFF<G,Concurrent>& _parent, G& _g, SerialRevs& revs, SerialReached& reached): parent(_parent), g(_g), serialRevs(revs), serialReached(reached) { } void operator()(const GraphNode& node, Galois::UserContext<GraphNode>& ctx) { if (!g.getData(node, flag).free) return; ParallelRevs parallelRevs(ctx.getPerIterAlloc()); ParallelReached parallelReached(ctx.getPerIterAlloc()); parent(g, node, ctx, RevsWrapper(serialRevs, parallelRevs).get(), ReachedWrapper(serialReached, parallelReached).get()); } }; void operator()(G& g) { SerialRevs revs; SerialReached reached; Galois::setActiveThreads(Concurrent ? numThreads : 1); Galois::for_each(g.A.begin(), g.A.end(), Process(*this, g, revs, reached)); } }; //********************** ABMP Algorithm ************************** struct ABMPNode: public FFNode { unsigned layer; int next; ABMPNode(): FFNode() { } ABMPNode(size_t i): FFNode(i), layer(0), next(0) { } }; //! Matching algorithm of Alt, Blum, Mehlhorn and Paul template<typename G, bool Concurrent> struct MatchingABMP { typedef typename G::NodeList NodeList; typedef typename G::GraphNode GraphNode; typedef typename G::edge_iterator edge_iterator; typedef typename G::node_type node_type; typedef typename GraphTypes<G>::Edge Edge; typedef std::vector<Edge, typename Galois::PerIterAllocTy::rebind<Edge>::other> Revs; typedef std::pair<GraphNode,unsigned> WorkItem; static const Galois::MethodFlag flag = Concurrent ? Galois::MethodFlag::CHECK_CONFLICT : Galois::MethodFlag::NONE; struct Indexer: public std::unary_function<const WorkItem&,unsigned> { unsigned operator()(const WorkItem& n) const { return n.second; } }; struct Less: public std::binary_function<const WorkItem&,const WorkItem&,bool> { bool operator()(const WorkItem& n1, const WorkItem& n2) const { if (n1.second < n2.second) return true; if (n1.second > n2.second) return false; return n1.first < n2.first; } }; struct Greater: public std::binary_function<const WorkItem&,const WorkItem&,bool> { bool operator()(const WorkItem& n1, const WorkItem& n2) const { if (n1.second > n2.second) return true; if (n1.second < n2.second) return false; return n1.first > n2.first; } }; std::string name() { return std::string(Concurrent ? "Concurrent" : "Serial") + " Alt-Blum-Mehlhorn-Paul"; } bool nextEdge(G& g, const GraphNode& src, GraphNode& next) { node_type& dsrc = g.getData(src, Galois::MethodFlag::NONE); unsigned l = dsrc.layer - 1; // Start search where we last left off edge_iterator ii = g.edge_begin(src, flag); std::advance(ii, dsrc.next); edge_iterator ei = g.edge_end(src, flag); for (; ii != ei && g.getData(g.getEdgeDst(ii), Galois::MethodFlag::NONE).layer != l; ++ii, ++dsrc.next) { ; } if (ii == ei) { return false; } else { next = g.getEdgeDst(ii); return true; } } //! Returns true if we've added a new element bool operator()(G& g, const GraphNode& root, Galois::UserContext<WorkItem>& ctx) { Revs revs(ctx.getPerIterAlloc()); GraphNode cur = root; while (true) { GraphNode next; if (g.getData(cur, Galois::MethodFlag::NONE).free && g.getData(cur, Galois::MethodFlag::NONE).layer == 0) { assert(g.getData(root, Galois::MethodFlag::NONE).free); // (1) Breakthrough g.getData(cur, Galois::MethodFlag::NONE).free = g.getData(root, Galois::MethodFlag::NONE).free = false; // Reverse edges in augmenting path for (typename Revs::iterator ii = revs.begin(), ei = revs.end(); ii != ei; ++ii) { g.removeEdge(ii->first, g.findEdge(ii->first, ii->second, Galois::MethodFlag::NONE), Galois::MethodFlag::NONE); g.addEdge(ii->second, ii->first, Galois::MethodFlag::NONE); } //revs.clear(); if (revs.size() > 1024) { std::cout << "WARNING: allocating large amounts in parallel: " << revs.size() << "elements\n"; } return false; } else if (nextEdge(g, cur, next)) { // (2) Advance revs.push_back(Edge(cur, next)); cur = next; } else { // (3) Retreat unsigned& layer = g.getData(cur, Galois::MethodFlag::NONE).layer; layer += 2; g.getData(cur, Galois::MethodFlag::NONE).next = 0; if (revs.empty()) { ctx.push(std::make_pair(cur, layer)); return true; } cur = revs.back().first; revs.pop_back(); } } } struct Process { typedef int tt_needs_parallel_break; typedef int tt_needs_per_iter_alloc; MatchingABMP<G,Concurrent>& parent; G& g; unsigned& maxLayer; size_t& size; Process(MatchingABMP<G,Concurrent>& p, G& _g, unsigned& m, size_t& s): parent(p), g(_g), maxLayer(m), size(s) { } void operator()(const WorkItem& item, Galois::UserContext<WorkItem>& ctx) { unsigned curLayer = item.second; if (curLayer > maxLayer) { std::cout << "Reached max layer: " << curLayer << "\n"; ctx.breakLoop(); return; } //if (size <= 50 * curLayer) { // std::cout << "Reached min size: " << size << "\n"; // ctx.breakLoop(); //} if (!parent(g, item.first, ctx)) { //__sync_fetch_and_add(&size, -1); } } }; void operator()(G& g) { Galois::StatTimer t("serial"); t.start(); std::vector<WorkItem> initial; for (typename NodeList::iterator ii = g.A.begin(), ei = g.A.end(); ii != ei; ++ii) { g.getData(*ii).layer = 1; if (g.getData(*ii).free) initial.push_back(std::make_pair(*ii, 1)); } t.stop(); unsigned maxLayer = (unsigned) (0.1*sqrt(g.size())); size_t size = initial.size(); Galois::setActiveThreads(Concurrent ? numThreads : 1); using namespace Galois::WorkList; typedef ChunkedFIFO<1024> Chunk; typedef dChunkedFIFO<1024> dChunk; typedef OrderedByIntegerMetric<Indexer,dChunk> OBIM; #ifdef GALOIS_USE_EXP Exp::PriAuto<1024,Indexer,OBIM,Less,Greater>::for_each( initial.begin(), initial.end(), Process(*this, g, maxLayer, size)); #else Galois::for_each(initial.begin(), initial.end(), Process(*this, g, maxLayer, size), Galois::wl<OBIM>()); #endif t.start(); MatchingFF<G,false> algo; std::cout << "Switching to " << algo.name() << "\n"; algo(g); t.stop(); } }; // *************************** MaxFlow Algorithm ******************************* struct MFNode: public BaseNode { size_t excess; unsigned height; int current; MFNode(): BaseNode() { } MFNode(size_t i): BaseNode(i), excess(0), height(1), current(0) { } }; struct MFEdge { int cap; MFEdge(): cap(1) { } MFEdge(int c): cap(c) { } }; //! Matching via reduction to maxflow template<typename G, bool Concurrent> struct MatchingMF { typedef typename G::NodeList NodeList; typedef typename G::GraphNode GraphNode; typedef typename G::edge_iterator edge_iterator; typedef typename G::iterator iterator; typedef typename G::node_type node_type; typedef typename G::edge_type edge_type; static const Galois::MethodFlag flag = Concurrent ? Galois::MethodFlag::CHECK_CONFLICT : Galois::MethodFlag::NONE; /** * Beta parameter the original Goldberg algorithm to control when global * relabeling occurs. For comparison purposes, we keep them the same as * before, but it is possible to achieve much better performance by adjusting * the global relabel frequency. */ static const int BETA = 12; /** * Alpha parameter the original Goldberg algorithm to control when global * relabeling occurs. For comparison purposes, we keep them the same as * before, but it is possible to achieve much better performance by adjusting * the global relabel frequency. */ static const int ALPHA = 6; std::string name() { return std::string(Concurrent ? "Concurrent" : "Serial") + " Max Flow"; } void reduceCapacity(edge_type& edge1, edge_type& edge2, int amount) { edge1.cap -= amount; edge2.cap += amount; } bool discharge(G& g, const GraphNode& src, Galois::UserContext<GraphNode>& ctx, const GraphNode& source, const GraphNode& sink, unsigned numNodes) { node_type& node = g.getData(src, flag); //unsigned prevHeight = node.height; bool relabeled = false; if (node.excess == 0) { return false; } while (true) { Galois::MethodFlag f = relabeled ? Galois::MethodFlag::NONE : flag; bool finished = false; int current = 0; for (edge_iterator ii = g.edge_begin(src, f), ei = g.edge_end(src, f); ii != ei; ++ii, ++current) { GraphNode dst = g.getEdgeDst(ii); edge_type& edge = g.getEdgeData(ii); if (edge.cap == 0 || current < node.current) continue; node_type& dnode = g.getData(dst, Galois::MethodFlag::NONE); if (node.height - 1 != dnode.height) continue; // Push flow int amount = std::min(static_cast<int>(node.excess), edge.cap); reduceCapacity(edge, g.getEdgeData(g.findEdge(dst, src, Galois::MethodFlag::NONE)), amount); // Only add once if (dst != sink && dst != source && dnode.excess == 0) ctx.push(dst); node.excess -= amount; dnode.excess += amount; if (node.excess == 0) { finished = true; node.current = current; break; } } if (finished) break; relabel(g, src, numNodes); relabeled = true; //prevHeight = node.height; } return relabeled; } void relabel(G& g, const GraphNode& src, unsigned numNodes) { unsigned minHeight = std::numeric_limits<unsigned>::max(); int minEdge; int current = 0; for (edge_iterator ii = g.edge_begin(src, Galois::MethodFlag::NONE), ei = g.edge_end(src, Galois::MethodFlag::NONE); ii != ei; ++ii, ++current) { GraphNode dst = g.getEdgeDst(ii); int cap = g.getEdgeData(ii).cap; if (cap > 0) { node_type& dnode = g.getData(dst, Galois::MethodFlag::NONE); if (dnode.height < minHeight) { minHeight = dnode.height; minEdge = current; } } } assert(minHeight != std::numeric_limits<unsigned>::max()); ++minHeight; node_type& node = g.getData(src, Galois::MethodFlag::NONE); node.height = minHeight; node.current = minEdge; } struct Process { typedef int tt_needs_parallel_break; MatchingMF<G,Concurrent>& parent; G& g; const GraphNode& source; const GraphNode& sink; unsigned numNodes; unsigned globalRelabelInterval; bool& shouldGlobalRelabel; unsigned counter; Process(MatchingMF<G,Concurrent>& p, G& _g, const GraphNode& _source, const GraphNode& _sink, unsigned _numNodes, unsigned i, bool& s): parent(p), g(_g), source(_source), sink(_sink), numNodes(_numNodes), globalRelabelInterval(i), shouldGlobalRelabel(s), counter(0) { } void operator()(const GraphNode& src, Galois::UserContext<GraphNode>& ctx) { int increment = 1; if (parent.discharge(g, src, ctx, source, sink, numNodes)) { increment += BETA; } counter += increment; if (globalRelabelInterval && counter >= globalRelabelInterval) { shouldGlobalRelabel = true; ctx.breakLoop(); return; } } }; template<bool useCAS> struct UpdateHeights { typedef int tt_does_not_need_stats; G& g; UpdateHeights(G& _g): g(_g) { } //! Do reverse BFS on residual graph. void operator()(const GraphNode& src, Galois::UserContext<GraphNode>& ctx) { for (edge_iterator ii = g.edge_begin(src, useCAS ? Galois::MethodFlag::NONE : flag), ei = g.edge_end(src, useCAS ? Galois::MethodFlag::NONE : flag); ii != ei; ++ii) { GraphNode dst = g.getEdgeDst(ii); if (g.getEdgeData(g.findEdge(dst, src, Galois::MethodFlag::NONE)).cap > 0) { node_type& node = g.getData(dst, Galois::MethodFlag::NONE); unsigned newHeight = g.getData(src, Galois::MethodFlag::NONE).height + 1; if (useCAS) { unsigned oldHeight; while (newHeight < (oldHeight = node.height)) { if (__sync_bool_compare_and_swap(&node.height, oldHeight, newHeight)) { ctx.push(dst); break; } } } else { if (newHeight < node.height) { node.height = newHeight; ctx.push(dst); } } } } } }; void globalRelabel(G& g, const GraphNode& source, const GraphNode& sink, unsigned numNodes, std::vector<GraphNode>& incoming) { for (iterator ii = g.begin(), ei = g.end(); ii != ei; ++ii) { GraphNode src = *ii; node_type& node = g.getData(src, Galois::MethodFlag::NONE); node.height = numNodes; node.current = 0; if (src == sink) node.height = 0; } Galois::StatTimer T("BfsTime"); T.start(); Galois::for_each(sink, UpdateHeights<false>(g)); T.stop(); for (iterator ii = g.begin(), ei = g.end(); ii != ei; ++ii) { GraphNode src = *ii; node_type& node = g.getData(src, Galois::MethodFlag::NONE); if (src == sink || src == source) continue; if (node.excess > 0) incoming.push_back(src); } } void initializePreflow(G& g, const GraphNode& source, std::vector<GraphNode>& initial) { for (edge_iterator ii = g.edge_begin(source), ei = g.edge_end(source); ii != ei; ++ii) { GraphNode dst = g.getEdgeDst(ii); edge_type& edge = g.getEdgeData(ii); int cap = edge.cap; if (cap > 0) initial.push_back(dst); reduceCapacity(edge, g.getEdgeData(g.findEdge(dst, source)), cap); g.getData(dst).excess += cap; } } //! Adds reverse edges, void initializeGraph(G& g, GraphNode& source, GraphNode& sink, unsigned& numNodes, unsigned& interval) { size_t numEdges = 0; numNodes = g.size(); source = g.createNode(node_type(numNodes++)); sink = g.createNode(node_type(numNodes++)); g.getData(source).height = numNodes; g.addNode(source); g.addNode(sink); // Add reverse edge for (typename NodeList::iterator src = g.A.begin(), esrc = g.A.end(); src != esrc; ++src) { for (edge_iterator ii = g.edge_begin(*src), ei = g.edge_end(*src); ii != ei; ++ii) { GraphNode dst = g.getEdgeDst(ii); g.getEdgeData(g.addMultiEdge(dst, *src, Galois::MethodFlag::ALL)) = edge_type(0); ++numEdges; } } // Add edge from source to each node in A for (typename NodeList::iterator src = g.A.begin(), esrc = g.A.end(); src != esrc; ++src) { g.getEdgeData(g.addMultiEdge(source, *src, Galois::MethodFlag::ALL)) = edge_type(); g.getEdgeData(g.addMultiEdge(*src, source, Galois::MethodFlag::ALL)) = edge_type(0); ++numEdges; } // Add edge to sink from each node in B for (typename NodeList::iterator src = g.B.begin(), esrc = g.B.end(); src != esrc; ++src) { g.getEdgeData(g.addMultiEdge(*src, sink, Galois::MethodFlag::ALL)) = edge_type(); g.getEdgeData(g.addMultiEdge(sink, *src, Galois::MethodFlag::ALL)) = edge_type(0); ++numEdges; } interval = numNodes * ALPHA + numEdges; } //! Extract matching from saturated edges void extractMatching(G& g) { for (typename NodeList::iterator src = g.A.begin(), esrc = g.A.end(); src != esrc; ++src) { for (edge_iterator ii = g.edge_begin(*src), ei = g.edge_end(*src); ii != ei; ++ii) { GraphNode dst = g.getEdgeDst(ii); if (g.getEdgeData(ii).cap == 0) { g.getData(*src).free = g.getData(dst).free = false; } } } } void operator()(G& g) { Galois::StatTimer t("serial"); t.start(); GraphNode source; GraphNode sink; unsigned numNodes; unsigned interval; initializeGraph(g, source, sink, numNodes, interval); std::vector<GraphNode> initial; initializePreflow(g, source, initial); t.stop(); bool shouldGlobalRelabel = false; Galois::setActiveThreads(Concurrent ? numThreads : 1); while (!initial.empty()) { Galois::for_each(initial.begin(), initial.end(), Process(*this, g, source, sink, numNodes, interval, shouldGlobalRelabel)); if (!shouldGlobalRelabel) break; t.start(); std::cout << "Starting global relabel, current excess at sink " << g.getData(sink).excess << "\n"; initial.clear(); globalRelabel(g, source, sink, numNodes, initial); shouldGlobalRelabel = false; t.stop(); } t.start(); std::cout << "Final excess at sink " << g.getData(sink).excess << "\n"; g.removeNode(sink); g.removeNode(source); extractMatching(g); t.stop(); } }; template<typename G> struct Exists<G,MatchingMF> { typedef typename G::edge_iterator edge_iterator; bool operator()(G& g, const edge_iterator& ii) { //assert(g.getEdgeData(src, dst).cap + g.getEdgeData(dst, src).cap == 1); //assert(g.getEdgeData(src, dst).cap != g.getEdgeData(dst, src).cap); return g.getEdgeData(ii).cap == 1; } }; // ******************* Verification *************************** template<typename G> struct Verifier { typedef typename G::GraphNode GraphNode; typedef typename G::node_type node_type; typedef typename G::edge_iterator edge_iterator; typedef typename G::NodeList NodeList; typedef typename GraphTypes<G>::Matching Matching; bool hasCoveredNeighbors(G& g, const GraphNode& src) { for (edge_iterator ii = g.edge_begin(src), ei = g.edge_end(src); ii != ei; ++ii) { GraphNode dst = g.getEdgeDst(ii); if (!g.getData(dst).covered) return false; } return true; } void check(G& g, typename NodeList::iterator ii, typename NodeList::iterator ei, size_t& count, bool& retval) { for (; ii != ei; ++ii) { node_type& dii = g.getData(*ii); if (dii.degree > 1) { std::cerr << "Error: not a matching, node " << dii.id << " incident to " << dii.degree << " edges\n"; retval = false; } if (dii.covered) { count++; } if (dii.covered || hasCoveredNeighbors(g, *ii)) { // Good } else { std::cerr << "Error: not a node cover, node " << dii.id << " with degree " << dii.degree << " not covered nor incident to covered node\n"; retval = false; } } } bool operator()(G& g, const Matching& matching) { for (typename Matching::const_iterator ii = matching.begin(), ei = matching.end(); ii != ei; ++ii) { g.getData(ii->first).degree++; g.getData(ii->second).degree++; } bool retval = true; size_t count = 0; check(g, g.A.begin(), g.A.end(), count, retval); check(g, g.B.begin(), g.B.end(), count, retval); if (count != matching.size()) { std::cerr << "Error: matching is different than node cover " << matching.size() << " vs " << count << "\n"; retval = false; } return retval; } }; static double nextRand() { return rand() / (double) RAND_MAX; } /** * Generate a random bipartite graph as used in LEDA evaluation and * refererenced in [CGM+97]. Nodes are divided into numGroups groups of size * numA/numGroups each. Each node in A has degree d = numEdges/numA and the * edges out of a node in group i of A go to random nodes in groups i+1 and * i-1 of B. If numGroups == 0, just randomly assign nodes of A to nodes of * B. */ template<typename G> void generateInput(int numA, int numB, int numEdges, int numGroups, G* g) { typedef typename G::node_type node_type; assert(numA > 0 && numB > 0); size_t id = 0; for (int i = 0; i < numA; ++i) g->addNode(g->createNode(node_type(id++)), true); for (int i = 0; i < numB; ++i) g->addNode(g->createNode(node_type(id++)), false); int d = numEdges/numA; if (numGroups > numA) numGroups = numA; if (numGroups > numB) numGroups = numB; int count = 0; if (numGroups > 0) { int aSize = numA/numGroups; int bSize = numB/numGroups; for (typename G::NodeList::iterator ii = g->A.begin(), ei = g->A.end(); ii != ei; ++ii, ++count) { int group = count/aSize; if (group == numGroups) break; int base1 = group == 0 ? (numGroups-1)*bSize : (group-1)*bSize; int base2 = group == numGroups-1 ? 0 : (group+1)*bSize; for (int i = 0; i < d; ++i) { int b = nextRand() < 0.5 ? base1 : base2; int off = (int)(nextRand() * (bSize-1)); g->addEdge(*ii, g->B[b+off]); } } } int r = numEdges - count*d; while (r--) { int ind_a = (int)(nextRand()*(numA-1)); int ind_b = (int)(nextRand()*(numB-1)); g->addEdge(g->A[ind_a], g->B[ind_b]); } } template<template<typename,bool> class Algo, typename G, bool Concurrent> void start(int N, int numEdges, int numGroups) { typedef Algo<G,Concurrent> A; G g; generateInput(N, N, numEdges, numGroups, &g); A algo; std::cout << "Starting " << algo.name() << "\n"; Galois::StatTimer t; t.start(); algo(g); t.stop(); if (!skipVerify) { typename GraphTypes<G>::Matching matching; PrepareForVerifier<G,Algo>()(g, &matching); if (!Verifier<G>()(g, matching)) { std::cerr << "Verification failed.\n"; //assert(0 && "Verification failed"); //abort(); } else { std::cout << "Verification succeeded.\n"; } std::cout << "Algorithm produced matching of cardinality: " << matching.size() << "\n"; } } template<bool Concurrent> void start() { switch (algo) { case pfpAlgo: start<MatchingMF, BipartiteGraph<MFNode,MFEdge>, Concurrent>(N, numEdges, numGroups); break; case ffAlgo: start<MatchingFF, BipartiteGraph<FFNode,void>, Concurrent>(N, numEdges, numGroups); break; default: case abmpAlgo: start<MatchingABMP, BipartiteGraph<ABMPNode,void>, Concurrent>(N, numEdges, numGroups); break; } } int main(int argc, char** argv) { Galois::StatManager M; LonestarStart(argc, argv, name, desc, url); std::cout << "N: " << N << " numEdges: " << numEdges << " numGroups: " << numGroups << " seed: " << seed << "\n"; srand(seed); switch (executionType) { case serial: start<false>(); break; default: case parallel: start<true>(); break; } return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/clustering/Box3d.h
/** Single source shortest paths -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Agglomerative Clustering. * * @author Rashid Kaleem <[email protected]> */ #ifndef BOX3D_H_ #define BOX3D_H_ #include"Point3.h" #include<limits> using namespace std; class Box3d { protected: Point3 min; Point3 max; bool initialized; public: Box3d():min(std::numeric_limits<float>::max()), max(-1*std::numeric_limits<double>::max()){ initialized= false; } void setBox(Point3 & pt){ initialized=true; min.set(pt); max.set(pt); } void addPoint(Point3& pt){ initialized=true; min.setIfMin(pt); max.setIfMax(pt); } void addBox(Box3d & b){ initialized=true; min.setIfMin(b.min); max.setIfMax(b.max); } const Point3 & getMin()const{ return min; } const Point3 & getMax()const { return max; } bool isInitialized()const { return initialized; } bool equals(const Box3d & other)const{ return min.equals(other.min) && max.equals(other.max); } }; #endif /* BOX3D_H_ */
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/clustering/CMakeLists.txt
app(clustering)
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/clustering/ClusterNode.h
/** Single source shortest paths -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Agglomerative Clustering. * * @author Rashid Kaleem <[email protected]> */ #ifndef CLUSTERNODE_H_ #define CLUSTERNODE_H_ #include"LeafNode.h" #include"NodeWrapper.h" #include<assert.h> class ClusterNode : public AbstractNode{ private : AbstractNode *leftChild; AbstractNode *rightChild; vector<LeafNode*> reps; Point3 boxRadius; Point3 coneDirection; double coneCos; public: ClusterNode():boxRadius(0),coneDirection(0){ } virtual ~ClusterNode(){ // cout<<"Clearing reps"<<endl; reps.clear(); } void setBox(double minX, double maxX, double minY, double maxY, double minZ, double maxZ) { myLoc.set(0.5f * (minX + maxX),0.5f * (minY + maxY),0.5f * (minZ + maxZ)); boxRadius.set(0.5f * (maxX - minX),0.5f * (maxY - minY),0.5f * (maxZ - minZ)); } void setBox(Point3 & min, Point3 & max) { myLoc.set(min); myLoc.add(max); myLoc.scale(0.5); boxRadius.set(max); boxRadius.sub(min); boxRadius.scale(0.5); } void setChildren(AbstractNode *inLeft, AbstractNode *inRight, double repRandomNum) { leftChild = inLeft; rightChild = inRight; setSummedIntensity(*leftChild, *rightChild); // setCombinedFlags(leftChild, rightChild); //we only apply clamping to nodes that are low in the tree vector<double> *ranVec = repRandomNums[(int) (repRandomNum * numRepRandomNums)]; if (globalMultitime) { assert(false&&"Should not have time true!"); // int numReps = endTime - startTime + 1; // if (reps == null || reps.length < numReps) { // reps = new LeafNode[numReps]; // } else { // for (int j = numReps; j < reps.length; j++) { // reps[j] = null; // } //fill unused values will nulls // } // if (leftChild.isLeaf()) { // LeafNode leftLeaf = (LeafNode) leftChild; // if (rightChild.isLeaf()) { // chooseRepsWithTime(reps, this, ranVec, leftLeaf, (LeafNode) rightChild); // } else { // chooseRepsWithTime(reps, this, ranVec, (ClusterNode) rightChild, leftLeaf); //note: operation is symmectric so we just interchange the children in the call // } // } else { // ClusterNode leftClus = (ClusterNode) leftChild; // if (rightChild.isLeaf()) { // chooseRepsWithTime(reps, this, ranVec, leftClus, (LeafNode) rightChild); // } else { // chooseRepsWithTime(reps, this, ranVec, leftClus, (ClusterNode) rightChild); // } // } } else { if (reps.size() == 0 || reps.size()!= (unsigned int)globalNumReps) { reps.clear(); reps.resize(globalNumReps); } if (leftChild->isLeaf()) { LeafNode *leftLeaf = (LeafNode*) leftChild; if (rightChild->isLeaf()) { chooseRepsNoTime(reps, *this, ranVec, *leftLeaf, (LeafNode&) *rightChild); } else { chooseRepsNoTime(reps, *this, ranVec, (ClusterNode&) *rightChild, *leftLeaf); //note: operation is symmectric so we just interchange the children in the call } } else { ClusterNode *leftClus = (ClusterNode*) leftChild; if (rightChild->isLeaf()) { chooseRepsNoTime(reps, *this, ranVec, *leftClus, (LeafNode&) *rightChild); } else { chooseRepsNoTime(reps, *this, ranVec, *leftClus, (ClusterNode&) *rightChild); } } } } static void chooseRepsNoTime(vector<LeafNode*> & repArr, AbstractNode & parent, vector<double> * ranVec, LeafNode &left,LeafNode & right) { double totalInten = parent.getScalarTotalIntensity(); double leftInten = left.getScalarTotalIntensity(); double nextTest = (*ranVec)[0] * totalInten; for (unsigned int i = 0; i < repArr.size() - 1; i++) { double test = nextTest; nextTest = (*ranVec)[i + 1] * totalInten; repArr[i] = (test < leftInten) ? &left : &right; } repArr[repArr.size() - 1] = (nextTest < leftInten) ? &left : &right; } static void chooseRepsNoTime(vector<LeafNode*>& repArr, AbstractNode &parent, vector<double> *ranVec, ClusterNode &left, LeafNode &right) { double totalInten = parent.getScalarTotalIntensity(); double leftInten = left.getScalarTotalIntensity(); double nextTest = (*ranVec)[0] * totalInten; for (unsigned int i = 0; i < repArr.size() - 1; i++) { double test = nextTest; nextTest = (*ranVec)[i + 1] * totalInten; repArr[i] = (test < leftInten) ? (left.reps[i]) : &right; } repArr[repArr.size() - 1] = (nextTest < leftInten) ? (left.reps[repArr.size() - 1]) : &right; } static void chooseRepsNoTime(vector<LeafNode*> &repArr, AbstractNode &parent, vector<double> *ranVec, ClusterNode &left, ClusterNode &right) { double totalInten = parent.getScalarTotalIntensity(); double leftInten = left.getScalarTotalIntensity(); double nextTest = (*ranVec)[0] * totalInten; for (unsigned int i = 0; i < repArr.size() - 1; i++) { double test = nextTest; nextTest = (*ranVec)[i + 1] * totalInten; repArr[i] = (test < leftInten) ? (left.reps[i]) : (right.reps[i]); } repArr[repArr.size() - 1] = (nextTest < leftInten) ? (left.reps[repArr.size() - 1]) : (right.reps[repArr.size() - 1]); } void setDirectionCone(double dirX, double dirY, double dirZ, double inConeCos) { coneDirection.set(dirX,dirY,dirZ); coneCos = inConeCos; } // float getConeDirX() { // return coneDirX; // } // // public float getConeDirY() { // return coneDirY; // } // // public float getConeDirZ() { // return coneDirZ; // } float getConeCos() { return coneCos; } /** * */ void findConeDirsRecursive(vector<double> * coordArr, vector<ClusterNode*> & tempClusterArr){ //TODO : Fix this. NodeWrapper::CONE_RECURSE_DEPTH - 1 = 3 findConeDirsRecursive(*leftChild, coordArr, 0, tempClusterArr, 3); findConeDirsRecursive(*rightChild, coordArr, 0, tempClusterArr, 3); } static int findConeDirsRecursive(AbstractNode & node, vector<double> *fArr, int numDirs, vector<ClusterNode*> & cArr,int recurseDepth) { if (!node.isLeaf()) { ClusterNode & clus = (ClusterNode&) node; if (clus.coneCos == 1.0) { numDirs = addConeDir(fArr, numDirs, clus.coneDirection.getX(), clus.coneDirection.getY(), clus.coneDirection.getZ()); } else if (recurseDepth <= 0) { //find first empty slot and add this cluster there for (int i = 0; ; i++) { if (cArr[i] == NULL) { cArr[i] = &clus; if (cArr[i + 1] != NULL) { assert(false); } break; } } } else { numDirs = findConeDirsRecursive(*(clus.leftChild), fArr, numDirs, cArr, recurseDepth - 1); numDirs = findConeDirsRecursive(*(clus.rightChild), fArr, numDirs, cArr, recurseDepth - 1); } } else { LeafNode &light = (LeafNode&) node; numDirs = addConeDir(fArr, numDirs, light.getDirX(), light.getDirY(), light.getDirZ()); } return numDirs; } static int addConeDir(vector<double> *fArr, int numDirs, double x, double y, double z) { //only add direction if it does not match any existing directions for (int i = 0; i < 3 * numDirs; i++) { if (((*fArr)[i] == x) && ((*fArr)[i + 1] == y) && ((*fArr)[i + 2] == z)) { return numDirs; } } int index = 3 * numDirs; (*fArr)[index] = x; (*fArr)[index + 1] = y; (*fArr)[index + 2] = z; return numDirs + 1; } bool isLeaf() { return false; } int size() { // only leafs are counted return leftChild->size() + rightChild->size(); } }; #endif /* CLUSTERNODE_H_ */
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/clustering/AbstractNode.h
/** Single source shortest paths -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Agglomerative Clustering. * * @author Rashid Kaleem <[email protected]> */ #ifndef ABSTRACTNODE_H_ #define ABSTRACTNODE_H_ #include"Point3.h" #include<vector> #include<stdlib.h> #include<assert.h> #include<limits> #include<iostream> using namespace std; class AbstractNode { public: static int globalNumReps; static vector<vector<double>*>repRandomNums; static bool globalMultitime; protected: Point3 myLoc; Point3 intensity; // Use r,g,b as x,y,z int startTime, endTime; vector<double> timeVector; public: AbstractNode(double x, double y, double z) : myLoc(x, y, z), intensity(0) { startTime = -1; } AbstractNode() : myLoc(0), intensity(0) { startTime = -1; } virtual ~AbstractNode() { } double getScalarTotalIntensity() { return (1.0f / 3.0f) * intensity.getSum(); } double getRelativeIntensity(int time) { if (time < startTime || time > endTime) return 0; return timeVector[time - startTime]; } void setIntensity(double inScaleFactor, int inTime) { intensity.set(inScaleFactor); if (inTime == -1) { inTime = 0; } if (inTime >= 0) { startTime = inTime; endTime = inTime; timeVector.clear(); timeVector.push_back(1.0f); } else { //negative value used as signal that should be uniform across all time int len = -inTime; startTime = 0; endTime = (int) (len - 1); timeVector.clear(); timeVector.resize(len); for (int i = 0; i < len; i++) timeVector[i] = 1.0f / len; scaleIntensity(len); } } void setSummedIntensity(AbstractNode &inA, AbstractNode &inB) { intensity.set(inA.intensity); intensity.add(inB.intensity); startTime = inA.startTime < inB.startTime ? inA.startTime : inB.endTime; endTime = inA.startTime < inB.startTime ? inB.startTime : inA.endTime; if (startTime != endTime) { int len = endTime - startTime + 1; if ((timeVector.size() == 0) || timeVector.size() < (unsigned int)len) { timeVector.resize(len); } else { for (unsigned int i = 0; i < timeVector.size(); i++) { timeVector[i] = 0; } } double weightA = inA.getScalarTotalIntensity(); double weightB = inB.getScalarTotalIntensity(); double invDenom = 1.0f / (weightA + weightB); weightA *= invDenom; weightB *= invDenom; for (int i = inA.startTime; i <= inA.endTime; i++) { timeVector[i - startTime] += weightA * inA.timeVector[i - inA.startTime]; } for (int i = inB.startTime; i <= inB.endTime; i++) { timeVector[i - startTime] += weightB * inB.timeVector[i - inB.startTime]; } } else { timeVector.clear(); timeVector.push_back(1.0f); } } //////////////////////////////////////////////////////// void scaleIntensity(double inScale) { intensity.scale(inScale); } static void setGlobalNumReps() { if (globalNumReps == 1) { return; } //trees must be rebuilt for this to take effect globalNumReps = 1; double inc = 1.0f/1; for (int i = 0; i < 256; i++) { for (unsigned int i = 0; i < repRandomNums.size(); i++) { vector<double> * ranVec = new vector<double> (1); for (int j = ranVec->size()-1; j > 0; j++) { int index = (int) (j + 1) * (inc*(double) rand()) / (std::numeric_limits<int>::max()); if (index > j) { GALOIS_DIE("Badness :", index); } double temp = (*ranVec)[j]; (*ranVec)[j] = (*ranVec)[index]; (*ranVec)[index] = temp; } if(AbstractNode::repRandomNums[i] !=NULL) delete AbstractNode::repRandomNums[i]; AbstractNode::repRandomNums[i] = ranVec; } } } static void setGlobalMultitime() { //trees must be rebuilt for this to take effect globalMultitime = false; } Point3 & getPoint() { return myLoc; } virtual bool isLeaf()=0; virtual int size()=0; static void cleanup() { for (unsigned int i = 0; i < repRandomNums.size(); i++) delete AbstractNode::repRandomNums[i]; } friend ostream & operator<<(ostream & s, AbstractNode & pt); }; ostream & operator<<(ostream & s, AbstractNode & pt) { s << "Abs Node :: Loc " << pt.myLoc << " , Int ::" << pt.intensity << " Time:: [" << pt.startTime << " - " << pt.endTime << "]"; return s; } const int numRepRandomNums= 256; vector<vector<double>*> AbstractNode::repRandomNums(256); int AbstractNode::globalNumReps = -1; bool AbstractNode::globalMultitime = false; #endif /* ABSTRACTNODE_H_ */
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/clustering/LeafNode.h
/** Single source shortest paths -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Agglomerative Clustering. * * @author Rashid Kaleem <[email protected]> */ #ifndef LEAFNODE_H_ #define LEAFNODE_H_ #define MATH_PI 3.1415926 #include<iostream> #include "AbstractNode.h" #include "Point3.h" using namespace std; class LeafNode : public AbstractNode{ protected: //direction of maximum emission Point3 direction; /** * Creates a new instance of MLTreeLeafNode */ public: LeafNode(double x, double y, double z, double dirX, double dirY, double dirZ):AbstractNode(x,y,z), direction(dirX,dirY,dirZ) { // this->myLoc.x = x; // this->myLoc.y = y; // this->myLoc.z = z; setIntensity(1.0 / MATH_PI, 0); // this->direction.x = dirX; // this->direction.y = dirY; // this->direction.z = dirZ; } Point3 & getDirection(){ return direction; } double getDirX(){ return direction.getX(); } double getDirY(){ return direction.getY(); } double getDirZ(){ return direction.getZ(); } bool isLeaf() { return true; } int size() { return 1; } friend ostream & operator<<(ostream & s , LeafNode & pt); }; ostream & operator<<(ostream & s , LeafNode& pt){ s<<"LeafNode :: "; operator<<(s,(AbstractNode&)pt); s<<"Dir::"<<pt.direction; return s; } #endif /* LEAFNODE_H_ */
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/clustering/Point3.h
/** Single source shortest paths -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Agglomerative Clustering. * * @author Rashid Kaleem <[email protected]> */ #ifndef POINT3_H_ #define POINT3_H_ using namespace std; #include<iostream> class Point3 { double x, y, z; public: Point3(double v) { this->set(v); } Point3(double x, double y, double z) { this->x = x; this->y = y; this->z = z; } Point3(const Point3 & pt) { this->x = pt.x; this->y = pt.y; this->z = pt.z; } double getSum() const{ return x + y + z; } double getLen() const{ return x*x + y*y + z*z; } void scale(double factor) { x *= factor; y *= factor; z *= factor; } void add(const Point3 & pt) { x += pt.x; y += pt.y; z += pt.z; } void sub(const Point3 & pt) { x -= pt.x; y -= pt.y; z -= pt.z; } void set(double n) { x = y = z = n; } void set(double x, double y, double z) { this->x = x; this->y = y; this->z = z; } void set(const Point3 & other) { x = other.x; y = other.y; z = other.z; } bool setIfMax(double nx, double ny, double nz) { bool ret = false; if (nx > x) { x = nx; ret = true; } if (ny > y) { y = ny; ret = true; } if (nz > z) { z = nz; ret = true; } return ret; } bool setIfMin(double nx, double ny, double nz) { bool ret = false; if (nx < x) { x = nx; ret = true; } if (ny < y) { y = ny; ret = true; } if (nz < z) { z = nz; ret = true; } return ret; } bool setIfMax(const Point3 & other) { return setIfMax(other.x, other.y, other.z); } bool setIfMin(const Point3 & other) { return setIfMin(other.x, other.y, other.z); } double getX()const { return x; } double getY() const{ return y; } double getZ() const{ return z; } bool equals(const Point3 & other)const { return (x==other.x) && (y==other.y) && (z==other.z); } friend ostream & operator<<(ostream & s, const Point3 & pt); }; ostream & operator<<(ostream & s, const Point3 & pt) { s << "[" << pt.x << "," << pt.y << "," << pt.z << "]"; return s; } #endif /* POINT3_H_ */
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/clustering/KdTree.h
/** Single source shortest paths -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Agglomerative Clustering. * * @author Rashid Kaleem <[email protected]> */ #ifndef KDTREE_H_ #define KDTREE_H_ #include<vector> #include<limits> #include"Point3.h" #include"NodeWrapper.h" #include"KdCell.h" #include"PotentialCluster.h" using namespace std; class KdTree: public KdCell { private: double minLightIntensity; double maxConeCosine; Point3 minHalfSize; KdTree():KdCell(), minHalfSize(std::numeric_limits<double>::max()){ minLightIntensity=std::numeric_limits<double>::max(); maxConeCosine = -1.0f; } KdTree(int st, double sv):KdCell(st,sv), minHalfSize(0){ minLightIntensity=0; maxConeCosine = -1.0f; } public: /** * */ static KdTree * createTree(vector<NodeWrapper*> & inPoints){ KdTree * factory = new KdTree(); KdTree * root = (KdTree *) KdTree::subDivide(inPoints, 0, inPoints.size(), NULL, *factory); delete factory; return root; } /** * */ virtual KdCell *createNewBlankCell(int inSplitType, double inSplitValue) { // cout<<"CALLED !!!!! "<<endl; return new KdTree(inSplitType, inSplitValue); } /** * */ static void getAll(KdCell & tree, vector<NodeWrapper * > & allLeaves){ tree.getAll(allLeaves); } /** * */ bool notifyPointAdded(NodeWrapper & nw, bool inChange){ if(inChange){ double b3 = nw.getLight().getScalarTotalIntensity(); minLightIntensity = (minLightIntensity >= b3) ? b3 : minLightIntensity; maxConeCosine = (maxConeCosine >= nw.getConeCosine()) ? maxConeCosine : nw.getConeCosine(); double b2 = nw.getHalfSizeX(); double minHalfSizeX = (minHalfSize.getX() >= b2) ? b2 : minHalfSize.getX(); double b1 = nw.getHalfSizeY(); double minHalfSizeY = (minHalfSize.getY() >= b1) ? b1 : minHalfSize.getY(); double b = nw.getHalfSizeZ(); double minHalfSizeZ = (minHalfSize.getZ() >= b) ? b : minHalfSize.getZ(); minHalfSize.set(minHalfSizeX,minHalfSizeY,minHalfSizeZ); } else{ double newIntensity = nw.getLight().getScalarTotalIntensity(); if(minLightIntensity>newIntensity){ minLightIntensity = newIntensity; inChange=true; } if(maxConeCosine < nw.getConeCosine()){ maxConeCosine= nw.getConeCosine(); inChange=true; } inChange |= minHalfSize.setIfMin(nw.getHalfSizeX(),nw.getHalfSizeY(),nw.getHalfSizeZ()); } return inChange; } /** * */ NodeWrapper *findBestMatch(NodeWrapper &inLight) { // cout<<"********************************************"<<endl // <<"Finding match for "<<inLight<<endl; PotentialCluster cluster(inLight); if (splitType == LEAF) { findNearestRecursive(cluster); } else if (splitType == KdCell::SPLIT_X) { recurse(cluster, inLight.getLocationX()); } else if (splitType == KdCell::SPLIT_Y) { recurse(cluster, inLight.getLocationY()); } else if (splitType == KdCell::SPLIT_Z) { recurse(cluster, inLight.getLocationZ()); } else { assert(false&& "Invalid split type!"); } NodeWrapper * res = cluster.closest; // if(res==NULL){ // cout<<"##################################\nUnable to find a match for node "<<inLight // <<"Tree :: "<< *this<<"#######################"<<endl; // } return res; } void findNearestRecursive(PotentialCluster &potentialCluster) { // cout<<"Recurse Base?"<<potentialCluster<<endl; // cout<<"Find nearest recursive "<<(potentialCluster)<<endl; if (couldBeCloser(potentialCluster)==false) { return; } const NodeWrapper &from = potentialCluster.original; if (splitType == KdCell::LEAF) { //if it is a leaf then compute potential cluster size with each individual light or cluster for(int i=0;i<KdCell::MAX_POINTS_IN_CELL;i++){ if(pointList[i]!=NULL && pointList[i]->equals(potentialCluster.original)==false){ double size = NodeWrapper::potentialClusterSize(from, *(pointList[i])); if (size < potentialCluster.clusterSize) { // cout<<"Found close match!!! " << *pointList[i]<<endl; potentialCluster.closest = pointList[i]; potentialCluster.clusterSize = size; } } } } else if (splitType == KdCell::SPLIT_X) { recurse(potentialCluster, from.getLocationX()); } else if (splitType == KdCell::SPLIT_Y) { recurse(potentialCluster, from.getLocationY()); } else if (splitType == KdCell::SPLIT_Z) { recurse(potentialCluster, from.getLocationZ()); } else { assert(false&&"Invalid split type in find nearest recursive"); } } void recurse(PotentialCluster &potentialCluster, double which) { // cout<<"Inner node, recursing for "<<potentialCluster<<" Split?"<<which<< " <= "<<splitValue<<endl; //if its a interior node recurse on the closer child first // cout<<"Recurse "<<*this<<endl; if (which <= splitValue) { if(leftChild!=NULL && leftChild->removeFromTree==false) ((KdTree*) leftChild)->findNearestRecursive(potentialCluster); if(rightChild!=NULL && rightChild->removeFromTree==false) ((KdTree*) rightChild)->findNearestRecursive(potentialCluster); } else { if(rightChild!=NULL && rightChild->removeFromTree==false) ((KdTree*) rightChild)->findNearestRecursive(potentialCluster); if(leftChild!=NULL && leftChild->removeFromTree==false) ((KdTree*) leftChild)->findNearestRecursive(potentialCluster); } } /** * Determines if any element of this cell could be closer to the the cluster, outCluster, using * the metrics defined in inBuilder. * * @param outCluster the cluster to test * @return true if an element could be closer, false otherwise */ bool couldBeCloser(PotentialCluster &outCluster) { //first check to see if we can prove that none of our contents could be closer than the current closest const NodeWrapper &from = outCluster.original; //compute minumum offset to bounding box double a2 = min.getX() - from.getLocationX() >= from.getLocationX() - max.getX() ? min.getX() - from.getLocationX() : from.getLocationX() - max.getX(); //more than twice as fast as Math.max(a,0) double dx = (a2 >= 0) ? a2 : 0; double a1 = (min.getY() - from.getLocationY() >= from.getLocationY()- max.getY()) ? min.getY() - from.getLocationY() : from.getLocationY() - max.getY(); double dy = a1 >= 0 ? a1 : 0; double a = (min.getZ() - from.getLocationZ() >= from.getLocationZ() - max.getZ()) ? min.getZ() - from.getLocationZ() : from.getLocationZ() - max.getZ(); double dz = a >= 0 ? a : 0; //expand distance by half size of from's bounding box (distance is min to center of box) //and by half the minimum bounding box extents of any node in this cell // cout<<"From :: " << minHalfSize<<endl; dx += from.getHalfSizeX() + minHalfSize.getX(); dy += from.getHalfSizeY() + minHalfSize.getY(); dz += from.getHalfSizeZ() + minHalfSize.getZ(); //cone must be at least as big as the larger of from's and the smallest in this cell double coneCos = (maxConeCosine >= from.getConeCosine()) ? from.getConeCosine() : maxConeCosine; //minimum cluster intensity would be from's intensity plus smallest intensity inside this cell double intensity = minLightIntensity + from.getLight().getScalarTotalIntensity(); Point3 diff(dx,dy,dz); double testSize = NodeWrapper::clusterSizeMetric(diff, coneCos, intensity); //return if our contents could be closer and so need to be checked //extra factor of 0.9999 is to correct for any roundoff error in computing minimum size // cout<<"Could be closer computed :: "<<diff<<" , " <<outCluster.clusterSize << " versus "<<testSize<<endl; return (outCluster.clusterSize >= 0.9999 * testSize); } private: }; #endif /* KDTREE_H_ */
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/clustering/Clustering.cpp
/** Single source shortest paths -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Agglomerative Clustering. * * @author Rashid Kaleem <[email protected]> */ #include "Galois/Statistic.h" #include "Galois/Graph/Graph.h" #include "Galois/Galois.h" #include "Galois/Accumulator.h" #include "Lonestar/BoilerPlate.h" #include <vector> #include <map> #include <string> #include <sstream> #include <limits> #include <iostream> #include <fstream> #include <set> #include<iostream> #include<vector> #include<limits> #include<set> #include<map> #include<stdlib.h> #include "LeafNode.h" #include "NodeWrapper.h" #include "KdTree.h" #include"ClusterNode.h" #include <stdlib.h> #include <sys/time.h> namespace cll = llvm::cl; static const char* name = "Unordered Agglomerative Clustering"; static const char* desc = "Clusters data points using the well-known data-mining algorithm"; static const char* url = "agglomerative_clustering"; static cll::opt<int> numPoints("numPoints", cll::desc("Number of Points"), cll::init(1000)); #define DEBUG_CONSOLE 0 using namespace std; void loopBody(NodeWrapper * cluster, KdTree *kdTree, std::vector<NodeWrapper*> * wl, std::vector<ClusterNode*> *clusterArr, std::vector<double> * floatArr) ; /////////////////////////////////////////// void getRandomPoints(vector<LeafNode*> & lights, int numPoints){ double dirX = 0; double dirY = 0; double dirZ = 1; AbstractNode::setGlobalMultitime(); AbstractNode::setGlobalNumReps(); //generating random lights for (int i = 0; i <numPoints; i++) { double x = ((double) rand())/(std::numeric_limits<int>::max()); double y = ((double) rand())/(std::numeric_limits<int>::max()); double z = ((double) rand())/(std::numeric_limits<int>::max()); LeafNode * l = new LeafNode(x, y, z, dirX, dirY, dirZ); #if DEBUG_CONSOLE cout<<"Created "<<*l<<std::endl; #endif lights[i]=l; } return; } /*********************************************************************************************/ Galois::GAccumulator<size_t> addedNodes; struct FindMatching { KdTree * tree; Galois::InsertBag<NodeWrapper *> *newNodes; Galois::InsertBag<NodeWrapper *> &allocs; vector<double> * coordinatesArray; vector<ClusterNode*> &clusterArray; FindMatching(KdTree * pT,Galois::InsertBag<NodeWrapper *> *&pNNodes, Galois::InsertBag<NodeWrapper *> &pAllocs, vector<double> * pCoordinatesArray,vector<ClusterNode*> &pClusterArray): tree(pT), newNodes(pNNodes), allocs(pAllocs),coordinatesArray(pCoordinatesArray), clusterArray(pClusterArray) { } template<typename ContextTy> void operator()(NodeWrapper * nodeA, ContextTy& lwl) { if (tree->contains(*nodeA)) { NodeWrapper * nodeB = tree->findBestMatch((*nodeA)); if (nodeB != NULL && tree->contains(*nodeB)) { NodeWrapper * nodeBMatch = tree->findBestMatch((*nodeB)); if (nodeBMatch!=NULL ){ if(nodeA->equals(*nodeBMatch) && nodeA->equals(*nodeB)==false) { //Create a new node here. if(nodeA<nodeB){ //Galois::Allocator:: NodeWrapper * newNode = new NodeWrapper(*nodeA, *nodeB, coordinatesArray,clusterArray); newNodes->push(newNode); allocs.push(newNode); addedNodes +=1; } } else{ addedNodes +=1; newNodes->push(nodeA); } } } else{ addedNodes +=1; newNodes->push(nodeA); } } } }; //////////////////////////////////////////////////////////// int findMatch(KdTree * tree, NodeWrapper * nodeA,Galois::InsertBag<NodeWrapper *> *&newNodes, Galois::InsertBag<NodeWrapper *> &allocs, vector<double> * coordinatesArray,vector<ClusterNode*> &clusterArray ){ int addCounter=0; if (tree->contains(*nodeA)) { NodeWrapper * nodeB = tree->findBestMatch((*nodeA)); if (nodeB != NULL && tree->contains(*nodeB)) { NodeWrapper * nodeBMatch = tree->findBestMatch((*nodeB)); if (nodeBMatch!=NULL ){ // cout<<" Match found "<<*nodeA<<" AND " << *nodeB<<endl; if(nodeA->equals(*nodeBMatch) && nodeA->equals(*nodeB)==false) { // cout<<" A is "<<*nodeA<<" A-Closes=B:: " << *nodeB<<" B-Closest "<<*nodeBMatch<<endl; //Create a new node here. if(nodeA<nodeB){ NodeWrapper * newNode = new NodeWrapper(*nodeA, *nodeB, coordinatesArray,clusterArray); newNodes->push(newNode); allocs.push(newNode); addCounter++; } } else{ addCounter++; newNodes->push(nodeA); // cout<<" A is "<<*nodeA<<" A-Closes=B:: " << *nodeB<<" B-Closest "<<*nodeBMatch<<endl; } } } else{ addCounter++; newNodes->push(nodeA); } } return addCounter; } /*********************************************************************************************/ void clusterGalois(vector<LeafNode*> & lights) { int tempSize = (1 << NodeWrapper::CONE_RECURSE_SIZE) + 1; cout << "Temp size is " << tempSize << " coord. arr size should be "<< tempSize * 3 << endl; vector<double> * coordinatesArray = new vector<double> (tempSize * 3); vector<NodeWrapper*> initialWorklist(lights.size()); vector<ClusterNode*> clusterArray(tempSize); for (unsigned int i = 0; i < lights.size(); i++) { NodeWrapper * nw = new NodeWrapper(*(lights[i])); initialWorklist[i] = nw; } KdTree * tree = (KdTree::createTree(initialWorklist)); #if DEBUG_CONSOLE cout<<"Tree created "<<*tree<<endl; cout<<"================================================================"<<endl; #endif //////////////////////////////////// vector<NodeWrapper*> workListOld(0); KdTree::getAll(*tree, workListOld); vector<NodeWrapper*> workList(0); size_t size = 0; for(unsigned int i=0;i<workListOld.size();i++){ workList.push_back(workListOld[i]); } Galois::InsertBag<NodeWrapper *> *newNodes; Galois::InsertBag<NodeWrapper *> allocs; FindMatching findMatchingLambda(tree,newNodes, allocs,coordinatesArray,clusterArray); Galois::StatTimer T; T.start(); while(true){ newNodes = new Galois::InsertBag<NodeWrapper*>(); addedNodes.reset(); findMatchingLambda.newNodes=newNodes; findMatchingLambda.tree=tree; Galois::for_each(workList.begin(),workList.end(),findMatchingLambda); size += addedNodes.reduce(); workList.clear(); for(Galois::InsertBag<NodeWrapper*>::iterator it = newNodes->begin(), itEnd = newNodes->end();it!=itEnd;it++) workList.push_back(*it); if(size<2) break; size=0; KdCell::cleanupTree(tree); tree = (KdTree::createTree(workList)); delete newNodes; } T.stop(); #if DEBUG_CONSOLE cout<<"================================================================"<<endl<<*tree<<endl; #endif //!!!!!!!!!!!!!!!!!!!Cleanup delete newNodes; KdCell::cleanupTree(tree); AbstractNode::cleanup(); for (unsigned int i = 0; i < lights.size(); i++) { NodeWrapper * nw = initialWorklist[i]; delete nw; } for(Galois::InsertBag<NodeWrapper*>::iterator it = allocs.begin(), itEnd = allocs.end();it!=itEnd;it++) delete *it; delete coordinatesArray; return; } /*********************************************************************************************/ /////////////////////////////////////////// void clusterSerial(vector<LeafNode*> & lights) { int tempSize = (1 << NodeWrapper::CONE_RECURSE_SIZE) + 1; cout << "Temp size is " << tempSize << " coord. arr size should be "<< tempSize * 3 << endl; vector<double> * coordinatesArray = new vector<double> (tempSize * 3); vector<NodeWrapper*> initialWorklist(lights.size()); vector<ClusterNode*> clusterArray(tempSize); for (unsigned int i = 0; i < lights.size(); i++) { NodeWrapper * nw = new NodeWrapper(*(lights[i])); initialWorklist[i] = nw; } KdTree * tree = (KdTree::createTree(initialWorklist)); //#if DEBUG_CONSOLE cout<<"Tree created "<<*tree<<endl; cout<<"================================================================"<<endl; //#endif //////////////////////////////////// vector<NodeWrapper*> workListOld(0); KdTree::getAll(*tree, workListOld); vector<NodeWrapper*> workList(0); for(unsigned int i=0;i<workListOld.size();i++){ workList.push_back(workListOld[i]); } vector<NodeWrapper*> newNodes; vector<NodeWrapper*> allocs; while(true){ while (workList.size() > 1) { cout << "===================Worklist size :: "<< workList.size() << "===============" << endl; NodeWrapper * nodeA = workList.back(); workList.pop_back(); if (tree->contains(*nodeA)) { NodeWrapper * nodeB = tree->findBestMatch((*nodeA)); if (nodeB != NULL && tree->contains(*nodeB)) { NodeWrapper * nodeBMatch = tree->findBestMatch((*nodeB)); if (nodeBMatch!=NULL ){ if(nodeA->equals(*nodeBMatch) && nodeA->equals(*nodeB)==false) { if(nodeA<nodeB){ NodeWrapper * newNode = new NodeWrapper(*nodeA, *nodeB, coordinatesArray,clusterArray); newNodes.push_back(newNode); allocs.push_back(newNode); } } else{ newNodes.push_back(nodeA); } } } else{ newNodes.push_back(nodeA); } } } workList.clear(); for(vector<NodeWrapper*>::iterator it = newNodes.begin(), itEnd = newNodes.end();it!=itEnd;it++) workList.push_back(*it); cout<<"Newly added"<<newNodes.size()<<endl; if(newNodes.size()<2) break; KdCell::cleanupTree(tree); tree = (KdTree::createTree(workList)); newNodes.clear(); } #if DEBUG_CONSOLE cout<<"================================================================"<<endl <<*tree<<endl; #endif //!!!!!!!!!!!!!!!!!!!Cleanup KdCell::cleanupTree(tree); AbstractNode::cleanup(); for (unsigned int i = 0; i < lights.size(); i++) { NodeWrapper * nw = initialWorklist[i]; delete nw; } for(unsigned int i=0;i<allocs.size();i++) delete allocs[i]; delete coordinatesArray; return; } /////////////////////////////////////////// int main(int argc, char ** argv){ Galois::StatManager M; LonestarStart(argc, argv, name, desc, url); std::cout<<"Starting Clustering app...["<<numPoints<<"]"<<std::endl; //Initializing... vector<LeafNode*> * lights =new vector<LeafNode*>(numPoints); getRandomPoints(*lights, numPoints); // clusterSerial(*lights); clusterGalois(*lights); //Cleaning up! for(int i=0;i<numPoints;i++){ LeafNode * l = lights->at(i); #if DEBUG_CONSOLE std::cout<<"deleted :: "<<*l<<std::endl; #endif delete l; } std::cout<<"Ending Clustering app...["<<lights->size()<<"]"<<std::endl; delete lights; return 0; } ///////////////////////////////////////////
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/clustering/PotentialCluster.h
/** Single source shortest paths -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Agglomerative Clustering. * * @author Rashid Kaleem <[email protected]> */ #ifndef POTENTIALCLUSTER_H_ #define POTENTIALCLUSTER_H_ #include<limits> #include"NodeWrapper.h" using namespace std; class PotentialCluster { public: const NodeWrapper & original; NodeWrapper * closest; double clusterSize; PotentialCluster(NodeWrapper & pOriginal): original(pOriginal) { closest = NULL; clusterSize = numeric_limits<float>::max(); } friend ostream & operator<<(ostream & s, const PotentialCluster & p); }; ostream & operator<<(ostream & s, const PotentialCluster & p){ s<<"PC : ["<<p.original<<", ?"; if(p.closest!=NULL) s<<*(p.closest); else s<<"NULL"; s<<","<<p.clusterSize<<"]"; return s; } #endif /* POTENTIALCLUSTER_H_ */
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/clustering/KdCell.h
/** Single source shortest paths -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Agglomerative Clustering. * * @author Rashid Kaleem <[email protected]> */ #ifndef KDCELL_H_ #define KDCELL_H_ #include<limits> #include<vector> #include<algorithm> #include<iostream> #include"Point3.h" #include<assert.h> #include"NodeWrapper.h" using namespace std; class KdCell { public: const static int LEAF; const static int SPLIT_X; const static int SPLIT_Y; const static int SPLIT_Z; const static int MAX_POINTS_IN_CELL; bool removeFromTree; protected: Point3 min; Point3 max; const int splitType; const double splitValue; KdCell * leftChild; KdCell * rightChild; vector<NodeWrapper*> pointList; public: KdCell() : min(std::numeric_limits<double>::max()), max(-1 * std::numeric_limits< double>::max()), splitType(LEAF), splitValue(numeric_limits< double>::max()) { pointList.resize(MAX_POINTS_IN_CELL); leftChild = NULL; rightChild = NULL; removeFromTree=false; } KdCell(int inSplitType, double inSplitValue) : min(0), max(0), splitType(inSplitType), splitValue( inSplitValue) { if (splitType == LEAF) pointList.resize(MAX_POINTS_IN_CELL); else pointList.resize(0); leftChild=rightChild=NULL; removeFromTree=false; } virtual ~KdCell() { } bool equals(KdCell & other){ if(splitType!=other.splitType) return false; if(splitValue!=other.splitValue) return false; if(min.equals(other.min)==false) return false; if(max.equals(other.max)==false) return false; if(splitType==KdCell::LEAF) return leftChild->equals(*leftChild) && rightChild->equals(*rightChild); if(pointList.size()!=other.pointList.size()) return false; for(unsigned int i=0;i<pointList.size();i++){ if(pointList[i]!=NULL && other.pointList[i]!=NULL){ if(pointList[i]->equals(*other.pointList[i])==false) return false; } if(pointList[i]!=other.pointList[i]) return false; } return true; } /** * */ virtual KdCell* createNewBlankCell(int splitType, double splitValue) { cout<<"KDCELL CALLED !!!!! "<<endl; return (new KdCell(splitType, splitValue)); } /** * */ static void cleanupTree(KdCell * root) { if (root->splitType == LEAF) { delete root; return; } if(root->leftChild!=NULL) cleanupTree(root->leftChild); if(root->rightChild!=NULL) cleanupTree(root->rightChild); delete root; } /*** * */ static KdCell * subDivide(vector<NodeWrapper*> & list, int offset, const int size, vector<double> * arr, KdCell & factory) { KdCell * toReturn; if (size <= KdCell::MAX_POINTS_IN_CELL) { toReturn = factory.createNewBlankCell(KdCell::LEAF, numeric_limits< double>::max()); KdCell & cell = *toReturn; for (int i = 0; i < size; i++) { cell.pointList[i] = list[offset + i]; } for (int i = 0; i < size; i++) { for(int j=0;j<size;j++){ if(i!=j){ if(cell.pointList[i]->equals(*cell.pointList[j])) assert(false); } } } cell.computeBoundingBoxFromPoints(list, size); cell.notifyContentsRebuilt(true); } else { bool shouldClean = false; if (arr == NULL) { arr = new vector<double> (size); shouldClean = true; } Point3 min(std::numeric_limits<float>::max()); Point3 max(-std::numeric_limits<float>::max()); for (int i = offset; i < size; i++) { min.setIfMin(list[i]->getMin()); max.setIfMax(list[i]->getMax()); } Point3 diff(max); diff.sub(min); int splitTypeUsed = -1, splitType0, splitType1, splitType2; double splitValueUsed = -1; if (diff.getZ() > diff.getX() && diff.getZ() > diff.getY()) { splitType0 = KdCell::SPLIT_Z; bool comparCond = diff.getX() > diff.getY(); splitType1 = comparCond ? KdCell::SPLIT_X : KdCell::SPLIT_Y; splitType2 = comparCond ? KdCell::SPLIT_Y : KdCell::SPLIT_X; } else if (diff.getY() > diff.getX()) { splitType0 = KdCell::SPLIT_Y; bool comparCond = diff.getX() > diff.getZ(); splitType1 = comparCond ? KdCell::SPLIT_X : KdCell::SPLIT_Z; splitType2 = comparCond ? KdCell::SPLIT_Z : KdCell::SPLIT_X; } else { splitType0 = KdCell::SPLIT_X; bool comparCond = diff.getY() > diff.getZ(); splitType1 = comparCond ? KdCell::SPLIT_Y : KdCell::SPLIT_Z; splitType2 = comparCond ? KdCell::SPLIT_Z : KdCell::SPLIT_Y; } // cout<< "================================================================"<< endl; //Perform splitting, iteratively on type0, type1, type2, whichever suceeds. splitTypeUsed = splitType0; splitValueUsed = computeSplitValue(list, offset, size, splitType0, arr); if (splitValueUsed == numeric_limits<float>::max()) { splitTypeUsed = splitType1; splitValueUsed = computeSplitValue(list, offset, size, splitType1, arr); if (splitValueUsed == numeric_limits<float>::max()) { splitTypeUsed = splitType2; splitValueUsed = computeSplitValue(list, offset, size, splitType2, arr); } } //Unable to find a good split along any axis! if (splitValueUsed == numeric_limits<float>::max()) { assert(false && "Unable to find a valid split across any dimension!"); } // cout << "Before :" << offset << " , " << size << " , value ::" // << splitValueUsed << " type:" << splitTypeUsed << endl; int leftCountForSplit = splitList(list, offset, size, splitValueUsed, splitTypeUsed); // cout << "Splitting at " << offset << " , " << leftCountForSplit // << " , " << size << " , value ::" << splitValueUsed // << " type:" << splitTypeUsed << endl; if (leftCountForSplit <= 1 || leftCountForSplit >= size - 1) { // for (int i = 0; i < size; i++) // cout << "NW In split fault " << *list[offset + i] << endl; // cout << "Failed at " << offset << " , " << leftCountForSplit // << " , " << size << " , value ::" << splitValueUsed // << " type:" << splitTypeUsed << endl; assert(false && "Invalid split"); } toReturn = factory.createNewBlankCell(splitTypeUsed, splitValueUsed); KdCell & cell = *toReturn; cell.max.set(max); cell.min.set(min); cell.leftChild = subDivide(list, offset, leftCountForSplit, arr, factory); cell.rightChild = subDivide(list, offset + leftCountForSplit, size - leftCountForSplit, arr, factory); // cout << "created inner node" << cell; //Clean up on exit. if (shouldClean == true) delete arr; } return toReturn; } /** * */ bool notifyContentsRebuilt(bool inChange) { return inChange; } /** * */ static double computeSplitValue(vector<NodeWrapper*> & list, int offset, int size, int pSplitType, vector<double> * arr) { for (int i = 0; i < size; i++) { (*arr)[i] = findSplitComponent(*(list[offset + i]), pSplitType); } // cout << "SplitVal ::[ " << pSplitType << "]"; // for (int i = 0; i < size; i++) { // cout << "["<<*list[offset+i]<<" , "<<(*arr)[i] << ",]"; // } // cout << endl; return findMedianGapSplit(arr, size); } /** * */ static double findSplitComponent(NodeWrapper & n, int pSplitType) { if (pSplitType == KdCell::SPLIT_X) return n.getLocationX(); if (pSplitType == KdCell::SPLIT_Y) return n.getLocationY(); if (pSplitType == KdCell::SPLIT_Z) return n.getLocationZ(); assert(false && "Invalid splitType requested in findSplitComponent"); abort(); return 0.0; } /** * */ static double findMedianGapSplit(vector<double> * arr, int size) { // cout << "Pre sort Median ::[ "; // for (int i = 0; i < size; i++) { // cout << (*arr)[i] << ","; // } // cout << "]" << endl; sort(arr->begin(), arr->begin()+size); // cout << "Sorted Median ::[ "; // for (int i = 0; i < size; i++) { // cout << (*arr)[i] << ","; // } // cout << "]" << endl; int start = ((size - 1) >> 1) - ((size + 7) >> 3); int end = (size >> 1) + ((size + 7) >> 3); if (start == end) { //should never happen assert(false && "Start==End in findMedianSplit, should not happen!"); } double largestGap = 0; double splitValue = 0; double nextValue = (*arr)[start]; for (int i = start; i < end; i++) { double curValue = nextValue; //ie val[i] nextValue = (*arr)[i + 1]; if ((nextValue - curValue) > largestGap) { largestGap = nextValue - curValue; splitValue = 0.5f * (curValue + nextValue); if (splitValue == nextValue) { splitValue = curValue; } //if not between then choose smaller value } } if (largestGap <= 0) { //indicate that the attempt to find a good split value failed splitValue = numeric_limits<float>::max(); } return splitValue; } /** * */ static int splitList(vector<NodeWrapper*> & list, int startIndex, int size, double pSplitValue, const int pSplitType) { // for(int i=startIndex;i<size;i++){ // cout<<"NW to split :: "<<*list[i]; // } int lo = startIndex; int hi = startIndex + size - 1; //split into a low group that contains all points <= the split value and //a high group with all the points > the split value //note: after splitting, (lo - startIndex) will be the size of the low group while (lo <= hi) { while (lo <= hi && pSplitValue >= findSplitComponent(*(list[lo]), pSplitType)) { // cout << "Lo[" << findSplitComponent(*(list[lo]), pSplitType) // << "]"; lo++; } while (lo <= hi && pSplitValue < findSplitComponent(*(list[hi]), pSplitType)) { // cout << "Hi[" << findSplitComponent(*(list[hi]), pSplitType) // << "]"; hi--; } if (lo < hi) { int index1 = lo++; int index2 = hi--; NodeWrapper *temp = list[index1]; list[index1] = list[index2]; list[index2] = temp; } } return lo - startIndex; } /** * */ bool contains(NodeWrapper &point) { if (splitType == KdCell::LEAF) { //look for it in list of points for (int i = 0; i < KdCell::MAX_POINTS_IN_CELL; i++) { NodeWrapper * myNode = pointList[i]; if (myNode != NULL && (*myNode).equals(point) == true) { return true; } } return false; } else { //otherwise its an interior node, so find which child should contain the point float val = findSplitComponent(point, splitType); KdCell *child = val <= splitValue ? leftChild : rightChild; if(child!=NULL) return child->contains(point); return false; } } /** * */ void getAll(vector<NodeWrapper*> & allLeaves) { if (this->splitType == KdCell::LEAF) { for (int i = 0; i < KdCell::MAX_POINTS_IN_CELL; i++) { if (pointList[i] != NULL) allLeaves.push_back(pointList[i]); } } else { leftChild->getAll(allLeaves); rightChild->getAll(allLeaves); } } /** * */ bool remove(NodeWrapper & nw) { bool treeChanged = false; treeChanged = removeInternal(nw,NULL,NULL); cout<<"===================AFTER REMOVAL================" <<*this<<"====================================="<<endl; return treeChanged; } /** * */ bool removeInternal(NodeWrapper & nw, KdCell * parent, KdCell * grandParent) { bool treeChanged = false; //Leaf Node! if (this->splitType == KdCell::LEAF) { int numPoints=0; int indexToDelete = -1; for (int i = 0; i < KdCell::MAX_POINTS_IN_CELL; i++) { if (pointList[i] != NULL){ if (pointList[i]->equals(nw) == true) { indexToDelete = i; } numPoints++; } } //If we found a match, delete the node. if(indexToDelete!=-1){ if(numPoints==1 && parent!=NULL && grandParent!=NULL){ cout<<"About to Updated subnode :: " << *grandParent<<endl; } pointList[indexToDelete] = NULL; cout<<"Removing "<<nw<<endl; treeChanged = recomputeLeafBoundingBoxIfChanges(); treeChanged |= notifyContentsRebuilt(treeChanged); if(numPoints==1 && parent!=NULL && grandParent!=NULL){ // cout<<"About to Updated subnode :: " << *grandParent<<endl; KdCell *otherChild; if(parent->leftChild->equals(*this)){ otherChild = rightChild; } else{ otherChild = leftChild; } if (grandParent->leftChild->equals(*parent)) { grandParent->leftChild=otherChild; } else { grandParent->rightChild=otherChild; } this->removeFromTree=true; parent->removeFromTree = true; cout<<"Updated subnode :: " << *grandParent<<endl; } } } //Interior node. else { double nodeSplitAxisValue = findSplitComponent(nw, splitType); KdCell * child = nodeSplitAxisValue <= splitValue ? leftChild : rightChild; treeChanged = child->removeInternal(nw,this, parent); cout<<"BEFORE EX " <<*this<<endl; if(treeChanged ==true && removeFromTree==false){ treeChanged |= recomputeParentBoundingBoxIfChanges(); notifyContentsRebuilt(treeChanged); } } return treeChanged; } /** * */ bool add(NodeWrapper & nw) { return add(NULL, this, nw); } /** * */ static bool add(KdCell * parent, KdCell * current, NodeWrapper & nw) { bool treeChanged = false; if (current->splitType == KdCell::LEAF) { bool canInsert = false; for (int i = 0; i < KdCell::MAX_POINTS_IN_CELL; i++) { if (current->pointList[i] == NULL) { current->pointList[i] = &nw; canInsert = true; break; } } //If we could not insert in there, we need to split this. if (canInsert == false) { if (parent == NULL) { assert(false&&"Cannot split root node, in addNode"); } else { vector<NodeWrapper*>newList(KdCell::MAX_POINTS_IN_CELL + 1); for(int i=0;i<MAX_POINTS_IN_CELL;i++){ for(int j=0;j<MAX_POINTS_IN_CELL;j++){ if(i!=j){ if(current->pointList[i]->equals(*current->pointList[j])) assert(false&& "Sharing!!"); } } } for (int i = 0; i < MAX_POINTS_IN_CELL; i++) newList[i] = current->pointList[i]; newList[MAX_POINTS_IN_CELL] = &nw; KdCell *newCell = subDivide(newList, 0,KdCell::MAX_POINTS_IN_CELL + 1, NULL, *current); if (parent->leftChild == current) { parent->leftChild = newCell; } else if (parent->rightChild == current) { parent->rightChild = newCell; } canInsert = true; delete current; } } treeChanged = canInsert; } //Internal node. else { double nodeSplitAxisValue = findSplitComponent(nw, current->splitType); treeChanged = (nodeSplitAxisValue <= current->splitValue) ? add( current, current->leftChild, nw) : add(current, current->rightChild, nw); if (treeChanged) { bool change = current->addToBoundingBoxIfChanged(nw); change = current->notifyPointAdded(nw, change); } } return treeChanged; } private: /** * */ bool notifyPointAdded(NodeWrapper & nw, bool inChange) { return inChange; } /** * */ bool addToBoundingBoxIfChanged(NodeWrapper & nw) { bool retVal = min.setIfMin(nw.getLocation()); retVal |= max.setIfMax(nw.getLocation()); return retVal; } /** * */ void computeBoundingBoxFromPoints(vector<NodeWrapper *> & list, int size) { Point3 newMin(numeric_limits<double>::max()); Point3 newMax(-numeric_limits<double>::max()); for (int i = 0; i < size; i++) { newMin.setIfMin(list[i]->getLocation()); newMax.setIfMax(list[i]->getLocation()); } min.set(newMin); max.set(newMax); } /** * */ bool recomputeLeafBoundingBoxIfChanges() { Point3 newMin(numeric_limits<float>::max()); Point3 newMax(-numeric_limits<float>::max()); for (int i = 0; i < KdCell::MAX_POINTS_IN_CELL; i++) { if (pointList[i] != NULL) { newMin.setIfMin(pointList[i]->getMin()); newMax.setIfMax(pointList[i]->getMax()); } } return updateBoundingBox(newMin, newMax); } /** * */ bool recomputeParentBoundingBoxIfChanges(){ Point3 newMin(leftChild->min); newMin.setIfMin(rightChild->min); Point3 newMax(leftChild->max); newMax.setIfMax(rightChild->max); return updateBoundingBox(newMin, newMax); } /** * */ bool updateBoundingBox(Point3 & newMin, Point3 & newMax) { bool retVal = false; retVal = min.setIfMin(newMin); retVal |= max.setIfMax(newMax); return retVal; } /** * */ friend ostream& operator<<(ostream & s, KdCell & cell); }; const int KdCell::SPLIT_X = 0; const int KdCell::SPLIT_Y = 1; const int KdCell::SPLIT_Z = 2; const int KdCell::LEAF = 3; const int KdCell::MAX_POINTS_IN_CELL = 4; /** * */ ostream& operator<<(ostream & s, KdCell & cell) { if (cell.splitType == KdCell::LEAF) { s << "Leaf ::["; for (int i = 0; i < KdCell::MAX_POINTS_IN_CELL; i++) { if (cell.pointList[i] != NULL) s << *cell.pointList[i] << ","; } s << "]" << std::endl; } else { s << "InnerNode(" << cell.splitType << "," << cell.splitValue; if(cell.leftChild!=NULL) s<< ") \nLEFT::[" << (*cell.leftChild); else s<<" NO-LEFT "; if(cell.rightChild!=NULL) s<< "]\nRIGHT::["<< (*cell.rightChild); else s<<" NO-RIGHT"; s<< "]"; } return s; } #endif /* KDCELL_H_ */
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/clustering/NodeWrapper.h
/** Single source shortest paths -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Agglomerative Clustering. * * @author Rashid Kaleem <[email protected]> */ #ifndef NODEWRAPPER_H_ #define NODEWRAPPER_H_ #include"LeafNode.h" #include"ClusterNode.h" #include"Box3d.h" #include"Point3.h" #include<math.h> class NodeWrapper :public Box3d{ public: static const int CONE_RECURSE_SIZE; static const double GLOBAL_SCENE_DIAGONAL; private: AbstractNode & light; Box3d direction; double coneCosine; Point3 location; Point3 coneDirection; const int descendents; vector<ClusterNode *> coneClusters; const bool cleanLight; NodeWrapper * _l, *_r; public: /** * */ NodeWrapper(LeafNode & inNode):light(inNode),location(0),coneDirection(0),descendents(1),cleanLight(false){ setBox(inNode.getPoint()); direction.setBox(inNode.getDirection()); coneCosine=1.0f; coneDirection.set(inNode.getDirection()); location.set(getMin()); location.add(getMax()); location.scale(0.5f); _l=_r=NULL; } /** * */ NodeWrapper(NodeWrapper & pLeft, NodeWrapper & pRight, vector<double> * coordArr, vector<ClusterNode*> & tempClusterArr) :light(*(new ClusterNode())), location(0),coneDirection(0), descendents(pLeft.descendents + pRight.descendents), cleanLight(true){ NodeWrapper * l = &pLeft, *r = &pRight; if( (pLeft.location.getX() > pRight.location.getX()) || ( (pLeft.location.getX()==pRight.location.getX()) && (pLeft.location.getY() > pRight.location.getY()) ) || ( (pLeft.location.getX()==pRight.location.getX()) && (pLeft.location.getY() == pRight.location.getY()) && (pLeft.location.getZ() > pRight.location.getZ()) ) ){ l = &pRight; r = &pLeft; } addBox(*r); addBox(*l); location.set(max); location.add(min); location.scale(0.5); ((ClusterNode&)light).setBox(min, max); ((ClusterNode&)light).setChildren(&l->light, &r->light, ((double) rand())/numeric_limits<double>::max()); coneCosine = computeCone(*l,*r,((ClusterNode&)light)); if(coneCosine>-0.9f){ direction.addBox(l->direction); direction.addBox(r->direction); ((ClusterNode&)light).findConeDirsRecursive(coordArr,tempClusterArr); int numClus=0; for(; tempClusterArr[numClus]!=NULL;numClus++){ } if(numClus>0){ this->coneClusters.resize(numClus); for(int j=0;j<numClus;j++){ coneClusters[j]=tempClusterArr[j]; tempClusterArr[j]=NULL; } } } _l=l; _r=r; // cout<<"Creating new node wrapper["<<*l<<" , "<<*r<<"] w/ two children"<<*this<<endl; } /** * */ ~NodeWrapper(){ if(cleanLight){ // cout<<"Deleting nodewrapper "<<endl; delete (ClusterNode*)(&light); } } /** * */ static double computeCone(const NodeWrapper & a, const NodeWrapper & b, ClusterNode & cluster){ if(a.direction.isInitialized()==false || b.direction.isInitialized()==false) return -1.0f; Point3 min(a.direction.getMin()); min.setIfMin(b.direction.getMin()); Point3 max(a.direction.getMax()); max.setIfMax(b.direction.getMax()); Point3 temp(max); temp.sub(min); double radiusSq = temp.getLen(); temp.set(max); temp.add(min); double centerSq = temp.getLen(); if(centerSq <0.01){ return -1.0f; } double invLen = 1.0f/sqrt(centerSq); double minCos = (centerSq+4.0f - radiusSq)*0.25f * invLen; if(minCos < -1.0f){ minCos = -1.0f; } temp.scale(invLen); cluster.setDirectionCone(temp.getX(),temp.getY(),temp.getZ(),minCos); return minCos; } /** * */ static double computeCone(const NodeWrapper & a, const NodeWrapper & b){ if(a.direction.isInitialized()==false || b.direction.isInitialized()==false) return -1.0f; Point3 min(a.direction.getMin()); min.setIfMin(b.direction.getMin()); Point3 max(a.direction.getMax()); max.setIfMax(b.direction.getMax()); Point3 temp(max); temp.sub(min); double radiusSq = temp.getLen(); temp.set(max); temp.add(min); double centerSq = temp.getLen(); if(centerSq <0.01){ return -1.0f; } double invLen = 1.0f/sqrt(centerSq); double minCos = (centerSq+4.0f - radiusSq)*0.25f * invLen; if(minCos < -1.0f){ minCos = -1.0f; } temp.scale(invLen); return minCos; } /** * */ AbstractNode & getLight()const { return light; } /** * */ double getLocationX()const { return location.getX(); } double getLocationY()const{ return location.getY(); } double getLocationZ()const{ return location.getZ(); } double getConeCosine()const{ return coneCosine; } double getHalfSizeX()const{ return max.getX()-location.getX(); } double getHalfSizeY()const{ return max.getY()-location.getY(); } double getHalfSizeZ()const{ return max.getZ()-location.getZ(); } /** * */ const Point3 & getLocation()const { return location; } /** * */ bool equals(const NodeWrapper & other){ bool retVal=true; if(this->direction.equals(other.direction)==false) retVal &= false; if(this->coneCosine != other.coneCosine) retVal &= false; if(this->location.equals(other.location)==false) retVal &= false; if(this->coneDirection.equals(other.coneDirection)==false) retVal &= false; if(this->direction.equals(other.direction)==false) retVal &= false; //TODO : Add light comparison logic here! return retVal; } /** * */ static double potentialClusterSize(const NodeWrapper &a, NodeWrapper &b) { Point3 max(a.max); max.setIfMax(b.max); Point3 min(a.min); min.setIfMin(b.min); Point3 diff(max); diff.sub(min); double minCos = computeCone(a, b); double maxIntensity = a.light.getScalarTotalIntensity() + b.light.getScalarTotalIntensity(); return clusterSizeMetric(diff, minCos, maxIntensity); } /** * Compute a measure of the size of a light cluster */ static double clusterSizeMetric(Point3 & size, double cosSemiAngle, double intensity) { double len2 = size.getLen(); double angleFactor = (1 - cosSemiAngle) * GLOBAL_SCENE_DIAGONAL; double res = intensity * (len2 + angleFactor * angleFactor); // cout<<">>>>>>>>>>> "<<len2<<" "<<angleFactor << " " <<res<<endl; return res; } /** * */ friend ostream& operator<<(ostream& s, const NodeWrapper & node); }; const int NodeWrapper::CONE_RECURSE_SIZE=4; const double NodeWrapper::GLOBAL_SCENE_DIAGONAL = 2.0; /** * */ ostream& operator<<(ostream& s, const NodeWrapper & node){ s<<"NW::["<<node.location<<"] ConeClus :: "; for(unsigned int i=0;i<node.coneClusters.size();i++){ if(node.coneClusters[i]!=NULL) s<<""<< (*node.coneClusters[i])<<","; } if(node._l!=NULL) s<<"{LEFT "<<*node._l<<"}"; if(node._r!=NULL) s<<"{RIGHT "<<*node._r<<"}"; s<<endl; return s; } #endif /* NODEWRAPPER_H_ */
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/connectedcomponents/CMakeLists.txt
if(USE_EXP) include_directories(../../exp/apps/connectedcomponents .) endif() app(connectedcomponents)
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/connectedcomponents/ConnectedComponents.cpp
/** Connected components -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2013, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Compute the connect components of a graph and optionally write out the largest * component to file. * * @author Donald Nguyen <[email protected]> */ #include "Galois/Galois.h" #include "Galois/Accumulator.h" #include "Galois/Bag.h" #include "Galois/DomainSpecificExecutors.h" #include "Galois/Statistic.h" #include "Galois/UnionFind.h" #include "Galois/Graph/LCGraph.h" #include "Galois/Graph/OCGraph.h" #include "Galois/Graph/TypeTraits.h" #include "Galois/ParallelSTL/ParallelSTL.h" #include "llvm/Support/CommandLine.h" #include "Lonestar/BoilerPlate.h" #include <utility> #include <vector> #include <algorithm> #include <iostream> #ifdef GALOIS_USE_EXP #include "LigraAlgo.h" #include "GraphLabAlgo.h" #include "GraphChiAlgo.h" #endif const char* name = "Connected Components"; const char* desc = "Computes the connected components of a graph"; const char* url = 0; enum Algo { async, asyncOc, blockedasync, graphchi, graphlab, labelProp, ligra, ligraChi, serial, synchronous }; enum WriteType { none, largest }; namespace cll = llvm::cl; static cll::opt<std::string> inputFilename(cll::Positional, cll::desc("<input file>"), cll::Required); static cll::opt<std::string> outputFilename(cll::Positional, cll::desc("[output file]"), cll::init("largest.gr")); static cll::opt<std::string> transposeGraphName("graphTranspose", cll::desc("Transpose of input graph")); static cll::opt<bool> symmetricGraph("symmetricGraph", cll::desc("Input graph is symmetric"), cll::init(false)); cll::opt<unsigned int> memoryLimit("memoryLimit", cll::desc("Memory limit for out-of-core algorithms (in MB)"), cll::init(~0U)); static cll::opt<WriteType> writeType("output", cll::desc("Output type:"), cll::values( clEnumValN(WriteType::none, "none", "None (default)"), clEnumValN(WriteType::largest, "largest", "Write largest component"), clEnumValEnd), cll::init(WriteType::none)); static cll::opt<Algo> algo("algo", cll::desc("Choose an algorithm:"), cll::values( clEnumValN(Algo::async, "async", "Asynchronous (default)"), clEnumValN(Algo::blockedasync, "blockedasync", "Blocked asynchronous"), clEnumValN(Algo::asyncOc, "asyncOc", "Asynchronous out-of-core memory"), clEnumValN(Algo::labelProp, "labelProp", "Using label propagation algorithm"), clEnumValN(Algo::serial, "serial", "Serial"), clEnumValN(Algo::synchronous, "sync", "Synchronous"), #ifdef GALOIS_USE_EXP clEnumValN(Algo::graphchi, "graphchi", "Using GraphChi programming model"), clEnumValN(Algo::graphlab, "graphlab", "Using GraphLab programming model"), clEnumValN(Algo::ligraChi, "ligraChi", "Using Ligra and GraphChi programming model"), clEnumValN(Algo::ligra, "ligra", "Using Ligra programming model"), #endif clEnumValEnd), cll::init(Algo::async)); struct Node: public Galois::UnionFindNode<Node> { typedef Node* component_type; unsigned int id; component_type component() { return this->findAndCompress(); } }; template<typename Graph> void readInOutGraph(Graph& graph) { using namespace Galois::Graph; if (symmetricGraph) { Galois::Graph::readGraph(graph, inputFilename); } else if (transposeGraphName.size()) { Galois::Graph::readGraph(graph, inputFilename, transposeGraphName); } else { GALOIS_DIE("Graph type not supported"); } } /** * Serial connected components algorithm. Just use union-find. */ struct SerialAlgo { typedef Galois::Graph::LC_CSR_Graph<Node,void> ::with_no_lockable<true>::type Graph; typedef Graph::GraphNode GNode; void readGraph(Graph& graph) { Galois::Graph::readGraph(graph, inputFilename); } struct Merge { Graph& graph; Merge(Graph& g): graph(g) { } void operator()(const GNode& src) const { Node& sdata = graph.getData(src, Galois::MethodFlag::NONE); for (Graph::edge_iterator ii = graph.edge_begin(src, Galois::MethodFlag::NONE), ei = graph.edge_end(src, Galois::MethodFlag::NONE); ii != ei; ++ii) { GNode dst = graph.getEdgeDst(ii); Node& ddata = graph.getData(dst, Galois::MethodFlag::NONE); sdata.merge(&ddata); } } }; void operator()(Graph& graph) { std::for_each(graph.begin(), graph.end(), Merge(graph)); } }; /** * Synchronous connected components algorithm. Initially all nodes are in * their own component. Then, we merge endpoints of edges to form the spanning * tree. Merging is done in two phases to simplify concurrent updates: (1) * find components and (2) union components. Since the merge phase does not * do any finds, we only process a fraction of edges at a time; otherwise, * the union phase may unnecessarily merge two endpoints in the same * component. */ struct SynchronousAlgo { typedef Galois::Graph::LC_CSR_Graph<Node,void> ::with_no_lockable<true>::type ::with_numa_alloc<true>::type Graph; typedef Graph::GraphNode GNode; void readGraph(Graph& graph) { Galois::Graph::readGraph(graph, inputFilename); } struct Edge { GNode src; Node* ddata; int count; Edge(GNode src, Node* ddata, int count): src(src), ddata(ddata), count(count) { } }; Galois::InsertBag<Edge> wls[2]; Galois::InsertBag<Edge>* next; Galois::InsertBag<Edge>* cur; struct Initialize { Graph& graph; Galois::InsertBag<Edge>& next; Initialize(Graph& g, Galois::InsertBag<Edge>& next): graph(g), next(next) { } //! Add the first edge between components to the worklist void operator()(const GNode& src) const { for (Graph::edge_iterator ii = graph.edge_begin(src, Galois::MethodFlag::NONE), ei = graph.edge_end(src, Galois::MethodFlag::NONE); ii != ei; ++ii) { GNode dst = graph.getEdgeDst(ii); if (symmetricGraph && src >= dst) continue; Node& ddata = graph.getData(dst, Galois::MethodFlag::NONE); next.push(Edge(src, &ddata, 0)); break; } } }; struct Merge { Graph& graph; Galois::Statistic& emptyMerges; Merge(Graph& g, Galois::Statistic& e): graph(g), emptyMerges(e) { } void operator()(const Edge& edge) const { Node& sdata = graph.getData(edge.src, Galois::MethodFlag::NONE); if (!sdata.merge(edge.ddata)) emptyMerges += 1; } }; struct Find { typedef int tt_does_not_need_aborts; typedef int tt_does_not_need_push; typedef int tt_does_not_need_stats; Graph& graph; Galois::InsertBag<Edge>& next; Find(Graph& g, Galois::InsertBag<Edge>& next): graph(g), next(next) { } //! Add the next edge between components to the worklist void operator()(const Edge& edge, Galois::UserContext<Edge>&) const { (*this)(edge); } void operator()(const Edge& edge) const { GNode src = edge.src; Node& sdata = graph.getData(src, Galois::MethodFlag::NONE); Node* scomponent = sdata.findAndCompress(); Graph::edge_iterator ii = graph.edge_begin(src, Galois::MethodFlag::NONE); Graph::edge_iterator ei = graph.edge_end(src, Galois::MethodFlag::NONE); int count = edge.count + 1; std::advance(ii, count); for (; ii != ei; ++ii, ++count) { GNode dst = graph.getEdgeDst(ii); if (symmetricGraph && src >= dst) continue; Node& ddata = graph.getData(dst, Galois::MethodFlag::NONE); Node* dcomponent = ddata.findAndCompress(); if (scomponent != dcomponent) { next.push(Edge(src, dcomponent, count)); break; } } } }; void operator()(Graph& graph) { Galois::Statistic rounds("Rounds"); Galois::Statistic emptyMerges("EmptyMerges"); cur = &wls[0]; next = &wls[1]; Galois::do_all_local(graph, Initialize(graph, *cur)); while (!cur->empty()) { Galois::do_all_local(*cur, Merge(graph, emptyMerges)); Galois::for_each_local(*cur, Find(graph, *next)); cur->clear(); std::swap(cur, next); rounds += 1; } } }; struct LabelPropAlgo { struct LNode { typedef unsigned int component_type; unsigned int id; unsigned int comp; component_type component() { return comp; } bool isRep() { return id == comp; } }; typedef Galois::Graph::LC_CSR_Graph<LNode,void> ::with_no_lockable<true>::type ::with_numa_alloc<true>::type InnerGraph; typedef Galois::Graph::LC_InOut_Graph<InnerGraph> Graph; typedef Graph::GraphNode GNode; typedef LNode::component_type component_type; void readGraph(Graph& graph) { readInOutGraph(graph); } struct Initialize { Graph& graph; Initialize(Graph& g): graph(g) { } void operator()(GNode n) { LNode& data = graph.getData(n, Galois::MethodFlag::NONE); data.comp = data.id; } }; template<bool Forward,bool Backward> struct Process { typedef int tt_does_not_need_aborts; Graph& graph; Process(Graph& g): graph(g) { } template<typename Iterator,typename GetNeighbor> void update(LNode& sdata, Iterator ii, Iterator ei, GetNeighbor get, Galois::UserContext<GNode>& ctx) { for (; ii != ei; ++ii) { GNode dst = get(ii); LNode& ddata = graph.getData(dst, Galois::MethodFlag::NONE); while (true) { component_type old = ddata.comp; component_type newV = sdata.comp; if (old <= newV) break; if (__sync_bool_compare_and_swap(&ddata.comp, old, newV)) { ctx.push(dst); break; } } } } struct BackwardUpdate { Graph& graph; BackwardUpdate(Graph& g): graph(g) { } GNode operator()(typename Graph::in_edge_iterator ii) { return graph.getInEdgeDst(ii); } }; struct ForwardUpdate { Graph& graph; ForwardUpdate(Graph& g): graph(g) { } GNode operator()(typename Graph::edge_iterator ii) { return graph.getEdgeDst(ii); } }; //! Add the next edge between components to the worklist void operator()(const GNode& src, Galois::UserContext<GNode>& ctx) { LNode& sdata = graph.getData(src, Galois::MethodFlag::NONE); if (Backward) { update(sdata, graph.in_edge_begin(src, Galois::MethodFlag::NONE), graph.in_edge_end(src, Galois::MethodFlag::NONE), BackwardUpdate(graph), ctx); } if (Forward) { update(sdata, graph.edge_begin(src, Galois::MethodFlag::NONE), graph.edge_end(src, Galois::MethodFlag::NONE), ForwardUpdate(graph), ctx); } } }; void operator()(Graph& graph) { typedef Galois::WorkList::dChunkedFIFO<256> WL; Galois::do_all_local(graph, Initialize(graph)); if (symmetricGraph) { Galois::for_each_local(graph, Process<true,false>(graph), Galois::wl<WL>()); } else { Galois::for_each_local(graph, Process<true,true>(graph), Galois::wl<WL>()); } } }; struct AsyncOCAlgo { typedef Galois::Graph::OCImmutableEdgeGraph<Node,void> Graph; typedef Graph::GraphNode GNode; void readGraph(Graph& graph) { readInOutGraph(graph); } struct Merge { typedef int tt_does_not_need_aborts; typedef int tt_does_not_need_push; Galois::Statistic& emptyMerges; Merge(Galois::Statistic& e): emptyMerges(e) { } //! Add the next edge between components to the worklist template<typename GTy> void operator()(GTy& graph, const GNode& src) const { Node& sdata = graph.getData(src, Galois::MethodFlag::NONE); for (typename GTy::edge_iterator ii = graph.edge_begin(src, Galois::MethodFlag::NONE), ei = graph.edge_end(src, Galois::MethodFlag::NONE); ii != ei; ++ii) { GNode dst = graph.getEdgeDst(ii); Node& ddata = graph.getData(dst, Galois::MethodFlag::NONE); if (symmetricGraph && src >= dst) continue; if (!sdata.merge(&ddata)) emptyMerges += 1; } } }; void operator()(Graph& graph) { Galois::Statistic emptyMerges("EmptyMerges"); Galois::GraphChi::vertexMap(graph, Merge(emptyMerges), memoryLimit); } }; /** * Like synchronous algorithm, but if we restrict path compression (as done is * @link{UnionFindNode}), we can perform unions and finds concurrently. */ struct AsyncAlgo { typedef Galois::Graph::LC_CSR_Graph<Node,void> ::with_numa_alloc<true>::type ::with_no_lockable<true>::type Graph; typedef Graph::GraphNode GNode; void readGraph(Graph& graph) { Galois::Graph::readGraph(graph, inputFilename); } struct Merge { typedef int tt_does_not_need_aborts; typedef int tt_does_not_need_push; Graph& graph; Galois::Statistic& emptyMerges; Merge(Graph& g, Galois::Statistic& e): graph(g), emptyMerges(e) { } //! Add the next edge between components to the worklist void operator()(const GNode& src, Galois::UserContext<GNode>&) const { (*this)(src); } void operator()(const GNode& src) const { Node& sdata = graph.getData(src, Galois::MethodFlag::NONE); for (Graph::edge_iterator ii = graph.edge_begin(src, Galois::MethodFlag::NONE), ei = graph.edge_end(src, Galois::MethodFlag::NONE); ii != ei; ++ii) { GNode dst = graph.getEdgeDst(ii); Node& ddata = graph.getData(dst, Galois::MethodFlag::NONE); if (symmetricGraph && src >= dst) continue; if (!sdata.merge(&ddata)) emptyMerges += 1; } } }; void operator()(Graph& graph) { Galois::Statistic emptyMerges("EmptyMerges"); Galois::for_each_local(graph, Merge(graph, emptyMerges)); } }; /** * Improve performance of async algorithm by following machine topology. */ struct BlockedAsyncAlgo { typedef Galois::Graph::LC_CSR_Graph<Node,void> ::with_numa_alloc<true>::type ::with_no_lockable<true>::type Graph; typedef Graph::GraphNode GNode; struct WorkItem { GNode src; Graph::edge_iterator start; }; void readGraph(Graph& graph) { Galois::Graph::readGraph(graph, inputFilename); } struct Merge { typedef int tt_does_not_need_aborts; Graph& graph; Galois::InsertBag<WorkItem>& items; //! Add the next edge between components to the worklist template<bool MakeContinuation, int Limit, typename Pusher> void process(const GNode& src, const Graph::edge_iterator& start, Pusher& pusher) { Node& sdata = graph.getData(src, Galois::MethodFlag::NONE); int count = 1; for (Graph::edge_iterator ii = start, ei = graph.edge_end(src, Galois::MethodFlag::NONE); ii != ei; ++ii, ++count) { GNode dst = graph.getEdgeDst(ii); Node& ddata = graph.getData(dst, Galois::MethodFlag::NONE); if (symmetricGraph && src >= dst) continue; if (sdata.merge(&ddata)) { if (Limit == 0 || count != Limit) continue; } if (MakeContinuation || (Limit != 0 && count == Limit)) { WorkItem item = { src, ii + 1 }; pusher.push(item); break; } } } void operator()(const GNode& src) { Graph::edge_iterator start = graph.edge_begin(src, Galois::MethodFlag::NONE); if (Galois::Runtime::LL::getPackageForSelf(Galois::Runtime::LL::getTID()) == 0) { process<true, 0>(src, start, items); } else { process<true, 1>(src, start, items); } } void operator()(const WorkItem& item, Galois::UserContext<WorkItem>& ctx) { process<true, 0>(item.src, item.start, ctx); } }; void operator()(Graph& graph) { Galois::InsertBag<WorkItem> items; Merge merge = { graph, items }; Galois::do_all_local(graph, merge, Galois::loopname("Initialize"), Galois::do_all_steal(false)); Galois::for_each_local(items, merge, Galois::loopname("Merge"), Galois::wl<Galois::WorkList::dChunkedFIFO<128> >()); } }; template<typename Graph> struct is_bad { typedef typename Graph::GraphNode GNode; Graph& graph; is_bad(Graph& g): graph(g) { } bool operator()(const GNode& n) const { typedef typename Graph::node_data_reference node_data_reference; node_data_reference me = graph.getData(n); for (typename Graph::edge_iterator ii = graph.edge_begin(n), ei = graph.edge_end(n); ii != ei; ++ii) { GNode dst = graph.getEdgeDst(ii); node_data_reference data = graph.getData(dst); if (data.component() != me.component()) { std::cerr << "not in same component: " << me.id << " (" << me.component() << ")" << " and " << data.id << " (" << data.component() << ")" << "\n"; return true; } } return false; } }; template<typename Graph> bool verify(Graph& graph, typename std::enable_if<Galois::Graph::is_segmented<Graph>::value>::type* = 0) { return true; } template<typename Graph> bool verify(Graph& graph, typename std::enable_if<!Galois::Graph::is_segmented<Graph>::value>::type* = 0) { return Galois::ParallelSTL::find_if(graph.begin(), graph.end(), is_bad<Graph>(graph)) == graph.end(); } template<typename Graph> void writeComponent(Graph& graph, typename Graph::node_data_type::component_type component, typename std::enable_if<Galois::Graph::is_segmented<Graph>::value>::type* = 0) { std::cerr << "Writing component not supported for this graph\n"; abort(); } template<typename Graph> void writeComponent(Graph& graph, typename Graph::node_data_type::component_type component, typename std::enable_if<!Galois::Graph::is_segmented<Graph>::value>::type* = 0) { typedef typename Graph::GraphNode GNode; typedef typename Graph::node_data_reference node_data_reference; // id == 1 if node is in component size_t numEdges = 0; size_t numNodes = 0; for (typename Graph::iterator ii = graph.begin(), ei = graph.end(); ii != ei; ++ii) { node_data_reference data = graph.getData(*ii); data.id = data.component() == component ? 1 : 0; if (data.id) { size_t degree = std::distance(graph.edge_begin(*ii, Galois::MethodFlag::NONE), graph.edge_end(*ii, Galois::MethodFlag::NONE)); numEdges += degree; numNodes += 1; } } typedef Galois::Graph::FileGraphWriter Writer; Writer p; p.setNumNodes(numNodes); p.setNumEdges(numEdges); p.phase1(); // partial sums of ids: id == new_index + 1 typename Graph::node_data_type* prev = 0; for (typename Graph::iterator ii = graph.begin(), ei = graph.end(); ii != ei; ++ii) { node_data_reference data = graph.getData(*ii); if (prev) data.id = prev->id + data.id; if (data.component() == component) { size_t degree = std::distance(graph.edge_begin(*ii, Galois::MethodFlag::NONE), graph.edge_end(*ii, Galois::MethodFlag::NONE)); size_t sid = data.id - 1; assert(sid < numNodes); p.incrementDegree(sid, degree); } prev = &data; } assert(!prev || prev->id == numNodes); p.phase2(); for (typename Graph::iterator ii = graph.begin(), ei = graph.end(); ii != ei; ++ii) { node_data_reference data = graph.getData(*ii); if (data.component() != component) continue; size_t sid = data.id - 1; for (typename Graph::edge_iterator jj = graph.edge_begin(*ii, Galois::MethodFlag::NONE), ej = graph.edge_end(*ii, Galois::MethodFlag::NONE); jj != ej; ++jj) { GNode dst = graph.getEdgeDst(jj); node_data_reference ddata = graph.getData(dst, Galois::MethodFlag::NONE); size_t did = ddata.id - 1; //assert(ddata.component == component); assert(sid < numNodes && did < numNodes); p.addNeighbor(sid, did); } } p.finish<void>(); std::cout << "Writing largest component to " << outputFilename << " (nodes: " << numNodes << " edges: " << numEdges << ")\n"; p.structureToFile(outputFilename); } template<typename Graph> struct CountLargest { typedef typename Graph::node_data_type::component_type component_type; typedef std::map<component_type,int> Map; typedef typename Graph::GraphNode GNode; struct Accums { Galois::GMapElementAccumulator<Map> map; Galois::GAccumulator<size_t> reps; }; Graph& graph; Accums& accums; CountLargest(Graph& g, Accums& accums): graph(g), accums(accums) { } void operator()(const GNode& x) { typename Graph::node_data_reference n = graph.getData(x, Galois::MethodFlag::NONE); if (n.isRep()) { accums.reps += 1; return; } // Don't add reps to table to avoid adding components of size 1 accums.map.update(n.component(), 1); } }; template<typename Graph> struct ComponentSizePair { typedef typename Graph::node_data_type::component_type component_type; component_type component; int size; struct Max { ComponentSizePair operator()(const ComponentSizePair& a, const ComponentSizePair& b) const { if (a.size > b.size) return a; return b; } }; ComponentSizePair(): component(0), size(0) { } ComponentSizePair(component_type c, int s): component(c), size(s) { } }; template<typename Graph> struct ReduceMax { typedef typename Graph::node_data_type::component_type component_type; typedef Galois::GSimpleReducible<ComponentSizePair<Graph>,typename ComponentSizePair<Graph>::Max> Accum; Accum& accum; ReduceMax(Accum& accum): accum(accum) { } void operator()(const std::pair<component_type,int>& x) { accum.update(ComponentSizePair<Graph>(x.first, x.second)); } }; template<typename Graph> typename Graph::node_data_type::component_type findLargest(Graph& graph) { typedef CountLargest<Graph> CL; typedef ReduceMax<Graph> RM; typename CL::Accums accums; Galois::do_all_local(graph, CL(graph, accums)); typename CL::Map& map = accums.map.reduce(); size_t reps = accums.reps.reduce(); typename RM::Accum accumMax; Galois::do_all(map.begin(), map.end(), RM(accumMax)); ComponentSizePair<Graph>& largest = accumMax.reduce(); // Compensate for dropping representative node of components double ratio = graph.size() - reps + map.size(); size_t largestSize = largest.size + 1; if (ratio) ratio = largestSize / ratio; std::cout << "Number of non-trivial components: " << map.size() << " (largest: " << largestSize << " [" << ratio << "])\n"; std::cout << "Total components: " << reps << "\n"; return largest.component; } template<typename Algo> void run() { typedef typename Algo::Graph Graph; Algo algo; Graph graph; algo.readGraph(graph); std::cout << "Read " << graph.size() << " nodes\n"; unsigned int id = 0; for (typename Graph::iterator ii = graph.begin(), ei = graph.end(); ii != ei; ++ii, ++id) { graph.getData(*ii).id = id; } Galois::preAlloc(numThreads + (2 * graph.size() * sizeof(typename Graph::node_data_type)) / Galois::Runtime::MM::pageSize); Galois::reportPageAlloc("MeminfoPre"); Galois::StatTimer T; T.start(); algo(graph); T.stop(); Galois::reportPageAlloc("MeminfoPost"); if (!skipVerify || writeType == WriteType::largest) { auto component = findLargest(graph); if (!verify(graph)) { std::cerr << "verification failed\n"; assert(0 && "verification failed"); abort(); } if (writeType == WriteType::largest && component) { writeComponent(graph, component); } } } int main(int argc, char** argv) { Galois::StatManager statManager; LonestarStart(argc, argv, name, desc, url); Galois::StatTimer T("TotalTime"); T.start(); switch (algo) { case Algo::asyncOc: run<AsyncOCAlgo>(); break; case Algo::async: run<AsyncAlgo>(); break; case Algo::blockedasync: run<BlockedAsyncAlgo>(); break; case Algo::labelProp: run<LabelPropAlgo>(); break; case Algo::serial: run<SerialAlgo>(); break; case Algo::synchronous: run<SynchronousAlgo>(); break; #ifdef GALOIS_USE_EXP case Algo::graphchi: run<GraphChiAlgo>(); break; case Algo::graphlab: run<GraphLabAlgo>(); break; case Algo::ligraChi: run<LigraAlgo<true> >(); break; case Algo::ligra: run<LigraAlgo<false> >(); break; #endif default: std::cerr << "Unknown algorithm\n"; abort(); } T.stop(); return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/surveypropagation/CMakeLists.txt
app(surveypropagation)
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/surveypropagation/SurveyPropagation.cpp
/** Survey propagation -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Survey Propagation * * @author Andrew Lenharth <[email protected]> */ #include "Galois/Statistic.h" #include "Galois/Graph/Graph.h" #include "Galois/Galois.h" #include "Galois/Accumulator.h" #include "llvm/Support/CommandLine.h" #include "Lonestar/BoilerPlate.h" #ifdef GALOIS_USE_EXP #include "Galois/PriorityScheduling.h" #endif #include <cstdlib> #include <iostream> #include <math.h> using namespace std; using namespace Galois::WorkList; namespace cll = llvm::cl; static const char* name = "Survey Propagation"; static const char* desc = "Solves SAT problems using survey propagation"; static const char* url = "survey_propagation"; static cll::opt<int> seed(cll::Positional, cll::desc("<seed>"), cll::Required); static cll::opt<int> M(cll::Positional, cll::desc("<num variables>"), cll::Required); static cll::opt<int> N(cll::Positional, cll::desc("<num clauses>"), cll::Required); static cll::opt<int> K(cll::Positional, cll::desc("<variables per clause>"), cll::Required); //#define WLWL LocalQueues<ChunkedFIFO<1024>, FIFO<> > #define WLWL dChunkedFIFO<1024> //SAT problem: //variables Xi E {0,1}, i E {1 .. N), M constraints //constraints are or clauses of variables or negation of variables //clause a has variables i1...iK, J^a_ir E {-+1} //zi1 = J^a_ir * xir //Graph form: //N variables each get a variable node (circles in paper) (SET X, i,j,k...) //M clauses get a function node (square in paper) (set A, a,b,c...) // edge between xi and a if xi appears in a, weighted by J^a_i //V(i) function nodes a... to which variable node i is connected //n_i = |V(i)| = degree of variable node //V+(i) positive edges, V-(i) negative edges (per J^a_i) (V(i) = V+(i) + V-(i)) //V(i)\b set V(i) without b //given connected Fnode a and Vnode j, V^u_a(j) and V^s_a(j) are neighbors which cause j sat or unsat a: // if (J^a_j = 1): V^u_a(j) = V+(j); V^s_a(j) = V-(j)\a // if (J^a_j = -1): V^u_a(j) = V-(j); V^s_a(j) = V+(j)\a //Graph+data: //survey n_a->i E [0,1] //implementation //As a graph //nodes have: // a name // a eta product //edges have: // a double survey // a bool for sign (inversion of variable) // a pi product //Graph is undirected (for now) struct SPEdge { double eta; bool isNegative; SPEdge() {} SPEdge(bool isNeg) :isNegative(isNeg) { eta = (double)rand() / (double)RAND_MAX; } }; struct SPNode { bool isClause; int name; bool solved; bool value; int t; double Bias; SPNode(int n, bool b) :isClause(b), name(n), solved(false), value(false), t(0) {} }; typedef Galois::Graph::FirstGraph<SPNode, SPEdge, false> Graph; typedef Galois::Graph::FirstGraph<SPNode, SPEdge, false>::GraphNode GNode; static Graph graph; static std::vector<GNode> literals; static std::vector<std::pair<GNode,int> > clauses; static Galois::GAccumulator<unsigned int> nontrivial; static Galois::GReduceMax<double> maxBias; static Galois::GAccumulator<int> numBias; static Galois::GAccumulator<double> sumBias; //interesting parameters: static const double epsilon = 0.000001; static const int tmax = 100; //static int tlimit = 0; void initialize_random_formula(int M, int N, int K) { //M clauses //N variables //K vars per clause //build up clauses and literals clauses.resize(M); literals.resize(N); for (int m = 0; m < M; ++m) { GNode node = graph.createNode(SPNode(m, true)); graph.addNode(node, Galois::MethodFlag::NONE); clauses[m] = std::make_pair(node, 0); } for (int n = 0; n < N; ++n) { GNode node = graph.createNode(SPNode(n, false)); graph.addNode(node, Galois::MethodFlag::NONE); literals[n] = node; } for (int m = 0; m < M; ++m) { //Generate K unique values std::vector<int> touse; while (touse.size() != (unsigned)K) { //extra complex to generate uniform rand value int newK = (int)(((double)rand()/((double)RAND_MAX + 1)) * (double)(N)); if (std::find(touse.begin(), touse.end(), newK) == touse.end()) { touse.push_back(newK); graph.getEdgeData(graph.addEdge(clauses[m].first, literals[newK], Galois::MethodFlag::NONE)) = SPEdge((bool)(rand() % 2)); } } } //std::random_shuffle(literals.begin(), literals.end()); //std::random_shuffle(clauses.begin(), clauses.end()); } void print_formula() { for (unsigned m = 0; m < clauses.size(); ++m) { if (m != 0) std::cout << " & "; std::cout << "c" << m << "( "; GNode N = clauses[m].first; for (Graph::edge_iterator ii = graph.edge_begin(N, Galois::MethodFlag::NONE), ee = graph.edge_end( N, Galois::MethodFlag::NONE); ii != ee; ++ii) { if (ii != graph.edge_begin(N, Galois::MethodFlag::NONE)) std::cout << " | "; SPEdge& E = graph.getEdgeData(ii, Galois::MethodFlag::NONE); if (E.isNegative) std::cout << "-"; SPNode& V = graph.getData(graph.getEdgeDst(ii), Galois::MethodFlag::NONE); std::cout << "v" << V.name; if (V.solved) std::cout << "[" << (V.value ? 1 : 0) << "]"; std::cout << "{" << E.eta << "," << V.Bias << "," << (V.value ? 1 : 0) << "}"; std::cout << " "; } std::cout << " )"; } std::cout << "\n"; } void print_fixed() { for (unsigned n = 0; n < literals.size(); ++n) { GNode N = literals[n]; SPNode& V = graph.getData(N, Galois::MethodFlag::NONE); if (V.solved) std::cout << V.name << "[" << (V.value ? 1 : 0) << "] "; } std::cout << "\n"; } int count_fixed() { int retval = 0; for (unsigned n = 0; n < literals.size(); ++n) { GNode N = literals[n]; SPNode& V = graph.getData(N, Galois::MethodFlag::NONE); if (V.solved) ++retval; } return retval; } struct update_eta { double eta_for_a_i(GNode a, GNode i) { double etaNew = 1.0; //for each j for (Graph::edge_iterator jii = graph.edge_begin(a, Galois::MethodFlag::NONE), jee = graph.edge_end(a, Galois::MethodFlag::NONE); jii != jee; ++jii) { GNode j = graph.getEdgeDst(jii); if (j != i) { bool ajNegative = graph.getEdgeData(jii, Galois::MethodFlag::NONE).isNegative; double prodP = 1.0; double prodN = 1.0; double prod0 = 1.0; //for each b for (Graph::edge_iterator bii = graph.edge_begin(j, Galois::MethodFlag::NONE), bee = graph.edge_end(j, Galois::MethodFlag::NONE); bii != bee; ++bii) { GNode b = graph.getEdgeDst(bii); SPEdge Ebj = graph.getEdgeData(bii, Galois::MethodFlag::NONE); if (b != a) prod0 *= (1.0 - Ebj.eta); if (Ebj.isNegative) prodN *= (1.0 - Ebj.eta); else prodP *= (1.0 - Ebj.eta); } double PIu, PIs; if (ajNegative) { PIu = (1.0 - prodN) * prodP; PIs = (1.0 - prodP) * prodN; } else { PIs = (1.0 - prodN) * prodP; PIu = (1.0 - prodP) * prodN; } double PI0 = prod0; etaNew *= (PIu / (PIu + PIs + PI0)); } } return etaNew; } template<typename Context> void operator()(std::pair<GNode,int> a, Context& ctx) { this->operator()(a.first, ctx); } template<typename Context> void operator()(GNode a, Context& ctx) { //std::cerr << graph.getData(a).t << " "; // if (graph.getData(a, Galois::MethodFlag::NONE).t >= tlimit) // return; // for (Graph::neighbor_iterator iii = graph.neighbor_begin(a), // iee = graph.neighbor_end(a); iii != iee; ++iii) // for (Graph::neighbor_iterator bii = graph.neighbor_begin(*iii), // bee = graph.neighbor_end(*iii); bii != bee; ++bii) // // for (Graph::neighbor_iterator jii = graph.neighbor_begin(*bii), // // jee = graph.neighbor_end(*bii); // // jii != jee; ++jii) //{} ++graph.getData(a).t; //for each i for (Graph::edge_iterator iii = graph.edge_begin(a, Galois::MethodFlag::NONE), iee = graph.edge_end(a, Galois::MethodFlag::NONE); iii != iee; ++iii) { GNode i = graph.getEdgeDst(iii); double e = eta_for_a_i(a, i); double olde = graph.getEdgeData(iii, Galois::MethodFlag::NONE).eta; graph.getEdgeData(iii).eta = e; //std::cout << olde << ',' << e << " "; if (fabs(olde - e) > epsilon) { for (Graph::edge_iterator bii = graph.edge_begin(i, Galois::MethodFlag::NONE), bee = graph.edge_end(i, Galois::MethodFlag::NONE); bii != bee; ++bii) { GNode b = graph.getEdgeDst(bii); if (a != b) // && graph.getData(b, Galois::MethodFlag::NONE).t < tlimit) ctx.push(std::make_pair(b,100-(int)(100.0*(olde - e)))); } } } } }; //compute biases on each node struct update_biases { void operator()(GNode i) { SPNode& idata = graph.getData(i, Galois::MethodFlag::NONE); if (idata.solved) return; double pp1 = 1.0; double pp2 = 1.0; double pn1 = 1.0; double pn2 = 1.0; double p0 = 1.0; //for each function a for (Graph::edge_iterator aii = graph.edge_begin(i, Galois::MethodFlag::NONE), aee = graph.edge_end(i, Galois::MethodFlag::NONE); aii != aee; ++aii) { SPEdge& aie = graph.getEdgeData(aii, Galois::MethodFlag::NONE); double etaai = aie.eta; if (etaai > epsilon) nontrivial += 1; if (aie.isNegative) { pp2 *= (1.0 - etaai); pn1 *= (1.0 - etaai); } else { pp1 *= (1.0 - etaai); pn2 *= (1.0 - etaai); } p0 *= (1.0 - etaai); } double pp = (1.0 - pp1) * pp2; double pn = (1.0 - pn1) * pn2; double BiasP = pp / (pp + pn + p0); double BiasN = pn / (pp + pn + p0); // double Bias0 = 1.0 - BiasP - BiasN; double d = BiasP - BiasN; if (d < 0.0) d = BiasN - BiasP; idata.Bias = d; idata.value = (BiasP > BiasN); assert(!std::isnan(d) && !std::isnan(-d)); maxBias.update(d); numBias += 1; sumBias += d; } }; struct EIndexer: public std::unary_function<std::pair<GNode,int>,int> { int operator()(const std::pair<GNode,int>& v) { return v.second; } }; struct ELess { bool operator()(const std::pair<GNode,int>& lhs, const std::pair<GNode,int>& rhs) { if (lhs.second < rhs.second) return true; if (lhs.second > rhs.second) return false; return lhs < rhs; } }; struct EGreater { bool operator()(const std::pair<GNode,int>& lhs, const std::pair<GNode,int>& rhs) { if (lhs.second > rhs.second) return true; if (lhs.second < rhs.second) return false; return lhs > rhs; } }; //return true if converged void SP_algorithm() { //0) at t = 0, for every edge a->i, randomly initialize the message sigma a->i(t=0) in [0,1] //1) for t = 1 to tmax: //1.1) sweep the set of edges in a random order, and update sequentially the warnings on all the edges of the graph, generating the values sigma a->i (t) using SP_update //1.2) if (|sigma a->i(t) - sigma a->i (t-1) < E on all the edges, the iteration has converged and generated sigma* a->i = sigma a->i(t), goto 2 //2) if t = tmax return un-converged. if (t < tmax) then return the set of fixed point warnings sigma* a->i = sigma a->i (t) // tlimit += tmax; #ifdef GALOIS_USE_EXP Exp::PriAuto<64, EIndexer, WLWL, ELess, EGreater >::for_each(clauses.begin(), clauses.end(), update_eta(), "update_eta"); #else Galois::for_each(clauses.begin(), clauses.end(), update_eta(), Galois::loopname("update_eta"), Galois::wl<WLWL>()); #endif maxBias.reset(); numBias.reset(); sumBias.reset(); nontrivial.reset(); Galois::do_all(literals.begin(), literals.end(), update_biases(), Galois::loopname("update_biases")); } struct fix_variables { double limit; fix_variables(double d) :limit(d) {} void operator()(GNode i) {//, const Context& ctx) { SPNode& idata = graph.getData(i); if (idata.solved) return; if (idata.Bias > limit) { idata.solved = true; //TODO: simplify graph //for each b for (Graph::edge_iterator bii = graph.edge_begin(i), bee = graph.edge_end(i); bii != bee; ++bii) { graph.getData(graph.getEdgeDst(bii)).solved = true; graph.getData(graph.getEdgeDst(bii)).value = true; } graph.removeNode(i); } } }; void decimate() { double m = maxBias.reduce(); double n = nontrivial.reduce(); int num = numBias.reduce(); double average = num > 0 ? sumBias.reduce() / num : 0.0; std::cout << "NonTrivial " << n << " MaxBias " << m << " Average Bias " << average << "\n"; double d = ((m - average) * 0.25) + average; Galois::do_all(literals.begin(), literals.end(), fix_variables(d), Galois::loopname("fix_variables")); } bool survey_inspired_decimation() { //0) Randomize initial conditions for the surveys //1) run SP // if (SP does not converge, return SP UNCONVEREGED and stop // if SP convereges, use fixed-point surveys n*a->i to //2) decimate //2.1) if non-trivial surveys (n != 0) are found, then: // a) compute biases (W+,W-,W0) from PI+,PI-,PI0 // b) fix largest |W+ - W-| to x = W+ > W- // c) clean the graph //2.2) if all surveys are trivial(n = 0), output simplified subformula //4) if solved, output SAT, if no contradiction, continue at 1, if contridiction, stop do { SP_algorithm(); if (nontrivial.reduce()) { std::cout << "DECIMATED\n"; decimate(); } else { std::cout << "SIMPLIFIED\n"; return false; } } while (true); // while (true); return true; } int main(int argc, char** argv) { Galois::StatManager MM; LonestarStart(argc, argv, name, desc, url); srand(seed); initialize_random_formula(M,N,K); //print_formula(); //build_graph(); //print_graph(); std::cout << "Starting...\n"; Galois::StatTimer T; T.start(); survey_inspired_decimation(); T.stop(); //print_formula(); //print_fixed(); std::cout << "Fixed " << count_fixed() << " variables\n"; return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/barneshut/CMakeLists.txt
if(CMAKE_COMPILER_IS_GNUCC) set(CMAKE_CXX_FLAGS "${CMAKE_CXX_FLAGS} -ffast-math") endif() app(barneshut Barneshut.cpp)
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/barneshut/Point.h
struct Point { double val[3]; Point() { val[0] = val[1] = val[2] = 0.0; } //Point(double _x, double _y, double _z) : val{_x,_y,_z} {} Point(double _x, double _y, double _z) { val[0] = _x; val[1] = _y; val[2] = _z; } //explicit Point(double v) : val{v,v,v} {} explicit Point(double v) { val[0] = v; val[1] = v; val[2] = v; } double operator[](const int index) const { return val[index]; } double& operator[](const int index) { return val[index]; } double x() const { return val[0]; } double y() const { return val[1]; } double z() const { return val[2]; } bool operator==(const Point& other) const { return val[0] == other.val[0] && val[1] == other.val[1] && val[2] == other.val[2]; } bool operator!=(const Point& other) const { return !operator==(other); } Point& operator+=(const Point& other) { for (int i = 0; i < 3; ++i) val[i] += other.val[i]; return *this; } Point& operator-=(const Point& other) { for (int i = 0; i < 3; ++i) val[i] -= other.val[i]; return *this; } Point& operator*=(double value) { for (int i = 0; i < 3; ++i) val[i] *= value; return *this; } Point operator-(const Point& other) const { return Point(val[0] - other.val[0], val[1] - other.val[1], val[2] - other.val[2]); } Point operator+(const Point& other) const { return Point(val[0] + other.val[0], val[1] + other.val[1], val[2] + other.val[2]); } Point operator*(double d) const { return Point(val[0] * d, val[1] * d, val[2] * d); } Point operator/(double d) const { return Point(val[0] / d, val[1] / d, val[2] / d); } double dist2() const { return dot(*this); } double dot(const Point& p2) const { return val[0] * p2.val[0] + val[1] * p2.val[1] + val[2] * p2.val[2]; } void pairMin(const Point& p2) { for (int i = 0; i < 3; ++i) if (p2.val[i] < val[i]) val[i] = p2.val[i]; } void pairMax(const Point& p2) { for (int i = 0; i < 3; ++i) if (p2.val[i] > val[i]) val[i] = p2.val[i]; } double minDim() const { return std::min(val[0], std::min(val[1], val[2])); } }; std::ostream& operator<<(std::ostream& os, const Point& p) { os << "(" << p[0] << "," << p[1] << "," << p[2] << ")"; return os; }
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/barneshut/Barneshut.cpp
/** Barnes-hut application -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2012, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @author Martin Burtscher <[email protected]> * @author Donald Nguyen <[email protected]> */ #include "Galois/config.h" #include "Galois/Galois.h" #include "Galois/Statistic.h" #include "Galois/Bag.h" #include "llvm/Support/CommandLine.h" #include "Lonestar/BoilerPlate.h" #include <boost/math/constants/constants.hpp> #include <boost/iterator/transform_iterator.hpp> #include GALOIS_CXX11_STD_HEADER(array) #include <limits> #include <iostream> #include <fstream> #include <strings.h> #include GALOIS_CXX11_STD_HEADER(deque) #include "Point.h" const char* name = "Barnshut N-Body Simulator"; const char* desc = "Simulates gravitational forces in a galactic cluster using the " "Barnes-Hut n-body algorithm"; const char* url = "barneshut"; static llvm::cl::opt<int> nbodies("n", llvm::cl::desc("Number of bodies"), llvm::cl::init(10000)); static llvm::cl::opt<int> ntimesteps("steps", llvm::cl::desc("Number of steps"), llvm::cl::init(1)); static llvm::cl::opt<int> seed("seed", llvm::cl::desc("Random seed"), llvm::cl::init(7)); struct Node { Point pos; double mass; bool Leaf; }; struct Body : public Node { Point vel; Point acc; }; /** * A node in an octree is either an internal node or a leaf. */ struct Octree : public Node { std::array<Galois::Runtime::LL::PtrLock<Node,true>, 8> child; char cLeafs; char nChildren; Octree(const Point& p) { Node::pos = p; Node::Leaf = false; cLeafs = 0; nChildren = 0; } }; std::ostream& operator<<(std::ostream& os, const Body& b) { os << "(pos:" << b.pos << " vel:" << b.vel << " acc:" << b.acc << " mass:" << b.mass << ")"; return os; } struct BoundingBox { Point min; Point max; explicit BoundingBox(const Point& p) : min(p), max(p) { } BoundingBox() : min(std::numeric_limits<double>::max()), max(std::numeric_limits<double>::min()) { } void merge(const BoundingBox& other) { min.pairMin(other.min); max.pairMax(other.max); } void merge(const Point& other) { min.pairMin(other); max.pairMax(other); } double diameter() const { return (max - min).minDim(); } double radius() const { return diameter() * 0.5; } Point center() const { return (min + max) * 0.5; } }; std::ostream& operator<<(std::ostream& os, const BoundingBox& b) { os << "(min:" << b.min << " max:" << b.max << ")"; return os; } struct Config { const double dtime; // length of one time step const double eps; // potential softening parameter const double tol; // tolerance for stopping recursion, <0.57 to bound error const double dthf, epssq, itolsq; Config(): dtime(0.5), eps(0.05), tol(0.05), //0.025), dthf(dtime * 0.5), epssq(eps * eps), itolsq(1.0 / (tol * tol)) { } }; std::ostream& operator<<(std::ostream& os, const Config& c) { os << "Barnes-Hut configuration:" << " dtime: " << c.dtime << " eps: " << c.eps << " tol: " << c.tol; return os; } Config config; inline int getIndex(const Point& a, const Point& b) { int index = 0; for (int i = 0; i < 3; ++i) if (a[i] < b[i]) index += (1 << i); return index; } inline Point updateCenter(Point v, int index, double radius) { for (int i = 0; i < 3; i++) v[i] += (index & (1 << i)) > 0 ? radius : -radius; return v; } typedef Galois::InsertBag<Body> Bodies; typedef Galois::InsertBag<Body*> BodyPtrs; //FIXME: reclaim memory for multiple steps typedef Galois::InsertBag<Octree> Tree; struct BuildOctree { Octree* root; Tree& T; double root_radius; BuildOctree(Octree* _root, Tree& _t, double radius) : root(_root), T(_t), root_radius(radius) { } void operator()(Body* b) { insert(b, root, root_radius); } void insert(Body* b, Octree* node, double radius) { int index = getIndex(node->pos, b->pos); Node* child = node->child[index].getValue(); //go through the tree lock-free while we can if (child && !child->Leaf) { insert(b, static_cast<Octree*>(child), radius); return; } node->child[index].lock(); child = node->child[index].getValue(); if (child == NULL) { node->child[index].unlock_and_set(b); return; } radius *= 0.5; if (child->Leaf) { // Expand leaf Octree* new_node = &T.emplace(updateCenter(node->pos, index, radius)); assert(node->pos != b->pos); //node->child[index].unlock_and_set(new_node); insert(b, new_node, radius); insert(static_cast<Body*>(child), new_node, radius); node->child[index].unlock_and_set(new_node); } else { node->child[index].unlock(); insert(b, static_cast<Octree*>(child), radius); } } }; unsigned computeCenterOfMass(Octree* node) { double mass = 0.0; Point accum; unsigned num = 1; //Reorganize leaves to be dense //remove copies values int index = 0; for (int i = 0; i < 8; ++i) if (node->child[i].getValue()) node->child[index++].setValue(node->child[i].getValue()); for (int i = index; i < 8; ++i) node->child[i].setValue(NULL); node->nChildren = index; for (int i = 0; i < index; i++) { Node* child = node->child[i].getValue(); if (!child->Leaf) { num += computeCenterOfMass(static_cast<Octree*>(child)); } else { node->cLeafs |= (1 << i); ++num; } mass += child->mass; accum += child->pos * child->mass; } node->mass = mass; if (mass > 0.0) node->pos = accum / mass; return num; } /* void printRec(std::ofstream& file, Node* node, unsigned level) { static const char* ct[] = { "blue", "cyan", "aquamarine", "chartreuse", "darkorchid", "darkorange", "deeppink", "gold", "chocolate" }; if (!node) return; file << "\"" << node << "\" [color=" << ct[node->owner / 4] << (node->owner % 4 + 1) << (level ? "" : " style=filled") << " label = \"" << (node->Leaf ? "L" : "N") << "\"];\n"; if (!node->Leaf) { Octree* node2 = static_cast<Octree*>(node); for (int i = 0; i < 8 && node2->child[i]; ++i) { if (level == 3 || level == 6) file << "subgraph cluster_" << level << "_" << i << " {\n"; file << "\"" << node << "\" -> \"" << node2->child[i] << "\" [weight=0.01]\n"; printRec(file, node2->child[i], level + 1); if (level == 3 || level == 6) file << "}\n"; } } } void printTree(Octree* node) { std::ofstream file("out.txt"); file << "digraph octree {\n"; file << "ranksep = 2\n"; file << "root = \"" << node << "\"\n"; // file << "overlap = scale\n"; printRec(file, node, 0); file << "}\n"; } */ Point updateForce(Point delta, double psq, double mass) { // Computing force += delta * mass * (|delta|^2 + eps^2)^{-3/2} double idr = 1 / sqrt((float) (psq + config.epssq)); double scale = mass * idr * idr * idr; return delta * scale; } struct ComputeForces { // Optimize runtime for no conflict case typedef int tt_does_not_need_aborts; typedef int tt_needs_per_iter_alloc; typedef int tt_does_not_need_push; Octree* top; double diameter; double root_dsq; ComputeForces(Octree* _top, double _diameter) : top(_top), diameter(_diameter) { root_dsq = diameter * diameter * config.itolsq; } template<typename Context> void operator()(Body* b, Context& cnx) { Point p = b->acc; b->acc = Point(0.0, 0.0, 0.0); iterate(*b, root_dsq, cnx); b->vel += (b->acc - p) * config.dthf; } struct Frame { double dsq; Octree* node; Frame(Octree* _node, double _dsq) : dsq(_dsq), node(_node) { } }; template<typename Context> void iterate(Body& b, double root_dsq, Context& cnx) { std::deque<Frame, Galois::PerIterAllocTy::rebind<Frame>::other> stack(cnx.getPerIterAlloc()); stack.push_back(Frame(top, root_dsq)); while (!stack.empty()) { const Frame f = stack.back(); stack.pop_back(); Point p = b.pos - f.node->pos; double psq = p.dist2(); // Node is far enough away, summarize contribution if (psq >= f.dsq) { b.acc += updateForce(p, psq, f.node->mass); continue; } double dsq = f.dsq * 0.25; for (int i = 0; i < f.node->nChildren; i++) { Node* n = f.node->child[i].getValue(); assert(n); if (f.node->cLeafs & (1 << i)) { assert(n->Leaf); if (static_cast<const Node*>(&b) != n) { Point p = b.pos - n->pos; b.acc += updateForce(p, p.dist2(), n->mass); } } else { #ifndef GALOIS_CXX11_DEQUE_HAS_NO_EMPLACE stack.emplace_back(static_cast<Octree*>(n), dsq); #else stack.push_back(Frame(static_cast<Octree*>(n), dsq)); #endif __builtin_prefetch(n); } } } } }; struct AdvanceBodies { // Optimize runtime for no conflict case typedef int tt_does_not_need_aborts; AdvanceBodies() { } template<typename Context> void operator()(Body* b, Context&) { operator()(b); } void operator()(Body* b) { Point dvel(b->acc); dvel *= config.dthf; Point velh(b->vel); velh += dvel; b->pos += velh * config.dtime; b->vel = velh + dvel; } }; struct ReduceBoxes { // NB: only correct when run sequentially or tree-like reduction typedef int tt_does_not_need_stats; BoundingBox initial; void operator()(const Body* b) { initial.merge(b->pos); } }; struct mergeBox { void operator()(ReduceBoxes& lhs, ReduceBoxes& rhs) { return lhs.initial.merge(rhs.initial); } }; double nextDouble() { return rand() / (double) RAND_MAX; } struct InsertBody { BodyPtrs& pBodies; Bodies& bodies; InsertBody(BodyPtrs& pb, Bodies& b): pBodies(pb), bodies(b) { } void operator()(const Body& b) { //Body b2 = b; //b2.owner = Galois::Runtime::LL::getTID(); pBodies.push_back(&(bodies.push_back(b))); } }; struct centerXCmp { template<typename T> bool operator()(const T& lhs, const T& rhs) const { return lhs.pos[0] < rhs.pos[0]; } }; struct centerYCmp { template<typename T> bool operator()(const T& lhs, const T& rhs) const { return lhs.pos[1] < rhs.pos[1]; } }; struct centerYCmpInv { template<typename T> bool operator()(const T& lhs, const T& rhs) const { return rhs.pos[1] < lhs.pos[1]; } }; template<typename Iter> void divide(const Iter& b, const Iter& e) { if (std::distance(b,e) > 32) { std::sort(b,e, centerXCmp()); Iter m = Galois::split_range(b,e); std::sort(b,m, centerYCmpInv()); std::sort(m,e, centerYCmp()); divide(b, Galois::split_range(b,m)); divide(Galois::split_range(b,m), m); divide(m,Galois::split_range(m,e)); divide(Galois::split_range(m,e), e); } else { std::random_shuffle(b,e); } } /** * Generates random input according to the Plummer model, which is more * realistic but perhaps not so much so according to astrophysicists */ void generateInput(Bodies& bodies, BodyPtrs& pBodies, int nbodies, int seed) { double v, sq, scale; Point p; double PI = boost::math::constants::pi<double>(); srand(seed); double rsc = (3 * PI) / 16; double vsc = sqrt(1.0 / rsc); std::vector<Body> tmp; for (int body = 0; body < nbodies; body++) { double r = 1.0 / sqrt(pow(nextDouble() * 0.999, -2.0 / 3.0) - 1); do { for (int i = 0; i < 3; i++) p[i] = nextDouble() * 2.0 - 1.0; sq = p.dist2(); } while (sq > 1.0); scale = rsc * r / sqrt(sq); Body b; b.mass = 1.0 / nbodies; b.pos = p * scale; do { p[0] = nextDouble(); p[1] = nextDouble() * 0.1; } while (p[1] > p[0] * p[0] * pow(1 - p[0] * p[0], 3.5)); v = p[0] * sqrt(2.0 / sqrt(1 + r * r)); do { for (int i = 0; i < 3; i++) p[i] = nextDouble() * 2.0 - 1.0; sq = p.dist2(); } while (sq > 1.0); scale = vsc * v / sqrt(sq); b.vel = p * scale; b.Leaf = true; tmp.push_back(b); //pBodies.push_back(&bodies.push_back(b)); } //sort and copy out divide(tmp.begin(), tmp.end()); Galois::do_all(tmp.begin(), tmp.end(), InsertBody(pBodies, bodies)); } struct CheckAllPairs { Bodies& bodies; CheckAllPairs(Bodies& b): bodies(b) { } double operator()(const Body& body) { const Body* me = &body; Point acc; for (Bodies::iterator ii = bodies.begin(), ei = bodies.end(); ii != ei; ++ii) { Body* b = &*ii; if (me == b) continue; Point delta = me->pos - b->pos; double psq = delta.dist2(); acc += updateForce(delta, psq, b->mass); } double dist2 = acc.dist2(); acc -= me->acc; double retval = acc.dist2() / dist2; return retval; } }; double checkAllPairs(Bodies& bodies, int N) { Bodies::iterator end(bodies.begin()); std::advance(end, N); return Galois::ParallelSTL::map_reduce(bodies.begin(), end, CheckAllPairs(bodies), 0.0, std::plus<double>()) / N; } void run(Bodies& bodies, BodyPtrs& pBodies) { typedef Galois::WorkList::dChunkedLIFO<256> WL_; typedef Galois::WorkList::AltChunkedLIFO<32> WL; typedef Galois::WorkList::StableIterator<decltype(pBodies.local_begin()), true> WLL; for (int step = 0; step < ntimesteps; step++) { // Do tree building sequentially BoundingBox box = Galois::Runtime::do_all_impl(Galois::Runtime::makeLocalRange(pBodies), ReduceBoxes(), mergeBox(), "reduceBoxes", true).initial; //std::for_each(bodies.begin(), bodies.end(), ReduceBoxes(box)); Tree t; Octree& top = t.emplace(box.center()); Galois::StatTimer T_build("BuildTime"); T_build.start(); Galois::do_all_local(pBodies, BuildOctree(&top, t, box.radius()), Galois::loopname("BuildTree")); T_build.stop(); //update centers of mass in tree unsigned size = computeCenterOfMass(&top); //printTree(&top); std::cout << "Tree Size: " << size << "\n"; Galois::StatTimer T_compute("ComputeTime"); T_compute.start(); Galois::for_each_local(pBodies, ComputeForces(&top, box.diameter()), Galois::loopname("compute"), Galois::wl<WLL>()); T_compute.stop(); if (!skipVerify) { std::cout << "MSE (sampled) " << checkAllPairs(bodies, std::min((int) nbodies, 100)) << "\n"; } //Done in compute forces Galois::do_all_local(pBodies, AdvanceBodies(), Galois::loopname("advance")); std::cout << "Timestep " << step << " Center of Mass = "; std::ios::fmtflags flags = std::cout.setf(std::ios::showpos|std::ios::right|std::ios::scientific|std::ios::showpoint); std::cout << top.pos; std::cout.flags(flags); std::cout << "\n"; } } int main(int argc, char** argv) { Galois::StatManager M; LonestarStart(argc, argv, name, desc, url); std::cout << config << "\n"; std::cout << nbodies << " bodies, " << ntimesteps << " time steps\n"; Bodies bodies; BodyPtrs pBodies; generateInput(bodies, pBodies, nbodies, seed); Galois::StatTimer T; T.start(); run(bodies, pBodies); T.stop(); }
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/pagerank/CMakeLists.txt
if(USE_EXP) include_directories(../../exp/apps/pagerank .) endif() app(pagerank PageRank.cpp)
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/pagerank/PageRank.h
#ifndef APPS_PAGERANK_PAGERANK_H #define APPS_PAGERANK_PAGERANK_H #include "llvm/Support/CommandLine.h" //! d is the damping factor. Alpha is the prob that user will do a random jump, i.e., 1 - d static const float alpha = 1.0 - 0.85; //! maximum relative change until we deem convergence static const float tolerance = 0.01; //ICC v13.1 doesn't yet support std::atomic<float> completely, emmulate its //behavor with std::atomic<int> struct atomic_float : public std::atomic<int> { static_assert(sizeof(int) == sizeof(float), "int and float must be the same size"); float atomicIncrement(float value) { while (true) { union { float as_float; int as_int; } oldValue = { read() }; union { float as_float; int as_int; } newValue = { oldValue.as_float + value }; if (this->compare_exchange_strong(oldValue.as_int, newValue.as_int)) return newValue.as_float; } } float read() { union { int as_int; float as_float; } caster = { this->load(std::memory_order_relaxed) }; return caster.as_float; } void write(float v) { union { float as_float; int as_int; } caster = { v }; this->store(caster.as_int, std::memory_order_relaxed); } }; struct PNode { float value; atomic_float accum; PNode() { } float getPageRank() { return value; } }; extern llvm::cl::opt<unsigned int> memoryLimit; extern llvm::cl::opt<std::string> filename; extern llvm::cl::opt<unsigned int> maxIterations; #endif
0
rapidsai_public_repos/code-share/maxflow/galois/apps
rapidsai_public_repos/code-share/maxflow/galois/apps/pagerank/PageRank.cpp
/** Page rank application -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2013, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @author Donald Nguyen <[email protected]> */ #include "Galois/config.h" #include "Galois/Galois.h" #include "Galois/Accumulator.h" #include "Galois/Bag.h" #include "Galois/Statistic.h" #include "Galois/Graph/LCGraph.h" #include "Galois/Graph/TypeTraits.h" #include "Lonestar/BoilerPlate.h" #include GALOIS_CXX11_STD_HEADER(atomic) #include <string> #include <sstream> #include <limits> #include <iostream> #include <fstream> #include "PageRank.h" #ifdef GALOIS_USE_EXP #include "GraphLabAlgo.h" #include "LigraAlgo.h" #endif namespace cll = llvm::cl; static const char* name = "Page Rank"; static const char* desc = "Computes page ranks a la Page and Brin"; static const char* url = 0; enum Algo { graphlab, graphlabAsync, ligra, ligraChi, pull, serial }; cll::opt<std::string> filename(cll::Positional, cll::desc("<input graph>"), cll::Required); static cll::opt<std::string> transposeGraphName("graphTranspose", cll::desc("Transpose of input graph")); static cll::opt<bool> symmetricGraph("symmetricGraph", cll::desc("Input graph is symmetric")); static cll::opt<std::string> outputPullFilename("outputPull", cll::desc("Precompute data for Pull algorithm to file")); cll::opt<unsigned int> maxIterations("maxIterations", cll::desc("Maximum iterations"), cll::init(100)); cll::opt<unsigned int> memoryLimit("memoryLimit", cll::desc("Memory limit for out-of-core algorithms (in MB)"), cll::init(~0U)); static cll::opt<Algo> algo("algo", cll::desc("Choose an algorithm:"), cll::values( clEnumValN(Algo::pull, "pull", "Use precomputed data perform pull-based algorithm"), clEnumValN(Algo::serial, "serial", "Compute PageRank in serial"), #ifdef GALOIS_USE_EXP clEnumValN(Algo::graphlab, "graphlab", "Use GraphLab programming model"), clEnumValN(Algo::graphlabAsync, "graphlabAsync", "Use GraphLab-Asynchronous programming model"), clEnumValN(Algo::ligra, "ligra", "Use Ligra programming model"), clEnumValN(Algo::ligraChi, "ligraChi", "Use Ligra and GraphChi programming model"), #endif clEnumValEnd), cll::init(Algo::pull)); struct SerialAlgo { typedef Galois::Graph::LC_CSR_Graph<PNode,void> ::with_no_lockable<true>::type Graph; typedef Graph::GraphNode GNode; std::string name() const { return "Serial"; } void readGraph(Graph& graph) { Galois::Graph::readGraph(graph, filename); } struct Initialize { Graph& g; Initialize(Graph& g): g(g) { } void operator()(Graph::GraphNode n) { g.getData(n).value = 1.0; g.getData(n).accum.write(0.0); } }; void operator()(Graph& graph) { unsigned int iteration = 0; unsigned int numNodes = graph.size(); while (true) { float max_delta = std::numeric_limits<float>::min(); unsigned int small_delta = 0; for (auto ii = graph.begin(), ei = graph.end(); ii != ei; ++ii) { GNode src = *ii; PNode& sdata = graph.getData(src); int neighbors = std::distance(graph.edge_begin(src), graph.edge_end(src)); for (auto jj = graph.edge_begin(src), ej = graph.edge_end(src); jj != ej; ++jj) { GNode dst = graph.getEdgeDst(jj); PNode& ddata = graph.getData(dst); float delta = sdata.value / neighbors; ddata.accum.write(ddata.accum.read() + delta); } } for (auto ii = graph.begin(), ei = graph.end(); ii != ei; ++ii) { GNode src = *ii; PNode& sdata = graph.getData(src, Galois::MethodFlag::NONE); float value = (1.0 - alpha) * sdata.accum.read() + alpha; float diff = std::fabs(value - sdata.value); if (diff <= tolerance) ++small_delta; if (diff > max_delta) max_delta = diff; sdata.value = value; sdata.accum.write(0); } iteration += 1; std::cout << "iteration: " << iteration << " max delta: " << max_delta << " small delta: " << small_delta << " (" << small_delta / (float) numNodes << ")" << "\n"; if (max_delta <= tolerance || iteration >= maxIterations) break; } if (iteration >= maxIterations) { std::cout << "Failed to converge\n"; } } }; struct PullAlgo { struct LNode { float value[2]; float getPageRank() { return value[1]; } float getPageRank(unsigned int it) { return value[it & 1]; } void setPageRank(unsigned it, float v) { value[(it+1) & 1] = v; } }; typedef Galois::Graph::LC_InlineEdge_Graph<LNode,float> ::with_compressed_node_ptr<true>::type ::with_no_lockable<true>::type ::with_numa_alloc<true>::type Graph; typedef Graph::GraphNode GNode; std::string name() const { return "Pull"; } Galois::GReduceMax<double> max_delta; Galois::GAccumulator<unsigned int> small_delta; void readGraph(Graph& graph) { if (transposeGraphName.size()) { Galois::Graph::readGraph(graph, transposeGraphName); } else { std::cerr << "Need to pass precomputed graph through -graphTranspose option\n"; abort(); } } struct Initialize { Graph& g; Initialize(Graph& g): g(g) { } void operator()(Graph::GraphNode n) { LNode& data = g.getData(n, Galois::MethodFlag::NONE); data.value[0] = 1.0; data.value[1] = 1.0; } }; struct Copy { Graph& g; Copy(Graph& g): g(g) { } void operator()(Graph::GraphNode n) { LNode& data = g.getData(n, Galois::MethodFlag::NONE); data.value[1] = data.value[0]; } }; struct Process { PullAlgo* self; Graph& graph; unsigned int iteration; Process(PullAlgo* s, Graph& g, unsigned int i): self(s), graph(g), iteration(i) { } void operator()(const GNode& src, Galois::UserContext<GNode>& ctx) { (*this)(src); } void operator()(const GNode& src) { LNode& sdata = graph.getData(src, Galois::MethodFlag::NONE); double sum = 0; for (auto jj = graph.edge_begin(src, Galois::MethodFlag::NONE), ej = graph.edge_end(src, Galois::MethodFlag::NONE); jj != ej; ++jj) { GNode dst = graph.getEdgeDst(jj); float w = graph.getEdgeData(jj); LNode& ddata = graph.getData(dst, Galois::MethodFlag::NONE); sum += ddata.getPageRank(iteration) * w; } float value = sum * (1.0 - alpha) + alpha; float diff = std::fabs(value - sdata.getPageRank(iteration)); if (diff <= tolerance) self->small_delta += 1; self->max_delta.update(diff); sdata.setPageRank(iteration, value); } }; void operator()(Graph& graph) { unsigned int iteration = 0; while (true) { Galois::for_each_local(graph, Process(this, graph, iteration)); iteration += 1; float delta = max_delta.reduce(); size_t sdelta = small_delta.reduce(); std::cout << "iteration: " << iteration << " max delta: " << delta << " small delta: " << sdelta << " (" << sdelta / (float) graph.size() << ")" << "\n"; if (delta <= tolerance || iteration >= maxIterations) break; max_delta.reset(); small_delta.reset(); } if (iteration >= maxIterations) { std::cout << "Failed to converge\n"; } if (iteration & 1) { // Result already in right place } else { Galois::do_all_local(graph, Copy(graph)); } } }; //! Transpose in-edges to out-edges static void precomputePullData() { typedef Galois::Graph::LC_CSR_Graph<size_t, void> ::with_no_lockable<true>::type InputGraph; typedef InputGraph::GraphNode InputNode; typedef Galois::Graph::FileGraphWriter OutputGraph; //typedef OutputGraph::GraphNode OutputNode; InputGraph input; OutputGraph output; Galois::Graph::readGraph(input, filename); size_t node_id = 0; for (auto ii = input.begin(), ei = input.end(); ii != ei; ++ii) { InputNode src = *ii; input.getData(src) = node_id++; } output.setNumNodes(input.size()); output.setNumEdges(input.sizeEdges()); output.setSizeofEdgeData(sizeof(float)); output.phase1(); for (auto ii = input.begin(), ei = input.end(); ii != ei; ++ii) { InputNode src = *ii; size_t sid = input.getData(src); assert(sid < input.size()); //size_t num_neighbors = std::distance(input.edge_begin(src), input.edge_end(src)); for (auto jj = input.edge_begin(src), ej = input.edge_end(src); jj != ej; ++jj) { InputNode dst = input.getEdgeDst(jj); size_t did = input.getData(dst); assert(did < input.size()); output.incrementDegree(did); } } output.phase2(); std::vector<float> edgeData; edgeData.resize(input.sizeEdges()); for (auto ii = input.begin(), ei = input.end(); ii != ei; ++ii) { InputNode src = *ii; size_t sid = input.getData(src); assert(sid < input.size()); size_t num_neighbors = std::distance(input.edge_begin(src), input.edge_end(src)); float w = 1.0/num_neighbors; for (auto jj = input.edge_begin(src), ej = input.edge_end(src); jj != ej; ++jj) { InputNode dst = input.getEdgeDst(jj); size_t did = input.getData(dst); assert(did < input.size()); size_t idx = output.addNeighbor(did, sid); edgeData[idx] = w; } } float* t = output.finish<float>(); memcpy(t, &edgeData[0], sizeof(edgeData[0]) * edgeData.size()); output.structureToFile(outputPullFilename); std::cout << "Wrote " << outputPullFilename << "\n"; } //! Make values unique template<typename GNode> struct TopPair { float value; GNode id; TopPair(float v, GNode i): value(v), id(i) { } bool operator<(const TopPair& b) const { if (value == b.value) return id > b.id; return value < b.value; } }; template<typename Graph> static void printTop(Graph& graph, int topn) { typedef typename Graph::GraphNode GNode; typedef typename Graph::node_data_reference node_data_reference; typedef TopPair<GNode> Pair; typedef std::map<Pair,GNode> Top; Top top; for (auto ii = graph.begin(), ei = graph.end(); ii != ei; ++ii) { GNode src = *ii; node_data_reference n = graph.getData(src); float value = n.getPageRank(); Pair key(value, src); if ((int) top.size() < topn) { top.insert(std::make_pair(key, src)); continue; } if (top.begin()->first < key) { top.erase(top.begin()); top.insert(std::make_pair(key, src)); } } int rank = 1; std::cout << "Rank PageRank Id\n"; for (typename Top::reverse_iterator ii = top.rbegin(), ei = top.rend(); ii != ei; ++ii, ++rank) { std::cout << rank << ": " << ii->first.value << " " << ii->first.id << "\n"; } } template<typename Algo> void run() { typedef typename Algo::Graph Graph; Algo algo; Graph graph; algo.readGraph(graph); Galois::preAlloc(numThreads + (graph.size() * sizeof(typename Graph::node_data_type)) / Galois::Runtime::MM::pageSize); Galois::reportPageAlloc("MeminfoPre"); Galois::StatTimer T; std::cout << "Running " << algo.name() << " version\n"; std::cout << "Target max delta: " << tolerance << "\n"; T.start(); Galois::do_all_local(graph, typename Algo::Initialize(graph)); algo(graph); T.stop(); Galois::reportPageAlloc("MeminfoPost"); if (!skipVerify) printTop(graph, 10); } int main(int argc, char **argv) { LonestarStart(argc, argv, name, desc, url); Galois::StatManager statManager; if (outputPullFilename.size()) { precomputePullData(); return 0; } Galois::StatTimer T("TotalTime"); T.start(); switch (algo) { case Algo::pull: run<PullAlgo>(); break; #ifdef GALOIS_USE_EXP case Algo::ligra: run<LigraAlgo<false> >(); break; case Algo::ligraChi: run<LigraAlgo<true> >(); break; case Algo::graphlab: run<GraphLabAlgo<false,false> >(); break; case Algo::graphlabAsync: run<GraphLabAlgo<true,true> >(); break; #endif case Algo::serial: run<SerialAlgo>(); break; default: std::cerr << "Unknown algorithm\n"; abort(); } T.stop(); return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/sched.cpp
/** Scheduler Microbenchmark -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @section Description * * Test scalability of schedulers * * @author Andrew Lenharth <[email protected]> */ #include "Galois/Statistic.h" #include "Galois/Galois.h" #include "Lonestar/BoilerPlate.h" #ifdef GALOIS_USE_EXP #include "Galois/WorkList/WorkListExperimental.h" #endif static const char* name = "Scheduler Micro Benchmark"; static const char* desc = "Measures stuff"; static const char* url = 0; static llvm::cl::opt<int> sval(llvm::cl::Positional, llvm::cl::desc("<start value>"), llvm::cl::init(-1)); static llvm::cl::opt<int> ival(llvm::cl::Positional, llvm::cl::desc("<init num>"), llvm::cl::init(100)); struct process { void operator()(int item, Galois::UserContext<int>& lwl) { for (int i = 0; i < item; ++i) lwl.push(item - 1); } }; int main(int argc, char** argv) { LonestarStart(argc, argv, name, desc, url); std::vector<int> v((int)ival, (int)sval); std::cout << "Initial: " << (int)ival << " using " << (int)sval << "\n"; // Galois::StatTimer T0("T0"); // T0.start(); // using namespace Galois::Runtime::WorkList; // Galois::for_each<ChunkedLIFO<64> >(v.begin(), v.end(), process()); // T0.stop(); // Galois::StatTimer T1("T1"); // T1.start(); // using namespace Galois::Runtime::WorkList; // Galois::for_each<Alt::ChunkedAdaptor<LIFO<>, 64, true > >(v.begin(), v.end(), process()); // T1.stop(); Galois::StatTimer T2("T2"); T2.start(); using namespace Galois::WorkList; Galois::for_each(v.begin(), v.end(), process(), Galois::wl<dChunkedLIFO<64>>()); T2.stop(); }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/empty-member-lcgraph.cpp
#include "Galois/Graph/LCGraph.h" int main() { constexpr size_t intvoid = sizeof(Galois::Graph::detail::EdgeInfoBase<int,void>); constexpr size_t intint = sizeof(Galois::Graph::detail::EdgeInfoBase<int,int>); static_assert(intvoid < intint, "Failed to do empty member optimization"); return intvoid < intint ? 0 : 1; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/loopoverhead.cpp
#include "Galois/Timer.h" #include "Galois/Galois.h" #include <iostream> #include <cstdlib> int RandomNumber () { return (rand()%1000000); } const unsigned iter = 16*1024; struct emp { template<typename T> void operator()(const T& t) { Galois::Runtime::LL::compilerBarrier(); } template<typename T, typename C> void operator()(const T& t, const C& c) { Galois::Runtime::LL::compilerBarrier(); } }; void t_stl() { std::vector<unsigned> V(1024); //unsigned M = Galois::Runtime::LL::getMaxThreads(); std::cout << "stl:\nIterxSize\n"; std::cout << "Using " << 1 << " threads\n"; Galois::Timer t; t.start(); for (unsigned x = 0; x < iter; ++x) std::for_each(V.begin(), V.end(), emp()); t.stop(); std::cout << "STL(" << iter << "x" << V.size() << "): " << t.get() << "\n"; } void t_doall() { std::vector<unsigned> V(1024); unsigned M = Galois::Runtime::LL::getMaxThreads(); std::cout << "doall:\nIterxSize\n"; while (M) { Galois::setActiveThreads(M); //Galois::Runtime::LL::getMaxThreads()); std::cout << "Using " << M << " threads\n"; Galois::Timer t; t.start(); for (unsigned x = 0; x < iter; ++x) Galois::do_all(V.begin(), V.end(), emp()); t.stop(); std::cout << "Galois(" << iter << "x" << V.size() << "): " << t.get() << "\n"; M >>= 1; } } void t_foreach() { std::vector<unsigned> V(1024); unsigned M = Galois::Runtime::LL::getMaxThreads(); std::cout << "foreach:\nIterxSize\n"; while (M) { Galois::setActiveThreads(M); //Galois::Runtime::LL::getMaxThreads()); std::cout << "Using " << M << " threads\n"; Galois::Timer t; t.start(); for (unsigned x = 0; x < iter; ++x) Galois::for_each(V.begin(), V.end(), emp(), Galois::wl<Galois::WorkList::StableIterator<std::vector<unsigned>::iterator>>()); t.stop(); std::cout << "Galois(" << iter << "x" << V.size() << "): " << t.get() << "\n"; M >>= 1; } } int main() { t_stl(); t_doall(); t_foreach(); return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/forward-declare-graph.cpp
#include "Galois/Graph/Graph.h" #include "Galois/Graph/LCGraph.h" struct Node1; typedef Galois::Graph::FirstGraph<Node1, void, true> Graph1; struct Node1 { Graph1::edge_iterator edge; Graph1::GraphNode gnode; }; struct Node2; typedef Galois::Graph::LC_CSR_Graph<Node2, void> Graph2; struct Node2 { Graph2::edge_iterator edge; Graph2::GraphNode gnode; }; struct Node3; typedef Galois::Graph::LC_InlineEdge_Graph<Node3, void> Graph3; struct Node3 { Graph3::edge_iterator edge; Graph3::GraphNode gnode; }; struct Node4; typedef Galois::Graph::LC_Linear_Graph<Node4, void> Graph4; struct Node4 { Graph4::edge_iterator edge; Graph4::GraphNode gnode; }; struct Node5; typedef Galois::Graph::LC_Morph_Graph<Node5, void> Graph5; struct Node5 { Graph5::edge_iterator edge; Graph5::GraphNode gnode; }; int main() { Graph1 g1; Graph2 g2; Graph3 g3; Graph4 g4; Graph5 g5; return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/twoleveliteratora.cpp
#include "Galois/config.h" #include "Galois/TwoLevelIteratorA.h" #include "Galois/Runtime/ll/gio.h" #include <algorithm> #include <boost/iterator/counting_iterator.hpp> #include GALOIS_CXX11_STD_HEADER(vector) #include <list> #include <iostream> const int N = 1024 * 4; template<class D, class I> struct GetBegin { typename I::iterator operator()(typename D::reference x) const { return x.begin(); } typename I::const_iterator operator()(typename D::const_reference x) const { return x.begin(); } }; template<class D, class I> struct GetEnd { typename I::iterator operator()(typename D::reference x) const { return x.end(); } typename I::const_iterator operator()(typename D::const_reference x) const { return x.end(); } }; template<bool NonEmpty, class Tag, class D, class I> void check_forward() { D data; for (int i = 0; i < N; ++i) { #ifdef GALOIS_CXX11_VECTOR_HAS_NO_EMPLACE if (NonEmpty) { data.push_back(typename D::value_type()); data.back().push_back(i); } else { data.push_back(typename D::value_type()); data.push_back(typename D::value_type()); data.back().push_back(i); data.push_back(typename D::value_type()); } #else if (NonEmpty) { data.emplace_back(); data.back().push_back(i); } else { data.emplace_back(); data.emplace_back(); data.back().push_back(i); data.emplace_back(); } #endif } #if __cplusplus >= 201103L auto r = Galois::make_two_level_iterator<Tag>(data.begin(), data.end()); #else auto r = Galois::make_two_level_iterator< Tag, typename D::iterator, typename I::iterator, GetBegin<D, I>, GetEnd<D, I> >(data.begin(), data.end()); #endif if (!std::equal(r.first, r.second, boost::make_counting_iterator<int>(0))) { GALOIS_DIE("failed case: forward ", (NonEmpty ? "non-empty" : "empty"), " inner range"); } else if (std::distance(r.first, r.second) != N) { GALOIS_DIE("failed case: forward ", (NonEmpty ? "non-empty" : "empty"), " inner range: ", std::distance(r.first, r.second), " != ", N); } } template<bool NonEmpty, class Tag, class D, class I> void check_backward() { D data; for (int i = N-1; i >= 0; --i) { #ifdef GALOIS_CXX11_VECTOR_HAS_NO_EMPLACE if (NonEmpty) { data.push_back(typename D::value_type()); data.back().push_back(i); } else { data.push_back(typename D::value_type()); data.push_back(typename D::value_type()); data.back().push_back(i); data.push_back(typename D::value_type()); } #else if (NonEmpty) { data.emplace_back(); data.back().push_back(i); } else { data.emplace_back(); data.emplace_back(); data.back().push_back(i); data.emplace_back(); } #endif } #if __cplusplus >= 201103L auto r = Galois::make_two_level_iterator<Tag>(data.begin(), data.end()); #else auto r = Galois::make_two_level_iterator< Tag, typename D::iterator, typename I::iterator, GetBegin<D, I>, GetEnd<D, I> >(data.begin(), data.end()); #endif auto c = boost::make_counting_iterator<int>(0); if (std::distance(r.first, r.second) != N) { GALOIS_DIE("failed case: backward ", (NonEmpty ? "non-empty" : "empty"), " inner range: ", std::distance(r.first, r.second), " != ", N); } else if (r.first == r.second) { return; } --r.second; while (true) { if (*r.second != *c) { GALOIS_DIE("failed case: backward ", (NonEmpty ? "non-empty" : "empty"), " inner range: ", *r.second, " != ", *c); } if (r.first == r.second) break; --r.second; ++c; } } template<bool NonEmpty, class Tag, class D, class I> void check_strided() { D data; for (int i = 0; i < N; ++i) { #ifdef GALOIS_CXX11_VECTOR_HAS_NO_EMPLACE if (NonEmpty) { data.push_back(typename D::value_type()); data.back().push_back(i); } else { data.push_back(typename D::value_type()); data.push_back(typename D::value_type()); data.back().push_back(i); data.push_back(typename D::value_type()); } #else if (NonEmpty) { data.emplace_back(); data.back().push_back(i); } else { data.emplace_back(); data.emplace_back(); data.back().push_back(i); data.emplace_back(); } #endif } #if __cplusplus >= 201103L auto r = Galois::make_two_level_iterator<Tag>(data.begin(), data.end()); #else auto r = Galois::make_two_level_iterator< Tag, typename D::iterator, typename I::iterator, GetBegin<D, I>, GetEnd<D, I> >(data.begin(), data.end()); #endif auto c = boost::make_counting_iterator<int>(0); if (std::distance(r.first, r.second) != N) { GALOIS_DIE("failed case: strided ", (NonEmpty ? "non-empty" : "empty"), " inner range: ", std::distance(r.first, r.second), " != ", N); } else if (r.first == r.second) { return; } while (r.first != r.second) { if (*r.first != *c) { GALOIS_DIE("failed case: strided ", (NonEmpty ? "non-empty" : "empty"), " inner range: ", *r.first, " != ", *c); } auto orig = r.first; int k = std::max((N - *c) / 2, 1); std::advance(r.first, k); if (std::distance(orig, r.first) != k) { GALOIS_DIE("failed case: strided ", (NonEmpty ? "non-empty" : "empty"), " inner range: ", std::distance(orig, r.first), " != ", k); } for (int i = 0; i < k - 1; ++i) std::advance(r.first, -1); if (std::distance(orig, r.first) != 1) { GALOIS_DIE("failed case: strided ", (NonEmpty ? "non-empty" : "empty"), " inner range: ", std::distance(orig, r.first), " != 1"); } ++c; } } void check_forward_iteration() { check_forward<true, std::forward_iterator_tag, std::vector<std::vector<int>>, std::vector<int>>(); check_forward<true, std::forward_iterator_tag, std::vector<std::list<int>>, std::list<int>>(); check_forward<true, std::forward_iterator_tag, std::list<std::vector<int>>, std::vector<int>>(); check_forward<true, std::forward_iterator_tag, std::list<std::list<int>>, std::list<int>>(); check_forward<true, std::bidirectional_iterator_tag, std::vector<std::vector<int>>, std::vector<int>>(); check_forward<true, std::bidirectional_iterator_tag, std::vector<std::list<int>>, std::list<int>>(); check_forward<true, std::bidirectional_iterator_tag, std::list<std::vector<int>>, std::vector<int>>(); check_forward<true, std::bidirectional_iterator_tag, std::list<std::list<int>>, std::list<int>>(); check_forward<true, std::random_access_iterator_tag, std::vector<std::vector<int>>, std::vector<int>>(); check_forward<true, std::random_access_iterator_tag, std::vector<std::list<int>>, std::list<int>>(); check_forward<true, std::random_access_iterator_tag, std::list<std::vector<int>>, std::vector<int>>(); check_forward<true, std::random_access_iterator_tag, std::list<std::list<int>>, std::list<int>>(); check_forward<false, std::forward_iterator_tag, std::vector<std::vector<int>>, std::vector<int>>(); check_forward<false, std::forward_iterator_tag, std::vector<std::list<int>>, std::list<int>>(); check_forward<false, std::forward_iterator_tag, std::list<std::vector<int>>, std::vector<int>>(); check_forward<false, std::forward_iterator_tag, std::list<std::list<int>>, std::list<int>>(); check_forward<false, std::bidirectional_iterator_tag, std::vector<std::vector<int>>, std::vector<int>>(); check_forward<false, std::bidirectional_iterator_tag, std::vector<std::list<int>>, std::list<int>>(); check_forward<false, std::bidirectional_iterator_tag, std::list<std::vector<int>>, std::vector<int>>(); check_forward<false, std::bidirectional_iterator_tag, std::list<std::list<int>>, std::list<int>>(); check_forward<false, std::random_access_iterator_tag, std::vector<std::vector<int>>, std::vector<int>>(); check_forward<false, std::random_access_iterator_tag, std::vector<std::list<int>>, std::list<int>>(); check_forward<false, std::random_access_iterator_tag, std::list<std::vector<int>>, std::vector<int>>(); check_forward<false, std::random_access_iterator_tag, std::list<std::list<int>>, std::list<int>>(); } void check_backward_iteration() { check_backward<true, std::bidirectional_iterator_tag, std::vector<std::vector<int>>,std::vector<int>>(); check_backward<true, std::bidirectional_iterator_tag, std::vector<std::list<int>>,std::list<int>>(); check_backward<true, std::bidirectional_iterator_tag, std::list<std::vector<int>>,std::vector<int>>(); check_backward<true, std::bidirectional_iterator_tag, std::list<std::list<int>>,std::list<int>>(); check_backward<true, std::random_access_iterator_tag, std::vector<std::vector<int>>,std::vector<int>>(); check_backward<true, std::random_access_iterator_tag, std::vector<std::list<int>>,std::list<int>>(); check_backward<true, std::random_access_iterator_tag, std::list<std::vector<int>>,std::vector<int>>(); check_backward<true, std::random_access_iterator_tag, std::list<std::list<int>>,std::list<int>>(); check_backward<false, std::bidirectional_iterator_tag, std::vector<std::vector<int>>,std::vector<int>>(); check_backward<false, std::bidirectional_iterator_tag, std::vector<std::list<int>>,std::list<int>>(); check_backward<false, std::bidirectional_iterator_tag, std::list<std::vector<int>>,std::vector<int>>(); check_backward<false, std::bidirectional_iterator_tag, std::list<std::list<int>>,std::list<int>>(); check_backward<false, std::random_access_iterator_tag, std::vector<std::vector<int>>,std::vector<int>>(); check_backward<false, std::random_access_iterator_tag, std::vector<std::list<int>>,std::list<int>>(); check_backward<false, std::random_access_iterator_tag, std::list<std::vector<int>>,std::vector<int>>(); check_backward<false, std::random_access_iterator_tag, std::list<std::list<int>>,std::list<int>>(); } void check_strided_iteration() { check_strided<true, std::bidirectional_iterator_tag, std::vector<std::vector<int>>,std::vector<int>>(); check_strided<true, std::bidirectional_iterator_tag, std::vector<std::list<int>>,std::list<int>>(); check_strided<true, std::bidirectional_iterator_tag, std::list<std::vector<int>>,std::vector<int>>(); check_strided<true, std::bidirectional_iterator_tag, std::list<std::list<int>>,std::list<int>>(); check_strided<true, std::random_access_iterator_tag, std::vector<std::vector<int>>,std::vector<int>>(); check_strided<true, std::random_access_iterator_tag, std::vector<std::list<int>>,std::list<int>>(); check_strided<true, std::random_access_iterator_tag, std::list<std::vector<int>>,std::vector<int>>(); check_strided<true, std::random_access_iterator_tag, std::list<std::list<int>>,std::list<int>>(); check_strided<false, std::bidirectional_iterator_tag, std::vector<std::vector<int>>,std::vector<int>>(); check_strided<false, std::bidirectional_iterator_tag, std::vector<std::list<int>>,std::list<int>>(); check_strided<false, std::bidirectional_iterator_tag, std::list<std::vector<int>>,std::vector<int>>(); check_strided<false, std::bidirectional_iterator_tag, std::list<std::list<int>>,std::list<int>>(); check_strided<false, std::random_access_iterator_tag, std::vector<std::vector<int>>,std::vector<int>>(); check_strided<false, std::random_access_iterator_tag, std::vector<std::list<int>>,std::list<int>>(); check_strided<false, std::random_access_iterator_tag, std::list<std::vector<int>>,std::vector<int>>(); check_strided<false, std::random_access_iterator_tag, std::list<std::list<int>>,std::list<int>>(); } int main() { typedef std::vector<std::vector<int>> NestedVector; // Static checks NestedVector data; const NestedVector& d(data); #if __cplusplus >= 201103L auto r = Galois::make_two_level_iterator(d.begin(), d.end()); #else auto r = Galois::make_two_level_iterator< std::forward_iterator_tag, NestedVector::const_iterator, std::vector<int>::const_iterator, GetBegin<NestedVector, std::vector<int> >, GetEnd<NestedVector, std::vector<int> > >(d.begin(), d.end()); #endif static_assert(std::is_same<decltype(*r.first), const int&>::value, "failed case: preserve constness"); // Runtime checks check_forward_iteration(); check_backward_iteration(); check_strided_iteration(); return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/CMakeLists.txt
function(makeTest name) add_executable(test-${name} ${name}.cpp) target_link_libraries(test-${name} galois) add_test(${name} test-${name}) endfunction() makeTest(acquire) makeTest(bandwidth) makeTest(empty-member-lcgraph) makeTest(flatmap) makeTest(gdeque) if(NOT CMAKE_CXX_COMPILER_ID MATCHES "XL") makeTest(graph-compile) makeTest(worklists-compile) endif() makeTest(loopoverhead) makeTest(pc) makeTest(sched) makeTest(sort) makeTest(static) makeTest(lock) makeTest(twoleveliteratora) makeTest(forward-declare-graph)
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/graph-compile.cpp
#include "Galois/Graph/Graph.h" struct NoDefault { int x; explicit NoDefault(int x): x(x) { } private: NoDefault(); }; template<typename GraphTy> void check() { typedef typename GraphTy::GraphNode GNode; int v; GraphTy g; GNode n1 = g.createNode(v); GNode n2 = g.createNode(v); g.addNode(n1); g.addNode(n2); g.addMultiEdge(n1, n2, Galois::MethodFlag::ALL, v); } int main() { check<Galois::Graph::FirstGraph<NoDefault,NoDefault,true> >(); check<Galois::Graph::FirstGraph<NoDefault,NoDefault,false> >(); return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/bandwidth.cpp
#include "Galois/config.h" #include "Galois/Galois.h" #include "Galois/Timer.h" #include GALOIS_CXX11_STD_HEADER(random) #include <cstdio> #include <time.h> template<typename Gen> void random_access(Gen& gen, int* buf, size_t size, size_t accesses) { #if __cplusplus >= 201103L || defined(HAVE_CXX11_UNIFORM_INT_DISTRIBUTION) std::uniform_int_distribution<size_t> randIndex(0, size - 1); #else std::uniform_int<size_t> randIndex(0, size - 1); #endif for (unsigned i = 0; i < accesses; ++i) { size_t idx = randIndex(gen); buf[idx] += 1; } } struct run_local_helper { int* block; size_t seed; size_t size; run_local_helper(int* b, size_t s, size_t ss): block(b), seed(s), size(ss) { } void operator()(unsigned int tid, unsigned int num) { std::mt19937 gen(seed + tid); #if __cplusplus >= 201103L || defined(HAVE_CXX11_UNIFORM_INT_DISTRIBUTION) std::uniform_int_distribution<int> randSeed; #else std::uniform_int<int> randSeed; #endif auto r = Galois::block_range(block, block + size, tid, num); size_t d = std::distance(r.first, r.second); random_access(gen, r.first, d, d); } }; void run_local(size_t seed, size_t mega) { size_t size = mega*1024*1024; int *block = (int*) malloc(size*sizeof(*block)); // Assuming first touch policy Galois::on_each(run_local_helper(block, seed, size)); free(block); } struct run_interleaved_helper { int* block; size_t seed; size_t size; run_interleaved_helper(int* b, size_t s, size_t ss): block(b), seed(s), size(ss) { } void operator()(unsigned int tid, unsigned int num) { std::mt19937 gen(seed + tid); #if __cplusplus >= 201103L || defined(HAVE_CXX11_UNIFORM_INT_DISTRIBUTION) std::uniform_int_distribution<int> randSeed; #else std::uniform_int<int> randSeed; #endif auto r = Galois::block_range(block, block + size, tid, num); size_t d = std::distance(r.first, r.second); random_access(gen, block, size, d); } }; void run_interleaved(size_t seed, size_t mega, bool full) { size_t size = mega*1024*1024; int *block = (int*) Galois::Runtime::MM::largeInterleavedAlloc(size*sizeof(*block), full); Galois::on_each(run_interleaved_helper(block, seed, size)); Galois::Runtime::MM::largeInterleavedFree(block, size*sizeof(*block)); } template<typename Fn> long time_run(Fn fn) { Galois::Timer t1; t1.start(); fn(); t1.stop(); return t1.get(); } struct F1 { size_t seed; size_t mega; F1(size_t s, size_t m): seed(s), mega(m) { } void operator()() { run_local(seed, mega); } }; struct F2 { size_t seed; size_t mega; bool full; F2(size_t s, size_t m, bool f): seed(s), mega(m), full(f) { } void operator()() { run_interleaved(seed, mega, full); } }; int main(int argc, char** argv) { unsigned M = Galois::Runtime::LL::getMaxThreads() / 2; size_t mega = 200; if (argc > 1) { mega = atoi(argv[1]); } size_t seed = time(NULL); printf("Working set: %zu MB\n\n", mega); printf("Effective random-access bandwidth (MB/s)\n"); printf("T LOCAL INTERLEAVE FULL-INTERLEAVE\n"); for (unsigned threads = 1; threads <= M; ++threads) { Galois::setActiveThreads(threads); long local_millis = time_run(F1(seed, mega)); long interleave_millis = time_run(F2(seed, mega, false)); long full_interleave_millis = time_run(F2(seed, mega, true)); double mb = mega / (double) sizeof(int); // 4 + length of column header printf("%4d %8.2f %13.2f %18.2f\n", threads, mb / local_millis * 1000.0, mb / interleave_millis * 1000.0, mb / full_interleave_millis * 1000.0); } }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/lock.cpp
#include "Galois/Runtime/ll/SimpleLock.h" volatile int V; int main(int argc, char** argv) { Galois::Runtime::LL::SimpleLock<true> L; for (unsigned x = 0; x < 1000000000; ++x) { V = 0; L.lock(); V = 1; L.unlock(); V = 2; } return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/acquire.cpp
#include "Galois/Timer.h" #include "Galois/Runtime/Context.h" #include <iostream> int main(int argc, char** argv) { Galois::Runtime::SimpleRuntimeContext S; Galois::Runtime::Lockable L; Galois::Timer t; t.start(); for (int x = 0; x < 1024*1024*1024; ++x) Galois::Runtime::doAcquire(&L); t.stop(); std::cout << "Locking: " << t.get() << '\n'; return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/pc.cpp
#include "Galois/Runtime/PerThreadStorage.h" #include "Galois/Timer.h" #include "Galois/Galois.h" #include <iostream> using namespace Galois::Runtime; const int num = 1024 * 1024 * 1024; template<typename T> struct testL { PerThreadStorage<T>& b; testL(PerThreadStorage<T>& B) :b(B) {} void operator()(unsigned t, unsigned n) { for (int x = 0; x < num; ++x) { *b.getLocal() += x; } } }; template<typename T> struct testR { PerThreadStorage<T>& b; testR(PerThreadStorage<T>& B) :b(B) {} void operator()(unsigned t, unsigned n) { for (int x = 0; x < num; ++x) { *b.getRemote((t + 1) % n) += x; } } }; template<typename T> void testf(const char* str) { PerThreadStorage<T> b; std::cout << "\nRunning: " << str << " sizeof " << sizeof(PerThreadStorage<T>) << "\n"; Galois::Timer tL; tL.start(); Galois::on_each(testL<T>(b)); tL.stop(); Galois::Timer tR; tR.start(); Galois::on_each(testR<T>(b)); tR.stop(); std::cout << str << " L: " << tL.get() << " R: " << tR.get() << '\n'; } int main() { unsigned M = Galois::Runtime::LL::getMaxThreads(); while (M) { Galois::setActiveThreads(M); //Galois::Runtime::LL::getMaxThreads()); std::cout << "Using " << M << " threads\n"; testf<int>("int"); testf<double>("double"); M /= 2; } return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/gdeque.cpp
#include <iostream> #include "Galois/gdeque.h" using namespace std; using namespace Galois; int main() { gdeque<int> mydeque; for (int i = 0; i < 10; ++i) mydeque.push_back (i); cout << "Start size of mydeque is " << int(mydeque.size()); cout << "\nBy Iter:"; for (gdeque<int>::iterator it=mydeque.begin(); it!=mydeque.end(); ++it) cout << " " << *it; cout << "\nMind size of mydeque is " << int(mydeque.size()); cout << "\nPopping front out the elements in mydeque:"; while (!mydeque.empty()) { cout << " " << mydeque.front(); mydeque.pop_front(); } cout << "\nMind size of mydeque is " << int(mydeque.size()); for (int i = 0; i < 10; ++i) mydeque.push_back (i); cout << "\nMind size of mydeque is " << int(mydeque.size()); cout << "\nPopping back out the elements in mydeque:"; while (!mydeque.empty()) { cout << " " << mydeque.back(); mydeque.pop_back(); } cout << "\nMind size of mydeque is " << int(mydeque.size()); cout << "\nFinal size of mydeque is " << int(mydeque.size()) << endl; return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/sort.cpp
#include "Galois/Galois.h" #include "Galois/ParallelSTL/ParallelSTL.h" #include "Galois/Timer.h" #include <iostream> #include <cstdlib> #include <numeric> int RandomNumber () { return (rand()%1000000); } bool IsOdd (int i) { return ((i%2)==1); } struct IsOddS { bool operator() (int i) { return ((i%2)==1); } }; int do_sort() { unsigned M = Galois::Runtime::LL::getMaxThreads(); std::cout << "sort:\n"; while (M) { Galois::setActiveThreads(M); //Galois::Runtime::LL::getMaxThreads()); std::cout << "Using " << M << " threads\n"; std::vector<unsigned> V(1024*1024*16); std::generate (V.begin(), V.end(), RandomNumber); std::vector<unsigned> C = V; Galois::Timer t; t.start(); Galois::ParallelSTL::sort(V.begin(), V.end()); t.stop(); Galois::Timer t2; t2.start(); std::sort(C.begin(), C.end()); t2.stop(); bool eq = std::equal(C.begin(), C.end(), V.begin()); std::cout << "Galois: " << t.get() << " STL: " << t2.get() << " Equal: " << eq << "\n"; if (!eq) { std::vector<unsigned> R = V; std::sort(R.begin(), R.end()); if (!std::equal(C.begin(), C.end(), R.begin())) std::cout << "Cannot be made equal, sort mutated array\n"; for (size_t x = 0; x < V.size() ; ++x) { std::cout << x << "\t" << V[x] << "\t" << C[x]; if (V[x] != C[x]) std::cout << "\tDiff"; if (V[x] < C[x]) std::cout << "\tLT"; if (V[x] > C[x]) std::cout << "\tGT"; std::cout << "\n"; } return 1; } M >>= 1; } return 0; } int do_count_if() { unsigned M = Galois::Runtime::LL::getMaxThreads(); std::cout << "count_if:\n"; while (M) { Galois::setActiveThreads(M); //Galois::Runtime::LL::getMaxThreads()); std::cout << "Using " << M << " threads\n"; std::vector<unsigned> V(1024*1024*16); std::generate (V.begin(), V.end(), RandomNumber); unsigned x1,x2; Galois::Timer t; t.start(); x1 = Galois::ParallelSTL::count_if(V.begin(), V.end(), IsOddS()); t.stop(); Galois::Timer t2; t2.start(); x2 = std::count_if(V.begin(), V.end(), IsOddS()); t2.stop(); std::cout << "Galois: " << t.get() << " STL: " << t2.get() << " Equal: " << (x1 == x2) << "\n"; M >>= 1; } return 0; } template<typename T> struct mymax : std:: binary_function<T,T,T> { T operator()(const T& x, const T& y) const { return std::max(x,y); } }; int do_accumulate() { unsigned M = Galois::Runtime::LL::getMaxThreads(); std::cout << "accumulate:\n"; while (M) { Galois::setActiveThreads(M); //Galois::Runtime::LL::getMaxThreads()); std::cout << "Using " << M << " threads\n"; std::vector<unsigned> V(1024*1024*16); std::generate (V.begin(), V.end(), RandomNumber); unsigned x1,x2; Galois::Timer t; t.start(); x1 = Galois::ParallelSTL::accumulate(V.begin(), V.end(), 0U, mymax<unsigned>()); t.stop(); Galois::Timer t2; t2.start(); x2 = std::accumulate(V.begin(), V.end(), 0U, mymax<unsigned>()); t2.stop(); std::cout << "Galois: " << t.get() << " STL: " << t2.get() << " Equal: " << (x1 == x2) << "\n"; if (x1 != x2) std::cout << x1 << " " << x2 << "\n"; M >>= 1; } return 0; } int main() { int ret = 0; // ret |= do_sort(); // ret |= do_count_if(); ret |= do_accumulate(); return ret; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/flatmap.cpp
#include "Galois/FlatMap.h" #include "Galois/Timer.h" #include <iostream> #include <map> template<typename T, int X> void maptime(const char* c) { T m; Galois::Timer t1, t2; t1.start(); for (int x = 0; x < X; ++x) { m[x] = (double)x; } t1.stop(); t2.start(); for (int x = 0; x < X; ++x) { m[x]; } t2.stop(); std::cout << c << " " << t1.get() << " " << t2.get() << "\n"; } int main() { Galois::flat_map<int, double> m; Galois::flat_map<int, double> m2(m); //Galois::flat_map<int, double> m3 {{10,0},{20,0}}; Galois::flat_map<int, double> m3; m3.insert(std::make_pair(10, 0.0)); m3.insert(std::make_pair(20, 0.0)); Galois::flat_map<int, double> m4(m3.begin(), m3.end()); m2 = m3; m3 = std::move(m2); m[0] = 0.1; m[1] = 1.2; m[4] = 2.3; m[3] = 3.4; m[3] += 10.0; m.insert(std::make_pair(5, 4.5)); m.insert(m4.begin(), m4.end()); std::cout << "10 == " << m.find(10)->first << "\n"; m.erase(m.find(10)); m.erase(1); std::cout << m.size() << " " << m.empty() << " " << m.max_size() << "\n"; m.swap(m3); std::cout << m.size() << " " << m.empty() << " " << m.max_size() << "\n"; m.clear(); std::cout << m.size() << " " << m.empty() << " " << m.max_size() << "\n"; m.swap(m3); std::cout << m.size() << " " << m.empty() << " " << m.max_size() << "\n"; std::cout << m.at(0) << " " << m.count(0) << " " << (m == m) << "\n"; for (auto ii = m.begin(), ee = m.end(); ii != ee; ++ii) std::cout << ii->first << " " << ii->second << " "; std::cout << "\n"; for (auto ii = m.cbegin(), ee = m.cend(); ii != ee; ++ii) std::cout << ii->first << " " << ii->second << " "; std::cout << "\n"; for (auto ii = m.rbegin(), ee = m.rend(); ii != ee; ++ii) std::cout << ii->first << " " << ii->second << " "; std::cout << "\n"; for (auto ii = m.crbegin(), ee = m.crend(); ii != ee; ++ii) std::cout << ii->first << " " << ii->second << " "; std::cout << "\n"; const int X = 1000000; maptime<Galois::flat_map<int, double>,X>("fm"); maptime<Galois::flat_map<int, double>,X>("fm"); maptime<Galois::flat_map<int, double>,X>("fm"); maptime<std::map<int, double>,X>("std"); maptime<std::map<int, double>,X>("std"); maptime<std::map<int, double>,X>("std"); return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/worklists-compile.cpp
/** Check worklist instantiations -*- C++ -*- * @file * @section License * * Galois, a framework to exploit amorphous data-parallelism in irregular * programs. * * Copyright (C) 2011, The University of Texas at Austin. All rights reserved. * UNIVERSITY EXPRESSLY DISCLAIMS ANY AND ALL WARRANTIES CONCERNING THIS * SOFTWARE AND DOCUMENTATION, INCLUDING ANY WARRANTIES OF MERCHANTABILITY, * FITNESS FOR ANY PARTICULAR PURPOSE, NON-INFRINGEMENT AND WARRANTIES OF * PERFORMANCE, AND ANY WARRANTY THAT MIGHT OTHERWISE ARISE FROM COURSE OF * DEALING OR USAGE OF TRADE. NO WARRANTY IS EITHER EXPRESS OR IMPLIED WITH * RESPECT TO THE USE OF THE SOFTWARE OR DOCUMENTATION. Under no circumstances * shall University be liable for incidental, special, indirect, direct or * consequential damages or loss of profits, interruption of business, or * related expenses which may arise from use of Software or Documentation, * including but not limited to those resulting from defects in Software and/or * Documentation, or loss or inaccuracy of data of any kind. * * @author Andrew Lenharth <[email protected]> */ #include "Galois/Runtime/Range.h" template<typename T2> struct checker { typedef typename T2::template retype<int>::type T; T wl; typename T::template rethread<true>::type wl2; typename T::template rethread<false>::type wl3; checker() { int a[4] = {1,2,3,0}; wl.push(0); wl.push_initial(Galois::Runtime::makeStandardRange(&a[0], &a[4])); wl.push(&a[0], &a[4]); wl.pop(); wl2.push(0); wl2.push_initial(Galois::Runtime::makeStandardRange(&a[0], &a[4])); wl2.push(&a[0], &a[4]); wl2.pop(); wl3.push(0); wl3.push_initial(Galois::Runtime::makeStandardRange(&a[0], &a[4])); wl3.push(&a[0], &a[4]); wl3.pop(); } }; #define GALOIS_WLCOMPILECHECK(name) checker<name<> > ck_##name; #include "Galois/WorkList/WorkList.h" int main() { return 0; }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/test/static.cpp
// std_tr1__type_traits__is_pod.cpp #include "Galois/config.h" #include "Galois/Runtime/ll/PtrLock.h" #include "Galois/Runtime/ll/SimpleLock.h" #include "Galois/Runtime/ll/StaticInstance.h" #include GALOIS_CXX11_STD_HEADER(type_traits) #include <iostream> using namespace Galois::Runtime; using namespace Galois::Runtime::LL; int main() { std::cout << "is_pod PtrLock<int, true> == " << std::boolalpha << std::is_pod<PtrLock<int, true> >::value << std::endl; std::cout << "is_pod PtrLock<int, false> == " << std::boolalpha << std::is_pod<PtrLock<int, false> >::value << std::endl; std::cout << "is_pod SimpleLock<true> == " << std::boolalpha << std::is_pod<SimpleLock<true> >::value << std::endl; std::cout << "is_pod SimpleLock<false> == " << std::boolalpha << std::is_pod<SimpleLock<false> >::value << std::endl; std::cout << "is_pod StaticInstance<int> == " << std::boolalpha << std::is_pod<StaticInstance<int> >::value << std::endl; std::cout << "is_pod StaticInstance<std::iostream> == " << std::boolalpha << std::is_pod<StaticInstance<std::iostream> >::value << std::endl; std::cout << "is_pod volatile int == " << std::boolalpha << std::is_pod<volatile int>::value << std::endl; std::cout << "is_pod int == " << std::boolalpha << std::is_pod<int>::value << std::endl; // std::cout << "is_pod<throws> == " << std::boolalpha // << std::is_pod<throws>::value << std::endl; return (0); }
0
rapidsai_public_repos/code-share/maxflow/galois
rapidsai_public_repos/code-share/maxflow/galois/inputs/CMakeLists.txt
add_custom_target(more-inputs) file(WRITE ${CMAKE_CURRENT_BINARY_DIR}/copyinputs.cmake "file(COPY ${CMAKE_CURRENT_SOURCE_DIR} DESTINATION ${CMAKE_CURRENT_BINARY_DIR} PATTERN .svn EXCLUDE PATTERN CMakeLists.txt EXCLUDE)") add_custom_target(more-base-graphs COMMAND ${CMAKE_COMMAND} -P ${CMAKE_CURRENT_BINARY_DIR}/copyinputs.cmake) add_dependencies(more-inputs more-base-graphs) add_subdirectory(avi) add_subdirectory(meshes) add_subdirectory(random) add_subdirectory(road) add_subdirectory(scalefree)
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/meshes/CMakeLists.txt
function(mesh base numpoints) add_custom_command(OUTPUT ${base}.raw.node COMMAND python ${CMAKE_BINARY_DIR}/tools/generators/random-2d-points.py ${numpoints} 1 > ${base}.raw.node) add_custom_command(OUTPUT ${base}.node ${base}.ele ${base}.poly COMMAND delaunaytriangulation -noverify -writemesh ${base} ${base}.raw.node DEPENDS delaunaytriangulation ${base}.raw.node) endfunction(mesh) mesh(r500k 500000) mesh(r1M 1000000) mesh(r5M 5000000) mesh(r10M 10000000) add_custom_target(mesh-nodes DEPENDS r500k.node r1M.node r5M.node) add_custom_target(mesh-eles DEPENDS r500k.node r500k.ele r500k.poly r1M.node r1M.ele r1M.poly r5M.node r5M.ele r5M.poly) add_dependencies(more-inputs mesh-nodes mesh-eles)
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/meshes/r10k.1.ele
20001 3 0 0 7597 3480 5679 1 7597 5679 8158 2 7597 8158 2854 3 7597 8574 3480 4 7597 2854 8574 5 5329 3551 6978 6 5329 5463 3551 7 5329 6726 5463 8 5329 8946 6726 9 5329 9253 8946 10 5329 1685 6888 11 5329 6888 9253 12 5329 6978 1685 13 8305 1037 9838 14 8305 3677 1037 15 8305 4777 3677 16 8305 9838 4818 17 8305 4818 6978 18 8305 6978 3551 19 8305 3551 5382 20 8305 5382 4777 21 4818 9589 9456 22 4818 5546 9589 23 4818 1043 5546 24 4818 1037 1043 25 4818 9838 1037 26 4818 9456 1685 27 4818 1685 6978 28 1384 1548 8349 29 1384 8349 7682 30 1384 7596 1548 31 1384 7682 7596 32 9632 8445 8736 33 9632 8736 7259 34 9632 6442 8445 35 9632 8336 6855 36 9632 7259 8336 37 9632 6855 6442 38 8336 6208 6855 39 8336 7259 6208 40 8693 6208 8633 41 8693 8633 3885 42 8693 9521 6855 43 8693 3885 9521 44 8693 6855 6208 45 8445 2676 8736 46 8445 2624 2676 47 8445 6442 2624 48 8736 2676 6953 49 8736 6953 7259 50 3480 8574 1520 51 3480 1520 3451 52 3480 3451 2913 53 3480 2913 3647 54 3480 3647 2826 55 3480 2826 5679 56 7582 5778 610 57 7582 2854 5778 58 7582 2544 8574 59 7582 130 2544 60 7582 8574 2854 61 7582 610 5755 62 7582 5755 130 63 5755 610 5778 64 5755 5778 8073 65 5755 8073 8464 66 5755 2810 130 67 5755 8464 2810 68 1685 9456 3071 69 1685 3071 6888 70 4777 9440 3677 71 4777 3413 9440 72 4777 5382 627 73 4777 627 3413 74 3594 1256 6666 75 3594 6666 7720 76 3594 7943 6367 77 3594 6367 3365 78 3594 3365 1256 79 3594 7720 7943 80 1548 8510 8349 81 1548 7596 8510 82 8299 5873 1343 83 8299 1343 1628 84 8299 7872 5873 85 8299 9020 7080 86 8299 1628 9020 87 8299 7080 6673 88 8299 6673 7872 89 6855 9521 6442 90 2676 6865 6953 91 2676 6425 6865 92 2676 2624 4643 93 2676 4643 6425 94 2854 8158 5778 95 1520 8574 6788 96 1520 6788 616 97 1520 616 3451 98 5382 5463 4138 99 5382 3551 5463 100 5382 4138 627 101 7943 3071 6367 102 7943 7430 3071 103 7943 7720 7430 104 8349 8510 9711 105 8349 9711 3949 106 8349 3949 7682 107 6339 9877 1236 108 6339 1236 712 109 6339 648 6568 110 6339 4905 648 111 6339 6568 9877 112 6339 712 4905 113 7080 9020 3023 114 7080 3023 7082 115 7080 7082 6673 116 6675 6208 7259 117 6675 2680 6208 118 6675 7259 720 119 6675 720 2680 120 6442 9521 2624 121 9288 1784 7677 122 9288 7677 6701 123 9288 6701 6490 124 9288 4325 1784 125 9288 6490 4325 126 8574 2544 6788 127 8073 9222 8464 128 8073 2654 9222 129 8073 8158 2654 130 8073 5778 8158 131 8158 1146 2654 132 8158 5679 1146 133 4291 8739 6003 134 4291 260 8739 135 4291 3760 9374 136 4291 9374 260 137 4291 6003 3760 138 6277 171 5573 139 6277 5573 9698 140 6277 9374 171 141 6277 9698 9374 142 1043 1256 5546 143 1043 1037 3677 144 1043 3677 5765 145 1043 5765 6666 146 1043 6666 1256 147 4138 9086 627 148 4138 6726 991 149 4138 5463 6726 150 4138 991 6555 151 4138 6555 9086 152 991 6726 496 153 991 496 6555 154 6282 496 6726 155 6282 6565 496 156 6282 8636 6565 157 6282 923 8636 158 6282 8946 923 159 6282 6726 8946 160 9253 8837 8946 161 9253 3866 8837 162 9253 6888 3866 163 6367 9456 9589 164 6367 3071 9456 165 6367 9589 3365 166 9589 5546 3365 167 6704 3945 1016 168 6704 2212 3945 169 6704 4903 2285 170 6704 1016 4903 171 6704 2285 2212 172 9711 2074 3949 173 9711 3378 2074 174 9711 8510 3378 175 9877 6886 2513 176 9877 2513 1236 177 9877 6568 6886 178 8753 7534 5344 179 8753 278 7534 180 8753 1377 6888 181 8753 5344 1377 182 8753 6888 278 183 6673 7082 3514 184 6673 3514 2963 185 6673 2963 7872 186 8599 7934 2851 187 8599 8662 7934 188 8599 5253 8662 189 8599 2851 123 190 8599 123 7735 191 8599 7735 5253 192 3423 9300 5911 193 3423 765 9300 194 3423 3055 765 195 3423 3927 1097 196 3423 1097 6290 197 3423 6290 3055 198 3423 5911 3927 199 6346 2267 8318 200 6346 3324 2267 201 6346 8318 3324 202 1362 688 2547 203 1362 2547 460 204 1362 460 4548 205 1362 4548 1913 206 1362 9197 505 207 1362 1913 9197 208 1362 505 9648 209 1362 9648 7038 210 1362 7038 688 211 6953 720 7259 212 6953 2832 720 213 6953 6865 2832 214 2680 7853 6208 215 2680 720 7853 216 6208 8711 7362 217 6208 9310 8711 218 6208 7362 8633 219 6208 7853 9310 220 2624 3195 3144 221 2624 3144 7677 222 2624 7677 4643 223 2624 9521 974 224 2624 974 3195 225 974 9521 258 226 974 258 9614 227 974 7715 3195 228 974 9614 7715 229 1784 4325 6103 230 1784 872 7677 231 1784 2486 872 232 1784 6103 2486 233 8852 3485 1765 234 8852 4726 3485 235 8852 1765 3147 236 8852 3147 4726 237 9222 8884 8464 238 9222 4107 8884 239 9222 2654 9560 240 9222 9560 4107 241 6749 5326 3026 242 6749 4567 5326 243 6749 2250 7935 244 6749 3026 2250 245 6749 7935 4567 246 640 1525 1116 247 640 7276 1525 248 640 9195 858 249 640 1116 9195 250 640 858 7935 251 640 7935 2250 252 640 2250 7276 253 2250 3026 5296 254 2250 5296 7276 255 3760 4154 171 256 3760 171 9374 257 3760 4446 4154 258 3760 6003 4446 259 171 7671 5573 260 171 1093 7671 261 171 4154 1093 262 9440 5405 3677 263 9440 3413 5405 264 6666 9857 3955 265 6666 5765 9857 266 6666 3955 7720 267 6555 496 9086 268 8946 8837 923 269 3866 7216 4945 270 3866 6888 7216 271 3866 4945 8837 272 7216 9538 4945 273 7216 1377 9538 274 7216 6888 1377 275 4152 278 7430 276 4152 4905 278 277 4152 7430 2335 278 4152 2335 4905 279 3365 5546 1256 280 3071 7430 278 281 3071 278 6888 282 2285 4903 3995 283 2285 3995 2713 284 2285 2713 2212 285 1016 1827 4903 286 1016 3155 1827 287 1016 3945 2599 288 1016 2599 3155 289 3949 2074 9463 290 3949 9463 7682 291 7596 1510 8510 292 7596 3630 1510 293 7596 7682 3630 294 2513 2074 4693 295 2513 9463 2074 296 2513 5453 9463 297 2513 4693 2405 298 2513 6886 5453 299 2513 2405 1236 300 712 377 4905 301 712 527 377 302 712 6428 527 303 712 8147 6428 304 712 1236 2405 305 712 2405 8147 306 6886 1055 255 307 6886 255 5453 308 6886 6568 1055 309 5344 7534 1441 310 5344 1441 6514 311 5344 6514 6377 312 5344 6377 1377 313 3930 9104 5328 314 3930 2978 9104 315 3930 8437 2978 316 3930 8944 8437 317 3930 5328 8944 318 8437 1628 2978 319 8437 365 6351 320 8437 6351 1380 321 8437 8944 365 322 8437 1380 1628 323 9260 499 617 324 9260 9104 499 325 9260 5328 9104 326 9260 3239 1112 327 9260 1112 5328 328 9260 617 5585 329 9260 5585 3239 330 9020 9716 3023 331 9020 1628 9716 332 7872 2963 1439 333 7872 1439 2378 334 7872 2378 638 335 7872 2468 5873 336 7872 638 2468 337 2851 7020 5899 338 2851 5899 123 339 2851 7934 7020 340 3055 5192 765 341 3055 6290 5192 342 5877 9273 3927 343 5877 5911 9273 344 5877 3927 5911 345 7643 9273 8488 346 7643 8488 5403 347 7643 5403 6475 348 7643 6475 8318 349 7643 8318 3927 350 7643 3927 9273 351 2267 3927 8318 352 2267 8822 3927 353 2267 2791 8165 354 2267 3324 2791 355 2267 8165 5973 356 2267 5973 8822 357 6475 5348 3324 358 6475 5403 5348 359 6475 3324 8318 360 7038 9540 2813 361 7038 9678 9540 362 7038 5803 9678 363 7038 8370 5803 364 7038 9648 8370 365 7038 2813 688 366 9648 362 8370 367 9648 505 362 368 6865 1017 1707 369 6865 2869 1017 370 6865 1729 2869 371 6865 6425 1729 372 6865 1707 2832 373 3885 8633 258 374 3885 258 9521 375 3195 1743 3144 376 3195 7715 1743 377 7677 872 9512 378 7677 564 6701 379 7677 9512 4643 380 7677 3144 564 381 2486 6423 7962 382 2486 6103 6423 383 2486 7962 872 384 1431 2047 3562 385 1431 3562 8763 386 1431 8218 8366 387 1431 8366 2047 388 1431 3244 8218 389 1431 8763 3244 390 1765 3485 932 391 1765 2489 3147 392 1765 932 2489 393 394 5898 4726 394 394 4978 5898 395 394 3147 3644 396 394 3644 4978 397 394 4726 3147 398 3963 2714 6776 399 3963 7607 2714 400 3963 9075 6952 401 3963 6776 9075 402 3963 6952 6655 403 3963 6655 7607 404 5628 5373 1070 405 5628 3722 5373 406 5628 6356 3722 407 5628 5351 6356 408 5628 1070 5351 409 6356 6776 2714 410 6356 2714 4982 411 6356 4982 5710 412 6356 5710 3722 413 6356 5351 1302 414 6356 1302 6776 415 3647 5426 2826 416 3647 2913 5426 417 616 3200 3451 418 616 6788 3200 419 2810 9759 4101 420 2810 4101 1757 421 2810 1369 130 422 2810 1757 1369 423 2810 8464 9759 424 2654 1146 3735 425 2654 3735 9560 426 5204 8748 6478 427 5204 7309 8748 428 5204 6478 311 429 5204 311 7309 430 9892 3215 9743 431 9892 9743 3568 432 9892 4645 8242 433 9892 3065 4645 434 9892 8957 3215 435 9892 8242 8957 436 9892 4833 3065 437 9892 3568 4833 438 375 2209 3348 439 375 5564 2209 440 375 3348 9848 441 375 9848 6218 442 375 1904 5564 443 375 6218 1904 444 1773 7365 7139 445 1773 7139 2699 446 1773 2699 2003 447 1773 8041 7365 448 1773 5113 8041 449 1773 2003 5113 450 7649 2724 9927 451 7649 9927 4306 452 7649 6406 2724 453 7649 4306 8368 454 7649 8368 6406 455 4815 858 5693 456 4815 5693 9927 457 4815 9927 2724 458 4815 2724 8668 459 4815 8668 858 460 9195 5693 858 461 9195 8310 5693 462 9195 1116 8310 463 7935 858 8668 464 7935 8668 4567 465 2724 9768 4567 466 2724 6406 9768 467 2724 4567 8668 468 3026 5420 5296 469 3026 5326 2739 470 3026 2739 1049 471 3026 1049 5420 472 9374 9698 260 473 6161 3955 9857 474 6161 9857 7594 475 6161 1715 7465 476 6161 7594 1715 477 6161 7465 3955 478 3677 5405 5765 479 5765 5405 9857 480 4945 5802 8837 481 4945 9538 5802 482 7430 7720 2335 483 2212 2713 9599 484 2212 9599 2961 485 2212 2961 3945 486 9599 2713 649 487 9599 5244 7746 488 9599 649 5244 489 9599 7746 2961 490 3689 2846 7145 491 3689 5401 2846 492 3689 7145 9619 493 3689 9619 3702 494 3689 3702 3793 495 3689 3793 5401 496 2074 3378 4693 497 7682 9463 3857 498 7682 5385 3630 499 7682 3857 5385 500 1377 3936 9538 501 1377 6377 3936 502 8779 8386 8385 503 8779 2296 8386 504 8779 8385 2728 505 8779 2728 2296 506 5692 5350 7585 507 5692 7585 5585 508 5692 2731 5350 509 5692 617 2731 510 5692 5585 617 511 8944 1175 365 512 8944 5328 1175 513 3239 5585 1008 514 3239 7953 6372 515 3239 1008 7953 516 3239 7998 1112 517 3239 6372 7998 518 3023 2702 3033 519 3023 3033 7058 520 3023 9716 2702 521 3023 9102 7082 522 3023 7058 9102 523 6351 342 1291 524 6351 365 342 525 6351 1291 1380 526 5873 2468 1343 527 7556 5928 7324 528 7556 7324 1380 529 7556 1291 342 530 7556 342 339 531 7556 339 5928 532 7556 1380 1291 533 7934 4251 9013 534 7934 8662 4251 535 7934 9013 7020 536 5911 9300 9273 537 9273 9300 9065 538 9273 9065 8488 539 2547 2813 8769 540 2547 688 2813 541 2547 8769 460 542 2813 4354 8769 543 2813 1255 4354 544 2813 9540 1255 545 8370 2751 5803 546 8370 362 5549 547 8370 5549 2751 548 8062 7397 7265 549 8062 7265 4027 550 8062 7744 7397 551 8062 4836 7744 552 8062 4325 1588 553 8062 6103 4325 554 8062 4027 6103 555 8062 1588 4836 556 1543 2197 6534 557 1543 6009 2197 558 1543 9319 6009 559 1543 8633 9319 560 1543 258 8633 561 1543 6534 258 562 7362 9319 8633 563 7362 7279 9319 564 7362 8711 7279 565 6452 2197 7367 566 6452 7367 891 567 6452 891 9614 568 6452 6534 2197 569 6452 9614 6534 570 2832 2047 727 571 2832 727 720 572 2832 1707 2047 573 1729 6425 9512 574 1729 9512 2869 575 3144 1743 6984 576 3144 6984 5969 577 3144 5969 564 578 872 7962 6999 579 872 6999 9512 580 3653 891 9501 581 3653 9614 891 582 3653 9501 7715 583 3653 7715 9614 584 9235 1664 8366 585 9235 7526 1664 586 9235 8021 7526 587 9235 8863 8021 588 9235 8218 8863 589 9235 8366 8218 590 3244 6302 8218 591 3244 3412 6302 592 3244 8763 3412 593 3147 7712 3644 594 3147 8153 7712 595 3147 2489 8153 596 932 3485 2531 597 932 8634 9656 598 932 9656 1931 599 932 2531 8634 600 932 1931 2230 601 932 2230 2489 602 6952 4229 1029 603 6952 1029 6655 604 6952 4187 4229 605 6952 9075 4187 606 1070 5373 7041 607 1070 7041 8330 608 1070 8330 5351 609 9075 8787 8470 610 9075 5635 8787 611 9075 5351 8330 612 9075 8330 5635 613 9075 6776 1302 614 9075 1302 5351 615 9075 8470 4187 616 2826 5426 5679 617 3451 3200 1989 618 3451 1989 2913 619 8464 8884 9759 620 8748 2138 6478 621 8748 3568 2138 622 8748 4833 3568 623 8748 7309 4833 624 311 8921 1217 625 311 6478 8921 626 311 1217 7309 627 3215 6503 9743 628 3215 8957 6503 629 1904 7426 7427 630 1904 7427 5564 631 1904 6218 7426 632 3348 2209 5030 633 3348 5030 9848 634 7365 8041 3417 635 7365 3191 7139 636 7365 5082 3191 637 7365 3417 5082 638 3462 2003 4450 639 3462 5113 2003 640 3462 4450 870 641 3462 870 5113 642 4761 5420 1049 643 4761 1049 9812 644 4761 9812 5288 645 4761 5288 7592 646 4761 7592 5051 647 4761 5051 5420 648 4306 9927 8210 649 4306 8210 8368 650 4567 9768 5326 651 1306 3390 72 652 1306 72 3267 653 1306 3267 5693 654 1306 1778 3390 655 1306 7633 1778 656 1306 8310 7633 657 1306 5693 8310 658 2023 7391 1282 659 2023 1282 9371 660 2023 8799 7391 661 2023 4082 8799 662 2023 9371 4082 663 7391 8799 6214 664 7391 6214 9977 665 7391 7535 1282 666 7391 9977 7535 667 9398 8765 886 668 9398 4541 8765 669 9398 886 4602 670 9398 4602 4653 671 9398 4653 4844 672 9398 4844 4541 673 1891 7182 6360 674 1891 8000 7182 675 1891 6360 9284 676 1891 9284 2276 677 1891 2276 2225 678 1891 2225 8000 679 9673 3972 4909 680 9673 3720 3972 681 9673 4909 8588 682 9673 2229 4088 683 9673 8588 2229 684 9673 4088 3720 685 9698 6642 6270 686 9698 6270 260 687 9698 5573 6122 688 9698 6122 6642 689 6003 8581 6906 690 6003 8739 8581 691 6003 6906 4446 692 1098 661 6122 693 1098 6177 661 694 1098 1152 6177 695 1098 8392 904 696 1098 904 1152 697 1098 6122 8392 698 8344 7129 9466 699 8344 9466 6077 700 8344 2099 7129 701 8344 6077 2099 702 7465 1430 7544 703 7465 1715 1430 704 7465 7544 2335 705 7465 2335 7720 706 7465 7720 3955 707 627 6839 3413 708 627 10002 6839 709 627 496 10002 710 627 9086 496 711 496 6565 1086 712 496 1086 10002 713 8837 5802 923 714 278 377 7534 715 278 4905 377 716 5802 8500 3483 717 5802 9538 8500 718 5802 4451 923 719 5802 3483 4451 720 3945 2961 2343 721 3945 2343 4168 722 3945 4168 2599 723 7746 2343 2961 724 7746 127 2343 725 7746 5244 127 726 3793 2821 3962 727 3793 3702 2821 728 3793 5402 5401 729 3793 1827 5402 730 3793 4903 1827 731 3793 3962 4903 732 7145 2846 3672 733 7145 3672 4617 734 7145 4617 591 735 7145 591 9619 736 5385 7836 3630 737 5385 3857 868 738 5385 868 7836 739 8510 1510 4577 740 8510 4577 3378 741 648 6906 8581 742 648 9351 6906 743 648 8581 6568 744 648 4905 9351 745 527 6428 5780 746 527 5780 377 747 1055 2796 255 748 1055 6568 2796 749 2405 4693 8147 750 6377 6514 2707 751 6377 2707 4010 752 6377 4010 8500 753 6377 8500 3936 754 649 6860 5244 755 649 1924 6860 756 649 2713 1924 757 2728 6281 376 758 2728 376 3188 759 2728 8385 6281 760 2728 3188 2296 761 6281 9723 6694 762 6281 6694 376 763 6281 8385 9723 764 650 4864 9723 765 650 8742 4864 766 650 3034 8742 767 650 9723 8385 768 650 8385 8386 769 650 8386 3034 770 5350 737 7585 771 5350 755 737 772 5350 2731 755 773 2978 3001 3978 774 2978 3978 3152 775 2978 3420 9104 776 2978 3152 3420 777 2978 1628 1343 778 2978 1343 3001 779 1112 145 8817 780 1112 7998 145 781 1112 8817 5328 782 7082 9102 3514 783 365 4925 342 784 365 1175 4925 785 1343 2468 3001 786 4925 7402 342 787 4925 7837 7402 788 4925 1175 7837 789 9013 3397 7020 790 9013 5744 3397 791 9013 3053 5744 792 9013 4251 3053 793 765 1842 1100 794 765 8981 1842 795 765 5192 8981 796 765 1100 9300 797 3927 8822 10002 798 3927 10002 9634 799 3927 9634 1097 800 8165 9401 5973 801 8165 2791 9401 802 1851 4442 6797 803 1851 3808 4442 804 1851 909 3808 805 1851 6797 3768 806 1851 9492 5330 807 1851 3768 9492 808 1851 5330 909 809 4930 9906 505 810 4930 505 9197 811 4930 7147 8443 812 4930 8443 9906 813 4930 9197 7147 814 6790 6767 5447 815 6790 5447 1249 816 6790 1674 362 817 6790 362 6767 818 6790 9184 1674 819 6790 1249 9184 820 1588 520 4836 821 1588 4325 520 822 6534 9614 258 823 6425 4643 9512 824 564 4313 6490 825 564 6490 6701 826 564 5969 4313 827 6490 4313 4325 828 7962 6423 6999 829 5375 5121 2564 830 5375 2564 6984 831 5375 7505 5121 832 5375 6984 7505 833 7715 9501 6984 834 7715 6984 1743 835 8218 6302 8863 836 9611 8805 3485 837 9611 5026 8805 838 9611 3485 1779 839 9611 1779 5026 840 4726 5898 1779 841 4726 1779 3485 842 2230 7712 8153 843 2230 723 7712 844 2230 8153 2489 845 2230 1931 723 846 8634 9847 9656 847 8634 7634 915 848 8634 915 9847 849 8634 2692 7634 850 8634 6780 2692 851 8634 2531 6780 852 4203 7634 3674 853 4203 6096 7634 854 4203 3674 739 855 4203 739 2971 856 4203 2971 6096 857 9782 2589 3321 858 9782 3321 3137 859 9782 3145 822 860 9782 822 2589 861 9782 3137 3145 862 2518 7073 3632 863 2518 6342 7073 864 2518 706 6342 865 2518 3632 6566 866 2518 6566 706 867 4187 8470 4229 868 7607 7218 1110 869 7607 1110 6078 870 7607 6078 2714 871 7607 6655 7218 872 4229 8470 5942 873 4229 5942 1029 874 1553 4160 8320 875 1553 8320 4589 876 1553 5554 4160 877 1553 8193 5554 878 1553 4589 8193 879 8264 518 2314 880 8264 511 518 881 8264 2314 3598 882 8264 4725 2700 883 8264 2700 511 884 8264 9527 4725 885 8264 3598 9527 886 1232 4725 9527 887 1232 5270 4725 888 1232 9527 6358 889 1232 6358 5270 890 1486 9916 3075 891 1486 3075 7915 892 1486 2700 4725 893 1486 7915 2700 894 1486 4725 8294 895 1486 8294 9916 896 182 4608 8193 897 182 8193 1366 898 182 8211 9770 899 182 8678 8211 900 182 9770 4608 901 182 4057 8678 902 182 8821 4057 903 182 3747 8821 904 182 6241 3747 905 182 1366 6241 906 6583 5769 1881 907 6583 1881 9881 908 6583 6241 5769 909 6583 9881 6241 910 9377 1881 5769 911 9377 6454 1881 912 9377 5769 9186 913 9377 9186 6454 914 9476 9185 806 915 9476 806 9152 916 9476 9152 5403 917 9476 2700 9185 918 9476 1814 2700 919 9476 5403 1814 920 5679 5426 44 921 5679 44 1146 922 8884 4107 2977 923 8884 2977 3591 924 8884 3591 9759 925 6788 2544 8778 926 6788 8778 3200 927 130 8667 2544 928 130 1369 8667 929 1989 3200 2004 930 1989 2004 7767 931 1989 7767 2913 932 5426 2621 937 933 5426 937 44 934 5426 2913 2030 935 5426 2030 2621 936 5060 4843 9451 937 5060 9451 9496 938 5060 6901 6794 939 5060 6794 9306 940 5060 9306 4843 941 5060 9496 6901 942 8921 5419 8684 943 8921 8684 1217 944 8921 6478 5419 945 7309 9684 4833 946 7309 1328 9684 947 7309 1217 1328 948 9743 6503 2693 949 9743 2693 3568 950 8777 9574 8449 951 8777 8449 8744 952 8777 3338 9574 953 8777 6665 3338 954 8777 8744 6665 955 4085 7424 3330 956 4085 3330 5927 957 4085 5942 4066 958 4085 5927 5942 959 4085 4066 5267 960 4085 5267 7424 961 5267 102 2084 962 5267 4066 102 963 5267 4811 7424 964 5267 2084 4811 965 7426 1539 3191 966 7426 3191 7427 967 7426 6218 9293 968 7426 9293 2500 969 7426 2500 1539 970 9057 8375 8210 971 9057 5031 8375 972 9057 8210 9204 973 9057 9204 5313 974 9057 5313 5031 975 5030 469 8375 976 5030 2209 469 977 5030 8375 1107 978 5030 3361 9848 979 5030 1107 3361 980 6524 1107 5031 981 6524 5031 8051 982 6524 3361 1107 983 6524 8051 3361 984 1420 9007 8486 985 1420 8048 9007 986 1420 8627 6947 987 1420 6947 8818 988 1420 8818 8048 989 1420 8486 8627 990 5371 316 5604 991 5371 5604 2142 992 5371 2142 5683 993 5371 5683 316 994 7139 3191 1539 995 7139 1539 3546 996 7139 3546 2699 997 4450 5683 2142 998 4450 2142 870 999 4450 4663 5683 1000 4450 2699 4663 1001 4450 2003 2699 1002 7592 5288 2239 1003 7592 2239 2467 1004 7592 8439 5051 1005 7592 2467 8439 1006 9927 3267 8210 1007 9927 5693 3267 1008 469 8368 8375 1009 469 5082 6406 1010 469 2209 5082 1011 469 6406 8368 1012 3390 1778 4615 1013 3390 4615 4065 1014 3390 4065 72 1015 4082 1570 657 1016 4082 657 8799 1017 4082 9371 8327 1018 4082 8327 1570 1019 1282 3530 9371 1020 1282 7535 3530 1021 9371 3757 8327 1022 9371 4257 3757 1023 9371 3530 4257 1024 3222 4653 4602 1025 3222 3317 4653 1026 3222 4602 886 1027 3222 2403 6422 1028 3222 886 2403 1029 3222 6422 3317 1030 1489 3972 432 1031 1489 2403 3972 1032 1489 6422 2403 1033 1489 3869 6422 1034 1489 432 3869 1035 2642 7684 2628 1036 2642 2628 8323 1037 2642 5061 7684 1038 2642 8323 5061 1039 2750 2546 7950 1040 2750 1124 2546 1041 2750 7950 7599 1042 2750 7599 8000 1043 2750 8000 1124 1044 7599 7950 1347 1045 7599 1347 8765 1046 7599 8765 8000 1047 4844 4653 75 1048 4844 75 4541 1049 2225 8987 1124 1050 2225 2276 8987 1051 2225 1124 8000 1052 4088 2229 4108 1053 4088 9148 3720 1054 4088 4108 9148 1055 6301 1637 253 1056 6301 253 7367 1057 6301 7367 2197 1058 6301 6009 586 1059 6301 2197 6009 1060 6301 586 1637 1061 5573 7671 8392 1062 5573 8392 6122 1063 4446 265 8629 1064 4446 6906 265 1065 4446 8629 4154 1066 6519 8352 3904 1067 6519 3748 8352 1068 6519 7317 7129 1069 6519 3904 7317 1070 6519 7129 2099 1071 6519 2099 3748 1072 8392 5591 904 1073 8392 7671 5591 1074 6642 531 5068 1075 6642 5068 1956 1076 6642 1956 6270 1077 6642 6122 531 1078 8629 6839 4154 1079 8629 265 6839 1080 7129 7317 6140 1081 7129 6140 4946 1082 7129 4946 9466 1083 6140 7317 1152 1084 6140 1152 904 1085 6140 904 4946 1086 4733 904 5591 1087 4733 5591 1093 1088 4733 4946 904 1089 4733 1093 10002 1090 4733 10002 4946 1091 7544 9351 2335 1092 7544 2538 9351 1093 7544 1430 2538 1094 3413 6839 5405 1095 5405 7594 9857 1096 5405 6839 7594 1097 6565 8636 1086 1098 8636 923 4451 1099 8636 4451 1086 1100 3483 8500 4010 1101 3483 4010 1655 1102 3483 1655 4451 1103 3962 9559 3995 1104 3962 2821 9559 1105 3962 3995 4903 1106 6621 4582 3702 1107 6621 6996 4582 1108 6621 8148 6996 1109 6621 7269 8148 1110 6621 9619 591 1111 6621 3702 9619 1112 6621 591 7269 1113 5402 3672 2846 1114 5402 3623 3672 1115 5402 9404 3623 1116 5402 2846 5401 1117 5402 1827 9404 1118 3857 9463 5630 1119 3857 5630 868 1120 4905 2335 9351 1121 2796 1642 255 1122 2796 5658 1642 1123 2796 2325 5658 1124 2796 6568 2325 1125 1173 1858 4979 1126 1173 2507 1858 1127 1173 4979 4693 1128 1173 4693 2507 1129 8147 4693 4979 1130 8147 4979 6428 1131 1858 2599 6428 1132 1858 6428 4979 1133 1858 3155 2599 1134 1858 2507 3155 1135 3630 9404 1827 1136 3630 7836 9404 1137 3630 1827 1510 1138 4168 6428 2599 1139 4168 5780 6428 1140 4168 2343 5780 1141 7534 377 2343 1142 7534 2343 1441 1143 6514 3190 2707 1144 6514 1441 3190 1145 2707 6959 1781 1146 2707 3190 6959 1147 2707 1781 8878 1148 2707 8878 4010 1149 5244 6860 7217 1150 5244 6959 127 1151 5244 1781 6959 1152 5244 7217 1781 1153 1781 7217 8878 1154 5930 6664 1153 1155 5930 1153 9205 1156 5930 9205 8340 1157 5930 8340 2176 1158 5930 2176 2929 1159 5930 2929 7898 1160 5930 7898 6664 1161 5073 5189 5014 1162 5073 5014 4620 1163 5073 5242 5450 1164 5073 4620 5242 1165 5073 5450 5189 1166 2251 136 5801 1167 2251 6392 136 1168 2251 5406 6392 1169 2251 439 3491 1170 2251 5801 439 1171 2251 3491 5448 1172 2251 5448 5406 1173 4857 3034 841 1174 4857 4657 3034 1175 4857 841 7013 1176 4857 7013 8129 1177 4857 8129 4657 1178 8386 906 841 1179 8386 2296 906 1180 8386 841 3034 1181 1731 5448 2401 1182 1731 2401 2174 1183 1731 2174 5448 1184 3491 2401 5448 1185 3491 8219 2401 1186 3491 1246 8219 1187 3491 439 1246 1188 2047 1664 727 1189 2047 1017 3562 1190 2047 8366 1664 1191 2047 1707 1017 1192 3562 7877 8763 1193 3562 3839 7877 1194 3562 1017 2869 1195 3562 2869 3839 1196 2731 426 849 1197 2731 849 755 1198 2731 617 499 1199 2731 499 426 1200 5585 7585 9916 1201 5585 9916 1008 1202 5328 8817 1175 1203 3420 426 9104 1204 3420 6742 426 1205 3420 3152 7632 1206 3420 7632 6742 1207 2702 4126 4510 1208 2702 4510 9617 1209 2702 9617 3033 1210 2702 9716 4126 1211 3514 4025 2963 1212 3514 5436 4025 1213 3514 9102 5436 1214 1628 1380 9716 1215 7324 7333 1668 1216 7324 5928 7333 1217 7324 1668 4467 1218 7324 4467 9716 1219 7324 9716 1380 1220 342 5303 339 1221 342 7402 5303 1222 3234 7750 7735 1223 3234 5227 7750 1224 3234 7735 123 1225 3234 123 3886 1226 3234 3886 5227 1227 7020 5553 5899 1228 7020 3397 5317 1229 7020 5317 5553 1230 7588 6237 9535 1231 7588 3899 6237 1232 7588 9535 8620 1233 7588 8620 878 1234 7588 878 3899 1235 6290 1097 5192 1236 9300 1654 9065 1237 9300 1100 1654 1238 5973 9401 8967 1239 5973 8967 2244 1240 5973 2244 8822 1241 5348 2791 3324 1242 5348 9152 2791 1243 5348 5403 9152 1244 8615 45 6136 1245 8615 6820 45 1246 8615 1985 1842 1247 8615 6136 1985 1248 8615 1842 6820 1249 9679 5552 2167 1250 9679 6165 5552 1251 9679 6507 3797 1252 9679 3797 6165 1253 9679 2167 6507 1254 9034 2089 6858 1255 9034 6858 8783 1256 9034 6507 2167 1257 9034 2167 2089 1258 9034 2786 6507 1259 9034 8783 2786 1260 5330 4671 9625 1261 5330 9492 4671 1262 5330 9625 3577 1263 5330 5562 909 1264 5330 6247 5562 1265 5330 3577 6247 1266 9311 6517 3577 1267 9311 222 6517 1268 9311 9625 8008 1269 9311 8008 222 1270 9311 3577 9625 1271 350 264 7893 1272 350 1378 264 1273 350 1449 3302 1274 350 3302 8443 1275 350 8443 1378 1276 350 9146 1449 1277 350 7893 9146 1278 7147 2563 1681 1279 7147 1681 1378 1280 7147 9197 2563 1281 7147 1378 8443 1282 5640 7043 4603 1283 5640 4603 7227 1284 5640 2459 2025 1285 5640 2025 7043 1286 5640 7227 2459 1287 8535 5891 9641 1288 8535 6350 5891 1289 8535 362 6350 1290 8535 9641 362 1291 1674 6350 362 1292 1674 9184 6350 1293 6767 7937 5447 1294 6767 9906 7937 1295 6767 505 9906 1296 6767 362 505 1297 5549 9827 2751 1298 5549 1627 9827 1299 5549 362 5784 1300 5549 5784 1627 1301 5676 9678 9578 1302 5676 1540 9678 1303 5676 5803 6703 1304 5676 9578 5803 1305 5676 6703 1111 1306 5676 1111 1540 1307 4836 520 7744 1308 5121 4227 6791 1309 5121 2847 4227 1310 5121 7505 2847 1311 5121 2742 2564 1312 5121 6791 2742 1313 9501 7505 6984 1314 9501 891 7505 1315 3499 2247 3277 1316 3499 6423 2247 1317 3499 229 6423 1318 3499 4490 3683 1319 3499 3277 4490 1320 3499 3683 4989 1321 3499 4989 229 1322 720 3135 542 1323 720 542 9756 1324 720 9756 7853 1325 720 727 3135 1326 7526 8021 8600 1327 7526 8600 4320 1328 7526 4320 1664 1329 7703 7744 4059 1330 7703 4059 9568 1331 7703 8738 7744 1332 7703 6521 8413 1333 7703 9568 6521 1334 7703 8413 7265 1335 7703 7265 7397 1336 7703 7397 8738 1337 7265 9096 4027 1338 7265 9074 9096 1339 7265 8413 9074 1340 3861 7550 3046 1341 3861 3046 5905 1342 3861 5905 8413 1343 3861 8413 6521 1344 3861 6521 7550 1345 3644 9360 139 1346 3644 139 8205 1347 3644 8205 6468 1348 3644 6468 4978 1349 3644 7712 9360 1350 3485 8805 2531 1351 5955 1915 4551 1352 5955 8205 1915 1353 5955 3637 8205 1354 5955 6813 4630 1355 5955 4630 3637 1356 5955 4551 6813 1357 1931 7327 9383 1358 1931 475 7327 1359 1931 9656 475 1360 1931 9383 723 1361 2692 6780 2589 1362 2692 2589 739 1363 2692 739 3674 1364 2692 3674 7634 1365 2971 1555 6369 1366 2971 6369 9499 1367 2971 739 1555 1368 2971 9499 6096 1369 3145 7973 822 1370 3145 7211 7973 1371 3145 3137 7211 1372 8567 236 822 1373 8567 822 7973 1374 8567 7973 1555 1375 8567 739 236 1376 8567 1555 739 1377 2589 6780 3321 1378 2589 822 236 1379 2589 236 739 1380 7602 5777 4120 1381 7602 7123 5777 1382 7602 7502 7123 1383 7602 613 3478 1384 7602 4120 613 1385 7602 3478 7502 1386 1193 5016 6030 1387 1193 6030 2901 1388 1193 2901 3225 1389 1193 3225 473 1390 1193 473 5016 1391 3988 4454 3248 1392 3988 3753 4454 1393 3988 8927 3753 1394 3988 3248 2737 1395 3988 2737 454 1396 3988 454 6566 1397 3988 6566 7214 1398 3988 7214 8927 1399 6566 6030 7214 1400 6566 3632 6030 1401 6566 454 706 1402 4224 3753 3337 1403 4224 3788 3753 1404 4224 3337 5729 1405 4224 5729 2566 1406 4224 2566 3788 1407 3477 5496 9629 1408 3477 9629 2540 1409 3477 2703 5496 1410 3477 801 2703 1411 3477 5523 801 1412 3477 2540 5523 1413 721 4904 9853 1414 721 9853 6394 1415 721 6394 9109 1416 721 1402 4904 1417 721 2666 1402 1418 721 9109 2666 1419 7041 5373 1714 1420 7041 5635 8330 1421 7041 5432 5635 1422 7041 1714 5432 1423 5942 8470 8787 1424 5942 8787 4066 1425 5942 5927 1029 1426 1029 5927 3704 1427 1029 4248 6655 1428 1029 3704 4248 1429 6655 2876 8482 1430 6655 7961 2876 1431 6655 8482 7218 1432 6655 4248 7961 1433 7791 9174 8423 1434 7791 8423 1689 1435 7791 1689 9746 1436 7791 9746 302 1437 7791 2409 9703 1438 7791 302 2409 1439 7791 9703 9174 1440 8482 2876 1081 1441 8482 1081 5505 1442 8482 5505 1110 1443 8482 1110 7218 1444 699 4391 9045 1445 699 9045 1981 1446 699 1981 5526 1447 699 5526 7506 1448 699 7506 4391 1449 9770 5388 3486 1450 9770 3486 7769 1451 9770 8211 5388 1452 9770 7769 4608 1453 5554 4608 8658 1454 5554 8193 4608 1455 5554 8658 4160 1456 2558 6928 6236 1457 2558 518 6928 1458 2558 6236 2314 1459 2558 2314 518 1460 5178 3064 3560 1461 5178 173 3064 1462 5178 3560 173 1463 9527 3598 6358 1464 3598 2314 7382 1465 3598 7382 6358 1466 57 473 9416 1467 57 5270 473 1468 57 9416 1414 1469 57 4725 5270 1470 57 8907 4725 1471 57 1414 8907 1472 8294 4725 7536 1473 8294 7536 4954 1474 8294 7953 9916 1475 8294 4954 7953 1476 8678 1135 8211 1477 8678 4057 1135 1478 5769 6241 9186 1479 9185 2700 8915 1480 9185 8915 806 1481 1146 6299 4241 1482 1146 44 6299 1483 1146 4241 3735 1484 9759 3591 4101 1485 2544 8667 2840 1486 2544 2840 8778 1487 6448 3284 96 1488 6448 2621 3284 1489 6448 937 2621 1490 6448 96 2880 1491 6448 2880 937 1492 2913 3486 2030 1493 2913 7767 3486 1494 6299 7775 4668 1495 6299 3287 7775 1496 6299 4668 4241 1497 6299 44 3287 1498 2030 5388 1576 1499 2030 1576 2621 1500 2030 3486 5388 1501 7741 8452 2245 1502 7741 2245 9749 1503 7741 9749 8452 1504 600 1718 9891 1505 600 3385 1718 1506 600 9891 36 1507 600 36 3385 1508 4908 6179 3844 1509 4908 1927 6179 1510 4908 3844 6637 1511 4908 6637 1885 1512 4908 1885 4987 1513 4908 4987 1927 1514 4784 3308 1889 1515 4784 1970 3308 1516 4784 8012 1970 1517 4784 7345 7148 1518 4784 3684 7345 1519 4784 1889 3684 1520 4784 7148 7057 1521 4784 7057 8012 1522 4843 8077 9451 1523 4843 7433 8077 1524 4843 9306 7433 1525 6478 2138 391 1526 6478 391 5419 1527 8957 3377 6503 1528 8957 8242 3377 1529 3555 4215 7545 1530 3555 7545 1710 1531 3555 8580 4215 1532 3555 1169 5024 1533 3555 1710 1169 1534 3555 5024 8580 1535 9574 9913 1148 1536 9574 2523 9913 1537 9574 4838 8449 1538 9574 1148 4838 1539 9574 3338 2523 1540 7424 4811 3171 1541 7424 3171 2400 1542 7424 2400 3330 1543 3951 2754 6371 1544 3951 2275 2754 1545 3951 2659 2275 1546 3951 7246 2659 1547 3951 6371 7246 1548 5564 7427 2209 1549 9848 1483 6169 1550 9848 4780 1483 1551 9848 6141 4780 1552 9848 3361 6141 1553 9848 6169 6218 1554 8210 3267 9204 1555 8210 8375 8368 1556 8041 5326 9768 1557 8041 5113 5326 1558 8041 9768 3417 1559 5082 9768 6406 1560 5082 3417 9768 1561 5082 7427 3191 1562 5082 2209 7427 1563 1107 8375 5031 1564 8627 8486 3546 1565 8627 3546 1539 1566 8627 2500 6947 1567 8627 1539 2500 1568 316 9007 5604 1569 316 8486 9007 1570 316 4663 8486 1571 316 5683 4663 1572 5296 4226 7276 1573 5296 5420 4226 1574 5288 9812 2239 1575 5326 5113 2739 1576 1116 1525 966 1577 1116 7633 8310 1578 1116 966 7633 1579 72 4065 1168 1580 72 9204 3267 1581 72 9156 9204 1582 72 1168 9156 1583 6994 8812 3201 1584 6994 3201 2553 1585 6994 2553 4407 1586 6994 4407 1604 1587 6994 3091 8812 1588 6994 1604 3091 1589 4407 2553 4303 1590 4407 4303 1604 1591 5241 1864 8327 1592 5241 4221 1864 1593 5241 3757 798 1594 5241 8327 3757 1595 5241 798 4221 1596 1570 8832 657 1597 1570 1864 8832 1598 1570 8327 1864 1599 5173 8832 1969 1600 5173 657 8832 1601 5173 1969 27 1602 5173 27 657 1603 8799 657 6214 1604 4909 690 6551 1605 4909 6551 8588 1606 4909 3972 690 1607 6422 3869 899 1608 6422 899 3317 1609 7684 3431 690 1610 7684 690 731 1611 7684 5061 3431 1612 7684 731 2628 1613 7950 2546 731 1614 7950 731 1347 1615 3317 885 2152 1616 3317 899 885 1617 3317 2152 4653 1618 75 1379 4256 1619 75 7917 1379 1620 75 4023 4541 1621 75 4256 4023 1622 75 4653 2152 1623 75 2152 7917 1624 6360 9736 9284 1625 6360 7182 9736 1626 2546 8987 5968 1627 2546 5968 9454 1628 2546 2628 731 1629 2546 9454 2628 1630 2546 1124 8987 1631 6721 4829 9402 1632 6721 8323 4829 1633 6721 163 8323 1634 6721 3003 163 1635 6721 9402 3003 1636 3720 9148 2334 1637 3720 2334 7140 1638 3720 7140 432 1639 3720 432 3972 1640 5691 7714 6822 1641 5691 6822 8451 1642 5691 7509 3859 1643 5691 3859 7714 1644 5691 8451 7509 1645 5317 3397 2923 1646 5317 2923 1608 1647 5317 1608 1034 1648 5317 1034 5553 1649 3428 6804 4631 1650 3428 6440 6804 1651 3428 4631 5553 1652 3428 1034 6440 1653 3428 5553 1034 1654 4125 2923 9301 1655 4125 9301 3088 1656 4125 490 6150 1657 4125 3088 490 1658 4125 6150 1608 1659 4125 1608 2923 1660 9933 6594 7360 1661 9933 7360 6309 1662 9933 3781 6594 1663 9933 6309 2269 1664 9933 2269 3781 1665 7360 4825 5723 1666 7360 7768 4825 1667 7360 5723 8578 1668 7360 6594 7768 1669 7360 2164 6309 1670 7360 8578 2164 1671 6009 4740 586 1672 6009 9319 4740 1673 1637 586 8881 1674 1637 8881 7789 1675 1637 7789 253 1676 8739 2325 8581 1677 8739 260 2325 1678 3904 2326 6177 1679 3904 6177 7317 1680 3904 8352 2326 1681 6122 661 531 1682 4154 10002 1093 1683 4154 6839 10002 1684 4946 10002 2032 1685 4946 2032 9466 1686 1430 6906 2538 1687 1430 265 6906 1688 1430 1715 8621 1689 1430 8621 265 1690 1715 7594 6839 1691 1715 6839 8621 1692 1655 1086 4451 1693 1655 4010 4650 1694 1655 4650 1086 1695 6270 5658 260 1696 6270 1952 5658 1697 6270 1231 1952 1698 6270 1956 1231 1699 2713 3995 9559 1700 2713 9559 1924 1701 3702 4582 2821 1702 4582 9559 2821 1703 4582 7385 9559 1704 4582 5934 7385 1705 4582 6996 5934 1706 9463 5453 8248 1707 9463 8248 5630 1708 6568 8581 2325 1709 2507 4577 1510 1710 2507 1510 3155 1711 2507 3378 4577 1712 2507 4693 3378 1713 8971 5630 8200 1714 8971 8200 8404 1715 8971 8404 2346 1716 8971 2346 5630 1717 7836 4516 9404 1718 7836 868 4516 1719 7236 7734 704 1720 7236 704 7364 1721 7236 5985 7734 1722 7236 953 2346 1723 7236 7364 953 1724 7236 2346 8404 1725 7236 8404 5985 1726 8200 8248 255 1727 8200 255 1642 1728 8200 5630 8248 1729 8200 5985 8404 1730 8200 1633 5985 1731 8200 1642 1633 1732 377 5780 2343 1733 3936 8500 9538 1734 4010 625 4650 1735 4010 8878 625 1736 6959 3190 127 1737 4038 2539 4279 1738 4038 5213 2539 1739 4038 7217 6860 1740 4038 6860 8340 1741 4038 8340 5213 1742 4038 4279 7217 1743 2929 7251 9022 1744 2929 9022 6153 1745 2929 9515 7251 1746 2929 6153 7898 1747 2929 2176 9515 1748 8550 1170 4882 1749 8550 4882 167 1750 8550 3748 2064 1751 8550 2064 8042 1752 8550 8042 1170 1753 8550 3251 8352 1754 8550 167 3251 1755 8550 8352 3748 1756 63 8352 3251 1757 63 3251 2542 1758 63 6177 2326 1759 63 661 6177 1760 63 2542 661 1761 63 2326 8352 1762 5040 6229 5208 1763 5040 5208 696 1764 5040 5242 6229 1765 5040 8833 5450 1766 5040 6564 8833 1767 5040 5741 6564 1768 5040 5450 5242 1769 5040 696 5741 1770 5450 4952 5189 1771 5450 8833 4307 1772 5450 4307 4952 1773 5801 326 439 1774 5801 4194 326 1775 5801 136 4194 1776 8207 58 5333 1777 8207 246 58 1778 8207 7013 906 1779 8207 5333 7013 1780 8207 906 246 1781 7013 841 906 1782 7013 5333 2236 1783 7013 2236 8129 1784 4657 6991 3034 1785 4657 5171 6991 1786 4657 8129 5171 1787 9723 4864 6694 1788 6255 986 1592 1789 6255 696 986 1790 6255 6039 696 1791 6255 5215 8810 1792 6255 990 5215 1793 6255 1592 990 1794 6255 8810 6039 1795 2401 8219 2174 1796 3412 3965 6302 1797 3412 1403 3965 1798 3412 9525 1403 1799 3412 8763 2516 1800 3412 2516 9525 1801 9489 8600 8442 1802 9489 3770 8600 1803 9489 54 4353 1804 9489 4353 3770 1805 9489 5140 54 1806 9489 8442 5140 1807 9104 426 499 1808 9672 6890 983 1809 9672 983 2848 1810 9672 2848 4084 1811 9672 4084 380 1812 9672 380 8406 1813 9672 8406 7632 1814 9672 7632 6890 1815 4126 4467 4510 1816 4126 9716 4467 1817 2963 4025 1439 1818 9102 7058 4179 1819 9102 4179 7175 1820 9102 7175 5436 1821 2921 4251 7724 1822 2921 3053 4251 1823 2921 9860 3053 1824 2921 1643 8591 1825 2921 8591 9860 1826 2921 7724 1643 1827 1879 4251 8662 1828 1879 8662 8591 1829 1879 7724 4251 1830 1879 8591 1643 1831 1879 1643 7724 1832 5744 3053 1826 1833 5744 1826 8022 1834 5744 1502 174 1835 5744 8022 1502 1836 5744 174 9301 1837 5744 9301 3397 1838 7735 7750 5253 1839 8268 8435 4094 1840 8268 5752 8435 1841 8268 1395 6750 1842 8268 4094 1395 1843 8268 6750 5752 1844 1961 9032 3102 1845 1961 3102 6750 1846 1961 1395 3596 1847 1961 6750 1395 1848 1961 9340 9032 1849 1961 3596 9340 1850 7249 5177 2414 1851 7249 7377 5177 1852 7249 2414 5671 1853 7249 5671 9244 1854 7249 9244 8932 1855 7249 8932 7377 1856 8641 2715 2365 1857 8641 2365 929 1858 8641 2939 2715 1859 8641 7503 3199 1860 8641 929 7503 1861 8641 3199 2939 1862 8087 8351 9340 1863 8087 9340 8932 1864 8087 2357 8351 1865 8087 6587 2357 1866 8087 8932 9244 1867 8087 9244 6587 1868 9535 5494 8371 1869 9535 7334 5494 1870 9535 8371 8620 1871 9535 6237 2853 1872 9535 2853 7334 1873 5192 8620 8981 1874 5192 1097 8620 1875 8488 1654 5785 1876 8488 9065 1654 1877 8488 5785 1360 1878 8488 1360 5403 1879 5785 1654 1100 1880 5785 1100 6278 1881 5785 6278 1360 1882 1842 1985 1100 1883 1842 8981 6820 1884 6507 2786 3797 1885 909 5562 3354 1886 909 3354 3808 1887 3731 5562 6247 1888 3731 6247 3456 1889 3731 3456 8710 1890 3731 3354 5562 1891 3731 8710 3354 1892 9625 122 8008 1893 9625 4671 122 1894 3685 1087 1298 1895 3685 5616 1087 1896 3685 1298 1849 1897 3685 1849 5616 1898 1449 9146 8764 1899 1449 8764 317 1900 1449 317 3302 1901 3511 7553 5084 1902 3511 6955 7553 1903 3511 3977 6955 1904 3511 7448 3977 1905 3511 460 8676 1906 3511 5084 460 1907 3511 8676 7448 1908 9197 1913 2563 1909 2563 8188 1681 1910 2563 7553 8188 1911 2563 1913 7553 1912 2459 2194 4614 1913 2459 8334 2194 1914 2459 5540 8334 1915 2459 9441 2025 1916 2459 4614 9441 1917 2459 7227 5540 1918 7043 2025 4677 1919 7043 4677 1906 1920 7043 1906 9502 1921 7043 9502 4603 1922 362 9641 5784 1923 6703 3455 8144 1924 6703 8144 1111 1925 6703 2751 3455 1926 6703 5803 2751 1927 9540 9678 2015 1928 9540 2015 1255 1929 9578 9678 5803 1930 3614 2564 2742 1931 3614 4313 2564 1932 3614 520 4325 1933 3614 6983 520 1934 3614 4325 4313 1935 3614 2742 6983 1936 457 6341 2682 1937 457 83 6341 1938 457 2682 7261 1939 457 4059 2742 1940 457 7261 4059 1941 457 2742 6791 1942 457 6791 83 1943 9512 6999 2869 1944 6984 2564 5969 1945 891 7378 2847 1946 891 7367 7378 1947 891 2847 7505 1948 3683 4490 7394 1949 3683 7394 4989 1950 3277 8421 1203 1951 3277 2247 8421 1952 3277 1203 4490 1953 6423 6103 2247 1954 6423 229 6999 1955 7853 8098 9310 1956 7853 9756 8098 1957 3135 1664 4320 1958 3135 727 1664 1959 3135 4320 542 1960 7744 6983 4059 1961 7744 520 6983 1962 7744 8738 7397 1963 7149 8413 5905 1964 7149 5905 1960 1965 7149 9074 8413 1966 7149 1960 9074 1967 6521 8704 7550 1968 6521 9568 8704 1969 9163 7449 1274 1970 9163 1274 1359 1971 9163 1359 5180 1972 9163 5180 6292 1973 9163 6292 8365 1974 9163 8365 5248 1975 9163 5248 7449 1976 4288 8653 5190 1977 4288 895 8653 1978 4288 5362 895 1979 4288 5190 8570 1980 4288 8570 5362 1981 707 6369 8186 1982 707 177 6369 1983 707 8186 8065 1984 707 3528 2504 1985 707 2504 6314 1986 707 8065 3528 1987 707 6314 177 1988 9360 2367 139 1989 9360 7712 2367 1990 1779 5898 7048 1991 1779 7048 5026 1992 6468 2037 4978 1993 6468 7909 2037 1994 6468 7136 7909 1995 6468 8205 7136 1996 4630 104 5929 1997 4630 5522 104 1998 4630 5929 2320 1999 4630 6813 9825 2000 4630 9825 5522 2001 4630 2320 3637 2002 4551 1915 8767 2003 4551 8767 6813 2004 7184 3923 1048 2005 7184 1048 3541 2006 7184 3541 2367 2007 7184 7739 7327 2008 7184 7327 3923 2009 7184 2367 7739 2010 9383 7327 7721 2011 9383 7721 723 2012 4277 8979 177 2013 4277 177 9480 2014 4277 6096 9499 2015 4277 9499 8979 2016 4277 9655 6096 2017 4277 6762 9655 2018 4277 9480 6762 2019 6096 915 7634 2020 6096 9655 915 2021 9847 4265 9656 2022 9847 915 4265 2023 1555 8186 6369 2024 1555 7973 8186 2025 3321 3159 2487 2026 3321 2487 9774 2027 3321 9774 3137 2028 3321 6780 9161 2029 3321 9161 3159 2030 2905 7502 8681 2031 2905 8681 2324 2032 2905 2324 2582 2033 2905 2582 9719 2034 2905 9719 6102 2035 2905 6102 7502 2036 3478 613 1408 2037 3478 5398 7356 2038 3478 1408 5398 2039 3478 7356 7502 2040 3225 3632 7073 2041 3225 2901 3632 2042 3225 7073 9416 2043 3225 9416 473 2044 5016 3287 4983 2045 5016 4983 8870 2046 5016 473 3287 2047 5016 5280 6030 2048 5016 8870 5280 2049 7214 6030 8927 2050 3337 3989 5729 2051 3337 3881 3989 2052 3337 3753 3881 2053 3848 1305 6361 2054 3848 6361 6035 2055 3848 4295 8457 2056 3848 8885 4295 2057 3848 8457 1305 2058 3848 6035 8885 2059 8457 801 5523 2060 8457 4295 801 2061 8457 231 1305 2062 8457 5523 231 2063 5273 6361 7238 2064 5273 4070 6361 2065 5273 7238 1688 2066 5273 1688 4070 2067 9644 6361 1305 2068 9644 1305 231 2069 9644 7238 6361 2070 9644 2540 4629 2071 9644 4629 7238 2072 9644 231 2540 2073 5496 7630 230 2074 5496 2703 7630 2075 5496 230 9629 2076 6681 2591 2227 2077 6681 2227 8913 2078 6681 3610 2591 2079 6681 8913 3610 2080 4904 1402 4528 2081 4904 4528 7704 2082 4904 7704 184 2083 4904 153 9853 2084 4904 184 153 2085 9895 9758 5023 2086 9895 438 9758 2087 9895 1932 9000 2088 9895 9000 438 2089 9895 5023 1932 2090 5947 1845 7974 2091 5947 7974 1082 2092 5947 4920 1845 2093 5947 7187 4920 2094 5947 1082 7187 2095 4379 1910 9693 2096 4379 9508 1910 2097 4379 4494 3061 2098 4379 3061 9508 2099 4379 1370 4494 2100 4379 9693 1370 2101 5710 4982 9299 2102 5710 9299 3722 2103 9703 9640 9174 2104 9703 5747 9640 2105 9703 2409 9299 2106 9703 9299 5747 2107 1110 5964 577 2108 1110 2743 5964 2109 1110 5786 2743 2110 1110 577 6078 2111 1110 5505 5786 2112 2876 7961 1081 2113 5526 2924 4846 2114 5526 4846 6538 2115 5526 6538 1099 2116 5526 1981 2924 2117 5526 1099 7506 2118 4391 2944 5807 2119 4391 5807 9083 2120 4391 9083 5287 2121 4391 7506 3016 2122 4391 3016 2944 2123 4391 5287 9045 2124 4160 4988 3318 2125 4160 3318 2565 2126 4160 2565 8320 2127 4160 8658 4988 2128 2181 3538 3318 2129 2181 907 3538 2130 2181 4988 5357 2131 2181 5357 907 2132 2181 3318 4988 2133 4608 7769 8658 2134 8211 1135 3284 2135 8211 3284 1576 2136 8211 1576 5388 2137 4589 1740 9186 2138 4589 9186 8193 2139 4589 6643 1740 2140 4589 8733 6643 2141 4589 8320 8733 2142 2565 3306 8320 2143 2565 3538 3306 2144 2565 3318 3538 2145 6236 4955 7162 2146 6236 6928 4955 2147 6236 7382 2314 2148 6236 7162 7382 2149 5458 6408 1511 2150 5458 9304 6408 2151 5458 1511 4196 2152 5458 4196 3560 2153 5458 3064 9304 2154 5458 3560 3064 2155 3064 173 1095 2156 3064 1095 9304 2157 6342 4641 1414 2158 6342 5644 4641 2159 6342 1414 7073 2160 6342 706 5644 2161 4196 5644 706 2162 4196 706 2323 2163 4196 9720 5644 2164 4196 1511 9720 2165 4196 2323 3560 2166 6358 473 5270 2167 6358 5689 473 2168 6358 7382 5689 2169 8907 1414 4641 2170 8907 7536 4725 2171 8907 4641 7536 2172 8195 1894 9001 2173 8195 9001 7998 2174 8195 3474 1894 2175 8195 6372 3474 2176 8195 7998 6372 2177 4954 1894 3474 2178 4954 5 1894 2179 4954 3474 7953 2180 4954 7536 5 2181 7837 1074 3020 2182 7837 3020 7402 2183 7837 1175 8817 2184 7837 8817 1074 2185 6241 1366 9186 2186 6241 9881 3747 2187 2997 9881 8761 2188 2997 8761 3989 2189 2997 3747 9881 2190 2997 729 8821 2191 2997 3881 729 2192 2997 8821 3747 2193 2997 3989 3881 2194 4057 729 1135 2195 4057 8821 729 2196 3284 1135 729 2197 3284 729 96 2198 3284 2621 1576 2199 9186 1740 6454 2200 9186 1366 8193 2201 8915 9434 7439 2202 8915 7439 806 2203 8915 2700 737 2204 8915 737 9434 2205 3735 8249 2410 2206 3735 4241 8249 2207 3735 2410 9560 2208 9560 2946 1340 2209 9560 1340 5077 2210 9560 2410 2946 2211 9560 5077 4107 2212 4101 9533 7916 2213 4101 7916 9805 2214 4101 9805 9764 2215 4101 3591 9533 2216 4101 9764 1757 2217 1369 1757 9764 2218 1369 9764 9190 2219 1369 9190 2306 2220 1369 2306 8667 2221 346 6928 45 2222 346 2214 6928 2223 346 45 2946 2224 346 2410 2741 2225 346 2946 2410 2226 346 2741 2214 2227 2880 96 6632 2228 2880 6632 4983 2229 2880 3287 937 2230 2880 4983 3287 2231 44 937 3287 2232 3486 7767 7769 2233 3200 1101 2004 2234 3200 8778 1101 2235 6810 6871 9302 2236 6810 5217 6871 2237 6810 9302 6979 2238 6810 6979 2271 2239 6810 8871 8788 2240 6810 8788 5217 2241 6810 1128 8871 2242 6810 2271 1128 2243 3707 5217 7991 2244 3707 9729 5217 2245 3707 7814 4314 2246 3707 7991 7814 2247 3707 4314 9729 2248 4371 3257 1900 2249 4371 5255 3257 2250 4371 5663 7563 2251 4371 7563 5255 2252 4371 1900 5663 2253 2245 8452 7563 2254 2245 7563 5663 2255 2245 6256 9749 2256 2245 1900 6256 2257 2245 5663 1900 2258 6256 6059 9749 2259 6256 1900 3257 2260 6256 3257 2790 2261 6256 2790 9729 2262 6256 9729 6059 2263 5167 9470 5013 2264 5167 1905 9470 2265 5167 5013 9803 2266 5167 9803 1905 2267 787 8989 9891 2268 787 9891 1718 2269 787 1718 6142 2270 787 6142 8989 2271 9891 3081 8513 2272 9891 8513 36 2273 9891 8989 3081 2274 3385 1763 3864 2275 3385 2417 1763 2276 3385 36 2417 2277 3385 3864 1718 2278 523 1852 2114 2279 523 2114 6662 2280 523 1873 1852 2281 523 90 1873 2282 523 6662 90 2283 8919 4627 4357 2284 8919 4357 8796 2285 8919 5832 4627 2286 8919 757 6347 2287 8919 6347 5832 2288 8919 2866 757 2289 8919 8796 2866 2290 7845 8509 6347 2291 7845 6347 757 2292 7845 757 7039 2293 7845 7039 7515 2294 7845 7515 8509 2295 4987 1885 5225 2296 4987 5225 6221 2297 4987 6221 3336 2298 4987 3336 7567 2299 4987 7567 1927 2300 3844 7865 6637 2301 3844 6179 4159 2302 3844 4159 7865 2303 7148 3882 6109 2304 7148 7345 3882 2305 7148 6109 7057 2306 6901 1970 8252 2307 6901 8498 1970 2308 6901 8252 6794 2309 6901 5072 8498 2310 6901 9496 5072 2311 9451 7004 9496 2312 9451 8204 7004 2313 9451 8077 8204 2314 391 2138 4474 2315 391 4474 6042 2316 391 6042 1169 2317 391 1169 6525 2318 391 6525 5419 2319 3568 2693 2138 2320 6503 2533 9458 2321 6503 3377 2533 2322 6503 6231 5072 2323 6503 9458 6231 2324 6503 5072 2138 2325 6503 2138 2693 2326 8242 7114 6075 2327 8242 4645 7114 2328 8242 6075 3377 2329 5024 6042 8493 2330 5024 1169 6042 2331 5024 8493 8580 2332 3338 6665 673 2333 3338 673 975 2334 3338 975 2523 2335 4639 6580 6222 2336 4639 1154 6580 2337 4639 6222 2537 2338 4639 9356 6520 2339 4639 2537 9356 2340 4639 6520 6146 2341 4639 6146 7157 2342 4639 7157 1154 2343 3171 4811 1459 2344 3171 1459 2400 2345 2659 1209 7242 2346 2659 4635 1209 2347 2659 7246 4635 2348 2659 7780 7694 2349 2659 5771 7780 2350 2659 7242 5771 2351 2659 7694 2275 2352 6218 6169 9293 2353 6141 8051 8882 2354 6141 8882 4780 2355 6141 3361 8051 2356 5031 3060 8051 2357 5031 1262 3060 2358 5031 5313 1262 2359 6947 1902 8818 2360 6947 1209 1902 2361 6947 9293 4008 2362 6947 4008 1209 2363 6947 2500 9293 2364 8048 8818 1902 2365 8048 1902 7329 2366 8048 7329 436 2367 8048 436 9007 2368 2699 8486 4663 2369 2699 3546 8486 2370 8861 7276 4226 2371 8861 1525 7276 2372 8861 3241 1525 2373 8861 5833 3241 2374 8861 5126 5833 2375 8861 5051 5126 2376 8861 4226 5051 2377 5420 5051 4226 2378 9812 1049 2239 2379 2739 5113 870 2380 2739 870 8625 2381 2739 8625 2239 2382 2739 2239 1049 2383 8812 4546 843 2384 8812 3091 4546 2385 8812 843 3201 2386 2553 6604 6190 2387 2553 6190 4303 2388 2553 3201 8630 2389 2553 8630 6604 2390 798 3757 8112 2391 798 8112 927 2392 798 7908 4221 2393 798 927 7908 2394 9548 1969 8832 2395 9548 8729 1969 2396 9548 8832 1864 2397 9548 1864 9322 2398 9548 9322 8729 2399 9865 1416 1308 2400 9865 3908 1416 2401 9865 1308 6556 2402 9865 1739 3656 2403 9865 3656 3908 2404 9865 6556 1739 2405 27 1739 6556 2406 27 6556 6214 2407 27 1969 1739 2408 27 6214 657 2409 9005 8729 3236 2410 9005 3236 977 2411 9005 1739 1969 2412 9005 3656 1739 2413 9005 1969 8729 2414 9005 977 3656 2415 7535 3622 686 2416 7535 9977 3622 2417 7535 686 3530 2418 4257 8112 3757 2419 4257 1622 8112 2420 4257 3530 1622 2421 6068 4098 3294 2422 6068 3851 4098 2423 6068 8379 3851 2424 6068 3294 711 2425 6068 711 8379 2426 6551 3431 5061 2427 6551 5061 8804 2428 6551 690 3431 2429 6551 2229 8588 2430 6551 8804 2229 2431 432 1943 3869 2432 432 8869 1943 2433 432 7140 8869 2434 2403 886 896 2435 2403 896 3972 2436 731 690 1347 2437 2152 885 7917 2438 886 3260 896 2439 886 8765 3260 2440 4541 7182 8765 2441 4541 4023 7182 2442 8000 8765 7182 2443 8987 2276 5968 2444 9284 8867 516 2445 9284 516 2276 2446 9284 7508 8867 2447 9284 9736 7508 2448 3837 1547 5096 2449 3837 6573 1547 2450 3837 4273 4489 2451 3837 4489 6573 2452 3837 5096 4273 2453 3003 5410 4273 2454 3003 5643 5410 2455 3003 4273 5096 2456 3003 1547 163 2457 3003 5096 1547 2458 3003 9402 5643 2459 5547 2318 3133 2460 5547 3133 7109 2461 5547 7109 8743 2462 5547 8743 5410 2463 5547 5410 9135 2464 5547 9135 2318 2465 4108 7889 2858 2466 4108 2229 7889 2467 4108 2858 9148 2468 7889 9443 3767 2469 7889 7821 9443 2470 7889 9985 2858 2471 7889 3767 9985 2472 7889 2229 8804 2473 7889 8804 7821 2474 6916 2555 9936 2475 6916 9936 1004 2476 6916 3433 2555 2477 6916 5417 3433 2478 6916 3789 5417 2479 6916 1004 3789 2480 7509 5731 3859 2481 7509 8451 5731 2482 6182 2464 9270 2483 6182 5906 2464 2484 6182 6158 5906 2485 6182 7421 3332 2486 6182 8292 7421 2487 6182 3332 6158 2488 6182 9270 8292 2489 3332 8516 3193 2490 3332 3835 8516 2491 3332 3657 3835 2492 3332 3193 6158 2493 3332 7421 3657 2494 1412 21 4105 2495 1412 5227 21 2496 1412 7750 5227 2497 1412 8702 7750 2498 1412 4261 8702 2499 1412 4105 4261 2500 8272 8702 4261 2501 8272 4261 5253 2502 8272 5253 7750 2503 8272 7750 8702 2504 1034 9767 2269 2505 1034 2269 6440 2506 1034 1608 9767 2507 1608 6150 6334 2508 1608 6334 9767 2509 6309 2164 4276 2510 6309 4276 1587 2511 6309 1587 2269 2512 3781 490 1610 2513 3781 6150 490 2514 3781 6334 6150 2515 3781 1610 6594 2516 3781 2269 9767 2517 3781 9767 6334 2518 586 4740 8881 2519 9351 2538 6906 2520 2325 260 5658 2521 7317 6177 1152 2522 7671 1093 5591 2523 9674 5808 6077 2524 9674 2078 5808 2525 9674 2020 2078 2526 9674 6077 9466 2527 9674 9466 2020 2528 8621 6839 265 2529 4650 4279 2539 2530 4650 625 4279 2531 4650 2539 1086 2532 1952 1633 1642 2533 1952 1231 1633 2534 1952 1642 5658 2535 1924 185 6860 2536 1924 9559 185 2537 3623 9404 1285 2538 3623 1285 3679 2539 3623 3679 3672 2540 1285 9404 1126 2541 1285 1126 3679 2542 5453 255 8248 2543 2346 953 4642 2544 2346 4642 623 2545 2346 623 868 2546 2346 868 5630 2547 868 623 7648 2548 868 7648 4516 2549 2343 127 1441 2550 3190 1441 127 2551 7217 4279 8878 2552 5213 1153 6664 2553 5213 6664 3973 2554 5213 3973 7658 2555 5213 9205 1153 2556 5213 8340 9205 2557 5213 7658 2539 2558 2176 8340 1699 2559 2176 1699 9515 2560 6664 7898 3973 2561 2064 3748 2099 2562 2064 2099 3832 2563 2064 3832 8042 2564 7098 5874 7801 2565 7098 7734 5874 2566 7098 6013 74 2567 7098 7801 6013 2568 7098 74 704 2569 7098 704 7734 2570 5242 4620 6229 2571 439 326 1246 2572 5333 58 2930 2573 5333 2930 2236 2574 6991 8589 3034 2575 6991 112 8589 2576 6991 5171 112 2577 6694 4864 7717 2578 6694 7717 376 2579 8810 6909 5741 2580 8810 4184 6909 2581 8810 5741 6039 2582 8810 5215 4184 2583 5448 2174 9522 2584 5448 9522 2173 2585 5448 2173 5406 2586 8763 7877 2516 2587 54 5140 3043 2588 54 3043 4353 2589 380 4084 8004 2590 380 8004 7358 2591 380 7770 8406 2592 380 7358 7770 2593 339 5303 1686 2594 339 1686 5080 2595 339 5080 5928 2596 638 8523 2468 2597 638 2378 8523 2598 8444 3596 1395 2599 8444 8266 3596 2600 8444 7058 3033 2601 8444 3033 8266 2602 8444 7237 3783 2603 8444 1395 7237 2604 8444 3783 7058 2605 5436 364 4025 2606 5436 7175 364 2607 1439 2479 2820 2608 1439 2820 2378 2609 1439 4025 2479 2610 5394 6312 493 2611 5394 493 7805 2612 5394 5895 3783 2613 5394 3783 7237 2614 5394 7805 5895 2615 5394 7237 6312 2616 3776 8333 3102 2617 3776 3102 490 2618 3776 174 3025 2619 3776 3025 8333 2620 3776 3088 174 2621 3776 490 3088 2622 3397 9301 2923 2623 9301 174 3088 2624 1502 204 6424 2625 1502 6424 389 2626 1502 6315 204 2627 1502 389 174 2628 1502 8022 6315 2629 6287 3025 174 2630 6287 2783 3025 2631 6287 174 389 2632 6287 389 9908 2633 6287 9908 8511 2634 6287 8511 9461 2635 6287 9461 2783 2636 1564 9340 8351 2637 1564 9032 9340 2638 1564 3102 9032 2639 1564 8351 3102 2640 9340 7377 8932 2641 9340 3596 7377 2642 6750 3102 5752 2643 2414 5104 3240 2644 2414 5177 5104 2645 2414 3240 5671 2646 2735 2365 2715 2647 2735 2372 2365 2648 2735 5671 8974 2649 2735 7939 5671 2650 2735 2715 7939 2651 2735 8974 9009 2652 2735 9009 2372 2653 3199 7503 7768 2654 3199 7768 6587 2655 3199 6587 2939 2656 9244 2939 6587 2657 9244 5671 2939 2658 6237 9634 2853 2659 6237 3899 9634 2660 413 7439 9623 2661 413 2791 7439 2662 413 9623 9401 2663 413 9401 2791 2664 9552 4613 3947 2665 9552 9469 4613 2666 9552 8822 2244 2667 9552 2244 9469 2668 9552 3947 8822 2669 6278 7976 1360 2670 6278 1985 7976 2671 6278 1100 1985 2672 8120 6966 5283 2673 8120 6648 6966 2674 8120 7994 3489 2675 8120 3489 6648 2676 8120 5283 7994 2677 3489 7994 6101 2678 3489 6101 1963 2679 3489 1963 6648 2680 2017 9403 6547 2681 2017 7017 9403 2682 2017 6547 7017 2683 3797 9257 6165 2684 3797 5145 9257 2685 3797 8768 5145 2686 3797 2786 8768 2687 2167 5552 9903 2688 2167 8133 2089 2689 2167 8582 8133 2690 2167 9903 8582 2691 4099 6711 2384 2692 4099 2384 6856 2693 4099 6856 4166 2694 4099 9492 3768 2695 4099 5921 9492 2696 4099 4166 5921 2697 4099 3768 6711 2698 3456 2629 8710 2699 3456 1108 2629 2700 3456 6517 1108 2701 3456 6247 3577 2702 3456 3577 6517 2703 122 4671 6754 2704 122 6754 7035 2705 122 7035 8008 2706 1298 1214 7852 2707 1298 7852 407 2708 1298 407 6007 2709 1298 6007 1849 2710 1298 1087 9966 2711 1298 9966 1214 2712 5712 2286 6789 2713 5712 2058 2286 2714 5712 6789 2389 2715 5712 2389 2319 2716 5712 2319 2058 2717 9146 3457 3379 2718 9146 3379 8764 2719 9146 7893 3457 2720 9641 4387 5784 2721 9641 5891 4387 2722 5447 7937 6536 2723 5447 6536 1249 2724 8676 5902 9024 2725 8676 9024 7448 2726 8676 460 8769 2727 8676 8769 5902 2728 1913 4548 5084 2729 1913 5084 7553 2730 7227 3497 5540 2731 7227 4603 3497 2732 4603 7101 9697 2733 4603 9502 7101 2734 4603 9697 359 2735 4603 359 3497 2736 359 9697 8091 2737 359 2658 5540 2738 359 5540 3497 2739 359 8091 2658 2740 5540 2658 7772 2741 5540 7772 8334 2742 3455 2340 7875 2743 3455 7875 1026 2744 3455 1026 6652 2745 3455 6652 5878 2746 3455 2751 8009 2747 3455 8009 2340 2748 3455 5878 8144 2749 8144 5878 7573 2750 8144 9505 1111 2751 8144 7573 9505 2752 9678 1540 2015 2753 2742 4059 6983 2754 6791 4227 83 2755 4313 5969 2564 2756 4490 7337 7093 2757 4490 7093 660 2758 4490 660 7394 2759 4490 1203 7337 2760 4989 7394 6527 2761 4989 6527 4512 2762 4989 4512 7520 2763 4989 7520 229 2764 6999 229 7520 2765 6999 7520 3290 2766 6999 3290 2869 2767 8704 7888 3802 2768 8704 2882 7888 2769 8704 9568 2882 2770 8704 3802 7550 2771 4622 6851 2312 2772 4622 9094 6851 2773 4622 5180 4874 2774 4622 4874 9094 2775 4622 6292 5180 2776 4622 2312 6292 2777 5180 3090 2243 2778 5180 1359 3090 2779 5180 2243 4874 2780 5190 8653 1934 2781 5190 1934 9950 2782 5190 9950 7007 2783 5190 7007 8570 2784 6774 8570 7007 2785 6774 7007 6396 2786 6774 4570 3810 2787 6774 3810 735 2788 6774 735 993 2789 6774 993 8570 2790 6774 6396 4570 2791 3690 860 2682 2792 3690 2682 6341 2793 3690 1661 860 2794 3690 9863 1661 2795 3690 6341 9863 2796 9310 8069 8711 2797 9310 4642 8069 2798 9310 8098 4642 2799 7279 8549 9319 2800 7279 8711 8549 2801 85 8492 4031 2802 85 4031 7390 2803 85 7390 4044 2804 85 3406 8492 2805 85 888 3406 2806 85 9279 888 2807 85 4127 9279 2808 85 4044 4127 2809 8065 8186 7758 2810 8065 7758 7228 2811 8065 7228 3528 2812 1771 7211 4894 2813 1771 8186 7211 2814 1771 3643 4424 2815 1771 4894 3643 2816 1771 4424 4871 2817 1771 4871 8186 2818 5544 4719 6931 2819 5544 3205 4719 2820 5544 6931 3292 2821 5544 3292 3651 2822 5544 3651 3205 2823 2656 5185 4505 2824 2656 4505 8948 2825 2656 3821 5185 2826 2656 5251 3821 2827 2656 8948 5251 2828 139 7968 7605 2829 139 2367 7968 2830 139 7605 8205 2831 5898 2037 1078 2832 5898 1078 7048 2833 5898 4978 2037 2834 3637 2320 4514 2835 3637 4514 7136 2836 3637 7136 8205 2837 7739 7712 7721 2838 7739 2367 7712 2839 7739 7721 7327 2840 3923 6737 1048 2841 3923 7327 475 2842 3923 475 6737 2843 202 7461 3665 2844 202 3665 8078 2845 202 1078 2178 2846 202 2178 7461 2847 202 8078 1078 2848 723 7721 7712 2849 6762 8701 9655 2850 6762 3108 8701 2851 6762 9480 3108 2852 6780 2531 5392 2853 6780 5392 9161 2854 7356 341 8681 2855 7356 8163 341 2856 7356 5398 8163 2857 7356 8681 7502 2858 2324 7866 5340 2859 2324 5340 2582 2860 2324 8681 7866 2861 1408 5558 5398 2862 1408 613 5558 2863 2384 3298 9172 2864 2384 9172 3211 2865 2384 6711 3298 2866 2384 3211 6856 2867 8774 4442 3030 2868 8774 3030 6829 2869 8774 6711 6797 2870 8774 6829 6711 2871 8774 6797 4442 2872 2901 6030 3632 2873 6030 5280 8927 2874 3248 2182 2737 2875 3248 4454 2182 2876 3788 5729 113 2877 3788 113 4970 2878 3788 4970 9446 2879 3788 9446 3753 2880 3788 2566 5729 2881 3753 9446 4454 2882 3753 8927 5280 2883 3753 5280 3881 2884 6035 4121 8577 2885 6035 8577 8885 2886 6035 6361 4121 2887 4629 730 2166 2888 4629 4951 730 2889 4629 7341 4951 2890 4629 9629 7341 2891 4629 2540 9629 2892 4629 1025 7238 2893 4629 2166 1025 2894 7238 1025 7513 2895 7238 7513 1688 2896 1025 9710 7264 2897 1025 2166 9710 2898 1025 7264 7513 2899 9629 4431 4601 2900 9629 4601 5939 2901 9629 5939 7341 2902 9629 230 4431 2903 2591 8291 2227 2904 2591 4697 8291 2905 2591 7264 9710 2906 2591 3610 7264 2907 2591 9710 4697 2908 9109 6394 2938 2909 9109 2938 4075 2910 9109 4075 2666 2911 9147 467 7380 2912 9147 7380 4841 2913 9147 272 8508 2914 9147 4841 272 2915 9147 8508 467 2916 1932 3000 9000 2917 1932 5023 3000 2918 1845 7610 5023 2919 1845 4920 7610 2920 1845 9758 7974 2921 1845 5023 9758 2922 4494 1370 6450 2923 4494 6450 1283 2924 4494 1283 4222 2925 4494 4222 3061 2926 9746 1689 4769 2927 9746 3320 1714 2928 9746 1714 302 2929 9746 4769 3320 2930 1714 3320 5432 2931 1714 5373 302 2932 3722 2409 5373 2933 3722 9299 2409 2934 8787 5635 8250 2935 8787 8250 4066 2936 2409 302 5373 2937 4982 1890 5747 2938 4982 4202 1890 2939 4982 5747 9299 2940 4982 2714 671 2941 4982 671 4202 2942 2714 6078 671 2943 393 1667 8992 2944 393 8992 13 2945 393 4538 2924 2946 393 2924 1667 2947 393 6512 4538 2948 393 13 6512 2949 5142 1667 1981 2950 5142 4148 1667 2951 5142 9045 4723 2952 5142 1981 9045 2953 5142 4723 4148 2954 9045 3164 4723 2955 9045 4 3164 2956 9045 5287 4 2957 7506 1099 3016 2958 9307 7243 2835 2959 9307 2835 1315 2960 9307 1315 8476 2961 9307 19 8256 2962 9307 8476 19 2963 9307 4375 7243 2964 9307 4709 4375 2965 9307 8256 4709 2966 7871 9884 8656 2967 7871 8656 912 2968 7871 5507 3127 2969 7871 3127 9884 2970 7871 912 5507 2971 4988 4980 5357 2972 4988 8658 4980 2973 7769 7767 2004 2974 7769 2004 4980 2975 7769 4980 8658 2976 3306 8733 8320 2977 3306 3964 8733 2978 3306 1656 3964 2979 3306 8038 1656 2980 3306 3538 5000 2981 3306 5000 8038 2982 507 5229 2640 2983 507 6680 5229 2984 507 2640 9704 2985 507 9704 6680 2986 2840 2253 9984 2987 2840 9984 8839 2988 2840 8667 2253 2989 2840 8839 8778 2990 7162 5689 7382 2991 7162 5021 5689 2992 7162 7775 5021 2993 7162 4955 7775 2994 1414 9416 7073 2995 473 5689 3287 2996 3560 2323 173 2997 5644 9720 4641 2998 6372 7953 3474 2999 9916 7585 3075 3000 9916 7953 1008 3001 5 191 1894 3002 5 6232 191 3003 5 7536 6232 3004 8657 1074 145 3005 8657 145 9001 3006 8657 3020 1074 3007 8657 9001 3020 3008 7585 737 3075 3009 1881 9140 6073 3010 1881 6454 9140 3011 1881 6073 9881 3012 2700 1814 511 3013 2700 7915 737 3014 7823 1692 518 3015 7823 3745 1692 3016 7823 518 511 3017 7823 511 1814 3018 7823 1814 5403 3019 7823 5403 1360 3020 7823 1360 3745 3021 5695 6136 45 3022 5695 1692 6136 3023 5695 45 6928 3024 5695 6928 518 3025 5695 518 1692 3026 2410 8249 2741 3027 6820 8981 2554 3028 6820 2554 31 3029 6820 1340 2946 3030 6820 2946 45 3031 6820 31 1340 3032 6928 2214 4955 3033 1101 9715 5357 3034 1101 5357 2004 3035 1101 8778 9715 3036 6752 2679 7456 3037 6752 9590 2679 3038 6752 2429 9590 3039 6752 7456 2429 3040 2519 2429 4441 3041 2519 4441 5156 3042 2519 2374 2429 3043 2519 9132 2374 3044 2519 3915 9132 3045 2519 5156 3915 3046 1128 2271 780 3047 1128 3072 8871 3048 1128 780 3072 3049 3072 1559 1529 3050 3072 1529 8871 3051 3072 780 4093 3052 3072 4093 539 3053 3072 539 294 3054 3072 294 1559 3055 4314 7814 3142 3056 4314 3142 819 3057 4314 819 5090 3058 4314 5090 8976 3059 4314 8976 9729 3060 8452 9749 4618 3061 8452 4618 5161 3062 8452 5161 4971 3063 8452 4971 7563 3064 7563 9241 8315 3065 7563 4971 9241 3066 7563 6072 5255 3067 7563 8315 6072 3068 5013 8989 9803 3069 5013 3081 8989 3070 5013 7064 3081 3071 5013 7992 7064 3072 5013 9470 7992 3073 1718 3864 6142 3074 1852 9989 1361 3075 1852 1544 9989 3076 1852 1361 2114 3077 1852 1873 1544 3078 6662 6401 7825 3079 6662 7825 1580 3080 6662 1580 90 3081 6662 2114 6401 3082 3345 5501 7848 3083 3345 7848 4585 3084 3345 4585 2399 3085 3345 2399 404 3086 3345 404 5501 3087 5150 2494 2874 3088 5150 8227 2494 3089 5150 746 8227 3090 5150 2874 6477 3091 5150 6477 7515 3092 5150 7515 746 3093 8901 6347 8509 3094 8901 1509 6347 3095 8901 5210 1509 3096 8901 8509 5210 3097 757 2866 7039 3098 6571 4169 4243 3099 6571 8795 4169 3100 6571 1323 8795 3101 6571 4243 6761 3102 6571 6761 1323 3103 7074 4483 2942 3104 7074 5981 4483 3105 7074 9100 8934 3106 7074 2942 9100 3107 7074 8934 7867 3108 7074 7867 9781 3109 7074 9781 5981 3110 7567 3992 6179 3111 7567 3004 3992 3112 7567 3336 3004 3113 7567 6179 1927 3114 1889 8994 562 3115 1889 562 3684 3116 1889 3308 8994 3117 8012 7057 8252 3118 8012 8252 1970 3119 6010 2615 5548 3120 6010 6176 2615 3121 6010 6794 3909 3122 6010 5268 6794 3123 6010 5548 5268 3124 6010 3909 4052 3125 6010 4052 6176 3126 6109 8252 7057 3127 6109 6794 8252 3128 6109 3909 6794 3129 6109 3882 3909 3130 5168 884 9282 3131 5168 9282 9929 3132 5168 3209 884 3133 5168 7532 8187 3134 5168 9929 7532 3135 5168 8187 6223 3136 5168 6223 996 3137 5168 996 3209 3138 5072 6231 5025 3139 5072 4474 2138 3140 5072 7004 2885 3141 5072 2885 4474 3142 5072 5025 8498 3143 5072 9496 7004 3144 7531 7004 4058 3145 7531 4058 9326 3146 7531 6384 7004 3147 7531 9326 6384 3148 5419 6525 8684 3149 9458 874 4839 3150 9458 4839 6231 3151 9458 2533 874 3152 9684 9571 8860 3153 9684 8860 6623 3154 9684 6727 9571 3155 9684 2712 4833 3156 9684 1328 6727 3157 9684 6623 2712 3158 8449 4838 9700 3159 8449 406 8744 3160 8449 7221 406 3161 8449 3214 7221 3162 8449 9700 3214 3163 8580 936 4215 3164 8580 8493 936 3165 6665 8744 673 3166 6520 6522 8572 3167 6520 3356 6522 3168 6520 156 3356 3169 6520 9356 156 3170 6520 8572 6146 3171 4811 2084 2292 3172 4811 2292 1459 3173 3704 175 2072 3174 3704 2072 4248 3175 3704 8999 175 3176 3704 5927 8999 3177 2483 1651 4100 3178 2483 5028 1651 3179 2483 4755 2636 3180 2483 2636 5028 3181 2483 4100 4755 3182 2072 175 3266 3183 2072 3266 2122 3184 2072 2122 9771 3185 2072 9771 4248 3186 6371 3386 7246 3187 6371 2754 3386 3188 7694 4840 2275 3189 7694 1609 4840 3190 7694 7780 1609 3191 9293 6169 4008 3192 8051 3060 8882 3193 8625 138 926 3194 8625 870 138 3195 8625 926 2239 3196 5051 6837 5126 3197 5051 8439 6837 3198 966 1525 5988 3199 966 5988 3734 3200 966 8841 7633 3201 966 3734 8841 3202 2465 3709 4580 3203 2465 9683 3709 3204 2465 4580 2779 3205 2465 7141 4073 3206 2465 4073 3224 3207 2465 3224 9683 3208 2465 2779 7141 3209 3201 843 9191 3210 3201 9191 8630 3211 8154 6296 1416 3212 8154 5148 6296 3213 8154 840 2046 3214 8154 1416 840 3215 8154 2046 5148 3216 4221 2663 1085 3217 4221 7908 2663 3218 4221 9322 1864 3219 4221 1085 9322 3220 3656 977 6645 3221 3656 6645 3908 3222 8729 1407 3236 3223 8729 234 1407 3224 8729 9322 234 3225 3622 8296 2426 3226 3622 2426 686 3227 3622 6214 6556 3228 3622 6556 8296 3229 3622 9977 6214 3230 3530 3296 7089 3231 3530 686 3296 3232 3530 7089 1622 3233 3294 1416 6296 3234 3294 3911 1416 3235 3294 6296 711 3236 3294 4098 3911 3237 840 6645 4232 3238 840 4232 6173 3239 840 6173 2046 3240 840 1416 6645 3241 2721 722 6225 3242 2721 7102 722 3243 2721 6225 8023 3244 2721 8023 5294 3245 2721 5294 7102 3246 3972 3260 690 3247 3972 896 3260 3248 1347 690 3260 3249 1347 3260 8765 3250 7182 4023 9736 3251 3869 1943 6378 3252 3869 6378 109 3253 3869 109 899 3254 3639 2628 9454 3255 3639 4829 2628 3256 3639 6661 4829 3257 3639 5968 6661 3258 3639 9454 5968 3259 163 1547 8804 3260 163 8804 8323 3261 4273 5410 4489 3262 9402 7193 5643 3263 9402 4829 6661 3264 9402 6661 7193 3265 8743 7109 7745 3266 8743 7745 5410 3267 3133 2318 1527 3268 3133 1527 5236 3269 3133 6633 9575 3270 3133 9618 6633 3271 3133 7956 7109 3272 3133 9575 7956 3273 3133 5236 9618 3274 2858 8192 9725 3275 2858 9725 9148 3276 2858 2684 8192 3277 2858 9985 2684 3278 3767 9443 1832 3279 3767 1832 305 3280 3767 305 9985 3281 2555 9250 9936 3282 2555 3777 9250 3283 2555 3433 3777 3284 5731 8206 3859 3285 5731 9671 8206 3286 5731 8451 9671 3287 843 5520 9191 3288 843 9962 5520 3289 843 4546 9962 3290 5520 8630 9191 3291 5520 6501 8630 3292 5520 7714 6501 3293 5520 9962 6111 3294 5520 6111 6822 3295 5520 6822 7714 3296 5831 7736 3603 3297 5831 2896 7736 3298 5831 3603 1832 3299 5831 1832 9443 3300 5831 1598 3466 3301 5831 3466 2896 3302 5831 9443 1598 3303 1312 4938 8109 3304 1312 8109 6426 3305 1312 5212 2010 3306 1312 6426 5212 3307 1312 2010 4938 3308 763 1796 6353 3309 763 1165 1796 3310 763 6353 7273 3311 763 7273 1165 3312 8292 9270 9622 3313 8292 9622 2140 3314 8292 2140 9978 3315 8292 9978 7421 3316 7421 9978 2510 3317 7421 2510 3657 3318 5368 8591 3286 3319 5368 3286 2585 3320 5368 3835 3657 3321 5368 3657 9860 3322 5368 9860 8591 3323 5368 2585 3835 3324 3193 6321 6158 3325 3193 5602 6321 3326 3193 8516 5602 3327 572 1035 579 3328 572 252 1035 3329 572 579 9391 3330 572 9391 9948 3331 572 9948 252 3332 6594 1610 7768 3333 2164 5324 4276 3334 2164 8578 5324 3335 7378 8331 2847 3336 7378 21 8331 3337 7378 7367 5312 3338 7378 5312 5961 3339 7378 5961 21 3340 4105 5961 5610 3341 4105 21 5961 3342 4105 5610 4261 3343 123 9523 3886 3344 123 7593 9523 3345 123 5899 7593 3346 6387 4820 9863 3347 6387 9863 6341 3348 6387 5538 4820 3349 6387 3621 5538 3350 6387 6341 3621 3351 5538 3886 2097 3352 5538 2097 4820 3353 5538 21 5227 3354 5538 5227 3886 3355 5538 8331 21 3356 5538 4227 8331 3357 5538 3621 4227 3358 8212 1934 9863 3359 8212 6151 1934 3360 8212 4820 9875 3361 8212 9863 4820 3362 8212 9875 6151 3363 3111 8373 7826 3364 3111 9487 8373 3365 3111 2829 7466 3366 3111 7466 9487 3367 3111 7826 2829 3368 253 5312 7367 3369 253 2829 5312 3370 253 7789 2829 3371 7466 2829 3919 3372 7466 3919 195 3373 7466 3943 9487 3374 7466 195 3943 3375 9466 2032 2020 3376 1086 2539 7658 3377 1086 7658 10002 3378 1231 6963 5985 3379 1231 5985 1633 3380 1231 1956 6963 3381 3155 1510 1827 3382 9559 7385 185 3383 9404 4516 1126 3384 8878 4279 625 3385 8340 6860 1699 3386 1699 6860 9515 3387 7898 2066 3973 3388 7898 6153 2066 3389 6996 8148 386 3390 6996 386 3469 3391 6996 7251 5934 3392 6996 3469 7251 3393 3832 2099 6077 3394 3832 6077 5808 3395 3832 5808 9914 3396 3832 9914 1170 3397 3832 1170 8042 3398 1170 9914 2005 3399 1170 2005 4882 3400 5813 3251 4246 3401 5813 6469 3251 3402 5813 4246 4151 3403 5813 4151 6647 3404 5813 6647 2451 3405 5813 2451 6469 3406 2542 4477 661 3407 2542 3251 4477 3408 6963 1956 809 3409 6963 7734 5985 3410 6963 809 7734 3411 704 74 7364 3412 1592 7318 990 3413 1592 986 7318 3414 5189 3968 5014 3415 5189 4952 3968 3416 6229 998 9639 3417 6229 9639 5208 3418 6229 4620 998 3419 1246 4698 8219 3420 1246 326 4698 3421 8129 2236 3503 3422 8129 3503 5171 3423 3034 8589 7081 3424 3034 7081 8742 3425 3188 5632 906 3426 3188 5503 5632 3427 3188 906 2296 3428 3188 376 5503 3429 4864 6154 4877 3430 4864 4877 7717 3431 4864 8742 6154 3432 4740 9319 1561 3433 4740 1561 8881 3434 7819 5741 6909 3435 7819 6564 5741 3436 7819 6909 8267 3437 7819 8267 6564 3438 5215 3758 6792 3439 5215 990 3758 3440 5215 6792 4184 3441 5252 8219 4698 3442 5252 3359 8219 3443 5252 4698 2584 3444 5252 2584 7178 3445 5252 7178 3359 3446 7092 1303 2236 3447 7092 2236 2930 3448 7092 331 1303 3449 7092 2930 331 3450 2174 1303 331 3451 2174 8219 1303 3452 2174 331 2930 3453 2174 2930 9522 3454 6302 3965 8863 3455 8021 5258 8442 3456 8021 8442 8600 3457 8021 8863 5258 3458 8442 48 5140 3459 8442 396 48 3460 8442 9327 396 3461 8442 5258 9327 3462 6890 7632 3152 3463 6890 3152 983 3464 426 6742 849 3465 8406 7770 8770 3466 8406 3947 4613 3467 8406 4613 6742 3468 8406 8770 3947 3469 8406 6742 7632 3470 4510 1668 7333 3471 4510 7333 9617 3472 4510 4467 1668 3473 5928 5080 7333 3474 7097 9274 7306 3475 7097 7306 9188 3476 7097 5480 9053 3477 7097 9188 5480 3478 7097 9053 9274 3479 2820 9274 9053 3480 2820 2479 9274 3481 2820 9053 2378 3482 2468 8523 8462 3483 2468 8462 3978 3484 2468 3978 3001 3485 7058 3783 5895 3486 7058 5895 4179 3487 4025 364 2479 3488 7237 1395 4094 3489 7237 4094 6312 3490 8333 5752 3102 3491 8333 3025 5752 3492 490 7030 1610 3493 490 2357 7030 3494 490 3102 2357 3495 9860 3657 1826 3496 9860 1826 3053 3497 4631 5162 7220 3498 4631 7220 5899 3499 4631 6804 5162 3500 4631 5899 5553 3501 6440 2358 6804 3502 6440 2269 1587 3503 6440 1587 2358 3504 5162 4570 7220 3505 5162 8353 4570 3506 5162 2260 8353 3507 5162 6804 2260 3508 6424 204 9978 3509 6424 9978 2140 3510 6424 9908 389 3511 6424 2140 9908 3512 1125 5671 3240 3513 1125 8974 5671 3514 1125 3240 5104 3515 1125 5104 8974 3516 7377 3596 8266 3517 7377 8266 9617 3518 7377 9617 7333 3519 7377 7333 5177 3520 2715 2939 7939 3521 2939 5671 7939 3522 8620 2493 8981 3523 8620 1097 3295 3524 8620 8371 2493 3525 8620 3295 878 3526 3899 878 1097 3527 3899 1097 9634 3528 9401 9623 190 3529 9401 190 1786 3530 9401 1786 9469 3531 9401 9469 8967 3532 2244 8967 9469 3533 9469 1786 849 3534 9469 849 4613 3535 7994 5283 9634 3536 7994 9634 6101 3537 7012 9831 1077 3538 7012 989 9831 3539 7012 1077 7701 3540 7012 261 989 3541 7012 7701 4564 3542 7012 2936 7805 3543 7012 7805 261 3544 7012 5535 2936 3545 7012 4071 5535 3546 7012 4564 4071 3547 9403 674 6547 3548 9403 3080 674 3549 9403 9668 3080 3550 9403 7017 3223 3551 9403 3223 9668 3552 2089 8137 1849 3553 2089 1849 6858 3554 2089 8133 8137 3555 3768 6797 6711 3556 4671 9492 5921 3557 4671 5921 6754 3558 8133 615 8137 3559 8133 9426 615 3560 8133 8582 9426 3561 9966 6789 1214 3562 9966 2389 6789 3563 9966 1087 2389 3564 6789 5854 1214 3565 6789 2286 5854 3566 8554 5529 264 3567 8554 264 9970 3568 8554 2838 8579 3569 8554 9970 2838 3570 8554 8579 5529 3571 6433 692 2838 3572 6433 8188 692 3573 6433 1681 8188 3574 6433 2838 1681 3575 7893 264 5849 3576 7893 5849 3457 3577 6350 9184 5891 3578 7937 8443 6536 3579 7937 9906 8443 3580 8443 3302 6536 3581 460 5084 4548 3582 5902 8769 4354 3583 5902 4354 9024 3584 2751 9827 8009 3585 7553 176 8188 3586 7553 6955 176 3587 9441 4614 8489 3588 9441 8489 7271 3589 9441 7271 2025 3590 8091 7191 482 3591 8091 482 2658 3592 8091 4137 7191 3593 8091 9697 4137 3594 9073 6691 8715 3595 9073 8715 1478 3596 9073 5005 7468 3597 9073 4247 5005 3598 9073 1478 4247 3599 9073 7468 1573 3600 9073 1573 6691 3601 1627 4487 9827 3602 1627 4387 4487 3603 1627 5784 4387 3604 2340 8009 9827 3605 2340 9827 7875 3606 1111 9505 1540 3607 2015 8030 455 3608 2015 455 9738 3609 2015 6691 8030 3610 2015 1540 6691 3611 2015 9738 1255 3612 9505 4566 1140 3613 9505 3873 4566 3614 9505 8598 3873 3615 9505 7483 8598 3616 9505 7573 7483 3617 9505 8715 1540 3618 9505 1140 8715 3619 762 8309 7942 3620 762 3095 8309 3621 762 6656 6652 3622 762 7942 6656 3623 762 6652 1026 3624 762 1026 7875 3625 762 7875 3095 3626 7261 2882 4059 3627 7261 2682 2882 3628 4227 2847 8331 3629 4227 3621 83 3630 1203 7824 7337 3631 1203 8421 7824 3632 8421 9096 7824 3633 8421 4027 9096 3634 8421 2247 4027 3635 9096 9074 3887 3636 9096 3887 4173 3637 9096 4173 7337 3638 9096 7337 7824 3639 7337 4173 4677 3640 7337 4677 7093 3641 1248 9525 2516 3642 1248 2062 9525 3643 1248 9844 2062 3644 1248 2516 9844 3645 953 3119 7072 3646 953 4745 3119 3647 953 7072 4642 3648 953 7364 4745 3649 5248 3389 283 3650 5248 283 8376 3651 5248 8365 3389 3652 5248 8376 7449 3653 3046 2312 1027 3654 3046 7550 2312 3655 3046 9861 5905 3656 3046 1027 9861 3657 9568 4059 2882 3658 6292 2312 8365 3659 8570 993 5362 3660 9500 7408 8653 3661 9500 1661 7408 3662 9500 8653 8541 3663 9500 2154 860 3664 9500 860 1661 3665 9500 8541 2154 3666 860 2154 2682 3667 8711 8069 8549 3668 5610 1455 4261 3669 5610 7301 1455 3670 5610 5961 7301 3671 5312 7826 8373 3672 5312 8373 7301 3673 5312 2829 7826 3674 5312 7301 5961 3675 4127 1766 9279 3676 4127 8265 1766 3677 4127 4493 8265 3678 4127 1962 4493 3679 4127 4044 1962 3680 7758 4871 7228 3681 7758 8186 4871 3682 4424 6449 4871 3683 4424 5578 6449 3684 4424 2766 5578 3685 4424 3643 9455 3686 4424 9455 2766 3687 4894 7211 9345 3688 4894 9345 3643 3689 6931 4719 7855 3690 6931 7855 3292 3691 3821 3137 6600 3692 3821 7211 3137 3693 3821 6600 825 3694 3821 825 7855 3695 3821 7855 4719 3696 3821 4719 5185 3697 3821 5251 9345 3698 3821 9345 7211 3699 5251 8948 9345 3700 8205 7605 1915 3701 2037 7909 7088 3702 2037 7088 2178 3703 2037 2178 1078 3704 2320 5997 4514 3705 2320 5929 5997 3706 7605 7968 7640 3707 7605 7640 8741 3708 7605 8741 1915 3709 7088 3669 8468 3710 7088 7909 3669 3711 7088 7461 2178 3712 7088 7311 7461 3713 7088 8468 7311 3714 1078 7164 7048 3715 1078 8078 7164 3716 7461 4319 3665 3717 7461 7311 4319 3718 919 9921 7048 3719 919 7048 4770 3720 919 4770 8831 3721 919 8831 6486 3722 919 6486 9921 3723 8425 9334 9350 3724 8425 1758 9334 3725 8425 1194 1758 3726 8425 6486 1194 3727 8425 2487 9921 3728 8425 9350 2487 3729 8425 9921 6486 3730 1456 9495 825 3731 1456 825 6600 3732 1456 9325 9495 3733 1456 9774 9325 3734 1456 6600 9774 3735 2531 8805 5392 3736 8979 9499 6369 3737 8979 6369 177 3738 9655 8701 915 3739 8681 341 7866 3740 5398 5558 8163 3741 6041 1601 6443 3742 6041 3928 1601 3743 6041 1775 8403 3744 6041 8403 3928 3745 6041 1292 1775 3746 6041 6443 1292 3747 9409 4604 590 3748 9409 590 8394 3749 9409 91 7103 3750 9409 8960 91 3751 9409 7103 4604 3752 9409 8394 8960 3753 6856 6204 4166 3754 6856 3754 6204 3755 6856 3211 3754 3756 6711 6829 3298 3757 4442 2496 3134 3758 4442 3134 3030 3759 4442 3808 2496 3760 2448 9348 1198 3761 2448 1198 5880 3762 2448 5345 9348 3763 2448 5880 4165 3764 2448 1560 6768 3765 2448 4165 1560 3766 2448 6768 5345 3767 2737 2000 454 3768 2737 8063 2000 3769 2737 2182 8063 3770 6693 6686 228 3771 6693 228 2050 3772 6693 1535 9787 3773 6693 2050 1535 3774 6693 9787 4139 3775 6693 4139 6686 3776 628 1375 2637 3777 628 2637 1054 3778 628 1054 1066 3779 628 6686 4139 3780 628 1066 6686 3781 628 4139 9787 3782 628 9787 1375 3783 6361 4070 4121 3784 5523 2540 231 3785 9428 924 1811 3786 9428 1811 2211 3787 9428 2211 3213 3788 9428 3213 5918 3789 9428 5918 924 3790 9710 730 3213 3791 9710 3213 4697 3792 9710 2166 730 3793 4431 9713 4601 3794 4431 2894 9713 3795 4431 285 2894 3796 4431 3309 285 3797 4431 230 3309 3798 2633 7483 2688 3799 2633 2688 7215 3800 2633 8598 7483 3801 2633 7215 8598 3802 153 2664 9853 3803 153 7668 2664 3804 153 184 7668 3805 8508 2664 467 3806 8508 7829 2664 3807 8508 3695 7829 3808 8508 272 3695 3809 9000 361 438 3810 9000 3000 361 3811 7974 9758 5756 3812 7974 5756 5790 3813 7974 5790 1082 3814 5023 7610 3000 3815 1868 9758 1184 3816 1868 497 9758 3817 1868 1184 497 3818 9693 9751 5650 3819 9693 6076 9751 3820 9693 1910 6076 3821 9693 1091 1370 3822 9693 5650 1091 3823 1370 4687 6450 3824 1370 1091 4687 3825 2822 1030 3584 3826 2822 3584 1349 3827 2822 536 7726 3828 2822 7726 9912 3829 2822 1349 536 3830 2822 9912 1030 3831 8423 9174 196 3832 8423 3459 1689 3833 8423 196 3459 3834 5635 5432 8250 3835 6078 577 3600 3836 6078 3600 671 3837 577 5964 3600 3838 4538 6512 2924 3839 1981 1667 2924 3840 1878 5807 2944 3841 1878 2354 5807 3842 1878 2944 2569 3843 1878 2569 2354 3844 8384 9015 1821 3845 8384 1585 9015 3846 8384 1821 1689 3847 8384 1689 3459 3848 8384 3459 1585 3849 2527 5432 3999 3850 2527 8250 5432 3851 2527 9507 7454 3852 2527 3999 9507 3853 2527 7454 8250 3854 8896 4321 2120 3855 8896 2457 4321 3856 8896 3164 8624 3857 8896 2120 3164 3858 8896 8624 1213 3859 8896 1213 2457 3860 3299 1742 2646 3861 3299 9015 1742 3862 3299 2646 6388 3863 3299 6388 2457 3864 3299 2457 1213 3865 3299 1213 9015 3866 8624 1821 9015 3867 8624 9507 1821 3868 8624 9015 1213 3869 8624 3164 7454 3870 8624 7454 9507 3871 6045 5687 3307 3872 6045 9707 5687 3873 6045 4383 9707 3874 6045 3307 4383 3875 9333 7696 2962 3876 9333 2962 3667 3877 9333 3667 2252 3878 9333 1114 6558 3879 9333 6558 7696 3880 9333 2252 1114 3881 8256 8006 4709 3882 8256 19 9247 3883 8256 9247 8006 3884 8476 1315 8806 3885 8476 8806 7779 3886 8476 7779 1452 3887 8476 6336 19 3888 8476 1452 6336 3889 5507 4511 5179 3890 5507 5179 3127 3891 5507 1238 4511 3892 5507 912 1238 3893 9884 1174 8656 3894 9884 3127 4496 3895 9884 4496 1174 3896 7639 8410 2640 3897 7639 2640 5229 3898 7639 3964 8410 3899 7639 9773 1740 3900 7639 1740 6643 3901 7639 5229 9773 3902 7639 6643 3964 3903 9773 2617 1740 3904 9773 3569 2617 3905 9773 5229 3569 3906 8733 3964 6643 3907 5357 9715 907 3908 5357 4980 2004 3909 3538 9070 5000 3910 3538 3221 9070 3911 3538 7118 3221 3912 3538 907 7118 3913 907 9715 7376 3914 907 7376 7118 3915 2640 8410 4384 3916 2640 4384 9704 3917 6987 5648 9516 3918 6987 9516 1260 3919 6987 3257 5255 3920 6987 1260 3257 3921 6987 5255 7606 3922 6987 7606 3571 3923 6987 3571 5648 3924 6614 8839 7795 3925 6614 7795 9227 3926 6614 9227 7376 3927 6614 8778 8839 3928 6614 9715 8778 3929 6614 7376 9715 3930 2253 8673 1151 3931 2253 1151 9984 3932 2253 8667 8673 3933 6632 96 729 3934 6632 729 8898 3935 6632 8870 4983 3936 6632 8898 8870 3937 1511 6408 7266 3938 1511 7266 9720 3939 3068 6408 9304 3940 3068 9304 191 3941 3068 7266 6408 3942 3068 191 7266 3943 173 1860 1095 3944 173 2323 1860 3945 706 454 2323 3946 7536 7275 6232 3947 7536 4641 7275 3948 9434 190 9623 3949 9434 2355 190 3950 9434 9623 7439 3951 9434 737 2355 3952 9099 737 755 3953 9099 2355 737 3954 9099 755 849 3955 9099 849 1786 3956 9099 1786 2355 3957 1074 8817 145 3958 3075 737 7915 3959 9881 6073 8761 3960 8761 6073 492 3961 8761 492 9159 3962 8761 9159 2129 3963 8761 2129 7130 3964 8761 7130 873 3965 8761 873 3989 3966 1692 3745 6136 3967 8507 9092 2977 3968 8507 8862 9092 3969 8507 6635 8862 3970 8507 5077 6635 3971 8507 2977 4107 3972 8507 4107 5077 3973 6635 1340 31 3974 6635 31 4409 3975 6635 4409 8862 3976 6635 5077 1340 3977 4668 487 4241 3978 4668 7775 487 3979 8249 487 2741 3980 8249 4241 487 3981 2429 2374 9590 3982 2429 7456 4441 3983 780 2271 4093 3984 4093 2271 535 3985 4093 535 539 3986 7664 6059 8976 3987 7664 4618 6059 3988 7664 8976 8348 3989 7664 8348 4618 3990 5090 8348 8976 3991 5090 4417 8348 3992 5090 9581 4417 3993 5090 8418 9581 3994 5090 7470 8418 3995 5090 8800 7470 3996 5090 819 8800 3997 7814 1019 653 3998 7814 5164 1019 3999 7814 653 3142 4000 7814 9509 5164 4001 7814 7991 9509 4002 7064 7492 7169 4003 7064 4794 7492 4004 7064 7992 4794 4005 7064 8513 3081 4006 7064 7169 8513 4007 9803 8989 6142 4008 9803 6142 5568 4009 9803 2697 4329 4010 9803 5568 2697 4011 9803 4329 1905 4012 3864 1361 4902 4013 3864 4902 6142 4014 3864 6401 1361 4015 3864 1763 6401 4016 2114 1361 6401 4017 404 1423 8220 4018 404 2399 1423 4019 404 7398 1336 4020 404 8220 7398 4021 404 1336 5501 4022 5504 9718 5776 4023 5504 5776 2501 4024 5504 2501 9579 4025 5504 9026 9718 4026 5504 9579 9026 4027 2874 2494 7319 4028 2874 7319 6477 4029 1264 8487 6051 4030 1264 6051 2348 4031 1264 8509 7515 4032 1264 7515 8487 4033 1264 4332 8509 4034 1264 2348 4332 4035 1509 5490 5304 4036 1509 5740 5490 4037 1509 3700 6347 4038 1509 5304 3700 4039 1509 5210 5740 4040 2866 5608 7039 4041 2866 8796 5608 4042 7288 1494 354 4043 7288 2280 1494 4044 7288 354 4258 4045 7288 4169 8502 4046 7288 8502 2280 4047 7288 4243 4169 4048 7288 4258 4243 4049 4243 4258 6761 4050 1071 403 2942 4051 1071 2942 2661 4052 1071 6437 403 4053 1071 2661 6437 4054 8934 4965 7867 4055 8934 9100 9563 4056 8934 9563 4965 4057 1415 9821 5611 4058 1415 5611 2887 4059 1415 1885 6637 4060 1415 2887 1885 4061 1415 6637 9821 4062 6179 3992 4159 4063 8994 5025 6231 4064 8994 6231 7551 4065 8994 3308 5025 4066 8994 7862 3209 4067 8994 7551 7862 4068 8994 3209 562 4069 3684 562 2036 4070 3684 2036 7345 4071 3399 4052 3882 4072 3399 3882 2036 4073 3399 419 6719 4074 3399 2722 419 4075 3399 2036 2722 4076 3399 3593 4052 4077 3399 5282 3593 4078 3399 6719 5282 4079 419 996 9432 4080 419 9432 1677 4081 419 8274 6719 4082 419 1677 8274 4083 419 2722 562 4084 419 562 996 4085 3909 3882 4052 4086 7862 884 3209 4087 7862 4839 874 4088 7862 7551 4839 4089 7862 874 884 4090 9282 884 874 4091 9282 874 4981 4092 9282 8750 9929 4093 9282 3655 8750 4094 9282 4981 3655 4095 8187 5612 6223 4096 8187 9115 5612 4097 8187 7532 9115 4098 2885 8493 6042 4099 2885 6384 8493 4100 2885 7004 6384 4101 2885 6042 4474 4102 7004 8204 4058 4103 8204 4402 4058 4104 8204 781 4402 4105 8204 8077 781 4106 6231 4839 7551 4107 2863 3377 6075 4108 2863 6075 5370 4109 2863 2533 3377 4110 2863 308 2533 4111 2863 5370 308 4112 1328 1217 6727 4113 3065 2712 6824 4114 3065 4833 2712 4115 3065 6824 4645 4116 2712 4937 8696 4117 2712 1914 4937 4118 2712 6623 1914 4119 2712 8696 6824 4120 7914 9021 6345 4121 7914 2973 9021 4122 7914 6345 606 4123 7914 4910 4554 4124 7914 4554 2973 4125 7914 606 4910 4126 3784 4910 606 4127 3784 606 8034 4128 3784 4554 4910 4129 3784 4115 4554 4130 3784 9028 4115 4131 3784 8178 9028 4132 3784 8034 8178 4133 3214 700 471 4134 3214 9700 700 4135 3214 9571 6727 4136 3214 471 9571 4137 3214 3650 2763 4138 3214 6727 3650 4139 3214 2763 7221 4140 4215 6716 7545 4141 4215 9486 6716 4142 4215 936 9486 4143 7545 3650 1710 4144 7545 2763 3650 4145 7545 2149 2763 4146 7545 6716 2149 4147 1169 1710 3650 4148 1169 3650 6525 4149 6716 673 406 4150 6716 406 2149 4151 6716 7040 673 4152 6716 9486 8167 4153 6716 8167 7040 4154 8744 406 673 4155 6580 945 6222 4156 6580 4762 945 4157 6580 1154 4762 4158 2537 6222 2122 4159 2537 2122 6067 4160 2537 6067 9356 4161 6146 3322 2917 4162 6146 8572 3322 4163 6146 2917 7157 4164 2893 3315 8230 4165 2893 6618 3315 4166 2893 1816 8033 4167 2893 8230 1816 4168 2893 8033 4743 4169 2893 4743 6618 4170 2084 3104 2354 4171 2084 2354 2292 4172 2084 102 3104 4173 5556 5287 9083 4174 5556 1514 5287 4175 5556 3104 1514 4176 5556 9083 3104 4177 5927 3330 8999 4178 1459 6960 2802 4179 1459 2802 2400 4180 1459 7587 1613 4181 1459 1613 6960 4182 1459 2292 7587 4183 2586 529 1893 4184 2586 9297 529 4185 2586 2802 6960 4186 2586 6960 9297 4187 2586 1893 2802 4188 6393 8999 3330 4189 6393 4100 8999 4190 6393 2400 2802 4191 6393 3330 2400 4192 6393 2802 1893 4193 6393 1893 4755 4194 6393 4755 4100 4195 4755 529 2636 4196 4755 1893 529 4197 8455 1425 6067 4198 8455 6067 8566 4199 8455 8566 3266 4200 8455 3266 175 4201 8455 175 1425 4202 3266 8566 2122 4203 5917 2278 1425 4204 5917 1280 2278 4205 5917 7657 7798 4206 5917 7798 1280 4207 5917 1425 7657 4208 6570 2220 4331 4209 6570 5275 2220 4210 6570 4331 88 4211 6570 88 5275 4212 8830 3132 9006 4213 8830 6495 3132 4214 8830 9006 4635 4215 8830 4635 7246 4216 8830 7246 4095 4217 8830 4095 6495 4218 2275 8028 2754 4219 2275 4840 8028 4220 7242 4008 5903 4221 7242 5903 5771 4222 7242 1209 4008 4223 5903 4008 8420 4224 5903 9897 5771 4225 5903 8481 9897 4226 5903 8420 8481 4227 9204 1776 2371 4228 9204 2371 767 4229 9204 9156 1776 4230 9204 767 5313 4231 926 2467 2239 4232 926 8429 2467 4233 926 138 1662 4234 926 1662 8429 4235 7633 8841 597 4236 7633 597 1778 4237 1525 8776 5988 4238 1525 3241 8776 4239 3851 8379 4527 4240 3851 4527 3032 4241 3851 3032 4098 4242 6604 8630 4821 4243 6604 7931 8273 4244 6604 4821 7931 4245 6604 8273 6190 4246 7198 5465 4751 4247 7198 4751 2817 4248 7198 2011 5970 4249 7198 3982 2011 4250 7198 5970 5465 4251 7198 2817 3982 4252 7141 6193 3416 4253 7141 3416 4073 4254 7141 2779 6193 4255 2648 7997 6869 4256 2648 6869 2190 4257 2648 2959 5572 4258 2648 1208 2959 4259 2648 5572 9181 4260 2648 2190 1208 4261 2648 9181 7997 4262 6111 9181 5819 4263 6111 5819 6822 4264 6111 199 9181 4265 6111 9962 199 4266 9837 642 9839 4267 9837 9839 8728 4268 9837 8728 3280 4269 9837 7997 9131 4270 9837 6869 7997 4271 9837 3280 6869 4272 9837 9131 642 4273 1604 4303 5148 4274 1604 5148 2928 4275 1604 2928 3091 4276 5148 4303 6190 4277 5148 6190 6296 4278 5148 2046 2928 4279 2928 2046 4485 4280 2928 4485 732 4281 2928 6011 3091 4282 2928 732 6011 4283 2137 1144 8854 4284 2137 5291 1144 4285 2137 1227 4394 4286 2137 8854 1227 4287 2137 4394 2206 4288 2137 2206 1582 4289 2137 1582 5291 4290 3911 1308 1416 4291 3911 4098 9936 4292 3911 9936 4646 4293 3911 4646 1308 4294 6645 977 4232 4295 6645 1416 3908 4296 2934 220 743 4297 2934 743 7740 4298 2934 7740 210 4299 2934 2789 6908 4300 2934 210 2789 4301 2934 3579 220 4302 2934 6908 3579 4303 3579 3236 1407 4304 3579 3363 3236 4305 3579 2748 220 4306 3579 1407 2748 4307 3579 6908 3363 4308 6225 2381 8023 4309 6225 2849 2381 4310 6225 722 3381 4311 6225 3381 2849 4312 6457 3946 9392 4313 6457 9397 3946 4314 6457 5220 3605 4315 6457 9392 5220 4316 6457 6857 9397 4317 6457 3605 6857 4318 6857 2552 8068 4319 6857 8068 9397 4320 6857 3605 7089 4321 6857 7089 2552 4322 9231 8192 3592 4323 9231 3592 7034 4324 9231 7491 2983 4325 9231 7034 7491 4326 9231 9725 8192 4327 9231 2983 9725 4328 7508 4435 8867 4329 7508 9736 4435 4330 516 8867 4162 4331 516 4162 7458 4332 516 7458 5968 4333 516 5968 2276 4334 8869 4239 7560 4335 8869 7560 5184 4336 8869 5184 1943 4337 8869 7140 4239 4338 5968 5609 6661 4339 5968 7458 5609 4340 7109 7956 7745 4341 3875 5570 3612 4342 3875 9292 5570 4343 3875 9431 9292 4344 3875 3612 4489 4345 3875 4489 5410 4346 3875 5410 9431 4347 9985 305 9554 4348 9985 9554 2684 4349 5417 4149 7631 4350 5417 7631 3433 4351 5417 9593 4149 4352 5417 3789 9593 4353 4638 3370 9695 4354 4638 9695 4884 4355 4638 7840 821 4356 4638 4884 7840 4357 4638 821 3370 4358 3859 8206 821 4359 3859 821 6501 4360 3859 6501 7714 4361 1598 9443 7821 4362 1598 1330 3466 4363 1598 7705 1547 4364 1598 7821 7705 4365 1598 1211 2289 4366 1598 2289 1330 4367 1598 1547 1211 4368 2010 6398 4092 4369 2010 5212 6398 4370 2010 305 3603 4371 2010 4092 305 4372 2010 3603 7736 4373 2010 1458 4938 4374 2010 7736 1458 4375 6353 1796 5935 4376 6353 551 7273 4377 6353 5935 551 4378 1796 1165 22 4379 1796 22 8324 4380 1796 8324 8247 4381 1796 8247 8575 4382 1796 8575 5935 4383 8575 4274 7547 4384 8575 8247 4274 4385 8575 7547 5935 4386 6471 551 8075 4387 6471 9382 551 4388 6471 7980 9382 4389 6471 8075 7980 4390 9200 8576 7022 4391 9200 7022 5661 4392 9200 2592 8576 4393 9200 4837 2592 4394 9200 5661 4837 4395 5881 4701 4779 4396 5881 4779 3975 4397 5881 9295 6275 4398 5881 6275 4701 4399 5881 3975 9295 4400 8108 608 6216 4401 8108 2837 608 4402 8108 6216 5888 4403 8108 5888 9728 4404 8108 9728 3470 4405 8108 3470 2837 4406 6275 9382 7980 4407 6275 7899 9382 4408 6275 9295 7899 4409 6275 9728 4701 4410 6275 7980 9728 4411 1789 857 4004 4412 1789 6759 857 4413 1789 9142 6759 4414 1789 5063 9142 4415 1789 4004 5063 4416 2026 6950 5063 4417 2026 5063 6990 4418 2026 6990 5721 4419 2026 5721 4711 4420 2026 4711 8414 4421 2026 8414 6950 4422 3547 1897 2008 4423 3547 2008 8608 4424 3547 8608 2833 4425 3547 2833 526 4426 3547 526 1897 4427 7484 2833 8608 4428 7484 8608 2609 4429 7484 2609 6808 4430 7484 3762 2833 4431 7484 6808 3762 4432 6989 7100 6603 4433 6989 6603 7615 4434 6989 3803 3349 4435 6989 7615 3803 4436 6989 3349 7100 4437 8511 9908 6939 4438 8511 6939 9461 4439 9978 204 2510 4440 3835 8263 8516 4441 3835 2585 8263 4442 6158 6321 5906 4443 579 4189 9391 4444 579 2369 4189 4445 579 48 2369 4446 579 1678 5140 4447 579 5140 48 4448 579 1035 1678 4449 4617 5688 3043 4450 4617 6286 5688 4451 4617 3043 1035 4452 4617 8813 6286 4453 4617 3672 8813 4454 4617 1035 591 4455 5688 4353 3043 4456 5688 6654 3770 4457 5688 3770 4353 4458 5688 6286 6654 4459 3770 4320 8600 4460 3770 2333 4320 4461 3770 6654 2333 4462 3043 1678 1035 4463 3043 5140 1678 4464 5253 4261 5757 4465 5253 5757 8662 4466 6319 4851 3286 4467 6319 8557 4851 4468 6319 5499 8557 4469 6319 9258 9585 4470 6319 9585 5499 4471 6319 3286 9258 4472 1587 4276 2358 4473 9523 2097 3886 4474 9523 7593 2097 4475 4820 4119 9875 4476 4820 2097 4119 4477 3621 6341 83 4478 9875 6396 6151 4479 9875 4119 6396 4480 2829 7789 3919 4481 9487 9258 8373 4482 9487 9585 9258 4483 9487 3943 9585 4484 9515 6860 7385 4485 9515 5934 7251 4486 9515 7385 5934 4487 661 5068 531 4488 661 4477 5068 4489 2451 3943 6013 4490 2451 6013 6469 4491 2451 6647 3943 4492 4246 8647 4151 4493 4246 167 8647 4494 4246 3251 167 4495 6013 9748 74 4496 6013 3943 9748 4497 6013 7801 5874 4498 6013 5874 6469 4499 5874 7734 5068 4500 5874 5068 4556 4501 5874 4556 3251 4502 5874 3251 6469 4503 3251 4556 4477 4504 7734 809 5068 4505 3672 5183 8813 4506 3672 3679 5183 4507 986 696 8131 4508 986 8131 6198 4509 986 6198 7318 4510 7400 998 2113 4511 7400 2113 491 4512 7400 491 6198 4513 7400 8131 9639 4514 7400 6198 8131 4515 7400 9639 998 4516 4620 5014 998 4517 5406 2173 2298 4518 5406 2298 1273 4519 5406 1273 6392 4520 906 5632 246 4521 3503 2236 1303 4522 3503 1303 5171 4523 376 2083 1551 4524 376 1551 5503 4525 376 7717 2083 4526 8742 4464 6154 4527 8742 865 4464 4528 8742 7081 865 4529 6184 4061 1159 4530 6184 7081 4061 4531 6184 1159 7673 4532 6184 7673 585 4533 6184 585 7081 4534 9319 8549 1561 4535 6909 4184 8267 4536 6039 5741 696 4537 4184 4399 8267 4538 4184 6792 4399 4539 4698 326 2584 4540 8863 3965 5258 4541 3304 1023 5005 4542 3304 396 1023 4543 3304 4783 396 4544 3304 4499 4783 4545 3304 5005 4499 4546 3947 8770 8822 4547 4084 2848 2875 4548 4084 2875 8004 4549 6742 4613 849 4550 5303 7402 7777 4551 5303 7777 8983 4552 5303 1709 1686 4553 5303 8983 1709 4554 7333 5080 5177 4555 9053 8631 8523 4556 9053 5480 8631 4557 9053 8523 2378 4558 8523 8631 8462 4559 7175 4179 5895 4560 7175 5895 2936 4561 7175 2936 364 4562 4939 493 4094 4563 4939 4094 8435 4564 4939 8435 3369 4565 4939 989 261 4566 4939 261 493 4567 4939 7375 989 4568 4939 3369 7375 4569 6312 4094 493 4570 9831 8477 3570 4571 9831 3570 1077 4572 9831 989 7375 4573 9831 7375 8477 4574 7375 3570 8477 4575 7375 3369 3570 4576 4825 7503 929 4577 4825 929 2470 4578 4825 2470 5723 4579 4825 7768 7503 4580 8591 8662 3286 4581 6804 2358 2260 4582 204 7485 2510 4583 204 6315 7485 4584 7485 6315 8022 4585 7485 8022 1826 4586 7485 1826 2510 4587 7030 2357 3279 4588 7030 3279 1610 4589 8974 5104 9009 4590 878 3295 1097 4591 7306 10002 8822 4592 7306 1658 10002 4593 7306 9274 5535 4594 7306 5535 4071 4595 7306 4071 1522 4596 7306 1522 1658 4597 7306 5607 9188 4598 7306 8822 5607 4599 1360 7976 3745 4600 5283 6966 1443 4601 5283 1443 9634 4602 4071 4564 1522 4603 9274 364 5535 4604 9274 2479 364 4605 1388 5561 5106 4606 1388 5106 1665 4607 1388 7120 7017 4608 1388 7017 5561 4609 1388 1665 7120 4610 7017 5590 5959 4611 7017 5959 3223 4612 7017 7120 7947 4613 7017 7947 5590 4614 7017 6547 5561 4615 8552 4040 1293 4616 8552 1293 6491 4617 8552 4294 8369 4618 8552 8369 2092 4619 8552 2092 4040 4620 8552 6491 4294 4621 9653 2092 8269 4622 9653 8269 6114 4623 9653 1293 4040 4624 9653 6114 1293 4625 9653 4040 2092 4626 8369 1979 6269 4627 8369 4294 1979 4628 8369 6816 5550 4629 8369 5550 2092 4630 8369 6269 6816 4631 6165 2947 5552 4632 6165 9257 2947 4633 2987 4676 5804 4634 2987 9477 4676 4635 2987 4348 9477 4636 2987 9937 42 4637 2987 42 4348 4638 2987 5804 9937 4639 6060 6108 9843 4640 6060 9843 4994 4641 6060 6531 6108 4642 6060 9937 6228 4643 6060 6228 6531 4644 6060 42 9937 4645 6060 4994 42 4646 8137 615 5616 4647 8137 5616 1849 4648 9426 8582 7 4649 9426 7 2168 4650 9426 2168 9291 4651 9426 9291 615 4652 5616 1269 1087 4653 5616 615 1269 4654 1214 9263 7852 4655 1214 5854 9263 4656 2389 8536 2319 4657 2389 7499 8536 4658 2389 1087 1269 4659 2389 1269 7499 4660 8579 692 2058 4661 8579 2058 5529 4662 8579 2838 692 4663 8188 789 692 4664 8188 176 789 4665 264 5529 5849 4666 264 1378 9970 4667 9184 6106 6671 4668 9184 5091 6106 4669 9184 3924 5891 4670 9184 6671 3924 4671 9184 1249 5091 4672 176 3780 7613 4673 176 7613 9368 4674 176 6955 3780 4675 176 8483 789 4676 176 9368 8483 4677 3977 7448 6088 4678 3977 6088 8155 4679 3977 8155 6955 4680 4614 9555 8489 4681 4614 2194 9555 4682 2025 7093 4677 4683 2025 7271 660 4684 2025 660 7093 4685 9697 9375 4137 4686 9697 8626 9375 4687 9697 1447 8626 4688 9697 7101 1447 4689 8030 8419 6376 4690 8030 6376 455 4691 8030 6691 8419 4692 9777 8419 6691 4693 9777 6691 2062 4694 9777 515 6376 4695 9777 6376 8419 4696 9777 2062 515 4697 7468 1023 1573 4698 7468 5005 1023 4699 5878 6656 7573 4700 5878 6652 6656 4701 1540 8715 6691 4702 7875 9827 3095 4703 4247 1632 5815 4704 4247 1478 1632 4705 4247 5815 5005 4706 4566 2270 1631 4707 4566 4264 2270 4708 4566 1631 1140 4709 4566 3873 248 4710 4566 248 4264 4711 2247 6103 4027 4712 9074 741 3887 4713 9074 1960 741 4714 7520 6592 5257 4715 7520 5257 3290 4716 7520 4512 6592 4717 2869 3290 3839 4718 9525 1573 1023 4719 9525 1023 1403 4720 9525 2062 1573 4721 9844 515 2062 4722 9844 9526 515 4723 9844 9107 9526 4724 9844 2516 9107 4725 623 8098 7648 4726 623 4642 8098 4727 8098 583 7648 4728 8098 9756 583 4729 7449 8376 2018 4730 7449 2018 7530 4731 7449 481 1274 4732 7449 7530 481 4733 3802 6395 283 4734 3802 283 3389 4735 3802 7888 6395 4736 3802 8365 7550 4737 3802 3389 8365 4738 5905 9861 1960 4739 6851 1027 2312 4740 6851 9094 1027 4741 8365 2312 7550 4742 1934 8653 7408 4743 1934 7408 9863 4744 1934 6151 9950 4745 7007 6151 6396 4746 7007 9950 6151 4747 1661 9863 7408 4748 8549 7072 3119 4749 8549 8069 7072 4750 8549 3119 1561 4751 1455 5757 4261 4752 1455 8373 5757 4753 1455 7301 8373 4754 9279 8707 2957 4755 9279 1766 8707 4756 9279 2957 888 4757 1015 7042 9690 4758 1015 1454 7042 4759 1015 6911 5914 4760 1015 5914 1454 4761 1015 9690 6911 4762 5914 6911 8398 4763 5914 8398 1454 4764 7654 3415 4727 4765 7654 8228 3415 4766 7654 1277 6318 4767 7654 4727 1277 4768 7654 9421 9879 4769 7654 9879 8228 4770 7654 8099 9421 4771 7654 6318 8099 4772 8186 7973 7211 4773 3643 8948 9455 4774 3643 9345 8948 4775 7855 825 9495 4776 7855 9495 3292 4777 5185 4719 4505 4778 4514 5997 7136 4779 7640 7968 2254 4780 7640 2254 2407 4781 7640 1129 8741 4782 7640 2407 1129 4783 2367 3541 7968 4784 475 4265 6737 4785 475 9656 4265 4786 6737 4265 3364 4787 6737 3364 1048 4788 2635 7764 7730 4789 2635 5639 7764 4790 2635 7730 5475 4791 2635 5475 5639 4792 5026 3159 8805 4793 5026 9921 3159 4794 5026 7048 9921 4795 4770 5475 8831 4796 4770 8521 5475 4797 4770 7048 7164 4798 4770 7164 8521 4799 3159 9161 8805 4800 3159 9921 2487 4801 9350 9774 2487 4802 9350 9334 9774 4803 9495 9325 3292 4804 5392 8805 9161 4805 177 8536 9480 4806 177 6314 8536 4807 6600 3137 9774 4808 7002 3541 34 4809 7002 662 3541 4810 7002 34 1048 4811 7002 1048 4106 4812 7002 4106 662 4813 341 1281 7431 4814 341 8674 1281 4815 341 7431 7866 4816 341 4327 8674 4817 341 8163 4327 4818 7502 6102 7123 4819 5558 295 6403 4820 5558 6403 8412 4821 5558 613 295 4822 5558 8412 8163 4823 295 613 2163 4824 295 2163 9932 4825 295 9932 6403 4826 1775 1292 7326 4827 1775 9872 8403 4828 1775 7326 9872 4829 8403 9872 4604 4830 8403 4604 7103 4831 8403 7103 3928 4832 9872 7326 3754 4833 9872 3754 590 4834 9872 590 4604 4835 8008 2481 222 4836 8008 7035 2481 4837 6517 222 494 4838 6517 494 1108 4839 4166 6204 5921 4840 1141 7192 9792 4841 1141 9792 60 4842 1141 33 7192 4843 1141 4969 33 4844 1141 60 4969 4845 33 6542 7192 4846 33 695 6542 4847 33 4969 8312 4848 33 8312 695 4849 2594 4845 6549 4850 2594 5202 4845 4851 2594 6549 6542 4852 2594 6542 5202 4853 6768 5937 3811 4854 6768 8613 5937 4855 6768 1560 8613 4856 6768 3811 5345 4857 314 641 1560 4858 314 4845 641 4859 314 4165 8642 4860 314 1560 4165 4861 314 8642 4845 4862 4165 3475 8642 4863 4165 7771 3475 4864 4165 5880 7771 4865 2182 4454 4624 4866 2182 4624 8063 4867 9277 7456 5918 4868 9277 5918 978 4869 9277 9584 7302 4870 9277 978 9584 4871 9277 7302 4441 4872 9277 4441 7456 4873 5156 228 4792 4874 5156 4792 30 4875 5156 30 3915 4876 5156 4441 228 4877 285 1833 2894 4878 285 4275 25 4879 285 4211 4275 4880 285 3309 4211 4881 285 25 1833 4882 4121 4070 4492 4883 4121 4492 8577 4884 3213 730 4951 4885 3213 4951 5918 4886 3213 2211 4697 4887 7264 3610 7513 4888 6658 8986 2227 4889 6658 352 8986 4890 6658 9067 6552 4891 6658 6552 5175 4892 6658 5175 352 4893 6658 2227 9067 4894 7341 9841 4951 4895 7341 5939 9841 4896 230 7630 3987 4897 230 3987 4211 4898 230 4211 3309 4899 7483 7573 6656 4900 7483 6656 2688 4901 8715 2873 1478 4902 8715 1140 1631 4903 8715 1631 2873 4904 5340 4911 5728 4905 5340 9004 4911 4906 5340 7866 9004 4907 5340 5728 2582 4908 7415 5112 431 4909 7415 431 2938 4910 7415 2310 5112 4911 7415 6394 2310 4912 7415 2938 6394 4913 184 7704 7668 4914 467 2664 1732 4915 467 1732 766 4916 467 9603 7380 4917 467 766 9603 4918 272 2161 6854 4919 272 6854 5404 4920 272 4841 2161 4921 272 5404 3695 4922 438 1184 9758 4923 438 361 5670 4924 438 5670 6450 4925 438 6450 1184 4926 5670 1283 6450 4927 5670 361 1283 4928 9758 497 5756 4929 1091 497 1184 4930 1091 5650 497 4931 1091 1184 4687 4932 3061 4222 3853 4933 3061 3853 3198 4934 3061 3198 2677 4935 3061 2677 9508 4936 5790 5756 5650 4937 5790 5650 2841 4938 5790 2841 5576 4939 5790 5576 1082 4940 7726 5995 7187 4941 7726 7187 2597 4942 7726 536 5995 4943 7726 5058 6826 4944 7726 2597 5058 4945 7726 6826 9912 4946 9912 6826 4075 4947 9912 4075 1030 4948 7498 9381 6040 4949 7498 5996 9381 4950 7498 1815 5996 4951 7498 9478 4452 4952 7498 6040 9478 4953 7498 4452 918 4954 7498 4559 9139 4955 7498 918 4559 4956 7498 9139 1815 4957 3750 2309 3272 4958 3750 6414 2309 4959 3750 3937 7291 4960 3750 7291 6414 4961 3750 3272 3729 4962 3750 3729 3937 4963 9917 4508 759 4964 9917 9595 4508 4965 9917 7882 9595 4966 9917 9238 5931 4967 9917 5931 7882 4968 9917 8092 9238 4969 9917 759 8092 4970 4772 6605 8874 4971 4772 3916 6605 4972 4772 8874 9640 4973 4772 9640 3916 4974 1689 1821 4769 4975 196 4383 3459 4976 196 9707 4383 4977 196 9832 9707 4978 196 8874 9832 4979 196 9174 8874 4980 5792 3414 5019 4981 5792 1890 3414 4982 5792 3828 3633 4983 5792 1869 3828 4984 5792 5019 1869 4985 5792 3633 1890 4986 4692 3414 5622 4987 4692 5622 7919 4988 4692 7884 8244 4989 4692 7919 7884 4990 4692 8244 9380 4991 4692 9380 3414 4992 2222 2743 1703 4993 2222 1703 1945 4994 2222 5964 2743 4995 2222 2009 7204 4996 2222 1945 2009 4997 2222 7204 5964 4998 3600 6535 4202 4999 3600 1516 6535 5000 3600 7204 1516 5001 3600 4202 671 5002 3600 5964 7204 5003 2924 6512 4846 5004 2944 3016 2569 5005 1821 9507 4769 5006 7454 157 8250 5007 7454 3164 157 5008 3164 4321 4723 5009 3164 4 2843 5010 3164 2120 4321 5011 3164 2843 157 5012 2646 4333 7719 5013 2646 7719 6388 5014 2646 1742 4333 5015 5687 5931 9238 5016 5687 6605 5931 5017 5687 9238 3307 5018 5687 9707 8874 5019 5687 8874 6605 5020 4383 1585 3459 5021 4383 3307 1585 5022 1114 7252 6558 5023 1114 4480 7252 5024 1114 5086 4480 5025 1114 2252 5086 5026 19 2368 9247 5027 19 6336 2368 5028 6336 9900 2368 5029 6336 1452 9900 5030 7243 5830 2835 5031 7243 4375 5830 5032 5434 5179 4511 5033 5434 4511 2428 5034 5434 8480 5179 5035 5434 2428 8480 5036 3127 5179 4496 5037 8410 1656 4349 5038 8410 4349 6831 5039 8410 6831 4384 5040 8410 3964 1656 5041 495 535 8803 5042 495 8803 9516 5043 495 6680 9704 5044 495 9516 6680 5045 495 9704 535 5046 7606 5110 3571 5047 7606 5255 5110 5048 7376 4709 7118 5049 7376 9227 4709 5050 8839 4267 7795 5051 8839 6265 4267 5052 8839 9984 6265 5053 8673 8667 2306 5054 8673 2306 1151 5055 5689 5021 3287 5056 8898 5280 8870 5057 8898 729 5280 5058 3398 200 2927 5059 3398 9788 200 5060 3398 9900 9788 5061 3398 2927 3221 5062 3398 3221 9247 5063 3398 2368 9900 5064 3398 9247 2368 5065 1095 3409 8071 5066 1095 8071 9732 5067 1095 9001 9304 5068 1095 9732 9001 5069 1095 1860 3409 5070 7275 4641 9720 5071 7275 9720 7266 5072 7275 7266 6232 5073 7439 2791 806 5074 1786 190 2355 5075 1894 9304 9001 5076 1894 191 9304 5077 145 7998 9001 5078 492 6073 6625 5079 492 6625 9159 5080 3745 7976 6136 5081 4955 2214 7775 5082 2977 4683 7907 5083 2977 7907 3591 5084 2977 9092 4683 5085 8862 4409 9092 5086 2374 9132 5110 5087 2374 5110 6072 5088 2374 6072 9590 5089 3158 9132 3915 5090 3158 3915 7106 5091 3158 5066 9132 5092 3158 5774 5066 5093 3158 7106 5774 5094 3257 6979 9302 5095 3257 1260 6979 5096 3257 9302 2790 5097 2271 6979 535 5098 8976 6059 9729 5099 9749 6059 4618 5100 5967 8103 8348 5101 5967 8348 4417 5102 5967 29 2643 5103 5967 2643 6434 5104 5967 6434 8103 5105 5967 4417 29 5106 6836 2111 3870 5107 6836 6786 2111 5108 6836 3870 1772 5109 6836 1772 9898 5110 6836 9898 2697 5111 6836 2697 6786 5112 3142 653 6499 5113 3142 6499 5698 5114 3142 5698 819 5115 2506 8819 6900 5116 2506 6900 9498 5117 2506 9498 6601 5118 2506 8709 8819 5119 2506 6951 8709 5120 2506 6601 6951 5121 8709 292 5062 5122 8709 5062 6308 5123 8709 6308 6900 5124 8709 6900 8819 5125 8709 6951 3533 5126 8709 3533 292 5127 1905 7460 9470 5128 1905 4329 7460 5129 8513 2417 36 5130 8513 7169 2417 5131 1763 7825 6401 5132 1763 8367 7825 5133 1763 2417 8367 5134 1361 9989 4902 5135 7398 8555 9754 5136 7398 9754 1336 5137 7398 211 8555 5138 7398 1210 4365 5139 7398 4482 1210 5140 7398 4365 211 5141 7398 8220 4482 5142 5501 1336 7848 5143 488 211 4030 5144 488 4030 2279 5145 488 8555 211 5146 488 2279 8555 5147 4365 5614 211 5148 4365 1210 5614 5149 4575 9705 6166 5150 4575 6166 2872 5151 4575 5856 3099 5152 4575 6772 5856 5153 4575 3099 4809 5154 4575 4809 9044 5155 4575 9044 9705 5156 4575 2872 6772 5157 1734 434 4225 5158 1734 4225 7902 5159 1734 9044 434 5160 1734 7902 1474 5161 1734 1474 9705 5162 1734 9705 9044 5163 1474 7902 1949 5164 1474 1949 6166 5165 1474 6166 9705 5166 4218 4063 9010 5167 4218 9010 7355 5168 4218 7355 1596 5169 4218 9108 4063 5170 4218 1596 9108 5171 3368 5509 7156 5172 3368 7156 9358 5173 3368 6206 7388 5174 3368 3502 6206 5175 3368 7388 5509 5176 3368 9358 3502 5177 7388 1491 4124 5178 7388 8922 1491 5179 7388 4124 5509 5180 7388 6206 8922 5181 193 8726 7156 5182 193 811 8726 5183 193 6242 418 5184 193 418 811 5185 193 8908 6242 5186 193 7156 8908 5187 6093 5975 7584 5188 6093 8612 5975 5189 6093 7584 4936 5190 6093 4936 8612 5191 6325 5132 418 5192 6325 418 1073 5193 6325 1073 4936 5194 6325 7584 2415 5195 6325 2415 2610 5196 6325 4936 7584 5197 6325 2610 5132 5198 9437 9823 6463 5199 9437 1770 9823 5200 9437 3101 1770 5201 9437 6801 3101 5202 9437 3316 6801 5203 9437 6463 3316 5204 9718 9026 6926 5205 9718 5984 3512 5206 9718 3512 5776 5207 9718 742 5984 5208 9718 6926 742 5209 7516 4022 1181 5210 7516 3472 4022 5211 7516 3606 4750 5212 7516 1181 3606 5213 7516 675 4283 5214 7516 4750 675 5215 7516 4283 9400 5216 7516 9400 3472 5217 2494 1063 5054 5218 2494 5054 7319 5219 2494 8227 5228 5220 2494 5228 1063 5221 746 7515 7039 5222 746 7039 9068 5223 746 9068 8227 5224 5228 8227 8502 5225 5228 8502 3652 5226 5228 3652 1063 5227 8487 6477 3460 5228 8487 3460 6051 5229 8487 7515 6477 5230 4332 1481 5408 5231 4332 2348 1481 5232 4332 5210 8509 5233 4332 5408 5210 5234 5210 5408 5740 5235 6347 3700 5832 5236 9268 5054 1063 5237 9268 1342 5054 5238 9268 1063 3652 5239 9268 3652 2995 5240 9268 2995 4897 5241 9268 4897 1342 5242 3552 6761 4519 5243 3552 4519 2179 5244 3552 4345 4287 5245 3552 4287 6761 5246 3552 2179 4345 5247 4169 8795 8502 5248 4258 354 7860 5249 4258 7860 834 5250 4258 834 4519 5251 4258 4519 6761 5252 8750 4021 795 5253 8750 795 9929 5254 8750 9739 4021 5255 8750 3655 9739 5256 7921 8124 4627 5257 7921 9924 8124 5258 7921 4627 5832 5259 7921 5832 6569 5260 7921 7457 5370 5261 7921 6569 7457 5262 7921 5370 9924 5263 6437 9925 403 5264 6437 2661 8635 5265 6437 8635 9925 5266 9100 403 8053 5267 9100 8053 2601 5268 9100 2601 9563 5269 9100 2942 403 5270 6637 681 9821 5271 6637 7865 681 5272 4159 832 7865 5273 4159 2782 832 5274 4159 3992 2782 5275 562 2722 2036 5276 562 3209 996 5277 6719 4041 7748 5278 6719 7748 5282 5279 6719 8274 4041 5280 8274 1677 2299 5281 8274 2299 7748 5282 8274 7748 4041 5283 996 6223 9432 5284 2036 3882 7345 5285 2615 9118 5548 5286 2615 6176 9118 5287 5268 5548 7224 5288 5268 7224 6794 5289 1970 8498 3308 5290 6223 1677 9432 5291 6223 5612 1677 5292 6384 9326 4402 5293 6384 4402 8493 5294 4058 4402 9326 5295 2533 4981 874 5296 2533 308 4981 5297 4981 7457 3655 5298 4981 5370 7457 5299 4981 308 5370 5300 5370 2210 9924 5301 5370 5580 2210 5302 5370 6075 5580 5303 6977 680 8339 5304 6977 8339 5580 5305 6977 5580 6075 5306 6977 6075 680 5307 2719 6669 78 5308 2719 5868 6669 5309 2719 78 7667 5310 2719 7667 6582 5311 2719 6582 5868 5312 2763 2149 7221 5313 936 8493 9448 5314 936 9448 4216 5315 936 5864 9486 5316 936 4216 5864 5317 8167 9486 5864 5318 8167 5864 7674 5319 8167 7674 2734 5320 8167 2734 7040 5321 6727 8684 3650 5322 6727 1217 8684 5323 406 7221 2149 5324 870 2142 138 5325 4762 3015 945 5326 4762 7157 5070 5327 4762 1154 7157 5328 4762 5070 3015 5329 6222 945 4097 5330 6222 4097 2122 5331 7157 2917 5070 5332 4743 1816 5044 5333 4743 8033 1816 5334 4743 5044 6618 5335 1816 4626 5044 5336 1816 8230 5823 5337 1816 5823 4626 5338 3104 4 1514 5339 3104 2843 4 5340 3104 102 2843 5341 3104 9083 2354 5342 1081 5879 5505 5343 1081 9531 5879 5344 1081 7961 9531 5345 4248 9771 7961 5346 7587 9236 2398 5347 7587 2398 7037 5348 7587 7037 1613 5349 7587 2292 9236 5350 529 3460 4377 5351 529 5471 3460 5352 529 4377 3521 5353 529 1205 5471 5354 529 3521 2636 5355 529 1684 1205 5356 529 9297 1684 5357 9297 6960 1613 5358 9297 1613 1684 5359 4100 1651 6413 5360 4100 6413 8999 5361 9408 4097 945 5362 9408 9771 4097 5363 9408 945 9771 5364 6067 9722 9356 5365 6067 714 9722 5366 6067 2278 714 5367 6067 1425 2278 5368 6067 2122 8566 5369 175 1651 1425 5370 175 6413 1651 5371 175 8999 6413 5372 7657 1651 5028 5373 7657 5028 7798 5374 7657 1425 1651 5375 1280 917 2278 5376 1280 793 917 5377 1280 7798 1908 5378 1280 1908 793 5379 4331 2220 7786 5380 4331 7786 88 5381 4095 2736 5883 5382 4095 5883 6495 5383 4095 6663 2736 5384 4095 7246 6663 5385 1609 1579 4708 5386 1609 7780 1579 5387 1609 4708 4840 5388 9482 9897 4947 5389 9482 4947 4134 5390 9482 4134 7045 5391 9482 5067 1579 5392 9482 7045 5067 5393 9482 1579 9897 5394 5771 9897 7780 5395 5313 9547 1262 5396 5313 3168 9547 5397 5313 767 3168 5398 9007 1271 5604 5399 9007 436 1271 5400 9810 9760 9021 5401 9810 9021 804 5402 9810 4453 9760 5403 9810 3515 4453 5404 9810 5620 3515 5405 9810 804 5620 5406 4036 2452 2819 5407 4036 2819 3118 5408 4036 828 2452 5409 4036 3865 3404 5410 4036 3404 2602 5411 4036 3118 3865 5412 4036 2602 8096 5413 4036 8096 828 5414 4098 3032 1004 5415 4098 1004 9936 5416 4646 9056 2426 5417 4646 7627 9056 5418 4646 8296 6556 5419 4646 2426 8296 5420 4646 6556 1308 5421 4646 9936 7303 5422 4646 7303 7627 5423 8273 8471 4527 5424 8273 805 8471 5425 8273 7931 805 5426 8273 4527 6190 5427 8161 4868 3047 5428 8161 3047 4580 5429 8161 4580 8355 5430 8161 5465 5970 5431 8161 8355 5465 5432 8161 5970 2655 5433 8161 2655 4868 5434 1736 205 2440 5435 1736 6391 205 5436 1736 2440 5970 5437 1736 5970 2011 5438 1736 2011 7344 5439 1736 7344 6391 5440 5970 2440 2655 5441 3982 4731 7344 5442 3982 2817 4731 5443 3982 7344 2011 5444 2779 8117 6193 5445 2779 6739 8117 5446 2779 4580 6739 5447 199 5141 9131 5448 199 9131 7997 5449 199 7997 9181 5450 199 9962 5141 5451 4132 5441 642 5452 4132 4269 5441 5453 4132 642 9131 5454 4132 9131 5141 5455 4132 5141 4269 5456 9181 4872 5819 5457 9181 5572 2350 5458 9181 2350 4872 5459 6011 2200 4546 5460 6011 3805 2200 5461 6011 4546 3091 5462 6011 732 3805 5463 1582 6715 4422 5464 1582 2206 6715 5465 1582 4555 5291 5466 1582 4269 4555 5467 1582 4422 4269 5468 7044 2748 234 5469 7044 234 2013 5470 7044 2756 743 5471 7044 743 220 5472 7044 2013 2756 5473 7044 220 2748 5474 2756 2013 9234 5475 2756 9234 3816 5476 2756 3816 743 5477 1085 7372 1464 5478 1085 2663 7372 5479 1085 234 9322 5480 1085 1464 234 5481 234 2748 1407 5482 234 1464 2013 5483 711 6190 4527 5484 711 4527 8379 5485 711 6296 6190 5486 2046 3367 4485 5487 2046 6173 3367 5488 400 1865 5033 5489 400 7352 1865 5490 400 5033 8595 5491 400 881 7511 5492 400 8595 881 5493 400 7511 6908 5494 400 6908 2789 5495 400 2789 7352 5496 6908 7511 3363 5497 7102 5294 4678 5498 7102 4678 1172 5499 7102 1172 722 5500 8023 1033 5294 5501 8023 3740 1033 5502 8023 2381 3740 5503 3381 2344 9462 5504 3381 1990 2344 5505 3381 1675 2849 5506 3381 9462 1675 5507 3381 722 1990 5508 7336 2710 503 5509 7336 503 9462 5510 7336 9462 2344 5511 7336 2344 2710 5512 5820 9093 6941 5513 5820 2758 9093 5514 5820 159 61 5515 5820 61 1033 5516 5820 1033 2758 5517 5820 6941 159 5518 3605 5220 7089 5519 8055 8020 693 5520 8055 693 1204 5521 8055 4256 1379 5522 8055 1379 8020 5523 8055 1204 4256 5524 9148 9725 4268 5525 9148 4268 2334 5526 2983 4268 9725 5527 2983 838 4268 5528 2983 5982 838 5529 2983 7491 5982 5530 6661 5609 7193 5531 8867 6191 3021 5532 8867 4435 6191 5533 8867 3021 4162 5534 9736 6590 4435 5535 9736 4023 6590 5536 2628 4829 8323 5537 7140 2334 4268 5538 7140 4268 4239 5539 7458 4162 5609 5540 1270 3454 2107 5541 1270 5860 3454 5542 1270 2107 5609 5543 1270 5609 5860 5544 1527 2318 5643 5545 1527 5643 7193 5546 1527 7193 5609 5547 1527 5609 5236 5548 5643 9135 5410 5549 5643 2318 9135 5550 5410 7745 5923 5551 5410 5923 9431 5552 7303 8890 512 5553 7303 512 7472 5554 7303 7472 7627 5555 7303 9936 4323 5556 7303 4323 8890 5557 3789 1968 4170 5558 3789 4170 9593 5559 3789 1004 8471 5560 3789 8471 1968 5561 821 8206 420 5562 821 420 3370 5563 821 2360 6501 5564 821 7840 2360 5565 8206 1466 420 5566 8206 9671 1466 5567 8630 6501 2360 5568 8630 2360 4821 5569 2350 5572 4019 5570 2350 4019 4872 5571 1211 1547 6573 5572 1211 4489 1886 5573 1211 6573 4489 5574 1211 1886 2289 5575 1547 7705 8804 5576 4489 3612 1886 5577 4938 1458 103 5578 4938 4658 2630 5579 4938 2630 8109 5580 4938 38 4658 5581 4938 103 38 5582 7273 551 2559 5583 7273 2559 2691 5584 7273 9714 3525 5585 7273 2691 9714 5586 7273 3525 1165 5587 5935 7547 7022 5588 5935 8576 551 5589 5935 7022 8576 5590 8075 4481 7980 5591 8075 551 8576 5592 8075 8576 4481 5593 8576 2592 4481 5594 4837 5661 489 5595 4837 489 2550 5596 4837 5946 3470 5597 4837 2550 5946 5598 4837 3470 2592 5599 3620 2577 6814 5600 3620 9447 2577 5601 3620 6814 6404 5602 3620 6404 7222 5603 3620 7222 9447 5604 6483 8953 777 5605 6483 777 1391 5606 6483 1000 3668 5607 6483 1391 1000 5608 6483 3668 6981 5609 6483 6981 8953 5610 5421 5798 9587 5611 5421 9587 8494 5612 5421 9447 5798 5613 5421 8494 9447 5614 4701 9728 5888 5615 4701 5888 4779 5616 5888 7794 4779 5617 5888 6766 7794 5618 5888 6216 6766 5619 2034 526 7636 5620 2034 7636 9002 5621 2034 9002 3975 5622 2034 3975 4104 5623 2034 4104 526 5624 9295 9002 3787 5625 9295 3787 7899 5626 9295 3975 9002 5627 9142 6950 3687 5628 9142 3687 6759 5629 9142 5063 6950 5630 4004 9194 5207 5631 4004 857 9194 5632 4004 5207 6407 5633 4004 6407 5063 5634 6990 5063 1542 5635 6990 1542 2098 5636 6990 2098 5721 5637 2008 6969 7804 5638 2008 1897 6969 5639 2008 7804 6972 5640 2008 87 5829 5641 2008 6972 87 5642 2008 5829 8608 5643 5829 4300 2146 5644 5829 87 4300 5645 5829 2146 8608 5646 2833 7636 526 5647 2833 3762 7636 5648 7090 2609 8111 5649 7090 8111 5720 5650 7090 5720 2139 5651 7090 2139 7579 5652 7090 309 6808 5653 7090 7579 309 5654 7090 6808 2609 5655 6808 1480 9887 5656 6808 309 1480 5657 6808 9887 9851 5658 6808 9851 3762 5659 3349 3803 6682 5660 3349 446 2651 5661 3349 2651 7100 5662 3349 486 446 5663 3349 6682 486 5664 6939 3369 8435 5665 6939 9908 3369 5666 6939 8435 9461 5667 9270 2464 9622 5668 8516 8263 5602 5669 2585 6876 7574 5670 2585 4851 6876 5671 2585 7574 8263 5672 2585 3286 4851 5673 1035 252 591 5674 8001 6286 8813 5675 8001 6654 6286 5676 8001 2333 6654 5677 8001 6581 4077 5678 8001 8813 6581 5679 8001 4077 2333 5680 5757 8373 9258 5681 5757 9258 5770 5682 5757 5770 8662 5683 9258 3286 5770 5684 2097 7593 7220 5685 2097 7220 4119 5686 6860 185 7385 5687 1956 5068 809 5688 5068 4477 4556 5689 3679 583 5183 5690 3679 1126 583 5691 7274 7409 4696 5692 7274 9726 7409 5693 7274 7251 8963 5694 7274 6121 7251 5695 7274 7957 9726 5696 7274 8963 7957 5697 7274 4696 6121 5698 2113 998 5014 5699 2113 7673 491 5700 2113 5014 7673 5701 1351 7673 1159 5702 1351 491 7673 5703 1351 6198 491 5704 1351 1159 4061 5705 1351 4061 6198 5706 3758 7409 7957 5707 3758 7957 6792 5708 3758 4696 7409 5709 3758 7318 4696 5710 3758 990 7318 5711 8131 5208 9639 5712 8131 696 5208 5713 2173 99 2298 5714 2173 9522 99 5715 99 9976 3662 5716 99 3662 2298 5717 99 6195 9976 5718 99 5632 6195 5719 99 9522 5887 5720 99 5887 5632 5721 8589 4061 7081 5722 8589 112 4061 5723 58 9522 2930 5724 58 5887 9522 5725 58 246 5887 5726 585 6154 4464 5727 585 7881 6154 5728 585 7673 7881 5729 585 865 7081 5730 585 4464 865 5731 4745 7364 5418 5732 4745 5418 3119 5733 8881 9101 7789 5734 8881 9748 9101 5735 8881 1561 9748 5736 8647 8557 4151 5737 8647 4882 8558 5738 8647 8558 6876 5739 8647 6876 8557 5740 8647 167 4882 5741 2005 9914 6609 5742 2005 6609 7574 5743 2005 7574 8558 5744 2005 8558 4882 5745 2645 8557 5499 5746 2645 3212 8557 5747 2645 5499 9585 5748 2645 9585 3212 5749 2083 5120 3993 5750 2083 3993 9934 5751 2083 9934 1551 5752 2083 7717 5120 5753 8267 4399 5882 5754 8267 5882 6564 5755 7178 4974 3613 5756 7178 3613 3359 5757 7178 2584 4974 5758 8219 3359 1303 5759 1485 2671 3098 5760 1485 3098 6778 5761 1485 6778 4086 5762 1485 4086 2596 5763 1485 2596 2671 5764 5258 3965 9327 5765 396 4783 48 5766 396 9327 1023 5767 2875 2848 983 5768 2875 983 3152 5769 2875 3152 3978 5770 2875 8462 8004 5771 2875 3978 8462 5772 8770 7770 1568 5773 8770 1568 8822 5774 7358 5697 1568 5775 7358 3012 5697 5776 7358 1568 7770 5777 7358 8004 3012 5778 5080 3765 5177 5779 5080 1686 3765 5780 2936 5895 7805 5781 2936 5535 364 5782 261 7805 493 5783 5899 7220 7593 5784 9664 7768 1610 5785 9664 6587 7768 5786 9664 1610 3279 5787 9664 3279 2357 5788 9664 2357 6587 5789 3102 8351 2357 5790 8371 9103 2493 5791 8371 5494 9103 5792 5056 152 2453 5793 5056 2453 5494 5794 5056 7334 152 5795 5056 5494 7334 5796 1963 8745 8751 5797 1963 8751 9116 5798 1963 9116 4705 5799 1963 6101 8745 5800 1963 4705 6648 5801 8607 6101 9607 5802 8607 9607 5675 5803 8607 1265 1534 5804 8607 1534 8751 5805 8607 5675 1265 5806 8607 8751 8745 5807 8607 8745 6101 5808 1568 8622 5607 5809 1568 5607 8822 5810 1568 5697 8622 5811 5607 8054 7180 5812 5607 8622 8054 5813 5607 7180 9188 5814 2791 9152 806 5815 1443 1013 2853 5816 1443 6966 1013 5817 1443 2853 9634 5818 9188 7180 5480 5819 5561 2416 5106 5820 5561 6547 578 5821 5561 578 2416 5822 6547 674 578 5823 3426 2256 9544 5824 3426 9544 2416 5825 3426 674 5308 5826 3426 5308 2256 5827 3426 578 674 5828 3426 2416 578 5829 674 9583 5308 5830 674 3080 9583 5831 6816 6269 5550 5832 6491 2065 3161 5833 6491 3161 4294 5834 6491 8973 2065 5835 6491 678 2638 5836 6491 2638 8973 5837 6491 1293 678 5838 4296 5443 5130 5839 4296 6364 5443 5840 4296 1962 6364 5841 4296 6064 6230 5842 4296 6230 4493 5843 4296 4493 1962 5844 4296 53 6064 5845 4296 5130 53 5846 5552 408 7417 5847 5552 7417 9903 5848 5552 2947 408 5849 3611 3808 2475 5850 3611 2475 9257 5851 3611 5145 8768 5852 3611 8768 3808 5853 3611 9257 5145 5854 8768 2496 3808 5855 8768 2720 2496 5856 8768 2786 2720 5857 3354 7105 2475 5858 3354 8710 7105 5859 3354 2475 3808 5860 9937 4676 6228 5861 9937 5804 4676 5862 6531 8783 6108 5863 6531 2720 8783 5864 6531 6228 3134 5865 6531 3134 2720 5866 6343 8783 6858 5867 6343 6108 8783 5868 6343 6858 6007 5869 6343 6007 6108 5870 8582 5510 7 5871 8582 8685 5510 5872 8582 9903 8685 5873 2286 692 8483 5874 2286 8483 2890 5875 2286 2890 5854 5876 2286 2058 692 5877 2838 9970 1681 5878 3302 317 1249 5879 3302 1249 6536 5880 1378 1681 9970 5881 1249 317 5091 5882 789 8483 692 5883 6088 7772 8155 5884 6088 7448 7772 5885 482 7191 7561 5886 482 7561 7613 5887 482 7613 3780 5888 482 8155 2658 5889 482 3780 8155 5890 7271 6527 660 5891 7271 9177 6527 5892 7271 8489 9177 5893 2658 8155 7772 5894 3534 7191 4137 5895 3534 7561 7191 5896 3534 4137 4035 5897 3534 4035 7561 5898 7891 9813 6376 5899 7891 4803 9813 5900 7891 9526 4803 5901 7891 515 9526 5902 7891 6376 515 5903 9526 9107 8605 5904 9526 8605 7569 5905 9526 7569 4803 5906 455 6376 9813 5907 455 9813 2491 5908 455 2491 9738 5909 1573 2062 6691 5910 7942 3243 6634 5911 7942 8309 3243 5912 7942 6634 6656 5913 9827 4487 3095 5914 9738 8690 1255 5915 9738 2491 8690 5916 4354 2194 9024 5917 4354 6690 2194 5918 4354 1255 6690 5919 5815 1632 8496 5920 5815 4499 5005 5921 5815 894 4499 5922 5815 8496 894 5923 2270 9018 1631 5924 2270 4607 4537 5925 2270 4264 4607 5926 2270 4537 9018 5927 248 3993 4264 5928 248 3873 3993 5929 4607 9336 4537 5930 4607 4264 3993 5931 4607 3993 9336 5932 7394 660 6527 5933 3839 3290 7877 5934 5257 6592 7197 5935 5257 9107 7877 5936 5257 7197 9107 5937 5257 7877 3290 5938 2516 7877 9107 5939 4642 7072 8069 5940 583 9756 5183 5941 583 1126 7648 5942 542 4077 7104 5943 542 4320 4077 5944 542 7104 9756 5945 2243 4372 6207 5946 2243 8321 4372 5947 2243 6207 4874 5948 2243 3090 8321 5949 1274 481 1359 5950 6395 2154 8541 5951 6395 7888 2154 5952 6395 8541 283 5953 283 8541 2345 5954 283 2345 8376 5955 6396 4119 4570 5956 6381 508 9126 5957 6381 7659 508 5958 6381 9126 6207 5959 6381 6207 7659 5960 397 7101 1314 5961 397 7926 7101 5962 397 7659 7926 5963 397 1314 7659 5964 3887 1906 4173 5965 3887 741 1906 5966 4677 4173 1906 5967 9502 741 5916 5968 9502 1906 741 5969 9502 5916 7101 5970 5916 1314 7101 5971 5916 8856 1314 5972 5916 741 8856 5973 3708 6829 3030 5974 3708 3030 6228 5975 3708 7985 3298 5976 3708 3298 6829 5977 3708 4676 7985 5978 3708 6228 4676 5979 4676 9477 7985 5980 3406 5809 4031 5981 3406 4031 8492 5982 3406 135 5809 5983 3406 888 4623 5984 3406 4623 135 5985 888 2957 4623 5986 3706 2363 4998 5987 3706 4998 8546 5988 3706 3513 2330 5989 3706 8546 3513 5990 3706 2330 2363 5991 5076 2363 280 5992 5076 6338 2363 5993 5076 280 9172 5994 5076 3298 7985 5995 5076 7985 6338 5996 5076 9172 3298 5997 6911 8520 8398 5998 6911 2096 8520 5999 6911 9690 2096 6000 3651 8284 7280 6001 3651 7280 3205 6002 3651 3292 8284 6003 9421 8099 8284 6004 9421 8284 7195 6005 9421 7195 9879 6006 1277 9685 6318 6007 1277 855 9685 6008 1277 4727 855 6009 4871 6449 7228 6010 4719 2163 4505 6011 4719 3205 2163 6012 6696 8978 1228 6013 6696 3681 8978 6014 6696 4986 3681 6015 6696 1228 6599 6016 6696 6599 4727 6017 6696 4727 3415 6018 6696 3415 4986 6019 7136 5997 7909 6020 5929 4309 5746 6021 5929 104 4309 6022 5929 4382 5997 6023 5929 5746 4382 6024 8741 8767 1915 6025 8741 7710 8767 6026 8741 1129 7710 6027 6813 5387 483 6028 6813 483 9825 6029 6813 8767 5387 6030 7730 7764 7841 6031 7730 8831 5475 6032 7730 7841 8831 6033 4265 915 3567 6034 4265 3567 3364 6035 9325 9774 9334 6036 9325 9334 7195 6037 9325 7195 3292 6038 34 3541 1048 6039 8160 9616 9864 6040 8160 7810 9616 6041 8160 9864 3994 6042 8160 3994 2706 6043 8160 2706 7810 6044 6102 9339 7123 6045 6102 3976 9339 6046 6102 5892 3976 6047 6102 9719 5892 6048 4120 5777 8703 6049 4120 8703 7995 6050 4120 7995 613 6051 8163 8850 4327 6052 8163 8412 8850 6053 8850 8674 4327 6054 8850 7420 8674 6055 8850 9685 7420 6056 8850 8412 9685 6057 613 7995 2163 6058 7326 1292 6944 6059 7326 6944 3754 6060 7103 91 318 6061 7103 318 3928 6062 91 8278 18 6063 91 18 708 6064 91 708 9425 6065 91 9425 318 6066 91 8960 8278 6067 5473 7885 7019 6068 5473 7019 8293 6069 5473 1939 7885 6070 5473 8293 1939 6071 6754 320 2257 6072 6754 2257 7035 6073 6754 5921 320 6074 5921 6204 320 6075 7192 6542 1192 6076 7192 1192 554 6077 7192 554 9792 6078 6549 4845 3475 6079 6549 3475 6189 6080 6549 6189 6542 6081 5202 1854 4845 6082 5202 6542 695 6083 5202 695 7010 6084 5202 7010 151 6085 5202 151 1854 6086 5345 3983 9348 6087 5345 3811 3983 6088 5998 1363 3811 6089 5998 8665 1363 6090 5998 1741 158 6091 5998 158 8665 6092 5998 6125 1741 6093 5998 5937 6125 6094 5998 3811 5937 6095 2265 1741 6125 6096 2265 4898 1741 6097 2265 3220 7019 6098 2265 6125 3220 6099 2265 7019 4898 6100 8642 3475 4845 6101 4454 9446 4624 6102 5729 2776 113 6103 5729 3233 2776 6104 5729 3989 3233 6105 2637 1375 3160 6106 2637 3160 716 6107 2637 716 1054 6108 3285 6267 7727 6109 3285 1991 6267 6110 3285 1054 1991 6111 3285 7727 1054 6112 9787 1535 1375 6113 6496 2014 979 6114 6496 8417 2014 6115 6496 197 3140 6116 6496 979 197 6117 6496 3140 8417 6118 4441 7302 228 6119 924 5918 7456 6120 924 7456 2679 6121 924 2679 9241 6122 924 9241 2474 6123 924 2474 1811 6124 6760 8417 6884 6125 6760 6884 2894 6126 6760 7235 8417 6127 6760 5506 7235 6128 6760 6938 5506 6129 6760 1833 6938 6130 6760 2894 1833 6131 25 6938 1833 6132 25 4275 6938 6133 6910 7111 4601 6134 6910 4601 9713 6135 6910 3140 3877 6136 6910 3522 3140 6137 6910 3877 3582 6138 6910 3582 7111 6139 6910 9713 3522 6140 4070 1688 4771 6141 4070 4771 4492 6142 4697 2211 8291 6143 9067 2227 8291 6144 9067 8291 1244 6145 9067 1244 6552 6146 5939 8747 9841 6147 5939 4601 8747 6148 7630 2703 7815 6149 7630 7815 3987 6150 8598 9934 3873 6151 8598 7215 9934 6152 7866 7431 790 6153 7866 790 9004 6154 2310 9071 9901 6155 2310 9901 1397 6156 2310 1397 5112 6157 2310 6394 7489 6158 2310 7489 9071 6159 6394 9853 7489 6160 9853 9071 7489 6161 9853 7829 9071 6162 9853 2664 7829 6163 7668 6115 2664 6164 7668 7704 6115 6165 2161 8232 6854 6166 2161 4841 8611 6167 2161 8611 8232 6168 7380 9603 1337 6169 7380 1337 8611 6170 7380 8611 4841 6171 3695 7396 9254 6172 3695 3175 7396 6173 3695 9254 6300 6174 3695 5404 3175 6175 3695 6300 7829 6176 9254 7829 6300 6177 9254 4881 7829 6178 9254 7396 4881 6179 8235 6366 4906 6180 8235 4906 7586 6181 8235 4255 6366 6182 8235 4632 4255 6183 8235 7335 4632 6184 8235 9278 7335 6185 8235 7586 9278 6186 3710 9786 5824 6187 3710 3985 9786 6188 3710 1530 3985 6189 3710 7803 4736 6190 3710 5824 7803 6191 3710 4736 1530 6192 6450 4687 1184 6193 497 5650 5756 6194 5576 946 3790 6195 5576 2841 946 6196 5576 3790 1082 6197 5875 9557 2666 6198 5875 2666 4075 6199 5875 4075 5058 6200 5875 5058 9557 6201 6826 5058 4075 6202 7304 6159 4271 6203 7304 4271 6659 6204 7304 6659 5837 6205 7304 5837 6283 6206 7304 6283 3584 6207 7304 3584 6159 6208 5379 4931 8465 6209 5379 8465 3676 6210 5379 4559 4931 6211 5379 9139 4559 6212 5379 8602 9139 6213 5379 3676 8602 6214 9139 8602 1815 6215 4452 6453 412 6216 4452 412 7225 6217 4452 7225 918 6218 4452 9478 4438 6219 4452 4438 6453 6220 9041 6557 6639 6221 9041 2618 6557 6222 9041 6639 1903 6223 9041 1903 3836 6224 9041 3836 2618 6225 4931 918 7225 6226 4931 7225 756 6227 4931 3468 8465 6228 4931 5466 3468 6229 4931 3836 5466 6230 4931 756 3836 6231 4931 4559 918 6232 3729 6139 9128 6233 3729 2865 6139 6234 3729 3272 7384 6235 3729 9128 3937 6236 3729 7384 2865 6237 3937 9128 7291 6238 6139 9488 5018 6239 6139 5018 7626 6240 6139 7626 9128 6241 6139 2865 2259 6242 6139 2259 9488 6243 3078 3430 1623 6244 3078 1623 9588 6245 3078 9588 3430 6246 7882 5931 8463 6247 7882 8463 7027 6248 7882 7027 9595 6249 312 1634 3772 6250 312 6545 1634 6251 312 6597 6545 6252 312 759 6012 6253 312 6012 3192 6254 312 3192 6597 6255 312 3772 759 6256 8874 9707 9832 6257 8874 9174 9640 6258 3320 4769 3999 6259 3320 3999 5432 6260 3633 5747 1890 6261 3633 3828 5747 6262 9380 5019 3414 6263 9380 6688 5019 6264 9380 8244 4358 6265 9380 4358 6688 6266 3086 5977 9259 6267 3086 9259 6579 6268 3086 9975 5977 6269 3086 6579 4462 6270 3086 2949 9975 6271 3086 4462 2949 6272 8317 8244 7884 6273 8317 6032 8244 6274 8317 7884 2009 6275 8317 2949 7831 6276 8317 7831 6032 6277 8317 2009 2949 6278 7204 2009 1319 6279 7204 1319 1516 6280 5786 5879 3663 6281 5786 5505 5879 6282 5786 3663 1703 6283 5786 1703 2743 6284 4202 6535 1890 6285 1099 3913 8298 6286 1099 8298 3016 6287 1099 6538 3913 6288 8298 8466 241 6289 8298 241 390 6290 8298 3913 8466 6291 8298 390 3016 6292 4723 4321 4148 6293 4 5287 1514 6294 5807 2354 9083 6295 9507 3999 4769 6296 1742 9015 2183 6297 1742 2183 7591 6298 1742 7591 4333 6299 416 6924 284 6300 416 284 8415 6301 416 8415 5318 6302 416 5318 6924 6303 7252 9036 6558 6304 7252 4480 9036 6305 7696 7992 7460 6306 7696 7460 2962 6307 7696 4794 7992 6308 7696 6558 4794 6309 2835 5830 3076 6310 2835 3895 1315 6311 2835 3076 3895 6312 1238 227 4511 6313 1238 5135 227 6314 1238 912 5830 6315 1238 5830 5135 6316 5179 5459 4496 6317 5179 8480 5459 6318 5000 4349 8038 6319 5000 9070 4349 6320 5229 6680 3569 6321 2617 1326 1740 6322 2617 5648 1326 6323 2617 6680 9516 6324 2617 9516 5648 6325 2617 3569 6680 6326 9704 4384 535 6327 3571 9252 5648 6328 3571 4389 9252 6329 3571 5066 4389 6330 3571 5110 5066 6331 3287 5021 7775 6332 729 3881 5280 6333 2927 9070 3221 6334 2927 200 9070 6335 2323 454 2000 6336 2323 2000 1860 6337 6073 9140 6625 6338 7976 1985 6136 6339 2214 2741 487 6340 2214 487 7775 6341 2129 9159 7106 6342 2129 8542 7130 6343 2129 3915 8542 6344 2129 7106 3915 6345 8542 2631 7130 6346 8542 3915 30 6347 8542 30 2631 6348 9132 5066 5110 6349 228 6686 113 6350 228 113 4792 6351 228 7302 2050 6352 5110 5255 6072 6353 8315 2622 6072 6354 8315 9241 2679 6355 8315 2679 2622 6356 2790 6871 9729 6357 2790 9302 6871 6358 1559 659 1529 6359 1559 294 659 6360 8871 1529 6166 6361 8871 6166 8788 6362 5175 3798 7546 6363 5175 7546 352 6364 5175 9993 3798 6365 5175 2643 1183 6366 5175 6552 2643 6367 5175 1183 9993 6368 7546 3798 5201 6369 7546 9399 352 6370 7546 5201 9399 6371 8986 3255 1496 6372 8986 1496 8913 6373 8986 972 3255 6374 8986 8913 2227 6375 8986 352 972 6376 7991 5217 9203 6377 7991 9203 9196 6378 7991 9196 9509 6379 6871 5217 9729 6380 8103 7936 8348 6381 8103 6434 7936 6382 5624 1760 1862 6383 5624 9473 1760 6384 5624 5161 9473 6385 5624 1862 5161 6386 9241 4971 5161 6387 9241 5161 2474 6388 1772 2760 3907 6389 1772 3870 2760 6390 1772 3907 9898 6391 9943 6562 9226 6392 9943 9226 8522 6393 9943 8460 3870 6394 9943 7848 8460 6395 9943 8522 7848 6396 9943 3870 6562 6397 4850 8619 5531 6398 4850 6308 8619 6399 4850 6900 6308 6400 4850 1738 6900 6401 4850 5531 1738 6402 819 5698 8800 6403 7978 1982 2329 6404 7978 2329 2160 6405 7978 2536 1982 6406 7978 2160 3002 6407 7978 3002 594 6408 7978 594 1243 6409 7978 1243 2536 6410 4513 2329 9982 6411 4513 6431 2329 6412 4513 4006 5366 6413 4513 7501 4006 6414 4513 9982 7501 6415 4513 5366 6431 6416 9470 7460 7992 6417 1465 6187 2834 6418 1465 2834 4574 6419 1465 7168 6187 6420 1465 4633 7168 6421 1465 4254 4633 6422 1465 4574 4254 6423 8220 1423 9765 6424 8220 9765 4482 6425 211 5614 4030 6426 2872 3626 6772 6427 2872 6166 3626 6428 4809 3099 8145 6429 4809 8145 434 6430 4809 434 9044 6431 6896 7751 7533 6432 6896 7533 9047 6433 6896 9047 7751 6434 4063 6370 9010 6435 4063 9108 6370 6436 3444 9688 6370 6437 3444 399 9688 6438 3444 6370 9407 6439 3444 9407 1088 6440 3444 1088 399 6441 7834 5493 6735 6442 7834 6735 297 6443 7834 297 973 6444 7834 330 5493 6445 7834 9688 6526 6446 7834 973 9688 6447 7834 6526 330 6448 1880 399 5965 6449 1880 5668 399 6450 1880 373 5668 6451 1880 2419 373 6452 1880 1346 2419 6453 1880 5965 1346 6454 7011 244 3502 6455 7011 3502 9223 6456 7011 9223 3101 6457 7011 3101 6801 6458 7011 6801 244 6459 3554 6805 244 6460 3554 9947 6805 6461 3554 244 4112 6462 3554 4112 9947 6463 465 4124 8612 6464 465 8612 1073 6465 465 7156 5509 6466 465 5509 4124 6467 465 1073 7156 6468 8908 7156 1073 6469 8908 1073 6242 6470 7584 4924 2415 6471 7584 5975 4924 6472 5132 2115 8604 6473 5132 8604 5064 6474 5132 2610 2115 6475 5132 5064 418 6476 3101 501 1770 6477 3101 9223 501 6478 4283 7229 3094 6479 4283 675 7229 6480 4283 9635 9400 6481 4283 3094 9635 6482 9579 5437 9026 6483 9579 2501 2383 6484 9579 2383 3121 6485 9579 3121 5437 6486 5984 742 1916 6487 5984 7138 7143 6488 5984 1916 7138 6489 5984 7231 3512 6490 5984 7143 7231 6491 4750 4823 675 6492 4750 3606 4823 6493 5411 9882 4853 6494 5411 9155 9882 6495 5411 1245 9155 6496 5411 7907 1245 6497 5411 4853 2857 6498 5411 2857 235 6499 5411 235 7907 6500 8227 9068 8502 6501 6477 4377 3460 6502 6477 7319 4377 6503 2995 839 4287 6504 2995 4287 4897 6505 2995 3652 839 6506 5738 4636 6328 6507 5738 6328 2108 6508 5738 2761 5196 6509 5738 2108 2761 6510 5738 5196 5666 6511 5738 4976 5009 6512 5738 5666 4976 6513 5738 5009 4636 6514 4345 8019 7482 6515 4345 7482 9661 6516 4345 9661 4287 6517 4345 6328 8019 6518 4345 2179 6328 6519 6271 7482 8019 6520 6271 4636 7482 6521 6271 8019 6328 6522 6271 6328 4636 6523 7482 4326 9347 6524 7482 2530 4326 6525 7482 9347 9661 6526 7482 4636 8215 6527 7482 8215 2530 6528 4519 834 9968 6529 4519 9968 2179 6530 1323 839 8795 6531 1323 4287 839 6532 1323 6761 4287 6533 354 6738 7860 6534 354 4016 6738 6535 354 1494 4016 6536 9739 3655 1716 6537 9739 5490 4021 6538 9739 169 5490 6539 9739 1716 169 6540 2515 131 3655 6541 2515 3655 7457 6542 2515 3700 131 6543 2515 6569 3700 6544 2515 7457 6569 6545 6412 8124 1508 6546 6412 1508 9696 6547 6412 9696 8583 6548 6412 4357 8124 6549 6412 8583 3376 6550 6412 3376 4357 6551 4627 8124 4357 6552 9821 9721 5611 6553 9821 681 9721 6554 6390 2611 2887 6555 6390 4891 2611 6556 6390 5611 1284 6557 6390 1284 4891 6558 6390 2887 5611 6559 1284 9721 9781 6560 1284 9781 7687 6561 1284 5611 9721 6562 1284 1831 4891 6563 1284 7687 1831 6564 2661 3992 6544 6565 2661 6544 8635 6566 2661 2942 4483 6567 2661 4483 2782 6568 2661 2782 3992 6569 7865 832 681 6570 4052 3593 4220 6571 4052 4220 6176 6572 5548 7663 7224 6573 5548 9118 7663 6574 1683 8077 9866 6575 1683 9866 856 6576 1683 1240 781 6577 1683 781 8077 6578 1683 856 1240 6579 7532 4182 788 6580 7532 788 6653 6581 7532 6653 9115 6582 7532 9929 4182 6583 6075 7114 680 6584 4554 7433 2973 6585 4554 428 7433 6586 4554 4115 428 6587 78 6669 856 6588 78 856 428 6589 78 428 4115 6590 78 4115 7667 6591 9760 3057 6345 6592 9760 4453 3057 6593 9760 6345 9021 6594 606 6345 3057 6595 606 3057 2950 6596 606 2950 8180 6597 606 8180 8034 6598 736 1148 9913 6599 736 3039 1148 6600 736 6467 3039 6601 736 2523 6467 6602 736 9913 2523 6603 3650 8684 6525 6604 8860 9571 5703 6605 8860 5703 6623 6606 7528 6435 2830 6607 7528 1875 6435 6608 7528 2804 6274 6609 7528 2830 2804 6610 7528 6274 8982 6611 7528 8982 8876 6612 7528 8876 1875 6613 132 1197 7792 6614 132 3769 1197 6615 132 7792 9363 6616 132 9363 3716 6617 132 3716 8982 6618 132 8982 6274 6619 132 6274 3769 6620 8982 3716 1830 6621 8982 1638 8876 6622 8982 1830 1638 6623 2100 3482 6902 6624 2100 4216 3482 6625 2100 5864 4216 6626 2100 8346 5864 6627 2100 2425 1830 6628 2100 1830 8346 6629 2100 6902 2425 6630 2425 6582 1638 6631 2425 1638 1830 6632 2425 6902 6582 6633 138 3082 1662 6634 138 2687 3082 6635 138 3520 2687 6636 138 2142 3520 6637 3315 917 967 6638 3315 967 2421 6639 3315 2421 3944 6640 3315 3944 8230 6641 3315 6618 917 6642 102 8250 2843 6643 102 4066 8250 6644 7961 9771 4369 6645 7961 4369 9531 6646 2292 3016 9236 6647 2292 2569 3016 6648 2292 2354 2569 6649 1613 7037 1684 6650 4097 9771 2122 6651 1908 7798 7464 6652 1908 7464 8360 6653 1908 8360 793 6654 8992 1667 1768 6655 8992 1768 1080 6656 8992 1080 13 6657 9478 1418 4438 6658 9478 4581 1418 6659 9478 6040 1068 6660 9478 1068 5492 6661 9478 5492 4581 6662 7653 5636 7543 6663 7653 5452 5636 6664 7653 5492 3070 6665 7653 3070 5452 6666 7653 7543 5492 6667 2220 4240 9868 6668 2220 5275 4240 6669 2220 9868 6922 6670 2220 6922 7786 6671 9006 1902 4635 6672 9006 3132 5474 6673 9006 5474 7329 6674 9006 7329 1902 6675 7246 3386 6663 6676 2754 8046 8356 6677 2754 8028 8046 6678 2754 8356 3386 6679 1579 5067 6868 6680 1579 6868 4708 6681 1579 7780 9897 6682 8420 6169 8481 6683 8420 4008 6169 6684 1776 9156 1168 6685 1776 1168 2371 6686 1262 9547 3060 6687 436 82 1271 6688 436 9920 82 6689 436 7329 9920 6690 8920 2736 1747 6691 8920 1747 3856 6692 8920 3856 9275 6693 8920 3351 2736 6694 8920 9275 3351 6695 4524 621 930 6696 4524 7806 621 6697 4524 930 8952 6698 4524 8952 4722 6699 4524 4722 7806 6700 930 954 5872 6701 930 3601 954 6702 930 621 3601 6703 930 7110 8952 6704 930 5872 7110 6705 5620 893 4060 6706 5620 4060 1978 6707 5620 1978 3515 6708 5620 804 1226 6709 5620 1226 893 6710 8096 2602 3691 6711 8096 2897 828 6712 8096 3691 2897 6713 3831 8178 8034 6714 3831 6968 8178 6715 3831 1166 6968 6716 3831 8180 2063 6717 3831 2063 1166 6718 3831 8034 8180 6719 4527 8471 3032 6720 1622 4304 282 6721 1622 282 8112 6722 1622 7089 4304 6723 7305 1382 6200 6724 7305 3275 1382 6725 7305 2710 5727 6726 7305 5727 4835 6727 7305 4835 3275 6728 7305 503 2710 6729 7305 6200 503 6730 4868 2655 205 6731 4868 205 3047 6732 2440 205 2655 6733 8355 3709 5465 6734 8355 4580 3709 6735 8117 6739 5615 6736 8117 5615 6193 6737 2090 4440 1335 6738 2090 1335 2273 6739 2090 2273 2095 6740 2090 3328 105 6741 2090 105 4440 6742 2090 6724 1801 6743 2090 1801 3328 6744 2090 2095 6724 6745 6724 2095 9845 6746 6724 9845 5826 6747 6724 5826 2632 6748 6724 2794 1801 6749 6724 2632 2794 6750 5141 9962 2200 6751 5141 2200 4269 6752 6822 5819 8451 6753 642 5441 9839 6754 9962 4546 2200 6755 732 602 3805 6756 732 4485 602 6757 4555 3367 1105 6758 4555 1105 5291 6759 4555 602 3367 6760 4555 4269 3805 6761 4555 3805 602 6762 4422 702 4269 6763 4422 6715 7201 6764 4422 7201 5088 6765 4422 5088 702 6766 1227 8088 3445 6767 1227 3445 4394 6768 1227 8854 8088 6769 881 1144 7511 6770 881 8595 1144 6771 2013 1464 9234 6772 977 3236 4232 6773 2789 210 7352 6774 5782 4170 9030 6775 5782 8724 4170 6776 5782 9030 561 6777 5782 561 4032 6778 5782 4032 8724 6779 533 1607 4435 6780 533 4435 6590 6781 533 561 4207 6782 533 6590 561 6783 533 4207 1607 6784 8683 992 1287 6785 8683 5694 992 6786 8683 6212 5694 6787 8683 1607 4207 6788 8683 1287 1607 6789 8683 4207 6212 6790 9695 1466 9079 6791 9695 9079 9849 6792 9695 420 1466 6793 9695 3370 420 6794 9695 1287 4884 6795 9695 9849 1287 6796 5294 1033 4678 6797 9462 5157 1675 6798 9462 503 5157 6799 159 7856 4015 6800 159 4015 9537 6801 159 9537 61 6802 159 6941 7856 6803 9911 7790 8066 6804 9911 9392 7790 6805 9911 4498 9392 6806 9911 8066 4498 6807 5220 4498 4304 6808 5220 9392 4498 6809 5220 4304 7089 6810 7631 4149 7379 6811 7631 7379 7901 6812 7631 7901 3433 6813 115 8451 3437 6814 115 4147 8451 6815 115 3437 7107 6816 115 7107 6633 6817 115 6633 4147 6818 2294 2107 3454 6819 2294 3454 9079 6820 2294 9671 2107 6821 2294 1466 9671 6822 2294 9079 1466 6823 4256 4206 4023 6824 4256 1204 4206 6825 2684 7116 8192 6826 2684 9554 7116 6827 4239 838 7560 6828 4239 4268 838 6829 5061 8323 8804 6830 5609 2107 5236 6831 5609 4162 5860 6832 5236 9671 4147 6833 5236 2107 9671 6834 5236 4147 9618 6835 7821 8804 7705 6836 3466 2824 2896 6837 3466 1330 2824 6838 4323 9250 8890 6839 4323 9936 9250 6840 9250 1294 8890 6841 9250 2339 1294 6842 9250 3777 2339 6843 1004 3032 8471 6844 8451 5819 3437 6845 8451 4147 9671 6846 5572 2959 1352 6847 5572 1352 4019 6848 4658 6628 1769 6849 4658 1769 2630 6850 4658 3464 1672 6851 4658 1672 6628 6852 4658 38 3464 6853 6398 3204 701 6854 6398 701 4092 6855 6398 5212 6907 6856 6398 6907 3204 6857 6426 7277 5212 6858 6426 8109 7277 6859 9 9873 8719 6860 9 969 9873 6861 9 8181 969 6862 9 4208 7874 6863 9 7874 6781 6864 9 8719 4208 6865 9 6781 8181 6866 1165 3525 2098 6867 1165 2098 22 6868 7547 5661 7022 6869 7547 7698 5661 6870 7547 4274 7698 6871 551 9382 2559 6872 2592 7980 4481 6873 2592 3470 7980 6874 6404 6814 5796 6875 6404 7286 7346 6876 6404 8834 7286 6877 6404 7346 7222 6878 6404 5796 8834 6879 3668 1000 8756 6880 3668 8756 4942 6881 3668 4942 6981 6882 5798 1000 9587 6883 5798 7222 8756 6884 5798 8756 1000 6885 5798 9447 7222 6886 1652 5972 2311 6887 1652 2311 3217 6888 1652 4691 534 6889 1652 8877 4691 6890 1652 3217 8877 6891 1652 534 5972 6892 7435 1083 1840 6893 7435 1840 685 6894 7435 5946 1083 6895 7435 685 3470 6896 7435 3470 5946 6897 4779 7794 3975 6898 9002 7636 3787 6899 5063 6407 7451 6900 5063 7451 1542 6901 6972 6087 1911 6902 6972 7804 6087 6903 6972 1911 87 6904 8608 8111 2609 6905 8608 2146 8111 6906 5720 7260 2139 6907 5720 777 7260 6908 5720 4300 7965 6909 5720 7965 777 6910 5720 2146 4300 6911 5720 8111 2146 6912 6969 4397 7804 6913 6969 526 4104 6914 6969 4104 4397 6915 6969 1897 526 6916 446 7163 2651 6917 446 6834 7163 6918 446 486 2965 6919 446 2965 6834 6920 7100 2651 3056 6921 7100 3056 6603 6922 3986 8754 1109 6923 3986 6254 8754 6924 3986 1109 5716 6925 3986 5716 745 6926 3986 745 6254 6927 188 6289 7167 6928 188 7167 8085 6929 188 7343 1057 6930 188 1057 6289 6931 188 7554 7343 6932 188 8085 7554 6933 9461 3025 2783 6934 9461 5752 3025 6935 9461 8435 5752 6936 4808 5381 9908 6937 4808 9908 2140 6938 4808 2140 2587 6939 4808 9742 5381 6940 4808 2587 2508 6941 4808 2508 4350 6942 4808 4350 9742 6943 3657 2510 1826 6944 4077 6581 7104 6945 4077 4320 2333 6946 3917 8148 7269 6947 3917 208 8148 6948 3917 7269 208 6949 3286 8662 5770 6950 7220 4570 4119 6951 2358 4276 2260 6952 3919 9101 195 6953 3919 7789 9101 6954 4516 7648 1126 6955 5808 6591 6609 6956 5808 6609 9914 6957 5808 2078 6591 6958 5183 9961 6581 6959 5183 6581 8813 6960 5183 9756 9961 6961 9726 7957 7409 6962 2395 9022 6121 6963 2395 2066 9022 6964 2395 6121 4696 6965 2395 4696 2066 6966 7318 7658 4696 6967 7318 6198 10002 6968 7318 10002 7658 6969 5171 1303 112 6970 246 5632 5887 6971 6154 7881 479 6972 6154 479 4877 6973 4952 558 3968 6974 4952 4307 558 6975 7364 74 5418 6976 1561 5418 9748 6977 1561 3119 5418 6978 3212 9585 4151 6979 3212 4151 8557 6980 1551 9934 8975 6981 1551 8975 5503 6982 4399 7203 559 6983 4399 559 5882 6984 4399 6792 7203 6985 8963 7203 6792 6986 8963 6792 7957 6987 8963 3469 7203 6988 8963 7251 3469 6989 2584 326 4974 6990 2596 4086 3613 6991 2596 3613 4974 6992 2596 4974 326 6993 2596 326 2671 6994 1023 9327 1403 6995 4783 232 48 6996 4783 6612 232 6997 4783 4499 894 6998 4783 894 6612 6999 8462 3012 8004 7000 8462 8631 3012 7001 3369 9908 3570 7002 929 77 2470 7003 929 9651 77 7004 929 2365 9651 7005 5723 2470 1691 7006 5723 1691 8578 7007 4276 5324 8661 7008 4276 8661 5295 7009 4276 5295 2260 7010 4586 1077 3570 7011 4586 1953 1077 7012 4586 3570 5381 7013 4586 5381 1953 7014 4564 1658 1522 7015 4564 7701 1658 7016 7334 2853 152 7017 6648 4705 6966 7018 2493 1327 8981 7019 2493 9103 1327 7020 8981 1327 2554 7021 2853 1013 152 7022 152 5454 9573 7023 152 9573 1457 7024 152 1013 5454 7025 152 1457 2453 7026 5454 9155 2861 7027 5454 2861 9573 7028 5454 1013 9155 7029 7180 8054 8811 7030 7180 8811 5480 7031 7120 8654 7314 7032 7120 6126 8654 7033 7120 7314 7947 7034 7120 1665 6126 7035 2092 5550 8269 7036 678 2765 2638 7037 678 8458 3176 7038 678 1293 8458 7039 678 3176 2765 7040 8458 9009 3176 7041 8458 8454 9009 7042 8458 1293 6114 7043 8458 6114 8454 7044 8973 2141 2065 7045 8973 2638 2141 7046 6064 2256 8082 7047 6064 8082 6230 7048 6064 9544 2256 7049 6064 6812 9544 7050 6064 53 6812 7051 1419 6230 8139 7052 1419 8139 9692 7053 1419 5618 1766 7054 1419 1766 8265 7055 1419 8265 6230 7056 1419 9692 5618 7057 5115 1999 2570 7058 5115 2570 3 7059 5115 3 5293 7060 5115 307 1999 7061 5115 5293 307 7062 2947 663 408 7063 2947 2475 663 7064 2947 9257 2475 7065 2475 7105 663 7066 42 8397 4348 7067 42 4994 8397 7068 2168 5510 9291 7069 2168 7 5510 7070 6858 1849 6007 7071 615 9291 1269 7072 7228 5849 5529 7073 7228 5529 5279 7074 7228 5279 3528 7075 7228 3379 5849 7076 7228 3396 3379 7077 7228 6449 3396 7078 2319 2504 5279 7079 2319 8536 2504 7080 2319 5279 2058 7081 7499 1269 9291 7082 7499 9291 9480 7083 7499 9480 8536 7084 9368 7613 2890 7085 9368 2890 8483 7086 6955 8155 3780 7087 2194 8334 9024 7088 2194 8119 9555 7089 2194 6690 8119 7090 5858 9813 8119 7091 5858 8690 9813 7092 5858 1255 8690 7093 5858 6690 1255 7094 5858 8119 6690 7095 4137 9375 4035 7096 7561 7852 7613 7097 7561 4035 7852 7098 4803 7569 1190 7099 4803 1190 9813 7100 9107 6592 8605 7101 9107 7197 6592 7102 3095 4487 1566 7103 3095 1566 8309 7104 894 7016 6612 7105 894 8496 7016 7106 6592 4512 8605 7107 9756 7104 9961 7108 4874 6207 9126 7109 4874 9126 508 7110 4874 508 9094 7111 1359 481 4412 7112 1359 4412 3090 7113 2882 2682 2154 7114 2882 2154 7888 7115 9101 9748 3943 7116 9101 3943 195 7117 7659 2969 7463 7118 7659 7463 7926 7119 7659 6207 4372 7120 7659 4372 2969 7121 7659 1314 508 7122 2720 3134 2496 7123 2720 2786 8783 7124 7752 7463 2969 7125 7752 2969 1694 7126 7752 8397 7463 7127 7752 4376 4348 7128 7752 1694 4376 7129 7752 4348 8397 7130 8011 2330 7390 7131 8011 7390 4031 7132 8011 280 2330 7133 8011 4031 5809 7134 8011 5809 280 7135 4623 4012 135 7136 4623 7272 4012 7137 4623 2957 7272 7138 7272 9669 1224 7139 7272 1224 8394 7140 7272 8394 4012 7141 7272 8707 2424 7142 7272 2957 8707 7143 7272 2424 9669 7144 8707 447 2424 7145 8707 5726 447 7146 8707 1766 5618 7147 8707 5618 5726 7148 2330 3513 7390 7149 2330 280 2363 7150 6338 3537 2363 7151 6338 7985 3537 7152 9690 222 8461 7153 9690 8461 2396 7154 9690 494 222 7155 9690 7042 494 7156 9690 2396 2096 7157 8398 7500 1454 7158 8398 8520 7500 7159 8767 7710 2807 7160 8767 2807 9049 7161 8767 9049 410 7162 8767 410 5387 7163 8284 3292 7195 7164 8284 8099 7280 7165 6318 9685 8307 7166 6318 8307 8099 7167 9455 5187 2766 7168 9455 4505 5187 7169 9455 8948 4505 7170 3205 9932 2163 7171 3205 7280 9932 7172 9932 7280 6403 7173 3415 8228 4986 7174 3108 9480 5510 7175 3108 464 8701 7176 3108 5510 464 7177 5997 4382 7909 7178 8468 2511 7311 7179 8468 3669 2511 7180 4382 5746 5979 7181 4382 5979 3669 7182 4382 3669 7909 7183 7968 3036 2254 7184 7968 3541 3036 7185 5475 7164 8078 7186 5475 8078 5639 7187 5475 8521 7164 7188 7764 944 7841 7189 7764 3840 944 7190 7764 5639 3840 7191 1048 3364 4106 7192 7417 4244 8685 7193 7417 408 4244 7194 7417 8685 9903 7195 2203 3567 8685 7196 2203 6895 3567 7197 2203 8685 4244 7198 2203 4244 6895 7199 1061 636 848 7200 1061 7029 636 7201 1061 3226 2984 7202 1061 848 3226 7203 1061 2984 9719 7204 1061 9719 2956 7205 1061 2956 7029 7206 5728 7495 2956 7207 5728 4911 7495 7208 5728 2956 2582 7209 9864 5149 9386 7210 9864 9386 3994 7211 9864 9616 3976 7212 9864 3976 5149 7213 7123 9339 5777 7214 8412 6403 8307 7215 8412 8307 9685 7216 1601 2512 5172 7217 1601 5172 6443 7218 1601 3928 7049 7219 1601 7049 2512 7220 1292 320 6204 7221 1292 6204 6944 7222 1292 6443 320 7223 590 3754 4012 7224 590 4012 8394 7225 318 9425 7885 7226 318 7885 7049 7227 318 7049 3928 7228 7885 9425 7019 7229 7885 1939 7049 7230 320 6443 2257 7231 3211 9172 543 7232 3211 543 3754 7233 8710 2629 7105 7234 60 8594 7948 7235 60 9792 8594 7236 60 7948 4969 7237 8312 9592 6034 7238 8312 6034 695 7239 8312 5425 9592 7240 8312 4969 5425 7241 6542 6189 7778 7242 6542 7778 3918 7243 6542 3918 1192 7244 2096 4862 2393 7245 2096 2393 9963 7246 2096 9963 8520 7247 2096 2396 4862 7248 1560 641 3220 7249 1560 3220 8613 7250 9348 3983 2472 7251 9348 2472 1198 7252 3220 641 4117 7253 3220 4117 8293 7254 3220 8293 7019 7255 3220 6125 5937 7256 3220 5937 8613 7257 1741 4898 2886 7258 1741 2886 158 7259 4117 7351 3278 7260 4117 3278 8293 7261 4117 3313 8002 7262 4117 8002 7351 7263 4117 641 3313 7264 4845 1854 3313 7265 4845 3313 641 7266 9446 4970 4624 7267 1535 7302 7135 7268 1535 2050 7302 7269 1535 3877 1375 7270 1535 7135 3877 7271 1054 716 1991 7272 1054 7727 4970 7273 1054 4970 1066 7274 6686 1066 113 7275 1375 3877 3140 7276 1375 3140 3160 7277 3140 3522 8417 7278 3140 197 3160 7279 7302 9584 7135 7280 5918 4951 978 7281 3522 9713 6884 7282 3522 6884 8417 7283 8747 9584 7244 7284 8747 7244 9841 7285 8747 3825 9584 7286 8747 4601 3825 7287 3610 4771 1688 7288 3610 8913 4771 7289 3610 1688 7513 7290 2211 1092 5197 7291 2211 1811 1092 7292 2211 1244 8291 7293 2211 5197 1244 7294 8885 3045 7879 7295 8885 8577 3045 7296 8885 7879 4295 7297 2703 801 7815 7298 5120 9336 3993 7299 5120 9481 9336 7300 5120 7717 9481 7301 3873 9934 3993 7302 9976 441 3662 7303 9976 7173 441 7304 9976 6195 7173 7305 7431 3581 790 7306 7431 4867 3581 7307 7431 1281 4867 7308 7213 4912 5730 7309 7213 925 4912 7310 7213 3527 925 7311 7213 3157 3527 7312 7213 5730 3157 7313 2664 9286 1732 7314 2664 6115 9286 7315 6379 7635 9730 7316 6379 9730 1762 7317 6379 6844 7635 7318 6379 9603 6844 7319 6379 1337 9603 7320 6379 1762 1337 7321 4610 9986 7635 7322 4610 9286 9986 7323 4610 8172 9286 7324 4610 6844 8172 7325 4610 7635 6844 7326 4528 5759 9935 7327 4528 9935 9265 7328 4528 1402 5759 7329 4528 2521 7704 7330 4528 1554 2521 7331 4528 9265 1554 7332 6578 9098 3184 7333 6578 3184 4632 7334 6578 4632 9098 7335 9278 7338 7335 7336 9278 2937 7338 7337 9278 8879 2937 7338 9278 7586 8879 7339 6608 7161 2237 7340 6608 4525 7161 7341 6608 9309 4525 7342 6608 7296 9309 7343 6608 2237 7296 7344 9309 7661 7803 7345 9309 7803 4525 7346 9309 7296 9751 7347 9309 9751 7661 7348 7161 5674 9098 7349 7161 9098 2237 7350 7161 8663 5048 7351 7161 4525 8663 7352 7161 5048 5674 7353 5048 8141 5674 7354 5048 7665 8141 7355 5048 8663 7665 7356 4736 7803 7661 7357 4736 7661 1178 7358 4736 1178 1530 7359 3862 1983 3054 7360 3862 2293 1983 7361 3862 7903 7984 7362 3862 7984 7152 7363 3862 7152 2293 7364 3862 3054 7903 7365 5100 8820 7903 7366 5100 9240 8820 7367 5100 7903 3054 7368 5100 3054 9240 7369 8243 5938 6456 7370 8243 6456 7621 7371 8243 7621 8089 7372 8243 8089 5933 7373 8243 1453 5938 7374 8243 360 1453 7375 8243 7132 360 7376 8243 5933 7132 7377 5650 1067 2841 7378 5650 9751 1067 7379 3000 8791 3463 7380 3000 3463 361 7381 3000 7610 8791 7382 5995 3893 5811 7383 5995 1349 3893 7384 5995 536 1349 7385 5995 5811 4920 7386 5995 4920 7187 7387 1082 3790 2597 7388 1082 2597 7187 7389 2740 2597 9935 7390 2740 9935 5759 7391 2740 5759 6303 7392 2740 6303 9557 7393 2740 9557 5058 7394 2740 5058 2597 7395 6303 1402 2666 7396 6303 5759 1402 7397 6303 2666 9557 7398 5837 6659 5356 7399 5837 5356 6283 7400 5641 62 4271 7401 5641 8962 62 7402 5641 4271 1630 7403 5641 8184 8962 7404 5641 124 8184 7405 5641 1397 3743 7406 5641 3743 124 7407 5641 5112 1397 7408 5641 1630 5112 7409 6040 8043 1068 7410 6040 9381 8043 7411 8533 4438 1418 7412 8533 4724 4438 7413 8533 9438 7725 7414 8533 7725 4724 7415 8533 1418 9438 7416 7725 9438 8491 7417 7725 8491 8926 7418 7725 7200 4724 7419 7725 9113 7200 7420 7725 8926 9113 7421 6639 6023 1903 7422 6639 6066 6023 7423 6639 5176 6066 7424 6639 5136 5176 7425 6639 8306 2771 7426 6639 2771 5136 7427 6639 6557 8306 7428 8465 8945 9667 7429 8465 3468 8945 7430 8465 4814 3676 7431 8465 9667 4814 7432 4404 630 5527 7433 4404 5527 1313 7434 4404 2606 630 7435 4404 5708 2606 7436 4404 1313 5708 7437 5427 1521 2259 7438 5427 5900 1521 7439 5427 6441 5900 7440 5427 2259 2865 7441 5427 2865 6441 7442 7384 3272 8390 7443 7384 8390 9483 7444 7384 9483 2865 7445 9128 7626 7291 7446 5018 9488 1824 7447 5018 1824 9170 7448 5018 9170 7626 7449 9251 1623 3717 7450 9251 1965 1623 7451 9251 3717 5412 7452 9251 3355 1965 7453 9251 5412 3355 7454 2989 9840 3430 7455 2989 3430 3822 7456 2989 614 9840 7457 2989 3822 614 7458 1623 3430 9840 7459 1623 9840 3717 7460 1623 1965 9588 7461 7027 1869 8675 7462 7027 8463 1869 7463 7027 8675 9595 7464 9238 6131 3307 7465 9238 8092 6131 7466 6605 3916 5931 7467 759 4508 6012 7468 759 3772 8092 7469 9640 5747 5853 7470 9640 5853 3916 7471 3828 5853 5747 7472 3828 1869 5853 7473 3414 1890 6535 7474 3414 6535 5622 7475 2949 1730 3663 7476 2949 3663 9975 7477 2949 2009 1945 7478 2949 1945 1730 7479 2949 4462 7831 7480 6538 9964 8466 7481 6538 4846 9964 7482 6538 8466 3913 7483 3016 390 9236 7484 2843 8250 157 7485 9015 1585 2183 7486 3307 6131 1585 7487 2183 6145 7591 7488 2183 7413 6145 7489 2183 1585 7413 7490 5318 8415 5154 7491 5318 5154 4237 7492 5318 4237 5102 7493 5318 5102 6924 7494 2252 1011 5086 7495 2252 3667 1011 7496 2845 7490 1586 7497 2845 4571 7490 7498 2845 6145 6709 7499 2845 4543 6145 7500 2845 3666 4543 7501 2845 6709 4571 7502 2845 1586 3666 7503 2781 3906 7032 7504 2781 7032 4785 7505 2781 3666 1586 7506 2781 1586 3906 7507 2781 4785 3666 7508 1315 3895 8888 7509 1315 8888 7295 7510 1315 7295 8806 7511 5830 4375 5135 7512 5830 912 3076 7513 4511 227 2428 7514 9140 6454 9252 7515 9140 9252 6625 7516 8038 4349 1656 7517 5648 9252 6454 7518 5648 6454 1326 7519 7795 5135 4375 7520 7795 4267 5135 7521 7795 4375 9227 7522 9900 9133 9788 7523 9900 1452 9133 7524 8006 9247 3221 7525 8006 3221 7118 7526 8006 7118 4709 7527 3196 1151 2306 7528 3196 6823 1151 7529 3196 9190 6574 7530 3196 6574 6823 7531 3196 2306 9190 7532 3020 9732 622 7533 3020 622 7777 7534 3020 7777 7402 7535 3020 9001 9732 7536 191 6232 7266 7537 3989 873 3233 7538 8803 535 6979 7539 8803 6979 1260 7540 8803 1260 9516 7541 535 4384 539 7542 1529 659 6166 7543 1183 2643 29 7544 1183 29 9993 7545 7646 5197 1092 7546 7646 1092 1862 7547 7646 1862 1760 7548 7646 1760 6552 7549 7646 6552 5197 7550 9399 4892 352 7551 9399 5201 9586 7552 9399 9586 9359 7553 9399 9359 9724 7554 9399 9724 4892 7555 972 352 4892 7556 972 4892 4355 7557 972 4355 3255 7558 8348 7936 4618 7559 9473 2643 1760 7560 9473 7936 2643 7561 9473 5161 7936 7562 3907 2760 5502 7563 3907 5502 9898 7564 3870 8460 2760 7565 3870 2111 6562 7566 6562 2213 5037 7567 6562 5037 9226 7568 6562 2111 2213 7569 4585 9226 1423 7570 4585 1423 2399 7571 4585 7848 8522 7572 4585 8522 9226 7573 1738 2112 9498 7574 1738 9498 6900 7575 1738 5531 783 7576 1738 783 6349 7577 1738 6349 2112 7578 9460 292 6499 7579 9460 6499 8951 7580 9460 8951 7240 7581 9460 8241 5062 7582 9460 5062 292 7583 9460 7240 8241 7584 7467 4007 4655 7585 7467 128 4007 7586 7467 4655 5515 7587 7467 5515 128 7588 6550 4655 6705 7589 6550 6705 997 7590 6550 4112 4655 7591 6550 4774 4112 7592 6550 5971 4774 7593 6550 3261 5971 7594 6550 997 3261 7595 9070 3495 4349 7596 9070 200 3495 7597 6831 4349 3495 7598 6831 1028 539 7599 6831 539 4384 7600 6831 3495 1028 7601 8800 5698 7470 7602 6951 6601 6499 7603 6951 6499 3533 7604 9498 2091 8213 7605 9498 8213 1113 7606 9498 1113 6601 7607 9498 2112 3755 7608 9498 3755 2091 7609 1243 594 8669 7610 1243 8669 480 7611 1243 8213 2536 7612 1243 480 8213 7613 9982 8328 4523 7614 9982 4523 7501 7615 9982 2329 8328 7616 4782 4329 2697 7617 4782 2697 9898 7618 4782 2701 5300 7619 4782 9898 2701 7620 4782 5300 4329 7621 2701 129 5163 7622 2701 5163 5300 7623 2701 9898 129 7624 5568 6142 2213 7625 5568 2213 2111 7626 5568 2111 6786 7627 5568 6786 2697 7628 7825 8432 7127 7629 7825 7127 1580 7630 7825 8367 8432 7631 7762 9298 330 7632 7762 9490 9298 7633 7762 330 373 7634 7762 373 1132 7635 7762 1132 9490 7636 6187 7168 2184 7637 6187 2184 1506 7638 6187 1506 2834 7639 2184 7168 5446 7640 2184 5446 1506 7641 7811 7578 1930 7642 7811 1930 334 7643 7811 4018 7578 7644 7811 5446 4018 7645 7811 334 5446 7646 4018 9105 5493 7647 4018 6192 9105 7648 4018 5493 8838 7649 4018 8838 7578 7650 4018 7168 6611 7651 4018 5446 7168 7652 4018 6611 9187 7653 4018 9187 6192 7654 9411 8790 9754 7655 9411 2359 8790 7656 9411 8555 2279 7657 9411 2279 3636 7658 9411 3636 2359 7659 9411 9754 8555 7660 4482 9765 1266 7661 4482 1266 1210 7662 1210 8145 5614 7663 1210 434 8145 7664 1210 1266 434 7665 3099 5614 8145 7666 3099 5855 5614 7667 3099 5856 5855 7668 7533 2441 2580 7669 7533 2580 8300 7670 7533 5856 2441 7671 7533 5855 5856 7672 7533 7751 4030 7673 7533 4030 1167 7674 7533 8300 9047 7675 7533 1167 5855 7676 4030 5614 1167 7677 4030 7751 2279 7678 6772 3626 1523 7679 6772 1523 5856 7680 2441 5856 1859 7681 2441 1859 2580 7682 9010 6370 9688 7683 9010 9688 7355 7684 9407 6370 1358 7685 9407 1358 9819 7686 9407 9819 5089 7687 9407 5089 1218 7688 9407 5965 1088 7689 9407 1218 5965 7690 1088 5965 399 7691 5089 8722 3967 7692 5089 9819 8722 7693 5089 3967 2798 7694 5089 2798 2447 7695 5089 2447 1218 7696 6526 9688 399 7697 6526 399 5668 7698 6526 373 330 7699 6526 5668 373 7700 1346 5502 2419 7701 1346 129 5502 7702 1346 5965 6962 7703 1346 6962 129 7704 1597 9688 973 7705 1597 1596 9688 7706 1597 973 297 7707 1597 297 1596 7708 9317 6463 9823 7709 9317 9823 7906 7710 9317 9612 3316 7711 9317 3316 6463 7712 9317 4301 9612 7713 9317 7906 4301 7714 244 6805 3502 7715 244 3316 4112 7716 244 6801 3316 7717 4124 1491 8925 7718 4124 8925 8612 7719 6242 1073 418 7720 4936 1073 8612 7721 2115 7925 8604 7722 2115 0 7925 7723 2115 2610 2415 7724 2115 2415 0 7725 1770 501 8726 7726 1770 8726 958 7727 1770 958 8262 7728 1770 8262 9823 7729 9400 9635 1263 7730 9400 1263 7813 7731 9400 7813 3472 7732 2641 3512 9318 7733 2641 9318 8680 7734 2641 5776 3512 7735 2641 1096 2501 7736 2641 2501 5776 7737 2641 8680 1096 7738 2501 1096 2383 7739 9026 5437 3084 7740 9026 3084 6178 7741 9026 6178 6926 7742 3512 9087 9318 7743 3512 7231 9087 7744 1657 7392 5260 7745 1657 5260 7281 7746 1657 6410 4572 7747 1657 8918 6410 7748 1657 4572 7392 7749 1657 1181 8918 7750 1657 7281 1181 7751 1181 4022 8918 7752 1181 7281 3606 7753 4853 9882 5424 7754 4853 7833 2857 7755 4853 5424 7833 7756 5366 4006 862 7757 5366 862 4597 7758 5366 2948 6431 7759 5366 4597 2948 7760 1600 9741 9610 7761 1600 9610 7036 7762 1600 3374 9741 7763 1600 4193 3374 7764 1600 7036 4193 7765 1392 4933 3291 7766 1392 3291 7541 7767 1392 9610 4491 7768 1392 4491 2388 7769 1392 7541 9610 7770 1392 2388 4933 7771 9068 7039 5608 7772 9068 5608 8502 7773 839 3652 8795 7774 8215 4636 4310 7775 8215 4310 5165 7776 8215 5165 279 7777 8215 279 2530 7778 5009 4976 4310 7779 5009 4310 4636 7780 9968 834 4964 7781 9968 4964 1325 7782 9968 1325 2179 7783 4021 3114 795 7784 4021 5490 3114 7785 5304 5490 169 7786 5304 1716 131 7787 5304 169 1716 7788 5304 131 3700 7789 5408 1481 1787 7790 5408 1787 6880 7791 5408 6880 5740 7792 6569 5832 3700 7793 8796 4357 8485 7794 8796 8485 5608 7795 3376 8583 8339 7796 3376 8339 9221 7797 3376 2280 8502 7798 3376 8502 8485 7799 3376 8485 4357 7800 3376 9221 2280 7801 8795 3652 8502 7802 9924 1508 8124 7803 9924 2210 1508 7804 9696 2210 5580 7805 9696 5580 8583 7806 9696 1508 2210 7807 680 1589 6317 7808 680 6317 8339 7809 680 7114 1589 7810 2887 7883 6480 7811 2887 2611 7883 7812 2887 6480 1885 7813 9721 681 7844 7814 9721 7844 9781 7815 403 9925 8053 7816 3992 3004 6544 7817 832 5981 7844 7818 832 4483 5981 7819 832 7844 681 7820 832 2782 4483 7821 6176 6863 9118 7822 6176 2136 6863 7823 6176 1257 2136 7824 6176 4220 1257 7825 1240 6669 5868 7826 1240 5868 9448 7827 1240 856 6669 7828 1240 9448 781 7829 9306 6794 2386 7830 9306 2386 4338 7831 9306 4338 7433 7832 7224 8329 2386 7833 7224 1321 8329 7834 7224 7663 1321 7835 7224 2386 6794 7836 1677 9553 2299 7837 1677 5612 9553 7838 3655 131 1716 7839 9929 795 4182 7840 5025 3308 8498 7841 2973 7433 8691 7842 2973 8691 9021 7843 7667 4115 4859 7844 7667 4859 1638 7845 7667 1638 6582 7846 2523 9468 7756 7847 2523 7756 6467 7848 2523 975 9468 7849 1148 3039 4838 7850 8493 4402 9448 7851 9571 471 5703 7852 6274 2804 3769 7853 8346 1830 3716 7854 8346 3716 9363 7855 8346 9363 2001 7856 8346 2001 5864 7857 6902 5868 6582 7858 6902 3482 5868 7859 9834 4534 1936 7860 9834 1936 877 7861 9834 5883 4534 7862 9834 3425 3132 7863 9834 877 3425 7864 9834 3132 5883 7865 3425 5474 3132 7866 3425 8814 5474 7867 3425 877 6352 7868 3425 6352 7493 7869 3425 7493 4714 7870 3425 4714 8814 7871 4240 5665 9868 7872 4240 9424 5665 7873 4240 5275 9636 7874 4240 9636 9424 7875 1662 270 8429 7876 1662 3082 270 7877 8429 270 3829 7878 8429 3827 2467 7879 8429 3829 3827 7880 9628 9145 4449 7881 9628 847 9145 7882 9628 4449 2019 7883 9628 2019 4760 7884 9628 4760 847 7885 7702 967 6306 7886 7702 6533 967 7887 7702 6306 2283 7888 7702 2940 6533 7889 7702 2283 2940 7890 2917 3274 5070 7891 2917 3322 3274 7892 5659 4369 3015 7893 5659 6510 4369 7894 5659 3015 5070 7895 5659 5070 3274 7896 5659 3274 3073 7897 5659 3073 4795 7898 5659 4795 6510 7899 8230 3944 5823 7900 1883 6618 156 7901 1883 9722 6618 7902 1883 156 9356 7903 1883 9356 9722 7904 1205 1684 7037 7905 1205 7037 5471 7906 2636 3521 3618 7907 2636 2180 5028 7908 2636 3618 2180 7909 7798 5028 7425 7910 7798 7425 7464 7911 2180 3521 9795 7912 2180 9795 639 7913 2180 639 7425 7914 2180 7425 5028 7915 2180 3618 3521 7916 8360 957 1871 7917 8360 2620 957 7918 8360 7425 639 7919 8360 639 2620 7920 8360 7464 7425 7921 8360 1871 793 7922 6306 967 793 7923 6306 793 1871 7924 6306 1871 2283 7925 3617 7731 3110 7926 3617 3388 7731 7927 3617 6815 6554 7928 3617 6554 3197 7929 3617 3197 3089 7930 3617 3089 3388 7931 3617 3110 6815 7932 164 9888 7572 7933 164 812 9888 7934 164 827 6061 7935 164 7572 827 7936 164 6061 1550 7937 164 1550 4550 7938 164 4550 812 7939 1550 5127 4550 7940 1550 9980 5127 7941 1550 6061 9980 7942 1768 1667 1460 7943 1768 1460 1080 7944 5492 7543 4581 7945 5492 1068 3070 7946 4581 7543 4813 7947 4581 4813 1418 7948 3168 767 2463 7949 3168 2463 2233 7950 3168 2233 8233 7951 3168 8233 9547 7952 7537 9867 1168 7953 7537 1168 5133 7954 7537 2463 9867 7955 7537 8057 2463 7956 7537 5133 8057 7957 597 4615 1778 7958 597 8841 4615 7959 4947 8481 1483 7960 4947 9897 8481 7961 4947 921 9919 7962 4947 1483 921 7963 4947 9919 4134 7964 7045 6868 5067 7965 7045 304 6868 7966 7045 1484 304 7967 7045 4134 1484 7968 5275 3465 9636 7969 5275 88 3465 7970 7329 5474 9920 7971 3386 8356 6663 7972 6169 1483 8481 7973 1271 82 5020 7974 1271 5020 4660 7975 1271 4660 5604 7976 4534 3351 1936 7977 4534 5883 3351 7978 7263 5491 9025 7979 7263 3351 5491 7980 7263 1936 3351 7981 7263 2549 7809 7982 7263 7809 1936 7983 7263 9025 2549 7984 2736 6663 1747 7985 2736 3351 5883 7986 8952 9572 4722 7987 8952 7110 9572 7988 1230 4305 9580 7989 1230 9580 4565 7990 1230 7110 9313 7991 1230 9313 4305 7992 1230 4565 7110 7993 8101 4549 6120 7994 8101 6120 2752 7995 8101 7487 1867 7996 8101 2752 7487 7997 8101 1867 4549 7998 2452 6036 3238 7999 2452 3238 4972 8000 2452 4609 6036 8001 2452 4161 2819 8002 2452 1417 4161 8003 2452 4972 1417 8004 2452 828 4609 8005 4907 3231 5269 8006 4907 5269 3544 8007 4907 6683 3231 8008 4907 3544 3599 8009 4907 3599 8688 8010 4907 8688 6683 8011 3599 8313 3238 8012 3599 3544 8313 8013 3599 6036 8688 8014 3599 3238 6036 8015 804 7987 5219 8016 804 9021 7987 8017 804 5219 1226 8018 828 2897 4609 8019 8180 5600 2063 8020 8180 2950 5600 8021 1002 5945 3766 8022 1002 3766 1819 8023 1002 6914 5945 8024 1002 1819 6914 8025 9757 5945 1428 8026 9757 1428 7949 8027 9757 7949 3766 8028 9757 3766 5945 8029 3344 4812 7977 8030 3344 170 4812 8031 3344 212 170 8032 3344 7977 9183 8033 3344 2221 7171 8034 3344 7171 212 8035 3344 3129 2221 8036 3344 9183 3129 8037 4304 4498 6429 8038 4304 6429 282 8039 2552 7089 3296 8040 2552 3296 3271 8041 2552 3271 8068 8042 805 992 9699 8043 805 7931 992 8044 805 9699 8471 8045 8112 282 927 8046 288 7181 3275 8047 288 3275 5160 8048 288 5160 9662 8049 288 9662 7908 8050 288 7908 927 8051 288 927 282 8052 288 282 2202 8053 288 2202 7181 8054 9662 633 8246 8055 9662 5160 633 8056 9662 2920 5422 8057 9662 5422 2663 8058 9662 2663 7908 8059 9662 8246 2920 8060 2710 2344 5727 8061 9471 2438 6445 8062 9471 879 2438 8063 9471 3047 205 8064 9471 205 879 8065 9471 9125 3047 8066 9471 6445 9125 8067 5615 6739 581 8068 5615 4074 6193 8069 5615 5649 4074 8070 5615 581 5649 8071 3576 3328 4076 8072 3576 105 3328 8073 3576 9052 105 8074 3576 4076 9052 8075 3328 1801 4056 8076 3328 4056 4076 8077 2794 2632 3922 8078 2794 3922 1801 8079 7077 6715 5043 8080 7077 7201 6715 8081 7077 5043 2814 8082 7077 6144 9420 8083 7077 9420 7201 8084 7077 2814 6144 8085 2206 7165 6715 8086 2206 4394 7165 8087 4269 2200 3805 8088 4269 702 5441 8089 8854 5033 8088 8090 8854 1144 5033 8091 3367 6173 1105 8092 3367 602 4485 8093 1144 6173 7511 8094 1144 1105 6173 8095 1144 8595 5033 8096 1144 5291 1105 8097 3363 6173 4232 8098 3363 7511 6173 8099 3363 4232 3236 8100 1464 7372 9234 8101 8088 7411 3445 8102 8088 9608 7411 8103 8088 5033 9608 8104 210 7740 15 8105 210 2517 4352 8106 210 4352 8677 8107 210 15 2517 8108 210 8677 7352 8109 772 5960 9699 8110 772 9699 9958 8111 772 5694 4170 8112 772 4170 1968 8113 772 1968 5960 8114 772 9958 5694 8115 9030 4170 5694 8116 9030 5694 6212 8117 9030 4207 561 8118 9030 6212 4207 8119 6191 1607 9849 8120 6191 9849 3021 8121 6191 4435 1607 8122 1287 7840 4884 8123 1287 992 7840 8124 1287 9849 1607 8125 3740 2381 6307 8126 3740 6307 2758 8127 3740 2758 1033 8128 722 4968 9682 8129 722 1172 4968 8130 722 9682 1990 8131 1675 8342 2849 8132 1675 5157 8342 8133 61 9537 8031 8134 61 4678 1033 8135 61 8031 4678 8136 7790 3946 7112 8137 7790 7112 8169 8138 7790 8169 8066 8139 7790 9392 3946 8140 4498 7181 2202 8141 4498 1382 7181 8142 4498 8066 1382 8143 4498 2202 6429 8144 9397 8068 7112 8145 9397 7112 3946 8146 4328 7018 2282 8147 4328 2282 1751 8148 4328 1436 7018 8149 4328 9202 1436 8150 4328 1751 9202 8151 6378 1943 5184 8152 6378 5184 5633 8153 6378 5633 109 8154 4149 3035 7379 8155 4149 8724 3035 8156 4149 9593 8724 8157 6633 7107 9575 8158 6633 9618 4147 8159 8020 1379 6243 8160 8020 6243 693 8161 4206 6590 4023 8162 4206 3035 6590 8163 4206 1204 3035 8164 899 109 885 8165 8192 7116 3592 8166 838 5982 7560 8167 4162 3021 5860 8168 1832 3603 305 8169 2896 1458 7736 8170 2896 2824 1458 8171 9554 9775 7116 8172 9554 305 9775 8173 2426 9056 686 8174 5346 3437 5819 8175 5346 9826 3437 8176 5346 2316 50 8177 5346 5819 2316 8178 5346 50 9826 8179 4872 50 2316 8180 4872 4019 50 8181 4872 2316 5819 8182 6244 6722 7887 8183 6244 5570 6722 8184 6244 7887 1886 8185 6244 1886 3612 8186 6244 3612 5570 8187 1886 7887 6508 8188 1886 6508 2289 8189 1458 2824 103 8190 3464 2824 1565 8191 3464 1565 4322 8192 3464 4322 1672 8193 3464 38 103 8194 3464 103 2824 8195 6628 1672 3771 8196 6628 3771 1769 8197 6921 4819 8719 8198 6921 8719 9873 8199 6921 9873 226 8200 6921 3204 4819 8201 6921 226 3204 8202 6907 5212 3752 8203 6907 3752 4819 8204 6907 4819 3204 8205 7277 1717 8719 8206 7277 8719 3752 8207 7277 3752 5212 8208 7277 8109 1717 8209 8719 1717 4208 8210 8719 4819 3752 8211 969 3031 9873 8212 969 8181 3031 8213 5661 5789 5944 8214 5661 7698 5789 8215 5661 5944 489 8216 8247 1648 4274 8217 8247 4855 1648 8218 8247 8324 4855 8219 4274 4102 5364 8220 4274 5364 7698 8221 4274 1648 4102 8222 7222 1617 8756 8223 7222 7346 1617 8224 4942 7346 8501 8225 4942 1617 7346 8226 4942 8501 6981 8227 4942 8756 1617 8228 1000 1391 6297 8229 1000 6297 9587 8230 534 4691 4842 8231 534 4842 525 8232 534 525 5972 8233 2559 9965 2691 8234 2559 7899 9965 8235 2559 9382 7899 8236 3470 685 2837 8237 3470 9728 7980 8238 3975 6181 4104 8239 3975 7794 6181 8240 6766 6216 486 8241 6766 486 6682 8242 6766 6682 7794 8243 4711 2836 8414 8244 4711 9714 2836 8245 4711 3525 9714 8246 4711 5721 3525 8247 8414 2836 8712 8248 8414 8712 353 8249 8414 353 6950 8250 6950 353 908 8251 6950 908 3687 8252 4104 6181 2935 8253 4104 2935 2769 8254 4104 5476 4397 8255 4104 2769 5476 8256 9851 5235 3787 8257 9851 3787 3762 8258 9851 9887 7983 8259 9851 7983 5235 8260 87 3106 4300 8261 87 5049 3106 8262 87 24 5049 8263 87 1911 24 8264 486 6216 608 8265 486 608 178 8266 486 178 2965 8267 1774 7982 7437 8268 1774 3056 7982 8269 1774 299 5429 8270 1774 6253 299 8271 1774 7437 6253 8272 1774 5429 8692 8273 1774 8692 3056 8274 5302 6070 7308 8275 5302 7308 6253 8276 5302 7982 6070 8277 5302 7437 7982 8278 5302 6253 7437 8279 5429 299 9412 8280 5429 9412 3803 8281 5429 3803 8692 8282 7982 2614 6070 8283 7982 5497 2614 8284 7982 5594 5497 8285 7982 107 5594 8286 7982 3056 890 8287 7982 890 10000 8288 7982 10000 107 8289 2614 9561 6795 8290 2614 5497 9561 8291 2614 6795 2497 8292 2614 2497 6070 8293 116 2935 6181 8294 116 6181 9412 8295 116 1014 2935 8296 116 299 7308 8297 116 7308 1014 8298 116 9412 299 8299 1109 837 2303 8300 1109 8754 837 8301 1109 2303 5716 8302 5716 9069 745 8303 5716 4807 9069 8304 5716 2303 3631 8305 5716 3631 5050 8306 5716 5050 4807 8307 4722 9572 7897 8308 4722 7176 6117 8309 4722 6117 7806 8310 4722 7897 7176 8311 6117 797 8548 8312 6117 7176 797 8313 6117 8548 7806 8314 621 7806 7487 8315 621 7487 3601 8316 7343 7554 2916 8317 7343 2916 2650 8318 7343 2650 3301 8319 7343 3301 1057 8320 5836 4387 5305 8321 5836 6430 4387 8322 5836 7226 6430 8323 5836 8760 7226 8324 5836 5305 8760 8325 9908 5381 3570 8326 2587 9622 939 8327 2587 939 2508 8328 2587 2140 9622 8329 9622 2464 939 8330 9320 3250 656 8331 9320 2694 3250 8332 9320 656 8116 8333 9320 5906 2694 8334 9320 2464 5906 8335 9320 939 2464 8336 9320 8116 939 8337 6581 9961 7104 8338 8148 208 8202 8339 8148 8202 7323 8340 8148 7323 386 8341 8263 6609 6591 8342 8263 7574 6609 8343 8263 6591 5602 8344 2078 2032 9061 8345 2078 2020 2032 8346 2078 9061 6591 8347 2032 2432 9061 8348 2032 2665 656 8349 2032 656 2432 8350 2032 10002 2665 8351 4696 3973 2066 8352 4696 7658 3973 8353 6198 4061 1303 8354 6198 1303 10002 8355 3968 2331 9734 8356 3968 558 2331 8357 3968 9734 7881 8358 3968 7881 5014 8359 7881 7673 5014 8360 7881 9734 479 8361 6089 8362 4877 8362 6089 9734 8362 8363 6089 4877 479 8364 6089 479 9734 8365 4151 9585 6647 8366 5503 6195 5632 8367 5503 8975 6195 8368 8833 2109 9992 8369 8833 9992 4430 8370 8833 4430 5574 8371 8833 5574 4307 8372 8833 6564 2109 8373 6121 9022 7251 8374 326 3098 2671 8375 326 4194 3098 8376 2298 3662 1273 8377 3436 4086 1720 8378 3436 1720 9740 8379 3436 3613 4086 8380 3436 3359 3613 8381 3436 9740 3359 8382 6778 306 2668 8383 6778 2668 4929 8384 6778 7616 306 8385 6778 3098 7616 8386 6778 411 4086 8387 6778 4929 411 8388 9327 3965 1403 8389 2369 3739 4189 8390 2369 6455 3739 8391 2369 48 232 8392 2369 232 6455 8393 2000 8063 6130 8394 2000 5440 1860 8395 2000 9878 5440 8396 2000 6130 9878 8397 3765 2638 2765 8398 3765 2765 8772 8399 3765 1686 2638 8400 3765 8772 5177 8401 9617 8266 3033 8402 5104 5177 8772 8403 5104 8772 3176 8404 5104 3176 9009 8405 2372 8454 8954 8406 2372 8954 2365 8407 2372 9009 8454 8408 2470 3556 1691 8409 2470 77 3556 8410 8578 1691 5324 8411 4570 8353 3810 8412 1658 7701 1836 8413 1658 1836 4260 8414 1658 4260 2665 8415 1658 2665 10002 8416 5494 4683 9123 8417 5494 2453 4683 8418 5494 9123 9103 8419 6101 7955 9607 8420 6101 6262 7955 8421 6101 9634 10002 8422 6101 10002 6262 8423 1013 6966 6540 8424 1013 6540 7733 8425 1013 7733 9155 8426 4705 9116 6540 8427 4705 6540 6966 8428 656 2665 1987 8429 656 1987 8116 8430 656 3250 8672 8431 656 8672 2432 8432 9092 9123 4683 8433 9092 4409 9123 8434 1665 5106 6126 8435 2416 9544 5106 8436 9988 7859 4445 8437 9988 4445 3080 8438 9988 3080 9668 8439 9988 9668 7859 8440 5590 4423 5959 8441 5590 6163 4423 8442 5590 7947 6163 8443 6269 994 5550 8444 6269 2052 994 8445 6269 1979 2052 8446 6812 53 7307 8447 6812 7307 9544 8448 5618 538 5726 8449 5618 9692 538 8450 4493 6230 8265 8451 1644 4578 7713 8452 1644 7713 7307 8453 1644 7307 53 8454 1644 53 7350 8455 1644 7350 4578 8456 1999 7713 4578 8457 1999 307 7713 8458 1999 4578 2570 8459 5308 9583 9558 8460 5308 9558 9422 8461 5308 9422 8082 8462 5308 8082 2256 8463 6606 8032 5912 8464 6606 5443 8032 8465 6606 5912 4703 8466 6606 4703 2570 8467 6606 2570 5443 8468 851 5597 3589 8469 851 3589 683 8470 851 683 1556 8471 851 4703 5912 8472 851 5912 5597 8473 851 6700 4703 8474 851 1556 6700 8475 9375 8427 4035 8476 9375 9843 6108 8477 9375 6108 8427 8478 9375 8626 9843 8479 4994 9843 8626 8480 4994 8626 1447 8481 4994 1447 6543 8482 4994 6543 8397 8483 9291 5510 9480 8484 6449 5482 5057 8485 6449 5578 5482 8486 6449 5057 3396 8487 2058 5279 5529 8488 8334 7772 7448 8489 8334 7448 9024 8490 8489 9555 9813 8491 8489 9813 1190 8492 8489 1190 9177 8493 8119 9813 9555 8494 9813 8690 2491 8495 7569 8605 1190 8496 2873 1631 1632 8497 2873 1632 1478 8498 4537 8496 9018 8499 4537 5119 8496 8500 4537 9336 5119 8501 508 1314 9861 8502 508 1027 9094 8503 508 9861 1027 8504 8541 8653 2345 8505 8653 895 9915 8506 8653 9915 2018 8507 8653 2018 2345 8508 1314 8856 9861 8509 3134 6228 3030 8510 4348 4376 9373 8511 4348 9373 9477 8512 3754 6944 6204 8513 3754 543 676 8514 3754 135 4012 8515 3754 676 135 8516 135 676 5809 8517 4044 5597 8032 8518 4044 7390 5597 8519 4044 8032 6364 8520 4044 6364 1962 8521 2363 3537 4998 8522 3513 8546 2899 8523 3513 2899 3589 8524 3513 3589 7390 8525 3537 9477 9373 8526 3537 9373 4998 8527 3537 7985 9477 8528 1454 7500 9484 8529 1454 9484 9885 8530 1454 9885 4308 8531 1454 4308 7042 8532 4308 9772 2705 8533 4308 9885 9772 8534 4308 2705 7042 8535 410 4960 5387 8536 410 3024 4960 8537 410 9049 3024 8538 8099 8307 7280 8539 2766 5187 5578 8540 2163 7995 3427 8541 2163 3427 266 8542 2163 266 4505 8543 2801 9164 3681 8544 2801 3843 9164 8545 2801 3681 4986 8546 2801 4986 8228 8547 2801 8228 9267 8548 2801 9267 3843 8549 1228 5400 6599 8550 1228 9059 5400 8551 1228 8978 9059 8552 8228 9879 9267 8553 8701 464 3567 8554 8701 3567 915 8555 5510 8685 464 8556 8078 2980 5639 8557 8078 6998 2980 8558 8078 3665 6998 8559 7841 944 6777 8560 7841 6777 8831 8561 3036 9542 2407 8562 3036 2407 2254 8563 3036 3541 662 8564 3036 662 9542 8565 3567 464 8685 8566 3567 6895 3364 8567 4106 6895 662 8568 4106 3364 6895 8569 408 663 3123 8570 408 3123 4244 8571 9719 2984 5892 8572 9719 2582 2956 8573 2956 1410 7029 8574 2956 7495 1410 8575 9616 7810 9339 8576 9616 9339 3976 8577 5777 9339 8703 8578 1939 5172 2512 8579 1939 2512 7049 8580 1939 8293 5172 8581 9669 7670 5950 8582 9669 2424 7670 8583 9669 5950 1224 8584 7670 9033 5950 8585 7670 2424 447 8586 7670 447 9033 8587 8278 1224 5950 8588 8278 5950 18 8589 8278 8960 1224 8590 222 2481 8461 8591 7035 3278 7351 8592 7035 7351 8840 8593 7035 8840 2481 8594 7035 2257 3278 8595 6443 5172 2257 8596 554 1451 9792 8597 554 1192 1451 8598 7010 4862 5581 8599 7010 695 4862 8600 7010 5581 151 8601 1854 95 3313 8602 1854 151 95 8603 95 8002 3313 8604 95 1357 8002 8605 95 151 8840 8606 95 8840 1357 8607 9592 5425 3775 8608 9592 3775 6034 8609 7948 8594 1810 8610 7948 1810 6055 8611 7948 8875 4969 8612 7948 6055 8875 8613 8002 1357 7351 8614 6189 3475 7778 8615 2396 8461 5581 8616 2396 5581 4862 8617 8969 2629 1108 8618 8969 7042 2629 8619 8969 494 7042 8620 8969 1108 494 8621 1363 4776 3019 8622 1363 3019 6492 8623 1363 6492 3811 8624 1363 3607 4776 8625 1363 8665 3607 8626 3607 4702 4776 8627 3607 158 4702 8628 3607 8665 158 8629 5880 1198 6763 8630 5880 6763 1275 8631 5880 1275 7771 8632 3811 6492 3983 8633 148 6992 5613 8634 148 5613 1988 8635 148 7966 6992 8636 148 1988 239 8637 148 239 7966 8638 2725 3112 2226 8639 2725 2226 9308 8640 2725 8596 3112 8641 2725 9308 8596 8642 9606 2226 3112 8643 9606 8623 2226 8644 9606 6938 8623 8645 9606 5506 6938 8646 9606 3112 5506 8647 2776 3233 873 8648 2776 873 30 8649 2776 30 4792 8650 2776 4792 113 8651 4970 7727 4624 8652 4970 113 1066 8653 7135 9931 3877 8654 7135 9584 3825 8655 7135 3825 9931 8656 2014 3329 979 8657 2014 7235 3329 8658 2014 8417 7235 8659 197 979 9182 8660 197 9182 3160 8661 9584 978 7244 8662 7111 9931 3825 8663 7111 3582 9931 8664 7111 3825 4601 8665 2894 6884 9713 8666 9841 7244 4951 8667 801 4295 7815 8668 9169 306 7616 8669 9169 5495 306 8670 9169 7616 5495 8671 5311 8362 9283 8672 5311 4877 8362 8673 5311 9481 7717 8674 5311 9283 9481 8675 5311 7717 4877 8676 9481 9283 9336 8677 3662 441 6174 8678 3662 6174 1273 8679 790 2889 9004 8680 790 3581 2889 8681 4911 2437 3167 8682 4911 3167 7495 8683 4911 9004 2889 8684 4911 2889 4544 8685 4911 4544 2437 8686 3157 6461 52 8687 3157 52 8150 8688 3157 8150 3527 8689 3157 5730 9645 8690 3157 9645 6461 8691 8587 9645 4590 8692 8587 2667 9645 8693 8587 3736 2123 8694 8587 2123 2667 8695 8587 9417 3535 8696 8587 2981 9417 8697 8587 4590 2981 8698 8587 3535 3736 8699 6014 8093 4958 8700 6014 6687 8093 8701 6014 5246 6878 8702 6014 4958 5246 8703 6014 6878 6687 8704 9071 4881 9901 8705 9071 7829 4881 8706 1732 9286 8172 8707 1732 8172 766 8708 9603 8172 6844 8709 9603 766 8172 8710 2473 9286 6115 8711 2473 1376 9286 8712 2473 6115 6215 8713 2473 6215 1376 8714 7704 6215 6115 8715 7704 5876 6215 8716 7704 2521 5876 8717 8611 1337 1278 8718 8611 1278 8232 8719 7396 3175 6744 8720 7396 6744 7600 8721 7396 7600 4881 8722 2341 1424 1032 8723 2341 1032 7332 8724 2341 7332 8474 8725 2341 4826 5431 8726 2341 5431 1424 8727 2341 8474 4826 8728 1032 1424 4398 8729 1032 4398 8766 8730 1032 8766 7332 8731 7975 4255 2593 8732 7975 2593 7383 8733 7975 6366 4255 8734 7975 7383 8387 8735 7975 8387 2862 8736 7975 2862 9858 8737 7975 9858 4906 8738 7975 4906 6366 8739 3184 7868 4255 8740 3184 9098 7868 8741 3184 4255 4632 8742 7335 7338 4632 8743 7296 8436 5472 8744 7296 5472 8699 8745 7296 8699 9751 8746 7296 2237 8436 8747 5824 9786 3185 8748 5824 3185 8725 8749 5824 7665 8663 8750 5824 8725 7665 8751 5824 8663 7803 8752 5674 9582 9098 8753 5674 9472 9582 8754 5674 8141 9472 8755 7803 8663 4525 8756 7903 8820 7984 8757 5938 1453 4444 8758 5938 4444 6456 8759 5933 7152 5071 8760 5933 5071 2612 8761 5933 8089 7152 8762 5933 2612 7132 8763 1910 9508 6076 8764 3790 946 381 8765 3790 381 8880 8766 3790 5237 2597 8767 3790 9779 5237 8768 3790 8880 9779 8769 7610 4920 3463 8770 7610 3463 8791 8771 1067 8699 2841 8772 1067 9751 8699 8773 1283 7820 3853 8774 1283 3853 4222 8775 1283 8825 7820 8776 1283 361 8825 8777 3853 7820 1513 8778 3853 1745 3198 8779 3853 1513 1745 8780 2521 2216 5876 8781 2521 5512 2216 8782 2521 1554 5512 8783 4920 5811 3463 8784 2597 5237 9935 8785 4075 2938 1030 8786 431 5112 1630 8787 431 1630 6159 8788 431 6159 3584 8789 431 3584 2938 8790 6159 1630 4271 8791 1397 9901 7600 8792 1397 7600 3743 8793 6389 5206 2488 8794 6389 9113 5206 8795 6389 2985 9113 8796 6389 2488 2985 8797 4724 6453 4438 8798 4724 412 6453 8799 4724 7200 412 8800 6557 2488 6148 8801 6557 6148 8306 8802 6557 165 2488 8803 6557 2618 165 8804 3676 4814 8258 8805 3676 8258 2029 8806 3676 2029 8602 8807 630 9940 1995 8808 630 1995 5527 8809 630 2606 9940 8810 9824 3854 4167 8811 9824 4167 4475 8812 9824 9051 8868 8813 9824 8083 9051 8814 9824 4475 8083 8815 9824 8868 3854 8816 206 8390 6784 8817 206 4616 8390 8818 206 6784 2309 8819 206 2309 3531 8820 206 3531 9457 8821 206 9457 4616 8822 2865 9483 3693 8823 2865 3693 6441 8824 7626 2262 7291 8825 7626 3085 2262 8826 7626 9170 3085 8827 3272 2309 6784 8828 3272 6784 8390 8829 3355 5467 4500 8830 3355 3103 5467 8831 3355 4500 1965 8832 3355 5412 2627 8833 3355 2627 3103 8834 9840 818 3717 8835 9840 614 818 8836 8494 5536 9447 8837 8494 818 5536 8838 8494 9587 818 8839 6012 9630 3192 8840 6012 462 9630 8841 6012 4508 2492 8842 6012 2492 462 8843 9595 8675 4508 8844 5931 3916 8463 8845 8092 4571 6709 8846 8092 6709 6131 8847 8092 8565 4571 8848 8092 3772 8565 8849 5019 6688 1869 8850 7919 1319 7884 8851 7919 5622 1319 8852 2009 7884 1319 8853 1730 1703 3663 8854 1730 1945 1703 8855 5879 5310 3663 8856 5879 9531 6510 8857 5879 6510 5310 8858 6535 1516 5622 8859 9236 390 2398 8860 2457 6388 7186 8861 2457 4148 4321 8862 2457 7186 4148 8863 1585 6131 7413 8864 7146 4652 5083 8865 7146 3083 4652 8866 7146 5083 4285 8867 7146 4285 7115 8868 7146 7115 3083 8869 5154 5262 7492 8870 5154 8415 5262 8871 5154 6595 4237 8872 5154 7492 6595 8873 6558 6595 4794 8874 6558 9036 4237 8875 6558 4237 6595 8876 7927 3967 3658 8877 7927 3658 5086 8878 7927 1011 2798 8879 7927 5086 1011 8880 7927 2798 3967 8881 5092 1011 6575 8882 5092 2798 1011 8883 5092 2447 2798 8884 5092 6575 2447 8885 1876 3906 1575 8886 1876 1575 8544 8887 1876 8162 284 8888 1876 8544 8162 8889 1876 284 5285 8890 1876 5285 3906 8891 8162 192 284 8892 8162 5835 8130 8893 8162 8130 192 8894 8162 9859 5835 8895 8162 1069 9859 8896 8162 8544 1069 8897 3666 4785 4543 8898 6145 5869 7591 8899 6145 7413 5978 8900 6145 5978 6709 8901 6145 4543 5869 8902 7032 3906 3849 8903 7032 3849 2404 8904 7032 9543 4785 8905 7032 2404 9543 8906 6574 9805 6015 8907 6574 9190 9805 8908 6574 8569 6823 8909 6574 6015 8569 8910 4496 5459 5749 8911 4496 5749 1174 8912 3488 6265 9984 8913 3488 9984 9811 8914 3488 9811 618 8915 3488 4414 4267 8916 3488 4267 6265 8917 3488 618 4414 8918 3895 912 8888 8919 3895 3076 912 8920 912 8656 8888 8921 6454 1740 1326 8922 4375 4709 9227 8923 4267 4414 227 8924 4267 227 5135 8925 5066 5774 4389 8926 7106 9159 5774 8927 539 1028 5684 8928 539 5684 294 8929 5217 8788 9203 8930 1949 1467 9800 8931 1949 7902 1467 8932 1949 9203 8788 8933 1949 8788 6166 8934 1949 9800 9196 8935 1949 9196 9203 8936 9196 9800 1870 8937 9196 1870 9509 8938 6552 1760 2643 8939 6552 1244 5197 8940 5201 3374 9586 8941 5201 2291 3374 8942 5201 3798 2291 8943 9724 760 4892 8944 9724 9359 760 8945 2643 7936 6434 8946 4618 7936 5161 8947 5161 1862 2474 8948 7848 1336 8460 8949 2760 7153 2419 8950 2760 2419 5502 8951 2760 8460 7153 8952 2213 4902 4558 8953 2213 4558 5037 8954 2213 6142 4902 8955 9226 5037 783 8956 9226 783 1423 8957 5531 8619 783 8958 8241 3912 5062 8959 8241 2895 3912 8960 8241 7240 2895 8961 4655 4112 5515 8962 4655 4007 6705 8963 631 2435 1859 8964 631 1859 9504 8965 631 9384 4504 8966 631 9504 9384 8967 631 363 5445 8968 631 4504 363 8969 631 5445 2435 8970 5360 7779 6359 8971 5360 9133 7779 8972 5360 6359 3645 8973 5360 4644 4212 8974 5360 3645 4644 8975 5360 4212 9133 8976 3495 9362 7843 8977 3495 7843 1028 8978 3495 200 9362 8979 9245 1523 7843 8980 9245 3889 1523 8981 9245 9362 9384 8982 9245 9384 3889 8983 9245 7843 9362 8984 7470 3069 8418 8985 7470 5698 3069 8986 6601 1113 6499 8987 2044 2536 8213 8988 2044 8347 2536 8989 2044 2091 8347 8990 2044 8213 2091 8991 2536 8347 1982 8992 8328 1982 4523 8993 8328 2329 1982 8994 7050 6431 3002 8995 7050 2329 6431 8996 7050 3002 2160 8997 7050 2160 2329 8998 9898 5502 129 8999 7460 4329 2962 9000 9989 4558 4902 9001 9989 1544 4558 9002 2417 7169 2277 9003 2417 2277 4037 9004 2417 4037 8367 9005 7169 7492 9983 9006 7169 9983 2277 9007 5702 7366 3638 9008 5702 3638 8434 9009 5702 6192 9187 9010 5702 8434 6192 9011 5702 5627 9154 9012 5702 9154 7366 9013 5702 9187 5627 9014 5627 9187 6611 9015 5627 6611 1488 9016 5627 1488 9154 9017 330 8838 5493 9018 330 9298 8838 9019 4633 6611 7168 9020 4633 4254 6611 9021 4574 5065 9332 9022 4574 9332 4254 9023 4574 2673 5065 9024 4574 2834 2673 9025 5446 6116 1506 9026 5446 334 6116 9027 1266 4225 434 9028 1266 9765 4225 9029 1167 5614 5855 9030 5856 1523 1859 9031 6370 9108 1358 9032 1218 2447 6962 9033 1218 6962 5965 9034 6962 6575 5163 9035 6962 5163 129 9036 6962 2447 6575 9037 7355 9688 1596 9038 9612 9439 5651 9039 9612 5651 8076 9040 9612 9332 9439 9041 9612 4112 3316 9042 9612 8076 4112 9043 9612 4301 9332 9044 8612 8925 5975 9045 418 5064 4747 9046 418 4747 811 9047 7156 8726 9358 9048 6825 5889 941 9049 6825 2673 5889 9050 6825 9439 9332 9051 6825 9332 5065 9052 6825 5065 2673 9053 6825 941 9439 9054 9701 5413 5515 9055 9701 5515 8515 9056 9701 941 5889 9057 9701 5889 5413 9058 9701 8076 941 9059 9701 8515 8076 9060 128 5413 7747 9061 128 7747 4007 9062 128 5515 5413 9063 6046 7906 9694 9064 6046 9694 4957 9065 6046 4957 852 9066 6046 1488 8891 9067 6046 852 1488 9068 6046 4301 7906 9069 6046 8891 4301 9070 8262 958 5925 9071 8262 5925 9694 9072 8262 9694 9823 9073 501 9223 3502 9074 501 3502 9358 9075 501 9358 8726 9076 3094 7229 8985 9077 3094 9087 7231 9078 3094 7231 9635 9079 3094 8985 9087 9080 8680 3254 6152 9081 8680 6152 1096 9082 8680 9318 3254 9083 5437 3121 3084 9084 7392 7828 1174 9085 7392 4572 7828 9086 7392 1174 5749 9087 7392 5749 5260 9088 7281 5260 3606 9089 2857 7833 235 9090 6431 4238 8571 9091 6431 8571 3002 9092 6431 4491 4238 9093 6431 2948 4491 9094 8571 4238 8746 9095 8571 8746 5521 9096 8571 5521 3002 9097 9741 4491 9610 9098 9741 4238 4491 9099 9741 8746 4238 9100 9741 3374 8746 9101 2388 2948 4933 9102 2388 4491 2948 9103 4810 9752 4191 9104 4810 3646 9752 9105 4810 4191 9415 9106 4810 9415 963 9107 4810 963 8231 9108 4810 8231 3646 9109 2761 6559 5097 9110 2761 5097 5196 9111 2761 2108 2035 9112 2761 2035 6559 9113 4897 1898 9869 9114 4897 9869 8332 9115 4897 8332 1342 9116 4897 4287 1898 9117 4310 4976 5165 9118 6328 2179 2108 9119 2108 2179 1325 9120 2108 1325 1368 9121 2108 1368 2035 9122 9347 3487 9869 9123 9347 4326 3487 9124 9347 9869 9661 9125 834 2295 4964 9126 834 7860 2295 9127 5740 6880 5485 9128 5740 1040 5490 9129 5740 5485 1040 9130 2280 9221 1494 9131 1589 8497 1060 9132 1589 7114 8497 9133 1589 1060 6317 9134 7818 1933 7000 9135 7818 7000 866 9136 7818 866 4002 9137 7818 4002 8586 9138 7818 637 1933 9139 7818 3890 637 9140 7818 8586 3890 9141 5186 3553 9418 9142 5186 9418 5151 9143 5186 7687 7867 9144 5186 5151 7687 9145 5186 7867 4965 9146 5186 4965 3553 9147 1885 7199 5225 9148 1885 6480 7199 9149 5225 8585 6221 9150 5225 7199 8585 9151 5981 9781 7844 9152 4220 3593 3476 9153 4220 3476 1257 9154 5282 8679 5542 9155 5282 7748 8679 9156 5282 5542 3593 9157 781 9448 4402 9158 4115 9028 4859 9159 4859 9337 1638 9160 4859 9028 2891 9161 4859 2891 9337 9162 3057 4453 3515 9163 3057 3515 2950 9164 893 8448 553 9165 893 4592 8448 9166 893 1226 4592 9167 893 553 4060 9168 1978 5269 2950 9169 1978 435 5269 9170 1978 4060 435 9171 1978 2950 3515 9172 4405 9817 3247 9173 4405 3247 6847 9174 4405 3496 9817 9175 4405 6847 8632 9176 4405 5325 2900 9177 4405 2900 3496 9178 4405 8632 5325 9179 7040 1967 673 9180 7040 2734 1967 9181 5703 1526 1914 9182 5703 1914 6623 9183 5703 471 1526 9184 6435 2762 2830 9185 6435 1875 2762 9186 8876 2433 1875 9187 8876 9337 2433 9188 8876 1638 9337 9189 7792 485 9363 9190 7792 5795 485 9191 7792 1197 5795 9192 3482 4216 5868 9193 877 1936 6352 9194 7809 2549 8903 9195 7809 8928 6352 9196 7809 8903 8928 9197 7809 6352 1936 9198 9868 5665 6922 9199 588 3418 3202 9200 588 3202 1062 9201 588 3635 3418 9202 588 9820 3635 9203 588 1062 9820 9204 2467 3827 8439 9205 4449 8354 1102 9206 4449 9145 8354 9207 4449 1102 2915 9208 4449 2915 2019 9209 6533 2940 6266 9210 6533 6266 967 9211 5631 80 3504 9212 5631 3504 1524 9213 5631 3675 4172 9214 5631 1524 3675 9215 5631 4172 80 9216 8280 3561 3424 9217 8280 6263 3561 9218 8280 9110 6263 9219 8280 1524 1187 9220 8280 3424 1524 9221 8280 1187 9110 9222 6615 2982 5205 9223 6615 321 2982 9224 6615 80 321 9225 6615 5205 3504 9226 6615 3504 80 9227 6764 1272 8319 9228 6764 4710 1272 9229 6764 3504 5205 9230 6764 5205 3867 9231 6764 8319 3504 9232 6764 3867 4710 9233 4369 9771 3015 9234 4369 6510 9531 9235 3944 1487 5823 9236 3944 5376 1487 9237 3944 2421 5376 9238 1487 4626 5823 9239 1487 5451 4626 9240 1487 6841 5451 9241 1487 5376 6841 9242 156 5044 3356 9243 156 6618 5044 9244 8572 4715 1295 9245 8572 6522 4715 9246 8572 1295 5532 9247 8572 5532 3322 9248 5514 7151 5044 9249 5514 5044 8773 9250 5514 3847 7151 9251 5514 8773 3847 9252 5471 7037 6051 9253 5471 6051 3460 9254 9771 945 3015 9255 2278 917 714 9256 4377 9795 3521 9257 4377 7319 9795 9258 793 967 917 9259 6815 4230 8958 9260 6815 8958 6554 9261 6815 3110 4230 9262 4550 5127 812 9263 1667 4148 1460 9264 6092 1798 2217 9265 6092 4148 1798 9266 6092 2217 1460 9267 6092 1460 4148 9268 4659 2147 4576 9269 4659 4775 2147 9270 4659 5342 4775 9271 4659 4576 6416 9272 4659 6416 5342 9273 1191 9577 5004 9274 1191 5004 6567 9275 1191 4549 9577 9276 1191 6567 6120 9277 1191 6120 4549 9278 8026 8190 938 9279 8026 4848 8190 9280 8026 938 6416 9281 8026 6567 7548 9282 8026 7548 4848 9283 8026 6120 6567 9284 8026 6416 6120 9285 5988 7785 9945 9286 5988 8776 7785 9287 5988 9945 3734 9288 3070 1068 8043 9289 3070 8043 5423 9290 3070 5423 1737 9291 3070 1737 5452 9292 7543 5636 4813 9293 767 9867 2463 9294 767 2371 9867 9295 9867 2371 1168 9296 4065 4615 5423 9297 4065 5423 1947 9298 4065 4922 6202 9299 4065 1947 4922 9300 4065 6202 1168 9301 6202 6649 5133 9302 6202 4922 6649 9303 6202 5133 1168 9304 3060 9491 9919 9305 3060 9919 921 9306 3060 9198 9491 9307 3060 921 8882 9308 3060 9547 9198 9309 8233 2234 2902 9310 8233 2902 9198 9311 8233 392 2234 9312 8233 2233 392 9313 8233 9198 9547 9314 4134 9491 1484 9315 4134 9919 9491 9316 7786 6516 88 9317 7786 3282 6516 9318 7786 6922 3282 9319 1902 1209 4635 9320 3520 3418 2687 9321 3520 3202 3418 9322 3520 2142 3202 9323 4780 8882 1483 9324 5604 4660 3202 9325 5604 3202 2142 9326 5883 3132 6495 9327 9025 7529 9613 9328 9025 9613 2549 9329 9025 5491 7529 9330 9613 7529 1519 9331 9613 1519 8808 9332 9613 6616 2549 9333 9613 8808 6616 9334 9275 3856 3465 9335 9275 3465 2759 9336 9275 5491 3351 9337 9275 2759 5491 9338 5004 9577 6809 9339 5004 6809 5530 9340 5004 5530 7918 9341 5004 7918 6567 9342 6027 6164 7918 9343 6027 3216 6164 9344 6027 4547 2919 9345 6027 7918 4547 9346 6027 2919 3216 9347 2121 5059 4305 9348 2121 4330 5059 9349 2121 7110 5872 9350 2121 9313 7110 9351 2121 5872 4330 9352 2121 4305 9313 9353 7110 4565 9572 9354 1867 4547 4549 9355 1867 9081 4547 9356 1867 7487 9081 9357 1995 7194 959 9358 1995 959 5953 9359 1995 9940 7194 9360 1995 5953 5527 9361 3820 2301 6807 9362 3820 6807 2774 9363 3820 9394 6186 9364 3820 6186 2301 9365 3820 2774 9394 9366 2819 4161 5706 9367 2819 5706 2892 9368 2819 2892 3118 9369 8688 4609 2897 9370 8688 2897 6683 9371 8688 6036 4609 9372 5219 7890 3357 9373 5219 3357 1226 9374 5219 7987 7890 9375 3830 3691 3404 9376 3830 254 3691 9377 3830 5621 254 9378 3830 5433 5621 9379 3830 3404 3865 9380 3830 3865 7357 9381 3830 7357 7766 9382 3830 7766 5433 9383 6914 5621 4048 9384 6914 4048 2871 9385 6914 2871 5945 9386 6914 2224 5621 9387 6914 1819 2224 9388 3766 9534 1819 9389 3766 7949 9534 9390 2412 7756 5221 9391 2412 6113 7756 9392 2412 5221 9979 9393 2412 9979 5794 9394 2412 5794 6113 9395 3129 1621 6861 9396 3129 6861 2221 9397 3129 9183 1621 9398 2408 9357 540 9399 2408 540 7850 9400 2408 6240 3715 9401 2408 3715 9357 9402 2408 3218 6240 9403 2408 4796 3218 9404 2408 7850 4796 9405 3616 6903 710 9406 3616 4302 6903 9407 3616 710 5870 9408 3616 5870 9331 9409 3616 9331 1615 9410 3616 1615 4302 9411 9080 6848 9266 9412 9080 9266 4145 9413 9080 4145 5805 9414 9080 5805 6848 9415 6930 5944 5789 9416 6930 3654 5944 9417 6930 8843 748 9418 6930 5789 8843 9419 6930 748 3654 9420 4583 2988 7241 9421 4583 582 2988 9422 4583 7241 4341 9423 4583 4341 4767 9424 4583 4767 582 9425 7241 9056 4341 9426 7241 2988 9056 9427 8471 9699 1968 9428 5422 8438 327 9429 5422 327 7372 9430 5422 2920 9793 9431 5422 9793 8438 9432 5422 7372 2663 9433 5727 383 4835 9434 5727 9952 383 9435 5727 2344 9952 9436 8246 633 7880 9437 8246 7880 2920 9438 3047 9125 4580 9439 5465 2674 3218 9440 5465 3218 4751 9441 5465 3709 2674 9442 8640 2238 6651 9443 8640 651 2238 9444 8640 6651 2674 9445 8640 3709 9683 9446 8640 9683 651 9447 8640 2674 3709 9448 6240 3218 2674 9449 6240 2674 6651 9450 6240 6651 3715 9451 6193 4074 3416 9452 105 9052 4440 9453 2095 2273 5250 9454 2095 5250 9845 9455 3922 2632 9294 9456 3922 9294 4200 9457 3922 4200 4056 9458 3922 4056 1801 9459 6144 8906 9420 9460 6144 2814 6887 9461 6144 6887 8906 9462 6715 7165 4356 9463 6715 4356 5043 9464 9608 5033 1865 9465 9608 1865 7411 9466 7352 8677 6678 9467 7352 6678 1865 9468 9593 4170 8724 9469 5960 1968 9699 9470 5694 9958 992 9471 561 6590 4032 9472 992 9958 9699 9473 992 7931 7840 9474 2959 1208 4026 9475 2959 4026 1352 9476 2849 8342 2381 9477 6941 10000 890 9478 6941 9093 10000 9479 6941 890 7856 9480 6162 5157 1382 9481 6162 8342 5157 9482 6162 1382 8066 9483 6162 8066 8169 9484 6162 8169 8342 9485 2202 282 6429 9486 1382 5157 6200 9487 1382 3275 7181 9488 7018 6699 4634 9489 7018 4634 8505 9490 7018 1436 6699 9491 7018 8505 2282 9492 6699 1436 2653 9493 6699 2653 4634 9494 2422 9344 9202 9495 2422 9467 9344 9496 2422 9202 1751 9497 2422 1751 7560 9498 2422 7560 9467 9499 1751 5184 7560 9500 1751 2282 5184 9501 5184 2143 5633 9502 5184 2282 2143 9503 5633 2143 8505 9504 5633 8505 1413 9505 5633 1413 109 9506 7379 3035 693 9507 7379 693 2514 9508 7379 7209 7075 9509 7379 2514 7209 9510 7379 7075 7901 9511 7901 7075 2339 9512 7901 2339 3433 9513 3921 2339 7075 9514 3921 4447 2339 9515 3921 7075 7233 9516 3921 7233 4447 9517 3454 3021 9849 9518 3454 9849 9079 9519 3454 5860 3021 9520 1204 693 3035 9521 7917 885 6720 9522 7917 6720 1379 9523 7116 9775 3592 9524 7627 910 9056 9525 7627 7472 910 9526 3777 3433 2339 9527 5923 3817 9431 9528 5923 5655 3817 9529 5923 7745 5655 9530 9292 3817 1157 9531 9292 9431 3817 9532 9292 1157 5570 9533 7887 1659 6508 9534 7887 4432 1659 9535 7887 6722 4432 9536 1672 4322 3771 9537 3204 226 5309 9538 3204 5309 9967 9539 3204 9967 701 9540 1717 6194 4208 9541 1717 8109 6194 9542 4092 701 9775 9543 4092 9775 305 9544 1649 226 9873 9545 1649 9873 3031 9546 1649 3031 4109 9547 1649 1955 5309 9548 1649 5309 226 9549 1649 65 1955 9550 1649 4109 65 9551 4102 1648 9658 9552 4102 9658 5364 9553 4817 1172 7076 9554 4817 9212 1172 9555 4817 6124 4918 9556 4817 4918 9212 9557 4817 7076 6124 9558 4918 6124 89 9559 4918 89 1083 9560 4918 1083 7023 9561 4918 7023 9212 9562 5946 2550 1083 9563 2338 1156 9887 9564 2338 3435 1156 9565 2338 9887 1480 9566 2338 1480 3435 9567 6814 1393 5796 9568 6814 4621 1393 9569 6814 3901 4789 9570 6814 4789 4621 9571 6814 2577 3901 9572 7346 7286 8501 9573 5972 8501 7286 9574 5972 525 8501 9575 5972 7286 8834 9576 5972 8834 2311 9577 5536 3901 2577 9578 5536 1920 3901 9579 5536 4588 1920 9580 5536 2577 9447 9581 5536 818 4588 9582 3901 1920 4789 9583 8953 6981 7579 9584 8953 7579 2139 9585 8953 2139 7260 9586 8953 7260 777 9587 908 4842 1612 9588 908 3449 4842 9589 908 353 3449 9590 908 1612 3687 9591 3217 3441 8877 9592 3217 1895 3441 9593 3217 2311 1895 9594 5845 8877 3441 9595 5845 3441 9660 9596 5845 3687 8877 9597 5845 9660 3687 9598 2691 9965 5461 9599 2691 5461 9714 9600 7899 7983 4293 9601 7899 4293 9965 9602 7899 5235 7983 9603 7899 3787 5235 9604 7794 6682 6181 9605 8324 8146 2525 9606 8324 2525 4855 9607 8324 22 8146 9608 5721 2098 3525 9609 6759 3687 1625 9610 6759 1625 3335 9611 6759 3335 857 9612 4397 5476 7804 9613 3762 3787 7636 9614 2497 6087 6070 9615 2497 8528 1911 9616 2497 6795 8528 9617 2497 1911 6087 9618 8528 9561 8617 9619 8528 8617 853 9620 8528 853 1911 9621 8528 6795 9561 9622 2651 890 3056 9623 2651 7163 890 9624 6603 3056 8692 9625 6603 8692 7615 9626 6070 6087 7308 9627 299 6253 7308 9628 1014 889 2935 9629 1014 7308 889 9630 7690 5449 4164 9631 7690 4164 1907 9632 7690 1907 7440 9633 7690 8720 9794 9634 7690 9794 5449 9635 7690 7440 8720 9636 4311 5901 402 9637 4311 402 8792 9638 4311 8792 4020 9639 4311 3113 7873 9640 4311 7873 5901 9641 4311 1422 3113 9642 4311 4020 1422 9643 2303 837 3631 9644 7806 8548 7487 9645 8835 7167 2966 9646 8835 2240 7167 9647 8835 2966 4552 9648 8835 4552 2240 9649 6289 1057 6219 9650 6289 6219 1012 9651 6289 1012 7167 9652 7554 2732 2916 9653 7554 8085 2732 9654 445 3648 8222 9655 445 8222 6561 9656 445 6561 6322 9657 445 69 599 9658 445 599 3648 9659 445 6322 69 9660 599 8085 1533 9661 599 69 8085 9662 599 6626 3648 9663 599 1533 6626 9664 1709 8254 1686 9665 1709 8983 8254 9666 5891 3924 5305 9667 5891 5305 4387 9668 6430 4487 4387 9669 6430 7944 4487 9670 6430 7226 7944 9671 5906 6321 2694 9672 252 8202 7269 9673 252 9948 8202 9674 252 7269 591 9675 7269 8202 208 9676 6876 8558 7574 9677 6876 4851 8557 9678 5602 9785 6321 9679 5602 6591 9785 9680 1303 4061 112 9681 1303 3359 10002 9682 5418 74 9748 9683 6647 9585 3943 9684 6564 5882 2109 9685 7203 386 559 9686 7203 3469 386 9687 5882 559 9948 9688 5882 9948 9992 9689 5882 9992 2109 9690 6392 1273 2258 9691 6392 2258 136 9692 4086 411 5292 9693 4086 5292 1720 9694 7323 559 386 9695 7323 8202 559 9696 232 6612 6455 9697 3409 1860 4113 9698 3409 4113 7932 9699 3409 7932 8071 9700 5440 1752 1860 9701 5440 9878 1752 9702 3012 8054 5697 9703 3012 8631 8054 9704 2554 1327 31 9705 8454 6114 8954 9706 1077 1836 7701 9707 1077 1953 1836 9708 5324 3556 4423 9709 5324 1691 3556 9710 5324 4423 8661 9711 8622 5697 8054 9712 8811 8631 5480 9713 8811 8054 8631 9714 1987 3384 8116 9715 1987 2665 3384 9716 1245 7907 4683 9717 1245 4683 2861 9718 1245 2861 9155 9719 9573 2861 1457 9720 4409 31 9103 9721 4409 9103 9123 9722 9533 7907 235 9723 9533 235 7916 9724 9533 3591 7907 9725 5106 9544 7307 9726 5106 7307 1429 9727 5106 1429 6126 9728 7859 2365 8954 9729 7859 8954 4445 9730 7859 9668 9651 9731 7859 9651 2365 9732 9668 77 9651 9733 9668 3223 77 9734 7284 7348 7689 9735 7284 4445 7348 9736 7284 9583 4445 9737 7284 9316 9583 9738 7284 7689 9316 9739 2775 920 7689 9740 2775 994 920 9741 2775 7689 7348 9742 2775 7348 994 9743 5550 994 8269 9744 2765 3176 8772 9745 895 5362 8654 9746 895 8654 7428 9747 895 7428 9915 9748 53 5130 7350 9749 6230 8082 8139 9750 4578 7350 5130 9751 4578 5130 2570 9752 7307 268 1429 9753 7307 7713 268 9754 5912 8032 5597 9755 6700 8321 4412 9756 6700 1556 8321 9757 6700 4412 4703 9758 1265 1364 1534 9759 1265 7444 1364 9760 1265 5675 1705 9761 1265 1705 7444 9762 9008 9116 8751 9763 9008 6226 9116 9764 9008 8751 8238 9765 9008 1874 7755 9766 9008 7755 6226 9767 9008 8238 1874 9768 2890 9263 5854 9769 2890 7613 9263 9770 3457 5849 3379 9771 3396 5057 8764 9772 3396 8764 3379 9773 9177 8605 4512 9774 9177 4512 6527 9775 9177 1190 8605 9776 9018 1632 1631 9777 9018 8496 1632 9778 8856 741 9861 9779 7926 7463 8670 9780 7926 8670 1331 9781 7926 1331 7101 9782 676 543 5809 9783 280 543 9172 9784 280 5809 543 9785 4998 9373 7481 9786 4998 7481 8546 9787 7500 6793 9484 9788 7500 8520 6793 9789 8058 9542 7005 9790 8058 7005 3471 9791 8058 3471 2407 9792 8058 2407 9542 9793 1129 2407 3471 9794 1129 3471 7710 9795 5387 6943 483 9796 5387 4960 6943 9797 8307 6403 7280 9798 7195 9334 7078 9799 7195 7078 7207 9800 7195 7207 9879 9801 3528 5279 2504 9802 4505 266 4990 9803 4505 4990 5187 9804 9267 3852 3843 9805 9267 9879 3852 9806 3665 5316 6998 9807 3665 4319 5316 9808 7311 2511 7359 9809 7311 7359 2128 9810 7311 2128 4319 9811 6777 7078 8831 9812 6777 944 7078 9813 6895 5736 662 9814 6895 4244 5736 9815 9386 5149 3670 9816 9386 3670 784 9817 9386 784 3994 9818 1121 5397 1171 9819 1121 3226 5397 9820 1121 7196 5231 9821 1121 1171 7196 9822 1121 3976 5892 9823 1121 5892 3226 9824 1121 5149 3976 9825 1121 5231 5149 9826 9339 4042 8703 9827 9339 7810 4042 9828 7995 8703 3427 9829 4990 319 5678 9830 4990 5566 319 9831 4990 5678 8196 9832 4990 266 5566 9833 4990 8196 5187 9834 8931 3902 5678 9835 8931 3343 3902 9836 8931 5825 4042 9837 8931 4042 3343 9838 8931 319 5825 9839 8931 5678 319 9840 8960 8394 1224 9841 7019 9425 4898 9842 2481 8840 5581 9843 2481 5581 8461 9844 3278 2257 5172 9845 3278 5172 8293 9846 6758 470 1072 9847 6758 1072 9033 9848 6758 6923 6530 9849 6758 6530 470 9850 6758 2016 6923 9851 6758 9033 2016 9852 8197 18 5950 9853 8197 5950 1072 9854 8197 1072 477 9855 8197 477 18 9856 4862 6034 2393 9857 4862 695 6034 9858 1192 5534 1451 9859 1192 8784 5534 9860 1192 3918 8784 9861 151 5581 8840 9862 3775 5425 8646 9863 3775 8646 6034 9864 4969 9545 5425 9865 4969 8875 9545 9866 1357 8840 7351 9867 7778 7771 6728 9868 7778 3475 7771 9869 7778 6728 3918 9870 7105 2629 663 9871 2705 3123 7042 9872 2705 9772 3123 9873 4776 4702 1988 9874 4776 1988 3019 9875 6288 6492 3019 9876 6288 3019 476 9877 6288 476 2177 9878 6288 2177 1307 9879 6288 3983 6492 9880 6288 1307 3983 9881 239 1988 4702 9882 239 4702 2886 9883 239 3014 98 9884 239 98 4734 9885 239 2886 3014 9886 239 4734 7966 9887 7966 4439 6992 9888 7966 9949 4439 9889 7966 9097 9949 9890 7966 3629 9097 9891 7966 4734 3629 9892 7958 9594 3268 9893 7958 2337 9594 9894 7958 3268 6530 9895 7958 6530 1800 9896 7958 9747 7815 9897 7958 7815 2337 9898 7958 4067 9747 9899 7958 1800 4067 9900 3112 8596 7235 9901 3112 7235 5506 9902 979 3329 9182 9903 716 3160 9182 9904 716 9182 9060 9905 716 9060 1991 9906 2679 9590 2622 9907 978 4951 7244 9908 3582 3877 9931 9909 1811 2474 1092 9910 306 5495 2668 9911 1355 7215 2688 9912 1355 2688 6634 9913 1355 6634 6195 9914 1355 8975 9934 9915 1355 9934 7215 9916 1355 6195 8975 9917 441 8309 4827 9918 441 7173 8309 9919 441 4827 6174 9920 8473 4929 2668 9921 8473 411 4929 9922 8473 3116 5292 9923 8473 5292 411 9924 8473 2668 3116 9925 2706 1137 6717 9926 2706 3994 1137 9927 2706 6717 7754 9928 2706 7754 7810 9929 4867 3545 3581 9930 4867 1281 3545 9931 2437 9745 6080 9932 2437 6080 3167 9933 2437 4544 9745 9934 2232 5637 2590 9935 2232 5588 5637 9936 2232 8400 5588 9937 2232 898 8400 9938 2232 2590 898 9939 5810 5637 6736 9940 5810 6736 4140 9941 5810 4140 9799 9942 5810 2727 2590 9943 5810 2590 5637 9944 5810 9799 2727 9945 5730 4912 3697 9946 5730 3697 9645 9947 3535 9417 8239 9948 3535 8239 3736 9949 1372 3932 7083 9950 1372 7083 9192 9951 1372 9192 5662 9952 1372 8643 3932 9953 1372 6344 8643 9954 1372 5662 6344 9955 985 9645 3697 9956 985 4590 9645 9957 985 1018 67 9958 985 3697 1018 9959 985 67 2981 9960 985 2981 4590 9961 6878 5848 7716 9962 6878 7716 6687 9963 6878 5246 5848 9964 4958 9784 5246 9965 4958 8359 9784 9966 4958 8093 8359 9967 1337 4880 1278 9968 1337 7292 4880 9969 1337 1762 7292 9970 6854 4967 6744 9971 6854 8232 4967 9972 6854 6744 5404 9973 3175 5404 6744 9974 4826 2118 3742 9975 4826 3742 6006 9976 4826 6006 5431 9977 4826 4996 9889 9978 4826 9889 2118 9979 4826 8474 4996 9980 556 9889 4996 9981 556 7450 9889 9982 556 4996 8474 9983 556 8474 2082 9984 556 2082 7660 9985 556 7660 7450 9986 1424 3746 5472 9987 1424 5472 4398 9988 1424 5431 3746 9989 8603 5003 8040 9990 8603 8040 6945 9991 8603 5320 7496 9992 8603 7496 5003 9993 8603 6945 5320 9994 6082 7160 7523 9995 6082 1212 7160 9996 6082 7523 114 9997 6082 114 1212 9998 2593 7868 3572 9999 2593 3572 4973 10000 2593 4973 5261 10001 2593 4255 7868 10002 2593 5261 7383 10003 4906 9858 7586 10004 4632 7338 2237 10005 4632 2237 9098 10006 2237 7338 2031 10007 2237 2031 8436 10008 7661 4201 1178 10009 7661 4501 4201 10010 7661 9751 4501 10011 6846 3054 1983 10012 6846 1983 7052 10013 6846 5926 3228 10014 6846 7732 5926 10015 6846 6684 3054 10016 6846 3228 6684 10017 6846 7052 7732 10018 8820 8138 7984 10019 8820 5022 8138 10020 8820 9240 5022 10021 3232 6563 9712 10022 3232 9712 8194 10023 3232 1983 6563 10024 3232 8194 1983 10025 1453 5847 4444 10026 1453 4380 5847 10027 1453 360 4380 10028 6456 9750 7621 10029 6456 4596 9750 10030 6456 7055 4596 10031 6456 5847 7055 10032 6456 4444 5847 10033 5992 2662 7971 10034 5992 4600 2662 10035 5992 9040 4600 10036 5992 7971 4064 10037 5992 4064 6838 10038 5992 6838 9040 10039 8308 7820 8825 10040 8308 8825 8538 10041 8308 8538 3452 10042 8308 3452 7820 10043 361 3463 2877 10044 361 2877 8825 10045 5876 2216 6215 10046 9779 2616 7121 10047 9779 7121 5237 10048 9779 8880 2616 10049 7121 2616 1554 10050 7121 9265 2996 10051 7121 2996 5237 10052 7121 1554 9265 10053 9935 2996 9265 10054 9935 5237 2996 10055 1030 2938 3584 10056 3584 1052 1349 10057 3584 6283 1052 10058 4271 9040 3809 10059 4271 62 9040 10060 4271 3809 6659 10061 9901 4881 7600 10062 4163 7984 8138 10063 4163 611 7984 10064 4163 8138 1387 10065 4163 5358 611 10066 4163 3042 5358 10067 4163 1387 3042 10068 2985 165 7200 10069 2985 7200 9113 10070 2985 2488 165 10071 5206 6148 2488 10072 5206 8926 2043 10073 5206 2043 6148 10074 5206 9113 8926 10075 7225 7200 165 10076 7225 412 7200 10077 7225 2618 756 10078 7225 165 2618 10079 9438 1418 275 10080 9438 275 8491 10081 2043 8491 7625 10082 2043 8926 8491 10083 2043 7625 4080 10084 2043 4680 6148 10085 2043 5289 4680 10086 2043 4080 5289 10087 2618 3836 756 10088 4814 259 8258 10089 4814 9667 259 10090 3394 5634 3898 10091 3394 3898 338 10092 3394 310 7476 10093 3394 7476 2639 10094 3394 7339 310 10095 3394 338 7339 10096 3394 2639 5634 10097 4799 1976 3898 10098 4799 6280 1976 10099 4799 7785 6280 10100 4799 5634 9945 10101 4799 9945 7785 10102 4799 3898 5634 10103 2606 1884 4167 10104 2606 5708 1884 10105 2606 4167 5129 10106 2606 5129 9940 10107 8868 2094 3854 10108 8868 9051 2094 10109 9066 1521 7692 10110 9066 7692 1433 10111 9066 1824 9488 10112 9066 2478 1824 10113 9066 1433 2478 10114 9066 2259 1521 10115 9066 9488 2259 10116 7291 2262 6414 10117 3822 7287 1855 10118 3822 1855 614 10119 3822 9928 7287 10120 3822 1512 9928 10121 3822 3430 1512 10122 2627 5263 3106 10123 2627 3106 3103 10124 2627 6297 5263 10125 2627 5412 6297 10126 3717 818 9587 10127 3717 9587 5412 10128 9587 6297 5412 10129 1965 3269 9588 10130 1965 4500 3269 10131 5263 9689 3106 10132 5263 7965 9689 10133 5263 1391 7965 10134 5263 6297 1391 10135 6688 4358 6912 10136 6688 6912 2492 10137 6688 2492 8675 10138 6688 8675 1869 10139 4508 8675 2492 10140 8463 3916 1869 10141 4462 6579 2198 10142 4462 8164 7831 10143 4462 2198 8164 10144 5853 1869 3916 10145 5622 1516 1319 10146 4285 3073 7115 10147 4285 4795 3073 10148 4285 81 4795 10149 4285 5083 81 10150 4237 9036 6973 10151 4237 6973 9127 10152 4237 9127 5102 10153 6924 5102 2583 10154 6924 2583 2130 10155 6924 2130 284 10156 3667 2962 5163 10157 3667 5163 6575 10158 3667 6575 1011 10159 4480 7497 6973 10160 4480 5086 7497 10161 4480 6973 9036 10162 5919 9630 7700 10163 5919 7700 8367 10164 5919 3192 9630 10165 5919 4443 3192 10166 5919 570 4443 10167 5919 8367 570 10168 5285 6751 6707 10169 5285 6707 1793 10170 5285 1793 3849 10171 5285 284 6751 10172 5285 3849 3906 10173 9859 1069 5835 10174 4543 4785 3688 10175 4543 3688 5869 10176 1586 7490 1575 10177 1586 1575 3906 10178 6823 2738 1151 10179 6823 8569 2738 10180 6783 8569 9659 10181 6783 9659 6004 10182 6783 11 2738 10183 6783 2738 8569 10184 6783 4003 11 10185 6783 6152 4003 10186 6783 6004 6152 10187 2428 1089 8785 10188 2428 4414 1089 10189 2428 8785 8480 10190 2428 227 4414 10191 8785 5652 3727 10192 8785 3727 8416 10193 8785 1089 5652 10194 8785 3254 9318 10195 8785 9318 8480 10196 8785 8416 3254 10197 1089 4414 816 10198 1089 816 5652 10199 618 9811 2738 10200 618 2738 11 10201 618 11 816 10202 618 816 4414 10203 1151 9811 9984 10204 1151 2738 9811 10205 6130 8063 5195 10206 6130 5195 9878 10207 6267 3761 1752 10208 6267 1505 3761 10209 6267 1752 7727 10210 6267 1991 1505 10211 5774 9159 6625 10212 5774 6625 4389 10213 6072 2622 9590 10214 4892 760 4355 10215 29 5286 9993 10216 29 7655 5286 10217 29 4417 7655 10218 9581 8418 7729 10219 9581 7729 7655 10220 9581 7655 4417 10221 8460 8790 7938 10222 8460 9754 8790 10223 8460 7938 2625 10224 8460 2625 7153 10225 8460 1336 9754 10226 5037 4558 783 10227 8619 1423 783 10228 8619 6308 1423 10229 3912 5517 3066 10230 3912 2895 5517 10231 3912 3066 5062 10232 292 3533 6499 10233 2580 6705 4007 10234 2580 4007 8300 10235 2580 2435 6705 10236 2580 1859 2435 10237 6705 363 4644 10238 6705 4644 997 10239 6705 5445 363 10240 6705 2435 5445 10241 4212 4644 363 10242 4212 4504 9133 10243 4212 363 4504 10244 8806 5315 4619 10245 8806 7295 5315 10246 8806 4619 7779 10247 530 3458 6359 10248 530 6359 4619 10249 530 1491 3458 10250 530 4619 5315 10251 530 5315 8925 10252 530 8925 1491 10253 9362 200 9384 10254 653 8951 6499 10255 653 1019 8951 10256 8347 4523 1982 10257 8347 4427 4523 10258 8347 2091 4427 10259 8213 480 1113 10260 594 3002 5521 10261 594 5521 8149 10262 594 7729 8669 10263 594 125 7729 10264 594 8149 125 10265 8669 7729 8418 10266 8669 8418 3069 10267 8669 3069 480 10268 5300 5163 4329 10269 4329 5163 2962 10270 1544 6349 4558 10271 1544 1873 9158 10272 1544 9158 5857 10273 1544 5857 6349 10274 1873 90 4433 10275 1873 4433 9158 10276 4433 90 59 10277 4433 59 8939 10278 4433 8939 9158 10279 5493 9105 6735 10280 1930 7578 8838 10281 1930 8838 9298 10282 1930 9298 334 10283 2834 7938 9479 10284 2834 1506 7938 10285 2834 9479 5889 10286 2834 5889 2673 10287 7366 1241 6029 10288 7366 9154 1241 10289 7366 6029 3638 10290 8434 9105 6192 10291 8434 3638 670 10292 8434 670 7144 10293 8434 7144 6735 10294 8434 6735 9105 10295 2279 7751 3636 10296 7938 2359 9479 10297 7938 8790 2359 10298 7938 1506 2625 10299 1358 9108 5539 10300 1358 5539 9819 10301 1132 373 2419 10302 1132 2419 9490 10303 9947 3401 6805 10304 9947 4774 3401 10305 9947 4112 4774 10306 9439 941 5651 10307 941 8076 5651 10308 5515 4112 8515 10309 9564 7747 5413 10310 9564 5046 7747 10311 9564 5413 9479 10312 9564 3636 5046 10313 9564 2359 3636 10314 9564 9479 2359 10315 8891 1488 4254 10316 8891 4254 9332 10317 8891 9332 4301 10318 7906 9823 9694 10319 4957 7979 852 10320 4957 9694 4716 10321 4957 4716 7979 10322 958 8142 5606 10323 958 8726 8142 10324 958 5606 5925 10325 5925 5606 3505 10326 5925 3505 415 10327 5925 9830 9694 10328 5925 415 9830 10329 8985 9413 9087 10330 8985 8883 9413 10331 8985 7229 8883 10332 675 4823 7229 10333 5015 9413 4823 10334 5015 4823 6110 10335 5015 9087 9413 10336 5015 9318 9087 10337 5015 6110 9318 10338 3254 8416 6152 10339 7143 7138 6397 10340 7143 6397 7231 10341 3084 3121 2053 10342 3084 2053 785 10343 3084 8949 6178 10344 3084 785 8949 10345 7138 1468 9926 10346 7138 1916 1468 10347 7138 9926 6397 10348 1174 7828 8656 10349 5260 5749 5459 10350 5260 5459 3606 10351 7833 9119 2022 10352 7833 5424 9119 10353 7833 2022 522 10354 7833 522 235 10355 2948 4597 4933 10356 4933 4597 3291 10357 5608 8485 8502 10358 4191 9752 4915 10359 4191 4915 4764 10360 4191 4284 9415 10361 4191 4764 4284 10362 6559 4392 2524 10363 6559 2524 2434 10364 6559 2376 4392 10365 6559 2793 5097 10366 6559 2434 2793 10367 6559 2035 2376 10368 2793 740 2366 10369 2793 2434 740 10370 2793 2366 5097 10371 1325 2376 1368 10372 1325 4964 2376 10373 4287 9661 1898 10374 1898 9661 9869 10375 9869 3487 8332 10376 3479 433 7860 10377 3479 7860 6738 10378 3479 6738 9562 10379 3479 9562 433 10380 7860 433 2295 10381 795 3114 788 10382 795 788 4182 10383 5580 8339 8583 10384 6317 147 9221 10385 6317 1060 147 10386 6317 9221 8339 10387 8497 5783 1060 10388 8497 7114 4645 10389 8497 4645 5783 10390 2484 7404 9676 10391 2484 664 7404 10392 2484 4385 172 10393 2484 172 8586 10394 2484 2059 4385 10395 2484 9676 2059 10396 2484 8586 664 10397 172 4385 110 10398 172 110 3890 10399 172 3890 8586 10400 1933 637 92 10401 1933 92 3536 10402 1933 3536 7000 10403 9563 2613 8563 10404 9563 8563 4965 10405 9563 110 7389 10406 9563 7389 2613 10407 9563 2601 110 10408 110 4385 7389 10409 110 2601 4869 10410 110 4869 3890 10411 2943 4869 2601 10412 2943 3660 4869 10413 2943 8846 8584 10414 2943 8053 8846 10415 2943 2601 8053 10416 2943 8584 3660 10417 7389 4385 2059 10418 7389 2059 5686 10419 7389 5686 2613 10420 2059 9676 9289 10421 2059 9289 5686 10422 2131 2613 5686 10423 2131 5686 7190 10424 2131 7190 3553 10425 2131 3553 8563 10426 2131 8563 2613 10427 7867 7687 9781 10428 4338 8691 7433 10429 4338 2386 8691 10430 7663 9118 6863 10431 7663 6863 1321 10432 3593 5542 658 10433 3593 658 3476 10434 8077 7433 9866 10435 856 9866 428 10436 9448 5868 4216 10437 9028 8178 2891 10438 4060 553 435 10439 5325 7674 2900 10440 5325 8632 7674 10441 4838 3039 1207 10442 4838 1207 5484 10443 4838 5484 9700 10444 673 1967 975 10445 1526 5409 1914 10446 1526 471 700 10447 1526 700 5281 10448 1526 5281 5409 10449 4591 371 3259 10450 4591 3259 3247 10451 4591 3247 9709 10452 4591 9468 371 10453 4591 8381 9468 10454 4591 9709 8381 10455 2830 2762 3726 10456 2830 3726 5435 10457 2830 9918 2804 10458 2830 4584 9918 10459 2830 5435 4584 10460 1875 2433 2762 10461 8936 4249 6482 10462 8936 6482 4921 10463 8936 8364 4249 10464 8936 4921 8364 10465 2433 8597 2762 10466 2433 9337 8597 10467 9363 485 2001 10468 6352 8928 7493 10469 8928 6357 7493 10470 8928 4667 1839 10471 8928 6731 4667 10472 8928 8903 7590 10473 8928 7590 6731 10474 8928 1839 6357 10475 5665 8046 8530 10476 5665 9424 8046 10477 5665 8530 2993 10478 5665 2993 6922 10479 3418 3635 2808 10480 3418 2808 2687 10481 3829 270 509 10482 3829 509 3827 10483 8439 3786 5586 10484 8439 3827 3786 10485 8439 5586 6837 10486 49 645 5365 10487 49 1666 645 10488 49 5936 4573 10489 49 5365 5936 10490 49 4573 1666 10491 221 6513 5365 10492 221 5365 645 10493 221 7623 1367 10494 221 645 7623 10495 221 9312 6513 10496 221 1367 9312 10497 2106 4364 5951 10498 2106 4484 4364 10499 2106 6513 4484 10500 2106 5951 4890 10501 2106 4890 6513 10502 9312 4484 6513 10503 9312 1367 1239 10504 9312 32 4484 10505 9312 1239 32 10506 6304 2568 8097 10507 6304 8097 1239 10508 6304 5532 2568 10509 6304 3322 5532 10510 6304 2151 358 10511 6304 358 5314 10512 6304 5314 3322 10513 6304 1239 2151 10514 2915 1102 5245 10515 2915 5245 2 10516 2915 2 2019 10517 1295 4715 1755 10518 1295 1755 2568 10519 1295 2568 5532 10520 3138 6266 2940 10521 3138 2982 6266 10522 3138 3580 2982 10523 3138 4765 3580 10524 3138 1371 4765 10525 3138 2283 1371 10526 3138 2940 2283 10527 967 6266 2421 10528 4172 3675 321 10529 4172 321 80 10530 1187 1524 3504 10531 1187 3504 8319 10532 1187 8319 9110 10533 3867 2723 901 10534 3867 901 3628 10535 3867 3628 4710 10536 3867 5205 2723 10537 5044 7151 3356 10538 5044 4626 8773 10539 7151 3847 6056 10540 7151 6056 6522 10541 7151 6522 3356 10542 5038 8177 8097 10543 5038 8097 2568 10544 5038 2568 1755 10545 5038 1755 6123 10546 5038 6123 8177 10547 760 9359 4193 10548 760 4193 5349 10549 760 5349 425 10550 760 425 4355 10551 3255 450 1929 10552 3255 1929 3293 10553 3255 3293 1496 10554 3255 2177 450 10555 3255 2657 2177 10556 3255 4355 2657 10557 3110 7731 4230 10558 5127 5117 812 10559 5127 2716 5117 10560 5127 9980 2716 10561 6061 827 46 10562 6061 981 9980 10563 6061 46 981 10564 13 4344 6512 10565 13 2604 4344 10566 13 1080 2604 10567 1460 820 1080 10568 1460 2217 820 10569 7900 5834 9243 10570 7900 9752 5834 10571 7900 9243 812 10572 7900 5117 5893 10573 7900 5893 9752 10574 7900 812 5117 10575 6840 3049 9633 10576 6840 9676 3049 10577 6840 9289 9676 10578 6840 1354 9289 10579 6840 9633 9737 10580 6840 9737 1354 10581 6019 2572 4465 10582 6019 2528 2572 10583 6019 5274 8789 10584 6019 8789 1253 10585 6019 1253 2528 10586 6019 4465 5274 10587 3841 1462 2342 10588 3841 6862 1462 10589 3841 3383 5240 10590 3841 5240 6862 10591 3841 2342 3383 10592 4190 9166 3481 10593 4190 3481 4266 10594 4190 3383 9166 10595 4190 6481 3383 10596 4190 4266 6481 10597 9166 7124 3481 10598 9166 3265 7124 10599 9166 3824 3265 10600 9166 3383 2342 10601 9166 2342 3824 10602 4576 7267 4410 10603 4576 4410 4434 10604 4576 2147 7267 10605 4576 4434 6120 10606 4576 6120 6416 10607 4410 6695 5460 10608 4410 5460 372 10609 4410 372 4648 10610 4410 4648 6018 10611 4410 7267 6695 10612 4410 6018 4434 10613 6120 4434 2752 10614 3241 5833 444 10615 3241 2932 8776 10616 3241 444 2932 10617 3734 9945 2639 10618 3734 2639 3340 10619 3734 9883 8841 10620 3734 3340 9883 10621 9381 5996 8043 10622 2234 4141 2902 10623 2234 281 4141 10624 2234 392 281 10625 4615 1737 5423 10626 4615 9883 1737 10627 4615 8841 9883 10628 5133 654 575 10629 5133 575 8057 10630 5133 2788 654 10631 5133 6649 2788 10632 9198 2902 9491 10633 6868 6622 4708 10634 6868 304 6622 10635 1484 6997 304 10636 1484 9491 6997 10637 4708 1252 4840 10638 4708 6622 1252 10639 7847 1094 9167 10640 7847 9776 1094 10641 7847 9167 4034 10642 7847 4034 9776 10643 9636 3465 3856 10644 9636 3856 9424 10645 88 1103 2759 10646 88 2759 3465 10647 88 6516 1103 10648 2549 6616 8903 10649 5491 2759 1103 10650 5491 1103 7529 10651 6809 9577 5530 10652 4547 9577 4549 10653 4547 5530 9577 10654 4547 9081 5974 10655 4547 5974 4090 10656 4547 4090 2919 10657 4547 7918 5530 10658 7918 7548 6567 10659 7918 6164 7548 10660 954 5218 5872 10661 954 3601 5218 10662 8548 797 4090 10663 8548 4090 5974 10664 8548 5974 9081 10665 8548 9081 7487 10666 7487 345 3601 10667 7487 2752 345 10668 5527 1552 7952 10669 5527 5953 1552 10670 5527 7952 1313 10671 9394 2774 6500 10672 9394 6500 6186 10673 6033 8923 7475 10674 6033 7475 2162 10675 6033 1242 8923 10676 6033 6807 1242 10677 6033 2162 6807 10678 4161 1417 9111 10679 4161 9111 5851 10680 4161 5851 5706 10681 4972 3238 8313 10682 4972 8313 1417 10683 6683 4866 2063 10684 6683 2897 4866 10685 6683 2063 3231 10686 7890 7987 8329 10687 7890 9974 3357 10688 7890 6863 9974 10689 7890 8329 6863 10690 3207 8585 4592 10691 3207 6221 8585 10692 3207 4592 1226 10693 3207 1226 3357 10694 3207 3357 6221 10695 7869 3405 7568 10696 7869 7568 8857 10697 7869 8857 3405 10698 4866 424 2063 10699 4866 3751 424 10700 4866 7568 3405 10701 4866 3405 3751 10702 4866 2897 7568 10703 2602 3404 3691 10704 3865 3118 2892 10705 3865 2892 2385 10706 3865 2385 7357 10707 5600 5269 6498 10708 5600 2950 5269 10709 5600 6498 2063 10710 6968 1065 2305 10711 6968 2305 2717 10712 6968 68 1065 10713 6968 2717 8178 10714 6968 1166 68 10715 7766 1318 4411 10716 7766 5909 1318 10717 7766 7357 5909 10718 7766 4411 5433 10719 5621 2224 254 10720 5621 5433 4048 10721 1819 9534 2224 10722 5221 9468 9979 10723 5221 7756 9468 10724 5794 9979 8381 10725 5794 8381 4832 10726 5794 9361 6113 10727 5794 5822 9361 10728 5794 4832 5822 10729 225 9778 2787 10730 225 7262 9778 10731 225 9150 7262 10732 225 3897 9150 10733 225 6853 792 10734 225 2787 6853 10735 225 792 3897 10736 2623 3501 5645 10737 2623 8288 3501 10738 2623 5645 3342 10739 2623 3342 8288 10740 8037 5528 9095 10741 8037 9095 7540 10742 8037 3395 2172 10743 8037 892 3395 10744 8037 2672 892 10745 8037 2172 5528 10746 8037 7540 2672 10747 5724 9095 5528 10748 5724 9090 9095 10749 5724 5528 2172 10750 5724 2172 815 10751 5724 815 9090 10752 6861 1621 1426 10753 6861 1426 9062 10754 6861 9062 2221 10755 9183 6005 1621 10756 9183 7977 3392 10757 9183 3392 6005 10758 5369 1296 7807 10759 5369 7807 2061 10760 5369 3718 1807 10761 5369 1807 3387 10762 5369 3387 1296 10763 5369 2061 3718 10764 6127 2525 8146 10765 6127 8146 4362 10766 6127 4362 4497 10767 6127 4497 2525 10768 2439 4704 2817 10769 2439 2817 1409 10770 2439 8807 7816 10771 2439 7816 4704 10772 2439 1409 8807 10773 8823 8226 2150 10774 8823 1409 8226 10775 8823 8807 1409 10776 8823 2150 8807 10777 9357 5870 540 10778 9357 3715 5870 10779 710 540 5870 10780 710 8378 7850 10781 710 7850 540 10782 710 8843 8378 10783 710 6903 8843 10784 5805 2525 2150 10785 5805 4145 2525 10786 5805 4796 7850 10787 5805 7850 6848 10788 5805 2150 4796 10789 4796 2150 8226 10790 4796 9091 3218 10791 4796 8226 9091 10792 3275 4835 5160 10793 8378 2070 6848 10794 8378 6848 7850 10795 8378 8843 2070 10796 748 8843 3933 10797 748 3933 2991 10798 748 2991 3654 10799 4341 9056 910 10800 4341 910 5681 10801 4341 5681 4767 10802 582 7112 3271 10803 582 4767 7112 10804 582 3296 2988 10805 582 3271 3296 10806 8068 3271 7112 10807 686 9056 2988 10808 686 2988 3296 10809 4835 383 633 10810 4835 633 5160 10811 2920 7880 9731 10812 2920 9731 9793 10813 6445 8991 9735 10814 6445 9735 9378 10815 6445 2438 8991 10816 6445 9378 9125 10817 205 6391 626 10818 205 626 879 10819 7344 4731 3559 10820 7344 1750 6391 10821 7344 3559 1750 10822 3218 9091 4751 10823 5649 4076 7436 10824 5649 7436 4074 10825 5649 581 4076 10826 6739 4580 581 10827 4440 6362 1335 10828 4440 9052 6362 10829 4056 6678 8677 10830 4056 8677 7436 10831 4056 4200 6678 10832 4056 7436 4076 10833 2273 1335 5250 10834 2632 5826 9294 10835 9845 976 5826 10836 9845 3868 1567 10837 9845 1567 976 10838 9845 5250 3868 10839 2814 5043 1401 10840 2814 1401 6887 10841 7201 9420 5088 10842 8906 9839 9420 10843 8906 8728 9839 10844 8906 6887 8728 10845 702 5088 9420 10846 702 9420 5441 10847 743 3816 7740 10848 1865 6678 4200 10849 1865 4200 7411 10850 7840 4821 2360 10851 7840 7931 4821 10852 6869 3280 2190 10853 1208 2190 4026 10854 2381 6332 9093 10855 2381 9093 6307 10856 2381 8342 6332 10857 4678 8031 962 10858 4678 962 1172 10859 7856 890 4015 10860 4015 890 7163 10861 4015 7163 9537 10862 6332 8342 8169 10863 6332 8169 7112 10864 6332 7112 9093 10865 1436 9202 9344 10866 1436 9344 2653 10867 7491 1435 7560 10868 7491 7560 5982 10869 7491 7034 1435 10870 7560 1435 9467 10871 8649 2709 5762 10872 8649 7742 2709 10873 8649 701 7742 10874 8649 3592 9775 10875 8649 9775 701 10876 8649 5762 3592 10877 2143 2282 8505 10878 7075 7209 7233 10879 8890 1294 8988 10880 8890 8988 512 10881 910 7472 5681 10882 3437 9826 7107 10883 7745 1948 5655 10884 7745 5560 1948 10885 7745 7956 5560 10886 1157 2770 5570 10887 1157 9620 2770 10888 1157 4468 9620 10889 1157 3817 4468 10890 6722 5094 1725 10891 6722 1725 4432 10892 6722 5570 2770 10893 6722 2770 5094 10894 1769 3771 942 10895 1769 942 605 10896 1769 605 2630 10897 65 7128 1955 10898 65 1695 7128 10899 65 7471 1695 10900 65 4109 5922 10901 65 5922 7471 10902 8713 1695 7471 10903 8713 1493 1695 10904 8713 8802 1493 10905 8713 7471 5922 10906 8713 5922 4177 10907 8713 4177 8802 10908 4043 3500 2709 10909 4043 7128 3500 10910 4043 5309 1955 10911 4043 2709 5309 10912 4043 1955 7128 10913 4208 6194 7874 10914 9967 5309 7742 10915 9967 7742 701 10916 1648 4855 4145 10917 1648 4145 9658 10918 2965 8031 6834 10919 2965 178 8031 10920 6124 1840 89 10921 6124 7076 1840 10922 1083 3654 7023 10923 1083 2550 3654 10924 1083 89 1840 10925 4293 7983 1156 10926 4293 1156 6065 10927 4293 2836 5461 10928 4293 8712 2836 10929 4293 5461 9965 10930 4293 6065 8712 10931 1480 309 7951 10932 1480 525 3435 10933 1480 7951 525 10934 7983 9887 1156 10935 7579 6981 7951 10936 7579 7951 309 10937 5796 1393 8834 10938 2311 7581 1895 10939 2311 4649 7581 10940 2311 7126 4649 10941 2311 8834 7126 10942 1612 4842 4691 10943 1612 4691 3687 10944 8877 3687 4691 10945 5461 2836 9714 10946 22 374 9677 10947 22 9677 8146 10948 22 2098 374 10949 2098 1542 374 10950 3422 7595 7838 10951 3422 7838 2454 10952 3422 2454 3044 10953 3422 6407 5207 10954 3422 7451 6407 10955 3422 3044 7451 10956 3422 5207 7595 10957 8224 9677 374 10958 8224 374 427 10959 8224 427 3509 10960 8224 3509 456 10961 8224 456 9677 10962 6181 6682 9412 10963 5476 2769 889 10964 5476 889 7804 10965 1911 853 24 10966 4300 9689 7965 10967 4300 3106 9689 10968 8617 5049 24 10969 8617 764 5049 10970 8617 8114 764 10971 8617 9822 8114 10972 8617 9561 9822 10973 8617 24 853 10974 5594 5669 7996 10975 5594 1222 5669 10976 5594 7996 1445 10977 5594 107 1222 10978 5594 1445 5497 10979 3803 7615 8692 10980 3803 9412 6682 10981 7996 5669 7325 10982 7996 7325 8114 10983 7996 8114 1445 10984 8114 7325 3539 10985 8114 3539 764 10986 8114 9822 1445 10987 2935 889 2769 10988 137 7171 8504 10989 137 8504 4164 10990 137 4164 5449 10991 137 1857 5334 10992 137 5449 1857 10993 137 5334 7171 10994 8720 4553 9794 10995 8720 7440 4553 10996 3113 1422 8754 10997 3113 1746 7873 10998 3113 6254 1746 10999 3113 8754 6254 11000 5901 7832 402 11001 5901 7312 7832 11002 5901 7873 7312 11003 5050 1504 4807 11004 5050 3067 1504 11005 5050 3631 6001 11006 5050 6001 3067 11007 3631 837 6001 11008 8156 3952 9264 11009 8156 9264 6050 11010 8156 1944 4020 11011 8156 6050 1944 11012 8156 4020 3952 11013 3022 3795 3934 11014 3022 3934 7518 11015 3022 8716 7858 11016 3022 7518 8716 11017 3022 4517 3795 11018 3022 7858 4517 11019 2749 2855 5584 11020 2749 8311 2855 11021 2749 3007 5395 11022 2749 5584 3007 11023 2749 5395 8311 11024 7176 9855 4351 11025 7176 566 9855 11026 7176 7897 566 11027 7176 4351 797 11028 3974 8086 2033 11029 3974 5656 8086 11030 3974 6373 8374 11031 3974 8374 5656 11032 3974 1973 6373 11033 3974 5059 1973 11034 3974 2033 5059 11035 9124 1259 4662 11036 9124 1697 1259 11037 9124 8046 1697 11038 9124 8530 8046 11039 9124 9064 8530 11040 9124 4662 9064 11041 5717 7067 7708 11042 5717 94 7067 11043 5717 4934 94 11044 5717 1838 4959 11045 5717 4959 8236 11046 5717 7708 1838 11047 5717 8518 5843 11048 5717 5843 4934 11049 5717 8236 8518 11050 8518 8236 3289 11051 8518 3289 111 11052 8518 111 5843 11053 7172 8910 8499 11054 7172 111 8910 11055 7172 5843 111 11056 7172 2772 5843 11057 7172 8499 2772 11058 4552 7514 7849 11059 4552 5817 7514 11060 4552 2966 5817 11061 4552 7849 2240 11062 1057 3301 9114 11063 1057 9114 6219 11064 1012 4666 2755 11065 1012 3281 4666 11066 1012 6219 3281 11067 1012 2966 7167 11068 1012 2755 2966 11069 9114 3301 7095 11070 9114 7095 1802 11071 9114 3878 6219 11072 9114 1802 3878 11073 2916 7095 2650 11074 2916 3258 7095 11075 2916 1583 3258 11076 2916 2732 1583 11077 3648 2505 4713 11078 3648 612 2505 11079 3648 6626 612 11080 3648 4713 8222 11081 6104 4395 6561 11082 6104 6677 4395 11083 6104 8222 4759 11084 6104 4759 6677 11085 6104 6561 8222 11086 4568 2141 8254 11087 4568 3595 2141 11088 4568 622 3595 11089 4568 8110 622 11090 4568 8254 8110 11091 2065 6624 8893 11092 2065 8893 3161 11093 2065 2141 6624 11094 1686 8254 2141 11095 1686 2141 2638 11096 6624 4347 8893 11097 6624 3595 4347 11098 6624 2141 3595 11099 2215 1406 4492 11100 2215 4492 4771 11101 2215 4771 5027 11102 2215 5027 5793 11103 2215 5793 1406 11104 7226 217 1299 11105 7226 8760 217 11106 7226 6817 7944 11107 7226 1299 6817 11108 325 5119 7289 11109 325 154 5119 11110 325 2331 154 11111 325 7289 8362 11112 325 9734 2331 11113 325 8362 9734 11114 7289 9336 9283 11115 7289 9283 8362 11116 7289 5119 9336 11117 8116 3384 939 11118 6321 9785 2694 11119 6153 9022 2066 11120 559 8202 9948 11121 4189 3739 9391 11122 4430 3739 6455 11123 4430 6455 1606 11124 4430 1606 5574 11125 4430 9391 3739 11126 4430 9992 9391 11127 8071 622 9732 11128 8071 7932 622 11129 1860 3761 4113 11130 1860 1752 3761 11131 9103 31 1327 11132 4350 4260 1836 11133 4350 1836 9742 11134 4350 2665 4260 11135 4350 2508 2665 11136 5381 9742 1953 11137 2260 5295 8353 11138 4640 9607 9039 11139 4640 9039 194 11140 4640 510 8433 11141 4640 8433 9607 11142 4640 5617 6260 11143 4640 4017 5617 11144 4640 2681 510 11145 4640 6260 2681 11146 4640 3773 4017 11147 4640 194 3773 11148 5675 8433 510 11149 5675 510 1705 11150 5675 9607 8433 11151 2665 2508 2462 11152 2665 2462 3384 11153 4281 9119 7733 11154 4281 9116 9119 11155 4281 7733 6540 11156 4281 6540 9116 11157 9155 7733 9882 11158 4683 1457 2861 11159 4683 2453 1457 11160 7947 8661 6163 11161 7947 7314 8661 11162 4445 9583 3080 11163 4445 8954 7348 11164 7689 920 9316 11165 8269 994 7348 11166 8269 7348 6114 11167 5362 7314 8654 11168 5362 993 7314 11169 3810 5295 2960 11170 3810 8353 5295 11171 3810 2960 735 11172 5130 5443 2570 11173 6364 8032 5443 11174 2570 4703 3 11175 7713 9915 268 11176 7713 307 9915 11177 4703 7065 3 11178 4703 4412 7065 11179 5597 7390 3589 11180 538 9692 6438 11181 538 6438 9239 11182 538 9239 5726 11183 430 8139 198 11184 430 198 343 11185 430 6438 9692 11186 430 9692 8139 11187 430 5101 6438 11188 430 343 5101 11189 1534 1364 8238 11190 1534 8238 8751 11191 2022 6465 522 11192 2022 9119 6226 11193 2022 6226 7447 11194 2022 7447 6465 11195 1874 8049 7755 11196 1874 8238 8049 11197 218 999 3858 11198 218 5773 999 11199 218 517 5773 11200 218 8285 1724 11201 218 9085 8285 11202 218 3858 9085 11203 218 1724 517 11204 8427 6007 407 11205 8427 407 4035 11206 8427 6108 6007 11207 6612 7016 6455 11208 7016 8496 7442 11209 7016 7442 1606 11210 7016 1606 6455 11211 6656 6634 2688 11212 2018 8376 2345 11213 2018 9915 7530 11214 7101 1331 1447 11215 3 7530 5293 11216 3 7065 7530 11217 8670 7463 6543 11218 8670 6543 1447 11219 8670 1447 1331 11220 8397 6543 7463 11221 9373 4376 7481 11222 8546 7481 2899 11223 9484 6793 1650 11224 9484 7005 9542 11225 9484 9542 9885 11226 9484 1650 7005 11227 3024 6196 3792 11228 3024 9049 6196 11229 3024 3792 4960 11230 3471 4053 2807 11231 3471 7005 4053 11232 3471 2807 7710 11233 5746 4309 5979 11234 9334 1758 7078 11235 1194 8855 1758 11236 1194 6486 8855 11237 3681 4749 8978 11238 3681 9164 4749 11239 3852 9164 3843 11240 3852 3573 9164 11241 3852 4739 3573 11242 3852 9879 4739 11243 4727 6599 855 11244 5057 5482 3163 11245 5057 3163 8764 11246 6314 2504 8536 11247 8831 7078 1758 11248 8831 1758 8855 11249 8831 8855 6486 11250 5639 1131 8270 11251 5639 2980 1131 11252 5639 8270 3840 11253 803 140 1546 11254 803 6313 140 11255 803 1546 8628 11256 803 7608 4460 11257 803 4460 6313 11258 803 8628 7608 11259 5149 1058 6095 11260 5149 6095 3670 11261 5149 5231 1058 11262 1137 4133 6717 11263 1137 7651 4133 11264 1137 3994 784 11265 1137 784 7651 11266 2984 3226 5892 11267 8674 7420 1281 11268 8703 5825 8081 11269 8703 4042 5825 11270 8703 8081 3427 11271 8196 1120 5187 11272 8196 3902 2007 11273 8196 2007 6106 11274 8196 5678 3902 11275 8196 6106 1120 11276 319 5566 5825 11277 6326 6671 2007 11278 6326 3924 6671 11279 6326 8697 3924 11280 6326 5233 8697 11281 6326 2007 5233 11282 4316 1364 7444 11283 4316 8049 1364 11284 4316 5487 8049 11285 4316 5617 4457 11286 4316 7444 5617 11287 4316 4457 5487 11288 9425 1041 3014 11289 9425 3014 2886 11290 9425 2886 4898 11291 9425 708 1041 11292 2016 447 9239 11293 2016 9239 6923 11294 2016 9033 447 11295 1072 470 1605 11296 1072 1605 477 11297 1072 5950 9033 11298 6438 7672 9239 11299 6438 5101 7672 11300 7412 5101 4067 11301 7412 7672 5101 11302 7412 4067 7672 11303 5425 517 1724 11304 5425 1724 8646 11305 5425 9545 517 11306 1451 5534 9792 11307 7771 1275 6728 11308 3918 7294 8784 11309 3918 6728 7294 11310 2629 7042 3123 11311 2629 3123 663 11312 3014 3629 98 11313 3014 1041 3629 11314 4702 158 2886 11315 2472 3983 7969 11316 2472 6763 1198 11317 2472 5951 6763 11318 2472 4890 5951 11319 2472 7969 4890 11320 4734 98 3629 11321 5390 3987 7386 11322 5390 9242 3987 11323 5390 4806 914 11324 5390 7386 4806 11325 5390 914 9242 11326 9211 8209 8113 11327 9211 595 8209 11328 9211 8113 595 11329 4806 5101 3759 11330 4806 4067 5101 11331 4806 3759 8209 11332 4806 8209 914 11333 4806 9747 4067 11334 4806 7386 9747 11335 9747 7386 7815 11336 7815 7386 3987 11337 7815 4295 2337 11338 9594 7879 3268 11339 9594 4295 7879 11340 9594 2337 4295 11341 7879 6757 3268 11342 7879 3045 6757 11343 8577 4492 1406 11344 8577 1406 6935 11345 8577 6935 3045 11346 8596 9308 5367 11347 8596 5367 9806 11348 8596 9806 4852 11349 8596 4852 3329 11350 8596 3329 7235 11351 2631 30 873 11352 2631 873 7130 11353 5276 3116 3096 11354 5276 3096 1138 11355 5276 5292 3116 11356 5276 1138 1954 11357 5276 5962 1720 11358 5276 1720 5292 11359 5276 8590 5962 11360 5276 1954 8590 11361 2258 1273 1251 11362 2258 7616 4194 11363 2258 4194 136 11364 2258 6365 7616 11365 2258 1251 6365 11366 7616 3098 4194 11367 7616 6365 5495 11368 1273 5211 1251 11369 1273 6174 5211 11370 3116 2668 8024 11371 3116 8024 3096 11372 7754 4042 7810 11373 7754 3343 4042 11374 7754 6717 3343 11375 1410 5705 956 11376 1410 4503 5705 11377 1410 956 7029 11378 1410 2711 4503 11379 1410 7495 2711 11380 5400 4144 2889 11381 5400 2889 3581 11382 5400 3581 3545 11383 5400 3545 6599 11384 5400 9059 5709 11385 5400 5709 4144 11386 6849 7374 4656 11387 6849 3410 7374 11388 6849 4656 7006 11389 6849 7006 2727 11390 6849 2727 3410 11391 7006 5152 336 11392 7006 336 898 11393 7006 898 2590 11394 7006 4656 5152 11395 7006 2590 2727 11396 5152 8993 336 11397 5152 9529 8993 11398 5152 5108 9529 11399 5152 6355 5108 11400 5152 4656 6355 11401 5588 4408 9385 11402 5588 6160 4408 11403 5588 8400 6160 11404 5588 9385 5637 11405 5637 2970 6736 11406 5637 9385 2970 11407 6461 8551 52 11408 6461 9645 8551 11409 7300 301 619 11410 7300 6248 301 11411 7300 7009 2274 11412 7300 619 7009 11413 7300 2274 6248 11414 3736 8239 8643 11415 3736 8643 2123 11416 8643 2302 7009 11417 8643 8239 2302 11418 8643 7009 3932 11419 8643 6344 2123 11420 2302 5338 2274 11421 2302 9417 5338 11422 2302 2274 7009 11423 2302 8239 9417 11424 2199 7009 619 11425 2199 619 440 11426 2199 8671 3932 11427 2199 1767 8671 11428 2199 440 1767 11429 2199 3932 7009 11430 6344 2667 2123 11431 6344 5662 2667 11432 67 6374 2981 11433 67 1018 6374 11434 7699 850 7122 11435 7699 800 850 11436 7699 5763 8782 11437 7699 8782 3146 11438 7699 3146 800 11439 7699 7122 5763 11440 9050 3006 6850 11441 9050 6850 8782 11442 9050 5763 7122 11443 9050 8782 5763 11444 9050 66 4637 11445 9050 4637 8659 11446 9050 8659 3006 11447 9050 7122 3041 11448 9050 3041 66 11449 3041 7122 850 11450 3041 3833 8090 11451 3041 8090 209 11452 3041 209 66 11453 3041 850 3833 11454 5246 1202 5848 11455 5246 9784 1202 11456 7332 3724 2082 11457 7332 2082 8474 11458 7332 8766 3724 11459 3724 8766 8879 11460 3724 8879 7910 11461 3724 7910 2082 11462 5320 1212 1196 11463 5320 3100 1212 11464 5320 6945 3100 11465 5320 1196 7496 11466 114 4416 3742 11467 114 7523 4416 11468 114 1196 1212 11469 114 3742 2118 11470 114 2118 1196 11471 6006 2616 5431 11472 6006 8940 2616 11473 6006 3742 8940 11474 2118 9889 1196 11475 6133 1079 7160 11476 6133 6069 1079 11477 6133 3100 8964 11478 6133 7160 3100 11479 6133 8964 6069 11480 7868 9098 9582 11481 7868 9582 3572 11482 9582 9472 3572 11483 8725 724 6197 11484 8725 7695 724 11485 8725 7676 7665 11486 8725 6197 7676 11487 8725 3185 7695 11488 9786 2249 3957 11489 9786 3957 3185 11490 9786 3985 1475 11491 9786 1475 4143 11492 9786 4143 2249 11493 6630 8639 2815 11494 6630 7570 8639 11495 6630 2815 2249 11496 6630 3609 7570 11497 6630 4143 5920 11498 6630 5920 3609 11499 6630 2249 4143 11500 2911 1950 1983 11501 2911 1983 6765 11502 2911 8797 1950 11503 2911 3040 8797 11504 2911 6765 3040 11505 7069 646 7313 11506 7069 7055 646 11507 7069 1216 6048 11508 7069 6048 7055 11509 7069 3040 1216 11510 7069 7313 3040 11511 1216 9750 6048 11512 1216 6765 9750 11513 1216 3040 6765 11514 1206 8797 7820 11515 1206 7820 291 11516 1206 1950 8797 11517 1206 291 1950 11518 7152 7984 5071 11519 7152 8089 2293 11520 3054 6684 9240 11521 6563 8089 9712 11522 6563 2293 8089 11523 6563 1983 2293 11524 5022 3421 7886 11525 5022 7886 8138 11526 5022 9240 3421 11527 3421 9240 7886 11528 7971 7125 9405 11529 7971 9405 4064 11530 7971 2662 7125 11531 7208 2662 2918 11532 7208 7125 2662 11533 7208 4967 7125 11534 7208 2918 4967 11535 6838 3809 9040 11536 6838 4064 6619 11537 6838 6619 3809 11538 2841 8699 946 11539 774 2877 1983 11540 774 1983 291 11541 774 3452 8538 11542 774 8538 2877 11543 774 291 3452 11544 7820 8797 1513 11545 7820 3452 291 11546 3463 5811 3893 11547 3463 3893 5298 11548 3463 5298 5093 11549 3463 5093 10001 11550 3463 10001 2877 11551 8825 2877 8538 11552 6215 2216 1376 11553 1349 1052 3893 11554 611 6885 4923 11555 611 5358 6885 11556 611 5071 7984 11557 611 4923 5071 11558 8491 3494 7625 11559 8491 275 3494 11560 6148 5647 2771 11561 6148 4680 5647 11562 6148 2771 8306 11563 9667 8945 259 11564 1984 6476 8731 11565 1984 8484 6476 11566 1984 8731 8568 11567 1984 3494 8894 11568 1984 8568 3494 11569 1984 8894 8484 11570 338 3898 4009 11571 338 4009 7339 11572 5634 2639 9945 11573 4167 3854 5129 11574 4167 1884 4475 11575 3854 2094 5129 11576 8390 4797 9483 11577 8390 4616 4797 11578 3430 9588 8118 11579 3430 8118 1045 11580 3430 1045 1512 11581 1391 777 7965 11582 4789 1920 9955 11583 4789 9955 8123 11584 4789 6843 4621 11585 4789 8123 6843 11586 6333 8244 1324 11587 6333 4358 8244 11588 6333 1324 5704 11589 6333 1276 4388 11590 6333 5704 1276 11591 6333 4388 6912 11592 6333 6912 4358 11593 7831 1324 6032 11594 7831 8164 1324 11595 9975 4652 5977 11596 9975 3663 8275 11597 9975 8275 4652 11598 7115 3073 358 11599 7115 358 3083 11600 5034 4388 1276 11601 5034 1276 8303 11602 5034 8303 5341 11603 5034 4999 1901 11604 5034 1901 4388 11605 5034 5341 4999 11606 8432 351 7127 11607 8432 462 351 11608 8432 8367 462 11609 351 1901 4999 11610 351 1708 1901 11611 351 59 7127 11612 351 4999 59 11613 351 462 1708 11614 6131 6709 5978 11615 6131 5978 7413 11616 5102 9127 6598 11617 5102 6598 2583 11618 6595 7492 4794 11619 9983 2134 5098 11620 9983 5098 2277 11621 9983 8130 2134 11622 9983 7492 8130 11623 6973 3402 9127 11624 6973 7497 3402 11625 3967 8722 7206 11626 3967 7206 3658 11627 1580 7127 59 11628 1580 59 90 11629 570 4037 6545 11630 570 6545 4443 11631 570 8367 4037 11632 8544 7490 1069 11633 8544 1575 7490 11634 5835 6859 5098 11635 5835 1069 6859 11636 5835 2134 8130 11637 5835 5098 2134 11638 6138 437 9046 11639 6138 9046 2795 11640 6138 7538 437 11641 6138 5222 7538 11642 6138 2583 5002 11643 6138 5002 5222 11644 6138 2795 2583 11645 1297 6755 691 11646 1297 691 1825 11647 1297 1558 6755 11648 1297 1825 1558 11649 4785 9543 3688 11650 3849 1793 9520 11651 3849 9520 2404 11652 7916 5384 6015 11653 7916 6015 9805 11654 7916 235 5384 11655 8569 5384 9659 11656 8569 6015 5384 11657 8480 6110 5459 11658 8480 9318 6110 11659 5652 816 11 11660 5652 11 3727 11661 4624 5195 8063 11662 4624 7727 5195 11663 5195 1752 9878 11664 5195 7727 1752 11665 1991 9060 1505 11666 4389 6625 9252 11667 1028 7843 5684 11668 659 294 5684 11669 659 5684 3626 11670 659 3626 6166 11671 5684 7843 3626 11672 3798 5286 2291 11673 3798 9993 5286 11674 2474 1862 1092 11675 7655 7729 125 11676 7655 125 9395 11677 7655 9395 5286 11678 9800 1467 5517 11679 9800 5517 1870 11680 9765 5062 4225 11681 9765 1423 5062 11682 783 4558 6349 11683 2112 6349 5857 11684 2112 5857 5047 11685 2112 5047 3755 11686 5062 3434 4225 11687 5062 3066 3434 11688 5062 1423 6308 11689 6112 3645 3458 11690 6112 4644 3645 11691 6112 3458 5396 11692 6112 5396 4644 11693 3645 6359 3458 11694 4504 9788 9133 11695 4504 9384 9788 11696 4619 6359 7779 11697 200 9788 9384 11698 9504 3889 9384 11699 9504 1859 3889 11700 8951 1019 7240 11701 1113 480 3069 11702 1113 3069 5698 11703 1113 5698 6499 11704 4523 4427 9991 11705 4523 9991 1201 11706 4523 4466 7501 11707 4523 1201 4466 11708 4006 8303 862 11709 4006 4466 8303 11710 4006 7501 4466 11711 59 4798 1201 11712 59 5341 4798 11713 59 4999 5341 11714 59 1201 8939 11715 9158 8939 5857 11716 6611 4254 1488 11717 9298 9490 334 11718 1506 6116 2625 11719 3638 6029 670 11720 1596 7144 7685 11721 1596 297 7144 11722 1596 3249 9108 11723 1596 7685 3249 11724 2419 7153 9490 11725 6805 3401 6206 11726 6805 6206 3502 11727 6206 3401 8922 11728 4007 9047 8300 11729 4007 7747 9047 11730 5046 3636 7751 11731 5046 7751 7747 11732 5413 5889 9479 11733 9694 9830 4716 11734 5606 8142 3505 11735 7229 4823 9413 11736 7229 9413 8883 11737 1096 6004 4087 11738 1096 6152 6004 11739 1096 4087 2383 11740 7231 6397 9635 11741 6178 8949 6926 11742 1021 4787 1468 11743 1021 4717 4787 11744 1021 1468 5444 11745 1021 5444 4717 11746 9635 593 6493 11747 9635 6493 1263 11748 9635 6397 593 11749 9926 9686 6493 11750 9926 1468 9686 11751 9926 6493 593 11752 9926 593 6397 11753 6493 3174 1263 11754 6493 9686 3174 11755 5424 9882 9119 11756 4087 6004 9659 11757 4087 9659 2383 11758 1117 995 7784 11759 1117 3935 995 11760 1117 9055 3935 11761 1117 422 6474 11762 1117 900 422 11763 1117 6474 9055 11764 1117 7784 900 11765 9852 4899 2093 11766 9852 779 4899 11767 9852 3575 779 11768 9852 9019 3575 11769 9852 4535 9019 11770 9852 2093 4535 11771 668 1602 2093 11772 668 1992 1602 11773 668 2093 4899 11774 668 4899 4710 11775 668 4710 8809 11776 668 8809 1992 11777 2117 3997 3526 11778 2117 3526 1381 11779 2117 1381 4875 11780 2117 1348 3997 11781 2117 4875 1348 11782 2348 2398 1481 11783 2348 7037 2398 11784 2348 6051 7037 11785 1798 7186 9218 11786 1798 9218 7445 11787 1798 7445 2217 11788 1798 4148 7186 11789 9415 2231 963 11790 9415 6021 2231 11791 9415 4284 6021 11792 2524 7507 5247 11793 2524 4392 7507 11794 2524 744 2434 11795 2524 5247 744 11796 2035 1368 2376 11797 2366 9670 5097 11798 2366 740 5664 11799 2366 5664 9670 11800 2530 4735 6803 11801 2530 2925 4735 11802 2530 279 2925 11803 2530 6803 4326 11804 9115 6653 5612 11805 2299 2595 3686 11806 2299 3686 3400 11807 2299 9553 2595 11808 2299 3400 7748 11809 1342 8332 1482 11810 1342 1482 5054 11811 3487 4326 6803 11812 3487 6803 1946 11813 3487 1946 8332 11814 1482 8332 1946 11815 1482 1946 1728 11816 1482 9795 5054 11817 1482 1728 9795 11818 6738 2490 9562 11819 6738 4016 2490 11820 1494 147 4016 11821 1494 9221 147 11822 3114 5490 1040 11823 3114 1040 9342 11824 3114 9342 788 11825 368 6927 5943 11826 368 5943 9624 11827 368 6294 6927 11828 368 7521 6294 11829 368 9624 7521 11830 4029 5114 8261 11831 4029 8261 3128 11832 4029 2964 9353 11833 4029 9353 5114 11834 4029 3128 2964 11835 9353 2964 830 11836 9353 830 3812 11837 9353 4869 1199 11838 9353 637 4869 11839 9353 1199 5114 11840 9353 92 637 11841 9353 3812 92 11842 8586 4002 664 11843 3660 1199 4869 11844 3660 8584 1199 11845 7190 1690 9418 11846 7190 9418 3553 11847 7190 5686 1690 11848 9289 1354 5686 11849 4965 8563 3553 11850 7687 8341 1831 11851 7687 5151 8341 11852 8691 2386 7987 11853 8691 7987 9021 11854 9866 7433 428 11855 1257 970 2136 11856 1257 3476 970 11857 7686 3941 8635 11858 7686 9944 3941 11859 7686 8635 6946 11860 7686 6946 9944 11861 8178 2717 2891 11862 5269 3231 6498 11863 5269 435 3544 11864 6877 2611 4891 11865 6877 1220 2611 11866 6877 4732 1220 11867 6877 6833 4732 11868 6877 4728 6833 11869 6877 4891 4728 11870 8074 519 213 11871 8074 213 7210 11872 8074 7210 8127 11873 8074 8127 519 11874 485 5795 1450 11875 485 1450 3496 11876 485 3496 2900 11877 485 2900 2001 11878 7674 5864 2900 11879 7674 8632 2734 11880 9700 5484 700 11881 5281 700 5484 11882 5281 5484 6894 11883 5281 6894 5409 11884 371 1967 3259 11885 371 9468 1563 11886 371 1563 1967 11887 9709 7486 8126 11888 9709 8126 8381 11889 9709 3247 7486 11890 2762 8597 3726 11891 3726 8121 5435 11892 3726 8597 9337 11893 3726 9337 2891 11894 3726 2891 2305 11895 3726 2305 8121 11896 1197 6482 1450 11897 1197 2600 6482 11898 1197 1450 5795 11899 1197 3769 2600 11900 4249 23 6482 11901 4249 8364 23 11902 8903 6616 7590 11903 6922 1795 3282 11904 6922 9833 1795 11905 6922 2967 9833 11906 6922 2993 2967 11907 3202 4660 1062 11908 3082 2687 2808 11909 3082 2808 270 11910 2808 3635 8044 11911 2808 8044 270 11912 4062 5936 290 11913 4062 290 8848 11914 4062 5200 9423 11915 4062 9423 7170 11916 4062 7170 9042 11917 4062 8848 5200 11918 4062 9042 5936 11919 7623 7393 1367 11920 7623 882 2151 11921 7623 2151 7393 11922 7623 9224 882 11923 7623 1666 9224 11924 7623 645 1666 11925 4573 6411 1666 11926 4573 1003 6411 11927 4573 5936 9890 11928 4573 9890 1003 11929 6513 4890 7638 11930 6513 7638 5365 11931 32 8177 5055 11932 32 5055 4484 11933 32 8097 8177 11934 32 1239 8097 11935 2151 882 358 11936 2151 1239 7393 11937 6056 4598 6522 11938 6056 6132 4598 11939 6056 3847 6132 11940 3372 4715 6522 11941 3372 6522 4598 11942 3372 6123 4715 11943 3372 3543 6123 11944 3372 6132 3543 11945 3372 4598 6132 11946 2019 2 6841 11947 2019 6841 5941 11948 2019 5941 4760 11949 8229 6305 3847 11950 8229 313 6305 11951 8229 3847 2067 11952 8229 5451 902 11953 8229 902 313 11954 8229 2067 5451 11955 2529 3543 6305 11956 2529 9783 3543 11957 2529 6305 5690 11958 2529 5690 9783 11959 7728 3628 3738 11960 7728 3738 8809 11961 7728 4710 3628 11962 7728 8809 4710 11963 6266 2982 2421 11964 2283 8039 1371 11965 2283 1871 8039 11966 3580 5205 2982 11967 3580 2723 5205 11968 3580 4765 901 11969 3580 901 2723 11970 321 3675 2421 11971 321 2421 2982 11972 1524 5941 3675 11973 1524 4760 5941 11974 1524 3424 4760 11975 8319 1272 9110 11976 8039 957 1946 11977 8039 1946 1371 11978 8039 1871 957 11979 3274 5314 3073 11980 3274 3322 5314 11981 6618 9722 714 11982 6618 714 917 11983 8773 4626 1223 11984 8773 1223 3847 11985 4355 425 2657 11986 7731 691 4230 11987 7731 2231 691 11988 7731 4647 2231 11989 7731 3388 4647 11990 9237 5327 1590 11991 9237 817 5327 11992 9237 1590 8958 11993 9237 8958 4230 11994 9237 4230 817 11995 6554 8958 524 11996 6554 524 3197 11997 2607 9676 7404 11998 2607 1503 9676 11999 2607 7404 4889 12000 2607 9888 1503 12001 2607 7572 9888 12002 2607 3375 7572 12003 2607 4889 3375 12004 9980 981 7445 12005 9980 7445 747 12006 9980 747 2716 12007 1080 820 7210 12008 1080 7210 2604 12009 8525 9218 4800 12010 8525 747 9218 12011 8525 4800 5117 12012 8525 5117 2716 12013 8525 2716 747 12014 5117 4800 5893 12015 9633 7293 2158 12016 9633 1835 7293 12017 9633 2158 9737 12018 9633 3049 1835 12019 9011 2352 3170 12020 9011 9014 2352 12021 9011 5250 4465 12022 9011 3170 5250 12023 9011 4465 2572 12024 9011 2572 2818 12025 9011 2818 9014 12026 2528 2818 2572 12027 2528 9675 2818 12028 2528 1253 9818 12029 2528 9818 9675 12030 4465 5250 5274 12031 1221 3524 8847 12032 1221 8847 4539 12033 1221 4539 3481 12034 1221 7124 5477 12035 1221 3481 7124 12036 1221 5477 3524 12037 9646 4731 3524 12038 9646 3559 4731 12039 9646 3524 5477 12040 9646 5477 3559 12041 3383 6481 5240 12042 3703 5533 5336 12043 3703 1462 5533 12044 3703 6940 3265 12045 3703 5336 6940 12046 3703 3265 6234 12047 3703 6234 1462 12048 938 8190 1972 12049 938 1972 9144 12050 938 9144 6416 12051 4434 6018 2752 12052 64 8383 7564 12053 64 1046 8383 12054 64 7564 8961 12055 64 8961 1046 12056 8150 1574 3527 12057 8150 8383 3122 12058 8150 3122 1574 12059 8150 7564 8383 12060 8150 52 7564 12061 1976 4009 3898 12062 1976 7776 4009 12063 1976 6280 3050 12064 1976 3050 2466 12065 1976 2466 2379 12066 1976 2379 7776 12067 905 5833 5126 12068 905 5126 7863 12069 905 5111 5833 12070 905 4520 5111 12071 905 7863 6837 12072 905 6837 4520 12073 8776 2932 7785 12074 9883 8495 5452 12075 9883 3340 8495 12076 9883 5452 1737 12077 8043 5996 5423 12078 5423 5996 1947 12079 2233 6936 2729 12080 2233 2087 6936 12081 2233 2729 1145 12082 2233 7972 2087 12083 2233 1145 392 12084 2233 2463 7972 12085 392 1145 6806 12086 392 6806 281 12087 8882 921 1483 12088 6649 5996 1815 12089 6649 4922 5996 12090 6649 1815 2788 12091 2902 7371 9491 12092 2902 6537 7371 12093 2902 4141 6537 12094 9855 4090 4351 12095 9855 2919 4090 12096 9855 5897 2919 12097 9855 566 6997 12098 9855 6997 5897 12099 304 3627 6622 12100 304 6997 3627 12101 4840 1252 5259 12102 4840 5259 8028 12103 5126 6837 7863 12104 9167 1103 6516 12105 9167 6516 4034 12106 9167 1094 1103 12107 5474 82 9920 12108 5474 8814 82 12109 4714 7493 5087 12110 4714 5087 8851 12111 4714 8851 8814 12112 7529 1103 9387 12113 7529 9387 1519 12114 8808 9229 7590 12115 8808 1519 9229 12116 8808 7590 6616 12117 4090 797 4351 12118 5872 5218 754 12119 5872 754 4330 12120 3601 345 5218 12121 4648 3641 6018 12122 4648 2503 3641 12123 4648 372 2503 12124 7583 672 9642 12125 7583 9642 7749 12126 7583 7267 672 12127 7583 4941 7267 12128 7583 7749 4941 12129 2147 2028 9642 12130 2147 5672 2028 12131 2147 4775 5672 12132 2147 672 7267 12133 2147 9642 672 12134 1313 7952 3693 12135 1313 3693 5708 12136 2301 7096 9918 12137 2301 6420 7096 12138 2301 6186 6420 12139 2301 7070 6807 12140 2301 9918 7070 12141 8923 1242 4752 12142 8923 4752 6470 12143 8923 6470 7475 12144 5990 2162 3074 12145 5990 6807 2162 12146 5990 3074 6807 12147 3544 435 8313 12148 1417 8313 9111 12149 553 8448 3619 12150 553 3619 435 12151 3357 9974 3336 12152 3357 3336 6221 12153 4592 8067 8448 12154 4592 8585 8067 12155 417 2385 9591 12156 417 4028 2385 12157 417 9355 4028 12158 417 1941 9355 12159 417 1704 2575 12160 417 5486 1704 12161 417 9591 5486 12162 417 2575 1941 12163 9355 5347 4028 12164 9355 1470 5347 12165 9355 7895 1470 12166 9355 773 7895 12167 9355 1941 773 12168 8553 1318 9120 12169 8553 9376 1318 12170 8553 8289 9376 12171 8553 6024 4011 12172 8553 4011 8289 12173 8553 2284 6024 12174 8553 55 2284 12175 8553 9120 55 12176 254 2224 7693 12177 254 7568 2897 12178 254 8857 7568 12179 254 2897 3691 12180 254 7693 8857 12181 1166 424 68 12182 1166 2063 424 12183 424 3751 68 12184 5433 4411 9376 12185 5433 9376 4048 12186 5945 2871 1428 12187 9979 9468 8381 12188 7878 498 1676 12189 7878 1676 3052 12190 7878 3052 5816 12191 7878 6008 498 12192 7878 5816 6008 12193 792 300 1142 12194 792 7679 300 12195 792 1142 3897 12196 792 6853 7679 12197 3342 5645 1022 12198 3342 1022 2520 12199 3342 2520 5980 12200 3342 5980 8288 12201 815 4828 2068 12202 815 2068 7128 12203 815 2172 4828 12204 815 7128 9090 12205 3392 7977 4055 12206 3392 4055 1797 12207 3392 1797 8430 12208 3392 8430 6005 12209 2221 8504 7171 12210 2221 9136 8504 12211 2221 9062 9136 12212 4282 1400 9136 12213 4282 9136 9062 12214 4282 3052 1400 12215 4282 9062 3052 12216 3718 6008 9762 12217 3718 5563 6008 12218 3718 2061 5563 12219 3718 9762 1807 12220 7822 677 6698 12221 7822 2300 677 12222 7822 1807 9762 12223 7822 9762 2300 12224 7822 6698 3387 12225 7822 3387 1807 12226 3387 6698 1296 12227 4497 4362 9677 12228 4497 9677 456 12229 4497 456 7816 12230 4497 7816 8807 12231 4497 8807 2525 12232 7488 8847 4731 12233 7488 4731 4704 12234 7488 4704 7816 12235 7488 7816 6276 12236 7488 6276 9233 12237 7488 9233 8847 12238 8807 2150 2525 12239 9372 647 8257 12240 9372 8257 134 12241 9372 6481 3884 12242 9372 134 6481 12243 9372 3884 647 12244 8757 2223 647 12245 8757 916 2223 12246 8757 7896 916 12247 8757 3884 1461 12248 8757 1461 7896 12249 8757 647 3884 12250 6848 2070 9266 12251 8226 1409 9091 12252 1038 4302 1615 12253 1038 1615 383 12254 1038 6903 4302 12255 1038 8173 6903 12256 1038 9952 8173 12257 1038 383 9952 12258 503 6200 5157 12259 8843 5789 5364 12260 8843 5364 2070 12261 8843 6903 3933 12262 5944 6631 489 12263 5944 3654 6631 12264 2991 4122 7023 12265 2991 7023 3654 12266 2991 3933 4122 12267 7880 633 9731 12268 9331 2990 8775 12269 9331 6602 2990 12270 9331 8775 1615 12271 9331 5870 6602 12272 8991 2438 879 12273 8991 879 750 12274 8991 750 4940 12275 8991 4940 385 12276 8991 385 9735 12277 6391 1750 626 12278 1750 3559 778 12279 1750 6940 626 12280 1750 778 6940 12281 9125 9378 6268 12282 9125 6268 4580 12283 581 4580 6268 12284 581 6268 4076 12285 3416 7001 4073 12286 3416 1329 7001 12287 3416 4074 4352 12288 3416 4352 1329 12289 1335 5274 5250 12290 1335 8789 5274 12291 1335 6362 8789 12292 3868 5250 3170 12293 3868 3170 1896 12294 3868 1896 1567 12295 5043 4356 5966 12296 5043 5966 1401 12297 9420 9839 5441 12298 2190 3280 4026 12299 5862 4471 7165 12300 5862 1567 4471 12301 5862 4292 1567 12302 5862 7165 4394 12303 5862 4394 3445 12304 5862 3445 4292 12305 9682 4968 4122 12306 9682 4122 2124 12307 9682 2124 1990 12308 2758 6307 9093 12309 8401 6091 1413 12310 8401 1413 8505 12311 8401 885 6091 12312 8401 8505 885 12313 4634 5577 8505 12314 4634 2653 5577 12315 4447 7233 9296 12316 4447 9296 1294 12317 4447 1294 2339 12318 6243 1379 3013 12319 6243 3013 9201 12320 6243 9201 693 12321 3035 4032 6590 12322 3035 8724 4032 12323 5762 2709 7034 12324 5762 7034 3592 12325 109 1413 6091 12326 109 6091 885 12327 7209 2514 6417 12328 7209 6417 7233 12329 6720 885 5008 12330 6720 5008 3696 12331 6720 3696 1379 12332 7472 512 5681 12333 7107 9826 9575 12334 2289 1565 1330 12335 2289 6508 1565 12336 1565 2824 1330 12337 1565 6508 4322 12338 5094 2770 6323 12339 5094 6323 1725 12340 2630 2148 8109 12341 2630 120 2148 12342 2630 605 120 12343 5922 6872 4177 12344 5922 4109 6872 12345 4177 6872 1404 12346 4177 1404 8802 12347 1695 9090 7128 12348 1695 1493 9090 12349 8181 1701 3031 12350 8181 922 1701 12351 8181 6781 922 12352 6194 7960 1427 12353 6194 7993 7960 12354 6194 1427 7874 12355 6194 8109 7993 12356 3283 9537 6834 12357 3283 8031 9537 12358 3283 6834 8031 12359 7698 5364 5789 12360 6065 3435 4842 12361 6065 4842 3449 12362 6065 1156 3435 12363 6065 3449 8712 12364 3435 525 4842 12365 7951 6981 8501 12366 7951 8501 525 12367 8834 1393 7126 12368 353 8712 3449 12369 3441 8998 5488 12370 3441 9207 8998 12371 3441 1895 9207 12372 3441 5488 9660 12373 5842 1625 9660 12374 5842 5264 1625 12375 5842 1317 5264 12376 5842 5915 7552 12377 5842 7552 1317 12378 5842 5488 5915 12379 5842 9660 5488 12380 8998 5915 5488 12381 8998 9207 5915 12382 8146 9677 4362 12383 1542 7451 427 12384 1542 427 374 12385 5207 9194 7595 12386 427 7451 7539 12387 427 7539 3509 12388 889 6087 7804 12389 889 7308 6087 12390 9561 5497 9822 12391 1445 9822 5497 12392 7163 6834 9537 12393 5334 1857 5254 12394 5334 5254 170 12395 5334 170 212 12396 5334 212 7171 12397 9794 5254 1857 12398 9794 4553 5254 12399 9794 1857 5449 12400 7462 3269 1780 12401 7462 4579 3269 12402 7462 1780 4579 12403 1746 7478 3564 12404 1746 3564 7312 12405 1746 7312 7873 12406 1746 6254 7478 12407 745 7185 7478 12408 745 9981 7185 12409 745 6327 9981 12410 745 5278 6327 12411 745 9069 5278 12412 745 7478 6254 12413 8754 1422 837 12414 4807 8900 9069 12415 4807 9631 8900 12416 4807 1504 9631 12417 4020 8792 3952 12418 4020 1944 1422 12419 5483 7723 3067 12420 5483 459 7723 12421 5483 4517 5742 12422 5483 5742 459 12423 5483 3934 3795 12424 5483 7924 3934 12425 5483 3067 7924 12426 5483 3795 4517 12427 7858 5742 4517 12428 7858 8716 5742 12429 9485 1005 2644 12430 9485 9072 1005 12431 9485 6747 3347 12432 9485 3347 9072 12433 9485 1673 987 12434 9485 987 6107 12435 9485 6107 6747 12436 9485 2644 1673 12437 4885 1333 3276 12438 4885 4672 1333 12439 4885 6205 4672 12440 4885 3276 8010 12441 4885 8010 6205 12442 5395 3206 8311 12443 5395 4488 3206 12444 5395 3007 4488 12445 4488 1044 3206 12446 4488 6882 1044 12447 4488 3007 9137 12448 4488 9137 3203 12449 4488 3203 6882 12450 7897 9572 5818 12451 7897 5818 8609 12452 7897 8609 3627 12453 7897 3627 566 12454 7429 9572 8545 12455 7429 8545 5646 12456 7429 5818 9572 12457 7429 5646 5818 12458 5579 8531 2145 12459 5579 2145 4718 12460 5579 2033 8086 12461 5579 8086 8531 12462 5579 4718 2033 12463 6373 1332 620 12464 6373 1973 1332 12465 6373 620 8374 12466 9064 4662 7067 12467 9064 7067 634 12468 9064 634 5166 12469 9064 5166 8530 12470 4959 1838 3894 12471 4959 3289 8236 12472 4959 3894 3289 12473 1259 5646 8357 12474 1259 6025 5646 12475 1259 8357 3894 12476 1259 3894 4662 12477 1259 1697 6025 12478 7708 7067 1838 12479 4934 1923 94 12480 4934 5843 1923 12481 4913 3258 1583 12482 4913 8531 3258 12483 4913 1583 2732 12484 4913 2145 8531 12485 4913 8910 2145 12486 4913 8499 8910 12487 4913 2732 8499 12488 111 8440 8910 12489 111 2450 8440 12490 111 3289 2450 12491 2240 612 6626 12492 2240 7849 612 12493 2240 6626 7167 12494 2966 2755 6217 12495 2966 6217 5817 12496 6219 6572 3281 12497 6219 3878 6572 12498 2650 7095 3301 12499 8085 7167 1533 12500 8085 69 7079 12501 8085 7079 2732 12502 69 6322 9215 12503 69 9215 7079 12504 8222 4713 4759 12505 3595 7989 6472 12506 3595 6472 4347 12507 3595 622 7989 12508 8254 8983 8110 12509 3161 8893 2226 12510 3161 8623 4294 12511 3161 2226 8623 12512 4771 8913 296 12513 4771 296 5027 12514 1496 3293 296 12515 1496 296 8913 12516 5305 5159 8276 12517 5305 8276 8760 12518 5305 8697 5159 12519 5305 3924 8697 12520 7944 5001 1566 12521 7944 6817 5001 12522 7944 1566 4487 12523 3153 5001 4827 12524 3153 4827 8309 12525 3153 8309 1566 12526 3153 1566 5001 12527 558 4307 5574 12528 558 5574 7442 12529 558 7442 2331 12530 2462 2508 939 12531 2462 939 3384 12532 6591 9061 9785 12533 5295 8661 2960 12534 3359 9740 10002 12535 7777 622 8110 12536 7777 8110 8983 12537 9742 1836 1953 12538 510 2681 1705 12539 9607 7955 9039 12540 7733 9119 9882 12541 3223 5959 3556 12542 3223 3556 77 12543 6126 1429 7428 12544 6126 7428 8654 12545 7348 8954 6114 12546 934 1979 4294 12547 934 4294 5593 12548 934 5593 1979 12549 7428 1429 268 12550 7428 268 9915 12551 993 735 7314 12552 5726 9239 447 12553 8139 1682 198 12554 8139 8082 1682 12555 9239 1800 6923 12556 9239 7672 1800 12557 6260 1442 2681 12558 6260 5617 1442 12559 3773 949 4017 12560 3773 194 949 12561 1364 8049 8238 12562 6226 9119 9116 12563 6226 7755 3136 12564 6226 3136 7447 12565 9316 920 4916 12566 9316 3403 9583 12567 9316 4916 3403 12568 9558 9583 3403 12569 9558 3403 9422 12570 1724 546 8646 12571 1724 8285 546 12572 407 7852 4035 12573 9263 7613 7852 12574 7904 5986 1301 12575 7904 9772 5986 12576 7904 1301 5736 12577 7904 5736 3123 12578 7904 3123 9772 12579 5736 1301 5986 12580 5736 5986 662 12581 5736 4244 3123 12582 8496 5119 154 12583 8496 154 7442 12584 9861 741 1960 12585 307 7530 9915 12586 307 5293 7530 12587 7530 7065 481 12588 7065 4412 481 12589 4376 2969 1790 12590 4376 1694 2969 12591 4376 1790 7481 12592 9885 9542 5986 12593 9885 5986 9772 12594 3792 6196 5764 12595 3792 9085 4960 12596 3792 8285 9085 12597 3792 5764 8285 12598 4960 9085 3858 12599 4960 3858 6943 12600 5522 9825 9027 12601 5522 9027 3346 12602 5522 3346 104 12603 3858 999 6943 12604 6259 3971 9153 12605 6259 5773 3971 12606 6259 6474 422 12607 6259 9153 6474 12608 6259 422 999 12609 6259 999 5773 12610 422 900 999 12611 9685 855 6599 12612 9685 6599 7420 12613 7113 4739 7207 12614 7113 7207 944 12615 7113 944 3840 12616 7113 3840 3573 12617 7113 3573 4739 12618 4749 2411 5685 12619 4749 4595 2411 12620 4749 5685 8978 12621 4749 9164 4595 12622 7608 8628 7565 12623 7608 7565 4460 12624 6756 5214 8628 12625 6756 3604 5214 12626 6756 8628 1546 12627 6756 1546 6732 12628 6756 6732 2125 12629 6756 2125 3604 12630 8081 5825 5566 12631 8081 5566 3427 12632 8697 5233 5159 12633 2007 3902 5233 12634 2007 6671 6106 12635 1951 4856 9880 12636 1951 1353 4856 12637 1951 9880 9896 12638 1951 9896 829 12639 1951 829 1353 12640 4457 5170 6044 12641 4457 6044 8316 12642 4457 8316 5487 12643 4457 3408 5170 12644 4457 949 3408 12645 4457 5617 4017 12646 4457 4017 949 12647 1442 1705 2681 12648 1442 7444 1705 12649 1442 5617 7444 12650 6923 1800 6530 12651 470 6530 1605 12652 5101 343 3759 12653 8520 9963 6793 12654 6034 8646 2393 12655 8646 546 9963 12656 8646 9963 2393 12657 1041 708 3629 12658 18 477 708 12659 9242 914 8209 12660 9242 8209 4211 12661 9242 4211 3987 12662 8209 3759 8113 12663 8209 4275 4211 12664 8209 595 4275 12665 3329 4852 9182 12666 6938 4275 8623 12667 5962 728 1161 12668 5962 624 728 12669 5962 8590 624 12670 5962 1161 1720 12671 1954 1593 8590 12672 1954 1138 1593 12673 6365 9519 5495 12674 6365 1251 9330 12675 6365 9330 6095 12676 6365 6095 9519 12677 6195 6634 3243 12678 6195 3243 7173 12679 6174 5001 276 12680 6174 4827 5001 12681 6174 276 5211 12682 4096 9519 1058 12683 4096 1058 7474 12684 4096 7474 8024 12685 4096 8024 5495 12686 4096 5495 9519 12687 2668 5495 8024 12688 7024 2039 7347 12689 7024 7196 2039 12690 7024 1058 5231 12691 7024 5231 7196 12692 7024 7347 1058 12693 6717 5233 3343 12694 6717 4133 5233 12695 2266 8978 5685 12696 2266 9744 8978 12697 2266 9951 9744 12698 2266 5685 9951 12699 8459 2711 3167 12700 8459 3167 4801 12701 8459 4503 2711 12702 8459 603 4503 12703 8459 4801 603 12704 7495 3167 2711 12705 9059 8978 215 12706 9059 215 4403 12707 9059 4403 5709 12708 2889 4144 4544 12709 3545 1281 7420 12710 3545 7420 6599 12711 395 1997 3227 12712 395 3227 724 12713 395 724 4180 12714 395 4180 5500 12715 395 5500 1997 12716 4656 7374 6355 12717 6736 6464 4140 12718 6736 2970 6464 12719 8396 3235 369 12720 8396 369 3029 12721 8396 6891 3235 12722 8396 6596 6891 12723 8396 9256 1912 12724 8396 1912 7793 12725 8396 7793 8561 12726 8396 3029 9256 12727 8396 8561 6596 12728 946 8699 1304 12729 946 1304 3746 12730 946 5431 381 12731 946 3746 5431 12732 9645 2241 8551 12733 9645 2667 2241 12734 925 3527 4912 12735 2274 5338 7258 12736 2274 7258 6753 12737 2274 6753 6248 12738 3932 8671 7083 12739 619 5203 440 12740 619 301 3640 12741 619 3640 5203 12742 1018 2027 6374 12743 1018 9117 2027 12744 1018 3697 9117 12745 601 6850 3006 12746 601 3006 1853 12747 601 7331 6850 12748 601 1853 7331 12749 66 209 4637 12750 4834 4469 7933 12751 4834 7933 7645 12752 4834 8706 8035 12753 4834 8035 4469 12754 4834 7645 8706 12755 5848 7774 2976 12756 5848 2976 7716 12757 5848 1202 7774 12758 8093 1892 5828 12759 8093 5828 8359 12760 8093 6687 1892 12761 2976 7774 2192 12762 2976 2192 3721 12763 2976 3721 256 12764 2976 256 7716 12765 2509 1498 2192 12766 2509 2675 1498 12767 2509 7774 250 12768 2509 2192 7774 12769 2509 250 7248 12770 2509 7248 2675 12771 3910 6627 6330 12772 3910 6330 1935 12773 3910 8171 3508 12774 3910 1935 8171 12775 3910 3508 3940 12776 3910 3940 7842 12777 3910 7842 1115 12778 3910 1115 6627 12779 2471 6330 6627 12780 2471 6627 2413 12781 2471 2413 4393 12782 2471 4393 7647 12783 2471 7647 2420 12784 2471 2420 2764 12785 2471 2764 6330 12786 2605 2918 2662 12787 2605 8184 2918 12788 2605 2662 9390 12789 2605 9390 8184 12790 4600 9390 2662 12791 4600 62 9390 12792 4600 9040 62 12793 7635 9986 9730 12794 8879 7586 2578 12795 8879 2578 9220 12796 8879 8766 2937 12797 8879 9220 7910 12798 1196 8914 7496 12799 1196 9889 8914 12800 6099 7450 3855 12801 6099 8914 7450 12802 6099 7496 8914 12803 6099 6917 5003 12804 6099 5003 7496 12805 6099 3855 6917 12806 7660 2082 7910 12807 7660 7910 7450 12808 3742 4416 8940 12809 2207 8040 5003 12810 2207 5003 6917 12811 2207 6917 3027 12812 2207 3027 861 12813 2207 861 8040 12814 6945 6785 8964 12815 6945 8964 3100 12816 6945 3498 6785 12817 6945 861 3498 12818 6945 8040 861 12819 8964 6785 9801 12820 8964 9801 6069 12821 3027 6917 3855 12822 3027 3855 2418 12823 3027 5557 861 12824 3027 9551 5557 12825 3027 2418 9551 12826 7676 8141 7665 12827 7676 7056 8141 12828 7676 6197 7056 12829 4973 9472 7056 12830 4973 3572 9472 12831 4973 7056 5261 12832 7338 2937 4398 12833 7338 4398 2031 12834 9472 8141 7056 12835 1475 3985 7603 12836 1475 7603 6883 12837 1475 6883 4143 12838 4143 6883 5781 12839 4143 5781 5920 12840 2815 4419 348 12841 2815 7555 4419 12842 2815 348 2249 12843 2815 8639 7555 12844 7621 3801 9712 12845 7621 9750 3801 12846 7621 9712 8089 12847 3040 7313 8797 12848 8797 6773 1513 12849 8797 9324 6773 12850 8797 7313 9324 12851 3228 1334 6684 12852 3228 5926 1334 12853 9240 6684 584 12854 9240 584 7886 12855 8194 3801 3371 12856 8194 3371 1983 12857 8194 9712 3801 12858 7125 4967 9405 12859 4064 9285 6619 12860 4064 5093 9285 12861 4064 10001 5093 12862 4064 9405 10001 12863 6619 5356 6659 12864 6619 6659 3809 12865 6619 9285 5356 12866 4880 771 1278 12867 4880 9510 771 12868 4880 7292 9510 12869 6076 9508 349 12870 6076 349 1178 12871 6076 1178 4201 12872 6076 4201 9751 12873 2877 10001 1983 12874 5298 1052 6283 12875 5298 6283 5093 12876 5298 3893 1052 12877 2216 8361 1376 12878 2216 1079 8361 12879 2216 5512 1079 12880 2616 381 5431 12881 2616 8880 381 12882 2616 8940 1554 12883 5071 7132 2612 12884 5071 4923 7132 12885 5871 4962 3860 12886 5871 4888 4962 12887 5871 3860 2029 12888 5871 2029 4888 12889 2771 5647 5136 12890 1418 4813 275 12891 3468 4188 8945 12892 3468 5466 1235 12893 3468 1235 4188 12894 1903 9601 3836 12895 1903 4286 9601 12896 1903 6023 7452 12897 1903 7452 4286 12898 8894 7183 8484 12899 8894 3494 8845 12900 8894 8845 7183 12901 7028 8484 7183 12902 7028 6185 8484 12903 7028 7776 6185 12904 7028 1472 4009 12905 7028 7183 1472 12906 7028 4009 7776 12907 7339 4009 1671 12908 7339 1671 310 12909 5129 5814 9940 12910 5129 2094 5814 12911 3085 3063 4317 12912 3085 4317 1909 12913 3085 9170 3063 12914 3085 1909 2262 12915 9939 3341 7003 12916 9939 7003 8469 12917 9939 8469 3531 12918 9939 2309 6414 12919 9939 6414 3341 12920 9939 3531 2309 12921 9483 4797 3693 12922 1521 5900 7692 12923 1855 7287 9150 12924 1855 9150 568 12925 1855 568 4470 12926 1855 4588 614 12927 1855 4470 4588 12928 614 4588 818 12929 9588 3269 8118 12930 4621 6843 6502 12931 4621 6502 8655 12932 4621 8655 1624 12933 4621 1624 1393 12934 81 5310 6510 12935 81 6510 4795 12936 81 5083 5310 12937 5704 1324 5372 12938 5704 5372 1276 12939 8244 6032 1324 12940 5372 8164 5007 12941 5372 1324 8164 12942 5372 5007 1276 12943 8164 2495 3291 12944 8164 3291 5007 12945 8164 2198 2495 12946 3663 5310 8275 12947 3073 5314 358 12948 4388 1901 6912 12949 462 7700 9630 12950 462 5760 1708 12951 462 2492 5760 12952 462 8367 7700 12953 3772 1634 8565 12954 4333 3688 1578 12955 4333 7591 3688 12956 4333 1578 9753 12957 4333 9753 7719 12958 7650 7206 8722 12959 7650 1877 7206 12960 7650 4854 8514 12961 7650 8514 3263 12962 7650 8722 4854 12963 7650 9216 2290 12964 7650 2290 1877 12965 7650 6071 2811 12966 7650 2811 9216 12967 7650 3263 6071 12968 9127 3402 6598 12969 7492 5262 8130 12970 5086 6867 6710 12971 5086 3658 6867 12972 5086 6710 7497 12973 4037 6859 6545 12974 4037 5098 6859 12975 4037 2277 5098 12976 6942 8947 1634 12977 6942 6859 8947 12978 6942 6545 6859 12979 6942 1634 6545 12980 1069 7490 6859 12981 8947 7490 4571 12982 8947 4571 1634 12983 8947 6859 7490 12984 2583 6598 5002 12985 2583 2795 2130 12986 6755 6685 691 12987 6755 9046 6685 12988 6755 1558 9046 12989 9764 9805 9190 12990 9509 1870 5164 12991 1467 3066 5517 12992 1467 3434 3066 12993 1467 7902 3434 12994 5396 3458 8922 12995 5396 8922 5971 12996 5396 997 4644 12997 5396 5971 3261 12998 5396 3261 997 12999 5315 7295 5975 13000 5315 5975 8925 13001 7843 1523 3626 13002 1859 1523 3889 13003 1019 5164 7240 13004 5521 8746 9395 13005 5521 9395 2922 13006 5521 2922 8149 13007 5047 8939 7711 13008 5047 7711 3755 13009 5047 5857 8939 13010 7711 8939 9991 13011 7711 9991 4427 13012 7711 4427 2091 13013 7711 2091 3755 13014 4252 7979 5779 13015 4252 5779 2261 13016 4252 6157 852 13017 4252 852 7979 13018 4252 2261 6157 13019 6116 334 7153 13020 6116 7153 2625 13021 6029 8281 670 13022 6029 1660 8281 13023 6029 1241 1660 13024 7751 9047 7747 13025 9797 8514 4854 13026 9797 8260 8514 13027 9797 5539 8260 13028 9797 9819 5539 13029 9797 4854 9819 13030 9108 3249 5539 13031 7685 670 8223 13032 7685 8223 8708 13033 7685 8708 3249 13034 7685 7144 670 13035 1491 8922 3458 13036 5975 7295 7828 13037 5975 7828 4924 13038 4774 5971 3401 13039 8076 8515 4112 13040 6926 2498 742 13041 6926 8949 2498 13042 5444 1916 7349 13043 5444 1468 1916 13044 5444 7349 4717 13045 1916 742 7349 13046 9686 5271 4963 13047 9686 4963 3174 13048 9686 6285 5271 13049 9686 1468 6798 13050 9686 6798 6285 13051 4963 5271 5462 13052 4963 5462 238 13053 4963 7270 3174 13054 4963 238 7270 13055 3472 829 4022 13056 3472 7813 829 13057 5459 4823 3606 13058 5459 6110 4823 13059 235 522 5384 13060 522 9659 5384 13061 522 6465 9659 13062 2383 7447 3136 13063 2383 9659 7447 13064 2383 3136 3121 13065 9610 7541 6617 13066 9610 6617 7036 13067 900 483 999 13068 900 1180 483 13069 900 7784 1180 13070 3575 9019 3756 13071 3575 3756 779 13072 2093 4742 4535 13073 2093 1602 4742 13074 1059 8780 1322 13075 1059 6155 8780 13076 1059 6284 6155 13077 1059 8593 8135 13078 1059 1322 8593 13079 1059 8135 6284 13080 3997 1348 8556 13081 3997 8556 3156 13082 3997 3156 5700 13083 3997 5700 3526 13084 6497 8556 1348 13085 6497 1348 5667 13086 6497 5667 1094 13087 6497 1094 9776 13088 6497 9776 8556 13089 639 9795 1728 13090 639 1728 2620 13091 7319 5054 9795 13092 7186 557 9218 13093 7186 6388 557 13094 8466 2445 241 13095 8466 9964 2445 13096 6512 4344 4846 13097 4284 808 9520 13098 4284 9520 6021 13099 4284 4764 808 13100 963 2231 1122 13101 963 1122 8231 13102 1754 1471 452 13103 1754 8453 1471 13104 1754 9761 9528 13105 1754 452 9761 13106 1754 9528 8453 13107 980 2040 4964 13108 980 7205 2040 13109 980 433 7205 13110 980 2295 433 13111 980 4964 2295 13112 433 9562 7205 13113 9474 5097 9615 13114 9474 9615 9627 13115 9474 5666 5196 13116 9474 9627 5666 13117 9474 5196 5097 13118 2434 744 740 13119 279 5165 97 13120 279 97 2925 13121 2055 8121 2305 13122 2055 2305 1065 13123 2055 9534 8121 13124 2055 3405 9534 13125 2055 3751 3405 13126 2055 1065 3751 13127 5542 9944 970 13128 5542 970 658 13129 5542 8679 9944 13130 5612 6488 9553 13131 5612 6653 6488 13132 7748 2255 8679 13133 7748 3400 2255 13134 6803 4735 1946 13135 4016 6294 7521 13136 4016 7521 2490 13137 4016 8705 6294 13138 4016 147 8705 13139 4645 6824 5783 13140 6294 8705 6927 13141 8261 887 8127 13142 8261 9850 887 13143 8261 5114 9850 13144 8261 8127 3128 13145 5114 1199 9850 13146 2964 8127 7210 13147 2964 3128 8127 13148 2964 7210 820 13149 2964 820 830 13150 3890 4869 637 13151 1118 4502 952 13152 1118 7644 4502 13153 1118 2397 7644 13154 1118 952 4900 13155 1118 4900 2397 13156 664 4002 3375 13157 664 3375 4889 13158 664 4889 7404 13159 5508 9737 3730 13160 5508 3730 4299 13161 5508 4900 8698 13162 5508 4299 4900 13163 5508 8698 1690 13164 5508 1690 5686 13165 5508 1354 9737 13166 5508 5686 1354 13167 9418 4878 5151 13168 9418 4502 4878 13169 9418 1690 952 13170 9418 952 4502 13171 3004 7707 2308 13172 3004 2308 6544 13173 3004 323 7707 13174 3004 3336 323 13175 9925 8635 3941 13176 9925 3941 8053 13177 887 1733 3300 13178 887 9802 1733 13179 887 5677 213 13180 887 3300 5677 13181 887 519 8127 13182 887 213 519 13183 887 9850 9802 13184 2386 8329 7987 13185 8696 5943 5783 13186 8696 4937 5943 13187 8696 5783 6824 13188 2136 970 2308 13189 2136 7707 6863 13190 2136 2308 7707 13191 6946 6544 2308 13192 6946 8635 6544 13193 6946 2308 970 13194 6946 970 9944 13195 6863 7707 9974 13196 6863 8329 1321 13197 2891 2717 2305 13198 6480 7883 7199 13199 8585 7199 8013 13200 8585 8013 8067 13201 1220 4732 7340 13202 1220 7340 2611 13203 2660 3925 7395 13204 2660 5734 3925 13205 2660 1616 5734 13206 2660 7883 2868 13207 2660 7395 7883 13208 2660 2868 3737 13209 2660 4455 3125 13210 2660 7369 4455 13211 2660 3125 1616 13212 2660 3737 7369 13213 655 6211 3969 13214 655 3969 7946 13215 655 5677 6211 13216 655 7946 5677 13217 7210 4344 2604 13218 7210 213 4344 13219 5865 3800 2792 13220 5865 6467 3800 13221 5865 9365 6467 13222 5865 8314 4887 13223 5865 4887 9365 13224 5865 2792 8314 13225 3496 1450 9817 13226 2734 6847 3259 13227 2734 8632 6847 13228 2734 3259 1967 13229 1563 975 1967 13230 1563 9468 975 13231 3247 9817 7486 13232 3247 3259 6847 13233 3769 1497 2600 13234 3769 2804 1497 13235 6482 23 1450 13236 6482 2600 1497 13237 6482 1497 4921 13238 2001 2900 5864 13239 718 6796 7986 13240 718 502 6796 13241 718 7986 8126 13242 718 8126 502 13243 1839 7928 6421 13244 1839 6421 6357 13245 1839 4667 7928 13246 4606 1599 6421 13247 4606 6421 7928 13248 4606 740 1599 13249 4606 4667 5470 13250 4606 7928 4667 13251 4606 5470 5664 13252 4606 5664 740 13253 2958 8431 7299 13254 2958 6584 8431 13255 2958 8132 6584 13256 2958 6893 5470 13257 2958 7299 6893 13258 2958 5470 8995 13259 2958 8995 8132 13260 6421 1599 1696 13261 6421 1696 871 13262 6421 871 6357 13263 3282 1795 6516 13264 5247 871 1696 13265 5247 8996 871 13266 5247 1696 744 13267 5247 7507 8996 13268 9042 9890 5936 13269 9042 7170 9890 13270 9423 7036 5393 13271 9423 5393 355 13272 9423 4193 7036 13273 9423 5200 4193 13274 9423 355 7170 13275 1666 6411 9224 13276 7638 4890 717 13277 7638 717 1577 13278 7638 5936 5365 13279 7638 290 5936 13280 7638 1577 290 13281 1239 1367 7393 13282 6132 3847 6305 13283 6132 6305 3543 13284 1102 8354 5245 13285 4715 6123 1755 13286 5451 5245 5673 13287 5451 2 5245 13288 5451 5673 902 13289 5451 2067 4626 13290 5451 6841 2 13291 5690 902 5673 13292 5690 5673 6320 13293 5690 6305 313 13294 5690 313 902 13295 5690 6320 9783 13296 3628 901 3738 13297 957 2620 1946 13298 5941 6841 5376 13299 5941 5376 3675 13300 3374 9359 9586 13301 3374 4193 9359 13302 3374 2291 8746 13303 2291 5286 9395 13304 2291 9395 8746 13305 5383 5319 3673 13306 5383 3673 7422 13307 5383 5327 449 13308 5383 449 5319 13309 5383 7422 1590 13310 5383 1590 5327 13311 4230 691 6685 13312 4230 6685 817 13313 7142 8231 3388 13314 7142 5834 8231 13315 7142 3388 6771 13316 7142 6771 9243 13317 7142 9243 5834 13318 3375 4002 827 13319 3375 827 7572 13320 46 4729 981 13321 46 835 4729 13322 46 3892 835 13323 46 827 3892 13324 2217 7445 981 13325 2217 981 4729 13326 2217 4729 820 13327 4729 7000 830 13328 4729 835 7000 13329 4729 830 820 13330 6629 557 7719 13331 6629 7719 4800 13332 6629 4800 9218 13333 6629 9218 557 13334 1938 1645 1835 13335 1938 340 1645 13336 1938 9763 9888 13337 1938 9888 340 13338 1938 3049 9763 13339 1938 1835 3049 13340 1503 9763 9676 13341 1503 9888 9763 13342 3049 9676 9763 13343 5893 4915 9752 13344 5893 1713 4915 13345 5893 4800 1713 13346 4915 9511 4764 13347 4915 1578 9511 13348 4915 1713 1578 13349 9433 1350 4948 13350 9433 3694 1350 13351 9433 4948 3197 13352 9433 3197 3938 13353 9433 3938 3694 13354 9818 7512 8786 13355 9818 7099 7512 13356 9818 8017 6539 13357 9818 8786 8017 13358 9818 1253 5238 13359 9818 5238 7099 13360 9818 6539 9675 13361 5477 7124 3559 13362 2342 1462 6234 13363 2342 6234 3824 13364 3265 3824 6234 13365 3265 6940 7124 13366 9144 4110 3542 13367 9144 1972 4110 13368 9144 2119 6416 13369 9144 3542 2119 13370 6416 2119 5342 13371 2685 4738 8383 13372 2685 8383 1160 13373 2685 1160 5672 13374 2685 4775 4831 13375 2685 4831 4738 13376 2685 5672 4775 13377 2028 4001 9642 13378 2028 168 4001 13379 2028 5672 1160 13380 2028 1160 168 13381 7564 52 8961 13382 6280 4047 7247 13383 6280 7247 3050 13384 6280 6769 4047 13385 6280 7785 6769 13386 444 5833 5111 13387 444 5111 6799 13388 444 6799 2932 13389 3786 119 5586 13390 3786 5518 119 13391 3786 5940 5518 13392 3786 3827 5940 13393 5452 8495 5636 13394 5996 4922 1947 13395 1145 2729 6806 13396 575 654 4962 13397 575 4962 5489 13398 575 5489 2081 13399 575 2081 4363 13400 575 4363 8057 13401 281 6806 4141 13402 3627 8609 1252 13403 3627 1252 6622 13404 3627 6997 566 13405 6997 9491 5897 13406 1103 3219 9387 13407 1103 7315 3219 13408 1103 1094 7315 13409 3856 8356 9424 13410 3856 6663 8356 13411 3856 1747 6663 13412 8356 8046 9424 13413 8814 5020 82 13414 8814 2204 5020 13415 8814 8851 2204 13416 8046 9429 1697 13417 8046 8028 9429 13418 5218 4429 754 13419 5218 345 4429 13420 6164 4560 7548 13421 6164 4214 4560 13422 6164 3216 4214 13423 6018 3641 7062 13424 6018 7062 2752 13425 7267 4941 6695 13426 2094 913 6086 13427 2094 6086 5814 13428 2094 9051 913 13429 9940 5814 7194 13430 6086 913 1247 13431 6086 1247 8695 13432 6086 7194 5814 13433 6086 8695 7194 13434 2774 6807 6500 13435 7070 1242 6807 13436 7070 4584 1242 13437 7070 9918 4584 13438 2162 959 8695 13439 2162 7475 959 13440 2162 8695 3074 13441 1242 2535 9149 13442 1242 9149 4752 13443 1242 7419 2535 13444 1242 4584 7419 13445 5455 9905 9111 13446 5455 786 9905 13447 5455 9111 8313 13448 5455 435 3619 13449 5455 3619 786 13450 5455 8313 435 13451 3925 8106 7395 13452 3925 8448 8106 13453 3925 5734 8448 13454 3619 8448 786 13455 9591 2385 2892 13456 9591 2892 5359 13457 9591 5359 6213 13458 9591 6213 5486 13459 1941 2926 773 13460 1941 2575 2926 13461 2284 6331 6024 13462 2284 6948 6331 13463 2284 55 6948 13464 9120 1944 55 13465 9120 1318 1944 13466 8857 7693 3405 13467 68 3751 1065 13468 2224 9534 7693 13469 6113 9361 387 13470 6113 387 2792 13471 6113 2792 3800 13472 6113 3800 7756 13473 498 6008 9886 13474 498 9886 1676 13475 1142 8450 3897 13476 1142 300 8450 13477 1022 3728 2520 13478 1022 5645 3728 13479 9130 5137 2042 13480 9130 6062 5137 13481 9130 3728 3210 13482 9130 3210 6062 13483 9130 2520 3728 13484 9130 2042 2520 13485 2172 3395 4828 13486 7322 146 4171 13487 7322 5266 146 13488 7322 4171 2907 13489 7322 2907 5266 13490 892 7666 3395 13491 892 2543 7666 13492 892 4879 146 13493 892 146 1888 13494 892 1888 2543 13495 892 2672 4879 13496 9090 1493 9095 13497 5039 1427 7960 13498 5039 7960 3711 13499 5039 3711 43 13500 5039 705 9517 13501 5039 9517 1427 13502 5039 4205 705 13503 5039 43 4205 13504 4055 7922 1797 13505 4055 7977 7922 13506 1621 6005 1426 13507 9973 1676 1512 13508 9973 1512 1045 13509 9973 8723 1400 13510 9973 1400 3052 13511 9973 3052 1676 13512 9973 1045 8723 13513 1400 8723 9136 13514 2525 4145 4855 13515 9266 2070 9658 13516 9266 9658 4145 13517 7816 456 6276 13518 6481 4266 3884 13519 6481 134 5240 13520 1861 8257 647 13521 1861 2806 8257 13522 1861 647 2223 13523 1861 2223 1843 13524 1861 1843 2806 13525 3884 4539 796 13526 3884 796 1461 13527 3884 4266 4539 13528 1075 2805 6038 13529 1075 6038 6862 13530 1075 6862 5240 13531 1075 5240 2805 13532 9091 1409 4751 13533 8775 383 1615 13534 8775 1176 383 13535 8775 2990 2362 13536 8775 2362 443 13537 8775 443 1176 13538 8173 3933 6903 13539 8173 652 3933 13540 8173 9952 2344 13541 8173 2344 2124 13542 8173 2124 652 13543 3933 652 4122 13544 8438 3816 327 13545 8438 4786 3816 13546 8438 3224 4786 13547 8438 9793 3224 13548 5681 512 4767 13549 7372 327 9234 13550 6602 6651 2238 13551 6602 2238 2990 13552 6602 5870 6651 13553 2238 651 2912 13554 2238 2912 2362 13555 2238 2362 2990 13556 3224 4073 4786 13557 3224 2912 9683 13558 3224 9793 2912 13559 626 6940 814 13560 626 814 879 13561 9683 2912 651 13562 15 4786 7001 13563 15 7740 4786 13564 15 7001 2517 13565 4352 4074 7436 13566 4352 2517 1329 13567 4352 7436 8677 13568 4076 6268 9052 13569 976 9294 5826 13570 976 3445 9294 13571 976 4292 3445 13572 976 1567 4292 13573 6887 1401 9063 13574 6887 9063 1966 13575 6887 1966 8728 13576 4026 7232 9946 13577 4026 9946 1352 13578 4026 3280 7232 13579 7165 1764 4356 13580 7165 4471 1764 13581 1990 2124 2344 13582 8505 10000 3262 13583 8505 5577 10000 13584 8505 3262 5008 13585 8505 5008 885 13586 7233 6417 3262 13587 7233 4767 9296 13588 7233 3262 10000 13589 7233 10000 4767 13590 9201 3013 5008 13591 9201 5008 3262 13592 9201 3262 2514 13593 9201 2514 693 13594 2514 3262 6417 13595 7034 2709 3500 13596 7034 3500 1435 13597 3696 5008 3013 13598 3696 3013 1379 13599 1294 1254 8988 13600 1294 9296 1254 13601 8988 1254 512 13602 9826 50 9518 13603 9826 9518 2588 13604 9826 2588 9575 13605 6508 1659 4322 13606 1659 73 965 13607 1659 965 8475 13608 1659 4432 73 13609 1659 7905 4322 13610 1659 8475 7905 13611 3771 1024 9596 13612 3771 9596 942 13613 3771 4322 7905 13614 3771 7905 1024 13615 6872 3031 1701 13616 6872 4109 3031 13617 6872 1701 1404 13618 8109 2148 7993 13619 7874 1427 8836 13620 7874 8836 6781 13621 2837 685 608 13622 489 6631 2550 13623 178 685 7076 13624 178 7076 8031 13625 178 608 685 13626 1840 7076 685 13627 3687 9660 1625 13628 7451 3044 7539 13629 7325 5669 3539 13630 4164 1780 3269 13631 4164 3269 1907 13632 4164 8504 1780 13633 4579 8118 3269 13634 4579 1780 8504 13635 4579 8504 8118 13636 4406 3712 409 13637 4406 409 1788 13638 4406 1339 3712 13639 4406 4049 7562 13640 4406 1788 4049 13641 4406 3252 4426 13642 4406 4426 2264 13643 4406 7562 3252 13644 4406 2264 3180 13645 4406 3180 1339 13646 6001 7924 3067 13647 6001 7504 7924 13648 6001 837 7504 13649 1422 1562 2195 13650 1422 2195 4961 13651 1422 1944 1562 13652 1422 4961 837 13653 6327 5278 9981 13654 8025 6063 3990 13655 8025 3990 1673 13656 8025 1673 2644 13657 8025 1005 4672 13658 8025 2644 1005 13659 8025 4672 6063 13660 9791 150 9232 13661 9791 6509 150 13662 9791 4672 6509 13663 9791 6063 4672 13664 9791 9232 6063 13665 6747 7134 3347 13666 6747 6107 7134 13667 4700 2669 9828 13668 4700 9828 3782 13669 4700 3347 550 13670 4700 550 2669 13671 4700 9072 3347 13672 4700 3782 9072 13673 3276 679 8010 13674 3276 1333 679 13675 3206 1687 8311 13676 3206 1044 1687 13677 9137 4437 3203 13678 9137 8526 4437 13679 9137 3007 679 13680 9137 679 8526 13681 5584 8965 679 13682 5584 679 3007 13683 5584 2855 8965 13684 4205 4280 705 13685 4205 43 3634 13686 4205 3634 4280 13687 922 6882 3203 13688 922 1557 6882 13689 922 3203 1701 13690 922 6781 1557 13691 4305 5059 9580 13692 9572 4565 8545 13693 2033 4718 1848 13694 2033 1848 5059 13695 1848 4718 2145 13696 1848 2145 8440 13697 1848 9580 5059 13698 1848 8440 9580 13699 4662 1838 7067 13700 4662 3894 1838 13701 3894 8357 6730 13702 3894 6730 3289 13703 94 634 7067 13704 94 3779 634 13705 94 1923 3779 13706 2208 2347 9621 13707 2208 9621 8866 13708 2208 1923 5843 13709 2208 8866 1923 13710 2208 2772 2347 13711 2208 5843 2772 13712 8499 7079 2772 13713 8499 2732 7079 13714 2772 7079 2347 13715 336 8519 898 13716 336 8993 8519 13717 8400 898 240 13718 8400 4766 6160 13719 8400 6572 3878 13720 8400 5605 6572 13721 8400 3878 4766 13722 8400 3017 5605 13723 8400 240 3017 13724 6626 1533 7167 13725 2755 666 6217 13726 2755 4666 666 13727 6322 6561 4395 13728 6322 4395 9215 13729 4713 5555 4759 13730 4713 2505 5555 13731 6572 5605 3281 13732 7514 598 2695 13733 7514 2695 1182 13734 7514 1182 4895 13735 7514 4895 3954 13736 7514 5478 598 13737 7514 3954 7849 13738 7514 5817 5478 13739 6472 7989 4113 13740 6472 4113 836 13741 6472 5367 4347 13742 6472 836 5367 13743 7932 7989 622 13744 7932 4113 7989 13745 1929 450 3714 13746 1929 5793 5027 13747 1929 5027 296 13748 1929 296 3293 13749 1929 3714 5793 13750 1406 2430 4439 13751 1406 5793 2430 13752 1406 4439 6935 13753 5001 6817 276 13754 8309 7173 3243 13755 2960 8661 735 13756 3250 2694 8672 13757 5959 4423 3556 13758 6163 8661 4423 13759 4294 8623 5593 13760 517 9545 5773 13761 5187 1120 5482 13762 5187 5482 5578 13763 5482 1120 3163 13764 4372 8321 1790 13765 4372 1790 2969 13766 7481 1790 2899 13767 3589 2899 683 13768 9542 662 5986 13769 1650 9609 7781 13770 1650 7781 7005 13771 1650 713 9609 13772 1650 6793 713 13773 6473 4309 104 13774 6473 104 6613 13775 6473 1791 4309 13776 6473 6613 1791 13777 9049 4053 6196 13778 9049 2807 4053 13779 8285 5764 546 13780 859 9027 3461 13781 859 6670 9027 13782 859 1180 7784 13783 859 7784 6670 13784 859 3461 1180 13785 9825 3461 9027 13786 9825 483 3461 13787 999 483 6943 13788 483 1180 3461 13789 9153 2171 7320 13790 9153 3971 2171 13791 9153 7320 6474 13792 3840 8270 3573 13793 4739 9879 7207 13794 9164 8270 4914 13795 9164 4914 4595 13796 9164 3573 8270 13797 4319 2128 5316 13798 8628 5214 4223 13799 8628 4223 9539 13800 8628 9539 7565 13801 7565 9539 6723 13802 7565 4914 4460 13803 7565 5006 4914 13804 7565 6723 5006 13805 7432 8446 8191 13806 7432 4914 8446 13807 7432 8191 9138 13808 7432 9138 4460 13809 7432 4460 4914 13810 1131 9138 8191 13811 1131 8191 8270 13812 1131 6313 4460 13813 1131 4460 9138 13814 1131 2980 6313 13815 7361 1917 108 13816 7361 108 5374 13817 7361 9330 1917 13818 7361 5374 1971 13819 7361 1971 2086 13820 7361 2086 9330 13821 5159 5233 8276 13822 3902 3343 5233 13823 2415 4675 0 13824 2415 4924 4675 13825 8604 7925 8168 13826 8604 8168 5567 13827 8604 5567 5064 13828 0 6410 829 13829 0 829 9896 13830 0 4675 6410 13831 0 9896 7925 13832 829 6410 4022 13833 829 3950 1353 13834 829 7813 3950 13835 9880 8168 7925 13836 9880 1090 8168 13837 9880 4856 1090 13838 9880 7925 9896 13839 1800 7672 4067 13840 343 198 3759 13841 708 477 9708 13842 708 9708 9097 13843 708 9097 3629 13844 3983 1307 2477 13845 3983 2477 7969 13846 9182 4852 9060 13847 1720 1161 9740 13848 8590 1593 84 13849 8590 84 624 13850 1251 5211 1917 13851 1251 1917 9330 13852 5211 276 108 13853 5211 108 1917 13854 8024 7474 4773 13855 8024 4773 3096 13856 1058 9519 6095 13857 1058 7347 7474 13858 3670 7651 784 13859 3670 4133 7651 13860 3670 2086 4133 13861 3670 9330 2086 13862 3670 6095 9330 13863 5592 1942 4773 13864 5592 1437 1942 13865 5592 2850 1437 13866 5592 4773 7347 13867 5592 7347 2039 13868 5592 2039 2850 13869 9744 215 8978 13870 9744 9951 215 13871 9745 715 6080 13872 9745 698 715 13873 9745 4544 698 13874 4403 4420 8337 13875 4403 215 4420 13876 4403 8337 5709 13877 4144 5709 4544 13878 4928 1147 9134 13879 4928 9134 4413 13880 4928 3227 3011 13881 4928 5261 3227 13882 4928 3011 1147 13883 4928 4413 7383 13884 4928 7383 5261 13885 4180 7155 3410 13886 4180 724 7155 13887 4180 3410 5500 13888 1997 3011 3227 13889 1997 1147 3011 13890 1997 5500 1147 13891 2727 5500 3410 13892 2727 9799 5500 13893 4140 6464 1332 13894 4140 1332 6415 13895 4140 6415 9799 13896 8561 555 6596 13897 8561 7793 555 13898 1399 5322 3615 13899 1399 3009 5322 13900 1399 7656 4536 13901 1399 4536 3009 13902 1399 5439 7656 13903 1399 3615 5439 13904 7757 6016 6462 13905 7757 2390 6016 13906 7757 6462 2390 13907 2578 7586 504 13908 2578 504 2574 13909 2578 2574 9220 13910 3746 1304 5472 13911 7160 1079 7523 13912 7160 1212 3100 13913 8551 2241 7245 13914 8551 7245 52 13915 3527 5123 4912 13916 3527 1574 5123 13917 2449 8179 8961 13918 2449 8961 2060 13919 2449 2060 4289 13920 2449 4289 8179 13921 2375 8490 9228 13922 2375 2906 8490 13923 2375 7894 3297 13924 2375 3297 180 13925 2375 9228 7894 13926 2375 180 2906 13927 7894 9228 943 13928 7894 943 4557 13929 7894 4557 4103 13930 7894 4103 3297 13931 324 2281 2485 13932 324 4754 2281 13933 324 2485 4050 13934 324 4050 9442 13935 324 9442 2322 13936 324 2322 4754 13937 4000 2485 4242 13938 4000 4242 4130 13939 4000 4050 2485 13940 4000 4130 4050 13941 9323 1286 5583 13942 9323 5583 6090 13943 9323 2133 1163 13944 9323 1163 1286 13945 9323 6090 86 13946 9323 86 9442 13947 9323 9442 2133 13948 5338 9417 3550 13949 5338 3550 7258 13950 6374 2027 2981 13951 6850 7876 9600 13952 6850 9600 8782 13953 6850 7331 7876 13954 4637 209 4418 13955 4637 4418 8889 13956 4637 8889 2235 13957 4637 2235 8659 13958 8706 8090 3833 13959 8706 3833 8035 13960 8706 7645 8090 13961 155 2048 9514 13962 155 9514 4790 13963 155 4790 2048 13964 6687 7718 1892 13965 6687 7716 7718 13966 256 1463 3339 13967 256 3339 9567 13968 256 3721 1463 13969 256 8388 7716 13970 256 9567 8388 13971 250 7774 1202 13972 250 3273 7248 13973 250 1202 3273 13974 1498 1463 2192 13975 1498 3339 1463 13976 1498 2675 3339 13977 3273 1356 7248 13978 3273 1202 9784 13979 3273 9784 1356 13980 4847 9874 2307 13981 4847 2307 4628 13982 4847 4628 9874 13983 7297 8171 3587 13984 7297 3587 2307 13985 7297 3508 8171 13986 7297 9874 3448 13987 7297 2307 9874 13988 7297 3448 3508 13989 1935 6330 8171 13990 2764 1383 9956 13991 2764 9956 3587 13992 2764 2420 1383 13993 2764 3587 8171 13994 2764 8171 6330 13995 6589 5498 7812 13996 6589 544 5498 13997 6589 2402 544 13998 6589 7812 2402 13999 7876 5498 9600 14000 7876 7331 5498 14001 5103 6235 9493 14002 5103 9493 9088 14003 5103 1320 4378 14004 5103 4378 9510 14005 5103 9510 7292 14006 5103 7292 6235 14007 5103 9088 1320 14008 6744 4967 124 14009 6744 124 3743 14010 6744 3743 7600 14011 9390 8962 8184 14012 9390 62 8962 14013 9286 2581 9986 14014 9286 1376 2581 14015 8766 4398 2937 14016 7910 3855 7450 14017 7910 7817 3855 14018 7910 4181 7817 14019 7910 9220 4181 14020 9889 7450 8914 14021 861 5557 3498 14022 7056 6197 3227 14023 7056 3227 5261 14024 2031 4398 5472 14025 2031 5472 8436 14026 7383 4413 1980 14027 7383 1980 8387 14028 3985 349 2677 14029 3985 1530 349 14030 3985 2677 7603 14031 4501 9751 4201 14032 6883 2073 5781 14033 6883 7603 2073 14034 8639 7570 7555 14035 3198 7603 2677 14036 3198 166 7603 14037 3198 8886 166 14038 3198 1745 8886 14039 9750 4596 6048 14040 9750 6765 3371 14041 9750 3371 3801 14042 6048 4596 7055 14043 5847 4380 7055 14044 9324 186 2073 14045 9324 2073 166 14046 9324 166 6773 14047 9324 7313 186 14048 1334 369 3235 14049 1334 3235 584 14050 1334 584 6684 14051 1334 5926 369 14052 8138 7886 1387 14053 2918 124 4967 14054 2918 8184 124 14055 9405 4967 10001 14056 1278 771 8232 14057 9285 6283 5356 14058 9285 5093 6283 14059 9508 2677 349 14060 1554 8940 5512 14061 4923 6885 4368 14062 4923 4368 5378 14063 4923 5378 7132 14064 2603 8199 1517 14065 2603 3256 8199 14066 2603 1517 249 14067 2603 249 3256 14068 3860 1815 2029 14069 3860 654 2788 14070 3860 2788 1815 14071 3860 4962 654 14072 4813 3079 1671 14073 4813 1671 275 14074 4813 5636 3079 14075 5466 3836 9601 14076 5466 9601 1235 14077 6023 6066 7452 14078 3940 3508 4245 14079 3940 1679 7945 14080 3940 4245 1679 14081 3940 7945 3490 14082 3940 3490 7842 14083 4080 8950 8568 14084 4080 8568 8731 14085 4080 8731 5289 14086 4080 7625 8950 14087 3494 8950 7625 14088 3494 8568 8950 14089 3494 275 8845 14090 4009 1472 8829 14091 4009 8829 1671 14092 8924 2379 2466 14093 8924 2466 9960 14094 8924 6185 7776 14095 8924 7776 2379 14096 8924 9960 6185 14097 7183 8845 1472 14098 1884 1536 8824 14099 1884 8824 4475 14100 1884 5708 1536 14101 7952 1552 6441 14102 7952 6441 3693 14103 6441 1552 5900 14104 2262 76 3341 14105 2262 9923 76 14106 2262 1909 9923 14107 2262 3341 6414 14108 9170 1824 3063 14109 7285 8140 3353 14110 7285 3353 2127 14111 7285 4072 8140 14112 7285 2127 4072 14113 7287 9928 9150 14114 6843 4046 6502 14115 6843 8123 4046 14116 9907 8140 8107 14117 9907 8107 9955 14118 9907 1920 4470 14119 9907 9955 1920 14120 9907 568 8140 14121 9907 4470 568 14122 568 9150 3897 14123 568 3897 8450 14124 568 8450 8140 14125 5977 8176 6411 14126 5977 4652 8176 14127 5977 6411 9536 14128 5977 9536 9259 14129 5083 4652 8275 14130 5083 8275 5310 14131 5760 1901 1708 14132 5760 2492 6912 14133 5760 6912 1901 14134 1276 5007 862 14135 1276 862 8303 14136 4443 6597 3192 14137 4443 6545 6597 14138 1201 9991 8939 14139 1201 4798 4466 14140 8565 1634 4571 14141 3688 9543 9511 14142 3688 9511 1578 14143 3688 7591 5869 14144 5017 7782 2290 14145 5017 3484 7782 14146 5017 2290 9216 14147 5017 9216 3484 14148 6071 2156 2811 14149 6071 3263 2156 14150 8415 192 5262 14151 8415 284 192 14152 6751 2130 9541 14153 6751 284 2130 14154 6751 9541 6707 14155 5002 6598 8399 14156 5002 8399 4373 14157 5002 4373 5222 14158 6707 9541 8844 14159 6707 8844 2795 14160 6707 2795 1793 14161 8844 9541 2130 14162 8844 2130 2795 14163 1825 9520 1793 14164 1825 1793 1558 14165 1825 691 9520 14166 2404 9520 808 14167 2404 808 9969 14168 2404 9969 9543 14169 11 4003 3727 14170 1870 2895 7240 14171 1870 7240 5164 14172 1870 5517 2895 14173 7902 4225 3434 14174 9133 1452 7779 14175 2922 9395 125 14176 2922 125 8149 14177 1488 852 6157 14178 1488 6157 2261 14179 1488 2261 9154 14180 334 9490 7153 14181 4716 4886 2562 14182 4716 9830 4886 14183 4716 2562 4478 14184 4716 4478 5779 14185 4716 5779 7979 14186 5779 4478 6383 14187 5779 2797 2261 14188 5779 6383 2797 14189 8281 8223 670 14190 8281 1660 8223 14191 8722 9819 4854 14192 5539 9280 5138 14193 5539 3249 9280 14194 5539 5138 8260 14195 297 6735 7144 14196 3401 5971 8922 14197 415 1706 1753 14198 415 1753 3888 14199 415 3505 1706 14200 415 3888 9830 14201 8142 8726 3505 14202 1706 3505 8726 14203 1706 8726 6249 14204 1706 6249 1753 14205 8416 4003 6152 14206 8416 3727 4003 14207 1468 4787 6798 14208 3174 7270 1263 14209 4572 4675 4924 14210 4572 6410 4675 14211 4572 4924 7828 14212 3121 3136 2053 14213 7541 2495 9214 14214 7541 9214 6617 14215 7541 3291 2495 14216 9370 1476 9089 14217 9370 9089 4386 14218 9370 9352 8503 14219 9370 8503 1476 14220 9370 6053 9352 14221 9370 6203 6053 14222 9370 3733 6203 14223 9370 4386 3733 14224 1636 4861 1899 14225 1636 1899 8652 14226 1636 5711 4861 14227 1636 8652 5711 14228 7784 995 6670 14229 9145 3935 8354 14230 9145 847 3561 14231 9145 3561 7629 14232 9145 7629 995 14233 9145 995 3935 14234 6129 3876 2579 14235 6129 580 3876 14236 6129 4486 2476 14237 6129 2579 4486 14238 6129 2476 580 14239 1537 2170 5265 14240 1537 2626 2170 14241 1537 7799 2626 14242 1537 4744 1179 14243 1537 5265 4744 14244 1537 1179 7799 14245 1614 1611 2157 14246 1614 143 1611 14247 1614 2157 951 14248 1614 9076 3219 14249 1614 3219 143 14250 1614 951 9076 14251 4535 4742 8453 14252 4535 8453 9019 14253 8135 4034 2999 14254 8135 8593 4034 14255 8135 7797 6284 14256 8135 2999 7797 14257 3156 448 5735 14258 3156 4185 448 14259 3156 5735 5700 14260 3156 8556 4185 14261 5667 1806 1094 14262 5667 1348 8532 14263 5667 8532 4039 14264 5667 4039 1806 14265 8556 9776 6105 14266 8556 6105 4185 14267 2398 1787 1481 14268 2398 390 1787 14269 6880 8377 5485 14270 6880 5284 8377 14271 6880 1787 5284 14272 6388 7719 557 14273 4846 4344 9964 14274 4764 9511 808 14275 808 9543 9969 14276 808 9511 9543 14277 9528 3624 8453 14278 9528 9761 3624 14279 5666 9627 5165 14280 5666 5165 4976 14281 5097 9670 9615 14282 5165 452 97 14283 5165 9627 452 14284 8121 9534 5435 14285 9553 6488 2595 14286 1060 7033 147 14287 1060 5783 7033 14288 7521 9562 2490 14289 7521 9624 9562 14290 3812 3536 92 14291 3812 830 3536 14292 3536 830 7000 14293 4900 952 8698 14294 4900 4299 2397 14295 1690 8698 952 14296 5151 9176 4793 14297 5151 4878 9176 14298 5151 4793 8341 14299 6419 8846 8679 14300 6419 8584 8846 14301 6419 2255 1199 14302 6419 1199 8584 14303 6419 8679 2255 14304 9850 1199 2255 14305 9850 2255 9802 14306 3476 658 970 14307 323 3336 9974 14308 323 9974 7707 14309 6498 3231 2063 14310 7199 7883 8013 14311 2611 9029 6511 14312 2611 4135 9029 14313 2611 2868 7883 14314 2611 6511 2868 14315 2611 7340 4135 14316 3737 2868 9388 14317 3737 9388 7369 14318 213 5677 4344 14319 6211 3300 3969 14320 6211 5677 3300 14321 8314 5907 8718 14322 8314 8718 5239 14323 8314 2792 5907 14324 8314 5239 4887 14325 9365 4887 3039 14326 9365 3039 6467 14327 5599 5680 1207 14328 5599 1207 3039 14329 5599 7846 5680 14330 5599 5116 7846 14331 5599 7021 5116 14332 5599 3039 7021 14333 6894 5484 8700 14334 6894 8700 574 14335 6894 5586 5409 14336 6894 574 5586 14337 1914 8245 6713 14338 1914 6713 1234 14339 1914 1234 4937 14340 1914 5409 8245 14341 9550 5409 5586 14342 9550 5586 119 14343 9550 8245 5409 14344 9550 119 8245 14345 2804 9918 7096 14346 2804 7096 1497 14347 4921 1497 6167 14348 4921 6167 9871 14349 4921 9871 8364 14350 23 8364 9817 14351 23 9817 1450 14352 1497 7096 6420 14353 1497 6420 6167 14354 4832 8381 8301 14355 4832 8301 5380 14356 4832 5380 5822 14357 7986 6796 5513 14358 7986 5513 4051 14359 7986 4051 5216 14360 7986 8301 8126 14361 7986 5216 8301 14362 5748 8601 3311 14363 5748 5940 8601 14364 5748 5518 5940 14365 5748 4298 119 14366 5748 119 5518 14367 5748 3311 4298 14368 6731 9229 2870 14369 6731 7590 9229 14370 6731 8995 4667 14371 6731 2870 8995 14372 5470 6893 5664 14373 5470 4667 8995 14374 6357 5087 7493 14375 6357 871 4081 14376 6357 4081 5087 14377 1795 9833 2999 14378 1795 2999 6516 14379 270 8044 9665 14380 270 9665 509 14381 4081 871 8295 14382 4081 8295 8851 14383 4081 8851 5087 14384 7507 5884 1438 14385 7507 1438 8996 14386 7507 4425 5884 14387 7507 4392 4425 14388 7170 1003 9890 14389 7170 6201 1003 14390 7170 355 6201 14391 9224 8176 358 14392 9224 358 882 14393 9224 6411 8176 14394 5055 9717 7294 14395 5055 8666 9717 14396 5055 8177 8666 14397 5055 8456 4484 14398 5055 7294 8456 14399 358 8176 3083 14400 5245 5085 5673 14401 5245 8354 5085 14402 1810 4290 6055 14403 1810 4297 4290 14404 1810 8594 4297 14405 6123 8666 8177 14406 6123 5052 8666 14407 6123 3543 6548 14408 6123 6548 5052 14409 2067 1223 4626 14410 2067 3847 1223 14411 901 4765 3738 14412 4710 4899 1272 14413 2620 1728 1946 14414 4760 3424 847 14415 2158 3730 9737 14416 2158 6432 4299 14417 2158 4299 3730 14418 2158 7293 6432 14419 8958 3938 524 14420 8958 2456 3938 14421 8958 1590 7422 14422 8958 7422 2456 14423 5327 817 449 14424 6685 9046 817 14425 437 817 9046 14426 437 449 817 14427 437 274 5319 14428 437 7538 274 14429 437 5319 449 14430 5319 1646 3673 14431 5319 274 1646 14432 3388 8231 4647 14433 3388 3089 6771 14434 8231 5834 3646 14435 8231 1122 4647 14436 827 4002 3892 14437 3892 4002 835 14438 866 835 4002 14439 866 7000 835 14440 747 7445 9218 14441 9752 3646 5834 14442 4948 5386 378 14443 4948 378 3010 14444 4948 3010 3089 14445 4948 3089 3197 14446 4948 1350 5386 14447 9675 6539 5719 14448 9675 5719 2818 14449 2818 5719 8017 14450 2818 8017 2456 14451 2818 2456 9014 14452 3139 7422 3673 14453 3139 3673 9816 14454 3139 6706 7422 14455 3139 6049 6399 14456 3139 8084 6049 14457 3139 9816 8084 14458 3139 6399 6706 14459 3517 3953 8527 14460 3517 8527 9954 14461 3517 9121 3953 14462 3517 2883 9121 14463 3517 2397 2102 14464 3517 2102 2883 14465 3517 9954 2397 14466 3481 4539 4266 14467 3524 4731 8847 14468 2119 3122 5342 14469 2119 9213 3122 14470 2119 3542 9213 14471 4110 6250 8393 14472 4110 8393 3542 14473 4110 1972 5543 14474 4110 5543 6250 14475 8190 4848 7830 14476 8190 1084 1972 14477 8190 7830 1084 14478 4775 5342 4831 14479 8383 4738 3122 14480 8383 1046 7722 14481 8383 7722 1160 14482 1046 8961 8179 14483 1046 8179 7722 14484 5460 6695 4941 14485 5460 4941 1581 14486 5460 1581 372 14487 4941 3246 1581 14488 4941 7749 3246 14489 310 3079 5636 14490 310 5636 7476 14491 310 1671 3079 14492 6769 5718 4047 14493 6769 7785 5718 14494 4520 2730 7846 14495 4520 7846 6233 14496 4520 6233 5111 14497 4520 574 2730 14498 4520 6837 5586 14499 4520 5586 574 14500 3827 509 5940 14501 2463 9910 7972 14502 2463 8057 9910 14503 8057 4363 9910 14504 6806 2729 4141 14505 8609 8159 1252 14506 8609 5818 8159 14507 5897 7371 2919 14508 5897 9491 7371 14509 2919 7371 3216 14510 7548 4560 7830 14511 7548 7830 4848 14512 6807 3074 6500 14513 6470 4210 7475 14514 6470 4752 4210 14515 8448 8067 8106 14516 8448 5734 786 14517 5851 3059 5706 14518 5851 9905 565 14519 5851 565 3059 14520 5851 9111 9905 14521 8106 8067 8013 14522 8106 8013 7395 14523 1616 786 5734 14524 1616 3125 786 14525 4028 5347 2909 14526 4028 2909 5909 14527 4028 5909 2385 14528 2195 1562 5987 14529 2195 5987 3446 14530 2195 3446 4961 14531 5347 1470 5987 14532 5347 5987 8283 14533 5347 8283 5909 14534 5347 5909 2909 14535 8792 402 1310 14536 8792 1310 3952 14537 55 1944 3150 14538 55 3150 6948 14539 9376 4411 1318 14540 9376 8289 4048 14541 6024 6920 2287 14542 6024 2287 4515 14543 6024 6331 6920 14544 6024 4515 4011 14545 6213 5359 7614 14546 6213 7614 5486 14547 7949 1428 6646 14548 7949 6646 2535 14549 7949 2535 7419 14550 7949 7419 9534 14551 7693 9534 3405 14552 961 3958 189 14553 961 189 4078 14554 961 4011 3958 14555 961 4078 4011 14556 1289 6898 8134 14557 1289 8134 2205 14558 1289 401 6898 14559 1289 2205 401 14560 4616 9457 1515 14561 4616 1515 4797 14562 3800 6467 7756 14563 9361 5822 387 14564 7257 5331 2228 14565 7257 3796 5331 14566 7257 2842 3796 14567 7257 6889 2842 14568 7257 5976 6889 14569 7257 2228 5976 14570 8170 5976 2228 14571 8170 2228 1957 14572 8170 5335 5976 14573 8170 8304 5335 14574 8170 7459 8304 14575 8170 1957 7459 14576 9886 9778 1215 14577 9886 1215 1676 14578 9886 6853 2787 14579 9886 2787 9778 14580 9886 6008 6853 14581 9620 3093 782 14582 9620 782 6323 14583 9620 4468 3093 14584 9620 6323 2770 14585 2520 2042 5980 14586 3182 7839 3896 14587 3182 2576 7839 14588 3182 4468 2576 14589 3182 6368 4468 14590 3182 3896 6368 14591 782 3093 429 14592 782 429 6919 14593 782 6919 6323 14594 3242 2042 5137 14595 3242 5137 3312 14596 3242 2828 8708 14597 3242 8708 2042 14598 3242 4199 2828 14599 3242 3312 4199 14600 2828 4199 7283 14601 2828 7283 4529 14602 2828 4529 2392 14603 2828 2392 8708 14604 7443 6079 3395 14605 7443 3395 7666 14606 7443 7666 6079 14607 4828 3395 6079 14608 4828 6079 2653 14609 4828 2653 2068 14610 4171 7540 9828 14611 4171 9828 550 14612 4171 4879 7540 14613 4171 146 4879 14614 4171 550 2907 14615 4879 2672 7540 14616 9095 9828 7540 14617 9095 8802 9828 14618 9095 1493 8802 14619 705 6842 3680 14620 705 2144 6842 14621 705 3680 7566 14622 705 7566 9517 14623 705 4280 4123 14624 705 4123 2144 14625 3172 2827 8937 14626 3172 9180 2827 14627 3172 8937 1139 14628 3172 1139 2361 14629 3172 2361 8721 14630 3172 8721 9180 14631 5428 6245 9596 14632 5428 9596 1024 14633 5428 1024 6245 14634 1797 71 7256 14635 1797 7256 3314 14636 1797 3314 8430 14637 1797 7922 71 14638 7977 4812 7922 14639 9941 6698 677 14640 9941 3314 6698 14641 9941 8430 3314 14642 9941 1426 6005 14643 9941 677 1426 14644 9941 6005 8430 14645 1426 677 9062 14646 8723 1045 9136 14647 9762 5816 2300 14648 9762 6008 5816 14649 5816 3052 2300 14650 4704 4731 2817 14651 4949 7838 4919 14652 4949 1532 7838 14653 4949 4919 7407 14654 4949 7407 1532 14655 134 2805 5240 14656 134 1288 2805 14657 134 8257 1288 14658 3715 6651 5870 14659 383 1176 9281 14660 383 9281 633 14661 4122 4968 7023 14662 4122 652 2124 14663 3654 2550 6631 14664 327 3816 9234 14665 2362 2912 9793 14666 2362 9793 9731 14667 2362 9281 443 14668 2362 9731 9281 14669 4073 7001 4786 14670 879 814 286 14671 879 286 750 14672 6268 9378 9052 14673 7740 3816 4786 14674 1329 2517 7001 14675 1567 8072 4471 14676 1567 1896 8072 14677 8728 2135 1726 14678 8728 1966 2135 14679 8728 1726 3280 14680 4019 2461 50 14681 4019 1352 2461 14682 4356 9366 9249 14683 4356 9249 5966 14684 4356 1764 9366 14685 778 3559 7124 14686 778 7124 6940 14687 9093 7112 10000 14688 50 2461 9518 14689 2709 7742 5309 14690 120 9209 3711 14691 120 605 9209 14692 120 3711 2148 14693 7993 2148 7960 14694 8031 7076 962 14695 5364 9658 2070 14696 1393 1624 7126 14697 3335 1625 857 14698 7595 6971 7838 14699 7595 9194 6971 14700 5915 1777 7552 14701 5915 5994 1777 14702 5915 9207 5994 14703 3539 5669 5377 14704 3539 5377 1104 14705 3539 1104 764 14706 5732 6439 1907 14707 5732 1907 7611 14708 5732 5669 6439 14709 5732 4500 5467 14710 5732 7611 4500 14711 5732 5467 5377 14712 5732 5377 5669 14713 7562 4049 3252 14714 837 4961 7504 14715 5278 4682 1528 14716 5278 1528 725 14717 5278 725 9981 14718 5278 9069 8900 14719 5278 8900 4682 14720 1562 1318 8283 14721 1562 1944 1318 14722 1562 8283 5987 14723 7723 1504 3067 14724 7723 4561 1504 14725 7723 459 4561 14726 1504 4561 9631 14727 3990 9232 2878 14728 3990 2878 1106 14729 3990 1106 987 14730 3990 6063 9232 14731 3990 987 1673 14732 4672 6205 4386 14733 4672 4386 6509 14734 4672 1005 1333 14735 9232 40 2878 14736 9232 150 40 14737 3347 7134 550 14738 8010 679 8965 14739 8010 8428 8052 14740 8010 8052 9503 14741 8010 9503 6205 14742 8010 8965 8428 14743 43 3711 9209 14744 43 9209 3634 14745 8836 1427 9517 14746 8836 9517 1044 14747 8836 6882 1557 14748 8836 1557 6781 14749 8836 1044 6882 14750 5646 8545 8357 14751 5646 5042 5818 14752 5646 6025 5042 14753 4565 6730 8545 14754 4565 9580 6730 14755 5701 7095 3258 14756 5701 1693 7095 14757 5701 3258 8086 14758 5701 5656 8374 14759 5701 8374 1693 14760 5701 8086 5656 14761 8374 620 1693 14762 634 3779 2967 14763 634 2967 2993 14764 634 2993 5166 14765 8426 7079 9215 14766 8426 5169 7079 14767 8426 6585 5169 14768 8426 9215 6585 14769 2347 7079 9621 14770 4156 2218 7363 14771 4156 7363 3661 14772 4156 4759 2218 14773 4156 4381 4759 14774 4156 2155 4381 14775 4156 3661 2155 14776 3258 8531 8086 14777 9385 468 2970 14778 9385 4408 468 14779 898 8519 240 14780 3017 240 2799 14781 3017 2799 1311 14782 3017 1311 5605 14783 3878 1802 4766 14784 5817 6217 666 14785 5817 666 5478 14786 3954 7158 7849 14787 3954 4895 7158 14788 5555 2218 4759 14789 5555 7363 2218 14790 5555 2505 7363 14791 6382 4428 5569 14792 6382 5569 7580 14793 6382 7580 5733 14794 6382 2505 612 14795 6382 612 7158 14796 6382 7158 4428 14797 6382 5733 2505 14798 4347 5367 8893 14799 4113 3761 9060 14800 4113 9060 9806 14801 4113 9806 836 14802 2226 8893 9308 14803 5367 9308 8893 14804 5367 836 9806 14805 4275 595 5593 14806 4275 5593 8623 14807 1979 595 8113 14808 1979 8113 2052 14809 1979 5593 595 14810 1299 5374 276 14811 1299 276 6817 14812 1299 1971 5374 14813 1299 217 1971 14814 2331 7442 154 14815 2432 9814 9061 14816 2432 8672 9814 14817 9948 9391 9992 14818 7442 5574 1606 14819 7314 735 8661 14820 8082 9422 1682 14821 5534 7294 9792 14822 5534 8784 7294 14823 3037 5773 4116 14824 3037 4116 8018 14825 3037 8018 7964 14826 3037 7964 3971 14827 3037 3971 5773 14828 9545 4116 5773 14829 9545 8875 4116 14830 7964 8018 41 14831 7964 41 9436 14832 7964 9436 3971 14833 4116 2185 41 14834 4116 8875 2185 14835 4116 41 8018 14836 1374 317 8764 14837 1374 8764 667 14838 1374 6106 5091 14839 1374 5091 317 14840 1374 667 6106 14841 3090 4412 8321 14842 8321 1556 1790 14843 2899 1790 683 14844 6793 9963 713 14845 4309 1791 5979 14846 6196 9609 5764 14847 6196 7781 9609 14848 6196 4053 7781 14849 6474 7320 9055 14850 944 7207 7078 14851 1546 140 4128 14852 1546 4128 6732 14853 5214 3604 7316 14854 5214 7316 4223 14855 6723 9539 2088 14856 6723 2088 5332 14857 6723 5332 5006 14858 2086 8276 4133 14859 2086 217 8276 14860 2086 1971 217 14861 5374 108 276 14862 5233 4133 8276 14863 5566 266 3427 14864 5064 5567 4747 14865 4787 4717 4068 14866 4787 4068 2773 14867 4787 2773 6798 14868 2856 6976 4186 14869 2856 4186 6832 14870 2856 6832 9335 14871 2856 867 6976 14872 2856 5170 867 14873 2856 6044 5170 14874 2856 9335 6044 14875 8125 6044 9335 14876 8125 742 6044 14877 8125 7349 742 14878 8125 9335 7349 14879 5170 3408 8865 14880 5170 8865 867 14881 5613 9338 3019 14882 5613 2430 9338 14883 5613 6992 2430 14884 5613 3019 1988 14885 7347 4773 7474 14886 8827 9341 7753 14887 8827 636 9341 14888 8827 7753 5397 14889 8827 5397 5188 14890 8827 5188 636 14891 2039 7753 6074 14892 2039 1171 7753 14893 2039 6074 2850 14894 2039 7196 1171 14895 848 636 5188 14896 848 5188 3226 14897 9951 5821 215 14898 9951 5685 3107 14899 9951 3107 5821 14900 5685 2411 3107 14901 3167 6080 4801 14902 5709 8337 4544 14903 4544 8943 698 14904 4544 8337 8943 14905 6464 1693 620 14906 6464 2970 1693 14907 6464 620 1332 14908 1147 5500 9134 14909 7374 3410 7155 14910 7374 7155 4419 14911 7374 4419 6954 14912 7374 6954 6355 14913 5500 9799 9134 14914 9799 5174 9134 14915 9799 6415 5174 14916 9256 3029 8682 14917 9256 8682 1912 14918 5589 5582 4131 14919 5589 4131 6692 14920 5589 6692 738 14921 5589 7759 5582 14922 5589 738 7759 14923 3996 2110 738 14924 3996 738 6692 14925 3996 1912 2110 14926 3996 3586 1912 14927 3996 6692 3586 14928 7091 8251 8389 14929 7091 8537 8251 14930 7091 5199 8537 14931 7091 8389 5199 14932 7656 6462 4536 14933 7656 5439 6462 14934 6016 4536 6462 14935 6016 1389 7066 14936 6016 7066 4536 14937 6016 2390 1389 14938 7066 1389 6054 14939 7066 3009 4536 14940 7066 2652 3009 14941 7066 3149 2652 14942 7066 6054 3149 14943 6462 5439 6458 14944 6462 6458 384 14945 6462 384 2390 14946 2718 3604 2125 14947 2718 7316 3604 14948 2718 2125 3429 14949 2718 3429 823 14950 2718 823 7316 14951 7586 9858 504 14952 1304 8699 5472 14953 7523 5512 4416 14954 7523 1079 5512 14955 52 3245 8961 14956 52 7245 3245 14957 2060 8961 3245 14958 2060 3245 3705 14959 2060 3705 4289 14960 9228 2979 943 14961 9228 8490 2979 14962 141 6252 9217 14963 141 9217 7131 14964 141 3467 6252 14965 141 8234 3467 14966 141 7851 8234 14967 141 7131 7851 14968 2322 9442 5146 14969 2322 6134 6852 14970 2322 7575 6134 14971 2322 5146 7575 14972 2322 6852 4754 14973 2485 2281 4242 14974 2133 9442 4050 14975 2133 4130 6746 14976 2133 6746 1163 14977 2133 4050 4130 14978 9417 2981 3550 14979 3697 4912 7802 14980 3697 7802 9117 14981 850 800 3833 14982 3006 8659 7084 14983 3006 7084 245 14984 3006 245 1853 14985 209 8090 7645 14986 209 7645 4418 14987 4469 6402 7933 14988 4469 8035 6402 14989 9514 8122 8035 14990 9514 2048 8122 14991 9514 800 3146 14992 9514 3146 4790 14993 9514 8035 800 14994 3585 20 8616 14995 3585 8380 20 14996 3585 3519 5155 14997 3585 5155 8380 14998 3585 5036 3519 14999 3585 8616 5036 15000 7716 8388 7718 15001 2675 2690 3339 15002 2675 7248 2690 15003 5583 1286 8422 15004 5583 9570 6090 15005 5583 7219 4699 15006 5583 3005 7219 15007 5583 4699 3326 15008 5583 8422 3005 15009 5583 3326 9570 15010 3447 3671 2767 15011 3447 7870 3671 15012 3447 2767 537 15013 3447 537 8801 15014 3447 8801 5139 15015 3447 5139 3640 15016 3447 3640 7870 15017 3846 9874 9160 15018 3846 9160 7354 15019 3846 7354 8372 15020 3846 8372 2387 15021 3846 2387 3448 15022 3846 3448 9874 15023 2307 5389 4628 15024 2307 541 5389 15025 2307 3587 541 15026 1115 7842 5913 15027 1115 9870 6627 15028 1115 4448 9870 15029 1115 5913 4448 15030 2402 5099 1853 15031 2402 1853 9290 15032 2402 9290 544 15033 2402 7812 5099 15034 5498 8826 20 15035 5498 20 9600 15036 5498 8749 8826 15037 5498 8064 8749 15038 5498 7331 7812 15039 5498 544 4342 15040 5498 4342 8064 15041 544 541 1383 15042 544 9290 541 15043 544 1383 4342 15044 1320 9922 4378 15045 1320 9088 9922 15046 9730 9493 1762 15047 9730 9986 9493 15048 6069 1805 1079 15049 6069 9801 1805 15050 6197 724 3227 15051 724 4335 7155 15052 724 7695 4335 15053 1530 1178 349 15054 2249 348 3957 15055 7570 4685 9262 15056 7570 7857 4685 15057 7570 9262 7555 15058 7570 5850 7857 15059 7570 3609 5850 15060 4335 4419 7155 15061 4335 7695 3957 15062 4335 3957 348 15063 4335 348 4419 15064 1950 291 1983 15065 3371 6765 1983 15066 7313 646 186 15067 5926 7732 8389 15068 5926 8389 8251 15069 5926 8251 369 15070 1387 3235 6891 15071 1387 7886 3235 15072 1387 6891 3042 15073 5358 555 1396 15074 5358 6596 555 15075 5358 3042 6596 15076 5358 1396 6885 15077 8232 771 4967 15078 7517 4685 9706 15079 7517 1150 4685 15080 7517 9706 4368 15081 7517 4368 6885 15082 7517 2288 1150 15083 7517 1499 7159 15084 7517 7159 2288 15085 7517 1396 1499 15086 7517 6885 1396 15087 7132 9796 360 15088 7132 5378 9796 15089 7452 7150 5354 15090 7452 5354 4286 15091 7452 6066 7150 15092 1517 1235 9702 15093 1517 9702 249 15094 1517 8199 4188 15095 1517 4188 1235 15096 259 3806 8258 15097 259 8945 3806 15098 4962 4888 2081 15099 4962 2081 5489 15100 1815 8602 2029 15101 7945 3109 3490 15102 7945 1679 3109 15103 8829 275 1671 15104 8829 1472 275 15105 6185 9960 8484 15106 3558 9364 8279 15107 3558 1031 9364 15108 3558 7133 1031 15109 3558 2169 5954 15110 3558 5954 4690 15111 3558 7652 2169 15112 3558 4690 7133 15113 3558 10001 4741 15114 3558 8279 10001 15115 3558 4741 7652 15116 9546 6697 2054 15117 9546 2054 2038 15118 9546 7370 6697 15119 9546 8824 7370 15120 9546 5416 8824 15121 9546 2038 5416 15122 5708 3693 4797 15123 5708 4797 3961 15124 5708 3961 9396 15125 5708 9396 1536 15126 5900 6898 401 15127 5900 1552 6898 15128 5900 401 7692 15129 1804 4530 9396 15130 1804 6965 4530 15131 1804 9396 3961 15132 1804 3961 3360 15133 1804 3360 6965 15134 2686 3141 3181 15135 2686 3181 7232 15136 2686 7232 5859 15137 2686 5859 3141 15138 3181 1756 6874 15139 3181 6874 9946 15140 3181 3141 1756 15141 3181 9946 7232 15142 4072 4046 8107 15143 4072 1996 4046 15144 4072 8107 8140 15145 4072 2127 1996 15146 4588 4470 1920 15147 8123 9955 8107 15148 8123 8107 4046 15149 4652 3083 8176 15150 5341 8303 4798 15151 6710 3402 7497 15152 6710 8399 3402 15153 6710 3154 8399 15154 6710 6867 3154 15155 9216 2811 3484 15156 5262 192 8130 15157 2795 1558 1793 15158 2795 9046 1558 15159 6598 3402 8399 15160 2261 2797 9154 15161 7206 8905 3658 15162 7206 1877 8905 15163 811 4747 5209 15164 811 5209 6249 15165 811 6249 8726 15166 7813 1263 3950 15167 7828 7295 8656 15168 7036 6617 5393 15169 9352 8651 8503 15170 9352 6053 8651 15171 8128 9175 4005 15172 8128 4824 9175 15173 8128 2431 1476 15174 8128 4005 2431 15175 8128 1476 2745 15176 8128 2745 4824 15177 4861 5707 7577 15178 4861 7577 1899 15179 4861 5711 8221 15180 4861 8221 5707 15181 6670 995 8221 15182 6670 8221 5711 15183 6670 5711 9027 15184 8221 7864 7629 15185 8221 7629 5707 15186 8221 995 7864 15187 995 7629 7864 15188 753 9604 4744 15189 753 4744 6180 15190 753 1837 9604 15191 753 9727 1837 15192 753 3186 9727 15193 753 6180 3186 15194 1611 3764 1009 15195 1611 1009 2157 15196 1611 9078 3764 15197 1611 143 9078 15198 2476 1837 161 15199 2476 161 580 15200 2476 9604 1837 15201 2476 4486 9604 15202 1179 9604 4486 15203 1179 4744 9604 15204 1179 4486 7799 15205 6892 9229 6584 15206 6892 8132 9229 15207 6892 6584 8132 15208 9076 9229 1519 15209 9076 6584 9229 15210 9076 1519 3219 15211 9076 8717 6584 15212 9076 951 8717 15213 749 1837 9727 15214 749 161 1837 15215 749 9727 277 15216 749 4013 161 15217 749 277 4013 15218 4899 779 5128 15219 4899 5128 1272 15220 779 1925 5128 15221 779 3756 1925 15222 4359 4744 5265 15223 4359 5265 4956 15224 4359 337 4744 15225 4359 4956 337 15226 6284 7797 9987 15227 6284 9987 6155 15228 1279 9776 8593 15229 1279 6105 9776 15230 1279 1322 3563 15231 1279 3563 3991 15232 1279 3991 6105 15233 1279 8593 1322 15234 1348 4875 8532 15235 1787 241 6484 15236 1787 390 241 15237 1787 6484 5284 15238 241 2445 7946 15239 241 7946 6484 15240 9753 4800 7719 15241 9753 1713 4800 15242 9753 1578 1713 15243 452 1471 97 15244 452 9627 9761 15245 4964 2040 8185 15246 4964 8185 2376 15247 2376 8185 4392 15248 5435 9534 7419 15249 5435 7419 4584 15250 5485 8377 1040 15251 6653 788 971 15252 6653 971 6488 15253 7033 8705 147 15254 7033 6927 8705 15255 7033 5783 6927 15256 9562 3920 7205 15257 9562 9624 3920 15258 2255 3400 9802 15259 8013 7883 7395 15260 4891 1831 4728 15261 2868 6511 9388 15262 3300 1733 9349 15263 3300 9349 3969 15264 3686 2595 6504 15265 3686 6504 6937 15266 3686 6937 9349 15267 3686 9349 1733 15268 3686 1733 3400 15269 2445 9964 5677 15270 2445 5677 7946 15271 4344 5677 9964 15272 8968 3969 8297 15273 8968 8297 4953 15274 8968 7946 3969 15275 8968 8377 7946 15276 8968 9342 1040 15277 8968 4953 9342 15278 8968 1040 8377 15279 4887 5596 5116 15280 4887 5239 5596 15281 4887 5116 7021 15282 4887 7021 3039 15283 5680 7846 2730 15284 5680 2730 8700 15285 5680 8700 1207 15286 502 8126 7486 15287 502 7486 9817 15288 502 9817 6796 15289 1207 8700 5484 15290 8364 1545 9817 15291 8364 9871 1545 15292 3942 101 8512 15293 3942 8512 2753 15294 3942 2753 5380 15295 3942 5380 5216 15296 3942 5216 101 15297 8301 8381 8126 15298 8301 5216 5380 15299 4298 3311 3038 15300 4298 6713 8245 15301 4298 3038 6713 15302 4298 8245 119 15303 2870 9229 8132 15304 2870 8132 8995 15305 1519 9387 3219 15306 6893 9615 9670 15307 6893 7299 9615 15308 6893 9670 5664 15309 4034 6516 2999 15310 4034 8593 9776 15311 2993 8530 5166 15312 5020 9459 4660 15313 5020 1373 9459 15314 5020 2204 1373 15315 1062 9459 9820 15316 1062 4660 9459 15317 871 8996 8295 15318 744 1696 1599 15319 744 1599 740 15320 4425 4392 8185 15321 4425 8185 794 15322 4425 794 5884 15323 2864 9019 3624 15324 2864 6934 9019 15325 2864 7299 8431 15326 2864 4757 7299 15327 2864 8431 6934 15328 2864 3624 4757 15329 9259 9536 1003 15330 9259 1003 4533 15331 9259 4533 3419 15332 9259 3419 6579 15333 4364 1275 6763 15334 4364 6728 1275 15335 4364 8456 6728 15336 4364 6763 5951 15337 4364 4484 8456 15338 8354 3935 9055 15339 8354 9055 7320 15340 8354 7320 5085 15341 2185 4290 41 15342 2185 6055 4290 15343 2185 8875 6055 15344 4297 6541 4290 15345 4297 5052 6541 15346 4297 8594 5052 15347 3543 9783 6548 15348 5376 2421 3675 15349 3561 847 3424 15350 3561 5224 5707 15351 3561 5707 7629 15352 3561 6263 5224 15353 9110 1272 6436 15354 9110 6436 6263 15355 9214 2495 3813 15356 9214 1185 7026 15357 9214 3419 1185 15358 9214 7026 6617 15359 9214 3813 3419 15360 6432 4421 2102 15361 6432 7293 4421 15362 6432 2102 4299 15363 4647 1122 2231 15364 9888 322 9598 15365 9888 812 322 15366 9888 9598 340 15367 1835 1645 2844 15368 1835 2844 7293 15369 3694 3938 1350 15370 5719 6539 8017 15371 3673 1177 9816 15372 3673 5193 1177 15373 3673 1646 5193 15374 6399 7522 6706 15375 6399 883 7522 15376 6399 6049 883 15377 5993 1177 5193 15378 5993 8084 1177 15379 5993 5524 8084 15380 5993 1646 1850 15381 5993 5193 1646 15382 5993 1850 9249 15383 5993 9249 5524 15384 8527 3953 8606 15385 8527 8606 5131 15386 8527 7644 9954 15387 8527 5131 7644 15388 2397 9954 7644 15389 2397 4299 2102 15390 2844 1645 6821 15391 2844 6821 5625 15392 2844 5625 7293 15393 4539 8847 9233 15394 4539 9233 796 15395 1972 1084 5543 15396 9894 5737 7071 15397 9894 4542 5737 15398 9894 7071 4860 15399 9894 4860 1479 15400 9894 1479 9419 15401 9894 9419 4870 15402 9894 4870 4542 15403 9642 4001 7749 15404 4738 4831 3122 15405 7749 4001 2998 15406 7749 2998 3246 15407 5144 4374 3880 15408 5144 4262 4374 15409 5144 3880 9922 15410 5144 9922 4262 15411 4374 2785 7353 15412 4374 7353 453 15413 4374 9031 3980 15414 4374 453 9031 15415 4374 3980 3880 15416 4374 4262 3578 15417 4374 3578 2785 15418 2639 7476 3340 15419 5718 7247 4047 15420 5718 4545 7247 15421 5718 2932 4545 15422 5718 7785 2932 15423 7247 2191 3050 15424 7247 6119 2191 15425 7247 4545 6119 15426 9389 9168 5638 15427 9389 4545 9168 15428 9389 8718 4318 15429 9389 4318 4545 15430 9389 5596 8718 15431 9389 5638 5596 15432 6523 6233 5116 15433 6523 5116 5638 15434 6523 5638 9168 15435 6523 5111 6233 15436 6523 6799 5111 15437 6523 9168 6799 15438 8495 3340 7476 15439 8495 7476 5636 15440 9910 4363 7972 15441 2729 6936 3566 15442 2729 3566 4141 15443 1252 8159 4336 15444 1252 4336 5259 15445 8199 6845 4188 15446 8199 7174 6845 15447 8199 3256 7174 15448 9909 7174 3256 15449 9909 8290 7174 15450 9909 5806 4324 15451 9909 1569 5806 15452 9909 3256 1569 15453 9909 4324 8290 15454 4054 1163 2649 15455 4054 7675 1163 15456 4054 2649 2076 15457 4054 2076 7675 15458 6746 4130 4242 15459 6746 4242 1653 15460 6746 2649 1163 15461 6746 1653 2649 15462 6220 4242 2281 15463 6220 2281 9854 15464 6220 9854 2951 15465 6220 2951 26 15466 6220 26 4242 15467 7047 8290 4324 15468 7047 1653 8290 15469 7047 4324 5806 15470 7047 5806 1653 15471 1538 26 2951 15472 1538 6000 26 15473 1538 2951 5226 15474 1538 5226 6000 15475 7194 8695 959 15476 6500 1817 2545 15477 6500 8079 1817 15478 6500 2545 6186 15479 6500 3074 8079 15480 7475 8134 959 15481 7475 4210 8134 15482 9465 8942 3059 15483 9465 1829 8942 15484 9465 3059 1829 15485 9905 786 565 15486 335 9084 5297 15487 335 4495 9084 15488 335 1704 3407 15489 335 5297 1704 15490 335 3407 4495 15491 2575 1704 8758 15492 2575 8758 2926 15493 5987 7518 3446 15494 5987 1470 7518 15495 402 2526 1310 15496 402 7832 2526 15497 1318 5909 8283 15498 6515 8740 6020 15499 6515 6020 694 15500 6515 694 9942 15501 6515 223 8740 15502 6515 9942 223 15503 6948 6830 8740 15504 6948 3150 6830 15505 6948 8740 6331 15506 6830 9246 6020 15507 6830 6020 8740 15508 6830 9264 9246 15509 6830 3150 9264 15510 8289 4011 4048 15511 2385 5909 7357 15512 4011 4515 3958 15513 4011 4078 4048 15514 2871 6646 1428 15515 2871 1813 6646 15516 2871 4048 4078 15517 2871 4078 6933 15518 2871 6933 1813 15519 8573 8208 1824 15520 8573 1824 694 15521 8573 9902 8208 15522 8573 4816 9902 15523 8573 694 7524 15524 8573 7524 4816 15525 401 2205 7692 15526 4236 2287 6920 15527 4236 6775 2287 15528 4236 6920 1834 15529 4236 1433 7692 15530 4236 1189 1433 15531 4236 7692 6775 15532 4236 1834 1189 15533 9457 8859 1515 15534 9457 3642 8859 15535 9457 2904 3642 15536 9457 3531 2904 15537 7524 6020 3699 15538 7524 3699 6348 15539 7524 694 6020 15540 7524 6348 4816 15541 5907 4473 6119 15542 5907 387 4473 15543 5907 6119 4318 15544 5907 4318 8718 15545 5907 2792 387 15546 2842 6889 3117 15547 2842 3117 3796 15548 5976 548 6889 15549 5976 5335 548 15550 9778 7262 1215 15551 6853 8183 7679 15552 6853 6008 791 15553 6853 791 8183 15554 3310 3814 3891 15555 3310 421 3814 15556 3310 3891 5623 15557 3310 7773 6043 15558 3310 6043 7835 15559 3310 7835 421 15560 3310 5623 7773 15561 1725 9272 1338 15562 1725 1338 965 15563 1725 965 73 15564 1725 6919 9272 15565 1725 73 4432 15566 1725 6323 6919 15567 5655 1948 2576 15568 5655 2576 3817 15569 4468 3817 2576 15570 4468 6368 3093 15571 5980 8223 1660 15572 5980 1660 8288 15573 5980 2042 8223 15574 3728 5645 7787 15575 3728 7787 3210 15576 3896 4681 6062 15577 3896 6062 3210 15578 3896 4479 4681 15579 3896 7839 4479 15580 3896 3210 6368 15581 3093 7787 429 15582 3093 6368 7787 15583 4199 3312 7283 15584 5137 6479 7283 15585 5137 4681 6479 15586 5137 7283 3312 15587 5137 6062 4681 15588 2219 6246 6770 15589 2219 3625 6246 15590 2219 4146 2012 15591 2219 6770 4146 15592 2219 2012 5012 15593 2219 5012 3625 15594 146 8080 1888 15595 146 5266 8080 15596 1919 4280 3634 15597 1919 3634 9180 15598 1919 9180 8721 15599 1919 8721 9829 15600 1919 9829 4280 15601 4123 4280 1918 15602 4123 1918 2698 15603 4123 2698 2144 15604 8937 4830 6245 15605 8937 6245 1139 15606 8937 2827 4830 15607 514 3634 9209 15608 514 2827 3634 15609 514 9209 942 15610 514 9596 4830 15611 514 942 9596 15612 514 4830 2827 15613 3130 6956 4361 15614 3130 8475 6956 15615 3130 4361 7905 15616 3130 7905 8475 15617 9596 6245 4830 15618 3052 9062 677 15619 3052 677 2300 15620 6008 5563 8047 15621 6008 8047 791 15622 6899 1119 2187 15623 6899 1940 1119 15624 6899 442 1127 15625 6899 1127 1940 15626 6899 5343 442 15627 6899 2187 5343 15628 6276 2670 796 15629 6276 796 9233 15630 6276 456 2670 15631 2670 7539 1461 15632 2670 3509 7539 15633 2670 456 3509 15634 2670 1461 796 15635 1409 2817 4751 15636 4919 6971 5595 15637 4919 5595 7407 15638 4919 7838 6971 15639 8257 3087 1288 15640 8257 2806 3087 15641 2805 4804 6038 15642 2805 1288 4804 15643 1176 443 9281 15644 9731 633 9281 15645 6362 9378 5238 15646 6362 5238 1253 15647 6362 9052 9378 15648 6362 1253 8789 15649 9378 9735 5238 15650 4200 9294 7411 15651 1726 2135 5859 15652 1726 5859 7232 15653 1726 7232 3280 15654 1352 9946 2461 15655 1764 4471 8072 15656 1764 8072 9366 15657 3445 7411 9294 15658 8072 1896 883 15659 8072 883 9366 15660 7112 4767 10000 15661 1254 9296 512 15662 9344 9467 1435 15663 9344 1435 3500 15664 9344 3500 2068 15665 9344 2068 2653 15666 7128 2068 3500 15667 2148 3711 7960 15668 8136 1127 442 15669 8136 9038 1127 15670 8136 442 903 15671 8136 903 9038 15672 7076 1172 962 15673 1625 6971 857 15674 1625 5264 6971 15675 9194 857 6971 15676 9207 1895 7581 15677 9207 7581 5994 15678 5049 4343 3106 15679 5049 764 4343 15680 4343 3103 3106 15681 4343 1104 3103 15682 4343 764 1104 15683 1222 107 4553 15684 1222 4553 6439 15685 1222 6439 5669 15686 5467 3103 5377 15687 8504 9136 8118 15688 3712 3180 2768 15689 3712 1339 3180 15690 3712 2768 409 15691 4049 1788 9343 15692 4049 9343 513 15693 4049 513 3252 15694 4961 3446 7504 15695 3934 3446 7518 15696 3934 7924 3446 15697 7185 6149 7478 15698 7185 9494 6149 15699 7185 9981 8727 15700 7185 8727 9494 15701 8727 3931 2560 15702 8727 768 3931 15703 8727 9981 768 15704 8727 2560 9494 15705 3393 5223 5481 15706 3393 5481 2317 15707 3393 1986 1698 15708 3393 1698 5223 15709 3393 2317 1986 15710 8237 356 3744 15711 8237 3744 7589 15712 8237 1882 9271 15713 8237 9271 356 15714 8237 6819 1882 15715 8237 7589 6819 15716 267 3323 8175 15717 267 8175 2482 15718 267 1106 3323 15719 267 1042 1106 15720 267 2482 1042 15721 7134 4146 2907 15722 7134 2907 550 15723 7134 6107 4146 15724 4146 987 935 15725 4146 935 5012 15726 4146 5012 2012 15727 4146 6770 2907 15728 4146 6107 987 15729 9072 1701 3203 15730 9072 3203 4437 15731 9072 3782 1701 15732 9072 4437 1005 15733 3719 5904 1823 15734 3719 1823 7967 15735 3719 7619 9815 15736 3719 9815 5904 15737 3719 7967 7619 15738 1680 8 9815 15739 1680 9427 8 15740 1680 7619 8873 15741 1680 8873 14 15742 1680 14 9427 15743 1680 9815 7619 15744 2878 40 3323 15745 2878 3323 1106 15746 8428 6995 8052 15747 8428 8965 6995 15748 2855 1398 2045 15749 2855 4111 1398 15750 2855 8424 4111 15751 2855 3680 8424 15752 2855 8311 3680 15753 2855 2045 8965 15754 1687 3680 8311 15755 1687 7566 3680 15756 1687 1044 7566 15757 1701 3782 3516 15758 1701 3516 1404 15759 5042 8159 5818 15760 5042 4336 8159 15761 5042 1921 4336 15762 5042 9429 1921 15763 5042 1697 9429 15764 5042 6025 1697 15765 8545 6730 8357 15766 3641 6827 7062 15767 3641 7681 6827 15768 3641 2503 7681 15769 345 2752 7062 15770 345 7062 6827 15771 345 6827 4429 15772 8440 2145 8910 15773 8440 2450 9580 15774 1432 4330 754 15775 1432 754 2321 15776 1432 1973 4330 15777 1432 2321 1973 15778 8866 6585 4587 15779 8866 4587 1923 15780 8866 9621 5169 15781 8866 5169 6585 15782 7079 5169 9621 15783 4612 6660 8447 15784 4612 8447 5468 15785 4612 5468 7068 15786 4612 2370 6660 15787 4612 3701 2370 15788 4612 7068 3701 15789 2370 8543 6660 15790 2370 2155 8543 15791 2370 6677 4381 15792 2370 3701 6677 15793 2370 4381 2155 15794 4381 6677 4759 15795 7095 8853 931 15796 7095 1693 8853 15797 7095 931 8737 15798 7095 8737 1802 15799 6160 8737 931 15800 6160 4766 8737 15801 6160 931 4408 15802 240 8519 2799 15803 1802 8737 4766 15804 7849 7158 612 15805 598 5478 2382 15806 598 2382 4532 15807 598 4532 2695 15808 2505 5733 7363 15809 2175 5118 8045 15810 2175 8045 7434 15811 2175 7434 6961 15812 2175 6961 118 15813 2175 4192 5118 15814 2175 118 4192 15815 3761 1505 9060 15816 6028 1682 3403 15817 6028 198 1682 15818 6028 3403 920 15819 6028 920 344 15820 6028 2052 2941 15821 6028 344 2052 15822 6028 2941 198 15823 9061 9814 9785 15824 9785 8672 2694 15825 9785 9814 8672 15826 9422 3403 1682 15827 8049 5487 7755 15828 7447 9659 6465 15829 5487 8949 785 15830 5487 785 7755 15831 5487 8316 8949 15832 4916 920 3403 15833 9792 9717 8594 15834 9792 7294 9717 15835 2171 5085 7320 15836 2171 9436 5085 15837 2171 3971 9436 15838 5979 8759 2511 15839 5979 752 8759 15840 5979 1791 752 15841 5979 2511 3669 15842 5764 9609 9963 15843 5764 9963 546 15844 6313 2980 140 15845 8446 8270 8191 15846 8446 4914 8270 15847 9539 4223 4756 15848 9539 4756 2088 15849 3523 960 7930 15850 3523 7930 1411 15851 3523 478 6982 15852 3523 6982 960 15853 3523 3682 478 15854 3523 1411 3682 15855 478 1711 6982 15856 478 5745 1711 15857 478 3682 5745 15858 1711 8016 6982 15859 1711 5339 8016 15860 1711 5745 5339 15861 7295 8888 8656 15862 4198 2551 6118 15863 4198 6118 6905 15864 4198 6905 5567 15865 4198 5567 8168 15866 4198 8168 2551 15867 5567 6905 4747 15868 6586 8887 7423 15869 6586 7423 4068 15870 6586 6832 8887 15871 6586 4717 7349 15872 6586 7349 9335 15873 6586 9335 6832 15874 6586 4068 4717 15875 6798 2773 6285 15876 3408 949 552 15877 3408 552 8865 15878 785 2053 7755 15879 6992 4439 2430 15880 3019 9338 476 15881 1605 6530 3268 15882 1605 3268 6757 15883 1605 9708 477 15884 1605 6757 9708 15885 1556 683 1790 15886 7969 2477 573 15887 7969 573 4890 15888 1138 5109 6800 15889 1138 6800 1593 15890 1138 3096 5109 15891 5109 3096 1942 15892 5109 1942 6800 15893 7753 3439 6074 15894 7753 1171 5397 15895 7753 9341 2541 15896 7753 2541 3439 15897 1782 2541 3900 15898 1782 3439 2541 15899 1782 3900 3439 15900 6074 569 2850 15901 6074 9666 569 15902 6074 3439 9666 15903 8943 4805 8326 15904 8943 8326 698 15905 8943 8337 9225 15906 8943 9225 4805 15907 9225 4420 5713 15908 9225 5713 6135 15909 9225 8337 4420 15910 9225 1501 4805 15911 9225 6135 1501 15912 3226 5188 5397 15913 6518 5821 8714 15914 6518 8714 4420 15915 6518 215 5821 15916 6518 4420 215 15917 8152 5174 6415 15918 8152 4334 5174 15919 8152 7328 8849 15920 8152 8849 4334 15921 8152 6446 7328 15922 8152 6415 6446 15923 2970 468 1693 15924 7328 4429 1164 15925 7328 6446 4429 15926 7328 1164 8849 15927 4413 1164 6679 15928 4413 8849 1164 15929 4413 6679 1980 15930 4413 4334 8849 15931 4413 9134 4334 15932 3791 5850 5920 15933 3791 7857 5850 15934 3791 5781 8402 15935 3791 5920 5781 15936 3791 8402 7857 15937 9529 1150 2288 15938 9529 2288 3325 15939 9529 3325 8993 15940 9529 5108 1150 15941 9262 4685 5108 15942 9262 6355 6954 15943 9262 6954 7555 15944 9262 5108 6355 15945 6954 4419 7555 15946 9565 3586 4131 15947 9565 6553 3586 15948 9565 4131 2799 15949 9565 2799 1785 15950 9565 1785 1499 15951 9565 1499 6553 15952 8682 2110 1912 15953 8682 6298 2110 15954 8682 3029 6298 15955 7759 4312 5582 15956 7759 3874 4312 15957 7759 738 3874 15958 2110 1964 738 15959 2110 7086 1964 15960 2110 6298 7086 15961 5199 644 2049 15962 5199 5125 644 15963 5199 4706 5125 15964 5199 2049 8537 15965 5199 8389 4706 15966 3173 4339 8240 15967 3173 5571 4339 15968 3173 4045 5571 15969 3173 4131 4045 15970 3173 2799 4131 15971 3173 8240 2799 15972 4339 1311 2799 15973 4339 2799 8240 15974 4339 5571 9654 15975 4339 9654 3281 15976 4339 3281 1311 15977 2571 3872 6487 15978 2571 6487 5352 15979 2571 8752 2263 15980 2571 2263 3872 15981 2571 6870 8752 15982 2571 813 6870 15983 2571 5352 813 15984 5469 6199 5705 15985 5469 5705 603 15986 5469 2652 6199 15987 5469 603 2652 15988 5439 12 5657 15989 5439 3615 12 15990 5439 5657 6458 15991 7359 2511 8759 15992 7359 2689 2128 15993 7359 3871 2689 15994 7359 8759 3871 15995 752 262 7662 15996 752 7662 3871 15997 752 3871 8759 15998 752 1791 968 15999 752 968 262 16000 5541 4956 4863 16001 5541 7999 4956 16002 5541 4863 6137 16003 5541 761 2041 16004 5541 6613 761 16005 5541 6137 6613 16006 5541 2041 864 16007 5541 864 7999 16008 4563 1639 7662 16009 4563 3815 1639 16010 4563 262 1618 16011 4563 7662 262 16012 4563 1618 3815 16013 2125 1928 3429 16014 2125 6732 1928 16015 7316 8395 4223 16016 7316 823 8395 16017 9858 2862 988 16018 9858 988 504 16019 4416 5512 8940 16020 7245 4289 3705 16021 7245 2241 4289 16022 7245 3705 3245 16023 4346 807 3905 16024 4346 8217 807 16025 4346 3905 6852 16026 4346 6745 8217 16027 4346 6134 4883 16028 4346 6852 6134 16029 4346 4883 6745 16030 2981 4883 3550 16031 2981 2027 4883 16032 9790 7453 7911 16033 9790 7911 3334 16034 9790 4993 5885 16035 9790 5885 7453 16036 9790 9957 4993 16037 9790 3334 9957 16038 7680 5885 4993 16039 7680 4993 4748 16040 7680 4748 2349 16041 7680 2349 5885 16042 8490 2906 3929 16043 8490 3929 2979 16044 9367 3929 2906 16045 9367 4788 3929 16046 9367 2906 8828 16047 9367 8828 4788 16048 6252 3467 9217 16049 5662 9971 2667 16050 5662 2391 9971 16051 5662 9192 2391 16052 5146 5078 7258 16053 5146 7258 7575 16054 5146 9442 5078 16055 7258 5078 6753 16056 7258 3550 7575 16057 4912 5123 7802 16058 2974 2975 5430 16059 2974 5430 207 16060 2974 9117 3183 16061 2974 4540 9117 16062 2974 3183 2975 16063 2974 207 4540 16064 4686 8393 6250 16065 4686 6250 3183 16066 4686 9117 7802 16067 4686 3183 9117 16068 4686 7802 8393 16069 7331 5099 7812 16070 7331 1853 5099 16071 800 8035 3833 16072 8659 1225 7084 16073 8659 2235 1225 16074 8035 8122 6402 16075 5036 328 5653 16076 5036 8616 328 16077 5036 5653 3519 16078 3721 2192 1463 16079 8422 1892 9846 16080 8422 9846 293 16081 8422 293 3005 16082 8422 5828 1892 16083 8422 1286 5828 16084 6090 6753 86 16085 6090 9570 6753 16086 7219 6576 4699 16087 7219 293 6576 16088 7219 3005 293 16089 2767 2313 537 16090 2767 3671 2313 16091 8749 5750 8826 16092 8749 8064 5750 16093 3448 2387 6295 16094 3448 6295 3508 16095 4628 9876 7084 16096 4628 7084 2235 16097 4628 5389 9876 16098 4628 9160 9874 16099 4628 9210 9160 16100 4628 2235 9210 16101 9956 1383 541 16102 9956 541 3587 16103 4393 4370 7330 16104 4393 7330 7647 16105 4393 2413 4370 16106 6627 9870 2881 16107 6627 7254 1937 16108 6627 2881 7254 16109 6627 1937 2413 16110 4370 9329 7330 16111 4370 3597 9329 16112 4370 2413 3597 16113 4378 3880 3980 16114 4378 3980 771 16115 4378 9922 3880 16116 4378 771 9510 16117 6235 1762 9493 16118 6235 7292 1762 16119 2581 4083 8687 16120 2581 8687 9986 16121 2581 1805 4083 16122 2581 8361 1805 16123 2581 1376 8361 16124 1079 1805 8361 16125 9551 7453 5557 16126 9551 2418 7453 16127 3498 943 2979 16128 3498 2979 6785 16129 3498 9808 943 16130 3498 5885 9808 16131 3498 5557 5885 16132 3185 3957 7695 16133 3609 5920 5850 16134 8886 6773 166 16135 8886 1745 6773 16136 4380 8402 1237 16137 4380 9862 8402 16138 4380 360 9862 16139 4380 646 7055 16140 4380 1237 646 16141 3235 7886 584 16142 7732 8216 8389 16143 7732 7052 8216 16144 3042 6891 6596 16145 186 5781 2073 16146 186 646 5781 16147 4967 1922 201 16148 4967 201 10001 16149 4967 453 1922 16150 4967 771 453 16151 1396 555 1499 16152 4368 9706 6052 16153 4368 6052 5378 16154 9017 9706 9862 16155 9017 6052 9706 16156 9017 360 9796 16157 9017 9796 6052 16158 9017 9862 360 16159 9796 5378 6052 16160 9706 2336 9862 16161 9706 4685 2336 16162 7015 5654 3948 16163 7015 3948 5011 16164 7015 5011 8938 16165 7015 4673 5654 16166 7015 8938 370 16167 7015 370 4673 16168 5654 5464 2784 16169 5654 2784 9702 16170 5654 4673 5464 16171 5654 9702 9601 16172 5654 9601 3948 16173 5136 9208 5176 16174 5136 5647 9208 16175 9208 7150 5176 16176 9208 2268 7150 16177 9208 9769 2268 16178 9208 5647 9769 16179 7150 6066 5176 16180 7150 9998 5354 16181 7150 2268 9998 16182 1235 9601 9702 16183 8258 2903 2029 16184 8258 9171 2903 16185 8258 3806 9171 16186 4888 3804 2081 16187 4888 2029 2903 16188 4888 2903 3804 16189 3109 1162 5852 16190 3109 9972 1162 16191 3109 5852 3490 16192 3109 1679 9972 16193 6929 4448 3490 16194 6929 506 4448 16195 6929 5852 6489 16196 6929 6489 506 16197 6929 3490 5852 16198 8845 275 1472 16199 9755 6316 2103 16200 9755 629 6316 16201 9755 4654 4768 16202 9755 4768 4896 16203 9755 4896 629 16204 9755 2103 7941 16205 9755 7941 1031 16206 9755 4684 4654 16207 9755 1031 4684 16208 4741 10001 8904 16209 4741 8904 5799 16210 4741 5799 4992 16211 4741 4176 7652 16212 4741 2394 4176 16213 4741 4992 2394 16214 9178 4091 7268 16215 9178 6400 4091 16216 9178 8904 6400 16217 9178 7268 5799 16218 9178 5799 8904 16219 1444 5799 9930 16220 1444 9930 9657 16221 1444 4992 5799 16222 1444 9657 4992 16223 3327 6748 2933 16224 3327 911 6748 16225 3327 7059 2002 16226 3327 2002 911 16227 3327 1603 799 16228 3327 2933 1603 16229 3327 799 7059 16230 1591 3926 5788 16231 1591 5954 3926 16232 1591 5788 5954 16233 1603 3926 799 16234 1603 2933 5812 16235 1603 6650 3926 16236 1603 5812 6650 16237 6697 7370 563 16238 6697 563 9687 16239 6697 9687 2054 16240 8824 7179 7370 16241 8824 1536 7179 16242 8824 5416 4475 16243 5416 8083 4475 16244 5416 5767 8083 16245 5416 2038 8304 16246 5416 8304 5767 16247 8083 5767 9051 16248 3961 4797 3382 16249 3961 3382 3360 16250 2246 9063 9524 16251 2246 3484 9063 16252 2246 3732 3484 16253 2246 3763 1850 16254 2246 1850 3732 16255 2246 9524 3763 16256 2156 6258 2811 16257 2156 9435 6258 16258 2156 4778 9435 16259 2156 3263 4778 16260 5859 9435 4778 16261 5859 4778 3807 16262 5859 2135 9435 16263 5859 3807 3141 16264 3141 3807 1756 16265 1317 7552 5595 16266 1317 5595 5264 16267 1777 4157 7552 16268 1777 6031 4157 16269 1777 8157 6031 16270 1777 5994 8157 16271 8140 8450 3353 16272 5007 3291 862 16273 3658 8905 6867 16274 3154 3350 8399 16275 3154 7087 3350 16276 3154 6867 7087 16277 2290 7782 5739 16278 2290 5739 1877 16279 9154 2797 8930 16280 9154 8930 1241 16281 425 5349 2534 16282 425 2534 576 16283 425 576 2657 16284 7026 1185 6201 16285 7026 5393 6617 16286 7026 355 5393 16287 7026 6201 355 16288 1476 5456 2745 16289 1476 8503 5456 16290 1476 2431 9089 16291 5711 8652 9027 16292 9727 7577 5224 16293 9727 6180 7577 16294 9727 3186 6180 16295 9727 5224 277 16296 9078 7060 3764 16297 9078 143 7060 16298 1009 7799 4486 16299 1009 3764 7799 16300 1009 4486 2579 16301 1009 2579 2157 16302 3876 2157 2579 16303 3876 951 2157 16304 3876 580 7963 16305 3876 7963 951 16306 6584 8717 8431 16307 7963 580 9475 16308 7963 9475 8717 16309 7963 8717 951 16310 6436 277 8793 16311 6436 1925 277 16312 6436 1272 1925 16313 6436 8793 6263 16314 9003 5224 6263 16315 9003 6263 8793 16316 9003 8793 5224 16317 4013 6128 161 16318 4013 5230 6128 16319 4013 277 3756 16320 4013 3756 5230 16321 4742 1471 8453 16322 4742 1602 1471 16323 5128 1925 1272 16324 4744 337 6180 16325 5983 1899 7108 16326 5983 7999 1899 16327 5983 337 7999 16328 5983 7108 337 16329 7577 5707 5224 16330 7577 6180 7108 16331 7577 7108 1899 16332 1322 8780 3563 16333 4875 1381 4605 16334 4875 4605 8532 16335 5735 448 8909 16336 5735 8909 1 16337 5735 8105 5700 16338 5735 1 8105 16339 1992 2925 97 16340 1992 3738 2925 16341 1992 97 1602 16342 1992 8809 3738 16343 8453 3624 9019 16344 5846 2040 4737 16345 5846 794 2040 16346 5846 5884 794 16347 5846 4737 5884 16348 1438 5884 7988 16349 1438 7988 9459 16350 1438 9459 8996 16351 7988 3635 9820 16352 7988 5884 3635 16353 7988 9820 9459 16354 788 3440 971 16355 788 9342 3440 16356 6488 971 6937 16357 6488 6937 6504 16358 6488 6504 2595 16359 6927 5783 5943 16360 7205 4737 2040 16361 7205 3920 4737 16362 3941 8679 8846 16363 3941 9944 8679 16364 3941 8846 8053 16365 1733 9802 3400 16366 3969 9349 8297 16367 2730 574 8700 16368 5822 5380 9497 16369 5822 9497 387 16370 6796 9817 1545 16371 6796 1545 5513 16372 5380 2753 5442 16373 5380 7612 9497 16374 5380 5442 7612 16375 9665 8044 2952 16376 9665 2952 8601 16377 9665 8601 509 16378 3219 7315 472 16379 3219 472 6918 16380 3219 6918 143 16381 472 7315 3998 16382 472 3998 6918 16383 2204 8295 1373 16384 2204 8851 8295 16385 6934 8717 9475 16386 6934 8431 8717 16387 6934 9475 5230 16388 6934 5230 9019 16389 6411 1003 9536 16390 4533 1185 3419 16391 4533 1003 6201 16392 4533 6201 1185 16393 6579 3419 3813 16394 6579 3813 3391 16395 6579 3391 2198 16396 5085 9436 5673 16397 4290 6541 41 16398 8594 9717 1186 16399 8594 1186 5052 16400 9783 6320 6541 16401 9783 6541 6548 16402 6548 6541 5052 16403 6320 9436 41 16404 6320 5673 9436 16405 6320 41 6541 16406 3813 2495 3391 16407 8303 4466 4798 16408 2102 4421 2883 16409 9556 9735 385 16410 9556 5797 9735 16411 9556 385 3692 16412 9556 3692 7512 16413 9556 7512 5797 16414 3197 524 3938 16415 1350 2456 8017 16416 1350 3938 2456 16417 1350 8017 5386 16418 3170 2352 1896 16419 1850 3763 9249 16420 1850 3608 3732 16421 1850 7405 3608 16422 1850 1646 7405 16423 7422 2757 2456 16424 7422 6706 2757 16425 2757 7522 7796 16426 2757 6706 7522 16427 2757 7796 2456 16428 6049 8084 5524 16429 6049 5524 9366 16430 6049 9366 883 16431 5524 9249 9366 16432 4502 6957 4878 16433 4502 7644 6957 16434 5131 750 7644 16435 5131 4940 750 16436 5131 8606 4940 16437 7293 3506 4421 16438 7293 5625 3506 16439 1645 340 6821 16440 4694 6097 2263 16441 4694 2263 4756 16442 4694 8959 6097 16443 4694 4223 8959 16444 4694 4756 4223 16445 3542 5123 9213 16446 3542 8393 7802 16447 3542 7802 5123 16448 4860 7071 1479 16449 4831 5342 3122 16450 7722 4542 168 16451 7722 8179 4542 16452 7722 168 1160 16453 1581 3246 4507 16454 1581 4507 372 16455 3980 9031 771 16456 4262 709 3578 16457 4262 9088 709 16458 4262 9922 9088 16459 2191 6119 4473 16460 2191 4473 3050 16461 4545 2932 9168 16462 4545 4318 6119 16463 6233 7846 5116 16464 5638 5116 5596 16465 7972 5153 2087 16466 7972 4363 5153 16467 4214 3216 6537 16468 4214 6537 3566 16469 4214 3566 4560 16470 7371 6537 3216 16471 6733 2087 9143 16472 6733 9143 9938 16473 6733 1084 6936 16474 6733 6936 2087 16475 6733 9938 1084 16476 7830 4560 1084 16477 6845 8945 4188 16478 6845 6740 3806 16479 6845 3806 8945 16480 6845 9766 6740 16481 6845 7174 9766 16482 3256 7368 1569 16483 3256 249 7368 16484 9784 2076 9255 16485 9784 9255 1356 16486 9784 8359 2076 16487 2649 1653 9255 16488 2649 9255 2076 16489 4242 26 8290 16490 4242 8290 1653 16491 5806 1569 9255 16492 5806 9255 1653 16493 2951 9854 7683 16494 2951 7683 5226 16495 913 3794 1748 16496 913 1748 2545 16497 913 9051 3794 16498 913 1817 1247 16499 913 2545 1817 16500 5953 959 8134 16501 5953 8134 6898 16502 5953 6898 1552 16503 2535 6646 9149 16504 3074 1247 8079 16505 3074 8695 1247 16506 9149 6646 4876 16507 9149 4876 3492 16508 9149 3492 4752 16509 8942 5706 3059 16510 8942 1829 8255 16511 8942 8255 5706 16512 3059 9597 1829 16513 3059 565 9597 16514 786 8358 565 16515 786 3125 8358 16516 3407 6657 3179 16517 3407 3179 269 16518 3407 269 4495 16519 3407 1704 6657 16520 6239 7614 5359 16521 6239 5359 8198 16522 6239 51 6657 16523 6239 8198 51 16524 6239 6657 7614 16525 5363 51 5706 16526 5363 5706 5321 16527 5363 1822 51 16528 5363 5321 1822 16529 5486 6657 1704 16530 5486 7614 6657 16531 1470 7895 7518 16532 9264 3952 9246 16533 9264 3150 6050 16534 3952 6020 9246 16535 3952 6864 6020 16536 3952 1310 6864 16537 1944 6050 3150 16538 8740 223 6331 16539 6331 223 6920 16540 2892 5706 8198 16541 2892 8198 5359 16542 3958 2287 7760 16543 3958 7760 189 16544 3958 4515 2287 16545 4078 189 6933 16546 8208 9902 4317 16547 8208 4317 3063 16548 8208 3063 1824 16549 2478 1189 223 16550 2478 223 9942 16551 2478 1433 1189 16552 2478 694 1824 16553 2478 9942 694 16554 7692 7760 6775 16555 7692 2205 7760 16556 1834 6920 223 16557 1834 223 1189 16558 3531 8469 2904 16559 2904 6782 3642 16560 2904 8469 6782 16561 3341 76 7003 16562 3028 6348 4674 16563 3028 4674 9643 16564 3028 9643 6405 16565 3028 8102 4317 16566 3028 4317 9902 16567 3028 6405 8102 16568 3028 9902 4816 16569 3028 4816 6348 16570 4317 8102 1909 16571 101 6183 8512 16572 101 4051 6183 16573 101 5216 4051 16574 2228 6251 1957 16575 2228 5331 6251 16576 1215 1512 1676 16577 1215 9928 1512 16578 1215 7262 9928 16579 7773 5623 9287 16580 7773 9287 1735 16581 7773 1735 6043 16582 3319 3891 3814 16583 3319 3814 2557 16584 3319 2557 6147 16585 3319 7558 3891 16586 3319 6147 7558 16587 7414 1975 726 16588 7414 1640 1975 16589 7414 7558 1640 16590 7414 5623 3891 16591 7414 3891 7558 16592 7414 9287 5623 16593 7414 726 9287 16594 2588 4479 3008 16595 2588 3008 9575 16596 2588 6980 4479 16597 2588 1390 6980 16598 2588 9518 1390 16599 5645 3501 429 16600 5645 429 7787 16601 6368 3210 7787 16602 8223 2042 8708 16603 6770 6246 2907 16604 2543 1888 2071 16605 2543 2071 5577 16606 2543 5577 7666 16607 6079 5577 2653 16608 6079 7666 5577 16609 8930 2797 9449 16610 8930 4611 1241 16611 8930 9449 183 16612 8930 183 4611 16613 8721 6002 7527 16614 8721 7527 8441 16615 8721 3741 6002 16616 8721 2361 3741 16617 8721 8441 9829 16618 4280 9829 1918 16619 9829 8441 1918 16620 2827 9180 3634 16621 4361 1250 7905 16622 4361 2634 1250 16623 4361 3352 2201 16624 4361 6956 3352 16625 4361 2201 2634 16626 942 9209 605 16627 6245 8730 1139 16628 6245 1250 8730 16629 6245 1024 1250 16630 1338 183 2777 16631 1338 2777 7959 16632 1338 9272 183 16633 1338 3305 965 16634 1338 7959 3305 16635 9136 1045 8118 16636 1195 6238 8047 16637 1195 3518 6238 16638 1195 8047 5563 16639 1195 5563 3518 16640 5343 7929 442 16641 5343 948 7929 16642 5343 7282 948 16643 5343 8506 7282 16644 5343 2187 8506 16645 7896 7539 3044 16646 7896 3044 916 16647 7896 1461 7539 16648 7838 1532 2454 16649 1843 2223 3048 16650 1843 3048 3774 16651 1843 3774 6802 16652 1843 6802 2806 16653 1288 3087 5989 16654 1288 5989 4804 16655 1172 9212 4968 16656 9296 4767 512 16657 903 442 7929 16658 903 7256 1134 16659 903 1134 6460 16660 903 7929 7256 16661 903 6460 9038 16662 7256 71 1134 16663 7256 7929 948 16664 7256 948 2351 16665 7256 2351 3314 16666 5377 3103 1104 16667 5254 4812 170 16668 5254 107 4812 16669 5254 4553 107 16670 2768 6168 409 16671 2768 3077 6168 16672 2768 3180 5323 16673 2768 5323 3077 16674 3180 6261 5323 16675 3180 2264 6261 16676 2502 4682 9631 16677 2502 9631 4561 16678 2502 9157 1528 16679 2502 1528 4682 16680 2502 4463 9157 16681 2502 4561 4463 16682 9157 4463 409 16683 9157 409 6168 16684 9157 6168 7519 16685 9157 7519 3845 16686 9157 8990 1528 16687 9157 3845 8990 16688 1788 4463 9343 16689 1788 409 4463 16690 459 4463 4561 16691 459 9343 4463 16692 459 5742 9343 16693 5297 8758 1704 16694 5297 7763 8758 16695 5297 9084 7763 16696 1290 8618 6335 16697 1290 4259 8618 16698 1290 6335 269 16699 1290 269 4259 16700 1528 8990 725 16701 8900 9631 4682 16702 3446 7924 7504 16703 7478 6149 382 16704 7478 382 3564 16705 9494 5122 6149 16706 9494 2560 5122 16707 7270 3362 1353 16708 7270 3565 3362 16709 7270 1353 1263 16710 7270 238 3565 16711 1353 3362 4856 16712 1353 3950 1263 16713 9179 6676 7189 16714 9179 3540 6676 16715 9179 5271 6285 16716 9179 6285 3540 16717 9179 1719 5271 16718 9179 7189 1719 16719 1719 5462 5271 16720 1719 7189 367 16721 1719 367 5462 16722 6620 4186 8539 16723 6620 7410 4186 16724 6620 8539 5963 16725 6620 5963 7410 16726 6904 8539 4186 16727 6904 4661 8539 16728 6904 4186 6976 16729 6904 8061 4661 16730 6904 6976 867 16731 6904 867 8865 16732 6904 8865 8061 16733 758 7438 8771 16734 758 5134 7438 16735 758 8771 5619 16736 758 5619 5866 16737 758 5866 5134 16738 1986 2317 7046 16739 1986 7046 2051 16740 1986 2051 5029 16741 1986 5029 1698 16742 5029 2051 4521 16743 5029 1473 1698 16744 5029 687 1473 16745 5029 5407 687 16746 5029 4521 5407 16747 1882 2726 5619 16748 1882 6819 2726 16749 1882 484 8933 16750 1882 5619 484 16751 1882 8933 8166 16752 1882 8166 9271 16753 3323 9406 8175 16754 3323 40 9406 16755 7619 7967 7188 16756 7619 7188 8873 16757 5053 1042 2482 16758 5053 7967 1042 16759 5053 7188 7967 16760 5053 3778 7188 16761 5053 2482 3778 16762 150 6509 2057 16763 150 2057 40 16764 1333 1005 679 16765 8965 2045 6995 16766 8526 1005 4437 16767 8526 679 1005 16768 9517 7566 1044 16769 3680 6842 8424 16770 2823 5751 9305 16771 2823 9305 1926 16772 2823 6842 5751 16773 2823 8424 6842 16774 2823 1926 8424 16775 4943 9305 5751 16776 4943 1620 9305 16777 4943 5751 8095 16778 4943 8095 1620 16779 6961 7434 9151 16780 6961 4340 118 16781 6961 9151 4340 16782 5059 4330 1973 16783 2450 3289 6730 16784 2450 6730 9580 16785 4395 3701 6585 16786 4395 6677 3701 16787 4395 6585 9215 16788 7068 7381 6585 16789 7068 5468 7381 16790 7068 6585 3701 16791 6660 9602 8447 16792 6660 8543 9602 16793 2155 5032 8543 16794 2155 3661 5032 16795 931 8853 4408 16796 5478 666 2382 16797 5118 5537 1309 16798 5118 1309 303 16799 5118 4192 5537 16800 5118 303 8045 16801 4852 9806 9060 16802 2941 2052 3759 16803 2941 3759 198 16804 920 994 344 16805 9609 713 9963 16806 1120 6106 667 16807 1120 667 3163 16808 7005 7781 4053 16809 140 6998 4128 16810 140 2980 6998 16811 6998 5316 4128 16812 5006 5438 4595 16813 5006 4595 4914 16814 5006 5332 5438 16815 960 6982 2910 16816 960 2910 5575 16817 960 5575 8547 16818 960 8547 7930 16819 3682 4219 5745 16820 3682 9043 4219 16821 3682 1411 70 16822 3682 70 9043 16823 8016 5339 3649 16824 8016 3649 6779 16825 8016 2733 6982 16826 8016 6779 2733 16827 8168 1090 2551 16828 742 2498 6044 16829 6832 4186 7410 16830 6832 7410 8887 16831 8316 2498 8949 16832 8316 6044 2498 16833 949 194 552 16834 2053 3136 7755 16835 3331 2657 576 16836 3331 8592 2657 16837 3331 8638 8592 16838 3331 4366 8638 16839 3331 576 4366 16840 9949 9708 6935 16841 9949 9097 9708 16842 9949 6935 4439 16843 3045 6935 9708 16844 3045 9708 6757 16845 9717 8666 1186 16846 2477 8638 5290 16847 2477 5290 573 16848 2477 8592 8638 16849 2477 1307 8592 16850 1577 8980 290 16851 1577 717 8980 16852 3096 4773 1942 16853 1437 2850 569 16854 1437 1341 6800 16855 1437 6800 1942 16856 1437 569 1341 16857 2541 9341 6640 16858 2541 6640 545 16859 2541 545 3900 16860 636 142 9341 16861 636 7029 142 16862 4805 5657 12 16863 4805 12 8326 16864 4805 1501 5657 16865 5821 3107 8714 16866 4461 1316 5753 16867 4461 5753 6734 16868 4461 6734 3107 16869 4461 1744 79 16870 4461 2411 1744 16871 4461 79 1316 16872 4461 3107 2411 16873 8259 5277 5598 16874 8259 5598 8325 16875 8259 1394 5277 16876 8259 8345 1394 16877 8259 8325 8345 16878 6415 1332 1973 16879 6415 1973 2321 16880 6415 2321 6446 16881 4334 9134 5174 16882 8402 5781 1237 16883 8402 9862 2336 16884 8402 2336 7857 16885 8519 1785 2799 16886 8519 3325 1785 16887 8519 8993 3325 16888 1499 1785 7159 16889 1499 555 6553 16890 6298 3029 8251 16891 6298 8251 7086 16892 4131 5582 4045 16893 4131 3586 6692 16894 738 1964 3874 16895 2049 8524 8537 16896 2049 644 8524 16897 79 2272 8752 16898 79 1744 2272 16899 79 8752 2193 16900 79 2193 1316 16901 8752 8984 2193 16902 8752 6870 8984 16903 8752 2272 2263 16904 6199 2652 8644 16905 6199 8644 5705 16906 1389 6380 5069 16907 1389 2390 6380 16908 1389 5069 3532 16909 1389 3532 6054 16910 3615 5322 12 16911 2128 4128 5316 16912 2128 2689 4128 16913 1791 6613 6137 16914 1791 6137 968 16915 6137 4863 968 16916 1618 262 968 16917 1618 968 4863 16918 1618 4863 4956 16919 1618 4956 3815 16920 9112 4975 7709 16921 9112 7709 950 16922 9112 950 8104 16923 9112 6732 4128 16924 9112 4128 4975 16925 9112 1928 6732 16926 9112 3429 1928 16927 9112 100 3429 16928 9112 8104 100 16929 6017 6725 5069 16930 6017 9836 6725 16931 6017 5069 6380 16932 6017 6380 7234 16933 6017 7234 6505 16934 6017 6505 9836 16935 4181 5737 7817 16936 4181 7071 5737 16937 4181 1761 7403 16938 4181 7403 7071 16939 4181 9220 1761 16940 7403 5758 1479 16941 7403 504 5758 16942 7403 2574 504 16943 7403 1761 2574 16944 7403 1479 7071 16945 2862 8387 988 16946 4883 2027 6745 16947 4883 6134 3550 16948 2241 5768 6081 16949 2241 9971 5768 16950 2241 6081 4289 16951 2241 2667 9971 16952 3062 8143 1712 16953 3062 4753 8143 16954 3062 1712 8234 16955 3062 984 7083 16956 3062 7083 4753 16957 3062 3588 984 16958 3062 8234 3588 16959 4993 9957 4748 16960 2349 4748 776 16961 2349 776 9808 16962 2349 9808 5885 16963 2906 180 8828 16964 7131 4557 7851 16965 7131 4103 4557 16966 7131 9217 4103 16967 5910 2077 4540 16968 5910 4540 8277 16969 5910 6667 2077 16970 5910 2816 8217 16971 5910 8277 2816 16972 5910 8217 6745 16973 5910 6745 6667 16974 9442 86 5078 16975 6852 3905 4754 16976 5078 86 6753 16977 6248 9570 2328 16978 6248 2328 301 16979 6248 6753 9570 16980 9117 6667 3850 16981 9117 3850 2027 16982 9117 2077 6667 16983 9117 4540 2077 16984 4540 207 8277 16985 2975 6672 5430 16986 2975 6098 6672 16987 2975 3183 6098 16988 4790 3146 8782 16989 4790 8782 8388 16990 4790 8388 2048 16991 8782 9600 8388 16992 5653 7510 3519 16993 5653 521 7510 16994 5653 328 521 16995 1892 7718 9846 16996 1286 1163 7675 16997 1286 7675 5828 16998 9570 5787 2328 16999 9570 3326 5787 17000 4699 3115 2313 17001 4699 6576 3115 17002 4699 2313 3326 17003 2898 3799 6427 17004 2898 6427 4901 17005 2898 734 3162 17006 2898 3162 3799 17007 2898 4901 734 17008 537 1727 8801 17009 537 3115 1727 17010 537 2313 3115 17011 7870 8916 3671 17012 7870 6375 8916 17013 7870 3640 6375 17014 8826 5750 8616 17015 8826 8616 20 17016 541 9290 5389 17017 7354 9160 4263 17018 7354 4263 8372 17019 5913 7842 3490 17020 5913 3490 4448 17021 1492 2420 7647 17022 1492 7647 4865 17023 1492 1383 2420 17024 1492 4342 1383 17025 1492 5750 8064 17026 1492 4865 5750 17027 1492 8064 4342 17028 2413 1937 3597 17029 9088 7212 709 17030 9088 9493 7212 17031 1805 9801 4083 17032 3855 5737 5754 17033 3855 7817 5737 17034 3855 5754 2418 17035 5557 7453 5885 17036 1745 1513 6773 17037 8938 2080 8917 17038 8938 8917 347 17039 8938 5011 2080 17040 8938 770 370 17041 8938 347 770 17042 3948 5354 9998 17043 3948 9998 5011 17044 3948 9601 5354 17045 7455 6915 592 17046 7455 592 2353 17047 7455 9122 6915 17048 7455 4673 9122 17049 7455 2353 4673 17050 9798 6702 4129 17051 9798 2816 6702 17052 9798 7691 6000 17053 9798 6000 2816 17054 9798 4129 7691 17055 5647 4680 9769 17056 4286 5354 9601 17057 2784 5464 2353 17058 2784 2353 249 17059 2784 249 9702 17060 6740 7691 4129 17061 6740 4129 3806 17062 6740 9766 7691 17063 9856 9998 2268 17064 9856 2268 3966 17065 9856 5011 9998 17066 9856 2080 5011 17067 9856 8917 2080 17068 9856 6743 8917 17069 9856 3966 6743 17070 1679 4245 3288 17071 1679 3288 9972 17072 5852 1162 6489 17073 9870 8732 2881 17074 9870 4089 9789 17075 9870 9789 8732 17076 9870 4448 506 17077 9870 506 4089 17078 8842 2387 8372 17079 8842 4651 2387 17080 8842 8372 273 17081 8842 273 9769 17082 8842 9769 4651 17083 3117 6889 4758 17084 3117 4758 121 17085 3117 121 3796 17086 4654 4684 7133 17087 4654 7133 4768 17088 7652 4176 2169 17089 5799 7268 9930 17090 3956 2002 4176 17091 3956 7954 2002 17092 3956 4176 2394 17093 3956 9657 3664 17094 3956 3664 7954 17095 3956 4992 9657 17096 3956 2394 4992 17097 7059 799 2169 17098 7059 2169 4176 17099 7059 4176 2002 17100 3926 571 5788 17101 3926 6650 571 17102 3926 5954 799 17103 6324 8540 6257 17104 6324 4530 8540 17105 6324 9396 4530 17106 6324 7179 9396 17107 6324 6257 7179 17108 7370 6257 563 17109 7370 7179 6257 17110 9396 7179 1536 17111 7782 3608 5739 17112 7782 3484 3732 17113 7782 3732 3608 17114 9524 9063 4337 17115 9524 4337 3763 17116 3263 8094 4778 17117 3263 8514 8094 17118 4778 8094 5867 17119 4778 5867 8322 17120 4778 4217 3807 17121 4778 8322 4217 17122 3807 2619 1756 17123 3807 4217 2619 17124 6874 1756 2619 17125 6874 2619 2153 17126 6874 2153 4231 17127 6874 2461 9946 17128 6874 4231 2461 17129 7552 4157 5595 17130 1996 4270 7628 17131 1996 7628 5565 17132 1996 2127 4270 17133 1996 9532 3507 17134 1996 5565 9532 17135 1996 3507 4763 17136 1996 4763 4046 17137 1624 842 7126 17138 1624 8655 842 17139 4763 1629 8655 17140 4763 3507 1629 17141 4763 6502 4046 17142 4763 8655 6502 17143 6867 8905 7087 17144 1877 5739 8905 17145 8399 3350 4746 17146 8399 4746 4373 17147 5349 5200 2534 17148 5349 4193 5200 17149 3714 476 5793 17150 3714 450 476 17151 2534 8848 576 17152 2534 5200 8848 17153 7557 8095 2698 17154 7557 2698 7527 17155 7557 7527 6002 17156 7557 6002 6386 17157 7557 6386 4178 17158 7557 4178 2021 17159 7557 2021 8095 17160 2431 532 7053 17161 2431 4005 532 17162 2431 7053 9089 17163 9027 8652 3346 17164 3764 1123 7799 17165 3764 7060 1123 17166 8793 277 5224 17167 3756 277 1925 17168 3756 9019 5230 17169 1639 8014 7662 17170 1639 3815 2170 17171 1639 2170 1381 17172 1639 1381 8014 17173 4956 7999 337 17174 4956 5265 3815 17175 7799 1123 2626 17176 337 7108 6180 17177 9833 7797 2999 17178 9833 3779 8070 17179 9833 8070 7797 17180 9833 2967 3779 17181 8070 1923 8781 17182 8070 3779 1923 17183 8070 8781 9987 17184 8070 9987 7797 17185 1806 7315 1094 17186 1806 4039 7315 17187 5700 9199 3526 17188 5700 8105 9199 17189 448 4185 6105 17190 448 6105 2945 17191 448 2945 8909 17192 9987 4587 769 17193 9987 8781 4587 17194 9987 769 5399 17195 9987 5399 6155 17196 5284 6484 8377 17197 4765 1371 4735 17198 4765 4735 3738 17199 1471 1602 97 17200 794 8185 2040 17201 9627 9615 9761 17202 4737 3920 8559 17203 4737 8559 8044 17204 4737 8044 3635 17205 4737 3635 5884 17206 9459 1373 8996 17207 3920 2908 8559 17208 3920 9807 2908 17209 3920 9624 9807 17210 8343 8559 2908 17211 8343 2908 2952 17212 8343 2952 8044 17213 8343 8044 8559 17214 3440 6937 971 17215 3440 1036 6937 17216 3440 9342 1036 17217 6937 8297 9349 17218 6937 1036 8297 17219 5943 4937 1234 17220 5943 1234 4155 17221 5943 4155 9624 17222 3125 4455 5243 17223 3125 5243 8358 17224 7946 8377 6484 17225 8297 1036 4953 17226 4728 8341 6833 17227 4728 1831 8341 17228 9497 7253 875 17229 9497 7612 7253 17230 9497 4473 387 17231 9497 9733 4473 17232 9497 875 9733 17233 3311 6209 1268 17234 3311 1268 3038 17235 3311 8601 6209 17236 509 8601 5940 17237 8601 2952 6209 17238 1373 8295 8996 17239 3391 2495 2198 17240 4597 862 3291 17241 4421 1619 2883 17242 4421 3506 1619 17243 9121 2883 1619 17244 9121 1619 3953 17245 385 4940 8606 17246 385 8606 3953 17247 385 3953 3692 17248 1495 1619 3506 17249 1495 3506 528 17250 1495 528 7512 17251 1495 7512 3692 17252 1495 3692 1619 17253 7512 528 8786 17254 7512 7099 5797 17255 691 2231 9520 17256 9598 6821 340 17257 9598 3010 6821 17258 9598 322 6771 17259 9598 6771 3010 17260 3089 3010 6771 17261 9243 6771 322 17262 9243 322 812 17263 8017 8786 5386 17264 2352 7796 7522 17265 2352 7522 1896 17266 2352 9691 7796 17267 2352 9014 9691 17268 9691 2456 7796 17269 9691 9014 2456 17270 1646 274 560 17271 1646 560 7405 17272 8084 9816 1177 17273 7644 750 9346 17274 7644 9346 1541 17275 7644 1541 6957 17276 6862 6038 6447 17277 6862 6447 1462 17278 8407 813 3661 17279 8407 3661 7580 17280 8407 6870 813 17281 8407 6897 6870 17282 8407 7580 6897 17283 6097 8472 5307 17284 6097 8959 8472 17285 6097 5307 7604 17286 6097 7604 6487 17287 6097 6487 3872 17288 6097 3872 2263 17289 2263 2272 2088 17290 2263 2088 4756 17291 2085 2364 8059 17292 2085 8059 287 17293 2085 1 8909 17294 2085 802 1 17295 2085 8909 8007 17296 2085 287 802 17297 2085 8007 2364 17298 5307 3883 844 17299 5307 8472 3883 17300 5307 4593 7604 17301 5307 844 4593 17302 5123 1574 9213 17303 4542 4870 4001 17304 4542 4001 168 17305 4542 8179 5737 17306 5758 2248 1479 17307 5758 504 988 17308 5758 988 4507 17309 5758 4507 3246 17310 5758 3246 2998 17311 5758 2998 2248 17312 4870 2998 4001 17313 4870 9419 2998 17314 1820 2785 8686 17315 1820 2879 2785 17316 1820 180 3297 17317 1820 3297 8189 17318 1820 8189 2879 17319 1820 8686 180 17320 3578 8686 2785 17321 3578 709 7212 17322 3578 7212 5725 17323 3578 5725 8686 17324 6799 9168 2932 17325 2081 3804 1531 17326 2081 1531 5516 17327 2081 8966 4363 17328 2081 5516 8966 17329 2903 9171 6702 17330 2903 6702 1531 17331 2903 1531 3804 17332 5259 4336 1921 17333 5259 1921 8028 17334 3566 6936 4560 17335 3566 6537 4141 17336 1084 4560 6936 17337 1084 9938 5543 17338 7174 8290 26 17339 7174 26 9766 17340 1356 1569 592 17341 1356 592 6915 17342 1356 9122 7248 17343 1356 6915 9122 17344 1356 9255 1569 17345 7683 9854 3905 17346 7683 3905 807 17347 7683 807 5226 17348 9854 2281 3905 17349 1247 1817 8079 17350 2455 1813 6933 17351 2455 4876 1813 17352 2455 5414 3492 17353 2455 189 5414 17354 2455 6933 189 17355 2455 3492 4876 17356 4752 3492 4210 17357 1829 5234 8255 17358 1829 4599 5234 17359 1829 9597 4599 17360 6657 51 3179 17361 51 8198 5706 17362 51 1822 3179 17363 2926 7895 773 17364 2926 8758 7895 17365 7895 8758 7518 17366 6775 7760 2287 17367 3382 4797 7617 17368 3382 7617 3169 17369 3382 3169 3360 17370 1515 8859 332 17371 1515 332 7617 17372 1515 7617 4797 17373 76 9923 7003 17374 4674 7765 1310 17375 4674 1310 4114 17376 4674 6348 7765 17377 4674 4114 9643 17378 7832 2069 7669 17379 7832 7312 2069 17380 7832 7669 2526 17381 5239 8718 5596 17382 8512 8794 2753 17383 8512 6183 8794 17384 5513 5886 4051 17385 5513 1545 5886 17386 5335 8304 2038 17387 5335 2038 28 17388 5335 28 548 17389 6985 1957 8560 17390 6985 7459 1957 17391 6985 3051 7459 17392 6985 8560 3051 17393 1957 833 7861 17394 1957 5886 833 17395 1957 5948 5886 17396 1957 7861 8560 17397 1957 6251 5948 17398 7262 9150 9928 17399 8183 2972 7679 17400 8183 6974 2972 17401 8183 9106 6974 17402 8183 791 9106 17403 6974 6227 2972 17404 6974 1641 6227 17405 6974 9106 1641 17406 7558 5626 1846 17407 7558 6147 5626 17408 7558 1846 1640 17409 726 1594 388 17410 726 388 9287 17411 726 9230 1594 17412 726 1975 9230 17413 7839 1948 3008 17414 7839 3008 4479 17415 7839 2576 1948 17416 3008 1948 5560 17417 3008 5560 9575 17418 6980 4681 4479 17419 6980 1390 4681 17420 6246 2071 5266 17421 6246 7788 2071 17422 6246 3625 7788 17423 6246 5266 2907 17424 8080 2071 1888 17425 8080 5266 2071 17426 2669 550 9828 17427 2201 6273 2634 17428 2201 6085 6273 17429 2201 3352 6085 17430 9449 6383 2777 17431 9449 2797 6383 17432 9449 2777 183 17433 3501 8288 1241 17434 3501 1241 7800 17435 3501 5957 429 17436 3501 7800 5957 17437 429 9272 6919 17438 429 5957 9272 17439 2361 1139 6494 17440 2361 6494 5075 17441 2361 5075 3741 17442 1918 8441 2698 17443 8475 965 3305 17444 8475 3305 6956 17445 1024 7905 1250 17446 3305 7959 6956 17447 1907 6439 7440 17448 1907 3269 4500 17449 1907 4500 7611 17450 5563 2061 3518 17451 1296 2351 7807 17452 1296 6698 2351 17453 7282 8734 7738 17454 7282 7738 948 17455 7282 8506 8734 17456 2187 8036 8506 17457 2187 1119 8036 17458 9445 7807 7738 17459 9445 7738 8734 17460 9445 461 2061 17461 9445 2061 7807 17462 9445 8734 8036 17463 9445 8036 8562 17464 9445 8562 461 17465 6940 5336 814 17466 1532 1386 7310 17467 1532 7407 1386 17468 1532 7310 2454 17469 2223 916 3048 17470 71 7922 1134 17471 4812 10000 7922 17472 4812 107 10000 17473 6875 2101 4664 17474 6875 4664 8798 17475 6875 4858 7469 17476 6875 6958 4858 17477 6875 8798 6958 17478 6875 7469 2101 17479 251 6741 4033 17480 251 4033 4917 17481 251 7494 6741 17482 251 3602 7913 17483 251 7913 7494 17484 251 4917 3602 17485 6451 5761 3914 17486 6451 3914 3749 17487 6451 1812 5761 17488 6451 3713 1812 17489 6451 3749 3713 17490 9343 5742 513 17491 4495 298 7342 17492 4495 7342 9084 17493 4495 269 298 17494 6335 8618 2297 17495 6335 2297 298 17496 6335 298 269 17497 3698 8664 4158 17498 3698 379 8664 17499 3698 4158 4995 17500 3698 4995 8798 17501 3698 8798 379 17502 3845 9530 8990 17503 3845 7519 9530 17504 2994 2778 6149 17505 2994 6149 5122 17506 2994 5122 7827 17507 2994 7827 2778 17508 6149 2778 382 17509 5194 3442 6873 17510 5194 3931 3442 17511 5194 6873 4233 17512 5194 4233 7827 17513 5194 7827 1500 17514 5194 1500 3931 17515 238 5462 3565 17516 4022 6410 8918 17517 6285 2773 7620 17518 6285 7620 3540 17519 3362 4234 940 17520 3362 940 1158 17521 3362 9369 4234 17522 3362 3565 9369 17523 3362 1158 4856 17524 940 2436 2839 17525 940 4679 2436 17526 940 4234 367 17527 940 367 4679 17528 940 2839 1158 17529 7189 179 697 17530 7189 7479 179 17531 7189 6676 7479 17532 7189 697 367 17533 8539 2427 9379 17534 8539 9379 5963 17535 8539 4661 2427 17536 8061 4966 2427 17537 8061 474 4966 17538 8061 2427 4661 17539 8061 8865 474 17540 7410 5963 1670 17541 7410 1670 7923 17542 7410 7923 8887 17543 8887 8467 7423 17544 8887 7923 8467 17545 8771 7438 8933 17546 8771 8933 484 17547 8771 484 5619 17548 2968 2188 831 17549 2968 831 643 17550 2968 5191 2188 17551 2968 643 333 17552 2968 333 5191 17553 5223 751 5481 17554 5223 333 751 17555 5223 1698 1473 17556 5223 1473 333 17557 7642 2427 1507 17558 7642 9379 2427 17559 7642 1133 9379 17560 7642 1507 7955 17561 7642 7955 1133 17562 356 9549 3744 17563 356 9271 9549 17564 8933 7438 8166 17565 1106 1042 935 17566 1106 935 987 17567 3625 1818 7788 17568 3625 6975 1818 17569 3625 935 2189 17570 3625 5012 935 17571 3625 2189 6975 17572 7188 3778 8873 17573 5603 1722 1047 17574 5603 1047 1700 17575 5603 5147 1722 17576 5603 1700 5147 17577 2304 831 2188 17578 2304 2188 7970 17579 2304 7008 831 17580 2304 7783 7008 17581 2304 9082 9994 17582 2304 9994 7783 17583 2304 7970 9082 17584 5714 8100 1267 17585 5714 1809 8100 17586 5714 8911 9513 17587 5714 9513 1809 17588 5714 8762 8911 17589 5714 1267 8762 17590 6329 2914 9513 17591 6329 8350 2914 17592 6329 9513 8911 17593 6329 9430 8689 17594 6329 8689 8350 17595 6329 8911 9430 17596 8762 6819 9430 17597 8762 2446 6819 17598 8762 9430 8911 17599 8762 1267 9193 17600 8762 9193 2446 17601 6509 4386 2057 17602 5751 2144 2698 17603 5751 2698 8095 17604 5751 6842 2144 17605 4695 6272 5415 17606 4695 9647 6272 17607 4695 5415 8524 17608 4695 8524 632 17609 4695 632 9647 17610 4197 5537 1490 17611 4197 1490 7618 17612 4197 7618 1974 17613 4197 243 144 17614 4197 1974 243 17615 4197 144 7525 17616 4197 7525 1309 17617 4197 1309 5537 17618 118 4781 1702 17619 118 4340 4781 17620 118 1702 4192 17621 1921 9429 8028 17622 4429 6827 9953 17623 4429 9953 1164 17624 4429 6446 754 17625 7681 372 35 17626 7681 35 1001 17627 7681 1001 4213 17628 7681 2503 372 17629 7681 4213 6827 17630 4213 1001 9953 17631 4213 9953 6827 17632 4587 6585 7381 17633 4587 7381 769 17634 4587 8781 1923 17635 7381 9842 5399 17636 7381 5399 769 17637 7381 5468 9842 17638 666 4666 2382 17639 2852 5569 4428 17640 2852 4428 3264 17641 2852 3264 5569 17642 1635 4209 7202 17643 1635 7202 4532 17644 1635 4532 3230 17645 1635 3874 2443 17646 1635 3230 3874 17647 1635 2443 4209 17648 8045 303 7202 17649 8045 7202 1549 17650 8045 1549 7434 17651 3759 2052 8113 17652 667 8764 3163 17653 4595 5438 2272 17654 4595 2272 1744 17655 4595 1744 2411 17656 5438 5332 2088 17657 5438 2088 2272 17658 2910 2733 3229 17659 2910 3229 5575 17660 2910 6982 2733 17661 5745 4219 5339 17662 2733 6779 3229 17663 8276 217 8760 17664 4747 6905 5209 17665 4366 717 5290 17666 4366 4721 717 17667 4366 5290 8638 17668 4366 576 4721 17669 7294 6728 8456 17670 9338 5793 476 17671 9338 2430 5793 17672 6800 1341 2104 17673 6800 2104 1593 17674 569 9666 1341 17675 3439 1341 9666 17676 3439 5081 1341 17677 3439 3900 5081 17678 7029 956 142 17679 6080 37 4801 17680 6080 715 37 17681 8326 715 698 17682 8326 12 715 17683 4420 8714 463 17684 4420 463 5713 17685 463 8714 6734 17686 463 6734 5713 17687 3107 6734 8714 17688 6135 5713 5682 17689 6135 5682 1501 17690 4024 1394 8345 17691 4024 869 1394 17692 4024 8345 5035 17693 4024 5035 9303 17694 4024 4720 6811 17695 4024 6811 5299 17696 4024 5299 3838 17697 4024 3838 869 17698 4024 9303 4720 17699 8345 3165 5035 17700 8345 2056 3165 17701 8345 8325 2056 17702 2884 3970 6811 17703 2884 6811 8201 17704 2884 6466 3970 17705 2884 4950 6466 17706 2884 5559 4950 17707 2884 8201 5559 17708 1980 6679 8387 17709 1150 5108 4685 17710 7857 2336 4685 17711 6553 7793 3586 17712 6553 555 7793 17713 7793 1912 3586 17714 8216 4706 8389 17715 8216 7052 4706 17716 4706 7052 5125 17717 8251 3029 369 17718 8251 8537 7086 17719 8537 8524 7086 17720 5571 8115 9654 17721 5571 4045 8115 17722 8115 733 9654 17723 8115 4045 5582 17724 8115 5582 4312 17725 8115 4312 733 17726 2193 1020 1316 17727 2193 8984 1020 17728 5753 1316 1020 17729 5753 1020 8610 17730 5753 5713 6734 17731 5753 5682 5713 17732 5753 8610 5682 17733 4670 70 3826 17734 4670 9043 70 17735 4670 5079 9043 17736 4670 3826 9189 17737 4670 9189 5079 17738 2652 37 3009 17739 2652 603 37 17740 2652 3149 8644 17741 2390 7177 6380 17742 2390 384 7177 17743 6458 1572 3097 17744 6458 8003 1572 17745 6458 3097 384 17746 6458 5657 8003 17747 3871 7662 2689 17748 3429 100 823 17749 4873 17 4436 17750 4873 5890 17 17751 4873 7990 5890 17752 4873 4436 8547 17753 4873 8547 7990 17754 7234 869 3838 17755 7234 6380 869 17756 7234 9444 6505 17757 7234 3838 9444 17758 3532 9452 6054 17759 3532 609 9452 17760 3532 5069 6725 17761 3532 6725 609 17762 1761 9220 2574 17763 5737 8363 5754 17764 5737 8179 8363 17765 1574 3122 9213 17766 3550 6134 7575 17767 4289 6081 3438 17768 4289 3438 8363 17769 4289 8363 8179 17770 7920 3438 6081 17771 7920 6081 5768 17772 7920 5768 3438 17773 984 5479 9192 17774 984 9192 7083 17775 984 3588 5479 17776 4557 8151 776 17777 4557 776 7851 17778 4557 943 8151 17779 3929 4083 9801 17780 3929 1866 4083 17781 3929 4788 1866 17782 3929 6785 2979 17783 3929 9801 6785 17784 9217 4509 4103 17785 9217 3467 4509 17786 9192 5479 2391 17787 8217 5226 807 17788 8217 2816 5226 17789 4754 3905 2281 17790 6667 6745 3850 17791 3183 6250 6098 17792 8122 3339 1076 17793 8122 2048 3339 17794 8122 1076 6402 17795 6881 9329 521 17796 6881 5952 9329 17797 6881 328 8616 17798 6881 8616 5952 17799 6881 521 328 17800 3519 7510 6879 17801 3519 6879 5155 17802 8616 5750 5952 17803 8359 5828 7675 17804 8359 7675 2076 17805 3339 2690 1076 17806 3339 2048 9567 17807 3326 2313 8916 17808 3326 8916 5787 17809 293 9846 6576 17810 734 7117 1727 17811 734 4901 7117 17812 734 1727 3162 17813 3671 8916 2313 17814 8916 6375 2328 17815 8916 2328 5787 17816 8801 1727 7117 17817 8801 7117 933 17818 8801 933 5139 17819 5750 4865 5952 17820 9160 9210 4263 17821 6295 3819 5587 17822 6295 8895 3819 17823 6295 4245 3508 17824 6295 5587 4245 17825 6295 2387 8895 17826 9290 1853 9876 17827 9290 9876 5389 17828 9493 826 7212 17829 9493 9986 826 17830 4083 1866 8687 17831 1983 10001 7052 17832 166 2073 7603 17833 1237 5781 646 17834 9122 2690 7248 17835 9122 4673 370 17836 9122 370 2690 17837 770 2242 1076 17838 770 347 2242 17839 770 1076 370 17840 4673 2353 5464 17841 7691 9766 6000 17842 6000 5226 2816 17843 6000 9766 26 17844 3288 6476 1518 17845 3288 1518 2406 17846 3288 2406 9972 17847 3288 6171 5074 17848 3288 5074 6476 17849 3288 4245 6171 17850 4089 506 6489 17851 4089 6489 4235 17852 4089 4235 9789 17853 8372 4263 273 17854 8731 3819 5289 17855 8731 6476 3819 17856 3796 8794 5331 17857 3796 121 8794 17858 9364 6967 5999 17859 9364 5999 8279 17860 9364 1031 6967 17861 7941 9650 5999 17862 7941 5999 6967 17863 7941 2103 9650 17864 7941 6967 1031 17865 4684 1031 7133 17866 9657 9930 3664 17867 799 5954 2169 17868 5812 3659 6650 17869 5812 6638 3659 17870 5812 982 6638 17871 5812 2933 982 17872 6257 8540 6354 17873 6257 6354 563 17874 4530 880 8540 17875 4530 7085 4014 17876 4530 4014 880 17877 4530 6965 7085 17878 7085 4472 4014 17879 7085 6965 4472 17880 5095 1344 9450 17881 5095 9450 8302 17882 5095 7290 9354 17883 5095 8302 7290 17884 5095 9354 4802 17885 5095 4802 1344 17886 9681 2116 9959 17887 9681 9959 1039 17888 9681 5991 4802 17889 9681 1039 5991 17890 9681 4802 2116 17891 3484 2811 9063 17892 9063 1401 4337 17893 9063 6258 1966 17894 9063 2811 6258 17895 8094 8514 5867 17896 8322 5699 4217 17897 8322 224 5699 17898 8322 5867 224 17899 2135 1966 6258 17900 2135 6258 9435 17901 8970 6577 4529 17902 8970 4529 2153 17903 8970 2619 4217 17904 8970 4217 5699 17905 8970 5699 6577 17906 8970 2153 2619 17907 5994 7223 8157 17908 5994 7581 7223 17909 6971 5264 5595 17910 5595 16 7407 17911 5595 4157 16 17912 6094 5838 3131 17913 6094 3131 3443 17914 6094 405 5838 17915 6094 5198 405 17916 6094 3443 5198 17917 4649 7126 842 17918 4649 3131 5838 17919 4649 5838 7581 17920 4649 842 9141 17921 4649 9141 3131 17922 9141 8655 1629 17923 9141 842 8655 17924 9141 5511 3131 17925 9141 1629 5511 17926 405 7223 5838 17927 405 8157 7223 17928 405 5198 6031 17929 405 6031 8157 17930 3507 3303 1629 17931 3507 9532 1626 17932 3507 1626 9248 17933 3507 9248 3303 17934 1626 719 9248 17935 1626 9532 719 17936 8905 5739 7087 17937 450 2177 476 17938 3741 5075 5209 17939 3741 5209 6905 17940 3741 6905 6002 17941 4178 4932 2021 17942 4178 6118 4932 17943 4178 6386 6118 17944 3733 6205 9503 17945 3733 9503 6203 17946 3733 4386 6205 17947 9089 6264 4386 17948 9089 7053 6264 17949 8816 5841 824 17950 8816 824 8941 17951 8816 8941 8892 17952 8816 8892 5841 17953 161 6128 580 17954 5230 9475 6128 17955 4605 1381 2626 17956 4605 6170 8532 17957 4605 1993 6170 17958 4605 7060 1993 17959 4605 1123 7060 17960 4605 2626 1123 17961 7060 143 6918 17962 7060 6918 1993 17963 2170 3815 5265 17964 2170 2626 1381 17965 1899 7999 864 17966 1899 3346 8652 17967 1899 864 3346 17968 6170 7315 4039 17969 6170 3998 7315 17970 6170 4039 8532 17971 6170 1993 3998 17972 8780 3126 3563 17973 8780 9602 3126 17974 8780 6155 5399 17975 8780 5399 9842 17976 8780 9842 9602 17977 1946 4735 1371 17978 3738 4735 2925 17979 9615 7299 3373 17980 9615 3373 9761 17981 6167 7912 2746 17982 6167 6420 7912 17983 6167 2746 9871 17984 9342 4953 1036 17985 7340 4732 4135 17986 7369 9388 3879 17987 7369 3879 4599 17988 7369 4599 4455 17989 6511 149 3879 17990 6511 9029 149 17991 6511 3879 9388 17992 6310 9807 1268 17993 6310 2908 9807 17994 6310 1268 6209 17995 6310 6209 2952 17996 6310 2952 2908 17997 6713 9624 4155 17998 6713 9807 9624 17999 6713 3038 9807 18000 6713 4155 1234 18001 3624 3194 4757 18002 3624 9761 3194 18003 5052 1186 8666 18004 3506 5625 528 18005 3692 3953 1619 18006 2231 6021 9520 18007 8786 528 5386 18008 2704 1136 8341 18009 2704 8341 4793 18010 2704 1056 1136 18011 2704 4793 9176 18012 2704 9176 6447 18013 2704 6447 1056 18014 4689 1541 9346 18015 4689 9346 8005 18016 4689 5533 1541 18017 4689 8005 219 18018 4689 219 5533 18019 4804 5989 5601 18020 4804 5601 6038 18021 5138 6577 5699 18022 5138 5699 8260 18023 5138 9280 6577 18024 813 5032 3661 18025 813 9904 5032 18026 813 2931 9904 18027 813 5352 2931 18028 8007 8909 4669 18029 8007 4669 2364 18030 1 802 8105 18031 7604 4593 5352 18032 7604 5352 6487 18033 844 6588 4593 18034 844 3883 6588 18035 6250 3411 6098 18036 6250 5543 3411 18037 9419 2248 2998 18038 9419 1479 2248 18039 4507 988 35 18040 4507 35 372 18041 2879 8189 1922 18042 2879 1922 133 18043 2879 133 2785 18044 9031 453 771 18045 2466 3050 9960 18046 2087 5153 9143 18047 4363 8966 5153 18048 9171 4129 6702 18049 9171 3806 4129 18050 1531 2780 5516 18051 1531 6702 2780 18052 6708 2165 6672 18053 6708 8966 2165 18054 6708 5153 8966 18055 6708 9143 5153 18056 6708 9938 9143 18057 6708 6672 9938 18058 1569 7368 592 18059 6833 8341 1136 18060 6833 1136 4732 18061 2746 7912 8564 18062 2746 8564 9871 18063 6186 7912 6420 18064 6186 2545 7912 18065 3492 5414 4210 18066 5706 8255 5321 18067 3179 4259 269 18068 3179 1822 4259 18069 8758 7763 9084 18070 8758 9084 8382 18071 8758 8382 8716 18072 8758 8716 7518 18073 3642 1007 8859 18074 3642 6782 1007 18075 1909 8102 2708 18076 1909 2708 9923 18077 6864 7765 3699 18078 6864 1310 7765 18079 6864 3699 6020 18080 6348 3699 7765 18081 2526 7669 8902 18082 2526 8902 8735 18083 2526 8735 4114 18084 2526 4114 1310 18085 6156 289 8484 18086 6156 8484 9960 18087 6156 6084 289 18088 6156 4473 5391 18089 6156 9960 4473 18090 6156 5391 6084 18091 6913 1219 8409 18092 6913 8409 3842 18093 6913 7253 5442 18094 6913 3842 7253 18095 6913 5442 1219 18096 2753 8794 8405 18097 2753 8405 5442 18098 875 6866 9733 18099 875 7253 6866 18100 4051 5948 6183 18101 4051 5886 5948 18102 2038 2054 28 18103 7459 3051 8304 18104 8560 8815 3051 18105 8560 7861 8815 18106 7679 6227 8912 18107 7679 8912 300 18108 7679 2972 6227 18109 791 8047 9106 18110 3725 3823 5827 18111 3725 8645 3823 18112 3725 5827 3253 18113 3725 3253 8645 18114 1641 5827 6227 18115 1641 4253 5827 18116 1641 6238 4253 18117 1641 9106 6238 18118 4253 3253 5827 18119 4253 3583 3253 18120 4253 6238 3583 18121 2469 3366 1006 18122 2469 6175 3366 18123 2469 1006 6175 18124 607 4390 3814 18125 607 237 4390 18126 607 3814 421 18127 607 421 7835 18128 607 7835 3453 18129 607 3453 237 18130 9230 4270 1261 18131 9230 1261 1594 18132 9230 7628 4270 18133 9230 1975 7628 18134 5560 7956 9575 18135 3782 9828 3516 18136 1887 2132 6383 18137 1887 6383 6085 18138 1887 3352 2777 18139 1887 2777 2132 18140 1887 6085 3352 18141 2634 6273 5232 18142 2634 5232 1250 18143 183 9272 5957 18144 183 5957 4611 18145 8288 1660 1241 18146 1139 8730 6494 18147 8441 7527 2698 18148 2061 461 3518 18149 8047 6238 9106 18150 2351 6698 3314 18151 2351 948 7738 18152 2351 7738 7807 18153 8506 8036 8734 18154 8562 5301 6993 18155 8562 7559 5301 18156 8562 5551 461 18157 8562 6993 5551 18158 8562 8036 7559 18159 8036 1119 2327 18160 8036 2327 7559 18161 1940 2867 6949 18162 1940 6949 3333 18163 1940 1127 2867 18164 1940 3333 1119 18165 7310 3044 2454 18166 7310 916 3044 18167 7310 3774 916 18168 7310 1386 3774 18169 3048 916 3774 18170 7023 4968 9212 18171 1134 7922 6460 18172 4553 7440 6439 18173 9815 5181 6083 18174 9815 8 5181 18175 9815 1823 5904 18176 9815 6083 1823 18177 2442 3358 2567 18178 2442 1477 3358 18179 2442 2567 8271 18180 2442 8286 6022 18181 2442 8271 8286 18182 2442 6022 9626 18183 2442 9626 4917 18184 2442 4917 1477 18185 7469 458 2101 18186 7469 947 458 18187 7469 4858 947 18188 3602 4400 7913 18189 3602 4917 4400 18190 1595 3366 1571 18191 1595 1571 7051 18192 1595 7051 1847 18193 1595 1847 2522 18194 1595 2522 1006 18195 1595 1006 3366 18196 2159 6932 4195 18197 2159 4195 451 18198 2159 451 1828 18199 2159 1828 6932 18200 3713 4272 1812 18201 3713 3749 1434 18202 3713 1434 4272 18203 4526 3077 5323 18204 4526 5323 1994 18205 4526 6168 3077 18206 4526 7519 6168 18207 4526 1994 7519 18208 6261 5511 5323 18209 6261 2264 5511 18210 298 2297 5761 18211 298 5761 7342 18212 2297 3863 3914 18213 2297 8618 3863 18214 2297 3914 5761 18215 5321 4259 1822 18216 5321 6293 4259 18217 5321 8255 5234 18218 5321 5234 6293 18219 4158 3166 7441 18220 4158 8664 3166 18221 4158 7441 4995 18222 7063 768 9981 18223 7063 9981 2744 18224 7063 6026 1385 18225 7063 1155 6026 18226 7063 2744 1155 18227 7063 1385 768 18228 8990 9530 5626 18229 8990 5626 725 18230 5742 8716 513 18231 2560 1500 4175 18232 2560 3931 1500 18233 2560 4175 5122 18234 5122 4175 7827 18235 3981 1500 7827 18236 3981 4175 1500 18237 3981 7827 4175 18238 6873 9990 4233 18239 6873 3442 6506 18240 6873 6506 9990 18241 8660 1090 4856 18242 8660 2954 1090 18243 8660 4856 1158 18244 8660 1158 2839 18245 8660 2839 2954 18246 9369 3565 4234 18247 367 2831 106 18248 367 106 4679 18249 367 697 2831 18250 367 4234 5462 18251 5800 3984 7620 18252 5800 4228 3984 18253 5800 4068 7423 18254 5800 7620 4068 18255 5800 7423 8467 18256 5800 8467 4228 18257 1670 5963 5147 18258 1670 4228 7923 18259 1670 500 4228 18260 1670 5147 500 18261 5619 7940 7637 18262 5619 7637 5866 18263 5619 2726 7940 18264 6819 6729 9430 18265 6819 7589 6729 18266 6819 2446 3151 18267 6819 3151 2726 18268 643 831 333 18269 1473 687 6262 18270 1473 6262 333 18271 751 7008 2532 18272 751 2532 5481 18273 751 333 7008 18274 2532 6100 4396 18275 2532 2888 6100 18276 2532 7008 2888 18277 2532 4396 5481 18278 2317 5481 4396 18279 2317 4396 7046 18280 5407 9206 9379 18281 5407 4521 9206 18282 5407 9379 687 18283 552 194 9039 18284 552 1863 4966 18285 552 4966 8865 18286 552 9039 1863 18287 1507 1863 9453 18288 1507 9453 7955 18289 1507 2427 4966 18290 1507 4966 1863 18291 9271 1808 9549 18292 9271 7473 1808 18293 9271 8166 7473 18294 8175 3778 2482 18295 8175 9406 3778 18296 247 6689 6644 18297 247 6644 2356 18298 247 8873 6188 18299 247 14 8873 18300 247 2356 14 18301 247 6188 6689 18302 935 1042 2189 18303 8873 3778 6188 18304 4069 9016 1047 18305 4069 7046 9016 18306 4069 1722 5519 18307 4069 1047 1722 18308 4069 5519 7046 18309 1722 4521 2051 18310 1722 2051 5519 18311 1722 5525 4521 18312 1722 5147 5525 18313 9082 5143 7542 18314 9082 3018 5143 18315 9082 7970 3018 18316 9082 7542 9994 18317 8689 9430 6729 18318 8689 6729 4791 18319 8689 8897 8350 18320 8689 8755 8897 18321 8689 4791 8755 18322 8095 2021 2436 18323 8095 2436 1620 18324 5415 9048 8524 18325 5415 8997 9048 18326 5415 6272 8997 18327 144 243 7025 18328 144 7025 6718 18329 144 6718 7525 18330 4192 1702 1490 18331 4192 1490 5537 18332 754 6446 2321 18333 9953 1001 6679 18334 9953 6679 1164 18335 1693 468 8853 18336 5733 7580 7363 18337 3661 7363 7580 18338 468 4408 8853 18339 3281 9654 366 18340 3281 366 4666 18341 3281 5605 1311 18342 2382 4666 1723 18343 2382 1723 4532 18344 366 9654 733 18345 366 733 1723 18346 366 1723 4666 18347 4428 7158 3264 18348 2443 3120 1549 18349 2443 1549 4209 18350 2443 3874 3120 18351 7434 6714 9151 18352 7434 1549 6714 18353 2052 344 994 18354 2551 6363 6118 18355 2551 1090 6363 18356 5209 5075 9464 18357 5209 9464 1753 18358 5209 1753 6249 18359 4890 5290 717 18360 4890 573 5290 18361 1799 3959 4926 18362 1799 8644 3959 18363 1799 956 5705 18364 1799 5705 8644 18365 1799 4926 956 18366 6640 6560 7373 18367 6640 4926 6560 18368 6640 9341 4926 18369 6640 7373 545 18370 4720 1958 5559 18371 4720 5559 6811 18372 4720 9303 1958 18373 5035 1258 1958 18374 5035 3165 1258 18375 5035 1958 9303 18376 3970 6466 1421 18377 3970 1421 7052 18378 3970 7052 6811 18379 4950 5559 1958 18380 4950 1958 1258 18381 4950 6636 6466 18382 4950 1258 6636 18383 2288 7159 3325 18384 3325 7159 1785 18385 6679 988 8387 18386 6679 1001 988 18387 7086 9048 1964 18388 7086 8524 9048 18389 3826 70 6560 18390 3826 6560 9189 18391 9043 5079 9452 18392 9043 9452 4219 18393 6560 1411 9276 18394 6560 9276 7373 18395 6560 70 1411 18396 6560 3959 9189 18397 6560 4926 3959 18398 3149 5079 3959 18399 3149 3959 8644 18400 3149 9452 5079 18401 3149 6054 9452 18402 3009 37 5322 18403 37 603 4801 18404 37 12 5322 18405 37 715 12 18406 384 1064 7743 18407 384 7743 7177 18408 384 3097 1064 18409 761 104 3346 18410 761 3346 2041 18411 761 6613 104 18412 4975 4128 2689 18413 4975 2689 7709 18414 7930 8547 5081 18415 7930 5081 9276 18416 7930 9276 1411 18417 4436 17 2104 18418 4436 2104 5081 18419 4436 5081 8547 18420 6505 8182 6668 18421 6505 6668 9836 18422 6505 9444 8182 18423 6725 9836 609 18424 6380 9663 869 18425 6380 7177 9809 18426 6380 9809 9663 18427 5754 7911 2418 18428 5754 8363 7911 18429 1712 3467 8234 18430 1712 8143 3467 18431 3588 4748 2696 18432 3588 776 4748 18433 3588 8234 776 18434 3588 2696 5479 18435 7453 2418 7911 18436 9957 3334 5768 18437 9957 5768 2696 18438 9957 2696 4748 18439 8151 943 9808 18440 8151 9808 776 18441 7851 776 8234 18442 4103 5791 3297 18443 4103 4509 5791 18444 7083 8671 4753 18445 1767 2598 8671 18446 1767 8282 2598 18447 1767 9569 8282 18448 1767 440 9569 18449 6745 2027 3850 18450 5430 6672 2165 18451 5430 2165 207 18452 8203 1922 8189 18453 8203 201 1922 18454 8203 7094 4522 18455 8203 4522 201 18456 8203 7387 7094 18457 8203 6409 7387 18458 8203 8189 6409 18459 6402 1076 2242 18460 6402 2242 7933 18461 245 7084 9876 18462 245 9876 1853 18463 9600 10001 8388 18464 9600 20 10001 18465 7718 8388 6576 18466 7718 6576 9846 18467 3162 8388 10001 18468 3162 6576 8388 18469 3162 10001 201 18470 3162 1727 3115 18471 3162 2953 3799 18472 3162 93 2953 18473 3162 201 93 18474 3162 3115 6576 18475 1225 2235 7084 18476 4865 7647 5952 18477 6375 3640 301 18478 6375 301 2328 18479 6529 2353 592 18480 6529 7368 2353 18481 6529 592 7368 18482 347 8917 2242 18483 249 2353 7368 18484 6171 5587 5074 18485 6171 4245 5587 18486 2268 273 3966 18487 2268 9769 273 18488 4263 9210 273 18489 3966 9210 7609 18490 3966 7609 2647 18491 3966 273 9210 18492 3966 2647 6743 18493 8484 2380 6476 18494 8484 289 2380 18495 4680 5289 8895 18496 4680 8895 4651 18497 4680 4651 9769 18498 8214 548 28 18499 8214 3939 548 18500 8214 28 2054 18501 8214 9687 3939 18502 8214 2054 9687 18503 3794 9051 5767 18504 3794 5767 7981 18505 3794 7981 1748 18506 1188 3834 5010 18507 1188 4927 3834 18508 1188 9314 3939 18509 1188 3939 4927 18510 1188 5010 9314 18511 6889 9789 4235 18512 6889 548 9789 18513 6889 4235 4758 18514 5999 9650 9077 18515 5999 9077 8279 18516 7268 4091 9930 18517 2683 3549 4476 18518 2683 6610 3549 18519 2683 1872 6610 18520 2683 216 1872 18521 2683 4476 216 18522 2933 6748 982 18523 5788 571 4690 18524 5788 4690 5954 18525 571 6650 3659 18526 571 3659 3450 18527 571 3450 4768 18528 571 4768 4690 18529 6405 9643 2315 18530 6405 2315 669 18531 6405 669 8102 18532 4472 6965 6818 18533 4472 6818 2116 18534 4472 2116 56 18535 4472 56 4014 18536 9354 56 6787 18537 9354 7290 56 18538 9354 6787 4802 18539 4802 7278 1344 18540 4802 2860 7278 18541 4802 6787 2116 18542 4802 5991 2860 18543 9219 3087 2806 18544 9219 2806 6291 18545 9219 6291 2825 18546 9219 2825 9037 18547 9219 9037 9173 18548 9219 9173 3087 18549 1401 5966 4337 18550 4529 6577 2392 18551 4529 7283 2153 18552 4231 7283 6479 18553 4231 2153 7283 18554 4231 6479 9518 18555 4231 9518 2461 18556 4157 8411 1434 18557 4157 6031 8411 18558 4157 1434 8529 18559 4157 8529 16 18560 5198 3443 2264 18561 5198 2264 6031 18562 3131 5511 3443 18563 5838 7223 7581 18564 1629 5323 5511 18565 1629 3303 5323 18566 9248 719 3303 18567 4746 3350 9165 18568 4746 9165 4373 18569 6002 6905 6386 18570 2021 4932 2436 18571 6363 4932 6118 18572 6363 2839 2436 18573 6363 2436 4932 18574 6363 2954 2839 18575 6363 1090 2954 18576 2745 5545 4824 18577 2745 1143 5545 18578 2745 5456 1143 18579 8651 6988 8503 18580 8651 6053 6988 18581 1446 8892 8941 18582 1446 6053 8892 18583 1446 8872 3270 18584 1446 8941 8872 18585 1446 3270 6053 18586 8052 4822 8892 18587 8052 5124 4822 18588 8052 8892 6203 18589 8052 6995 5124 18590 8052 6203 9503 18591 4386 6264 2057 18592 1130 8478 7298 18593 1130 4822 8478 18594 1130 824 5841 18595 1130 7298 824 18596 1130 5841 8892 18597 1130 8892 4822 18598 9475 580 6128 18599 3038 1268 9807 18600 4757 3194 7299 18601 5625 378 528 18602 5625 6821 378 18603 7099 5238 5797 18604 6957 9176 4878 18605 6957 1541 9176 18606 219 8005 814 18607 219 814 5336 18608 219 5336 5533 18609 5989 9173 5601 18610 5989 3087 9173 18611 7538 5222 274 18612 3350 5041 9165 18613 3350 7087 5041 18614 8260 5867 8514 18615 8260 224 5867 18616 8260 5699 224 18617 8708 2392 3249 18618 5352 4593 2931 18619 6897 7580 5569 18620 6897 5569 6970 18621 6897 6970 4174 18622 6897 4174 6870 18623 3526 8014 1381 18624 3526 9199 8014 18625 802 287 100 18626 802 100 9199 18627 802 9199 8105 18628 8909 2945 4669 18629 4531 3991 3563 18630 4531 2945 3991 18631 4531 4669 2945 18632 4531 3563 4669 18633 4593 6588 2931 18634 271 1866 4788 18635 271 4788 826 18636 271 8687 1866 18637 271 826 8687 18638 2785 133 7353 18639 5516 2780 2165 18640 5516 2165 8966 18641 9938 6672 5543 18642 5543 6098 3411 18643 5543 6672 6098 18644 1136 6674 4732 18645 1136 1056 6674 18646 4135 4732 6674 18647 4135 6674 10 18648 4135 10 9029 18649 7912 2545 8564 18650 4876 6646 1813 18651 8716 8382 513 18652 9084 1812 8382 18653 9084 7342 1812 18654 8469 6444 6782 18655 8469 7003 6444 18656 7669 2069 2812 18657 7669 2812 8902 18658 8735 8338 2315 18659 8735 4401 8338 18660 8735 2315 9643 18661 8735 8902 4401 18662 8735 9643 4114 18663 5391 9733 6866 18664 5391 6866 6084 18665 5391 4473 9733 18666 5442 8405 1219 18667 5442 7253 7612 18668 7253 3842 6866 18669 635 1219 8405 18670 635 8405 4456 18671 635 4456 6489 18672 635 6489 8409 18673 635 8409 1219 18674 8304 3051 5767 18675 5948 6251 8794 18676 5948 8794 6183 18677 4944 4118 1735 18678 4944 3823 4118 18679 4944 6227 3823 18680 4944 8912 6227 18681 4944 1735 8912 18682 5827 3823 6227 18683 3583 1571 3366 18684 3583 3366 3253 18685 3583 6238 3518 18686 3583 3518 461 18687 3583 461 5551 18688 3583 5551 1571 18689 6175 3473 5272 18690 6175 7601 3473 18691 6175 5272 3366 18692 6175 1006 7601 18693 3814 4390 1385 18694 3814 1385 2557 18695 7835 6043 117 18696 7835 117 7255 18697 7835 8648 3453 18698 7835 7255 8648 18699 117 1735 4118 18700 117 6043 1735 18701 117 4118 7255 18702 4270 2127 1261 18703 5565 7628 9532 18704 1975 719 7628 18705 1975 3678 719 18706 1975 1640 3678 18707 4681 1390 6479 18708 9828 8802 3516 18709 3352 7959 2777 18710 3352 6956 7959 18711 4611 5957 7800 18712 4611 7800 1241 18713 8335 4886 5232 18714 8335 2562 4886 18715 8335 6273 6085 18716 8335 6085 4478 18717 8335 4478 2562 18718 8335 5232 6273 18719 9129 863 1345 18720 9129 1345 6385 18721 9129 2867 863 18722 9129 7137 2867 18723 9129 6385 7137 18724 1127 863 2867 18725 1127 9038 863 18726 814 8005 286 18727 1818 4997 7624 18728 1818 7624 7788 18729 1818 6975 4997 18730 1663 4195 5743 18731 1663 5743 9414 18732 1663 2024 4195 18733 1663 9414 9058 18734 1663 9058 2024 18735 5743 4195 3208 18736 5743 1998 9414 18737 5743 3358 1998 18738 5743 2567 3358 18739 5743 3208 2567 18740 6210 7054 5355 18741 6210 466 7054 18742 6210 5355 8286 18743 6210 3208 4195 18744 6210 4195 466 18745 6210 8286 3208 18746 6022 8286 5355 18747 6022 5355 9626 18748 6340 9410 4712 18749 6340 4712 9077 18750 6340 9650 9410 18751 6340 9077 9650 18752 2103 9410 9650 18753 2103 4712 9410 18754 2103 596 4712 18755 2103 6316 596 18756 2101 458 4664 18757 4400 5306 7913 18758 4400 9626 5306 18759 4400 4917 9626 18760 7549 1828 451 18761 7549 549 1828 18762 7549 5301 9835 18763 7549 9835 549 18764 7549 7051 5301 18765 7549 1847 7051 18766 7549 451 1847 18767 7051 1571 5301 18768 6993 1571 5551 18769 6993 5301 1571 18770 6932 549 233 18771 6932 233 2423 18772 6932 2423 4195 18773 6932 1828 549 18774 2069 4183 382 18775 2069 382 2812 18776 2069 3564 4183 18777 2069 7312 3564 18778 1812 4426 8382 18779 1812 4272 4426 18780 1812 7342 5761 18781 3749 3914 3863 18782 3749 3863 1434 18783 7519 1994 9899 18784 7519 9899 9530 18785 3252 8382 4426 18786 3252 513 8382 18787 5234 4599 665 18788 5234 665 6293 18789 7441 3166 4459 18790 7441 1300 4995 18791 7441 4459 1300 18792 9035 203 162 18793 9035 6311 203 18794 9035 162 4142 18795 9035 4142 6057 18796 9035 6057 604 18797 9035 604 6311 18798 329 4142 162 18799 329 162 6459 18800 329 6459 8650 18801 329 5272 4142 18802 329 8650 5272 18803 2744 9981 725 18804 2744 725 1155 18805 6026 2557 1385 18806 6026 1155 2557 18807 768 1385 3442 18808 768 3442 3931 18809 3564 382 4183 18810 3442 1385 4390 18811 3442 3105 6506 18812 3442 4390 3105 18813 7827 4233 4985 18814 7827 4985 2778 18815 5462 4234 3565 18816 7620 2773 4068 18817 7620 3984 3540 18818 7923 4228 8467 18819 3151 2446 6528 18820 3151 6528 2726 18821 333 831 7008 18822 333 7446 5191 18823 333 6262 10002 18824 333 10002 7446 18825 1133 6262 9379 18826 1133 7955 6262 18827 687 9379 6262 18828 1863 9039 9453 18829 8166 7438 7641 18830 8166 7641 7473 18831 2196 7053 1010 18832 2196 6264 7053 18833 2196 1010 9406 18834 2196 40 2057 18835 2196 9406 40 18836 2196 2057 6264 18837 6188 242 5158 18838 6188 3778 242 18839 6188 5158 6689 18840 357 242 7598 18841 357 7598 8287 18842 357 5158 242 18843 357 8287 5158 18844 2189 7967 1823 18845 2189 1823 6975 18846 2189 1042 7967 18847 7598 532 9175 18848 7598 9175 5545 18849 7598 242 532 18850 7598 5545 8287 18851 1047 9016 1700 18852 500 1700 9016 18853 500 9016 1448 18854 500 1448 4228 18855 500 5147 1700 18856 7046 6100 5256 18857 7046 5256 5457 18858 7046 5519 2051 18859 7046 4396 6100 18860 7046 5457 9016 18861 7970 6143 3018 18862 7970 2188 6143 18863 1398 6546 6995 18864 1398 6995 2045 18865 1398 4111 6546 18866 6995 6546 5124 18867 5598 5277 5956 18868 5598 5956 8325 18869 6272 3165 2056 18870 6272 2056 3574 18871 6272 9647 3165 18872 6272 3574 8997 18873 1064 6279 7743 18874 1064 7618 1490 18875 1064 4977 7618 18876 1064 3097 4977 18877 1064 1702 1721 18878 1064 1721 6279 18879 1064 1490 1702 18880 7618 4977 1974 18881 1721 3143 587 18882 1721 4781 3143 18883 1721 1702 4781 18884 1721 587 4136 18885 1721 4136 6279 18886 733 4312 1723 18887 1182 5629 4204 18888 1182 4204 4895 18889 1182 2695 5629 18890 5569 6047 8610 18891 5569 8610 1020 18892 5569 3264 6047 18893 5569 1020 6970 18894 9151 7688 4340 18895 9151 9995 7688 18896 9151 6714 9995 18897 3120 1964 4688 18898 3120 4688 9995 18899 3120 9995 1549 18900 3120 3874 1964 18901 3230 4532 1723 18902 3230 1723 4312 18903 3230 4312 3874 18904 7525 3979 6418 18905 7525 6418 7119 18906 7525 6718 3979 18907 7525 7119 1309 18908 303 7119 3510 18909 303 1309 7119 18910 303 3510 2695 18911 303 2695 7202 18912 3229 6779 6811 18913 3229 6811 10001 18914 3229 10001 10002 18915 3229 7990 5575 18916 3229 9740 7990 18917 3229 10002 9740 18918 6905 6118 6386 18919 2177 2657 1307 18920 8592 1307 2657 18921 956 9341 142 18922 956 4926 9341 18923 4503 603 5705 18924 6828 1749 5956 18925 6828 7622 1749 18926 6828 9809 7622 18927 6828 5277 1394 18928 6828 5956 5277 18929 6828 1394 9809 18930 6466 6636 1421 18931 6636 1841 1421 18932 6636 7321 1841 18933 6636 1258 7321 18934 9048 214 7688 18935 9048 7688 4688 18936 9048 4688 1964 18937 9048 8997 214 18938 632 644 7321 18939 632 8524 644 18940 632 7321 9647 18941 8517 6047 3264 18942 8517 3264 6418 18943 8517 8929 6047 18944 8517 3058 8929 18945 8517 3979 3058 18946 8517 6418 3979 18947 8610 6047 8929 18948 8610 8929 5682 18949 4223 8395 8959 18950 5079 9189 3959 18951 7373 9276 545 18952 2689 7662 7709 18953 8059 8472 8959 18954 8059 8959 8395 18955 8059 2364 8472 18956 8059 8395 287 18957 5575 7990 8547 18958 5081 3900 9276 18959 5081 2104 1341 18960 6668 3649 5339 18961 6668 5339 2803 18962 6668 5772 3649 18963 6668 8182 5772 18964 6668 609 9836 18965 6668 2803 609 18966 7761 9638 5772 18967 7761 423 9638 18968 7761 8182 9444 18969 7761 9444 423 18970 7761 5772 8182 18971 9444 3838 423 18972 7177 7743 7622 18973 7177 7622 9809 18974 7911 8363 3438 18975 7911 3438 3334 18976 9971 2391 6058 18977 9971 6058 5768 18978 3438 5768 3334 18979 5479 2696 6058 18980 5479 6058 2391 18981 2696 5768 6058 18982 8671 2598 4753 18983 207 2165 2780 18984 207 2780 8277 18985 5791 6409 3297 18986 5791 4509 6409 18987 180 8686 5725 18988 180 5725 8828 18989 7094 3187 4522 18990 7094 6986 3187 18991 7094 7387 6986 18992 2048 8388 9567 18993 20 8380 10001 18994 2953 93 3187 18995 2953 3187 5715 18996 2953 6427 3799 18997 2953 5715 6427 18998 6427 9652 4901 18999 6427 5715 9652 19000 2556 521 9329 19001 2556 7510 521 19002 2556 9329 1584 19003 2556 1584 2480 19004 2556 2480 7510 19005 933 7117 5337 19006 933 5337 2332 19007 933 2332 5139 19008 3640 5139 5203 19009 370 1076 2690 19010 8917 6743 2242 19011 4418 7645 2105 19012 4418 2105 5775 19013 4418 5775 8889 19014 7609 9210 2235 19015 7609 2235 8889 19016 7609 8889 5775 19017 7609 5775 2647 19018 2380 6084 6172 19019 2380 289 6084 19020 2380 6172 1518 19021 2380 1518 6476 19022 6172 2406 1518 19023 6172 964 2406 19024 6172 6084 964 19025 5587 3819 5074 19026 5289 3819 8895 19027 2387 4651 8895 19028 1584 9329 1937 19029 1584 7254 3432 19030 1584 3432 2480 19031 1584 1937 7254 19032 3939 9314 548 19033 3939 9687 4927 19034 7981 3051 8815 19035 7981 5767 3051 19036 7981 8815 1748 19037 5010 2881 8732 19038 5010 3834 2881 19039 5010 8732 9314 19040 4927 6835 3834 19041 4927 2986 6835 19042 4927 9687 2986 19043 548 9314 9789 19044 7697 1872 216 19045 7697 216 5766 19046 7697 9576 1872 19047 7697 6400 1050 19048 7697 5766 6400 19049 7697 1050 9576 19050 897 4476 4707 19051 897 216 4476 19052 897 4707 9959 19053 897 332 216 19054 897 6818 332 19055 897 9959 6818 19056 4476 5896 4707 19057 4476 257 5896 19058 4476 3549 257 19059 982 6748 6638 19060 4768 3450 4896 19061 4768 7133 4690 19062 8859 216 332 19063 8859 5766 216 19064 8859 1007 5766 19065 8102 669 2708 19066 4625 8338 4984 19067 4625 4984 6638 19068 4625 669 2315 19069 4625 2315 8338 19070 4625 6748 928 19071 4625 928 669 19072 4625 6638 6748 19073 3493 911 5839 19074 3493 5839 928 19075 3493 6748 911 19076 3493 928 6748 19077 6965 3360 6818 19078 4014 5642 6354 19079 4014 6354 8540 19080 4014 8540 880 19081 4014 56 5642 19082 6787 56 2116 19083 9680 5601 9173 19084 9680 9173 9999 19085 9680 7854 5601 19086 9680 1056 7854 19087 9680 6674 1056 19088 9680 9999 6674 19089 6291 6802 9315 19090 6291 9315 2825 19091 6291 2806 6802 19092 6802 3774 7230 19093 6802 7230 1959 19094 6802 1959 9315 19095 9518 6479 1390 19096 3608 7405 5041 19097 3608 5041 5739 19098 3443 5511 2264 19099 3303 1994 5323 19100 3303 4518 1994 19101 3303 719 4518 19102 8503 7542 5143 19103 8503 5143 5456 19104 8503 6988 7678 19105 8503 7678 7542 19106 3270 8872 1792 19107 3270 1792 7477 19108 3270 7477 9261 19109 3270 9261 6053 19110 6203 8892 6053 19111 3346 864 2041 19112 3998 1993 6918 19113 4455 4599 5243 19114 3373 7299 3194 19115 3373 3194 9761 19116 8848 290 8980 19117 8848 8980 4721 19118 8848 4721 576 19119 4721 8980 717 19120 378 5386 528 19121 378 6821 3010 19122 5238 9735 5797 19123 7522 883 1896 19124 5533 9176 1541 19125 5533 1462 9176 19126 6038 7854 6447 19127 6038 5601 7854 19128 5222 4373 9165 19129 5222 9165 274 19130 7087 5739 5041 19131 9280 2392 6577 19132 9280 3249 2392 19133 2931 6588 9904 19134 6870 4174 8984 19135 4669 3883 2364 19136 4669 9162 3883 19137 4669 3563 3126 19138 4669 3126 9162 19139 8472 2364 3883 19140 1759 4665 6588 19141 1759 9269 4665 19142 1759 3883 9269 19143 1759 6588 3883 19144 7212 826 5725 19145 2816 8277 6702 19146 398 2186 8956 19147 398 8956 3557 19148 398 3557 4594 19149 398 4594 5894 19150 398 5894 4360 19151 398 4360 2186 19152 4079 8864 1229 19153 4079 6593 8864 19154 4079 1229 7861 19155 4079 833 6593 19156 4079 7861 833 19157 4210 846 8134 19158 4210 5414 846 19159 2205 846 7760 19160 2205 8134 846 19161 9923 5839 7003 19162 9923 2708 5839 19163 4473 9960 3050 19164 4456 4758 6489 19165 4456 8405 121 19166 4456 121 4758 19167 3842 8409 6866 19168 6251 5331 8794 19169 300 388 8450 19170 300 9328 388 19171 300 8912 9328 19172 3823 8650 4118 19173 3823 8645 8650 19174 3253 3366 8645 19175 3366 5272 8645 19176 388 1594 8450 19177 388 9328 9287 19178 4118 6641 7255 19179 4118 8650 6641 19180 7628 719 9532 19181 8802 1404 3516 19182 2777 6383 2132 19183 8730 5232 9321 19184 8730 9321 6494 19185 8730 1250 5232 19186 863 9038 1345 19187 9038 6460 4562 19188 9038 4562 1345 19189 4562 6460 6385 19190 4562 6385 1345 19191 7922 10000 6385 19192 7922 6385 6460 19193 1926 9996 7706 19194 1926 9305 9996 19195 1926 7706 4111 19196 1926 4111 8424 19197 4997 1823 7624 19198 4997 6975 1823 19199 6083 5181 8029 19200 6083 8029 7624 19201 6083 7624 1823 19202 9427 2356 4991 19203 9427 4991 9054 19204 9427 14 2356 19205 9427 9054 8 19206 9414 1998 9058 19207 3208 8286 8271 19208 3208 8271 2567 19209 4664 8050 2548 19210 4664 2548 8798 19211 4664 458 8050 19212 629 2561 6316 19213 629 4896 2561 19214 7913 3333 7494 19215 7913 3590 3333 19216 7913 5306 3590 19217 9023 3785 6741 19218 9023 6741 7494 19219 9023 7494 3333 19220 9023 3333 3785 19221 6741 845 5105 19222 6741 3785 845 19223 6741 5105 4033 19224 3590 1119 3333 19225 3590 7054 1119 19226 3590 5355 7054 19227 3590 5306 5355 19228 1847 2024 2522 19229 1847 451 2024 19230 5301 7559 233 19231 5301 233 9835 19232 8648 8253 3453 19233 8648 6641 4367 19234 8648 4367 2373 19235 8648 2373 8253 19236 8648 7255 6641 19237 4935 6337 9893 19238 4935 9893 810 19239 4935 810 604 19240 4935 604 6057 19241 4935 6057 8637 19242 4935 8637 3473 19243 4935 3473 9566 19244 4935 9566 6337 19245 2812 4401 8902 19246 2812 414 4401 19247 2812 382 414 19248 181 8529 3863 19249 181 9637 8529 19250 181 3863 160 19251 181 160 9637 19252 4272 8411 3548 19253 4272 1434 8411 19254 4272 3548 4426 19255 8411 6031 3548 19256 4259 5958 8618 19257 4259 7892 5958 19258 4259 4278 7892 19259 4259 4360 4278 19260 4259 6293 4360 19261 4995 1300 5924 19262 4995 6958 8798 19263 4995 8391 6958 19264 4995 5924 8391 19265 604 810 955 19266 604 955 6311 19267 4142 8637 6057 19268 4142 5272 8637 19269 1155 6147 2557 19270 1155 725 6147 19271 2778 4985 5722 19272 2778 5722 382 19273 1977 9990 6506 19274 1977 6506 1794 19275 1977 4569 9990 19276 1977 1794 4569 19277 6506 237 3453 19278 6506 3105 237 19279 6506 3092 1794 19280 6506 8253 3092 19281 6506 3453 8253 19282 3540 3984 6676 19283 3984 4228 5660 19284 3984 5660 6676 19285 5963 9206 5147 19286 5963 9379 9206 19287 315 3888 2079 19288 315 2079 9321 19289 315 8899 3888 19290 315 4886 8899 19291 315 9321 4886 19292 106 2831 7166 19293 106 6224 4679 19294 106 7166 6224 19295 7589 3744 6729 19296 2446 9193 6528 19297 7008 7783 2888 19298 9206 5525 5147 19299 9206 4521 5525 19300 4966 474 8865 19301 7940 7446 3178 19302 7940 3178 7637 19303 7940 2726 7446 19304 7438 1365 9393 19305 7438 9393 7641 19306 7438 5134 1365 19307 2859 7473 7641 19308 2859 8858 7473 19309 2859 2460 2747 19310 2859 2747 7576 19311 2859 7641 2460 19312 2859 7576 8858 19313 2460 5949 2747 19314 2460 7641 5949 19315 9406 1010 242 19316 9406 242 3778 19317 6689 263 6644 19318 6689 5158 263 19319 242 1010 532 19320 8287 6712 5158 19321 8287 126 6712 19322 8287 5545 126 19323 532 1010 7053 19324 532 4005 9175 19325 3380 1448 39 19326 3380 39 5182 19327 3380 5182 6964 19328 3380 5660 1448 19329 3380 6964 5660 19330 7783 3529 2888 19331 7783 9994 3529 19332 8100 47 1267 19333 8100 5191 47 19334 8100 6143 2188 19335 8100 1809 6143 19336 8100 2188 5191 19337 6143 1809 9513 19338 6143 9513 3018 19339 1267 6528 9193 19340 1267 47 6528 19341 9513 2914 3018 19342 4824 5545 9175 19343 9804 6546 4111 19344 9804 8478 6546 19345 9804 7706 5045 19346 9804 5045 8478 19347 9804 4111 7706 19348 8325 1749 3143 19349 8325 3143 2056 19350 8325 5956 1749 19351 8997 3574 214 19352 587 1749 4136 19353 587 3143 1749 19354 6279 4136 7743 19355 3510 4204 5629 19356 3510 7119 4204 19357 3510 5629 2695 19358 4895 3264 7158 19359 4895 4204 3264 19360 6970 1020 8984 19361 6970 8984 4174 19362 6714 1549 9995 19363 4209 1549 7202 19364 6811 5559 8201 19365 6811 6779 5299 19366 6811 7052 10001 19367 3649 9638 6779 19368 3649 5772 9638 19369 5299 2608 3838 19370 5299 9638 2608 19371 5299 6779 9638 19372 9740 1161 7990 19373 1593 2104 17 19374 1593 17 84 19375 869 9663 1394 19376 1394 9663 9809 19377 1421 1841 5125 19378 1421 5125 7052 19379 2608 423 3838 19380 2608 9638 423 19381 644 1841 7321 19382 644 5125 1841 19383 7321 1258 9647 19384 7622 4136 1749 19385 7622 7743 4136 19386 1572 4977 3097 19387 1572 2075 4977 19388 1572 8003 2075 19389 1783 1405 9997 19390 1783 9997 2075 19391 1783 8174 1405 19392 1783 8003 5657 19393 1783 5657 8174 19394 1783 2075 8003 19395 5657 1501 8174 19396 1405 3058 9997 19397 1405 8174 3058 19398 5682 8929 1501 19399 7662 950 7709 19400 7662 8014 950 19401 823 287 8395 19402 823 100 287 19403 8104 950 9199 19404 8104 9199 100 19405 2803 5339 4219 19406 2803 4219 609 19407 3467 8143 4509 19408 4753 2598 8614 19409 4753 8614 8143 19410 440 5203 9569 19411 8614 2598 9652 19412 8614 9652 6986 19413 8614 6986 8143 19414 3297 6409 8189 19415 4522 3187 547 19416 4522 547 201 19417 3187 93 547 19418 3187 6986 5715 19419 5844 3237 8380 19420 5844 8380 3177 19421 5844 1344 3237 19422 5844 3177 1344 19423 7278 3237 1344 19424 7278 2860 3237 19425 5952 7647 7330 19426 5952 7330 9329 19427 7510 2480 6879 19428 9450 1344 3177 19429 9450 3177 5155 19430 9450 6879 8302 19431 9450 5155 6879 19432 3432 7254 5840 19433 3432 8302 2480 19434 3432 7290 8302 19435 3432 5840 7290 19436 7933 2242 6743 19437 7933 6743 2105 19438 7933 2105 7645 19439 5139 2332 5203 19440 6743 2647 2105 19441 2647 5775 2105 19442 6476 5074 3819 19443 1937 9329 3597 19444 9687 563 5107 19445 9687 5107 2986 19446 4235 6489 4758 19447 8732 9789 9314 19448 8279 2458 1477 19449 8279 1477 10001 19450 8279 458 947 19451 8279 9077 458 19452 8279 947 2458 19453 947 4858 4506 19454 947 4506 2458 19455 1050 6400 8904 19456 1050 8904 9576 19457 6610 2955 3549 19458 6610 689 9012 19459 6610 9576 689 19460 6610 9012 2955 19461 6610 1872 9576 19462 9930 4091 3664 19463 2002 8225 1803 19464 2002 8060 8225 19465 2002 1803 911 19466 2002 7954 8060 19467 6400 1007 4091 19468 6400 5766 1007 19469 6782 4091 1007 19470 6782 6444 4091 19471 5839 7154 7003 19472 5839 911 1803 19473 5839 1803 7154 19474 5839 2708 928 19475 1803 6485 7154 19476 1803 8225 6485 19477 669 928 2708 19478 8338 4401 4984 19479 5642 7254 6835 19480 5642 5840 7254 19481 5642 6835 6354 19482 5642 56 5840 19483 2116 6818 9959 19484 4337 5966 3763 19485 5041 7405 9165 19486 9249 3763 5966 19487 560 274 9165 19488 560 9165 7405 19489 2127 3353 1261 19490 2264 3548 6031 19491 2264 4426 3548 19492 4478 6085 6383 19493 9464 5075 6494 19494 9464 6494 2079 19495 9464 2079 1753 19496 7298 8478 775 19497 7298 775 824 19498 6988 9261 7061 19499 6988 6053 9261 19500 6988 7061 7678 19501 9261 8955 8972 19502 9261 7477 8955 19503 9261 8972 7061 19504 8941 39 8872 19505 8941 824 39 19506 8014 9199 950 19507 8358 9597 565 19508 8358 5243 9597 19509 750 286 9346 19510 9176 1462 6447 19511 1056 6447 7854 19512 9346 286 8005 19513 2945 6105 3991 19514 3883 9162 9269 19515 988 1001 35 19516 4788 8828 826 19517 8687 826 9986 19518 5725 826 8828 19519 1440 4849 1200 19520 1440 7407 4849 19521 1440 9637 4153 19522 1440 1200 9637 19523 1440 4153 1386 19524 1440 1386 7407 19525 4360 5894 4278 19526 4360 6293 2186 19527 665 8956 2186 19528 665 2186 6293 19529 665 4599 8956 19530 3879 149 3557 19531 3879 3557 8956 19532 3879 8956 4599 19533 1229 8564 2545 19534 1229 8864 8564 19535 1229 2545 1748 19536 1229 8815 7861 19537 1229 1748 8815 19538 6593 1545 9871 19539 6593 9871 8864 19540 6593 833 1545 19541 5414 7760 846 19542 5414 189 7760 19543 121 8405 8794 19544 1545 833 5886 19545 4917 4033 1477 19546 8912 1735 9328 19547 8645 5272 8650 19548 8450 1594 3353 19549 9287 9328 1735 19550 8650 703 6641 19551 8650 6459 703 19552 3678 1640 4518 19553 3678 4518 719 19554 2327 1119 4315 19555 2327 233 7559 19556 2327 4315 233 19557 5577 2126 7031 19558 5577 7031 10000 19559 5577 2071 2126 19560 7788 7624 8479 19561 7788 8479 684 19562 7788 684 8027 19563 7788 8027 2071 19564 1998 3358 4893 19565 1998 4893 9058 19566 4195 2024 451 19567 4195 2423 466 19568 4712 596 458 19569 4712 458 9077 19570 8050 458 596 19571 8050 596 2548 19572 4858 4415 4506 19573 4858 6958 4415 19574 6316 5361 7808 19575 6316 9649 5361 19576 6316 2561 9649 19577 6316 7808 596 19578 549 9835 233 19579 6641 703 4367 19580 3473 8637 5272 19581 3473 7601 9566 19582 5908 7239 9058 19583 5908 9058 2678 19584 5908 8534 2522 19585 5908 2522 7239 19586 5908 9566 8534 19587 5908 6337 9566 19588 5908 2678 6337 19589 4233 7014 4985 19590 4233 4569 7014 19591 4233 9990 4569 19592 5722 4985 2809 19593 5722 2809 414 19594 5722 414 382 19595 3863 8618 160 19596 3863 8529 1434 19597 379 5361 8664 19598 379 7808 5361 19599 379 8798 2548 19600 379 2548 7808 19601 2573 5696 8391 19602 2573 955 5696 19603 2573 8391 5924 19604 2573 5924 955 19605 162 203 6459 19606 2800 9530 9899 19607 2800 9899 3124 19608 2800 5626 9530 19609 2800 1846 5626 19610 2800 4518 1640 19611 2800 1640 1846 19612 2800 3124 4518 19613 725 5626 6147 19614 1794 5361 4569 19615 1794 3166 5361 19616 1794 3092 3166 19617 2436 4679 1620 19618 8899 4886 9830 19619 8899 9830 3888 19620 6224 9305 1620 19621 6224 1620 4679 19622 6224 7166 9305 19623 8935 7166 2831 19624 8935 9996 7166 19625 8935 2831 9996 19626 2726 6528 7446 19627 6528 47 5191 19628 6528 5191 7446 19629 7955 9453 9039 19630 2914 1143 5456 19631 2914 8350 1143 19632 2914 5456 3018 19633 4791 6729 3744 19634 4791 3744 8755 19635 5134 2499 1365 19636 5134 5866 2499 19637 7576 6644 7571 19638 7576 7571 8858 19639 7576 4458 6644 19640 7576 2747 6607 19641 7576 6607 4458 19642 2747 567 6607 19643 2747 5949 567 19644 5158 6712 263 19645 2356 6644 4991 19646 6712 9549 1808 19647 6712 7480 9549 19648 6712 126 7480 19649 6712 1808 263 19650 1448 1233 39 19651 1448 5660 4228 19652 1448 9016 1233 19653 9016 1792 1233 19654 9016 5457 1792 19655 6100 5863 5256 19656 6100 3529 5863 19657 6100 2888 3529 19658 179 7737 697 19659 179 6532 7737 19660 179 6037 8056 19661 179 7479 6037 19662 179 8056 5861 19663 179 5861 6532 19664 8056 824 5861 19665 8056 5182 824 19666 8056 6037 5182 19667 7706 9996 2992 19668 7706 2992 5045 19669 6546 8478 4822 19670 6546 4822 5124 19671 2056 3143 3574 19672 214 3574 1647 19673 214 1647 7688 19674 4781 1647 3143 19675 4781 4340 1647 19676 1974 9997 7025 19677 1974 4977 9997 19678 1974 7025 243 19679 2695 4532 7202 19680 8447 9842 5468 19681 8447 9602 9842 19682 4204 7119 6418 19683 4204 6418 3264 19684 3979 9997 3058 19685 3979 6718 9997 19686 5890 7990 728 19687 5890 728 17 19688 9647 1258 3165 19689 8174 8929 3058 19690 8174 1501 8929 19691 3900 545 9276 19692 4219 9452 609 19693 2598 5337 4901 19694 2598 4901 9652 19695 2598 8282 5337 19696 6986 7387 8143 19697 6986 9652 5715 19698 4901 5337 7117 19699 3237 2860 689 19700 3237 689 8904 19701 3237 10001 8380 19702 3237 8904 10001 19703 2860 9605 689 19704 2860 5991 9605 19705 6879 2480 8302 19706 7290 5840 56 19707 1922 7353 133 19708 1922 453 7353 19709 547 93 201 19710 9012 689 9605 19711 9012 9605 5991 19712 9012 5991 2955 19713 563 6354 5107 19714 3834 6835 7254 19715 3834 7254 2881 19716 2458 4506 187 19717 2458 187 2006 19718 2458 2006 7399 19719 2458 7399 1477 19720 9576 8904 689 19721 332 6818 7617 19722 4091 6444 3664 19723 7003 7154 6485 19724 7003 6485 6444 19725 6638 4984 3659 19726 9959 5896 1039 19727 9959 4707 5896 19728 5896 257 1039 19729 9037 2825 2377 19730 9037 9999 9173 19731 9037 2377 9999 19732 4594 3557 149 19733 4594 149 6925 19734 4594 2377 5353 19735 4594 5353 6 19736 4594 6 5894 19737 4594 6925 2377 19738 5232 4886 9321 19739 2079 3888 1753 19740 2079 6494 9321 19741 775 4250 824 19742 775 8478 4250 19743 3126 9269 9162 19744 3126 9602 9269 19745 6084 6866 964 19746 6588 8543 5032 19747 6588 4665 8543 19748 6588 5032 9904 19749 2780 6702 8277 19750 4518 3124 1994 19751 4153 8977 7230 19752 4153 9637 8977 19753 4153 7230 1386 19754 4599 9597 5243 19755 9029 1149 149 19756 9029 10 1149 19757 8564 8864 9871 19758 1477 4893 3358 19759 1477 7399 4893 19760 1477 4033 10001 19761 5105 845 4033 19762 3353 1594 1261 19763 7054 466 4315 19764 7054 4315 1119 19765 6949 2867 7137 19766 6949 3785 3333 19767 6949 7418 3785 19768 6949 7137 7418 19769 8027 8408 2126 19770 8027 684 8408 19771 8027 2126 2071 19772 4506 4415 187 19773 8015 7401 2444 19774 8015 3189 7401 19775 8015 2006 187 19776 8015 187 3189 19777 8015 2444 2006 19778 2561 4896 3148 19779 2561 3148 1051 19780 2561 1051 9649 19781 5306 9626 5355 19782 2522 8534 1006 19783 2522 2024 7239 19784 1200 8529 9637 19785 1200 16 8529 19786 1200 4849 16 19787 8253 2373 3092 19788 7601 8534 9566 19789 7601 1006 8534 19790 6337 2678 9893 19791 4401 7406 4984 19792 4401 414 7406 19793 4985 7014 2809 19794 7014 5361 9649 19795 7014 9649 2809 19796 7014 4569 5361 19797 2548 596 7808 19798 8391 5696 6958 19799 955 5924 6311 19800 955 810 5696 19801 4390 237 3105 19802 4459 3166 3092 19803 4459 3092 1300 19804 3166 8664 5361 19805 7166 9996 9305 19806 5181 3818 8029 19807 5181 8 3818 19808 1365 2499 8694 19809 1365 8694 9393 19810 7446 10002 3178 19811 3744 9549 8755 19812 8350 8897 1143 19813 7473 8858 1808 19814 6607 7416 4458 19815 6607 567 7416 19816 4991 682 9054 19817 4991 4150 682 19818 4991 9780 4150 19819 4991 4458 9780 19820 4991 6644 4458 19821 263 7571 6644 19822 263 1808 7571 19823 8872 39 1233 19824 8872 1233 1792 19825 3529 9994 5863 19826 5256 7061 8955 19827 5256 8955 5457 19828 5256 5863 9994 19829 5256 9994 7678 19830 5256 7678 7061 19831 3018 5456 5143 19832 1143 8897 5545 19833 8955 7061 8972 19834 8955 7477 5457 19835 5861 824 4250 19836 5861 5045 6532 19837 5861 4250 5045 19838 7479 6676 6037 19839 5182 39 824 19840 5182 6037 6964 19841 126 8897 8755 19842 126 8755 7480 19843 126 5545 8897 19844 1162 9972 2406 19845 1162 2406 964 19846 1162 6866 8409 19847 1162 964 6866 19848 1162 8409 6489 19849 3574 3143 1647 19850 6718 7025 9997 19851 7990 1161 728 19852 728 624 84 19853 728 84 17 19854 8143 7387 4509 19855 6409 4509 7387 19856 8380 5155 3177 19857 8282 9569 5337 19858 2955 5991 3549 19859 3549 1039 257 19860 3549 5991 1039 19861 5107 6354 6835 19862 5107 6835 2986 19863 7954 3664 8225 19864 7954 8225 8060 19865 6444 6485 8225 19866 6444 8225 3664 19867 3659 7406 589 19868 3659 589 3450 19869 3659 4984 7406 19870 6818 3169 7617 19871 6818 3360 3169 19872 6674 9999 9506 19873 6674 9506 10 19874 9315 5353 2377 19875 9315 2377 2825 19876 9315 1959 5353 19877 2377 6925 9999 19878 4665 9269 9602 19879 4665 9602 8543 19880 7230 3774 1386 19881 7230 1053 1959 19882 7230 8977 1053 19883 160 8977 9637 19884 160 8618 8977 19885 5894 6 4278 19886 4033 845 10001 19887 3785 7418 845 19888 6385 7418 7137 19889 6385 10000 7418 19890 2126 8408 5932 19891 2126 5932 7031 19892 1856 1469 4893 19893 1856 4893 7399 19894 1856 7399 2444 19895 1856 2444 1469 19896 2006 2444 7399 19897 4896 3450 3148 19898 2024 9058 7239 19899 4849 7407 16 19900 3124 9899 1994 19901 203 6311 2373 19902 203 2373 4367 19903 203 4367 6459 19904 5924 1300 2373 19905 5924 2373 6311 19906 810 3723 854 19907 810 9893 3723 19908 810 854 5696 19909 1669 187 4415 19910 1669 1844 187 19911 1669 854 1844 19912 1669 5696 854 19913 1669 4415 5696 19914 6958 5696 4415 19915 3092 2373 1300 19916 697 6532 2831 19917 697 7737 6532 19918 2831 6532 9996 19919 7416 9780 4458 19920 7416 567 4150 19921 7416 4150 9780 19922 8408 3818 5932 19923 8408 5249 3818 19924 8408 684 5249 19925 8479 8029 4730 19926 8479 7624 8029 19927 8479 4730 684 19928 8029 3818 4730 19929 5866 7637 7250 19930 5866 7250 2499 19931 3178 7250 7637 19932 3178 10002 7250 19933 1808 8858 7571 19934 7641 9393 5949 19935 1792 5457 7477 19936 7678 9994 7542 19937 6532 5045 9996 19938 2992 9996 5045 19939 6037 6676 6964 19940 4340 7688 1647 19941 4977 2075 9997 19942 5203 5337 9569 19943 5203 2332 5337 19944 5353 7892 6 19945 5353 3960 7892 19946 5353 1053 3960 19947 5353 1959 1053 19948 8977 5958 3903 19949 8977 3903 1053 19950 8977 8618 5958 19951 4278 6 7892 19952 845 7418 10001 19953 4893 1469 2678 19954 4893 2678 9058 19955 2444 7401 876 19956 2444 876 1469 19957 854 7401 1844 19958 854 3723 876 19959 854 876 7401 19960 2678 1469 3723 19961 2678 3723 9893 19962 876 3723 1469 19963 466 2423 4315 19964 2809 9649 7406 19965 2809 7406 414 19966 4367 703 6459 19967 1051 589 7406 19968 1051 7406 9649 19969 1051 3148 589 19970 567 5949 9393 19971 567 9393 7031 19972 567 7031 4150 19973 682 8 9054 19974 682 7031 8 19975 682 4150 7031 19976 5932 3818 7031 19977 3818 5249 4730 19978 3818 8 7031 19979 2499 7250 8694 19980 7250 9393 8694 19981 7250 10000 9393 19982 7250 10002 10000 19983 5045 4250 8478 19984 7688 9995 4688 19985 3450 589 3148 19986 3960 3903 5958 19987 3960 5958 7892 19988 3960 1053 3903 19989 9506 6925 149 19990 9506 149 1149 19991 9506 9999 6925 19992 9506 1149 10 19993 7418 10000 10001 19994 4315 2423 233 19995 5660 6964 6676 19996 5249 684 4730 19997 8755 9549 7480 19998 7401 3189 1844 19999 7031 9393 10000 20000 1844 3189 187
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/meshes/r10k.1.node
10003 2 0 0 0 8444.218515 7579.544029 0 1 4205.715808 2589.167503 0 2 5112.747214 4049.341375 0 3 7837.98589 3033.127261 0 4 4765.969542 5833.820395 0 5 9081.128852 5046.868558 0 6 2818.378444 7558.042042 0 7 6183.689967 2505.063414 0 8 9097.46256 9827.85476 0 9 8102.17236 9021.659504 0 10 3101.475693 7298.317483 0 11 8988.38288 6839.839319 0 12 4721.427155 1007.012081 0 13 4341.718355 6108.869734 0 14 9130.110532 9666.063678 0 15 4770.097766 8653.099278 0 16 2604.923104 8050.27827 0 17 5486.993038 140.417002 0 18 7197.046864 3988.235422 0 19 8248.449771 6681.532012 0 20 11.428193 4935.778665 0 21 8676.027755 2439.108769 0 22 3252.043627 8704.712321 0 23 1910.670915 5675.107406 0 24 2386.159286 9675.402503 0 25 8031.794693 4479.695714 0 26 804.458186 3200.546047 0 27 5079.406425 9328.338242 0 28 1090.578459 5512.672461 0 29 7065.614099 5474.409113 0 30 8144.668633 5402.83607 0 31 9638.38546 6031.85628 0 32 5876.170642 4449.890263 0 33 5962.868616 3849.01146 0 34 5756.510142 2903.295024 0 35 1893.913286 1867.295283 0 36 6127.731799 6566.59389 0 37 4765.30992 898.243612 0 38 7576.03922 8767.703708 0 39 9233.810159 8424.602231 0 40 8981.731214 9230.824398 0 41 5405.999249 3912.960502 0 42 7052.833999 2756.341213 0 43 8116.287085 8494.859652 0 44 8950.389674 5898.011835 0 45 9497.648732 5796.950107 0 46 4505.631066 6602.453786 0 47 9962.578394 9169.412179 0 48 7933.250841 823.729882 0 49 6127.83105 4864.44202 0 50 6301.473404 8450.775757 0 51 2430.356221 7314.892208 0 52 1171.342932 2204.605369 0 53 7945.829717 3325.361492 0 54 8159.130965 1006.075202 0 55 1463.584889 6976.706402 0 56 452.340679 5738.660368 0 57 9100.160147 5341.979683 0 58 6805.891326 266.967947 0 59 6349.999099 6063.384178 0 60 5759.52948 3912.094093 0 61 3701.399403 9805.166506 0 62 363.920376 216.365099 0 63 9610.312802 1849.719414 0 64 1238.951644 2105.765099 0 65 8007.465904 9369.691586 0 66 227.825757 4256.18832 0 67 1015.002194 2599.198898 0 68 2208.292713 6469.257198 0 69 3502.939674 1803.179015 0 70 5036.365052 393.787071 0 71 1009.212412 9882.351487 0 72 1993.557905 3585.553013 0 73 7315.983062 8383.265652 0 74 9184.82062 1694.246061 0 75 6726.405636 9665.48903 0 76 580.509438 6762.017843 0 77 8454.245937 3423.125411 0 78 2506.873393 5967.913935 0 79 4423.140337 1748.194845 0 80 4716.254151 4099.053957 0 81 5691.127395 5086.001301 0 82 3114.46001 3571.516826 0 83 8376.611744 2509.326648 0 84 5606.002189 124.363188 0 85 7415.743774 3359.165545 0 86 456.964936 2808.831642 0 87 2401.304078 9531.293398 0 88 3522.255615 2878.779149 0 89 3592.011973 9469.058357 0 90 6337.478522 6210.768456 0 91 7156.193503 3880.172353 0 92 4144.179883 6508.328623 0 93 15.242219 1923.095412 0 94 3344.016907 2394.159602 0 95 6373.994011 3786.480703 0 96 8754.233917 5681.514209 0 97 4144.063967 4022.670751 0 98 7018.296239 4182.265533 0 99 6621.95889 467.79686 0 100 4453.521897 2592.269234 0 101 1576.865721 5275.731302 0 102 4872.656011 5614.049256 0 103 7554.847673 8838.751542 0 104 4945.826704 3120.582464 0 105 4668.922354 8090.458574 0 106 8750.163315 8124.149324 0 107 1880.012941 9994.203595 0 108 6330.887599 834.670502 0 109 7255.543555 9868.214802 0 110 4018.168222 6785.150052 0 111 3161.771372 2135.246621 0 112 7173.241433 23.575647 0 113 8227.314105 5283.459769 0 114 977.843418 1189.038948 0 115 6492.654249 8736.538239 0 116 2799.827433 9785.151868 0 117 1001.806891 8539.381096 0 118 3966.961773 813.454168 0 119 2747.138434 4529.781848 0 120 7923.415312 8613.599036 0 121 1334.205542 5208.655284 0 122 6507.832381 3470.530146 0 123 8718.638357 2784.098152 0 124 185.743275 406.632737 0 125 6809.967701 5583.557361 0 126 9465.025542 9384.387997 0 127 9098.511774 420.04532 0 128 7491.348234 7013.248176 0 129 6553.618647 7123.576525 0 130 9027.101506 6401.411998 0 131 3724.49263 5379.287837 0 132 2078.441037 5871.255047 0 133 88.97082 1510.231739 0 134 3334.08388 7896.231589 0 135 7184.994228 3382.5597 0 136 6205.381083 412.029495 0 137 1638.605457 9819.140701 0 138 2895.308536 3947.91983 0 139 5484.842966 2934.070015 0 140 4780.646692 2397.060836 0 141 482.563623 1795.86849 0 142 5230.502317 708.628841 0 143 4031.691464 3285.2071 0 144 4147.21609 994.003382 0 145 9086.575544 4740.046511 0 146 8408.483326 9762.294576 0 147 3436.515937 4790.865192 0 148 6995.952912 4265.353235 0 149 3019.031162 7347.509912 0 150 8943.997782 9196.888444 0 151 6267.420468 3755.713463 0 152 9745.605215 6388.785175 0 153 658.346773 846.695691 0 154 7498.695718 611.561565 0 155 78.510053 3938.079518 0 156 5190.037287 4485.442856 0 157 4886.188044 5848.88702 0 158 6793.025674 4230.380735 0 159 3683.314563 9884.590581 0 160 2609.165354 7771.001545 0 161 4312.210246 3585.20382 0 162 638.579489 8635.789443 0 163 7020.041498 9030.107075 0 164 4516.117927 6769.209668 0 165 1189.102866 3979.536016 0 166 2072.319734 421.014279 0 167 9479.613513 2158.943685 0 168 1463.544898 1979.700436 0 169 3780.319643 5463.912623 0 170 1513.343685 9886.89889 0 171 9829.892105 1484.020171 0 172 4059.068832 6799.294831 0 173 8776.565829 4954.059249 0 174 9170.466728 3224.603149 0 175 4984.408915 4986.465919 0 176 6700.681513 2019.913088 0 177 6097.706104 2187.730969 0 178 3402.203151 9625.664633 0 179 8990.08038 8181.183809 0 180 354.682619 1483.668825 0 181 2568.819121 7841.665682 0 182 8423.333271 5829.481802 0 183 7181.316518 8070.5538 0 184 663.59131 846.431368 0 185 8688.95314 394.158294 0 186 2250.906537 406.320266 0 187 152.8514 8439.546857 0 188 3305.943673 1606.900603 0 189 1488.194903 6560.836618 0 190 9685.982717 5049.996926 0 191 9010.904769 5024.28599 0 192 5738.724775 6785.713568 0 193 8051.09989 7578.463823 0 194 9905.325627 7469.653892 0 195 9057.807234 2061.048321 0 196 5354.163043 5986.142637 0 197 8256.966172 4822.135631 0 198 7910.402117 3885.688902 0 199 5863.884556 8513.166075 0 200 7980.594711 6569.845519 0 201 2.406965 1819.689222 0 202 5068.577869 2544.593985 0 203 656.208433 8598.834221 0 204 9429.470213 3028.048781 0 205 4080.731674 8100.375338 0 206 622.587589 6409.848626 0 207 1273.208129 2870.8834 0 208 8299.406866 555.270459 0 209 359.338334 4178.660448 0 210 4918.309591 8633.251831 0 211 7171.887463 6735.438086 0 212 1513.737724 9867.059242 0 213 4111.401963 6117.708643 0 214 3866.830055 470.329158 0 215 4708.89209 1513.677539 0 216 324.654624 6174.004237 0 217 6299.662912 1052.928247 0 218 5491.437662 3466.679766 0 219 3834.140732 7764.198987 0 220 4903.196775 8812.766154 0 221 6101.197429 4671.88415 0 222 6323.126401 3378.653798 0 223 1243.237925 6825.296187 0 224 6220.374427 7885.664914 0 225 1271.091249 9117.833181 0 226 7993.412114 9168.874081 0 227 8725.347218 6810.064464 0 228 8102.508494 5190.073092 0 229 7854.891494 1891.274679 0 230 7821.141064 4445.796041 0 231 7566.162213 4554.702368 0 232 7895.587283 753.395852 0 233 446.409054 9342.895824 0 234 4861.651007 9010.713996 0 235 9447.832519 6665.111525 0 236 5717.968261 2159.793841 0 237 934.762193 8193.942151 0 238 8887.720676 7793.957107 0 239 6985.024327 4201.111161 0 240 3053.1159 1134.448956 0 241 4259.702481 5660.129742 0 242 9228.805831 9357.547693 0 243 4156.411965 992.109881 0 244 7738.187325 7342.793417 0 245 307.00846 4467.185991 0 246 6864.181043 301.342346 0 247 9192.823534 9622.424865 0 248 7225.427721 785.385397 0 249 703.294659 3592.533148 0 250 293.775078 3478.777273 0 251 99.642413 9743.235128 0 252 8190.066991 705.176115 0 253 8934.350918 2079.7804 0 254 2047.907983 6737.591455 0 255 9382.622682 1231.881212 0 256 71.845673 3691.301472 0 257 246.500144 6048.482376 0 258 8591.756086 1869.917024 0 259 1123.910358 3444.496073 0 260 9591.715206 1301.576944 0 261 9665.192605 3622.398699 0 262 4733.704028 2926.31986 0 263 9371.268442 9581.47895 0 264 6359.157065 1840.455502 0 265 9929.517886 1025.804395 0 266 5808.493816 1564.030601 0 267 8976.753142 9456.783915 0 268 8043.90298 3158.914187 0 269 2428.3869 7548.584132 0 270 2910.595191 4197.853779 0 271 462.556769 1322.338104 0 272 205.496206 779.211201 0 273 732.111494 4202.317022 0 274 5507.771776 7408.788199 0 275 1422.834738 4221.887462 0 276 6369.660374 845.556948 0 277 4448.111551 3692.560392 0 278 9489.319289 578.571139 0 279 4086.262212 4172.254798 0 280 7281.805046 3206.710029 0 281 2039.902759 2933.116552 0 282 4708.875424 9502.683296 0 283 7965.170228 2769.702458 0 284 5581.815884 6882.003036 0 285 7956.571557 4461.643839 0 286 3987.769051 7676.407428 0 287 4317.164956 2479.576689 0 288 4534.470315 9371.046463 0 289 1425.674882 4624.353545 0 290 6373.035244 4832.879883 0 291 2036.399044 18.431606 0 292 6989.917118 6187.35518 0 293 77.766494 2985.60121 0 294 7686.342595 6289.203785 0 295 5452.081159 1562.211098 0 296 7062.94043 4714.349217 0 297 6781.787462 7600.898367 0 298 2323.627214 7619.950131 0 299 2800.883847 9840.151371 0 300 1208.316108 8837.180187 0 301 405.47125 2565.758183 0 302 5261.019088 5816.161834 0 303 3962.34985 1020.317282 0 304 2526.080858 2833.965039 0 305 7552.228546 9087.743252 0 306 5954.099155 354.509657 0 307 7922.364716 3056.039328 0 308 3398.904064 5301.854376 0 309 2490.470476 9199.780879 0 310 1635.547583 4148.304005 0 311 2896.919495 5198.341022 0 312 5739.818031 6271.396891 0 313 5313.758038 4108.045023 0 314 6345.940124 4034.128766 0 315 7785.502591 7881.774253 0 316 2922.541681 3718.043236 0 317 6288.109059 1570.699671 0 318 6970.31931 3814.27753 0 319 5910.624748 1395.330992 0 320 6682.583861 3540.578606 0 321 4726.655762 4151.074008 0 322 4767.15248 6946.956329 0 323 3182.401768 6520.544809 0 324 602.221075 3001.851525 0 325 7452.096902 524.058781 0 326 6211.421953 255.467993 0 327 4715.288683 8885.450437 0 328 101.10094 5268.280207 0 329 664.568297 8671.097761 0 330 6862.965222 7419.538567 0 331 6690.075799 64.234537 0 332 411.778623 6208.76804 0 333 9996.851256 8731.472391 0 334 6996.858067 7270.999543 0 335 2266.870226 7516.139341 0 336 2879.241049 1054.60267 0 337 4608.948955 3301.957725 0 338 1682.553987 4217.098925 0 339 8972.00977 4352.702733 0 340 4472.918952 7088.277574 0 341 5241.618702 1292.230353 0 342 9103.923975 4441.243362 0 343 7893.377392 3888.7513 0 344 8068.460188 3895.36416 0 345 2201.595217 1961.946669 0 346 9400.346443 5865.302586 0 347 497.932651 3883.475962 0 348 2340.292605 846.570646 0 349 1867.558685 569.9048 0 350 6380.736282 1733.738648 0 351 6107.798762 6125.067479 0 352 7049.237107 5121.186506 0 353 2844.239903 8774.574539 0 354 3530.710817 4582.94325 0 355 6318.794317 5161.242982 0 356 9564.683486 9547.176774 0 357 9297.598506 9340.763497 0 358 5809.601356 4902.020637 0 359 7041.168174 2154.19593 0 360 2658.720392 438.072536 0 361 1628.575426 38.745499 0 362 6546.275765 1404.06989 0 363 7866.793456 6805.039959 0 364 9706.757934 3965.14487 0 365 9213.919135 4537.041723 0 366 3395.037398 1023.388699 0 367 8828.321851 7947.901586 0 368 3229.289765 4557.443849 0 369 3251.434658 288.291165 0 370 443.525254 3687.041259 0 371 2095.913281 5245.146032 0 372 1877.850356 2016.215865 0 373 6726.678813 7356.026568 0 374 3122.320959 8599.943994 0 375 2546.391747 3439.403763 0 376 7124.803904 445.029013 0 377 9341.834601 723.377318 0 378 4609.310589 7246.04826 0 379 474.68535 8090.026856 0 380 9788.933433 4605.116728 0 381 1181.236363 814.769957 0 382 987.304362 7654.413741 0 383 4140.128485 9192.341582 0 384 4406.397761 771.433101 0 385 4269.355875 7548.278934 0 386 8293.384268 393.516865 0 387 1803.893913 4900.13452 0 388 1280.85478 8710.926419 0 389 9344.608884 3195.969984 0 390 4348.436826 5570.540644 0 391 2855.057911 5410.756975 0 392 2011.850455 2966.412513 0 393 4417.836332 6046.699022 0 394 5361.650261 2609.879767 0 395 2317.878754 1187.302367 0 396 7834.936359 989.007665 0 397 7328.850062 2487.736957 0 398 2845.56984 7360.83433 0 399 6596.207917 7419.215555 0 400 5152.830588 8590.958197 0 401 1217.938914 6451.969614 0 402 1182.443125 7372.833681 0 403 3589.046615 6748.821044 0 404 7034.839134 6606.084576 0 405 2215.579803 8317.998864 0 406 2401.360874 5181.532972 0 407 6746.457542 2336.031748 0 408 6285.11723 2868.31048 0 409 1713.823761 8097.488285 0 410 5531.227701 3278.847066 0 411 5854.309472 252.863974 0 412 1298.228568 3955.808517 0 413 9757.565795 5104.745179 0 414 764.562051 7650.406152 0 415 7814.438709 7748.021744 0 416 5694.98038 6956.987379 0 417 2134.579363 7325.605909 0 418 8161.739873 7599.665402 0 419 3534.624026 5910.280506 0 420 6289.893575 9008.098537 0 421 1080.138953 8339.337709 0 422 5264.355585 3586.141206 0 423 4556.029015 126.354989 0 424 2200.735923 6527.634201 0 425 6608.492798 4946.989403 0 426 9533.258806 4809.150885 0 427 3139.436595 8477.808392 0 428 2591.582994 6043.05993 0 429 7034.188523 8216.962987 0 430 7853.687502 3840.923305 0 431 591.80306 382.878655 0 432 7264.603879 9616.913814 0 433 3431.653743 4411.950981 0 434 7257.980157 6578.312459 0 435 2601.065885 6715.848458 0 436 3049.024196 3563.579066 0 437 5395.133053 7323.138239 0 438 1512.162116 219.872109 0 439 6278.299545 245.646778 0 440 449.632407 2257.755767 0 441 6538.768733 665.450977 0 442 624.057676 9720.932444 0 443 4226.528938 8924.28934 0 444 2165.24284 4352.131795 0 445 3580.351346 1769.35536 0 446 3288.131858 9867.958187 0 447 7473.090098 3826.682792 0 448 4092.844344 2637.409012 0 449 5313.366786 7356.369121 0 450 6866.466158 4626.498353 0 451 419.390467 9215.078065 0 452 4089.338031 3902.98867 0 453 31.101145 1382.272141 0 454 8688.534175 5139.345962 0 455 7324.348442 1481.678864 0 456 3300.510067 8401.365565 0 457 8206.585212 2467.942681 0 458 219.753083 8064.669735 0 459 1688.44005 7876.813921 0 460 6836.592299 1683.147603 0 461 784.886437 9276.494299 0 462 5978.783973 6205.101731 0 463 4575.118028 1500.709773 0 464 6019.699129 2524.7288 0 465 8058.94656 7327.189548 0 466 272.67185 9324.230096 0 467 363.160483 896.193188 0 468 2927.345609 1508.090605 0 469 2361.450829 3558.094886 0 470 7354.997155 4047.113608 0 471 2698.397547 4923.131536 0 472 3925.932498 3107.641975 0 473 9005.416579 5504.48451 0 474 9773.27511 7729.124094 0 475 5704.992976 2624.465893 0 476 6868.436563 4559.17719 0 477 7213.87715 4037.788089 0 478 4960.050363 206.837674 0 479 7399.585023 342.735444 0 480 6807.253858 5820.036955 0 481 7759.176115 2897.775992 0 482 6861.108151 2070.979756 0 483 5292.720014 3402.803793 0 484 9784.545514 9718.665574 0 485 2089.697355 5660.382359 0 486 3294.426859 9685.38187 0 487 9245.259482 5861.458531 0 488 7200.844551 6813.247567 0 489 3533.556324 9163.615694 0 490 8994.535368 3306.584645 0 491 7473.949106 90.921267 0 492 8163.591106 5648.693454 0 493 9523.067128 3631.930745 0 494 6257.130749 3230.024315 0 495 7827.853814 6007.029968 0 496 9874.71023 10.127931 0 497 1407.587422 436.013821 0 498 1258.478488 9293.852971 0 499 9486.082995 4804.125347 0 500 9466.893946 8183.876102 0 501 7786.177341 7472.819508 0 502 1876.545852 5488.772611 0 503 4238.792306 9497.880476 0 504 1738.335381 1698.588436 0 505 6588.617536 1574.017896 0 506 1100.53673 5039.231973 0 507 7966.609712 6050.456716 0 508 7547.539728 2657.585316 0 509 2849.62833 4287.036417 0 510 9908.478843 7179.182565 0 511 9462.539573 5378.704557 0 512 5545.598516 9900.903355 0 513 1899.882757 7825.904372 0 514 7915.13824 8447.416276 0 515 7500.527092 1553.330182 0 516 6611.276321 9237.031846 0 517 5632.851525 3609.415104 0 518 9495.201486 5615.986505 0 519 4116.363945 6141.334981 0 520 8041.250166 2283.020906 0 521 156.92043 5290.948971 0 522 9413.574201 6802.579626 0 523 6309.080001 6278.151475 0 524 4969.897123 7309.192697 0 525 2491.9444 8917.54264 0 526 2744.726552 9449.450132 0 527 9264.9671 779.24524 0 528 4481.797012 7440.362849 0 529 4496.540715 5088.990248 0 530 8068.239377 7049.921609 0 531 9580.042227 1644.859943 0 532 9235.592862 9279.862525 0 533 6347.489386 9403.908273 0 534 2526.855874 8817.872834 0 535 7734.79293 6096.889997 0 536 906.292446 301.343537 0 537 109.694955 2505.580574 0 538 7623.524099 3866.250324 0 539 7754.467252 6256.424909 0 540 3892.618991 8801.466288 0 541 384.172394 4653.129902 0 542 8298.523394 1268.13483 0 543 7104.875615 3281.158419 0 544 243.012786 4737.249309 0 545 5216.927389 415.862507 0 546 5659.193536 3474.33838 0 547 44.932073 1907.733807 0 548 1108.106723 5406.219547 0 549 431.20163 9281.325701 0 550 8450.619724 9452.976437 0 551 3148.010328 9052.673886 0 552 9843.124225 7647.314343 0 553 2750.826136 6708.893041 0 554 5956.631537 4042.033022 0 555 3060.97854 598.481906 0 556 1253.824748 1339.56156 0 557 4808.928647 6418.933847 0 558 7640.684524 467.1376 0 559 8237.598726 434.712233 0 560 5549.468301 7441.478498 0 561 6312.213718 9496.786757 0 562 3446.983531 5858.833552 0 563 827.990627 5597.965879 0 564 8132.988011 2016.045138 0 565 2609.645004 7004.056402 0 566 2538.819669 2592.45474 0 567 9355.152879 9985.430308 0 568 1551.984307 9001.623873 0 569 5527.26486 386.011424 0 570 5855.027152 6415.496507 0 571 337.956987 7576.919222 0 572 8178.001415 716.432422 0 573 6483.999401 4565.474809 0 574 2387.212873 4586.703816 0 575 1593.897098 3336.659067 0 576 6552.072997 4764.855562 0 577 5559.200947 5434.427938 0 578 8205.942401 3433.827982 0 579 8129.620908 799.870871 0 580 4277.330459 3523.201165 0 581 4515.806387 8335.098205 0 582 5123.994005 9872.466463 0 583 8614.607203 1188.467453 0 584 3168.915356 227.255015 0 585 7337.534213 192.008044 0 586 8859.385148 1933.428648 0 587 4138.362903 620.39306 0 588 3112.548873 3895.149895 0 589 522.309735 7675.506532 0 590 7113.497195 3578.836241 0 591 8351.925532 774.218023 0 592 540.06401 3549.802944 0 593 9018.413322 7564.677019 0 594 6723.176786 5627.357352 0 595 8037.655387 4122.266932 0 596 306.885798 8024.042864 0 597 1904.934343 3876.588498 0 598 3576.093472 1233.656259 0 599 3507.84369 1770.868779 0 600 6160.138301 6534.343578 0 601 136.465529 4564.758524 0 602 5540.526565 8716.629944 0 603 4960.313102 804.504369 0 604 517.238791 8621.09083 0 605 7907.294093 8584.479312 0 606 2622.426676 6479.973608 0 607 957.180473 8265.731117 0 608 3336.129364 9551.472373 0 609 4713.825656 330.676969 0 610 9090.558776 6255.321488 0 611 2870.81286 368.038938 0 612 3766.863967 1568.605598 0 613 5482.803113 1468.836752 0 614 1746.142788 9208.694857 0 615 6401.200345 2425.814118 0 616 8788.962806 6247.158299 0 617 9455.993401 4829.167944 0 618 8879.00834 6784.438073 0 619 441.685559 2402.904901 0 620 2815.764049 1700.166834 0 621 2381.869506 2260.401485 0 622 8783.437492 4628.987935 0 623 8765.118313 1379.978835 0 624 5649.184866 134.676781 0 625 9303.014098 56.371144 0 626 3899.076486 8015.859587 0 627 9998.815592 195.097404 0 628 8240.854839 5100.879595 0 629 381.820205 7771.192709 0 630 1119.024126 6114.741873 0 631 7783.252161 6735.909267 0 632 3798.743247 264.416368 0 633 4362.639678 9136.944837 0 634 3329.233655 2479.587192 0 635 1378.308338 5102.52455 0 636 5333.482727 730.482424 0 637 4077.58486 6586.814549 0 638 9660.506852 4315.411217 0 639 4360.353369 4711.339726 0 640 2250.334912 3948.37642 0 641 6452.64726 3970.592091 0 642 5813.757484 8355.82288 0 643 9979.675731 8850.396836 0 644 3717.966269 217.271343 0 645 6116.045995 4745.507082 0 646 2370.17112 403.040991 0 647 3215.70239 7980.713128 0 648 9641.190069 1066.601391 0 649 8776.394118 487.176712 0 650 7134.758189 267.957134 0 651 4210.496823 8702.308385 0 652 3931.081476 9245.643176 0 653 7131.951411 6041.842808 0 654 1613.79048 3404.957836 0 655 4110.961643 5902.048641 0 656 9960.381602 2837.097478 0 657 5035.628908 9334.479076 0 658 3454.207938 6286.047873 0 659 7661.315387 6302.69725 0 660 7534.306798 1956.930002 0 661 9573.376868 1768.978068 0 662 5836.81176 2960.426091 0 663 6344.230253 2911.104154 0 664 4312.133568 6822.225482 0 665 2690.687506 7278.758824 0 666 3468.776728 1321.560972 0 667 6131.287169 1657.580289 0 668 4305.774463 3983.974119 0 669 761.688474 7107.698374 0 670 6808.235651 7777.95005 0 671 5449.131409 5539.167757 0 672 1692.330029 2074.63899 0 673 2282.494905 5253.035287 0 674 8189.825825 3569.741167 0 675 8818.719881 7358.782685 0 676 7164.471432 3351.721293 0 677 1184.774921 9627.904811 0 678 8546.106356 4088.679908 0 679 8632.181902 8992.17115 0 680 3424.736234 5015.614924 0 681 3317.898403 6951.575141 0 682 9121.673135 9845.441039 0 683 7437.790748 3052.423539 0 684 8804.932901 9926.19629 0 685 3465.261637 9487.123524 0 686 5115.464055 9646.354423 0 687 9958.559901 8129.420958 0 688 6834.370492 1540.144693 0 689 49.172832 5954.708504 0 690 7044.599055 9355.380452 0 691 5171.199002 6968.466027 0 692 6473.559715 2049.20125 0 693 6443.000928 9817.212113 0 694 1111.849566 6885.432432 0 695 6143.051175 3758.547238 0 696 7933.477539 104.858586 0 697 8924.116221 8173.63953 0 698 4807.048315 1081.391549 0 699 4526.285557 5842.528991 0 700 2538.834785 4865.314648 0 701 7757.287639 9227.317956 0 702 5616.450276 8272.41785 0 703 779.33213 8563.680463 0 704 9208.145655 1680.013763 0 705 8274.873618 8495.661703 0 706 8786.588683 5171.395198 0 707 6082.542439 2080.832454 0 708 7081.315494 4050.173034 0 709 211.690857 1342.671135 0 710 3882.180316 8851.798061 0 711 5649.422933 9162.570341 0 712 9294.838444 867.949921 0 713 5882.154137 3345.280382 0 714 5067.951223 4555.248025 0 715 4799.432726 1018.058082 0 716 8331.600838 4902.799618 0 717 6449.875563 4726.787527 0 718 1810.183766 5410.00585 0 719 1595.397391 8521.792561 0 720 8316.040256 1436.387782 0 721 688.43953 684.919169 0 722 3932.440249 9530.414373 0 723 5561.404161 2655.26574 0 724 2296.488271 1108.731948 0 725 1410.712105 8118.632666 0 726 1386.334647 8640.615572 0 727 8229.980742 1368.088021 0 728 5587.247699 70.552679 0 729 8620.361343 5582.771204 0 730 7553.403944 4903.453269 0 731 6904.219993 9312.391242 0 732 5595.458101 8747.054769 0 733 3430.454423 975.325457 0 734 51.446426 2266.50279 0 735 8385.868369 3114.954626 0 736 2246.161476 4956.304234 0 737 9469.041225 5089.784483 0 738 3408.716626 775.01791 0 739 5736.669333 2262.569795 0 740 3674.991277 3811.623667 0 741 7581.843372 2316.288448 0 742 9358.922258 7423.88068 0 743 4811.195408 8804.744913 0 744 3591.679803 3843.398736 0 745 1293.69131 7785.560945 0 746 4011.926528 5002.530282 0 747 4709.686654 6561.818176 0 748 3739.384311 9158.613261 0 749 4319.22259 3592.139778 0 750 4008.780552 7662.957215 0 751 9930.5659 8665.146463 0 752 4797.274985 2913.593435 0 753 4459.870544 3440.155531 0 754 2435.320522 1869.409154 0 755 9558.757345 4993.051904 0 756 1099.748737 3839.066101 0 757 3887.169172 5135.34527 0 758 9800.413246 9766.334966 0 759 5658.941107 6180.915253 0 760 6756.290749 5022.221827 0 761 4866.780582 3145.239392 0 762 6839.217395 918.952783 0 763 3171.452462 8909.785595 0 764 2273.78151 9675.82378 0 765 9841.69722 5753.826631 0 766 404.359803 934.781973 0 767 2003.016377 3268.115683 0 768 1131.082116 7972.107731 0 769 3641.5457 2337.336984 0 770 436.938704 3826.718594 0 771 45.067305 1164.914505 0 772 6046.455101 9349.454113 0 773 1993.659219 7410.612067 0 774 1977.05521 14.951938 0 775 8965.380462 8461.087377 0 776 667.78716 1771.352882 0 777 2343.00928 9283.213646 0 778 3819.290956 8073.817566 0 779 4358.135328 3812.446667 0 780 7653.480548 6157.609966 0 781 2693.176942 5828.105982 0 782 7038.5285 8270.780916 0 783 6771.790792 6407.470713 0 784 5959.023425 920.509491 0 785 9451.890595 7148.419105 0 786 2728.711294 6923.506941 0 787 6208.174361 6588.514457 0 788 3789.08971 5731.758548 0 789 6600.272307 2016.56069 0 790 5080.121644 1203.416553 0 791 1055.304981 9110.605752 0 792 1245.472246 8932.669718 0 793 4697.991995 4549.026158 0 794 3398.153195 4162.177164 0 795 3772.323808 5649.82947 0 796 3355.933191 8219.758635 0 797 2335.617502 2484.701227 0 798 4805.515466 9350.812838 0 799 239.156741 7234.136156 0 800 60.065877 4048.602131 0 801 7642.072497 4460.791217 0 802 4294.889289 2532.16829 0 803 4750.956382 2282.594997 0 804 2835.212898 6532.935611 0 805 5994.470561 9295.455154 0 806 9688.690814 5223.801932 0 807 875.565126 2999.030943 0 808 5178.048956 6731.628934 0 809 9461.972494 1551.074337 0 810 366.847018 8700.356828 0 811 8051.643682 7657.482766 0 812 4686.007678 6777.807041 0 813 4114.692248 1920.516578 0 814 3908.937651 7870.46596 0 815 8018.55622 9611.344661 0 816 8876.671252 6820.845368 0 817 5209.120228 7239.270235 0 818 1832.035893 9230.845313 0 819 7125.765745 5944.855555 0 820 4340.417173 6335.415891 0 821 6176.787279 8988.541265 0 822 5707.363108 2133.771524 0 823 4413.793611 2429.685107 0 824 9049.501688 8435.258144 0 825 5558.191145 1963.915676 0 826 435.42013 1341.694537 0 827 4432.192808 6742.040784 0 828 2239.981045 6845.203497 0 829 8619.49384 7572.410816 0 830 4255.274752 6457.279074 0 831 9883.67433 8854.116029 0 832 3381.495065 6854.470536 0 833 1632.112814 5573.684711 0 834 3565.339649 4381.463184 0 835 4388.988539 6632.329398 0 836 8459.960073 4685.718422 0 837 1465.847881 7541.542732 0 838 7516.430106 9538.452397 0 839 3940.560069 4638.790094 0 840 5405.957416 8921.233965 0 841 7042.165179 212.781236 0 842 2073.226876 8538.948477 0 843 5854.738174 8739.08466 0 844 4113.991375 2104.678872 0 845 41.407269 9960.509588 0 846 1363.815332 6429.687657 0 847 4897.089102 3801.493909 0 848 5372.021501 782.835603 0 849 9700.342024 4927.369412 0 850 152.895168 4193.434314 0 851 7572.019053 3120.836696 0 852 7450.224088 7673.627198 0 853 2391.207189 9679.724862 0 854 278.887494 8636.054841 0 855 5126.491216 1533.794885 0 856 2583.929458 5935.172919 0 857 2784.571639 8384.210764 0 858 2195.28514 3840.612974 0 859 5068.13168 3397.729637 0 860 8241.428032 2638.822044 0 861 889.771733 1547.851884 0 862 6269.454553 5635.626501 0 863 632.983219 9930.491636 0 864 4794.406327 3194.372012 0 865 7291.624015 242.918589 0 866 4342.491448 6644.138391 0 867 9621.362249 7616.377781 0 868 8851.592096 1189.059072 0 869 4297.706056 317.904251 0 870 2719.941978 3842.968651 0 871 3438.210807 3737.407969 0 872 8030.800047 1895.436328 0 873 8244.956102 5419.210871 0 874 3387.451285 5522.357673 0 875 1614.233323 4954.547496 0 876 219.532969 8629.750778 0 877 3315.810348 3440.429493 0 878 9951.519974 6134.557319 0 879 4176.536944 7906.567213 0 880 676.647071 5705.042042 0 881 5207.009619 8612.28168 0 882 5862.003425 4852.724152 0 883 5202.25859 7818.973081 0 884 3473.207958 5577.894139 0 885 7073.902727 9955.554543 0 886 6936.841955 9618.711712 0 887 3990.326613 6087.809928 0 888 7452.948573 3484.159496 0 889 2691.749388 9728.331111 0 890 3485.339729 9999.026771 0 891 8522.709847 2160.681148 0 892 8282.192224 9836.271266 0 893 2768.202242 6644.544138 0 894 7695.89223 832.819988 0 895 8193.318049 3083.607321 0 896 7063.817962 9501.382211 0 897 351.090214 6117.128805 0 898 2924.046278 1146.587891 0 899 7118.548026 9790.465623 0 900 5127.105009 3463.442092 0 901 4490.895948 4146.178849 0 902 5319.019096 4091.758365 0 903 803.724646 9794.27736 0 904 9967.072779 1741.345547 0 905 2410.399663 4369.562914 0 906 6987.32937 313.449355 0 907 8354.975507 6384.333733 0 908 2692.935621 8708.672149 0 909 6612.092131 3169.242813 0 910 5478.459943 9792.375586 0 911 484.329669 7084.620166 0 912 8494.136102 6923.168489 0 913 1400.184129 5971.496035 0 914 7859.552457 4185.959122 0 915 5824.282782 2534.679543 0 916 3127.485507 8085.701431 0 917 4894.981376 4488.117375 0 918 1228.838371 3744.708983 0 919 5207.210559 2310.123347 0 920 8079.355618 3837.007063 0 921 2384.897924 3082.974933 0 922 8244.635327 9041.43476 0 923 9602.978486 151.9408 0 924 7538.941306 5254.84036 0 925 1245.600769 2465.335764 0 926 2816.908305 4042.166876 0 927 4707.212724 9367.888564 0 928 583.55057 7091.69305 0 929 8541.060949 3572.99918 0 930 2492.171984 2213.084906 0 931 3008.391767 1452.979906 0 932 5516.779869 2503.995042 0 933 272.515355 2326.334332 0 934 8206.321055 4173.70222 0 935 8835.362547 9436.156314 0 936 2433.483285 5599.724511 0 937 8810.669097 5814.203373 0 938 1680.002864 2479.532475 0 939 9876.248298 2993.868649 0 940 8677.029822 7950.123378 0 941 7419.847028 7219.422568 0 942 7899.818637 8474.076852 0 943 623.664365 1678.098245 0 944 5055.293246 2124.895259 0 945 5332.180226 4931.823395 0 946 1267.71449 859.611521 0 947 116.527967 8250.361301 0 948 817.416684 9615.653287 0 949 9838.318545 7456.964433 0 950 4503.832808 2757.884635 0 951 4124.524219 3452.93266 0 952 3962.951396 7261.95783 0 953 8925.262076 1577.150269 0 954 2426.705788 2098.969062 0 955 453.459901 8542.005796 0 956 5112.755433 670.347787 0 957 4462.552611 4506.10792 0 958 7779.55956 7613.974486 0 959 1344.889894 6268.756157 0 960 5096.862934 134.917766 0 961 1477.358293 6668.484238 0 962 3670.258062 9636.853955 0 963 5017.503622 6882.831697 0 964 1336.176397 4794.484586 0 965 7341.214712 8334.816758 0 966 1996.07429 3969.067211 0 967 4735.270091 4403.723936 0 968 4754.416706 2959.002252 0 969 8087.207429 9130.779455 0 970 3490.007285 6378.600717 0 971 3807.059183 5787.519917 0 972 6955.389447 5015.162773 0 973 6745.820702 7571.457443 0 974 8432.956355 1888.098898 0 975 2163.848971 5143.713517 0 976 5096.570189 8077.254936 0 977 5173.833725 9000.524695 0 978 7776.028358 5063.158112 0 979 8263.261217 4758.559608 0 980 3417.15159 4334.234394 0 981 4562.080123 6505.319515 0 982 521.57095 7295.086771 0 983 9682.327752 4588.175691 0 984 687.722938 2012.563839 0 985 1032.140393 2563.536613 0 986 7939.071055 10.494353 0 987 8735.793324 9395.471506 0 988 1850.030841 1735.864349 0 989 9657.629629 3603.801549 0 990 8117.763047 90.106776 0 991 9907.91579 164.902063 0 992 6075.705954 9284.503547 0 993 8312.60859 3104.02557 0 994 8220.804128 3930.476369 0 995 4998.064171 3632.780005 0 996 3547.180674 5820.752265 0 997 7820.679852 6994.911285 0 998 7680.779559 142.732679 0 999 5316.933935 3527.886028 0 1000 2086.148327 9208.518221 0 1001 1968.0805 1844.749659 0 1002 1788.140945 6580.949064 0 1003 6117.399304 5056.33469 0 1004 5868.017571 9405.763143 0 1005 8612.100871 9059.345201 0 1006 541.57834 8974.12774 0 1007 313.506473 6476.429451 0 1008 9308.321784 5024.634234 0 1009 4193.206676 3317.429545 0 1010 9161.236184 9259.692641 0 1011 6191.255092 7144.289841 0 1012 3391.270412 1381.747672 0 1013 9790.00978 6570.221167 0 1014 2743.875495 9770.835525 0 1015 6089.699336 3305.850869 0 1016 8958.130005 779.00428 0 1017 8041.536641 1595.790155 0 1018 1076.74446 2589.440685 0 1019 7148.255438 6080.082986 0 1020 4212.783774 1590.461925 0 1021 9237.51864 7662.851745 0 1022 6862.666283 8129.090662 0 1023 7742.452606 1124.250113 0 1024 7733.542182 8387.254341 0 1025 7467.558605 4822.772763 0 1026 6864.45644 1000.076136 0 1027 7643.453585 2622.277683 0 1028 7851.263963 6352.840838 0 1029 5090.784566 5360.171557 0 1030 747.308061 408.979104 0 1031 148.248149 7755.424675 0 1032 1384.953178 1228.665367 0 1033 3850.627898 9777.029714 0 1034 8859.242948 3132.890286 0 1035 8197.984482 850.777753 0 1036 3920.403394 5792.057868 0 1037 9862.469153 487.069578 0 1038 4124.210173 9196.1044 0 1039 276.106823 5990.823789 0 1040 3993.937458 5602.684672 0 1041 7033.494137 4066.954136 0 1042 8920.522405 9557.145226 0 1043 9850.591313 547.784995 0 1044 8368.29457 8783.725093 0 1045 1454.052594 9414.294951 0 1046 1271.138537 2073.140784 0 1047 9555.467156 8307.831592 0 1048 5765.511876 2878.083309 0 1049 2527.154849 4031.385309 0 1050 89.93498 6363.59184 0 1051 515.501091 7738.521381 0 1052 701.636439 102.543804 0 1053 2846.570026 7726.920407 0 1054 8326.370251 5073.027621 0 1055 9382.97294 1145.170253 0 1056 3322.19407 7403.452905 0 1057 3233.199182 1453.60748 0 1058 5783.607643 625.739924 0 1059 3730.168209 2538.687397 0 1060 3318.123645 4851.822218 0 1061 5357.024485 843.57456 0 1062 3155.281129 3836.967407 0 1063 4033.044021 4800.353538 0 1064 4258.720243 740.275823 0 1065 2193.245824 6442.86032 0 1066 8287.64013 5114.406147 0 1067 1481.897673 704.670038 0 1068 1558.941978 3840.47148 0 1069 5652.064168 6642.572363 0 1070 5243.593176 5652.906619 0 1071 3522.334094 6655.969088 0 1072 7268.602437 4021.254002 0 1073 8149.12478 7439.320286 0 1074 9047.43989 4667.483085 0 1075 3452.21931 7772.036679 0 1076 375.934297 3838.762848 0 1077 9771.932093 3422.638833 0 1078 5123.223886 2497.695355 0 1079 769.469773 1109.517468 0 1080 4352.100772 6190.023142 0 1081 5457.484053 5186.822154 0 1082 1116.509361 402.592836 0 1083 3586.961928 9424.848882 0 1084 1798.175524 2692.613861 0 1085 4831.40966 9142.072043 0 1086 9469.743626 13.035745 0 1087 6478.956027 2361.581225 0 1088 6544.816977 7428.466359 0 1089 8871.3939 6834.174827 0 1090 8472.095938 7844.799141 0 1091 1607.161382 436.927658 0 1092 7387.786394 5259.188984 0 1093 9978.65505 1648.905414 0 1094 3852.699376 2877.835757 0 1095 8786.973177 4836.95762 0 1096 9136.495816 7071.900029 0 1097 9988.061683 5997.79016 0 1098 9761.591529 1734.063373 0 1099 4416.800612 5783.912042 0 1100 9782.959106 5678.798241 0 1101 8652.64981 6285.055588 0 1102 5124.010252 3914.413842 0 1103 3686.34048 2952.180374 0 1104 2113.699709 9625.770244 0 1105 5364.612161 8658.695365 0 1106 8849.637611 9422.998611 0 1107 2381.668061 3377.288924 0 1108 6331.398796 3220.540452 0 1109 1439.280945 7598.592137 0 1110 5503.918988 5365.230196 0 1111 7104.710385 1147.402517 0 1112 9219.090078 4798.230842 0 1113 6918.28893 6003.242609 0 1114 6052.329261 7099.116802 0 1115 887.956436 4967.332177 0 1116 2102.894209 3896.838521 0 1117 5117.457897 3539.486367 0 1118 4067.129069 7308.698224 0 1119 433.272659 9565.935895 0 1120 6039.17523 1635.546375 0 1121 5572.187637 809.35562 0 1122 5014.737046 6886.314264 0 1123 4197.779358 3141.813192 0 1124 6737.141068 9352.85186 0 1125 8736.358411 3853.682135 0 1126 8634.022393 1150.341622 0 1127 587.205986 9831.869689 0 1128 7629.087215 6149.884292 0 1129 5587.807554 3088.789474 0 1130 8990.821646 8527.504497 0 1131 4817.15004 2203.828018 0 1132 6763.951785 7261.892414 0 1133 9955.062641 7903.781655 0 1134 912.46862 9899.408446 0 1135 8545.128156 5825.239384 0 1136 3309.311491 7329.27701 0 1137 5966.213047 957.655825 0 1138 5635.126251 201.969299 0 1139 7886.966474 8235.857556 0 1140 7301.155054 914.784135 0 1141 5880.937194 3913.955667 0 1142 1283.930523 8920.904441 0 1143 9422.941202 9222.836913 0 1144 5312.178281 8644.284895 0 1145 1978.362149 2954.839405 0 1146 9087.112411 5903.739702 0 1147 2260.158072 1300.974479 0 1148 2283.119206 4960.068821 0 1149 3034.890975 7344.217421 0 1150 2713.11009 784.37605 0 1151 8982.126478 6638.39306 0 1152 9740.642902 1819.970846 0 1153 8703.875586 171.955478 0 1154 5378.221322 4797.424352 0 1155 1261.963901 8151.187132 0 1156 2708.519331 8984.341526 0 1157 6994.134457 8523.605517 0 1158 8664.809635 7917.829797 0 1159 7364.883514 40.705196 0 1160 1434.300082 2071.320395 0 1161 5774.824148 33.746169 0 1162 1271.565269 4849.667068 0 1163 410.642736 3187.463876 0 1164 2199.883436 1744.070534 0 1165 3166.056474 8812.167677 0 1166 2314.426597 6491.588253 0 1167 7339.981815 6752.805837 0 1168 1887.454622 3498.007245 0 1169 2721.570384 5386.463299 0 1170 9690.351582 2178.725771 0 1171 5523.706927 654.766349 0 1172 3755.671688 9541.729509 0 1173 9084.773112 952.061379 0 1174 8525.25876 7157.063922 0 1175 9179.234573 4608.154606 0 1176 4225.55009 8961.529712 0 1177 5361.573115 7613.674983 0 1178 1776.421051 684.333389 0 1179 4404.938294 3270.515306 0 1180 5118.734542 3443.233358 0 1181 8625.880136 7356.049398 0 1182 3839.568611 1258.66471 0 1183 7098.445722 5410.855529 0 1184 1519.452829 347.847514 0 1185 6167.001832 5162.479487 0 1186 5754.552781 4158.612133 0 1187 4687.118396 3914.26213 0 1188 877.253495 5353.05123 0 1189 1216.042303 6734.886204 0 1190 7494.181741 1679.290386 0 1191 2015.116977 2407.111235 0 1192 5985.101192 4064.92584 0 1193 8875.303032 5479.671673 0 1194 5256.362721 2184.9389 0 1195 908.572539 9247.099896 0 1196 996.389874 1302.250222 0 1197 1953.083616 5768.263677 0 1198 6390.334414 4316.365019 0 1199 3948.975866 6410.27286 0 1200 2620.944505 8004.504477 0 1201 6400.497305 6028.626247 0 1202 288.766053 3453.742935 0 1203 7688.597946 2059.076406 0 1204 6444.941762 9747.197196 0 1205 4405.404792 5179.472616 0 1206 2120.401325 70.167642 0 1207 2366.011326 4718.399651 0 1208 6042.713692 8359.294284 0 1209 2900.18852 3290.444444 0 1210 7206.486384 6642.812632 0 1211 7145.224981 8772.847628 0 1212 886.813075 1244.86378 0 1213 4963.425276 6126.045929 0 1214 6540.715179 2300.97494 0 1215 1360.959814 9214.358619 0 1216 2400.70856 178.282372 0 1217 2829.125385 5171.999249 0 1218 6333.540259 7392.090237 0 1219 1455.887639 5078.761602 0 1220 3201.941452 7246.835163 0 1221 3594.942309 8111.433673 0 1222 1916.196287 9947.020061 0 1223 5214.39632 4238.451321 0 1224 7256.572078 3788.453295 0 1225 354.78809 4408.764249 0 1226 2877.941328 6612.116408 0 1227 5267.145722 8300.981194 0 1228 4892.791238 1553.458913 0 1229 1486.043325 5726.231592 0 1230 2648.73987 2115.992838 0 1231 9417.827141 1392.962593 0 1232 9160.704899 5362.275349 0 1233 9369.081943 8390.330824 0 1234 2988.782953 4701.966463 0 1235 852.830014 3666.71351 0 1236 9267.272808 1009.996794 0 1237 2456.372419 427.264201 0 1238 8608.282634 6835.875869 0 1239 5893.452174 4656.528296 0 1240 2600.435819 5858.435352 0 1241 7027.155799 7929.996504 0 1242 1624.74187 6253.035823 0 1243 6788.257943 5811.737548 0 1244 7277.542113 5177.836356 0 1245 9546.400644 6501.853685 0 1246 6280.476767 131.577643 0 1247 1435.417884 6010.715341 0 1248 7669.116547 1442.581182 0 1249 6368.285788 1543.463755 0 1250 7632.040442 8212.052255 0 1251 6206.139861 679.138981 0 1252 2794.384367 2695.312919 0 1253 4678.335382 7800.651361 0 1254 5783.178316 9919.561151 0 1255 7082.471481 1413.590672 0 1256 9791.291464 586.127814 0 1257 3328.572009 6372.512758 0 1258 3904.865526 221.724956 0 1259 2964.84587 2418.66687 0 1260 7761.490352 5925.539339 0 1261 1439.958978 8726.057226 0 1262 2129.985575 3196.783511 0 1263 8747.233973 7652.163599 0 1264 4208.310886 5192.717429 0 1265 9791.690195 7108.063574 0 1266 7157.291514 6557.821746 0 1267 9882.384717 9240.089297 0 1268 2982.393659 4451.579574 0 1269 6356.861164 2369.004175 0 1270 6472.839509 9032.728581 0 1271 3062.756887 3679.225381 0 1272 4499.396386 3863.17685 0 1273 6433.22419 519.692125 0 1274 7767.360789 2853.422873 0 1275 6220.060868 4238.682946 0 1276 6112.890902 5689.486991 0 1277 5175.57846 1603.231567 0 1278 75.227489 1069.767612 0 1279 3848.933928 2570.974842 0 1280 4847.970223 4708.313664 0 1281 5153.883353 1327.097014 0 1282 4974.087795 9504.868006 0 1283 1719.873674 155.433655 0 1284 3388.88364 7084.993698 0 1285 8607.508303 1092.679475 0 1286 312.027591 3101.367453 0 1287 6220.344731 9204.068496 0 1288 3304.23537 7793.62298 0 1289 1275.166941 6409.725556 0 1290 2499.635172 7611.782754 0 1291 9121.258667 4414.066238 0 1292 6872.183519 3540.376084 0 1293 8490.725565 4101.337445 0 1294 5840.778657 9864.544726 0 1295 5576.371908 4528.302486 0 1296 960.602463 9496.208042 0 1297 5248.997126 7007.913171 0 1298 6545.821837 2374.435469 0 1299 6370.706761 966.287957 0 1300 572.884059 8409.133203 0 1301 6007.820455 3013.725749 0 1302 5268.395925 5579.024827 0 1303 6777.782689 1.342816 0 1304 1444.483698 931.698333 0 1305 7530.860479 4523.347158 0 1306 1983.966026 3744.860581 0 1307 6694.545937 4612.240736 0 1308 5458.590476 9375.332702 0 1309 4003.231974 1032.539234 0 1310 1071.384499 7247.173578 0 1311 3124.695759 1150.380559 0 1312 7781.811603 8888.195685 0 1313 1023.568403 6165.138356 0 1314 7404.883583 2458.34648 0 1315 8366.688796 6840.124143 0 1316 4445.697976 1657.156234 0 1317 2578.327872 8294.681586 0 1318 1678.078282 7046.333464 0 1319 5709.425809 5607.179953 0 1320 163.316724 1227.01288 0 1321 3098.045668 6303.292421 0 1322 3814.354182 2564.918527 0 1323 3838.408234 4631.157565 0 1324 5945.831873 5597.474563 0 1325 3680.180176 4254.622731 0 1326 8062.392474 5890.153231 0 1327 9704.846959 6024.737152 0 1328 2832.906272 5131.155797 0 1329 4729.018333 8529.260886 0 1330 7374.99546 8805.877696 0 1331 7178.293534 2532.757919 0 1332 2728.153003 1638.084068 0 1333 8790.420161 9000.828077 0 1334 3235.643852 232.236413 0 1335 4742.675693 7883.794527 0 1336 7029.565371 6756.037194 0 1337 210.148691 1019.156237 0 1338 7292.159089 8185.511448 0 1339 1822.175324 8163.80161 0 1340 9512.804128 6016.34706 0 1341 5517.201657 329.223535 0 1342 4139.430291 4669.953942 0 1343 9534.540838 4408.611906 0 1344 119.10969 5671.001092 0 1345 681.20893 9920.195947 0 1346 6596.924967 7190.894523 0 1347 6934.871873 9409.96122 0 1348 4049.473078 2789.405451 0 1349 787.147166 228.210356 0 1350 4771.755093 7437.017288 0 1351 7392.411971 28.749421 0 1352 6166.599936 8317.821753 0 1353 8669.497139 7696.248502 0 1354 4188.807491 7039.57636 0 1355 7015.335134 642.03441 0 1356 388.884029 3461.326091 0 1357 6433.557377 3809.663041 0 1358 6449.897192 7615.127462 0 1359 7713.77595 2831.83325 0 1360 9717.371717 5537.946075 0 1361 6279.035839 6352.085418 0 1362 6733.461804 1540.079296 0 1363 6745.798053 4315.374711 0 1364 9686.896681 7141.501749 0 1365 9739.901341 9910.601584 0 1366 8339.999986 5861.93105 0 1367 6006.759577 4696.852233 0 1368 3696.745582 4187.407182 0 1369 9134.927361 6463.048367 0 1370 1699.272271 372.606473 0 1371 4391.51175 4408.66264 0 1372 658.247224 2267.571389 0 1373 3314.005228 3767.32886 0 1374 6249.037336 1559.911607 0 1375 8217.870659 4971.112972 0 1376 691.253675 995.868234 0 1377 9431.735844 319.852175 0 1378 6489.831506 1789.870784 0 1379 6542.052144 9875.936576 0 1380 9182.040816 4372.564679 0 1381 4315.035133 2894.398525 0 1382 4404.140063 9579.237069 0 1383 378.596646 4788.353753 0 1384 8957.25853 1066.111226 0 1385 1167.206949 8147.708605 0 1386 2828.262205 7979.360618 0 1387 3018.071681 323.065041 0 1388 8198.340555 3318.195623 0 1389 4613.055666 598.516894 0 1390 6508.329638 8289.528735 0 1391 2197.559694 9332.063455 0 1392 6335.95074 5481.97485 0 1393 2058.510659 8760.684287 0 1394 4239.490482 426.617026 0 1395 9257.784493 3688.47482 0 1396 2945.899912 580.002144 0 1397 330.957668 431.038451 0 1398 8749.608442 8678.801445 0 1399 4697.31969 812.474756 0 1400 1392.529683 9475.226532 0 1401 5607.111911 7955.916979 0 1402 768.319868 653.190882 0 1403 7771.265332 1158.088088 0 1404 8207.014509 9344.493262 0 1405 4328.310645 1151.308602 0 1406 7176.222269 4456.861689 0 1407 5014.11272 8879.86624 0 1408 5398.563303 1381.966833 0 1409 3725.113551 8496.614726 0 1410 5114.458511 807.469385 0 1411 5065.434721 350.951011 0 1412 8793.068197 2481.148473 0 1413 7291.780918 9946.429385 0 1414 8963.647661 5286.291459 0 1415 3241.472137 6987.47669 0 1416 5466.113194 9088.022136 0 1417 2421.752927 6934.551454 0 1418 1524.853826 4050.921787 0 1419 7773.906437 3643.499444 0 1420 2836.242984 3529.022895 0 1421 3736.540677 79.77128 0 1422 1431.2304 7405.762425 0 1423 6927.872539 6524.823897 0 1424 1368.5351 1158.320593 0 1425 4895.52034 4839.041879 0 1426 1257.995462 9658.229147 0 1427 8173.44227 8722.169402 0 1428 1721.920141 6565.36388 0 1429 8132.308181 3235.148281 0 1430 9853.46769 950.747393 0 1431 7932.290397 1446.112143 0 1432 2513.13346 1895.184788 0 1433 1157.396705 6708.926237 0 1434 2429.591891 7992.529601 0 1435 7694.447868 9574.215731 0 1436 7746.918047 9900.30828 0 1437 5573.25798 319.905105 0 1438 3320.084604 3940.799462 0 1439 9663.157296 4211.298491 0 1440 2701.712309 7997.463134 0 1441 9197.823946 466.748382 0 1442 9809.719717 7226.808226 0 1443 9957.52054 6485.574575 0 1444 77.847524 6783.24828 0 1445 2267.303069 9884.641914 0 1446 9320.839705 8607.582359 0 1447 7086.606039 2533.93623 0 1448 9266.405325 8226.150537 0 1449 6339.284116 1709.52674 0 1450 1992.472848 5669.192866 0 1451 5932.997098 4080.112896 0 1452 8135.186336 6783.772561 0 1453 2580.555454 300.441444 0 1454 6067.875636 3293.979553 0 1455 8898.359567 2342.045723 0 1456 5486.333059 1979.288527 0 1457 9667.289557 6429.395418 0 1458 7530.833547 8908.56327 0 1459 4538.817694 5467.404176 0 1460 4496.391385 6190.781441 0 1461 3347.538632 8219.636034 0 1462 3652.176195 7713.830083 0 1463 166.987584 3636.849387 0 1464 4798.943093 9010.516124 0 1465 7223.662487 7338.042696 0 1466 6366.444961 9007.484894 0 1467 7249.197281 6314.746432 0 1468 9208.560093 7641.952157 0 1469 147.885506 8686.193819 0 1470 1881.924615 7483.751066 0 1471 4133.822304 3923.049358 0 1472 1538.541144 4288.644223 0 1473 9994.439441 8272.905272 0 1474 7367.414215 6429.373678 0 1475 2146.756817 631.684713 0 1476 9327.207517 9085.470778 0 1477 22.189118 9110.860451 0 1478 7488.605841 987.453311 0 1479 1542.225275 1763.696849 0 1480 2566.081026 9028.23833 0 1481 4211.799228 5384.771878 0 1482 4243.435673 4640.972996 0 1483 2508.066118 3151.209523 0 1484 2524.494136 2848.974271 0 1485 6079.208293 233.135708 0 1486 9372.869182 5137.40785 0 1487 5021.229327 4218.778556 0 1488 7310.058374 7613.046274 0 1489 7223.698276 9653.965236 0 1490 4144.969028 856.433582 0 1491 7983.360237 7124.728248 0 1492 254.50282 4928.20268 0 1493 8097.742229 9482.693935 0 1494 3496.808078 4717.498759 0 1495 4449.044507 7440.909202 0 1496 7034.54233 4749.024926 0 1497 1850.183294 5871.409532 0 1498 249.899969 3557.468966 0 1499 3078.618082 666.84963 0 1500 973.935587 7883.16232 0 1501 4531.56394 1287.153958 0 1502 9339.90661 3156.474221 0 1503 4402.269338 6948.14354 0 1504 1545.310429 7824.975174 0 1505 8453.201745 4912.519853 0 1506 7094.56172 7233.790889 0 1507 9918.693842 7752.477605 0 1508 3607.700685 5106.911157 0 1509 3938.390673 5351.054493 0 1510 8957.651227 961.948954 0 1511 8942.129994 5039.078753 0 1512 1454.011207 9338.910903 0 1513 1945.641789 269.775576 0 1514 4708.706146 5736.693034 0 1515 505.4094 6288.734113 0 1516 5631.20694 5631.497373 0 1517 809.506573 3567.474702 0 1518 1305.78666 4679.165625 0 1519 3706.20929 3298.344694 0 1520 8817.984842 6242.448813 0 1521 1100.561865 6573.68327 0 1522 9962.462901 3652.919693 0 1523 7705.231533 6571.483743 0 1524 4750.520692 4046.014967 0 1525 2139.490924 4177.612204 0 1526 2668.128158 4863.059404 0 1527 6693.754903 8868.669672 0 1528 1454.252782 8097.781852 0 1529 7619.610907 6280.694736 0 1530 1920.745914 717.071132 0 1531 1368.516122 3218.503994 0 1532 2913.727447 8103.970844 0 1533 3435.913194 1622.694467 0 1534 9757.208983 7048.934127 0 1535 8033.085258 4972.207185 0 1536 968.989621 5862.592876 0 1537 4447.430576 3180.497227 0 1538 874.817048 3161.120203 0 1539 2723.104055 3562.621896 0 1540 7133.340686 1166.33431 0 1541 3788.410747 7588.658059 0 1542 3096.88362 8559.724 0 1543 8640.600741 1892.224152 0 1544 6495.877974 6394.164576 0 1545 1697.552118 5577.767056 0 1546 4752.420109 2407.381913 0 1547 7129.982823 8953.79575 0 1548 8964.84425 1057.684425 0 1549 3788.521867 892.505526 0 1550 4638.620949 6631.805833 0 1551 7068.858232 577.052975 0 1552 1130.423855 6321.635032 0 1553 8349.313841 6075.126372 0 1554 939.125067 818.381054 0 1555 5806.107677 2169.04654 0 1556 7476.315416 3021.301541 0 1557 8259.390548 9020.994169 0 1558 5310.617794 7026.649733 0 1559 7640.663932 6266.712112 0 1560 6467.955322 4036.817198 0 1561 8928.123481 1772.023135 0 1562 1618.418606 7243.855975 0 1563 2114.216733 5201.211111 0 1564 9014.637304 3575.815087 0 1565 7356.122692 8690.669753 0 1566 6586.534443 907.950575 0 1567 5163.514869 7970.425024 0 1568 9977.688961 4586.596773 0 1569 562.615629 3491.423143 0 1570 4994.984957 9294.026437 0 1571 651.803846 9158.093912 0 1572 4399.746391 995.321003 0 1573 7516.167479 1210.794696 0 1574 1339.801416 2368.636624 0 1575 5472.401329 6603.183783 0 1576 8603.698637 5897.370128 0 1577 6374.894444 4811.938249 0 1578 5043.045579 6629.65796 0 1579 2699.449418 2959.918903 0 1580 6229.78819 6217.398861 0 1581 1801.959967 1957.10253 0 1582 5484.338679 8332.419776 0 1583 3117.826986 1739.949071 0 1584 485.470105 5301.652475 0 1585 5284.547773 6126.639736 0 1586 5465.659107 6589.534758 0 1587 8701.314734 3174.993963 0 1588 7960.419904 2267.391384 0 1589 3308.709785 4943.836417 0 1590 5196.334773 7376.835931 0 1591 260.521544 7384.138218 0 1592 8061.288606 13.983777 0 1593 5619.914073 187.271673 0 1594 1383.18753 8711.893939 0 1595 549.61654 9074.001857 0 1596 6674.904465 7659.259369 0 1597 6752.260182 7583.811598 0 1598 7319.631292 8948.59521 0 1599 3598.452803 3828.136175 0 1600 6494.261395 5301.642092 0 1601 6785.226314 3681.592785 0 1602 4187.250675 3921.367803 0 1603 396.348208 7368.454801 0 1604 5689.62425 8859.482515 0 1605 7379.068882 4149.041336 0 1606 7754.458949 634.103461 0 1607 6361.260424 9311.912426 0 1608 8916.117235 3164.082076 0 1609 2805.683232 2948.581262 0 1610 8866.509829 3422.509396 0 1611 4133.494384 3296.916992 0 1612 2662.260124 8700.985484 0 1613 4436.66844 5342.14894 0 1614 4013.378968 3353.405888 0 1615 4035.922139 8948.85799 0 1616 2803.176785 6967.283265 0 1617 2140.564162 9092.121923 0 1618 4669.257459 2987.763986 0 1619 4285.705443 7397.572534 0 1620 8564.085657 8125.955662 0 1621 1298.098558 9673.060863 0 1622 4773.23228 9511.045291 0 1623 1708.125072 9409.137884 0 1624 1929.635039 8693.907628 0 1625 2706.808932 8409.506344 0 1626 1638.153761 8547.58033 0 1627 6613.646037 1213.988474 0 1628 9368.61204 4340.229032 0 1629 1836.923966 8436.6928 0 1630 543.985107 382.333301 0 1631 7372.428178 898.711591 0 1632 7464.114481 944.673187 0 1633 9396.662607 1373.419996 0 1634 5629.438476 6460.885954 0 1635 3662.07131 958.02228 0 1636 4882.917339 3356.533168 0 1637 8909.362295 2031.653196 0 1638 2237.789315 5971.92545 0 1639 4439.899892 2869.796313 0 1640 1403.416054 8398.125842 0 1641 955.484044 9039.653852 0 1642 9404.428133 1302.522509 0 1643 9246.369577 2657.102441 0 1644 7924.697375 3246.617106 0 1645 4455.943256 7104.927252 0 1646 5462.393619 7545.869655 0 1647 3963.082955 623.061224 0 1648 3434.608462 8846.350182 0 1649 8023.287157 9261.822285 0 1650 5891.913632 3282.105853 0 1651 4817.143649 4931.903876 0 1652 2450.115411 8712.673613 0 1653 590.707015 3315.691215 0 1654 9781.433351 5603.438934 0 1655 9438.265969 62.158912 0 1656 8116.46183 6255.238664 0 1657 8564.056243 7346.125808 0 1658 9998.630626 3377.459323 0 1659 7439.948056 8446.190273 0 1660 6932.835956 7912.671073 0 1661 8191.626666 2717.848455 0 1662 2832.329275 4044.767161 0 1663 237.744362 9050.500576 0 1664 8110.697203 1318.251029 0 1665 8186.107077 3295.591496 0 1666 6068.127837 4891.977593 0 1667 4446.856976 6090.11496 0 1668 9073.71321 4141.041548 0 1669 266.610257 8513.806997 0 1670 9519.006876 8071.768121 0 1671 1566.726124 4211.789509 0 1672 7568.823882 8636.110459 0 1673 8698.626966 9236.366193 0 1674 6416.137649 1386.641779 0 1675 4201.578485 9594.957109 0 1676 1322.257794 9329.49115 0 1677 3595.781325 5908.791882 0 1678 8134.525722 929.191205 0 1679 1123.59801 4783.677533 0 1680 9043.240005 9702.75766 0 1681 6543.029244 1914.820524 0 1682 7934.215729 3762.200425 0 1683 2643.104967 5899.113063 0 1684 4429.253184 5191.91144 0 1685 9704.454686 383.772352 0 1686 8735.509101 4334.902384 0 1687 8457.350151 8760.753032 0 1688 7368.546705 4737.570659 0 1689 5217.381181 5960.785652 0 1690 3955.148309 7135.414392 0 1691 8547.520549 3369.465412 0 1692 9545.046461 5627.207186 0 1693 2936.351433 1627.391739 0 1694 7263.390699 2810.875118 0 1695 8088.845087 9469.512412 0 1696 3524.97978 3779.824015 0 1697 3017.998547 2556.663134 0 1698 9986.624615 8277.110768 0 1699 8650.83392 276.929041 0 1700 9523.915492 8238.698622 0 1701 8232.69987 9266.142129 0 1702 4117.166629 768.718099 0 1703 5694.464464 5356.924986 0 1704 2159.310156 7423.940484 0 1705 9851.825949 7162.718818 0 1706 7941.425748 7727.36871 0 1707 8105.059333 1595.964563 0 1708 6055.951833 6083.176736 0 1709 8740.325716 4379.010407 0 1710 2601.709084 5366.216903 0 1711 4936.004659 168.272082 0 1712 487.761169 1881.063966 0 1713 4925.716501 6585.43402 0 1714 5209.832064 5748.840402 0 1715 9919.995559 876.432966 0 1716 3727.013681 5453.669936 0 1717 7906.527966 8837.136104 0 1718 6202.399085 6555.69362 0 1719 8943.519708 7919.891792 0 1720 5807.707928 121.801091 0 1721 4126.087006 708.859066 0 1722 9629.775232 8266.341147 0 1723 3459.724845 1004.475303 0 1724 5640.863862 3521.081734 0 1725 7232.655288 8372.96975 0 1726 5969.778963 8183.181763 0 1727 84.745022 2334.586443 0 1728 4306.518403 4650.245107 0 1729 8127.393946 1755.04697 0 1730 5728.921775 5379.26503 0 1731 6478.90201 136.917358 0 1732 437.305257 908.927182 0 1733 3933.943464 5977.515144 0 1734 7340.068088 6509.079676 0 1735 1075.119974 8658.267486 0 1736 3945.079923 8163.586354 0 1737 1711.594525 3802.917155 0 1738 6704.352298 6300.87878 0 1739 5187.904999 9231.385552 0 1740 8115.587708 5958.526078 0 1741 6776.652562 4151.992462 0 1742 5129.01835 6302.580315 0 1743 8374.08072 1999.779667 0 1744 4577.240924 1840.407518 0 1745 1972.00136 356.797963 0 1746 1191.819109 7573.503801 0 1747 3299.512769 3047.506049 0 1748 1438.838778 5763.817856 0 1749 4150.857797 552.648376 0 1750 3825.866192 8076.087319 0 1751 7567.726789 9747.3917 0 1752 8574.756974 4976.905373 0 1753 7923.760889 7853.888886 0 1754 4100.255874 3871.490369 0 1755 5600.95002 4425.617075 0 1756 6229.383997 8137.726066 0 1757 9189.694304 6433.264287 0 1758 5248.07887 2158.247122 0 1759 3995.767943 2242.464317 0 1760 7288.468411 5402.910047 0 1761 1532.848543 1652.205684 0 1762 281.737694 1137.897308 0 1763 6191.683483 6376.427337 0 1764 5282.658087 7894.354923 0 1765 5464.88683 2564.130426 0 1766 7655.520051 3664.324517 0 1767 444.884413 2161.664569 0 1768 4447.483768 6131.156107 0 1769 7795.114101 8614.545311 0 1770 7742.885952 7514.586691 0 1771 5893.447419 1931.996892 0 1772 6661.420696 6943.806025 0 1773 2680.943496 3711.028757 0 1774 2938.282792 9956.506138 0 1775 6971.169346 3591.722644 0 1776 1947.604337 3405.4392 0 1777 2411.81135 8307.803065 0 1778 1880.155033 3784.528235 0 1779 5349.324717 2514.37438 0 1780 1688.856108 9613.809686 0 1781 9036.72333 268.641105 0 1782 5335.792651 437.319468 0 1783 4337.224639 1095.205341 0 1784 8045.234435 2009.934002 0 1785 3006.040136 858.180068 0 1786 9682.195269 5001.24119 0 1787 4221.911555 5528.52149 0 1788 1794.680293 7975.048357 0 1789 2871.146555 8469.264567 0 1790 7391.753626 2946.944622 0 1791 4860.386841 2944.689262 0 1792 9401.969233 8489.7495 0 1793 5389.903231 6897.376719 0 1794 776.869765 8007.330462 0 1795 3582.967477 2685.645814 0 1796 3277.090708 8892.022595 0 1797 1032.96405 9865.05651 0 1798 4635.799514 6273.891803 0 1799 5066.447044 626.982818 0 1800 7657.348324 4010.489268 0 1801 4821.173423 8215.264872 0 1802 3115.735388 1409.598983 0 1803 456.242368 6899.677947 0 1804 663.350557 5934.463902 0 1805 681.42092 1129.062091 0 1806 3938.941079 2918.773191 0 1807 1072.407397 9418.707909 0 1808 9464.720159 9626.663573 0 1809 9804.231341 9095.30774 0 1810 5660.340492 4042.665734 0 1811 7418.233485 5237.682713 0 1812 2273.312873 7757.118661 0 1813 1630.548287 6517.861345 0 1814 9497.664058 5353.005499 0 1815 1454.151369 3583.347834 0 1816 5107.630212 4320.820851 0 1817 1490.920106 5981.80373 0 1818 8800.125583 9716.833259 0 1819 1813.825649 6583.084752 0 1820 217.639158 1498.194643 0 1821 5133.79457 6064.208812 0 1822 2478.770919 7347.22739 0 1823 8920.513657 9700.718442 0 1824 1039.268206 6833.388245 0 1825 5229.902537 6980.796525 0 1826 9334.128834 2864.592994 0 1827 8813.12211 906.098724 0 1828 413.289713 9250.862703 0 1829 2589.293458 7106.481667 0 1830 2197.654545 5882.895805 0 1831 3402.85318 7229.989229 0 1832 7448.100425 9023.353835 0 1833 8033.723669 4501.60338 0 1834 1273.131448 6713.911526 0 1835 4392.496566 7088.041997 0 1836 9881.931675 3347.731624 0 1837 4436.746763 3432.675506 0 1838 3212.927627 2425.021143 0 1839 3528.671468 3620.311169 0 1840 3584.255867 9479.166844 0 1841 3751.970545 174.192145 0 1842 9648.469435 5810.288305 0 1843 3082.010403 7937.678814 0 1844 220.100697 8546.083039 0 1845 1188.178682 241.981181 0 1846 1433.754645 8352.146829 0 1847 507.315595 9137.843591 0 1848 2918.247652 1969.924923 0 1849 6550.393877 2424.233332 0 1850 5652.366734 7639.004903 0 1851 6676.871362 3173.833686 0 1852 6333.280258 6288.085229 0 1853 207.363521 4608.392289 0 1854 6327.251788 3815.807791 0 1855 1604.280004 9126.367081 0 1856 108.659875 8652.750924 0 1857 1667.026473 9913.87037 0 1858 9106.861357 918.305469 0 1859 7676.405911 6678.130643 0 1860 8646.407889 4963.910599 0 1861 3120.943201 7907.833187 0 1862 7364.090804 5363.828191 0 1863 9854.026411 7694.747947 0 1864 4971.408173 9258.092837 0 1865 5058.197515 8431.087567 0 1866 499.528143 1299.088056 0 1867 2129.408193 2321.091376 0 1868 1404.302873 415.333778 0 1869 5596.194945 5899.708035 0 1870 7265.297681 6148.554864 0 1871 4531.567592 4499.118879 0 1872 140.632893 6163.993833 0 1873 6359.109843 6257.350511 0 1874 9616.98229 7032.759974 0 1875 2107.328111 6106.155165 0 1876 5539.242349 6728.060499 0 1877 5948.262999 7574.364398 0 1878 4580.279408 5668.607894 0 1879 9256.495043 2639.105436 0 1880 6624.83918 7379.454979 0 1881 8211.725303 5733.106487 0 1882 9741.88516 9629.280396 0 1883 5137.253722 4522.131044 0 1884 1032.524699 5871.64274 0 1885 3110.44524 6879.992938 0 1886 7162.163216 8660.255025 0 1887 7430.999503 8093.983614 0 1888 8410.985318 9958.71348 0 1889 3290.791648 5888.470047 0 1890 5572.364866 5708.753144 0 1891 6677.757129 9369.255076 0 1892 182.915108 3101.26042 0 1893 4625.930645 5168.251296 0 1894 9068.796264 4996.422733 0 1895 2365.186756 8572.706797 0 1896 5147.034846 7843.004087 0 1897 2641.048446 9449.617173 0 1898 4013.826594 4468.536445 0 1899 4767.582216 3309.836761 0 1900 7585.800578 5762.290267 0 1901 6034.903149 6009.530855 0 1902 2944.081061 3417.224638 0 1903 911.694031 3849.97036 0 1904 2622.603239 3486.73681 0 1905 6247.323745 6849.982511 0 1906 7484.924031 2215.049618 0 1907 1830.642935 9681.681354 0 1908 4664.742221 4757.560946 0 1909 830.340008 6870.713234 0 1910 1724.743735 522.17236 0 1911 2509.775114 9661.515047 0 1912 3324.37436 570.240571 0 1913 6702.949877 1740.219591 0 1914 2847.310892 4761.225361 0 1915 5405.943953 3028.401011 0 1916 9247.693291 7578.382091 0 1917 6268.069619 751.063003 0 1918 8180.25681 8291.66256 0 1919 8083.825368 8310.574116 0 1920 1737.933856 8989.503206 0 1921 2945.820294 2644.297294 0 1922 18.276531 1577.637661 0 1923 3475.838972 2333.164373 0 1924 8741.352382 476.655243 0 1925 4451.756834 3788.598675 0 1926 8647.493914 8354.404124 0 1927 3244.265096 6781.846211 0 1928 4592.132119 2500.452043 0 1929 6965.888826 4652.134784 0 1930 6955.547539 7379.475191 0 1931 5619.68029 2643.326305 0 1932 1371.817966 104.908888 0 1933 4231.079111 6605.883894 0 1934 8266.763805 2848.967597 0 1935 682.370762 4816.184013 0 1936 3384.730761 3343.8679 0 1937 472.817923 5199.316981 0 1938 4422.071094 7074.155511 0 1939 6782.754646 3826.192194 0 1940 426.365102 9715.686282 0 1941 2029.545286 7390.365088 0 1942 5614.183936 301.179649 0 1943 7331.804897 9724.46511 0 1944 1496.928319 7153.469715 0 1945 5720.485038 5406.734831 0 1946 4335.113777 4467.049112 0 1947 1719.664785 3606.946688 0 1948 6754.662566 8490.921695 0 1949 7361.29808 6262.516251 0 1950 2290.119483 54.726084 0 1951 8582.817084 7663.664645 0 1952 9467.861585 1357.565075 0 1953 9739.249095 3301.040597 0 1954 5637.915743 193.695578 0 1955 7944.385822 9349.625719 0 1956 9462.520672 1549.238792 0 1957 1395.494279 5477.570682 0 1958 4074.48697 187.281621 0 1959 2882.130991 7787.005794 0 1960 7642.435805 2372.466519 0 1961 9193.394483 3675.815297 0 1962 7696.239752 3423.535532 0 1963 9863.080202 6762.128076 0 1964 3709.567514 647.14554 0 1965 1877.231699 9471.393075 0 1966 5751.570109 7998.150673 0 1967 2128.001514 5243.697627 0 1968 6002.883623 9389.905022 0 1969 5055.802001 9239.14329 0 1970 3187.009587 5827.318695 0 1971 6252.779113 960.631416 0 1972 1654.956293 2554.136624 0 1973 2622.687328 1849.229514 0 1974 4185.919639 974.026644 0 1975 1497.146805 8556.453049 0 1976 1793.264921 4476.194812 0 1977 809.067069 7966.040997 0 1978 2680.739676 6624.720346 0 1979 8193.341579 4140.231383 0 1980 2069.296181 1577.090962 0 1981 4597.329646 5946.028115 0 1982 6588.860735 5866.214834 0 1983 2442.281378 15.736026 0 1984 1364.804807 4410.874204 0 1985 9689.107233 5676.110745 0 1986 9797.749005 8410.816122 0 1987 9959.809064 2893.958883 0 1988 6898.728251 4308.750704 0 1989 8710.053616 6133.25374 0 1990 4039.588244 9432.240463 0 1991 8411.693196 4937.000468 0 1992 4251.790194 4032.727475 0 1993 4050.457333 3099.709613 0 1994 1673.463498 8303.700933 0 1995 1218.578853 6228.982542 0 1996 1591.595752 8678.48429 0 1997 2278.090247 1257.416774 0 1998 177.781727 9047.309716 0 1999 7886.689661 3136.096185 0 2000 8644.882914 5080.254805 0 2001 2190.475189 5675.835299 0 2002 285.669527 6956.963847 0 2003 2712.493778 3738.041372 0 2004 8627.767733 6233.814242 0 2005 9592.750202 2266.163372 0 2006 66.857429 8519.89834 0 2007 6091.189935 1330.711012 0 2008 2534.988427 9470.997575 0 2009 5772.401229 5537.276804 0 2010 7708.637053 9012.872054 0 2011 3901.918722 8244.986732 0 2012 8690.824356 9550.707991 0 2013 4804.034111 8926.365143 0 2014 8233.124738 4696.195767 0 2015 7179.086491 1350.405666 0 2016 7444.777608 3962.254126 0 2017 8279.099347 3449.714207 0 2018 7975.476693 2901.244309 0 2019 4987.326805 3971.80488 0 2020 9963.811755 2411.062404 0 2021 8420.34619 8078.821222 0 2022 9467.437953 6927.488385 0 2023 4965.879229 9417.121668 0 2024 377.606432 9077.370154 0 2025 7420.56492 2024.934555 0 2026 2924.670926 8639.124217 0 2027 1037.46111 2702.941311 0 2028 1506.753173 2093.13529 0 2029 1303.815332 3471.034781 0 2030 8731.226294 5929.737523 0 2031 1591.843222 1047.487194 0 2032 9979.840736 2523.838846 0 2033 2866.089961 1857.237448 0 2034 2790.295673 9446.133363 0 2035 3710.946821 4136.607294 0 2036 3343.358615 5957.731199 0 2037 5246.206494 2606.600363 0 2038 1076.711562 5547.100152 0 2039 5573.873729 565.774816 0 2040 3414.794335 4241.522447 0 2041 4839.065507 3176.177285 0 2042 6694.093241 8012.677523 0 2043 1193.224074 4218.587648 0 2044 6676.181039 5925.93409 0 2045 8724.155519 8704.765869 0 2046 5454.954531 8878.950903 0 2047 8065.402135 1502.567458 0 2048 92.545385 3864.733713 0 2049 3650.466562 281.836046 0 2050 8104.244794 5163.515627 0 2051 9759.79268 8334.924791 0 2052 8078.279986 3990.177329 0 2053 9434.240752 7132.795983 0 2054 1050.371052 5538.214609 0 2055 2112.381631 6424.640086 0 2056 4024.394538 410.344592 0 2057 8994.877866 9194.922375 0 2058 6367.230293 2078.111088 0 2059 4117.126209 6946.494031 0 2060 1158.592806 2071.863811 0 2061 905.229457 9340.074042 0 2062 7549.184694 1374.26356 0 2063 2356.468731 6572.699304 0 2064 9737.048832 2153.837823 0 2065 8482.44059 4352.408662 0 2066 8574.682489 114.06548 0 2067 5222.963041 4186.591187 0 2068 7872.785867 9611.60671 0 2069 1017.425717 7532.409699 0 2070 3629.578266 8815.622377 0 2071 8639.032046 9973.961655 0 2072 5093.36138 4987.823336 0 2073 2120.434684 511.554969 0 2074 9054.570247 1081.78774 0 2075 4322.035062 1014.514102 0 2076 374.43728 3278.273071 0 2077 1145.087601 2830.176426 0 2078 9927.925773 2405.325389 0 2079 7878.817864 7889.321936 0 2080 649.010844 3915.638736 0 2081 1491.809778 3246.64274 0 2082 1304.511818 1379.169154 0 2083 7143.985001 541.873162 0 2084 4766.224813 5517.705249 0 2085 4243.155708 2475.049586 0 2086 6231.84985 973.032291 0 2087 1746.770644 2953.64254 0 2088 4491.778348 2018.732424 0 2089 6493.316179 2618.585064 0 2090 4789.924189 8048.965518 0 2091 6690.808845 6027.033196 0 2092 8323.253659 4039.858755 0 2093 4300.081451 3905.933884 0 2094 1308.840791 5965.61205 0 2095 4901.841068 7980.00397 0 2096 6085.676022 3452.753699 0 2097 8592.799348 2765.224353 0 2098 3055.763576 8693.909419 0 2099 9799.201182 2117.278233 0 2100 2247.425339 5793.163651 0 2101 244.153169 8150.552886 0 2102 4264.374519 7311.272007 0 2103 252.919761 7945.72738 0 2104 5483.995884 219.306108 0 2105 482.48731 4070.107263 0 2106 6232.131667 4530.390973 0 2107 6437.35558 9003.933412 0 2108 3819.7966 4207.492938 0 2109 7951.416726 436.61578 0 2110 3390.245888 624.846693 0 2111 6536.338166 6742.623431 0 2112 6640.086928 6204.948253 0 2113 7460.079631 139.179519 0 2114 6302.034298 6303.95294 0 2115 8342.715991 7543.729435 0 2116 344.180853 5920.65659 0 2117 4118.722366 2796.191804 0 2118 1083.005904 1215.884228 0 2119 1554.926452 2391.066196 0 2120 4830.723697 6047.390395 0 2121 2599.166438 2041.053254 0 2122 5220.524261 4880.315948 0 2123 751.589825 2285.113642 0 2124 3938.173927 9342.155655 0 2125 4582.364713 2462.484109 0 2126 8737.602663 9981.877664 0 2127 1554.301115 8723.695775 0 2128 4908.714996 2563.297794 0 2129 8122.247546 5493.998009 0 2130 5524.240732 6973.374088 0 2131 3904.9025 7005.366273 0 2132 7415.888203 8087.9555 0 2133 482.263258 3067.177786 0 2134 5829.951054 6662.034575 0 2135 5963.918771 8029.470624 0 2136 3320.891021 6399.752711 0 2137 5329.642388 8423.967888 0 2138 2988.758077 5346.725918 0 2139 2373.515765 9247.145938 0 2140 9629.483798 3037.157077 0 2141 8626.981118 4343.426248 0 2142 2919.972747 3805.966923 0 2143 7432.654971 9838.493604 0 2144 8303.625525 8431.671343 0 2145 3032.824121 1950.982146 0 2146 2425.024912 9428.693617 0 2147 1638.456681 2128.318803 0 2148 7936.601971 8670.403126 0 2149 2447.842976 5227.617915 0 2150 3645.493194 8631.657739 0 2151 5852.88107 4764.897707 0 2152 6796.456881 9848.979202 0 2153 6387.562537 8081.48768 0 2154 8114.52279 2649.49903 0 2155 3902.496501 1988.765674 0 2156 6038.760704 7867.194642 0 2157 4159.405412 3331.323854 0 2158 4269.587458 7215.55355 0 2159 406.276008 9244.578516 0 2160 6611.908 5725.637793 0 2161 141.82701 862.096849 0 2162 1509.824914 6163.977756 0 2163 5592.150035 1641.865589 0 2164 8593.965823 3321.920516 0 2165 1397.41499 2918.738196 0 2166 7508.57673 4864.605311 0 2167 6378.594941 2694.008138 0 2168 6202.509641 2464.314933 0 2169 132.460661 7170.565577 0 2170 4417.951724 3015.85784 0 2171 5260.958152 3810.14969 0 2172 8075.777115 9703.798352 0 2173 6521.490452 384.788004 0 2174 6538.479094 92.250222 0 2175 3994.62859 916.214509 0 2176 8634.872758 261.095759 0 2177 6779.242596 4621.69131 0 2178 5091.269257 2589.096799 0 2179 3770.261933 4329.016645 0 2180 4502.317232 4884.087456 0 2181 8349.205272 6308.699705 0 2182 8602.969463 5157.189004 0 2183 5235.8474 6287.506876 0 2184 7119.958091 7346.429888 0 2185 5591.284329 3998.463252 0 2186 2772.802877 7374.976545 0 2187 593.730831 9571.704989 0 2188 9898.185527 8967.728919 0 2189 8872.228466 9572.925255 0 2190 6009.625017 8357.278988 0 2191 1854.855724 4590.284659 0 2192 229.171625 3543.798346 0 2193 4349.612139 1733.368191 0 2194 7130.808199 1763.895441 0 2195 1604.523989 7494.57387 0 2196 9100.188591 9252.381233 0 2197 8668.432588 1987.322368 0 2198 6052.054238 5319.507016 0 2199 512.012098 2300.05935 0 2200 5723.264498 8588.443076 0 2201 7550.071878 8122.364078 0 2202 4548.111469 9536.645541 0 2203 6113.783366 2790.198738 0 2204 3310.098797 3744.128419 0 2205 1307.235142 6432.120162 0 2206 5367.166185 8235.687743 0 2207 973.809733 1535.413576 0 2208 3379.588978 2169.14777 0 2209 2511.318678 3520.336719 0 2210 3539.374192 5076.403758 0 2211 7396.904156 5197.171107 0 2212 8912.240336 631.633993 0 2213 6562.907206 6612.787023 0 2214 9321.148478 5757.196235 0 2215 7107.219951 4594.514801 0 2216 740.917232 996.796915 0 2217 4556.416261 6274.717908 0 2218 3818.797375 1846.129478 0 2219 8678.634432 9580.727297 0 2220 3442.07819 2784.196308 0 2221 1411.120972 9738.283652 0 2222 5666.360814 5460.76394 0 2223 3135.726445 8005.613506 0 2224 1885.098037 6659.548491 0 2225 6700.441141 9358.466196 0 2226 8333.341719 4444.937761 0 2227 7233.878644 5070.374415 0 2228 1364.483428 5398.687574 0 2229 7193.726688 9273.090756 0 2230 5558.218971 2651.929412 0 2231 5134.570179 6951.122189 0 2232 2844.888 1314.119774 0 2233 1929.158913 3004.650387 0 2234 2070.20368 2943.755314 0 2235 421.652006 4363.381233 0 2236 6913.548182 103.383339 0 2237 1665.126508 1032.515866 0 2238 4190.388488 8743.992356 0 2239 2687.952427 4015.783332 0 2240 3541.4796 1551.849449 0 2241 912.618661 2149.842356 0 2242 419.557614 3933.607107 0 2243 7597.502722 2784.628669 0 2244 9891.824811 5040.96111 0 2245 7563.753295 5679.946064 0 2246 5677.459764 7815.86524 0 2247 7844.427023 2053.383014 0 2248 1606.86261 1841.683868 0 2249 2315.302345 783.81814 0 2250 2317.201748 3973.523186 0 2251 6301.478799 275.87996 0 2252 6146.418101 7100.878046 0 2253 8915.074193 6558.158252 0 2254 5673.653499 2980.663217 0 2255 3822.215133 6132.231107 0 2256 8028.042368 3487.228981 0 2257 6658.550908 3637.524785 0 2258 6190.203472 442.979768 0 2259 1011.314344 6589.016874 0 2260 8574.289098 3102.616689 0 2261 7405.789949 7720.361203 0 2262 680.6711 6706.020057 0 2263 4351.615077 2006.210349 0 2264 2043.97831 8215.24207 0 2265 6770.39964 4053.392672 0 2266 4727.773886 1610.029575 0 2267 9891.884625 5248.584856 0 2268 739.638199 4128.002869 0 2269 8779.346548 3200.73336 0 2270 7326.382561 800.782931 0 2271 7676.953894 6123.445879 0 2272 4553.793491 1928.850316 0 2273 4892.812943 7954.303281 0 2274 510.213312 2503.945826 0 2275 2917.686964 2944.1928 0 2276 6680.905628 9295.015468 0 2277 5900.670067 6560.893876 0 2278 4930.723613 4717.760406 0 2279 7211.164345 6840.969887 0 2280 3666.702728 4798.285411 0 2281 699.088622 3082.271607 0 2282 7525.236005 9811.586098 0 2283 4633.684855 4424.708161 0 2284 1447.303651 6894.746459 0 2285 8885.169429 643.647109 0 2286 6478.010309 2091.935991 0 2287 1354.465483 6652.157048 0 2288 2860.575367 810.875235 0 2289 7296.242342 8726.589945 0 2290 5843.971426 7673.426172 0 2291 6909.303583 5378.867012 0 2292 4558.336646 5553.195513 0 2293 2778.323455 51.882701 0 2294 6418.582118 9006.268414 0 2295 3519.59797 4372.180704 0 2296 7015.035444 327.635709 0 2297 2486.583101 7704.376874 0 2298 6519.259296 466.575769 0 2299 3754.187857 5969.359667 0 2300 1170.531755 9405.093194 0 2301 1738.273462 6058.5551 0 2302 670.107828 2514.664006 0 2303 1455.604988 7620.511501 0 2304 9794.535351 8919.269578 0 2305 2170.401084 6406.723426 0 2306 9074.865247 6581.534372 0 2307 614.667297 4490.65145 0 2308 3319.024157 6459.906852 0 2309 617.173454 6589.995816 0 2310 479.447461 561.756241 0 2311 2283.662331 8633.725897 0 2312 7679.264826 2641.353293 0 2313 96.648074 2612.503156 0 2314 9331.45725 5556.534912 0 2315 800.313381 7250.687206 0 2316 6289.173702 8474.961196 0 2317 9800.112188 8469.188998 0 2318 6785.565064 8773.785144 0 2319 6207.158475 2114.022938 0 2320 5147.840676 2989.182586 0 2321 2479.459059 1853.134286 0 2322 673.650809 2852.680938 0 2323 8766.907187 5085.420255 0 2324 5298.774477 1108.756615 0 2325 9572.950929 1205.040799 0 2326 9651.784146 1863.553063 0 2327 492.350042 9408.727404 0 2328 310.308975 2719.458262 0 2329 6593.503635 5727.011485 0 2330 7325.406964 3153.658974 0 2331 7524.112464 552.889775 0 2332 331.385212 2334.497779 0 2333 8273.294443 1120.586517 0 2334 7350.699143 9424.940694 0 2335 9709.479786 913.127235 0 2336 2558.599298 576.174108 0 2337 7620.384329 4233.303758 0 2338 2648.345103 9016.877396 0 2339 5909.891099 9760.107005 0 2340 6809.053923 1107.130564 0 2341 1349.982064 1179.760946 0 2342 3618.118981 7883.881127 0 2343 9176.295576 539.758136 0 2344 4086.788393 9417.145103 0 2345 7991.396886 2798.132812 0 2346 8974.050284 1378.245316 0 2347 3354.551436 2044.731012 0 2348 4241.723295 5339.057122 0 2349 729.590368 1759.729656 0 2350 6184.797081 8400.955688 0 2351 887.911788 9564.873629 0 2352 5008.078945 7747.98858 0 2353 585.065978 3573.056475 0 2354 4618.655711 5647.188589 0 2355 9628.469383 5053.172045 0 2356 9135.992411 9677.667167 0 2357 8941.285774 3515.14451 0 2358 8677.542106 3131.25367 0 2359 7186.168727 6971.077534 0 2360 6022.444265 9000.902762 0 2361 7945.42894 8134.680457 0 2362 4240.151849 8858.506504 0 2363 7291.60399 3156.047269 0 2364 4221.327407 2390.156696 0 2365 8508.701614 3733.515139 0 2366 3751.820844 3878.06175 0 2367 5593.222222 2821.576276 0 2368 8196.09975 6694.299295 0 2369 7920.307234 683.651105 0 2370 3766.742337 2074.966295 0 2371 1933.459345 3370.380015 0 2372 8526.569006 3777.123217 0 2373 630.413361 8477.398314 0 2374 7863.987729 5485.699223 0 2375 464.476225 1528.275547 0 2376 3576.687609 4152.453716 0 2377 3000.490586 7674.725748 0 2378 9674.163559 4275.707732 0 2379 1709.331869 4516.026354 0 2380 1379.403968 4639.701407 0 2381 4092.268314 9822.355854 0 2382 3523.607129 1219.378041 0 2383 9309.296898 7036.111738 0 2384 6961.888996 3254.663547 0 2385 2034.881571 7124.032372 0 2386 2895.220918 6151.786152 0 2387 938.281022 4379.123216 0 2388 6356.766595 5505.672162 0 2389 6387.30985 2304.676549 0 2390 4549.608117 655.883494 0 2391 760.439203 2070.61454 0 2392 6476.868388 7950.768464 0 2393 5983.337253 3560.883132 0 2394 73.123 6947.913191 0 2395 8502.673632 96.430506 0 2396 6172.654931 3445.538667 0 2397 4107.302135 7332.569559 0 2398 4335.738191 5495.704256 0 2399 6931.70787 6600.312327 0 2400 4757.782593 5367.470136 0 2401 6448.565074 134.472428 0 2402 231.718949 4655.023551 0 2403 7073.549331 9509.898815 0 2404 5264.080767 6740.311318 0 2405 9209.378762 994.986401 0 2406 1274.388049 4766.331209 0 2407 5672.003248 3038.779391 0 2408 3862.790987 8695.763116 0 2409 5312.917905 5731.297673 0 2410 9282.763687 5951.152532 0 2411 4620.511084 1782.347072 0 2412 1910.719276 5053.185505 0 2413 453.134621 5090.571751 0 2414 8808.007276 3884.202485 0 2415 8385.023449 7515.342378 0 2416 8135.094453 3380.162389 0 2417 6097.584333 6528.490754 0 2418 993.716475 1701.63211 0 2419 6718.792666 7209.220801 0 2420 405.966896 4852.563879 0 2421 4796.748852 4244.396033 0 2422 7631.352454 9706.95116 0 2423 312.971676 9296.100806 0 2424 7363.983641 3822.592012 0 2425 2354.165733 5876.399727 0 2426 5349.362167 9485.807359 0 2427 9745.112402 7787.376071 0 2428 8779.659807 6919.216078 0 2429 7854.320578 5335.401858 0 2430 7009.010701 4369.308119 0 2431 9216.56263 9155.710347 0 2432 9966.150798 2562.62186 0 2433 2170.291026 6165.264616 0 2434 3696.251945 3967.181455 0 2435 7722.727046 6760.786544 0 2436 8537.993238 8083.02928 0 2437 4898.359245 1044.313704 0 2438 4221.732271 7893.526171 0 2439 3670.566372 8424.930406 0 2440 3991.216895 8179.202152 0 2441 7591.144771 6715.794821 0 2442 70.735306 9257.41661 0 2443 3669.585825 924.698958 0 2444 126.856742 8609.119052 0 2445 4184.986145 5864.812316 0 2446 9846.911374 9350.146178 0 2447 6298.47712 7315.130882 0 2448 6433.807214 4193.176502 0 2449 1159.945206 2070.426988 0 2450 2979.475116 2140.582673 0 2451 9317.072636 2050.288406 0 2452 2354.224144 6958.766861 0 2453 9707.615929 6375.854561 0 2454 2930.912666 8151.928706 0 2455 1563.354898 6490.276122 0 2456 4941.105545 7519.442598 0 2457 4858.927178 6213.373919 0 2458 30.512088 8435.75615 0 2459 7246.495207 1975.207516 0 2460 9463.325109 9897.546034 0 2461 6283.425528 8359.482563 0 2462 9897.881325 3049.795936 0 2463 1849.682389 3236.596614 0 2464 9668.617897 2958.470982 0 2465 4509.331173 8511.145593 0 2466 1774.746447 4539.010913 0 2467 2640.612108 4194.851864 0 2468 9609.172777 4373.186342 0 2469 616.805579 8927.341088 0 2470 8574.137724 3429.802926 0 2471 489.749113 4944.214252 0 2472 6408.406394 4387.840472 0 2473 673.59589 934.979009 0 2474 7484.405254 5348.132646 0 2475 6496.262243 2956.431629 0 2476 4363.712135 3413.274652 0 2477 6549.583126 4551.00052 0 2478 1115.045648 6787.762005 0 2479 9735.391859 4124.031108 0 2480 329.28887 5416.789528 0 2481 6375.972629 3543.370275 0 2482 8994.671928 9506.810128 0 2483 4703.438278 5039.071337 0 2484 4256.608875 6844.939717 0 2485 589.483751 3051.710391 0 2486 7998.925487 1947.117716 0 2487 5382.805234 2174.553103 0 2488 1147.798561 4048.957759 0 2489 5492.394273 2623.579824 0 2490 3397.625838 4515.255741 0 2491 7292.8161 1493.750103 0 2492 5883.512498 5977.961693 0 2493 9739.215061 6054.833502 0 2494 4065.045211 4821.738174 0 2495 6134.712378 5323.554122 0 2496 6740.703227 2937.283379 0 2497 2465.623612 9782.120824 0 2498 9415.446854 7393.905091 0 2499 9815.637487 9933.742193 0 2500 2707.570405 3454.910978 0 2501 9213.325498 7167.940239 0 2502 1490.567182 7883.066862 0 2503 1936.343071 2055.464598 0 2504 6137.491361 2086.011755 0 2505 3812.525858 1632.344163 0 2506 6895.116218 6151.794425 0 2507 9071.648623 954.787937 0 2508 9861.277023 3077.265637 0 2509 290.366192 3492.512858 0 2510 9475.049187 2902.393662 0 2511 4923.737077 2753.919007 0 2512 6766.421986 3716.286684 0 2513 9246.895061 1091.949411 0 2514 6265.613163 9874.735727 0 2515 3691.632533 5350.871383 0 2516 7734.485708 1456.08616 0 2517 4750.833259 8548.577695 0 2518 8802.188589 5268.133607 0 2519 7980.360409 5338.882443 0 2520 6816.250692 8102.893305 0 2521 761.007305 934.808944 0 2522 447.279043 8980.810169 0 2523 2197.437261 5055.239195 0 2524 3559.303785 3896.413636 0 2525 3485.362079 8672.55276 0 2526 1056.234665 7412.517502 0 2527 5031.310224 5857.054869 0 2528 4700.198175 7742.378727 0 2529 5430.449233 4106.78521 0 2530 4121.936311 4252.174913 0 2531 5524.577019 2440.749117 0 2532 9772.339097 8601.978644 0 2533 3369.91805 5318.940454 0 2534 6485.799791 4933.275615 0 2535 1725.951108 6437.842764 0 2536 6670.481606 5869.656897 0 2537 5209.857713 4689.474388 0 2538 9780.047191 979.454133 0 2539 8853.118324 18.561806 0 2540 7586.29265 4593.318787 0 2541 5322.12021 511.632417 0 2542 9552.380402 1809.098333 0 2543 8266.143091 9959.123854 0 2544 8869.914584 6367.051192 0 2545 1522.439581 5924.829324 0 2546 6760.184783 9291.206934 0 2547 6861.156278 1616.881971 0 2548 380.012924 8075.537571 0 2549 3523.47834 3358.112382 0 2550 3496.892693 9229.57071 0 2551 8362.427533 7908.651661 0 2552 4855.267236 9843.427137 0 2553 5783.775264 8883.830986 0 2554 9675.430475 6016.599738 0 2555 5930.70965 9631.376438 0 2556 302.791025 5384.852698 0 2557 1184.738178 8187.953209 0 2558 9356.334642 5607.736015 0 2559 2989.891907 9011.690685 0 2560 1027.08754 7890.169127 0 2561 415.876203 7763.686075 0 2562 7634.489922 7910.367721 0 2563 6628.518542 1821.687619 0 2564 8226.262069 2240.42031 0 2565 8288.206185 6268.715929 0 2566 8423.531928 5380.678312 0 2567 135.709671 9230.847011 0 2568 5673.218733 4463.436842 0 2569 4572.129653 5660.361032 0 2570 7819.589419 3163.317996 0 2571 4285.994431 1905.311507 0 2572 4802.190367 7769.205957 0 2573 426.471196 8475.595564 0 2574 1594.92717 1634.069124 0 2575 2118.360823 7407.192 0 2576 6864.824528 8478.228109 0 2577 1890.121365 9042.34633 0 2578 1612.307606 1605.769181 0 2579 4209.071984 3354.023733 0 2580 7598.480823 6755.779643 0 2581 596.526199 1097.870186 0 2582 5251.373955 1041.063813 0 2583 5619.138177 7187.288037 0 2584 6187.480918 94.41122 0 2585 9360.206141 2544.271345 0 2586 4578.453644 5246.927285 0 2587 9773.752849 3091.817944 0 2588 6576.416663 8384.209616 0 2589 5645.713256 2228.544602 0 2590 2780.975458 1307.58516 0 2591 7320.161137 4953.478364 0 2592 3293.342585 9182.428246 0 2593 1997.294369 1267.868038 0 2594 6205.589616 3937.249219 0 2595 3791.615595 5891.707553 0 2596 6091.403275 191.856271 0 2597 984.025882 475.894319 0 2598 339.005377 2113.240429 0 2599 9103.653975 765.89783 0 2600 1932.975875 5766.98098 0 2601 3786.203447 6657.687163 0 2602 2070.312595 6893.479576 0 2603 747.835838 3534.29649 0 2604 4272.862399 6141.688663 0 2605 175.548468 321.41893 0 2606 1151.085019 6015.618255 0 2607 4396.696403 6932.136407 0 2608 4475.821443 74.747 0 2609 2457.548681 9319.680499 0 2610 8326.839059 7514.54077 0 2611 3162.670045 7214.935162 0 2612 2765.824106 331.313681 0 2613 3909.82653 6927.580327 0 2614 2436.187486 9883.522107 0 2615 3158.773111 6246.711665 0 2616 1052.909944 884.880663 0 2617 8011.133027 5978.79661 0 2618 1061.987917 3915.566599 0 2619 6281.043678 8039.837717 0 2620 4383.690167 4585.143717 0 2621 8758.839213 5879.380114 0 2622 7714.720555 5484.821288 0 2623 6922.964388 8069.161575 0 2624 8337.487249 1841.99222 0 2625 7046.691944 7136.739176 0 2626 4331.642084 3036.645127 0 2627 2068.363587 9412.519418 0 2628 6857.361663 9227.639206 0 2629 6392.144949 3097.329904 0 2630 7822.456363 8657.068469 0 2631 8157.755595 5441.20483 0 2632 4992.32336 8195.120786 0 2633 7065.851922 836.965599 0 2634 7591.607288 8179.410742 0 2635 5050.744358 2221.262241 0 2636 4526.94574 4969.984433 0 2637 8254.179628 4956.350856 0 2638 8646.896285 4242.795076 0 2639 1776.086465 4098.562125 0 2640 7993.192417 6095.654378 0 2641 9131.991013 7092.741216 0 2642 6966.292887 9234.187407 0 2643 7188.988591 5445.381269 0 2644 8668.576681 9206.262693 0 2645 9265.197095 2263.274686 0 2646 4996.809126 6386.329899 0 2647 498.714207 4134.781806 0 2648 6047.05905 8407.577087 0 2649 420.218299 3212.092236 0 2650 3153.003666 1631.570237 0 2651 3252.119409 9913.785075 0 2652 4906.390068 731.465411 0 2653 7856.977425 9858.503263 0 2654 9215.589903 6100.42235 0 2655 4024.401974 8210.58976 0 2656 5732.061158 1783.753129 0 2657 6643.735321 4754.36733 0 2658 6987.586224 2059.881348 0 2659 2901.244729 3046.462382 0 2660 2903.40066 7034.728498 0 2661 3509.984186 6654.389209 0 2662 152.934387 249.966674 0 2663 4682.724095 9167.213436 0 2664 470.216881 857.424368 0 2665 9998.313133 3110.292236 0 2666 739.458794 625.174479 0 2667 801.005511 2239.486188 0 2668 5880.600632 345.266222 0 2669 8401.418301 9415.548095 0 2670 3336.547882 8300.156354 0 2671 6083.675285 238.669554 0 2672 8286.134725 9751.231194 0 2673 7334.640956 7282.971802 0 2674 4041.584677 8553.356425 0 2675 259.345192 3559.417304 0 2676 8288.173848 1706.676514 0 2677 1902.455046 527.189211 0 2678 292.017629 8868.750331 0 2679 7703.462363 5439.051778 0 2680 8447.721176 1517.000839 0 2681 9850.975499 7220.860005 0 2682 8187.199309 2577.126268 0 2683 191.627371 6123.364506 0 2684 7499.089573 9280.366197 0 2685 1490.470084 2241.466033 0 2686 6130.846644 8148.596088 0 2687 2969.84439 3913.211115 0 2688 6966.406239 779.947155 0 2689 4765.572788 2680.105512 0 2690 335.551414 3658.274753 0 2691 2977.878077 8946.164384 0 2692 5653.166417 2333.951272 0 2693 3070.580612 5245.968089 0 2694 9885.819576 2739.407188 0 2695 3778.332135 1120.234706 0 2696 769.896389 1971.287055 0 2697 6494.265137 6846.516057 0 2698 8232.585987 8267.145992 0 2699 2741.875266 3715.085957 0 2700 9452.040717 5242.117825 0 2701 6460.957113 7021.331088 0 2702 9228.402434 4101.283417 0 2703 7751.228179 4445.765827 0 2704 3420.621685 7369.915561 0 2705 6139.887383 3098.74847 0 2706 5876.786616 1053.46291 0 2707 9150.856809 315.567846 0 2708 713.013908 6960.328646 0 2709 7849.961984 9338.137772 0 2710 4227.099467 9408.592159 0 2711 5024.533949 910.57863 0 2712 2955.68248 4954.957028 0 2713 8812.036065 596.742057 0 2714 5422.281523 5499.144342 0 2715 8657.205215 3709.93887 0 2716 4740.103344 6645.673852 0 2717 2265.088706 6359.862987 0 2718 4494.804931 2404.128459 0 2719 2499.865887 5927.717032 0 2720 6780.140403 2835.32434 0 2721 3860.814895 9658.836008 0 2722 3455.485116 5915.160953 0 2723 4569.583098 4147.526559 0 2724 2310.374829 3736.644049 0 2725 8297.990908 4539.53416 0 2726 9965.912006 9535.846511 0 2727 2595.221668 1299.019436 0 2728 7063.507162 361.368281 0 2729 1954.053307 2923.826297 0 2730 2378.288663 4587.512174 0 2731 9523.679207 4870.562833 0 2732 3209.683662 1802.049227 0 2733 5032.98045 33.776254 0 2734 2208.84974 5381.276673 0 2735 8658.318607 3730.197311 0 2736 3326.990324 3099.780172 0 2737 8636.124107 5140.072685 0 2738 8989.457939 6740.612043 0 2739 2566.210277 3873.762359 0 2740 842.453064 576.386899 0 2741 9292.747224 5856.894773 0 2742 8215.738992 2277.768991 0 2743 5603.860542 5393.418724 0 2744 1275.14024 8130.134167 0 2745 9404.118008 9216.267441 0 2746 1724.076059 5840.973592 0 2747 9397.324699 9904.200111 0 2748 4968.575507 8860.388868 0 2749 8616.902199 8783.739898 0 2750 6786.445731 9374.240405 0 2751 6808.694404 1198.136792 0 2752 2101.265478 2206.273239 0 2753 1549.566483 5158.806926 0 2754 3060.616735 2950.281813 0 2755 3431.861714 1350.203787 0 2756 4782.2894 8883.20708 0 2757 5120.411383 7627.836051 0 2758 3891.678846 9913.298504 0 2759 3482.109729 3069.478606 0 2760 6785.084839 6994.86773 0 2761 3767.89372 4089.1554 0 2762 2109.83216 6150.906164 0 2763 2555.26681 5220.84495 0 2764 502.137218 4816.085143 0 2765 8649.983335 4125.333028 0 2766 5973.865832 1741.632523 0 2767 152.814954 2520.205073 0 2768 1759.538209 8181.404772 0 2769 2727.657656 9662.988635 0 2770 7084.618457 8473.209023 0 2771 1026.124461 4068.834539 0 2772 3307.166454 2056.020624 0 2773 9211.819905 7833.808754 0 2774 1642.069211 6026.06948 0 2775 8233.93642 3847.482079 0 2776 8239.087198 5348.986535 0 2777 7369.169604 8126.617638 0 2778 975.309591 7779.89777 0 2779 4526.229472 8444.256866 0 2780 1365.47087 3036.986141 0 2781 5347.217712 6530.689783 0 2782 3409.538401 6792.785034 0 2783 9313.345445 3353.80478 0 2784 676.131165 3632.786907 0 2785 145.375513 1472.262303 0 2786 6645.629947 2765.060431 0 2787 1270.883367 9121.035504 0 2788 1618.673902 3411.553329 0 2789 5012.932585 8626.719114 0 2790 7553.040477 5900.069628 0 2791 9786.697317 5144.944539 0 2792 1949.123259 4886.954638 0 2793 3729.187338 3946.702143 0 2794 4955.855325 8214.499164 0 2795 5463.248445 7027.239747 0 2796 9394.906702 1209.239253 0 2797 7277.77708 7912.825302 0 2798 6211.123605 7323.933637 0 2799 3160.764358 975.837243 0 2800 1505.547139 8347.839953 0 2801 4949.899281 1798.87094 0 2802 4597.035735 5263.027902 0 2803 4807.133312 259.865391 0 2804 1867.652327 6002.812686 0 2805 3405.202579 7764.722368 0 2806 3096.643236 7885.198394 0 2807 5649.477045 3230.587921 0 2808 3025.413948 4049.772835 0 2809 738.680265 7804.361246 0 2810 9182.855831 6399.379098 0 2811 5890.492599 7854.007217 0 2812 941.685512 7468.381086 0 2813 6862.394215 1533.374975 0 2814 5653.407303 8027.654952 0 2815 2420.373933 791.476038 0 2816 1031.686191 3072.044062 0 2817 3840.670011 8341.818774 0 2818 4772.199248 7637.165188 0 2819 2357.552593 6992.294788 0 2820 9760.527263 4137.286826 0 2821 8620.9135 561.669773 0 2822 778.560041 390.81248 0 2823 8598.892657 8320.253576 0 2824 7456.460823 8807.427728 0 2825 3022.098436 7735.478525 0 2826 8832.81088 6008.127544 0 2827 7988.699803 8339.661674 0 2828 6549.770125 7994.09757 0 2829 8951.476258 2147.695111 0 2830 2069.96211 6165.134642 0 2831 8813.798605 8169.244229 0 2832 8168.610089 1553.702956 0 2833 2639.810424 9358.21719 0 2834 7247.366903 7240.188746 0 2835 8440.652738 6790.531377 0 2836 2930.50726 8827.314633 0 2837 3310.303009 9462.34724 0 2838 6474.951428 1948.481398 0 2839 8555.27565 7948.039007 0 2840 8826.465518 6468.85361 0 2841 1448.954144 734.854486 0 2842 1319.436895 5288.512046 0 2843 4834.2404 5849.867541 0 2844 4452.183914 7155.253846 0 2845 5392.22778 6503.006481 0 2846 8557.922347 856.416047 0 2847 8494.489909 2377.705039 0 2848 9698.63034 4573.831829 0 2849 4166.770618 9736.384625 0 2850 5565.523596 440.477269 0 2851 8924.570458 2750.453548 0 2852 4014.167837 1444.875763 0 2853 9949.027466 6418.288411 0 2854 9043.364365 6198.085577 0 2855 8632.835343 8734.47787 0 2856 9575.678174 7600.166811 0 2857 9527.509447 6667.067412 0 2858 7403.010371 9257.355405 0 2859 9425.987311 9785.424962 0 2860 40.508303 5848.248833 0 2861 9604.008873 6490.805599 0 2862 1920.156646 1538.706289 0 2863 3362.156407 5277.24243 0 2864 4083.384133 3691.891103 0 2865 880.973288 6438.997745 0 2866 3882.001051 5108.613024 0 2867 520.776292 9950.785268 0 2868 2940.171309 7108.565274 0 2869 8019.506774 1697.585069 0 2870 3733.288791 3526.977098 0 2871 1715.723459 6566.423955 0 2872 7543.306663 6503.559275 0 2873 7366.920206 934.996614 0 2874 4151.748207 4979.465275 0 2875 9684.059211 4537.779233 0 2876 5392.370499 5249.633261 0 2877 1783.41521 0.232809 0 2878 8911.003392 9314.165569 0 2879 174.384973 1537.278906 0 2880 8806.785295 5707.128648 0 2881 856.41589 5224.567 0 2882 8037.32791 2598.588938 0 2883 4255.45209 7377.201533 0 2884 3924.439899 42.181442 0 2885 2848.389596 5523.691023 0 2886 6879.381485 4155.428082 0 2887 3175.489269 7047.21021 0 2888 9752.24011 8668.426128 0 2889 4935.264119 1277.248645 0 2890 6605.707633 2101.17342 0 2891 2270.221496 6280.204767 0 2892 2231.869245 7121.908753 0 2893 5042.461402 4331.764899 0 2894 8037.05706 4624.001525 0 2895 7208.626902 6195.359079 0 2896 7443.093924 8922.415407 0 2897 2137.435317 6779.173898 0 2898 44.526212 2159.791095 0 2899 7412.882087 3075.091003 0 2900 2173.572632 5574.076953 0 2901 8875.843168 5408.296685 0 2902 2131.214897 2932.239107 0 2903 1296.559949 3309.053103 0 2904 503.111938 6540.114363 0 2905 5308.94854 1110.936234 0 2906 468.967342 1468.647299 0 2907 8607.797842 9629.348115 0 2908 3050.724047 4411.107607 0 2909 1906.568677 7269.027129 0 2910 5091.777784 123.210237 0 2911 2332.772699 80.332128 0 2912 4376.00257 8711.739055 0 2913 8806.711331 6027.635622 0 2914 9595.751031 9114.091012 0 2915 5105.31266 3933.427774 0 2916 3154.09147 1668.969104 0 2917 5507.697176 4738.414076 0 2918 100.873381 338.368214 0 2919 2172.565395 2597.816755 0 2920 4499.317742 9022.76969 0 2921 9236.117245 2697.67738 0 2922 6785.427973 5561.005282 0 2923 9002.000873 3025.154096 0 2924 4441.459046 5948.937203 0 2925 4194.834091 4181.456223 0 2926 2005.936736 7417.401177 0 2927 8137.026104 6513.31221 0 2928 5627.950373 8803.807397 0 2929 8601.166884 198.088475 0 2930 6791.280737 206.250006 0 2931 4070.960608 2009.003141 0 2932 2049.917156 4356.664576 0 2933 457.693179 7245.569371 0 2934 4914.026293 8727.127038 0 2935 2732.160269 9673.999966 0 2936 9629.856741 3828.629075 0 2937 1543.144631 1250.670926 0 2938 688.188685 421.845341 0 2939 8683.971882 3641.248012 0 2940 4674.63969 4360.30492 0 2941 8019.204453 4010.954876 0 2942 3570.65132 6786.477678 0 2943 3837.383313 6577.099909 0 2944 4581.164568 5682.483435 0 2945 4025.692386 2533.414798 0 2946 9435.091287 5887.226992 0 2947 6360.908015 2865.923879 0 2948 6360.060547 5526.518729 0 2949 5813.725125 5391.18293 0 2950 2574.90174 6544.517173 0 2951 807.343862 3109.986591 0 2952 3036.126625 4343.976052 0 2953 27.367212 2046.607027 0 2954 8539.927772 7919.544816 0 2955 132.731106 6067.308834 0 2956 5150.682055 974.225656 0 2957 7417.163011 3622.331972 0 2958 3822.146276 3658.391813 0 2959 6083.105559 8337.04087 0 2960 8424.342812 3125.68001 0 2961 8975.68822 586.458899 0 2962 6229.592748 7004.917759 0 2963 9557.49144 4172.164284 0 2964 4146.208043 6276.98818 0 2965 3401.672045 9686.617234 0 2966 3478.293297 1468.927362 0 2967 3395.031846 2545.741971 0 2968 9985.166028 8882.975268 0 2969 7340.292159 2742.107335 0 2970 2816.809482 1518.691287 0 2971 5847.629636 2207.345933 0 2972 1045.588719 9009.539184 0 2973 2690.986577 6260.072953 0 2974 1293.822288 2846.38002 0 2975 1384.327184 2760.555003 0 2976 94.033125 3617.861743 0 2977 9388.597731 6259.298557 0 2978 9491.81465 4512.72254 0 2979 595.259016 1535.53545 0 2980 4872.099252 2279.065872 0 2981 916.514256 2626.442946 0 2982 4682.154455 4206.30081 0 2983 7494.95062 9405.52306 0 2984 5432.240455 909.605084 0 2985 1174.039776 4033.436274 0 2986 858.821485 5433.221802 0 2987 7095.073749 2897.207279 0 2988 5218.04586 9790.806696 0 2989 1664.727383 9294.014683 0 2990 4147.77614 8803.477529 0 2991 3738.98985 9181.53139 0 2992 8812.521088 8306.715098 0 2993 3293.30848 2592.760564 0 2994 983.713365 7794.622435 0 2995 4003.342341 4649.295638 0 2996 953.350341 693.24396 0 2997 8415.958349 5586.555171 0 2998 1652.620841 1894.027113 0 2999 3601.662051 2658.127996 0 3000 1364.799573 75.990982 0 3001 9551.78718 4442.97368 0 3002 6612.894591 5655.576908 0 3003 7016.993659 8907.396631 0 3004 3290.320723 6570.53448 0 3005 148.526101 2967.257288 0 3006 261.488515 4435.059792 0 3007 8569.713914 8931.851494 0 3008 6708.94181 8459.478366 0 3009 4728.256223 823.004174 0 3010 4649.68433 7182.444292 0 3011 2252.05796 1278.952628 0 3012 9846.938735 4463.823593 0 3013 6483.26761 9922.760155 0 3014 6981.967833 4141.317891 0 3015 5402.397164 4963.895937 0 3016 4510.911652 5676.822433 0 3017 3091.129667 1147.603028 0 3018 9629.193848 9037.852827 0 3019 6876.843752 4412.322496 0 3020 8903.440356 4653.487939 0 3021 6428.589077 9253.110032 0 3022 1782.644253 7656.577363 0 3023 9338.514481 4111.906427 0 3024 5610.569245 3309.628454 0 3025 9310.899801 3355.370623 0 3026 2432.885429 3920.470712 0 3027 968.32375 1593.463082 0 3028 968.918573 7114.698898 0 3029 3320.831789 373.679017 0 3030 6908.995145 2989.66045 0 3031 8105.57129 9178.835912 0 3032 5852.982228 9320.820638 0 3033 9230.951459 3927.475324 0 3034 7127.303746 198.968669 0 3035 6326.920374 9685.362831 0 3036 5695.652151 2970.08912 0 3037 5397.050124 3819.33736 0 3038 2953.801757 4490.13529 0 3039 2253.992877 4739.227818 0 3040 2384.840981 180.393987 0 3041 222.202639 4236.974727 0 3042 2985.066472 392.100893 0 3043 8165.570557 980.96459 0 3044 3081.94991 8223.626637 0 3045 7351.167883 4284.886364 0 3046 7668.687058 2594.347404 0 3047 4218.578829 8115.314582 0 3048 3116.124539 8038.481063 0 3049 4369.217473 7035.63218 0 3050 1792.681341 4546.713552 0 3051 1341.043718 5634.493096 0 3052 1291.972939 9425.620271 0 3053 9226.319289 2770.01106 0 3054 3167.99269 42.851507 0 3055 9954.613303 5767.71175 0 3056 3179.668377 9959.357533 0 3057 2664.676428 6516.313813 0 3058 4274.45694 1201.40755 0 3059 2569.874502 7053.240329 0 3060 2317.147598 3138.319027 0 3061 1799.285473 373.963633 0 3062 524.022132 1954.413569 0 3063 947.276035 6871.180762 0 3064 8845.781157 4951.569519 0 3065 3065.633341 5044.34618 0 3066 7158.878885 6317.019494 0 3067 1598.396813 7728.969026 0 3068 8988.821931 5024.85692 0 3069 6943.793115 5816.335523 0 3070 1660.731469 3846.584126 0 3071 9640.38423 536.601732 0 3072 7643.348323 6187.00351 0 3073 5687.646472 4928.213726 0 3074 1500.484899 6097.111615 0 3075 9441.432619 5078.382265 0 3076 8489.054062 6845.220482 0 3077 1723.481609 8211.547124 0 3078 1693.052301 9426.813991 0 3079 1602.675141 4114.650108 0 3080 8264.175864 3606.427434 0 3081 6164.001556 6631.010727 0 3082 2903.117106 4050.922052 0 3083 5850.890235 5006.636061 0 3084 9378.438534 7239.150812 0 3085 857.914761 6849.920205 0 3086 5922.882741 5264.499339 0 3087 3246.854196 7772.8471 0 3088 9090.025276 3242.831229 0 3089 4837.067696 7164.042113 0 3090 7609.512873 2826.103774 0 3091 5745.387589 8752.211893 0 3092 713.008572 8273.051014 0 3093 7015.284098 8272.095783 0 3094 8885.566166 7439.419049 0 3095 6660.288504 947.380062 0 3096 5712.608337 340.109714 0 3097 4367.148374 844.557919 0 3098 6082.579489 326.587485 0 3099 7365.583415 6664.383727 0 3100 842.08745 1310.662829 0 3101 7734.124928 7447.969884 0 3102 9082.060967 3512.646413 0 3103 2070.018112 9547.136294 0 3104 4731.03231 5664.906199 0 3105 908.576166 8066.33521 0 3106 2230.785181 9503.491782 0 3107 4629.149651 1579.781209 0 3108 6033.085911 2499.798845 0 3109 1131.668635 4860.826648 0 3110 5040.870731 7113.659908 0 3111 9003.883779 2173.071759 0 3112 8251.881444 4535.483687 0 3113 1259.74579 7509.952621 0 3114 3860.355693 5601.707383 0 3115 32.195635 2473.230178 0 3116 5791.533915 309.553055 0 3117 1315.441064 5246.59329 0 3118 2204.678558 7043.080775 0 3119 8926.489723 1646.029084 0 3120 3716.720209 716.139407 0 3121 9395.966619 7123.949286 0 3122 1438.568958 2325.585147 0 3123 6139.381037 2991.133657 0 3124 1575.440372 8351.889828 0 3125 2759.091206 7009.190461 0 3126 3970.040111 2385.646473 0 3127 8647.69468 7033.895641 0 3128 4131.080408 6270.255366 0 3129 1367.930577 9750.564343 0 3130 7518.196099 8233.795009 0 3131 2062.264619 8396.583203 0 3132 3180.01618 3404.33947 0 3133 6675.08182 8737.921412 0 3134 6824.788379 2902.778774 0 3135 8245.632461 1349.429909 0 3136 9426.726702 7057.115895 0 3137 5615.424353 2090.16907 0 3138 4607.408042 4237.204509 0 3139 5289.660329 7652.416317 0 3140 8235.831087 4823.648298 0 3141 6155.205667 8126.97732 0 3142 7143.837215 5983.560759 0 3143 4023.675854 620.11725 0 3144 8317.790543 2024.580887 0 3145 5692.858203 2110.013476 0 3146 37.880523 4032.539019 0 3147 5407.700175 2606.166263 0 3148 506.172912 7708.521807 0 3149 4836.465631 542.854405 0 3150 1374.156764 7025.142024 0 3151 9852.644108 9379.685418 0 3152 9616.122794 4563.02079 0 3153 6589.476992 837.09763 0 3154 5881.410962 7377.004529 0 3155 8976.545036 826.267 0 3156 4138.541726 2715.665341 0 3157 1153.923969 2343.758072 0 3158 8005.815929 5551.270797 0 3159 5474.91835 2307.18027 0 3160 8255.954986 4845.652542 0 3161 8345.452474 4383.822769 0 3162 17.383411 2266.889312 0 3163 6089.127177 1668.528996 0 3164 4845.133182 5980.946525 0 3165 3906.57605 285.60541 0 3166 619.794434 8095.559113 0 3167 4950.386405 952.085411 0 3168 2050.15178 3212.880513 0 3169 552.171599 6069.895374 0 3170 5007.726668 7778.783566 0 3171 4765.511939 5445.007737 0 3172 8039.314585 8270.560181 0 3173 3263.690222 976.726238 0 3174 8975.522171 7708.953564 0 3175 196.175595 600.292583 0 3176 8636.172789 4032.803502 0 3177 54.457297 5659.330886 0 3178 9962.770261 9833.79276 0 3179 2442.369965 7381.838107 0 3180 1854.728722 8196.119785 0 3181 6150.406462 8168.219795 0 3182 6874.30087 8313.374703 0 3183 1374.770643 2702.964531 0 3184 1868.18739 1237.320204 0 3185 2220.387022 833.888596 0 3186 4492.851531 3452.099983 0 3187 88.712137 1955.084305 0 3188 7023.195121 434.199938 0 3189 185.987447 8565.611928 0 3190 9150.431795 369.444224 0 3191 2598.598225 3584.099776 0 3192 5809.760176 6272.368182 0 3193 9644.168494 2703.959742 0 3194 4016.087751 3761.924606 0 3195 8385.76498 1931.426266 0 3196 9092.93855 6620.740272 0 3197 4892.023492 7195.19726 0 3198 1967.177469 440.535939 0 3199 8654.611326 3566.678537 0 3200 8734.394845 6234.105658 0 3201 5821.004918 8826.023486 0 3202 3038.437583 3832.080979 0 3203 8447.990115 9074.604513 0 3204 7857.866298 9189.6314 0 3205 5504.510721 1732.923457 0 3206 8482.354537 8833.285419 0 3207 3041.916535 6668.164973 0 3208 188.05621 9261.011031 0 3209 3471.348294 5639.267591 0 3210 6841.247331 8234.390134 0 3211 7069.76651 3270.310886 0 3212 9306.548655 2229.209447 0 3213 7469.148254 5071.006658 0 3214 2534.43204 5127.643583 0 3215 3149.177112 5208.61825 0 3216 2085.553752 2644.141491 0 3217 2446.142061 8615.978272 0 3218 3915.342938 8569.231595 0 3219 3787.590777 3204.527224 0 3220 6641.077655 4045.661561 0 3221 8187.086674 6471.856351 0 3222 6998.106398 9698.200396 0 3223 8449.328846 3416.367832 0 3224 4594.112554 8660.118442 0 3225 8927.838425 5388.853959 0 3226 5456.980604 832.804461 0 3227 2127.551225 1183.145364 0 3228 3253.077012 159.208725 0 3229 5077.260579 5.960774 0 3230 3596.970698 1021.316245 0 3231 2431.661664 6641.248035 0 3232 2644.847114 57.739288 0 3233 8255.777012 5390.230981 0 3234 8825.919902 2685.545077 0 3235 3198.052862 308.438088 0 3236 5076.060054 8947.644801 0 3237 17.860156 5775.221913 0 3238 2403.334265 6868.611773 0 3239 9254.648375 4843.572251 0 3240 8767.624805 3857.055681 0 3241 2176.915722 4226.902705 0 3242 6586.011057 8023.516692 0 3243 6769.876056 718.425761 0 3244 7954.883479 1325.209918 0 3245 1150.600397 2123.478659 0 3246 1742.115899 1931.642066 0 3247 2005.08162 5352.999744 0 3248 8603.035739 5254.104976 0 3249 6573.93157 7822.972232 0 3250 9901.066845 2742.922736 0 3251 9420.45083 1955.402605 0 3252 1927.960312 7958.818736 0 3253 789.615155 9012.291567 0 3254 9031.107397 7021.293178 0 3255 6966.172073 4795.562121 0 3256 707.413375 3458.197104 0 3257 7607.273907 5876.926247 0 3258 3058.463012 1721.98429 0 3259 2106.610687 5341.710497 0 3260 7000.312789 9442.904552 0 3261 7806.330826 7061.13045 0 3262 6328.16788 9980.030756 0 3263 6094.928445 7816.579359 0 3264 4020.863529 1393.45859 0 3265 3671.792132 7923.533358 0 3266 5081.050333 4955.600282 0 3267 2080.334239 3624.449407 0 3268 7493.907854 4171.806518 0 3269 1756.402607 9588.065669 0 3270 9330.785413 8605.871025 0 3271 4892.750477 9867.210689 0 3272 713.072985 6549.282352 0 3273 321.173876 3444.760429 0 3274 5598.654965 4829.719801 0 3275 4364.30222 9373.773528 0 3276 8833.746287 8906.205109 0 3277 7800.743515 2015.504976 0 3278 6612.402204 3699.62047 0 3279 8888.346051 3443.951125 0 3280 5967.6789 8269.457902 0 3281 3288.572665 1213.007922 0 3282 3568.586863 2703.927749 0 3283 3510.5149 9767.405175 0 3284 8594.965735 5845.574971 0 3285 8398.701429 5054.494387 0 3286 9312.47465 2532.484111 0 3287 9008.750928 5640.862216 0 3288 1109.322696 4731.971554 0 3289 3143.678893 2214.298193 0 3290 7869.360852 1683.066743 0 3291 6253.010124 5535.543227 0 3292 5479.723771 1871.149949 0 3293 7012.773762 4732.372573 0 3294 5580.577384 9283.505705 0 3295 9936.398393 6097.197434 0 3296 5023.471844 9777.604692 0 3297 331.159771 1644.058903 0 3298 7048.392657 3143.480597 0 3299 4977.373436 6229.072774 0 3300 4032.619002 5910.664941 0 3301 3178.225394 1597.768162 0 3302 6380.346395 1630.493744 0 3303 1687.962188 8498.71393 0 3304 7754.385309 998.789191 0 3305 7364.060905 8230.651961 0 3306 8255.371443 6230.510564 0 3307 5379.812616 6096.960858 0 3308 3203.794966 5801.277721 0 3309 7896.865875 4445.489833 0 3310 1085.007816 8389.287246 0 3311 2924.66032 4419.177962 0 3312 6583.893139 8036.032317 0 3313 6398.758838 3860.831518 0 3314 1063.078482 9676.468307 0 3315 4974.921009 4417.413412 0 3316 7623.274417 7412.322549 0 3317 7044.646376 9797.354164 0 3318 8322.68288 6279.116746 0 3319 1281.818582 8300.786806 0 3320 5157.17165 5849.530298 0 3321 5569.197345 2221.670391 0 3322 5567.175851 4698.30473 0 3323 8971.252082 9410.968054 0 3324 9830.083297 5293.328186 0 3325 2912.693433 944.263696 0 3326 212.897844 2764.991703 0 3327 395.341656 7175.852154 0 3328 4780.235666 8198.205497 0 3329 8337.40912 4726.718348 0 3330 4818.294837 5301.692138 0 3331 6550.989873 4759.502591 0 3332 9598.662894 2755.715521 0 3333 381.009495 9719.513064 0 3334 876.524689 1880.40951 0 3335 2738.987777 8409.775767 0 3336 3161.735161 6559.025387 0 3337 8462.983085 5433.018387 0 3338 2280.732337 5133.815712 0 3339 228.988138 3661.466838 0 3340 1801.747181 4021.728521 0 3341 601.08171 6700.910694 0 3342 6893.010018 8067.394105 0 3343 5959.050133 1233.332925 0 3344 1455.875813 9842.480396 0 3345 6958.056422 6624.665324 0 3346 4874.005502 3237.374404 0 3347 8501.091344 9397.065205 0 3348 2497.14776 3438.073314 0 3349 3183.500887 9850.833429 0 3350 5759.420574 7424.448086 0 3351 3335.283979 3266.900394 0 3352 7448.790933 8153.203011 0 3353 1429.570499 8754.411048 0 3354 6517.271004 3038.996338 0 3355 1954.513641 9467.875935 0 3356 5217.954722 4391.94517 0 3357 3057.984189 6603.150589 0 3358 89.141191 9113.665617 0 3359 6162.210465 6.153871 0 3360 616.690367 5999.791769 0 3361 2405.68977 3314.374414 0 3362 8735.54806 7865.951813 0 3363 5154.255537 8768.110192 0 3364 5817.239421 2802.442835 0 3365 9760.425697 593.142345 0 3366 689.722073 8960.930323 0 3367 5508.724327 8762.488967 0 3368 7934.091284 7326.167544 0 3369 9560.559477 3445.82571 0 3370 6257.69694 9061.304379 0 3371 2459.820926 60.923505 0 3372 5456.594403 4277.922567 0 3373 3974.936879 3846.827705 0 3374 6760.26144 5266.61627 0 3375 4418.641795 6788.289704 0 3376 3589.767596 4903.410967 0 3377 3346.76846 5276.536971 0 3378 9060.637234 1011.487956 0 3379 6244.012639 1795.93961 0 3380 9233.186293 8211.386943 0 3381 4050.789352 9530.128616 0 3382 575.169231 6095.608336 0 3383 3540.619402 7904.456628 0 3384 9948.714782 2907.503766 0 3385 6158.171332 6526.433804 0 3386 3127.380071 2984.330703 0 3387 1012.023342 9459.86153 0 3388 4940.859604 7014.395405 0 3389 7865.09003 2678.649453 0 3390 1945.220605 3730.207253 0 3391 6098.610974 5287.753939 0 3392 1154.986039 9829.050362 0 3393 9891.975998 8481.81168 0 3394 1702.700185 4192.418664 0 3395 8061.548145 9883.205769 0 3396 6165.32724 1780.139922 0 3397 9042.981893 2959.138319 0 3398 8151.639518 6604.822745 0 3399 3445.947516 6072.112867 0 3400 3758.489907 6010.453604 0 3401 7828.695167 7181.975238 0 3402 5818.600611 7194.167135 0 3403 8035.383903 3776.267464 0 3404 2051.726061 6911.386311 0 3405 2085.05582 6582.03005 0 3406 7367.477624 3372.912966 0 3407 2281.14542 7483.027372 0 3408 9751.450903 7537.350484 0 3409 8718.757089 4767.434147 0 3410 2496.183571 1095.936755 0 3411 1498.434896 2713.590024 0 3412 7821.08503 1287.266819 0 3413 9986.246066 419.103427 0 3414 5696.659288 5753.309854 0 3415 5016.228361 1659.822566 0 3416 4645.759975 8481.000441 0 3417 2568.760028 3687.503385 0 3418 3057.323758 3902.645031 0 3419 6122.390958 5222.385382 0 3420 9575.421469 4691.490288 0 3421 3043.111805 181.886734 0 3422 2936.015994 8320.733044 0 3423 9956.935786 5725.734725 0 3424 4824.580996 3862.152002 0 3425 3317.421952 3500.604675 0 3426 8090.579966 3449.843996 0 3427 5763.743554 1427.187437 0 3428 8801.734165 3071.522123 0 3429 4574.617456 2513.569528 0 3430 1644.170535 9391.731509 0 3431 7037.23613 9276.340647 0 3432 406.256466 5525.456736 0 3433 5996.397151 9641.417166 0 3434 7164.662214 6334.575355 0 3435 2682.346032 8957.09497 0 3436 5913.05266 9.801959 0 3437 6394.569003 8603.128443 0 3438 988.248188 1920.781887 0 3439 5439.058347 418.609227 0 3440 3875.433036 5780.926368 0 3441 2458.586032 8508.706432 0 3442 991.341646 8017.251682 0 3443 2094.571046 8341.624825 0 3444 6555.189844 7460.74601 0 3445 5195.577548 8213.344339 0 3446 1620.206642 7538.294243 0 3447 194.181671 2509.842578 0 3448 852.628723 4520.78136 0 3449 2762.470378 8824.886632 0 3450 406.404988 7621.321004 0 3451 8770.592811 6196.921098 0 3452 1972.199575 17.287518 0 3453 861.091554 8271.472865 0 3454 6425.630778 9058.491991 0 3455 6967.089349 1081.153683 0 3456 6422.946322 3157.15403 0 3457 6263.383864 1794.584433 0 3458 7965.660262 7046.604416 0 3459 5249.417246 6027.635343 0 3460 4320.314122 5132.949742 0 3461 5090.439522 3345.900617 0 3462 2712.324375 3818.387571 0 3463 1093.743337 1.640666 0 3464 7543.264583 8737.346089 0 3465 3446.34673 2944.225337 0 3466 7401.351039 8859.719625 0 3467 469.556032 1825.812457 0 3468 988.282505 3588.843384 0 3469 8319.073837 347.547289 0 3470 3316.863071 9403.143766 0 3471 5724.395977 3169.021315 0 3472 8674.854239 7542.243829 0 3473 547.087349 8832.628946 0 3474 9179.711664 4998.551189 0 3475 6281.641028 4039.22271 0 3476 3424.010751 6309.454668 0 3477 7718.286897 4483.57255 0 3478 5430.708777 1365.379126 0 3479 3421.481031 4441.343987 0 3480 8921.501443 6110.003901 0 3481 3564.957415 8046.758284 0 3482 2394.011941 5809.061499 0 3483 9443.891926 129.552906 0 3484 5780.188309 7730.098278 0 3485 5438.061958 2463.19837 0 3486 8682.390458 6074.103205 0 3487 4167.150258 4410.466868 0 3488 8843.247129 6743.558817 0 3489 9897.73211 6713.372813 0 3490 1077.391729 4931.92999 0 3491 6363.208894 157.540432 0 3492 1557.081691 6451.455112 0 3493 522.080346 7087.861708 0 3494 1342.65536 4339.671146 0 3495 7969.015008 6375.395659 0 3496 2045.426828 5599.075332 0 3497 7155.657859 2086.534871 0 3498 672.136915 1541.334729 0 3499 7799.346522 1991.621658 0 3500 7802.709016 9560.088719 0 3501 7065.738406 8067.787488 0 3502 7848.25241 7323.475814 0 3503 6943.32731 92.788913 0 3504 4619.061166 4003.751596 0 3505 7823.247613 7674.530585 0 3506 4393.430926 7299.724808 0 3507 1746.748349 8614.753798 0 3508 741.855517 4643.948527 0 3509 3242.665662 8373.415163 0 3510 3864.291597 1175.999554 0 3511 6872.109726 1819.590359 0 3512 9104.300932 7274.375822 0 3513 7398.473056 3116.241334 0 3514 9538.909488 4128.021192 0 3515 2671.307691 6536.417345 0 3516 8244.393998 9372.771068 0 3517 4157.568577 7391.422446 0 3518 878.897633 9270.223576 0 3519 92.062785 5415.006986 0 3520 2966.812829 3901.335565 0 3521 4416.293773 4960.381415 0 3522 8082.616398 4766.628556 0 3523 5053.358096 270.078324 0 3524 3626.256975 8204.686213 0 3525 3078.512695 8786.008526 0 3526 4308.6319 2777.899674 0 3527 1266.89315 2420.413057 0 3528 6120.997257 2044.742671 0 3529 9740.308713 8668.119584 0 3530 4950.020157 9535.038136 0 3531 547.170685 6581.453051 0 3532 4716.901173 443.707333 0 3533 6974.999735 6172.651433 0 3534 6871.88043 2281.7066 0 3535 771.863277 2414.860141 0 3536 4240.878937 6594.894353 0 3537 7241.917161 3042.44539 0 3538 8256.063546 6356.155921 0 3539 2140.119095 9743.957267 0 3540 9090.503596 7966.845024 0 3541 5713.092123 2935.402638 0 3542 1473.210878 2550.682889 0 3543 5471.476071 4168.46113 0 3544 2453.625264 6776.411983 0 3545 5078.684895 1359.154423 0 3546 2749.930888 3600.453453 0 3547 2641.225898 9421.129808 0 3548 2189.512689 8108.734022 0 3549 182.275215 6034.662553 0 3550 751.642547 2692.044567 0 3551 9889.306964 303.762954 0 3552 3788.329916 4402.578291 0 3553 3746.788906 7086.663016 0 3554 7741.751208 7251.572518 0 3555 2604.456192 5400.614686 0 3556 8467.212146 3391.887365 0 3557 2905.284837 7336.592811 0 3558 33.115548 7176.977852 0 3559 3755.778137 8150.588524 0 3560 8852.37348 4984.495624 0 3561 4798.080676 3660.544273 0 3562 7956.047815 1579.832138 0 3563 3948.878988 2450.550708 0 3564 1060.271263 7608.234595 0 3565 8830.075108 7836.07132 0 3566 2007.999815 2752.082457 0 3567 5970.491448 2581.923844 0 3568 3025.496309 5192.988004 0 3569 8014.992269 5989.805114 0 3570 9664.50847 3345.748099 0 3571 7888.879006 5690.280868 0 3572 2005.360312 1165.92628 0 3573 4978.585858 2025.953677 0 3574 3943.366588 429.799701 0 3575 4345.594575 3802.204659 0 3576 4636.981996 8115.045369 0 3577 6436.513787 3270.372449 0 3578 216.167483 1423.620391 0 3579 5046.066416 8811.70554 0 3580 4593.463442 4203.638282 0 3581 5063.222798 1305.634838 0 3582 8006.884919 4906.625953 0 3583 734.596689 9129.451442 0 3584 684.639405 285.333464 0 3585 25.714628 5452.278851 0 3586 3247.395729 654.728142 0 3587 452.740581 4702.053483 0 3588 706.819712 1998.181774 0 3589 7423.041519 3091.713362 0 3590 293.794961 9581.128278 0 3591 9334.591365 6376.814408 0 3592 7601.723912 9258.822643 0 3593 3437.796307 6260.448769 0 3594 9757.96305 616.401944 0 3595 8614.508036 4521.105984 0 3596 9172.20671 3766.309697 0 3597 431.873121 5157.598705 0 3598 9300.701632 5508.403113 0 3599 2412.210143 6792.558267 0 3600 5539.227575 5533.585958 0 3601 2389.539559 2204.645756 0 3602 109.159583 9690.202171 0 3603 7511.855963 9009.444652 0 3604 4528.136469 2365.292526 0 3605 4728.149928 9746.281852 0 3606 8711.215683 7294.996181 0 3607 6787.59713 4297.082249 0 3608 5726.469863 7597.461683 0 3609 2399.98037 669.694339 0 3610 7342.354311 4835.018619 0 3611 6615.268452 2884.697761 0 3612 7084.491796 8640.958811 0 3613 6037.926172 54.112614 0 3614 8151.75197 2247.64848 0 3615 4670.562521 892.593327 0 3616 3966.971362 8931.940874 0 3617 4968.278781 7142.46015 0 3618 4510.796566 4952.592183 0 3619 2748.590601 6768.298393 0 3620 2023.179022 9040.484771 0 3621 8413.706091 2533.79086 0 3622 5128.936253 9541.017249 0 3623 8537.978068 1055.347919 0 3624 4079.878998 3771.133686 0 3625 8793.929884 9616.220077 0 3626 7718.1607 6426.021726 0 3627 2652.386192 2646.39202 0 3628 4458.877552 4087.001414 0 3629 7057.798056 4178.95088 0 3630 8861.021309 1023.593314 0 3631 1490.446025 7640.695041 0 3632 8809.636573 5306.728325 0 3633 5557.015882 5806.112917 0 3634 8104.13418 8420.648576 0 3635 3178.100153 3999.837776 0 3636 7256.040864 6916.85222 0 3637 5259.173491 3002.632635 0 3638 6973.617435 7738.012174 0 3639 6793.328728 9159.295113 0 3640 300.76936 2480.048118 0 3641 2020.176729 2068.437773 0 3642 421.392859 6463.809132 0 3643 5870.705018 1857.309293 0 3644 5499.495234 2791.187496 0 3645 7978.525169 6936.917524 0 3646 4932.957804 6885.649052 0 3647 8821.502956 6015.877128 0 3648 3591.900614 1761.265441 0 3649 4784.124593 76.76132 0 3650 2661.172018 5261.651767 0 3651 5468.901601 1766.162195 0 3652 3926.683784 4744.663802 0 3653 8491.505347 2030.812444 0 3654 3675.480148 9193.041741 0 3655 3625.119545 5462.873759 0 3656 5208.575077 9142.661053 0 3657 9465.37206 2838.063053 0 3658 6037.888087 7386.056684 0 3659 469.509215 7523.270642 0 3660 3895.659262 6497.670683 0 3661 3935.078308 1916.818991 0 3662 6555.572876 574.623225 0 3663 5708.599826 5254.593615 0 3664 216.471752 6736.431742 0 3665 4967.171611 2465.750453 0 3666 5358.21783 6519.40149 0 3667 6192.530845 7093.330773 0 3668 2224.732596 9168.398187 0 3669 4968.846867 2768.100968 0 3670 5969.502914 873.938792 0 3671 177.491148 2551.913864 0 3672 8496.13412 1056.93208 0 3673 5315.9207 7471.19352 0 3674 5768.208006 2297.481013 0 3675 4907.855003 4123.078493 0 3676 1184.234685 3534.042226 0 3677 9901.205287 470.251299 0 3678 1537.157809 8510.078872 0 3679 8545.956001 1092.692163 0 3680 8471.188977 8647.487192 0 3681 4845.141872 1743.452573 0 3682 4955.618749 246.331433 0 3683 7702.268787 1930.877291 0 3684 3299.761391 5897.462354 0 3685 6537.244914 2391.476793 0 3686 3849.720918 5901.046492 0 3687 2680.693873 8590.040012 0 3688 5221.937355 6505.087838 0 3689 8546.37834 811.087915 0 3690 8296.660475 2642.189292 0 3691 2080.849379 6828.290521 0 3692 4311.805194 7504.876803 0 3693 919.899568 6263.784242 0 3694 4784.238912 7409.512389 0 3695 255.833584 730.348814 0 3696 6513.919554 9940.553507 0 3697 1128.892345 2521.19984 0 3698 525.506307 8150.785771 0 3699 1064.557709 7170.872508 0 3700 3769.023211 5346.316469 0 3701 3738.941545 2091.864508 0 3702 8495.895226 695.95177 0 3703 3763.383459 7841.035062 0 3704 5037.728785 5188.324514 0 3705 1127.996255 2101.009799 0 3706 7309.495862 3127.652918 0 3707 7378.592801 5987.70611 0 3708 6969.775313 2995.757493 0 3709 4156.046647 8507.888023 0 3710 1921.98318 736.940418 0 3711 8007.330931 8624.987226 0 3712 1792.736868 8163.200597 0 3713 2299.21851 7921.267212 0 3714 6896.524185 4618.402646 0 3715 3930.338182 8701.668103 0 3716 2146.685785 5857.597618 0 3717 1879.35307 9322.250567 0 3718 1008.186796 9369.309649 0 3719 8966.60177 9677.790011 0 3720 7213.072792 9452.19303 0 3721 148.529866 3627.116591 0 3722 5281.058268 5663.480376 0 3723 293.160408 8695.696223 0 3724 1378.217124 1375.701181 0 3725 757.377926 8954.632459 0 3726 2159.255219 6219.846084 0 3727 8998.638329 6927.424498 0 3728 6857.458 8163.211409 0 3729 813.135866 6548.285685 0 3730 4165.530825 7168.169788 0 3731 6512.958183 3139.896463 0 3732 5680.192526 7650.044718 0 3733 9050.596408 8887.61552 0 3734 1901.57249 4060.486288 0 3735 9253.625731 5972.625231 0 3736 770.202558 2395.790534 0 3737 2926.366846 7114.303093 0 3738 4354.539014 4098.604996 0 3739 7917.308631 624.329626 0 3740 3916.902563 9830.974931 0 3741 8066.510709 7989.810288 0 3742 1019.819901 1129.155425 0 3743 202.740974 441.627355 0 3744 9624.348833 9433.751967 0 3745 9576.745825 5621.685443 0 3746 1431.622691 944.534897 0 3747 8427.228785 5728.411976 0 3748 9682.058722 2051.147688 0 3749 2362.178997 7812.770829 0 3750 723.905198 6586.580927 0 3751 2178.76686 6547.586381 0 3752 7906.103746 9039.173681 0 3753 8567.153541 5387.622292 0 3754 7041.842335 3485.081101 0 3755 6667.209172 6103.331894 0 3756 4349.041163 3790.558844 0 3757 4835.654156 9363.094593 0 3758 8232.011955 72.262154 0 3759 8014.36545 4022.95734 0 3760 9782.008152 1303.167473 0 3761 8489.994911 4901.377765 0 3762 2671.683778 9245.07064 0 3763 5616.632517 7852.735076 0 3764 4167.365641 3245.246201 0 3765 8770.591394 4147.434259 0 3766 1778.229856 6540.45144 0 3767 7437.177771 9113.588661 0 3768 6752.927923 3166.007488 0 3769 1951.480043 5872.088391 0 3770 8198.308377 1089.489563 0 3771 7699.937508 8545.272543 0 3772 5614.815498 6286.732152 0 3773 9865.020308 7422.405985 0 3774 2996.345536 8003.956317 0 3775 5876.468889 3620.577628 0 3776 9213.178494 3364.402576 0 3777 5909.087465 9707.336704 0 3778 9102.348793 9530.332996 0 3779 3487.695536 2473.122803 0 3780 6756.425452 1999.785959 0 3781 8866.943571 3261.76826 0 3782 8329.179413 9350.315305 0 3783 9431.366033 3747.584213 0 3784 2513.699425 6294.17993 0 3785 239.794782 9905.564483 0 3786 2759.745802 4398.236868 0 3787 2759.601091 9281.261287 0 3788 8427.547296 5358.331433 0 3789 5945.13164 9435.771077 0 3790 1198.218985 654.54636 0 3791 2445.444584 559.508661 0 3792 5620.055266 3364.180527 0 3793 8615.984551 761.433749 0 3794 1404.772383 5766.623007 0 3795 1750.056061 7676.544514 0 3796 1339.718719 5280.744692 0 3797 6532.766649 2776.891235 0 3798 6999.787902 5380.328131 0 3799 33.722542 2142.068472 0 3800 1954.123555 4933.791259 0 3801 2554.015289 127.698376 0 3802 7877.746831 2651.653083 0 3803 3041.053704 9858.803622 0 3804 1404.243801 3247.81568 0 3805 5609.200976 8637.296477 0 3806 1073.350124 3374.457643 0 3807 6142.415411 8049.163091 0 3808 6670.454269 2941.429627 0 3809 398.045948 152.818488 0 3810 8427.376455 3072.916512 0 3811 6621.099734 4261.681355 0 3812 4190.732325 6484.577631 0 3813 6109.711654 5280.965987 0 3814 1133.571982 8295.216144 0 3815 4497.526836 3013.740448 0 3816 4759.836577 8865.472856 0 3817 6938.732406 8528.500008 0 3818 8975.851172 9955.371129 0 3819 1049.668663 4453.893994 0 3820 1664.853349 6030.626977 0 3821 5681.728602 1914.055879 0 3822 1614.70797 9281.383598 0 3823 929.809826 8888.814091 0 3824 3665.507756 7915.478371 0 3825 7944.994082 4916.859263 0 3826 5020.541742 414.057101 0 3827 2773.499734 4300.254561 0 3828 5549.890511 5869.824888 0 3829 2820.54618 4259.251805 0 3830 1934.120411 6941.297731 0 3831 2403.229049 6464.38133 0 3832 9761.713047 2248.236828 0 3833 233.864634 4156.559402 0 3834 840.556218 5309.175642 0 3835 9508.234939 2635.043313 0 3836 977.447523 3814.861749 0 3837 7108.836798 8798.050294 0 3838 4470.520846 144.410079 0 3839 7913.410575 1630.225432 0 3840 4971.058461 2120.785661 0 3841 3521.256163 7783.291128 0 3842 1481.627647 4972.353966 0 3843 4938.842796 1843.954783 0 3844 3266.682869 6864.828916 0 3845 1554.055457 8186.546984 0 3846 762.514668 4378.438406 0 3847 5346.744079 4243.649612 0 3848 7455.692533 4474.574375 0 3849 5383.18709 6833.200631 0 3850 1059.682327 2773.535145 0 3851 5785.29269 9282.371375 0 3852 4987.06403 1892.500601 0 3853 1848.54426 312.270405 0 3854 1236.82725 5927.662054 0 3855 1136.655188 1579.509519 0 3856 3311.416208 3003.404404 0 3857 8923.319723 1127.574581 0 3858 5444.323207 3434.790553 0 3859 6260.2766 8837.460629 0 3860 1453.375969 3382.213213 0 3861 7721.72609 2496.994056 0 3862 2859.970066 51.408076 0 3863 2523.966173 7812.365973 0 3864 6222.447302 6397.980751 0 3865 2070.376663 7054.699031 0 3866 9564.183608 244.445214 0 3867 4515.62969 4059.981439 0 3868 5084.798445 7886.921564 0 3869 7272.316647 9735.621029 0 3870 6704.63031 6789.775449 0 3871 4832.877225 2710.396578 0 3872 4285.863015 1959.410815 0 3873 7187.700841 794.297314 0 3874 3499.537622 844.256832 0 3875 6947.590813 8627.655336 0 3876 4165.160223 3433.590753 0 3877 8024.633225 4931.264299 0 3878 3153.693713 1333.782323 0 3879 2941.819621 7238.248266 0 3880 94.798129 1297.984351 0 3881 8515.687001 5513.414985 0 3882 3239.137858 6026.941855 0 3883 4042.331034 2286.582604 0 3884 3319.751358 8040.539744 0 3885 8567.092294 1773.81702 0 3886 8681.843039 2705.730509 0 3887 7563.582605 2233.760871 0 3888 7813.966776 7836.799734 0 3889 7786.195992 6611.295848 0 3890 4051.225328 6697.114247 0 3891 1229.733036 8345.807825 0 3892 4406.576857 6660.850973 0 3893 884.660545 80.106125 0 3894 3088.843301 2299.857854 0 3895 8417.828753 6871.601167 0 3896 6819.927987 8279.510869 0 3897 1320.678009 8925.229637 0 3898 1716.696933 4242.338157 0 3899 9982.572773 6229.272846 0 3900 5294.520108 402.406224 0 3901 1786.594616 8954.257893 0 3902 6043.88883 1331.619268 0 3903 2791.518813 7689.240247 0 3904 9712.242813 1984.306356 0 3905 834.550785 3004.202337 0 3906 5377.903471 6684.210823 0 3907 6677.574093 7008.295357 0 3908 5282.936548 9180.649037 0 3909 3229.607659 6103.673096 0 3910 717.800293 4842.97972 0 3911 5536.25918 9331.244124 0 3912 7130.642158 6284.671543 0 3913 4380.351645 5773.067509 0 3914 2377.166285 7793.838574 0 3915 8073.624157 5442.680192 0 3916 5479.987267 5939.519975 0 3917 8311.153579 562.551202 0 3918 6035.51037 4092.57173 0 3919 9047.4556 2067.475395 0 3920 3224.896938 4370.802915 0 3921 5901.194603 9887.177034 0 3922 4944.206147 8236.224286 0 3923 5713.830524 2775.519257 0 3924 6187.830896 1289.054655 0 3925 2844.906464 6923.103779 0 3926 306.698512 7390.656112 0 3927 9991.938281 5492.156388 0 3928 6960.072886 3746.784827 0 3929 564.298009 1433.81755 0 3930 9335.495676 4562.191471 0 3931 1010.88862 7984.418221 0 3932 600.586479 2292.953517 0 3933 3805.668397 9168.900673 0 3934 1726.606438 7649.586217 0 3935 5095.570539 3653.682202 0 3936 9407.579334 281.713474 0 3937 735.649867 6610.076738 0 3938 4892.305794 7397.951897 0 3939 995.817685 5435.215144 0 3940 982.316352 4806.409443 0 3941 3629.785439 6516.679974 0 3942 1605.689068 5258.7025 0 3943 9135.864708 2068.98836 0 3944 4991.812194 4269.997202 0 3945 8983.731158 615.608231 0 3946 4665.901375 9952.616929 0 3947 9866.650466 4853.879213 0 3948 717.623393 3854.621692 0 3949 9047.074758 1083.412262 0 3950 8714.61767 7632.235251 0 3951 2996.644873 3023.457566 0 3952 1214.251151 7208.532575 0 3953 4244.104899 7456.795261 0 3954 3797.731116 1404.758271 0 3955 9887.790228 748.162039 0 3956 189.113562 6884.433977 0 3957 2271.099561 849.450514 0 3958 1452.903966 6680.364253 0 3959 5042.416186 536.551769 0 3960 2821.078152 7671.580231 0 3961 734.928233 5964.957731 0 3962 8696.188077 676.554768 0 3963 5265.801292 5473.245758 0 3964 8134.292418 6138.766711 0 3965 7893.134561 1148.430198 0 3966 641.984023 4145.161563 0 3967 6099.51046 7379.74648 0 3968 7607.806982 387.325502 0 3969 4037.216702 5869.368963 0 3970 3902.182926 40.257163 0 3971 5363.837652 3730.797877 0 3972 7117.052455 9485.956524 0 3973 8704.515755 36.0355 0 3974 2829.257641 1767.436166 0 3975 2985.22338 9492.49977 0 3976 5590.509771 955.157428 0 3977 6863.884619 1902.685735 0 3978 9616.767484 4473.913898 0 3979 4158.323022 1170.343898 0 3980 76.178946 1304.026333 0 3981 974.309728 7879.833593 0 3982 3879.785057 8270.047497 0 3983 6635.221556 4398.159605 0 3984 9208.567586 8027.012533 0 3985 1966.300997 659.618624 0 3986 1340.923218 7647.599773 0 3987 7808.294747 4246.791398 0 3988 8623.535357 5269.102347 0 3989 8371.166756 5495.763542 0 3990 8756.698569 9253.811648 0 3991 3965.700843 2543.252077 0 3992 3364.567263 6654.886966 0 3993 7230.206185 760.816689 0 3994 5917.256015 968.116659 0 3995 8733.501917 675.827721 0 3996 3359.288675 689.049434 0 3997 4133.55922 2769.77388 0 3998 3990.344344 3085.097514 0 3999 5120.229669 5852.104935 0 4000 572.990143 3061.103413 0 4001 1511.477193 1918.874743 0 4002 4343.922707 6678.013432 0 4003 9072.6844 6899.580971 0 4004 2895.424186 8434.284201 0 4005 9292.003965 9210.72116 0 4006 6388.539582 5767.50252 0 4007 7478.752968 6947.488457 0 4008 2755.704677 3222.644184 0 4009 1657.049744 4277.12227 0 4010 9292.518819 104.83951 0 4011 1475.118298 6686.789868 0 4012 7149.825688 3526.399797 0 4013 4272.970112 3631.583951 0 4014 629.280421 5707.091137 0 4015 3502.142925 9936.404123 0 4016 3420.626607 4608.795055 0 4017 9852.776957 7402.05741 0 4018 7027.388954 7459.316379 0 4019 6222.487357 8379.581529 0 4020 1323.801417 7315.168041 0 4021 3785.458243 5580.089637 0 4022 8589.235897 7473.196959 0 4023 6527.823842 9584.149287 0 4024 4227.665686 242.849178 0 4025 9612.893227 4083.987783 0 4026 6066.471807 8318.995227 0 4027 7841.173508 2133.067482 0 4028 1965.029622 7317.222028 0 4029 4131.522703 6277.381835 0 4030 7336.517609 6765.07021 0 4031 7352.45133 3306.172999 0 4032 6295.447982 9554.62695 0 4033 19.650591 9804.252388 0 4034 3718.13168 2781.362192 0 4035 6853.610916 2320.558979 0 4036 2204.7763 7026.610976 0 4037 5877.279125 6510.453021 0 4038 8855.608447 168.713095 0 4039 3961.419301 2928.112724 0 4040 8384.924708 4056.3962 0 4041 3610.758064 6026.133964 0 4042 5830.65977 1237.674937 0 4043 7871.855999 9349.501398 0 4044 7604.514839 3326.760401 0 4045 3344.877211 941.467778 0 4046 1782.675717 8746.116328 0 4047 1901.305176 4479.650237 0 4048 1644.319296 6749.775978 0 4049 1854.676705 7972.671296 0 4050 550.199728 3051.914218 0 4051 1616.144336 5371.267031 0 4052 3267.104587 6157.093352 0 4053 5720.901235 3261.401879 0 4054 391.656895 3230.759426 0 4055 1143.997096 9874.072851 0 4056 4803.026089 8287.586565 0 4057 8492.048784 5773.810398 0 4058 2763.069615 5740.378169 0 4059 8100.966143 2420.139584 0 4060 2710.228502 6656.210546 0 4061 7330.006402 12.759845 0 4062 6293.716022 4949.209987 0 4063 6621.659398 7632.792704 0 4064 276.174835 39.138501 0 4065 1759.54369 3614.103307 0 4066 4948.518038 5545.096479 0 4067 7738.212186 4039.177608 0 4068 9325.926494 7820.243232 0 4069 9621.648562 8328.626806 0 4070 7369.494946 4623.616799 0 4071 9939.803768 3690.240641 0 4072 1630.826597 8796.567311 0 4073 4619.049565 8636.37902 0 4074 4667.860447 8386.660786 0 4075 782.276835 513.978733 0 4076 4626.810392 8220.950409 0 4077 8327.713466 1126.777647 0 4078 1530.469719 6637.827638 0 4079 1566.297094 5678.140077 0 4080 1248.597804 4321.161015 0 4081 3427.175963 3715.3558 0 4082 4971.004323 9383.572348 0 4083 599.637791 1249.024933 0 4084 9717.826856 4579.670654 0 4085 4939.952226 5405.382375 0 4086 5963.40728 162.862743 0 4087 9266.733016 6968.789618 0 4088 7259.759432 9317.198277 0 4089 1095.48823 5065.943564 0 4090 2300.925978 2479.390025 0 4091 249.340319 6649.069476 0 4092 7693.692079 9073.606881 0 4093 7697.721172 6129.169265 0 4094 9426.993891 3648.598799 0 4095 3155.397633 3181.600289 0 4096 5880.198244 497.287712 0 4097 5244.658406 4900.281139 0 4098 5794.831077 9326.65204 0 4099 6851.753487 3278.915273 0 4100 4779.077631 5075.477077 0 4101 9254.132695 6414.539503 0 4102 3474.634076 8875.40176 0 4103 442.213616 1713.169939 0 4104 2786.854755 9562.545855 0 4105 8764.283235 2446.598132 0 4106 5841.360048 2876.473713 0 4107 9356.788942 6233.474688 0 4108 7287.054483 9312.321132 0 4109 8060.546539 9285.991623 0 4110 1514.350823 2593.989387 0 4111 8711.474688 8463.838733 0 4112 7678.317302 7194.641229 0 4113 8546.165805 4751.100541 0 4114 1003.541452 7271.926016 0 4115 2469.286834 6090.82279 0 4116 5598.282981 3891.03198 0 4117 6554.988085 3854.171256 0 4118 961.108817 8604.72994 0 4119 8468.670033 2829.477651 0 4120 5599.987869 1345.184563 0 4121 7380.174612 4553.090514 0 4122 3831.142889 9314.546975 0 4123 8275.411767 8429.257782 0 4124 8062.842941 7268.92241 0 4125 9032.527389 3193.705626 0 4126 9195.562415 4154.086485 0 4127 7530.770854 3474.444106 0 4128 4711.567417 2488.031688 0 4129 1171.696803 3204.605618 0 4130 536.270507 3126.224227 0 4131 3269.870392 774.028124 0 4132 5748.477662 8412.717732 0 4133 6104.966008 1045.170083 0 4134 2494.661808 2963.462638 0 4135 3121.566407 7287.506117 0 4136 4194.261676 637.327118 0 4137 6954.420657 2264.647207 0 4138 9913.61421 232.691919 0 4139 8198.458978 5105.555474 0 4140 2660.473349 1534.565033 0 4141 2036.210465 2861.791907 0 4142 638.214281 8661.467424 0 4143 2219.347467 668.173285 0 4144 4916.902539 1300.752666 0 4145 3541.309526 8749.105692 0 4146 8667.051451 9505.943908 0 4147 6485.134239 8764.225675 0 4148 4645.3447 6168.108183 0 4149 6083.765403 9618.809727 0 4150 9188.729912 9878.021093 0 4151 9322.24344 2174.142954 0 4152 9601.537857 738.671347 0 4153 2774.600947 7921.796877 0 4154 9978.431298 1161.060453 0 4155 3012.431927 4674.379876 0 4156 3848.400914 1944.873138 0 4157 2498.592965 8108.252466 0 4158 534.195681 8160.973737 0 4159 3358.924188 6814.383951 0 4160 8340.144241 6210.526454 0 4161 2417.913648 6965.134117 0 4162 6569.120062 9183.348722 0 4163 2935.824835 357.070806 0 4164 1737.809437 9672.744934 0 4165 6355.390219 4172.612492 0 4166 6873.669534 3328.829083 0 4167 1175.983136 5958.595866 0 4168 9127.835098 758.167108 0 4169 3779.062379 4711.148347 0 4170 6052.442644 9478.528792 0 4171 8431.037896 9684.08109 0 4172 4731.889493 4101.644067 0 4173 7570.877691 2183.005788 0 4174 4141.790667 1706.293977 0 4175 993.441452 7862.949568 0 4176 174.231029 7028.411341 0 4177 8168.776026 9374.503407 0 4178 8330.831426 8090.147588 0 4179 9526.941935 3865.987893 0 4180 2342.009373 1126.055597 0 4181 1503.551617 1637.587658 0 4182 3736.536198 5690.388801 0 4183 1046.54871 7607.423641 0 4184 8099.245979 263.530303 0 4185 4081.332151 2682.219465 0 4186 9558.732906 7719.834426 0 4187 5113.999978 5447.476101 0 4188 887.473837 3533.425908 0 4189 7928.682168 668.734534 0 4190 3469.61722 8024.014477 0 4191 5018.491495 6800.293016 0 4192 4058.078137 904.675022 0 4193 6542.959814 5113.934359 0 4194 6175.919943 365.205734 0 4195 277.326076 9277.848661 0 4196 8879.802595 5107.493057 0 4197 4111.805842 977.924343 0 4198 8339.301568 7845.646084 0 4199 6571.607057 8023.029249 0 4200 4945.922477 8346.727252 0 4201 1743.490028 687.438934 0 4202 5477.025445 5583.322143 0 4203 5789.642069 2303.029536 0 4204 3938.872105 1209.928116 0 4205 8125.745227 8474.117871 0 4206 6484.878765 9664.277216 0 4207 6284.963686 9355.335501 0 4208 8068.423533 8948.110445 0 4209 3713.450924 937.519081 0 4210 1454.380968 6403.826348 0 4211 7898.36915 4416.997424 0 4212 7921.44072 6795.785292 0 4213 2047.92235 1890.402408 0 4214 2014.338016 2675.441312 0 4215 2522.262152 5445.12583 0 4216 2377.429102 5733.251086 0 4217 6214.006366 7974.957313 0 4218 6622.080578 7633.519075 0 4219 4866.092372 280.199695 0 4220 3312.921381 6269.357349 0 4221 4807.333125 9190.057099 0 4222 1830.888351 315.583127 0 4223 4407.009386 2218.156697 0 4224 8448.342504 5404.706288 0 4225 7155.852532 6460.149047 0 4226 2334.480934 4056.93248 0 4227 8447.835046 2419.838941 0 4228 9311.688827 8051.129149 0 4229 5101.001395 5412.747688 0 4230 5112.328656 7151.184558 0 4231 6404.6113 8156.34067 0 4232 5254.664756 8944.288628 0 4233 825.521949 7897.618599 0 4234 8804.555628 7891.639167 0 4235 1185.686529 5154.70471 0 4236 1273.196511 6655.829706 0 4237 5856.962482 7039.012535 0 4238 6602.902015 5432.526734 0 4239 7440.16767 9522.003283 0 4240 3312.617767 2809.004272 0 4241 9141.351778 5878.734578 0 4242 672.780984 3125.793992 0 4243 3794.231156 4654.27701 0 4244 6128.341599 2883.579811 0 4245 1019.014639 4727.450561 0 4246 9438.304361 2133.669167 0 4247 7503.772081 976.6738 0 4248 5123.282848 5160.298018 0 4249 1899.438638 5720.433469 0 4250 8961.166399 8434.784297 0 4251 9172.386329 2665.911048 0 4252 7440.810761 7716.860453 0 4253 792.277339 9019.170966 0 4254 7274.711747 7441.600426 0 4255 1906.556634 1279.530686 0 4256 6493.705166 9689.054387 0 4257 4863.735507 9432.086176 0 4258 3584.714142 4547.618323 0 4259 2528.054587 7513.991821 0 4260 9916.209686 3279.150378 0 4261 8860.496327 2440.5245 0 4262 173.72531 1329.312862 0 4263 715.807255 4266.854314 0 4264 7318.828269 801.301106 0 4265 5755.489642 2596.926881 0 4266 3463.847179 8039.335175 0 4267 8746.737792 6740.950413 0 4268 7446.778478 9471.560344 0 4269 5675.698944 8427.116852 0 4270 1497.252493 8686.198525 0 4271 446.931904 214.760374 0 4272 2269.881032 7954.968752 0 4273 7091.943209 8805.265035 0 4274 3425.105357 8909.537186 0 4275 8145.280656 4345.815223 0 4276 8572.147067 3265.451997 0 4277 5936.767666 2299.715286 0 4278 2807.856523 7552.503694 0 4279 8891.561116 35.829038 0 4280 8162.598145 8401.431094 0 4281 9726.729265 6737.888639 0 4282 1374.488841 9528.894511 0 4283 8859.682763 7447.710772 0 4284 5086.661407 6768.379272 0 4285 5747.725068 5051.529017 0 4286 870.721426 3854.990259 0 4287 3925.607953 4578.798835 0 4288 8259.67264 2992.983861 0 4289 1081.745042 2037.624334 0 4290 5571.995702 4025.456504 0 4291 9699.790228 1280.033567 0 4292 5160.911299 8055.271339 0 4293 2866.703449 8930.591689 0 4294 8262.319181 4198.156932 0 4295 7608.388723 4281.099309 0 4296 7831.825449 3379.614104 0 4297 5649.792553 4083.810973 0 4298 2871.442556 4543.441958 0 4299 4156.090536 7176.826816 0 4300 2346.939678 9455.088758 0 4301 7494.931835 7505.326629 0 4302 3983.741412 8978.623171 0 4303 5653.639103 8922.736474 0 4304 4749.573375 9644.520595 0 4305 2671.966874 2081.846216 0 4306 2263.695933 3620.180909 0 4307 7790.089863 456.80357 0 4308 6141.279809 3118.15013 0 4309 4917.113076 2963.832285 0 4310 3969.779905 4185.339686 0 4311 1236.291155 7417.444969 0 4312 3445.065529 943.63292 0 4313 8166.209839 2175.612619 0 4314 7256.554248 5950.490496 0 4315 379.201147 9464.178488 0 4316 9703.617991 7323.2505 0 4317 930.69594 6973.626337 0 4318 1920.598845 4633.582935 0 4319 4954.430983 2545.13639 0 4320 8244.164581 1247.44288 0 4321 4782.214785 6053.267068 0 4322 7537.818895 8605.896994 0 4323 5708.415376 9704.602555 0 4324 629.092395 3363.606502 0 4325 8063.693643 2202.575168 0 4326 4128.809561 4373.776267 0 4327 5228.09958 1347.158067 0 4328 7609.622787 9780.05976 0 4329 6369.352826 6941.184966 0 4330 2538.547046 1969.22725 0 4331 3498.347351 2830.427593 0 4332 4116.452921 5348.791338 0 4333 5011.638614 6430.846185 0 4334 2331.724484 1627.00438 0 4335 2361.319302 949.586945 0 4336 2844.892291 2575.23224 0 4337 5608.280458 7867.180512 0 4338 2835.637228 6138.220265 0 4339 3245.477064 1044.398253 0 4340 3981.869424 757.462524 0 4341 5353.511882 9868.150179 0 4342 214.522307 4837.698982 0 4343 2206.960632 9563.296097 0 4344 4223.507441 5973.044544 0 4345 3890.090882 4363.80092 0 4346 828.020806 2834.137311 0 4347 8500.681454 4505.226794 0 4348 7182.744437 2845.693041 0 4349 8060.149993 6323.606294 0 4350 9907.724529 3248.893883 0 4351 2353.679895 2528.642354 0 4352 4757.669257 8508.564979 0 4353 8179.521817 1020.1203 0 4354 7100.066442 1666.539328 0 4355 6859.382541 4962.099453 0 4356 5369.423975 7971.853885 0 4357 3705.41821 5043.949085 0 4358 5846.59783 5800.187117 0 4359 4597.111179 3193.698648 0 4360 2775.570096 7401.970703 0 4361 7532.223205 8218.429358 0 4362 3315.258182 8580.357426 0 4363 1626.893986 3151.058639 0 4364 6233.121197 4368.26687 0 4365 7202.547252 6669.483191 0 4366 6485.775793 4719.902511 0 4367 687.230596 8541.959258 0 4368 2792.177012 492.862897 0 4369 5442.19161 5052.935214 0 4370 412.489547 5110.905787 0 4371 7667.065838 5696.502303 0 4372 7422.626451 2745.506602 0 4373 5672.387162 7353.909067 0 4374 80.208746 1378.821805 0 4375 8547.914569 6705.141674 0 4376 7269.921817 2869.533632 0 4377 4406.637743 4962.87512 0 4378 132.255293 1215.875159 0 4379 1732.251057 492.851198 0 4380 2487.108962 380.13266 0 4381 3789.373689 1958.105942 0 4382 5014.918537 2882.30866 0 4383 5343.267733 6072.383713 0 4384 7868.516833 6157.514806 0 4385 4055.234105 6813.827764 0 4386 9061.366598 9052.995822 0 4387 6519.568636 1191.451842 0 4388 6104.731592 5817.567873 0 4389 7980.654486 5656.803251 0 4390 979.731603 8118.633473 0 4391 4595.715827 5782.625191 0 4392 3520.265565 4108.5887 0 4393 437.197997 5075.229564 0 4394 5331.01492 8241.727289 0 4395 3603.084858 1938.307064 0 4396 9764.100813 8594.899715 0 4397 2707.796778 9592.869662 0 4398 1502.033797 1177.007921 0 4399 8135.340944 297.15239 0 4400 109.728474 9682.308257 0 4401 789.571276 7372.323857 0 4402 2733.141514 5709.451353 0 4403 4777.606824 1429.675175 0 4404 1030.478326 6150.577628 0 4405 2115.189598 5531.406599 0 4406 1858.741725 8034.297739 0 4407 5721.686458 8879.268306 0 4408 2927.300568 1480.704642 0 4409 9602.490644 6151.499306 0 4410 1904.09145 2136.489653 0 4411 1734.16446 6989.620525 0 4412 7661.582251 2972.359103 0 4413 2191.07196 1540.220166 0 4414 8812.314957 6825.491889 0 4415 262.882902 8435.102288 0 4416 923.68375 1097.29245 0 4417 7064.181855 5589.726913 0 4418 439.401073 4156.789479 0 4419 2419.916773 957.347867 0 4420 4654.005254 1495.238434 0 4421 4306.727235 7326.047813 0 4422 5598.645337 8280.80595 0 4423 8418.214813 3311.378539 0 4424 5951.321895 1883.00873 0 4425 3475.028764 4104.94875 0 4426 2086.098228 8015.11846 0 4427 6541.412053 6002.037555 0 4428 3967.517405 1458.637595 0 4429 2203.177082 1960.54975 0 4430 7904.986815 602.059322 0 4431 7903.483253 4668.519579 0 4432 7314.1479 8388.571817 0 4433 6386.408008 6197.681368 0 4434 1887.017179 2247.28205 0 4435 6509.484893 9407.691183 0 4436 5364.680506 175.614191 0 4437 8476.53479 9100.107779 0 4438 1384.041556 3978.11621 0 4439 7141.174085 4326.433929 0 4440 4685.250433 8008.825633 0 4441 7951.076193 5201.082947 0 4442 6780.056191 3022.053511 0 4443 5828.061906 6331.394552 0 4444 2556.067797 296.421721 0 4445 8286.499049 3739.17881 0 4446 9864.02035 1137.22757 0 4447 5873.979825 9873.453105 0 4448 947.353904 5012.530191 0 4449 4999.598517 3895.031829 0 4450 2721.846017 3809.669331 0 4451 9568.287474 84.476061 0 4452 1358.901535 3931.153863 0 4453 2671.943297 6513.940011 0 4454 8568.699531 5265.958597 0 4455 2789.441114 7109.999851 0 4456 1342.568575 5143.349315 0 4457 9694.557483 7376.176199 0 4458 9290.006801 9812.517538 0 4459 597.624084 8248.450188 0 4460 4723.555318 2190.798976 0 4461 4502.387907 1686.357087 0 4462 6016.282736 5314.241808 0 4463 1628.130225 8036.758404 0 4464 7298.464279 243.326388 0 4465 4800.742059 7779.900288 0 4466 6357.709034 5826.768817 0 4467 9157.308028 4181.043703 0 4468 6984.221276 8482.951931 0 4469 301.263306 4000.638496 0 4470 1629.534007 9033.952102 0 4471 5253.214767 7937.684759 0 4472 582.719039 5798.505472 0 4473 1694.767513 4834.237345 0 4474 2911.42736 5479.183382 0 4475 1176.594393 5831.747056 0 4476 245.606914 6079.000633 0 4477 9525.575269 1798.032221 0 4478 7598.582471 7911.6327 0 4479 6687.426259 8402.476866 0 4480 5970.586469 7174.668127 0 4481 3205.198148 9162.481465 0 4482 7121.766578 6576.427546 0 4483 3418.308408 6799.327677 0 4484 6019.803835 4401.462225 0 4485 5574.862823 8764.847269 0 4486 4362.103047 3342.832205 0 4487 6612.341211 945.829649 0 4488 8462.604258 8970.13007 0 4489 7077.618602 8695.299922 0 4490 7695.436233 1966.618086 0 4491 6413.35491 5468.933946 0 4492 7277.336561 4499.934264 0 4493 7723.476705 3537.58138 0 4494 1747.363492 365.933549 0 4495 2318.292462 7590.296178 0 4496 8613.788134 7145.27002 0 4497 3366.563177 8528.181314 0 4498 4555.264275 9632.345172 0 4499 7722.279467 902.200414 0 4500 1926.150774 9630.188235 0 4501 1725.157933 711.487105 0 4502 3917.30277 7301.065192 0 4503 5034.366513 827.995563 0 4504 7903.580228 6714.649723 0 4505 5820.537938 1638.493773 0 4506 156.07425 8400.119778 0 4507 1862.670652 1871.008964 0 4508 5731.734699 6081.477087 0 4509 406.921625 1794.611016 0 4510 9098.094726 4123.87509 0 4511 8707.998364 6906.190345 0 4512 7649.059036 1763.456818 0 4513 6424.606347 5675.76068 0 4514 5170.570972 2926.546849 0 4515 1447.975814 6698.264514 0 4516 8765.944687 1173.884122 0 4517 1768.285502 7696.597707 0 4518 1572.974678 8436.848643 0 4519 3678.989405 4396.094554 0 4520 2396.756563 4491.32736 0 4521 9778.398107 8181.746798 0 4522 87.578692 1883.921512 0 4523 6472.762755 5943.360699 0 4524 2444.657635 2337.154216 0 4525 1823.724081 901.692833 0 4526 1701.90043 8243.935475 0 4527 5826.236579 9201.942726 0 4528 831.852711 745.601558 0 4529 6469.374147 7965.049785 0 4530 700.246389 5742.312686 0 4531 3989.316894 2484.527718 0 4532 3606.380274 1056.617132 0 4533 6155.752525 5154.682974 0 4534 3316.333558 3283.296421 0 4535 4246.813848 3877.859505 0 4536 4666.960615 700.761739 0 4537 7394.231176 775.069969 0 4538 4396.861408 5994.447891 0 4539 3449.108949 8101.670652 0 4540 1206.348365 2843.608418 0 4541 6754.462853 9560.490182 0 4542 1447.080498 1891.737001 0 4543 5322.818461 6475.967748 0 4544 4881.74392 1174.680055 0 4545 2002.353981 4540.513772 0 4546 5765.950616 8718.0016 0 4547 2176.249601 2466.636911 0 4548 6796.534047 1721.374094 0 4549 2087.364054 2345.94458 0 4550 4676.987314 6695.124189 0 4551 5352.994412 3070.15415 0 4552 3566.419621 1471.21413 0 4553 1822.333125 9922.011439 0 4554 2595.805127 6210.071467 0 4555 5445.301406 8636.503907 0 4556 9448.367443 1798.117758 0 4557 579.929907 1710.782386 0 4558 6575.983662 6437.695557 0 4559 1238.745699 3706.7135 0 4560 1895.614198 2677.096366 0 4561 1582.147222 7850.845567 0 4562 716.92798 9933.545036 0 4563 4662.495232 2960.163879 0 4564 9944.800466 3566.792162 0 4565 2786.142374 2222.948462 0 4566 7292.344323 834.297904 0 4567 2375.080075 3846.500203 0 4568 8703.024212 4501.115987 0 4569 770.639822 7916.289414 0 4570 8430.588944 3042.803674 0 4571 5502.073188 6351.02956 0 4572 8419.854908 7294.45127 0 4573 6118.407588 4942.727494 0 4574 7311.912365 7336.917711 0 4575 7526.791972 6519.695065 0 4576 1734.100708 2285.996338 0 4577 8980.407495 976.472549 0 4578 7878.142864 3167.894984 0 4579 1679.719994 9599.176933 0 4580 4307.332864 8319.562784 0 4581 1551.941919 3973.716138 0 4582 8574.396866 523.193756 0 4583 5254.858899 9870.189019 0 4584 1810.251853 6219.951839 0 4585 6882.971283 6627.841605 0 4586 9731.206832 3305.617591 0 4587 3548.358264 2340.700946 0 4588 1725.40432 9109.65767 0 4589 8255.64262 6073.343562 0 4590 928.940974 2450.001029 0 4591 2029.301587 5264.129811 0 4592 2925.325261 6720.795081 0 4593 4119.463325 2084.813636 0 4594 2883.292535 7477.463454 0 4595 4690.554213 1865.37859 0 4596 2487.507724 195.676392 0 4597 6310.724609 5570.436911 0 4598 5382.88539 4293.347676 0 4599 2738.689236 7199.004615 0 4600 358.229575 205.057258 0 4601 7951.371881 4771.970562 0 4602 6870.146051 9680.60081 0 4603 7209.052697 2206.506685 0 4604 7122.537465 3710.782762 0 4605 4157.963377 3022.554395 0 4606 3661.617568 3741.565806 0 4607 7329.023616 738.370169 0 4608 8480.976698 6044.242421 0 4609 2301.066216 6837.098254 0 4610 449.517741 1055.841439 0 4611 7119.110615 8032.143797 0 4612 3760.033188 2136.070066 0 4613 9811.972377 4908.231102 0 4614 7290.367874 1879.778608 0 4615 1825.951189 3778.077551 0 4616 551.251442 6305.420624 0 4617 8292.744975 959.364211 0 4618 7280.536754 5644.64551 0 4619 8125.320585 6945.908885 0 4620 7685.978894 196.62372 0 4621 1855.724324 8790.344408 0 4622 7667.656281 2680.138761 0 4623 7360.415027 3520.816983 0 4624 8558.809714 5124.912917 0 4625 716.976679 7264.280436 0 4626 5189.870453 4260.170656 0 4627 3711.948136 5200.301724 0 4628 579.453265 4426.567881 0 4629 7582.875711 4699.702174 0 4630 5128.511401 3041.97899 0 4631 8724.451409 2979.172218 0 4632 1768.694429 1276.502882 0 4633 7250.740456 7450.978693 0 4634 7796.9831 9955.26233 0 4635 2962.243784 3265.725864 0 4636 3935.169487 4229.064298 0 4637 365.62675 4317.761367 0 4638 6197.637419 9108.641145 0 4639 5316.369831 4745.753375 0 4640 9919.168103 7359.255326 0 4641 8997.566204 5187.40756 0 4642 8744.744149 1430.194304 0 4643 8168.421945 1808.102446 0 4644 7934.177742 6944.9245 0 4645 3167.430773 4981.550634 0 4646 5451.793888 9481.741456 0 4647 5013.383127 6968.435243 0 4648 1930.111204 2070.340236 0 4649 2086.662585 8527.54666 0 4650 9372.279238 22.327323 0 4651 944.265759 4316.891476 0 4652 5860.084245 5144.08213 0 4653 6850.044742 9704.5037 0 4654 212.00154 7726.924635 0 4655 7651.388344 7048.377985 0 4656 2613.959482 1077.41902 0 4657 7092.414006 75.195843 0 4658 7622.483327 8695.493123 0 4659 1697.331089 2302.502778 0 4660 3163.200432 3811.901155 0 4661 9740.703881 7766.47556 0 4662 3194.479223 2466.794003 0 4663 2844.100616 3715.541747 0 4664 281.102647 8100.737711 0 4665 3926.742632 2216.074261 0 4666 3391.318065 1208.630811 0 4667 3656.495375 3618.182228 0 4668 9150.173787 5858.86659 0 4669 4048.325171 2450.746241 0 4670 4996.520568 426.986547 0 4671 6563.637484 3413.551726 0 4672 8812.779077 9066.166801 0 4673 612.120684 3719.658082 0 4674 1000.178178 7219.610634 0 4675 8430.167213 7508.816169 0 4676 7085.430846 2913.712222 0 4677 7553.877492 2089.271624 0 4678 3744.371265 9693.047242 0 4679 8727.266531 8056.754275 0 4680 996.574694 4235.527054 0 4681 6655.49793 8227.410185 0 4682 1459.724721 7862.316995 0 4683 9633.182279 6349.880786 0 4684 189.878548 7730.725082 0 4685 2663.278056 754.015786 0 4686 1375.595427 2693.026716 0 4687 1624.641786 370.350486 0 4688 3804.235179 686.94228 0 4689 3831.437365 7723.057452 0 4690 214.667546 7437.458141 0 4691 2633.642347 8689.735313 0 4692 5716.355376 5718.426446 0 4693 9096.315969 1002.142091 0 4694 4331.814149 2079.764868 0 4695 3820.807586 342.873516 0 4696 8471.925479 52.390354 0 4697 7390.525975 5043.01709 0 4698 6222.107021 98.669756 0 4699 90.613829 2865.01077 0 4700 8407.791869 9401.149826 0 4701 3086.590403 9422.622843 0 4702 6840.06633 4255.685107 0 4703 7687.611896 3036.034373 0 4704 3674.012758 8373.231172 0 4705 9823.844625 6714.987653 0 4706 3593.901151 122.229587 0 4707 279.754629 6049.770398 0 4708 2684.611051 2826.99089 0 4709 8434.126267 6552.909029 0 4710 4453.629584 3991.159196 0 4711 3005.678178 8798.15722 0 4712 221.308638 8005.335832 0 4713 3666.553108 1807.216654 0 4714 3348.939751 3554.239604 0 4715 5490.99674 4333.116426 0 4716 7582.673111 7770.907841 0 4717 9265.228802 7741.600301 0 4718 2953.685014 1905.187635 0 4719 5626.324228 1732.074686 0 4720 4182.367911 169.904885 0 4721 6464.853213 4728.123781 0 4722 2436.946223 2387.623224 0 4723 4719.677846 6041.546494 0 4724 1321.698925 4066.233617 0 4725 9240.379934 5217.509346 0 4726 5372.844738 2542.532051 0 4727 5058.476279 1611.86892 0 4728 3283.710424 7261.399037 0 4729 4402.423354 6470.485032 0 4730 8909.925677 9908.194142 0 4731 3687.824159 8287.876252 0 4732 3172.989965 7281.033405 0 4733 9978.682815 1679.226803 0 4734 7018.043108 4190.757465 0 4735 4270.266303 4257.778703 0 4736 1849.104941 765.253933 0 4737 3249.295844 4194.857179 0 4738 1467.322805 2265.499263 0 4739 5055.125982 2007.222034 0 4740 8867.737415 1880.4423 0 4741 34.020803 7037.344529 0 4742 4190.36982 3914.772859 0 4743 5099.395922 4346.423159 0 4744 4513.306612 3259.516527 0 4745 8977.659715 1639.120406 0 4746 5725.124594 7383.613902 0 4747 8183.018241 7688.745944 0 4748 748.978211 1810.21109 0 4749 4730.500276 1738.250196 0 4750 8771.217786 7354.20299 0 4751 3887.689473 8499.150415 0 4752 1536.168841 6359.143689 0 4753 485.875842 2022.569262 0 4754 702.728101 2946.385618 0 4755 4677.242575 5089.013061 0 4756 4402.23795 2049.02436 0 4757 4032.725461 3754.614889 0 4758 1271.419346 5169.730158 0 4759 3793.977507 1859.813722 0 4760 4884.946826 3893.13333 0 4761 2503.382426 4091.648289 0 4762 5390.788382 4810.155989 0 4763 1768.024125 8637.278641 0 4764 5073.834493 6729.856897 0 4765 4376.910889 4242.657693 0 4766 3027.579762 1387.696884 0 4767 5355.491296 9971.82007 0 4768 308.879188 7615.191256 0 4769 5166.360962 5901.773933 0 4770 5111.521501 2326.395516 0 4771 7178.747271 4675.598426 0 4772 5466.229848 5925.544842 0 4773 5681.787533 436.829922 0 4774 7767.341623 7177.25989 0 4775 1583.529777 2199.564668 0 4776 6787.980122 4300.770709 0 4777 9930.55286 364.131573 0 4778 6124.074751 7897.666284 0 4779 3092.801501 9498.536942 0 4780 2449.839234 3189.120083 0 4781 4028.572911 730.780159 0 4782 6466.15053 6979.212114 0 4783 7825.247626 896.572883 0 4784 3251.549157 5903.906221 0 4785 5333.75556 6527.016272 0 4786 4683.333494 8683.633282 0 4787 9222.933833 7775.155416 0 4788 487.647207 1391.013295 0 4789 1767.286942 8922.927016 0 4790 30.193496 3957.762774 0 4791 9631.521509 9376.581209 0 4792 8184.773753 5318.522603 0 4793 3461.496291 7338.840202 0 4794 6062.408949 6898.634101 0 4795 5651.845025 5018.50663 0 4796 3806.050281 8653.836435 0 4797 605.907499 6191.196234 0 4798 6279.964848 5843.094831 0 4799 1814.072206 4258.459041 0 4800 4798.909652 6560.29131 0 4801 4935.420376 909.463289 0 4802 250.729585 5811.257612 0 4803 7495.887928 1606.12373 0 4804 3320.344711 7760.326776 0 4805 4640.326229 1284.249708 0 4806 7815.642089 4145.694441 0 4807 1473.36096 7772.869459 0 4808 9779.134423 3191.151474 0 4809 7336.380386 6610.228016 0 4810 5011.230532 6810.595666 0 4811 4767.340618 5491.592918 0 4812 1415.017085 9988.531105 0 4813 1529.165865 4052.832944 0 4814 1152.891651 3511.973515 0 4815 2222.395391 3730.129825 0 4816 1036.267914 7037.330607 0 4817 3667.703327 9519.968145 0 4818 9795.271855 449.738719 0 4819 7928.347553 9082.801256 0 4820 8466.002824 2729.623792 0 4821 5952.530498 9015.228588 0 4822 8915.493927 8617.875012 0 4823 8812.928282 7265.374891 0 4824 9336.762217 9225.080561 0 4825 8610.833109 3469.883384 0 4826 1147.49487 1158.885774 0 4827 6525.34624 723.163775 0 4828 7996.633895 9714.037687 0 4829 6852.300661 9099.797023 0 4830 7934.345344 8351.551249 0 4831 1523.276822 2291.696019 0 4832 1753.590116 5165.187544 0 4833 3036.032662 5079.85664 0 4834 315.884037 4047.211624 0 4835 4278.865241 9236.783449 0 4836 7935.579925 2296.074194 0 4837 3486.713103 9218.08445 0 4838 2353.470316 4937.905811 0 4839 3337.315229 5568.712238 0 4840 2837.02742 2888.507951 0 4841 202.856289 861.980057 0 4842 2660.574441 8824.007032 0 4843 2876.203167 5993.460349 0 4844 6739.843217 9652.658644 0 4845 6318.641545 4016.708827 0 4846 4327.93739 5942.913393 0 4847 592.777539 4441.203672 0 4848 1833.449775 2495.602946 0 4849 2627.458859 8037.706042 0 4850 6787.231669 6308.699277 0 4851 9336.332225 2528.501744 0 4852 8369.316255 4716.947714 0 4853 9560.400017 6641.263476 0 4854 6183.163202 7615.005666 0 4855 3382.86701 8785.37082 0 4856 8619.073833 7852.483459 0 4857 7033.461321 163.249969 0 4858 178.452902 8336.78029 0 4859 2295.061888 6185.50722 0 4860 1461.593646 1781.985096 0 4861 4862.868899 3422.054232 0 4862 6066.478369 3554.166285 0 4863 4744.206254 3036.049005 0 4864 7255.54767 343.881653 0 4865 252.309519 5003.308753 0 4866 2174.826752 6565.644961 0 4867 5114.121562 1314.130048 0 4868 4124.254018 8152.057242 0 4869 3949.595293 6567.370542 0 4870 1528.646733 1892.900702 0 4871 6002.124536 1946.046904 0 4872 6220.993173 8444.160203 0 4873 5360.542873 144.919815 0 4874 7596.915298 2741.684353 0 4875 4085.750702 2878.560516 0 4876 1598.325382 6468.82375 0 4877 7348.764823 426.571919 0 4878 3742.52724 7378.797103 0 4879 8373.774274 9752.419298 0 4880 121.619278 1116.876973 0 4881 342.892906 580.32179 0 4882 9519.216055 2231.238961 0 4883 837.312414 2699.910322 0 4884 6194.156748 9118.742954 0 4885 8838.504169 8902.76517 0 4886 7671.732905 7907.04351 0 4887 2125.256372 4768.109918 0 4888 1416.954349 3351.591206 0 4889 4366.274799 6862.023077 0 4890 6421.307833 4558.593387 0 4891 3245.406125 7159.396509 0 4892 6892.533885 5092.952399 0 4893 130.039448 9013.93507 0 4894 5856.725836 1895.63291 0 4895 3843.713043 1292.969688 0 4896 369.925801 7707.520989 0 4897 4057.699088 4625.909644 0 4898 6806.066562 4101.61163 0 4899 4435.974811 3871.097357 0 4900 4072.057487 7229.189201 0 4901 201.453305 2205.574969 0 4902 6451.686537 6496.808088 0 4903 8739.166541 723.745133 0 4904 693.717327 700.358579 0 4905 9438.214603 787.656573 0 4906 1843.838789 1445.238253 0 4907 2404.760957 6723.788249 0 4908 3241.284758 6842.461479 0 4909 7118.683016 9340.542702 0 4910 2535.760907 6288.203639 0 4911 5038.57363 1120.709711 0 4912 1247.101008 2474.010426 0 4913 3098.572978 1836.49393 0 4914 4730.805712 2107.935526 0 4915 4958.264349 6661.534826 0 4916 8074.309039 3813.987146 0 4917 31.586498 9760.46228 0 4918 3652.195599 9457.394899 0 4919 2804.239977 8190.176544 0 4920 1010.795252 187.013168 0 4921 1820.759596 5724.203237 0 4922 1720.574662 3579.099993 0 4923 2817.265011 388.154245 0 4924 8382.420964 7297.47473 0 4925 9102.289289 4551.191032 0 4926 5076.617356 568.333493 0 4927 862.83749 5411.999823 0 4928 2205.288701 1326.136289 0 4929 5876.03591 259.232175 0 4930 6584.759127 1710.078493 0 4931 1175.882561 3726.389342 0 4932 8432.193291 8048.368255 0 4933 6334.382484 5522.367858 0 4934 3356.386101 2332.071579 0 4935 414.634926 8753.509664 0 4936 8244.154129 7412.874254 0 4937 2979.085631 4727.175687 0 4938 7652.920413 8811.19992 0 4939 9546.159919 3599.057848 0 4940 4095.982757 7584.84413 0 4941 1755.065552 2027.483174 0 4942 2175.552733 9122.554524 0 4943 8528.051342 8198.217087 0 4944 996.11572 8864.491018 0 4945 9518.864389 227.974175 0 4946 9978.926938 1989.313726 0 4947 2529.472016 3111.130239 0 4948 4739.443107 7378.504673 0 4949 2828.515854 8168.638801 0 4950 3897.325379 109.864587 0 4951 7650.356283 4908.891636 0 4952 7666.634922 401.029785 0 4953 3958.348341 5770.822884 0 4954 9162.245057 5047.334234 0 4955 9335.368251 5722.347421 0 4956 4626.681087 3167.6379 0 4957 7545.394006 7724.545794 0 4958 206.028164 3316.087035 0 4959 3127.384384 2274.260292 0 4960 5496.929323 3379.530782 0 4961 1568.338435 7501.649752 0 4962 1518.509359 3351.302908 0 4963 8925.878136 7766.744339 0 4964 3510.62901 4277.223479 0 4965 3661.659109 6997.247029 0 4966 9791.57242 7727.372597 0 4967 15.694351 392.030328 0 4968 3773.255716 9455.407997 0 4969 5806.560629 3832.086004 0 4970 8377.150122 5150.726187 0 4971 7467.087716 5504.26395 0 4972 2408.970686 6905.499123 0 4973 2036.383801 1185.552403 0 4974 6130.038261 112.348532 0 4975 4642.577305 2644.187731 0 4976 3962.278907 4097.58653 0 4977 4274.83524 924.194594 0 4978 5300.445262 2645.388712 0 4979 9127.690629 932.203949 0 4980 8495.211484 6183.994893 0 4981 3492.829109 5371.482264 0 4982 5426.148943 5604.970748 0 4983 8838.415998 5629.09672 0 4984 671.20347 7350.869172 0 4985 838.20484 7823.722535 0 4986 4963.425336 1669.287156 0 4987 3152.401469 6746.200497 0 4988 8366.210602 6235.085898 0 4989 7708.287284 1906.785237 0 4990 5923.057228 1517.785134 0 4991 9161.010318 9777.556041 0 4992 49.161544 6864.357861 0 4993 814.073241 1791.399381 0 4994 7013.770845 2617.747687 0 4995 460.819527 8278.845146 0 4996 1256.134019 1296.025297 0 4997 8845.939325 9717.714386 0 4998 7248.76856 3042.480071 0 4999 6189.688443 5882.681495 0 5000 8134.267157 6303.253744 0 5001 6490.336076 845.266346 0 5002 5633.674869 7208.726062 0 5003 972.55828 1470.335018 0 5004 2015.941695 2454.185278 0 5005 7687.605215 1062.352258 0 5006 4614.201381 2062.027425 0 5007 6116.850392 5603.112179 0 5008 6470.812117 9971.121818 0 5009 3959.077044 4188.137042 0 5010 891.389874 5274.936609 0 5011 659.387321 3907.40052 0 5012 8699.477998 9557.782421 0 5013 6250.189531 6759.240335 0 5014 7492.125832 230.375631 0 5015 8849.137537 7254.033194 0 5016 8840.614614 5533.974641 0 5017 5833.935525 7691.284955 0 5018 933.49968 6743.754625 0 5019 5640.127843 5802.276862 0 5020 3294.052617 3757.541412 0 5021 9178.238042 5675.758914 0 5022 3016.236749 179.86269 0 5023 1240.533648 178.071246 0 5024 2655.832735 5528.690437 0 5025 3207.067111 5652.518404 0 5026 5388.496664 2400.689058 0 5027 7097.129219 4669.444087 0 5028 4703.190986 4919.756743 0 5029 9880.071357 8224.349882 0 5030 2452.577523 3418.956682 0 5031 2248.320424 3324.150367 0 5032 3992.056781 2005.932046 0 5033 5228.526634 8456.964329 0 5034 6163.178489 5848.251064 0 5035 4086.831171 279.444914 0 5036 62.330453 5318.867796 0 5037 6686.99909 6552.47945 0 5038 5694.595003 4445.981626 0 5039 8207.917049 8586.283623 0 5040 7780.549808 217.227878 0 5041 5752.891407 7532.686541 0 5042 2904.276071 2500.135141 0 5043 5541.043167 8030.063576 0 5044 5192.75071 4360.939893 0 5045 8839.880278 8315.945362 0 5046 7303.960532 6986.425995 0 5047 6523.257926 6163.722003 0 5048 1924.628969 1020.300591 0 5049 2317.57171 9627.144297 0 5050 1508.900601 7713.511976 0 5051 2406.87309 4210.156494 0 5052 5594.58913 4153.55057 0 5053 9015.444667 9545.44238 0 5054 4147.875488 4756.604073 0 5055 5887.697605 4300.251379 0 5056 9772.251016 6306.739907 0 5057 6111.463322 1765.083129 0 5058 823.847511 495.668762 0 5059 2680.226159 1905.016978 0 5060 2924.831364 5932.490586 0 5061 6998.185908 9234.046991 0 5062 7047.80241 6304.936187 0 5063 2920.85295 8550.548768 0 5064 8215.054362 7670.83963 0 5065 7327.051558 7326.972084 0 5066 7956.014531 5635.0997 0 5067 2625.084371 2884.558307 0 5068 9508.923625 1641.818482 0 5069 4609.75935 389.094158 0 5070 5505.10933 4879.012861 0 5071 2794.798637 342.726146 0 5072 3010.000733 5584.717736 0 5073 7703.319314 283.204256 0 5074 1104.344443 4596.119732 0 5075 8030.405878 7985.332288 0 5076 7127.089957 3096.294739 0 5077 9445.165687 6102.844358 0 5078 532.297058 2745.34441 0 5079 4956.939878 430.737648 0 5080 8958.38309 4221.536365 0 5081 5301.740564 272.607549 0 5082 2566.534523 3649.849958 0 5083 5786.298104 5126.028177 0 5084 6799.227425 1779.122788 0 5085 5219.30784 3885.910971 0 5086 6045.839149 7282.438716 0 5087 3417.277837 3645.450743 0 5088 5611.966368 8268.13801 0 5089 6254.354817 7434.917232 0 5090 7193.382409 5828.60711 0 5091 6291.597361 1514.475487 0 5092 6246.594247 7283.104328 0 5093 634.426594 3.579986 0 5094 7135.401546 8462.533053 0 5095 243.302169 5638.748574 0 5096 7077.194117 8892.424214 0 5097 3829.527966 3959.957081 0 5098 5808.475191 6606.404369 0 5099 209.676516 4630.160548 0 5100 3029.23166 122.500989 0 5101 7777.589152 3936.894067 0 5102 5746.950084 7100.032439 0 5103 201.645747 1201.097641 0 5104 8763.701433 3910.733786 0 5105 34.864466 9886.24473 0 5106 8143.719691 3313.826906 0 5107 800.937825 5567.925722 0 5108 2696.846989 785.862186 0 5109 5620.922631 272.734226 0 5110 7808.051224 5609.595643 0 5111 2332.989153 4407.863657 0 5112 531.595946 488.529415 0 5113 2625.747532 3788.927973 0 5114 4050.348142 6371.968071 0 5115 7871.592731 3062.769623 0 5116 2203.665834 4635.261026 0 5117 4820.538455 6670.565695 0 5118 3998.635436 938.212291 0 5119 7468.658068 624.552289 0 5120 7273.667799 568.389351 0 5121 8386.48032 2293.779015 0 5122 1008.677731 7836.357293 0 5123 1406.363062 2521.415336 0 5124 8906.199686 8653.12044 0 5125 3600.67865 119.281867 0 5126 2361.796235 4341.337512 0 5127 4686.097698 6690.176776 0 5128 4427.171353 3839.790885 0 5129 1216.57576 5983.888735 0 5130 7871.620644 3274.990899 0 5131 4098.882802 7530.830937 0 5132 8241.598765 7598.954155 0 5133 1711.07111 3450.203421 0 5134 9791.955635 9806.255752 0 5135 8590.505172 6764.843554 0 5136 955.185888 4088.136502 0 5137 6614.7967 8076.512308 0 5138 6341.089224 7841.730028 0 5139 277.556399 2385.52137 0 5140 8120.641318 938.357042 0 5141 5765.513655 8469.091641 0 5142 4619.623789 5980.893984 0 5143 9613.295371 9030.472922 0 5144 112.660323 1293.556552 0 5145 6598.603769 2858.405313 0 5146 619.530022 2773.589272 0 5147 9637.121207 8157.725102 0 5148 5626.935308 8920.99761 0 5149 5838.289616 831.574155 0 5150 4104.014824 4991.571299 0 5151 3678.38402 7214.535603 0 5152 2781.521805 1026.592075 0 5153 1636.726228 3074.375908 0 5154 5790.170627 6924.431978 0 5155 81.401032 5538.065165 0 5156 8062.424188 5292.461085 0 5157 4253.201646 9558.605434 0 5158 9268.673426 9375.797223 0 5159 6177.384608 1188.004432 0 5160 4429.744061 9292.239438 0 5161 7383.76169 5471.175281 0 5162 8629.187989 3037.965907 0 5163 6381.473095 7041.142513 0 5164 7258.710253 6090.708793 0 5165 4024.487506 4081.762193 0 5166 3276.413287 2584.763152 0 5167 6255.33325 6773.126158 0 5168 3585.585876 5710.11261 0 5169 3424.849688 2029.143959 0 5170 9708.195463 7537.034479 0 5171 6991.205422 55.901174 0 5172 6745.276718 3723.930146 0 5173 5073.535532 9326.220572 0 5174 2462.559517 1492.733486 0 5175 7070.128392 5312.845512 0 5176 894.981841 4012.66355 0 5177 8861.732571 3982.873398 0 5178 8843.758617 4963.619476 0 5179 8669.408888 7026.809201 0 5180 7692.213272 2754.296663 0 5181 8968.185538 9840.75786 0 5182 9109.759075 8244.559051 0 5183 8458.123413 1105.70137 0 5184 7418.458195 9778.087356 0 5185 5721.262859 1774.196207 0 5186 3669.855781 7153.886923 0 5187 5984.738173 1648.222319 0 5188 5392.999973 725.151399 0 5189 7640.734853 377.108202 0 5190 8256.859904 2928.921261 0 5191 9976.893443 9131.737458 0 5192 9950.778131 5916.468602 0 5193 5421.497827 7580.207387 0 5194 902.743976 7941.355446 0 5195 8593.854833 5071.092237 0 5196 3868.600509 4031.777583 0 5197 7337.299843 5237.608532 0 5198 2122.806679 8307.696854 0 5199 3606.143942 268.886202 0 5200 6444.870263 5020.370314 0 5201 6879.583928 5239.857697 0 5202 6235.622657 3845.655113 0 5203 362.280883 2347.154994 0 5204 2912.291682 5214.738129 0 5205 4617.564628 4137.419267 0 5206 1133.407492 4106.416438 0 5207 2917.609548 8380.016143 0 5208 7817.540259 59.614671 0 5209 8050.586729 7819.687819 0 5210 4046.036366 5367.568151 0 5211 6416.472974 651.571401 0 5212 7881.735295 9031.298122 0 5213 8762.9832 103.933691 0 5214 4525.878637 2340.854242 0 5215 8122.898338 105.213051 0 5216 1668.450276 5307.005541 0 5217 7505.663599 6049.758852 0 5218 2421.318853 2093.931547 0 5219 2935.945951 6527.009666 0 5220 4715.23391 9732.968293 0 5221 1915.408653 5060.150975 0 5222 5524.948703 7349.082483 0 5223 9981.523694 8518.225514 0 5224 4578.295986 3651.520756 0 5225 3113.864337 6739.402721 0 5226 904.289032 3021.317124 0 5227 8775.655967 2621.675602 0 5228 4000.729852 4831.04563 0 5229 8059.32041 6026.427278 0 5230 4228.713058 3662.846279 0 5231 5682.904908 716.883886 0 5232 7723.842993 8019.05635 0 5233 6098.553185 1212.648891 0 5234 2610.138732 7218.269608 0 5235 2749.555091 9188.009337 0 5236 6621.283505 8813.474292 0 5237 1008.145796 687.804537 0 5238 4495.24873 7757.639988 0 5239 2023.456348 4682.578091 0 5240 3471.533863 7800.963605 0 5241 4869.17862 9299.761153 0 5242 7724.508952 232.95556 0 5243 2775.060414 7112.99334 0 5244 8998.015309 389.742912 0 5245 5156.606688 3918.61063 0 5246 188.97736 3354.211515 0 5247 3497.009347 3889.179184 0 5248 7846.223065 2733.451294 0 5249 8956.726246 9965.071659 0 5250 4914.819622 7906.959526 0 5251 5770.162517 1828.885883 0 5252 6165.169702 44.837721 0 5253 8939.192204 2548.976313 0 5254 1688.595268 9976.965421 0 5255 7733.173697 5703.710685 0 5256 9582.784094 8671.736581 0 5257 7749.765957 1675.40726 0 5258 7963.002062 1149.238842 0 5259 2882.125541 2693.390015 0 5260 8635.249819 7263.068285 0 5261 2089.453976 1303.352805 0 5262 5773.158748 6852.319885 0 5263 2198.137446 9386.403267 0 5264 2634.437666 8321.0842 0 5265 4468.154422 3160.418523 0 5266 8569.753765 9724.593437 0 5267 4793.027526 5496.938088 0 5268 3075.95691 6177.757315 0 5269 2512.863058 6650.874591 0 5270 9103.497573 5343.759275 0 5271 8996.038636 7876.818246 0 5272 619.51362 8775.185687 0 5273 7408.741196 4646.402696 0 5274 4792.239854 7804.312385 0 5275 3432.058653 2895.638231 0 5276 5752.062002 160.712001 0 5277 4170.675158 475.555282 0 5278 1362.171898 7851.211092 0 5279 6239.442049 2038.852271 0 5280 8658.335156 5443.361072 0 5281 2541.24695 4824.440208 0 5282 3489.928446 6192.650255 0 5283 9976.950654 6589.619628 0 5284 4148.541032 5589.783255 0 5285 5476.962112 6841.414121 0 5286 6987.965682 5392.961309 0 5287 4689.076697 5772.325486 0 5288 2575.301424 4089.559705 0 5289 1182.381285 4369.987814 0 5290 6473.1835 4600.981743 0 5291 5400.505424 8616.322445 0 5292 5803.166721 183.766834 0 5293 7855.344768 3035.849363 0 5294 3848.797752 9669.36412 0 5295 8449.106585 3122.592718 0 5296 2325.137575 3997.967911 0 5297 2156.021797 7530.560866 0 5298 686.482367 7.340173 0 5299 4386.05989 30.200744 0 5300 6436.828789 7012.983939 0 5301 568.279604 9267.73263 0 5302 2730.202957 9906.992866 0 5303 8957.080688 4390.757515 0 5304 3806.710081 5434.68799 0 5305 6398.445081 1164.366373 0 5306 144.253344 9597.822398 0 5307 4162.689174 2104.55541 0 5308 8069.324215 3596.860529 0 5309 7860.561051 9259.685749 0 5310 5687.769982 5118.265669 0 5311 7331.055342 489.799414 0 5312 8910.828255 2228.196958 0 5313 2101.334518 3217.316176 0 5314 5648.801018 4830.639067 0 5315 8231.256481 7105.544402 0 5316 4910.715323 2503.470899 0 5317 8972.155873 3020.216036 0 5318 5728.980276 6965.94725 0 5319 5319.780896 7445.348807 0 5320 927.039576 1360.935019 0 5321 2529.181434 7311.435559 0 5322 4721.647968 880.767113 0 5323 1801.267803 8334.21006 0 5324 8547.527391 3309.192 0 5325 2167.843791 5521.49876 0 5326 2562.646779 3818.368256 0 5327 5222.17036 7367.457131 0 5328 9302.50736 4674.454236 0 5329 9689.372249 335.879067 0 5330 6659.564218 3234.584419 0 5331 1412.60629 5340.923417 0 5332 4556.627992 2018.953878 0 5333 6933.417426 220.956071 0 5334 1588.352024 9877.634589 0 5335 1131.216289 5515.569246 0 5336 3773.487808 7838.105336 0 5337 346.485167 2232.90132 0 5338 616.73333 2576.130442 0 5339 4847.031937 193.170209 0 5340 5131.362277 1098.727935 0 5341 6235.707727 5862.624589 0 5342 1562.942312 2345.860606 0 5343 627.579364 9665.397737 0 5344 9330.810038 435.849605 0 5345 6512.70875 4229.138772 0 5346 6316.248488 8492.991492 0 5347 1878.432249 7266.117445 0 5348 9766.092961 5286.472388 0 5349 6578.030028 4990.358868 0 5350 9508.202897 4967.221827 0 5351 5261.721416 5593.20005 0 5352 4185.43592 1968.607576 0 5353 2897.896762 7692.024976 0 5354 789.486235 3885.658778 0 5355 185.77567 9505.162584 0 5356 510.262929 165.163211 0 5357 8531.973 6256.178023 0 5358 2959.168045 480.250092 0 5359 2227.434405 7240.38833 0 5360 7999.594693 6900.634235 0 5361 578.805491 8018.067953 0 5362 8250.05537 3047.33399 0 5363 2477.954846 7314.048522 0 5364 3538.133646 8936.800464 0 5365 6187.803844 4781.237921 0 5366 6404.199171 5663.928088 0 5367 8397.831773 4567.980993 0 5368 9373.192429 2600.875774 0 5369 982.250526 9431.4186 0 5370 3513.821808 5191.727907 0 5371 2912.602318 3748.919525 0 5372 6110.35369 5608.663758 0 5373 5269.061991 5719.096216 0 5374 6286.149541 892.521715 0 5375 8381.722408 2210.961703 0 5376 4977.081717 4193.689421 0 5377 2058.197352 9636.474373 0 5378 2763.743502 446.946571 0 5379 1204.077976 3586.955345 0 5380 1665.726948 5145.505214 0 5381 9748.703183 3268.489015 0 5382 9904.869445 319.54186 0 5383 5224.303994 7431.932911 0 5384 9322.754286 6702.521042 0 5385 8910.383321 1126.760212 0 5386 4652.276507 7363.342019 0 5387 5386.455033 3268.87602 0 5388 8606.708911 5961.88182 0 5389 346.819975 4586.49261 0 5390 7848.615895 4188.779925 0 5391 1657.248059 4846.69803 0 5392 5522.717022 2400.194804 0 5393 6323.051964 5183.923567 0 5394 9532.764254 3728.645572 0 5395 8531.490385 8846.434386 0 5396 7875.788088 7029.217477 0 5397 5450.021143 674.049894 0 5398 5372.191764 1372.547287 0 5399 3662.743101 2348.380592 0 5400 4952.580827 1386.742715 0 5401 8566.112167 837.983872 0 5402 8588.12573 928.93759 0 5403 9713.786378 5386.695865 0 5404 153.979247 750.976562 0 5405 9975.148436 568.450119 0 5406 6384.568553 365.533143 0 5407 9852.797225 8110.483496 0 5408 4125.991591 5404.145235 0 5409 2670.098843 4712.695422 0 5410 6854.644275 8682.300272 0 5411 9559.301178 6636.965947 0 5412 1928.325172 9348.719967 0 5413 7466.085118 7100.892628 0 5414 1449.94473 6478.653991 0 5415 3822.023334 358.516533 0 5416 1172.381038 5688.608025 0 5417 5997.800553 9543.483257 0 5418 8992.658485 1707.492673 0 5419 2824.438897 5239.185928 0 5420 2457.115696 4052.747871 0 5421 1983.864109 9174.413577 0 5422 4653.653491 9031.941149 0 5423 1682.801467 3727.043302 0 5424 9580.649295 6672.075102 0 5425 5802.95618 3685.186987 0 5426 8805.433702 5965.26059 0 5427 992.60169 6435.679125 0 5428 7804.990072 8379.429904 0 5429 2960.910473 9898.210503 0 5430 1360.943454 2857.889285 0 5431 1184.857518 1046.593243 0 5432 5119.852877 5775.917757 0 5433 1753.504508 6867.105864 0 5434 8767.529052 6934.122352 0 5435 1977.087273 6327.142213 0 5436 9596.535608 4071.443252 0 5437 9347.592317 7218.870223 0 5438 4557.384406 1979.459558 0 5439 4628.477397 889.876719 0 5440 8623.233884 5004.800511 0 5441 5708.357276 8299.054226 0 5442 1594.495521 5039.490614 0 5443 7745.264867 3213.645093 0 5444 9270.778757 7621.633209 0 5445 7783.369732 6773.584675 0 5446 7058.95419 7370.523438 0 5447 6428.259145 1567.738744 0 5448 6474.470384 302.4907 0 5449 1679.55851 9832.900483 0 5450 7723.956883 300.066811 0 5451 5143.356822 4084.146624 0 5452 1696.138954 3917.459256 0 5453 9244.965088 1137.633611 0 5454 9680.540204 6533.993961 0 5455 2623.585995 6833.271256 0 5456 9581.480005 9085.727017 0 5457 9430.173466 8499.55825 0 5458 8913.640374 4999.837944 0 5459 8697.921018 7203.605982 0 5460 1776.834905 2025.758535 0 5461 2941.61658 8881.882849 0 5462 8913.132958 7857.015279 0 5463 9887.03081 265.655057 0 5464 644.341593 3645.99006 0 5465 3973.006042 8448.078709 0 5466 926.100831 3731.257285 0 5467 2022.982575 9623.330028 0 5468 3725.957533 2228.093665 0 5469 4925.876101 732.200384 0 5470 3735.151785 3658.722444 0 5471 4386.469963 5171.264913 0 5472 1501.462498 979.149704 0 5473 6767.521346 3860.677811 0 5474 3119.160281 3551.515374 0 5475 5075.242337 2304.163346 0 5476 2709.54979 9629.146931 0 5477 3664.115459 8119.155845 0 5478 3558.113174 1274.749039 0 5479 729.462747 2020.338633 0 5480 9899.175693 4204.284662 0 5481 9885.752078 8551.446402 0 5482 6050.569744 1737.549269 0 5483 1655.50748 7753.361018 0 5484 2429.689505 4764.094056 0 5485 4052.267826 5570.319014 0 5486 2198.208634 7325.507208 0 5487 9523.809086 7307.423164 0 5488 2463.399408 8465.485674 0 5489 1541.109915 3332.228971 0 5490 3845.731743 5522.766511 0 5491 3489.732205 3131.910965 0 5492 1577.13044 3894.95329 0 5493 6902.174494 7483.272512 0 5494 9751.992549 6294.9782 0 5495 5939.999586 469.633043 0 5496 7731.729898 4481.353705 0 5497 2352.885 9883.255148 0 5498 101.190776 4747.853117 0 5499 9258.500524 2281.074745 0 5500 2398.531706 1306.885403 0 5501 6967.937318 6635.621204 0 5502 6635.611898 7082.501778 0 5503 6992.128086 496.534958 0 5504 9256.241847 7207.952655 0 5505 5521.209214 5257.259432 0 5506 8205.224938 4554.104788 0 5507 8619.716679 6966.767229 0 5508 4107.698294 7139.300338 0 5509 7960.852223 7310.733597 0 5510 6134.744161 2491.912514 0 5511 1920.116883 8330.902715 0 5512 835.490147 1054.289718 0 5513 1677.45654 5498.794192 0 5514 5224.060974 4297.854592 0 5515 7520.473112 7114.417453 0 5516 1421.535765 3005.988139 0 5517 7245.998742 6225.904522 0 5518 2769.734093 4400.390919 0 5519 9647.791874 8324.010159 0 5520 6034.364894 8756.155173 0 5521 6724.82299 5525.468915 0 5522 5058.852991 3169.009531 0 5523 7620.195958 4479.524477 0 5524 5408.362342 7769.971409 0 5525 9657.339934 8166.194199 0 5526 4461.092756 5873.673918 0 5527 1083.065376 6239.879663 0 5528 8129.195914 9662.7382 0 5529 6342.092754 1964.767325 0 5530 2049.723502 2467.934922 0 5531 6791.286519 6364.741024 0 5532 5557.851773 4591.411316 0 5533 3718.141406 7679.919319 0 5534 5936.51509 4087.726921 0 5535 9779.737642 3840.434575 0 5536 1883.082613 9052.904212 0 5537 4076.617703 951.244324 0 5538 8552.040113 2528.902782 0 5539 6398.817639 7688.192754 0 5540 7137.039155 2045.512203 0 5541 4758.777271 3081.118089 0 5542 3469.581595 6258.955365 0 5543 1506.513762 2722.229243 0 5544 5504.256648 1825.039751 0 5545 9323.283613 9297.416405 0 5546 9758.370792 553.108339 0 5547 6795.422303 8756.781569 0 5548 3102.589083 6193.739239 0 5549 6694.857873 1292.227894 0 5550 8248.99786 3986.225814 0 5551 709.356574 9231.666433 0 5552 6344.476185 2804.087455 0 5553 8846.691863 2984.778027 0 5554 8406.193925 6113.269069 0 5555 3820.252788 1838.107781 0 5556 4705.198146 5723.388226 0 5557 891.747732 1610.527089 0 5558 5377.309361 1412.683013 0 5559 4070.889114 66.979866 0 5560 6719.721457 8559.462205 0 5561 8184.758074 3355.159634 0 5562 6555.799226 3154.905644 0 5563 921.280972 9250.469524 0 5564 2594.890957 3492.433969 0 5565 1592.554463 8627.429131 0 5566 5834.361555 1449.388927 0 5567 8263.451371 7744.294501 0 5568 6378.005741 6703.140773 0 5569 4105.083305 1525.04817 0 5570 7066.426603 8579.069082 0 5571 3345.6593 1003.331334 0 5572 6176.773962 8395.763922 0 5573 9831.956255 1559.417196 0 5574 7750.619851 581.033397 0 5575 5185.427785 54.614222 0 5576 1240.545485 617.034969 0 5577 7918.595449 9990.732334 0 5578 6006.950058 1745.808358 0 5579 2959.267147 1889.376636 0 5580 3472.710177 5070.482499 0 5581 6213.451547 3475.42316 0 5582 3373.255328 878.288743 0 5583 208.28175 2957.680691 0 5584 8632.527849 8781.762434 0 5585 9408.088638 5009.35664 0 5586 2646.858754 4479.374717 0 5587 1054.752177 4624.526229 0 5588 2897.369633 1369.719304 0 5589 3388.730729 851.114862 0 5590 8345.711631 3368.044301 0 5591 9961.795587 1662.964461 0 5592 5665.884046 448.426029 0 5593 8203.587834 4180.554549 0 5594 2102.494048 9946.390085 0 5595 2612.434524 8252.933841 0 5596 2072.511104 4618.259056 0 5597 7570.72838 3154.257982 0 5598 4164.802427 476.782024 0 5599 2273.006619 4712.446613 0 5600 2475.091617 6543.627325 0 5601 3285.916873 7635.941867 0 5602 9756.050926 2602.538583 0 5603 9575.465316 8251.452146 0 5604 3027.679241 3761.236955 0 5605 3119.003412 1164.388475 0 5606 7808.47279 7654.953199 0 5607 9978.489493 4251.862542 0 5608 3913.914063 5037.769235 0 5609 6602.271726 9025.359939 0 5610 8852.091326 2389.201832 0 5611 3294.748068 7046.676323 0 5612 3700.066028 5799.676075 0 5613 6968.443245 4357.404743 0 5614 7317.91445 6690.805566 0 5615 4558.996114 8396.72962 0 5616 6460.959132 2405.556106 0 5617 9773.80426 7284.122333 0 5618 7667.315862 3693.471855 0 5619 9866.891257 9670.220232 0 5620 2777.306333 6613.464578 0 5621 1819.582617 6735.162445 0 5622 5708.481867 5674.37402 0 5623 1157.651617 8455.616375 0 5624 7338.20204 5396.365042 0 5625 4450.511467 7225.898425 0 5626 1414.208675 8267.371653 0 5627 7164.542926 7638.140135 0 5628 5261.793085 5653.357174 0 5629 3840.052105 1196.042883 0 5630 9055.243804 1262.042549 0 5631 4739.460218 4075.803045 0 5632 6857.190394 456.4896 0 5633 7356.707276 9849.229234 0 5634 1785.149623 4187.82757 0 5635 5108.970313 5644.629628 0 5636 1643.70989 4044.914697 0 5637 2759.04687 1456.55257 0 5638 2102.532365 4560.203193 0 5639 4972.167736 2240.415293 0 5640 7332.535013 2083.19572 0 5641 339.858478 398.526605 0 5642 493.449074 5603.285297 0 5643 6828.829336 8849.544952 0 5644 8898.456577 5180.168838 0 5645 6920.989239 8145.7715 0 5646 2823.105022 2363.677484 0 5647 962.152389 4125.223335 0 5648 8008.84932 5806.735146 0 5649 4596.831747 8298.833168 0 5650 1470.038279 586.385419 0 5651 7438.981731 7243.511794 0 5652 8915.359127 6899.769205 0 5653 91.728484 5339.389117 0 5654 639.888005 3719.586764 0 5655 6858.108048 8491.215737 0 5656 2926.722869 1713.141813 0 5657 4503.432589 1054.391018 0 5658 9542.97885 1294.134977 0 5659 5531.279093 4943.673803 0 5660 9215.760064 8127.947138 0 5661 3477.840755 9067.065962 0 5662 704.256719 2203.986613 0 5663 7634.841256 5677.584376 0 5664 3768.226492 3810.079525 0 5665 3316.881506 2711.972346 0 5666 3928.461458 4063.852165 0 5667 3926.483295 2871.817965 0 5668 6639.619791 7391.371339 0 5669 1969.133147 9784.253019 0 5670 1644.62759 176.712897 0 5671 8758.853075 3801.849675 0 5672 1516.767714 2148.652367 0 5673 5343.057039 3993.458367 0 5674 1886.70464 1070.543684 0 5675 9942.459086 7097.950866 0 5676 7045.267314 1203.409885 0 5677 4140.031506 5959.41907 0 5678 5938.750888 1406.054777 0 5679 8959.242339 5956.396603 0 5680 2315.584522 4692.341655 0 5681 5488.648969 9886.847686 0 5682 4514.1464 1398.478348 0 5683 2850.26485 3719.83964 0 5684 7740.194724 6406.577741 0 5685 4714.250506 1722.385855 0 5686 4038.365044 6978.322409 0 5687 5421.567115 6027.719215 0 5688 8230.517959 1018.390975 0 5689 9122.004385 5554.150369 0 5690 5386.643192 4075.037546 0 5691 6226.592672 8755.655181 0 5692 9478.849461 4955.943321 0 5693 2078.4611 3748.607703 0 5694 6127.692516 9338.419521 0 5695 9499.523107 5669.164541 0 5696 350.916222 8505.676162 0 5697 9949.849182 4470.905437 0 5698 7003.816419 5954.540632 0 5699 6267.912445 7900.347797 0 5700 4208.394147 2694.222897 0 5701 2935.944722 1652.43114 0 5702 7058.033462 7659.4499 0 5703 2732.634811 4900.657847 0 5704 6048.851121 5683.655008 0 5705 4997.592574 736.495203 0 5706 2449.115496 7139.200106 0 5707 4812.478035 3472.764138 0 5708 934.622353 6106.748382 0 5709 4812.028095 1372.366498 0 5710 5336.776499 5635.959073 0 5711 4949.063893 3392.812924 0 5712 6385.659435 2129.982366 0 5713 4563.118658 1461.455857 0 5714 9784.125333 9193.138234 0 5715 105.637761 2060.238786 0 5716 1409.035865 7699.592383 0 5717 3256.3403 2322.139355 0 5718 1906.592596 4436.449952 0 5719 4737.817459 7611.325638 0 5720 2384.418241 9294.499076 0 5721 3053.866493 8695.401056 0 5722 823.162806 7755.067428 0 5723 8585.820749 3419.827899 0 5724 8080.7928 9621.235557 0 5725 310.08831 1400.646565 0 5726 7510.934237 3806.431166 0 5727 4204.979748 9261.04331 0 5728 5120.497305 1074.532203 0 5729 8399.014446 5386.817318 0 5730 1153.226298 2440.789235 0 5731 6275.452175 8816.375312 0 5732 1950.586489 9742.500859 0 5733 3898.950814 1698.960122 0 5734 2830.822651 6932.545838 0 5735 4175.417097 2631.696543 0 5736 6001.362843 2930.304641 0 5737 1290.14014 1695.87946 0 5738 3856.024224 4213.146367 0 5739 5815.364115 7546.643249 0 5740 4029.262015 5424.184689 0 5741 7983.93145 260.370768 0 5742 1827.336478 7770.846971 0 5743 147.871715 9209.815024 0 5744 9194.191869 2921.84901 0 5745 4947.08266 219.772538 0 5746 5007.289343 2915.238947 0 5747 5453.815283 5814.689402 0 5748 2805.620841 4408.80583 0 5749 8589.516949 7172.564734 0 5750 130.333081 4981.151292 0 5751 8535.024435 8230.36455 0 5752 9304.13103 3435.18344 0 5753 4448.458323 1550.383502 0 5754 1022.006037 1785.29291 0 5755 9095.590853 6256.603406 0 5756 1382.725157 525.416986 0 5757 8963.354782 2475.661013 0 5758 1663.307575 1832.1032 0 5759 827.76134 619.854043 0 5760 5992.353197 5994.147755 0 5761 2300.108041 7727.391808 0 5762 7696.97668 9318.930893 0 5763 54.731742 4278.332674 0 5764 5690.363387 3398.368746 0 5765 9914.393515 599.002134 0 5766 219.559467 6366.415822 0 5767 1236.796329 5735.875767 0 5768 931.890443 1999.755899 0 5769 8239.80628 5768.23961 0 5770 9052.189065 2450.192292 0 5771 2752.668918 3128.284865 0 5772 4651.590133 108.755049 0 5773 5451.888836 3684.732493 0 5774 8033.621299 5613.730419 0 5775 483.122003 4149.600032 0 5776 9166.50956 7215.260242 0 5777 5643.207584 1253.81457 0 5778 9074.914586 6212.4731 0 5779 7379.583643 7858.681851 0 5780 9182.166945 764.618674 0 5781 2358.831204 505.623821 0 5782 6159.70525 9501.394346 0 5783 3141.880216 4879.663242 0 5784 6554.656687 1242.955584 0 5785 9740.322541 5597.16231 0 5786 5554.314027 5324.375637 0 5787 300.2378 2721.74065 0 5788 255.183763 7403.446518 0 5789 3585.045494 9041.066146 0 5790 1266.236079 575.173587 0 5791 365.796378 1777.164047 0 5792 5609.138196 5792.360803 0 5793 7032.272995 4568.206505 0 5794 1847.980419 5070.346338 0 5795 2042.428228 5702.753407 0 5796 2102.834615 8822.095316 0 5797 4425.569987 7679.168994 0 5798 2038.590159 9169.234039 0 5799 51.715064 6730.03715 0 5800 9290.035873 7962.743412 0 5801 6282.998232 268.85705 0 5802 9488.795428 198.670908 0 5803 7000.721226 1256.783011 0 5804 7087.584375 2904.842624 0 5805 3635.061747 8688.690829 0 5806 573.346502 3362.117021 0 5807 4621.437562 5675.901593 0 5808 9782.022971 2376.290076 0 5809 7251.795 3306.361609 0 5810 2713.051614 1439.713283 0 5811 989.311258 164.490226 0 5812 486.595953 7336.537325 0 5813 9388.297324 2065.222038 0 5814 1286.384551 6035.012497 0 5815 7508.882731 953.381699 0 5816 1171.651925 9365.634157 0 5817 3563.432193 1379.214269 0 5818 2767.127581 2535.886901 0 5819 6290.17696 8520.60477 0 5820 3801.705523 9929.272904 0 5821 4644.773998 1539.61502 0 5822 1745.249013 5002.633625 0 5823 5024.948205 4233.116188 0 5824 1968.297306 886.301662 0 5825 5843.655584 1376.791483 0 5826 5062.178201 8102.934455 0 5827 912.49363 8920.402125 0 5828 250.565868 3109.862841 0 5829 2418.552427 9470.678561 0 5830 8533.632367 6814.587257 0 5831 7430.711953 8942.620724 0 5832 3738.008949 5221.220706 0 5833 2344.718541 4360.957931 0 5834 4925.042095 6892.174833 0 5835 5735.470951 6657.37649 0 5836 6412.971365 1087.983267 0 5837 526.676171 178.475407 0 5838 2160.550578 8357.91542 0 5839 533.557449 6910.311466 0 5840 487.325624 5599.59685 0 5841 9126.952123 8559.330944 0 5842 2573.61261 8431.062559 0 5843 3331.191041 2217.520732 0 5844 61.869771 5674.021287 0 5845 2571.341354 8567.633621 0 5846 3326.149462 4144.573609 0 5847 2512.685802 318.782933 0 5848 177.196247 3405.752814 0 5849 6264.326605 1838.341701 0 5850 2437.481291 634.423355 0 5851 2557.084965 7008.050979 0 5852 1123.966016 4970.471954 0 5853 5517.872407 5889.400886 0 5854 6550.720431 2199.947599 0 5855 7372.577721 6686.845115 0 5856 7547.373486 6660.496735 0 5857 6485.764618 6227.851115 0 5858 7226.740942 1595.609792 0 5859 6071.350805 8049.812812 0 5860 6474.031923 9055.748922 0 5861 9024.250789 8266.097404 0 5862 5201.896613 8058.838949 0 5863 9715.727568 8651.392693 0 5864 2301.67589 5686.926602 0 5865 2054.081246 4824.465202 0 5866 9869.464179 9844.564678 0 5867 6175.227505 7851.38193 0 5868 2501.866313 5832.231845 0 5869 5261.750745 6455.434543 0 5870 4003.830208 8780.535681 0 5871 1443.904238 3378.741228 0 5872 2466.830915 2079.375712 0 5873 9556.120988 4368.217449 0 5874 9368.256081 1794.289136 0 5875 802.947989 537.055755 0 5876 723.416991 931.369431 0 5877 9952.111498 5549.749442 0 5878 6982.854323 997.101989 0 5879 5570.289118 5192.827976 0 5880 6353.888504 4217.405965 0 5881 3035.794442 9448.98834 0 5882 8023.122111 410.811484 0 5883 3249.437445 3279.166487 0 5884 3306.624066 4014.028922 0 5885 811.446076 1748.792928 0 5886 1638.348695 5545.612768 0 5887 6787.078355 356.501846 0 5888 3161.044125 9493.565292 0 5889 7310.018293 7170.850599 0 5890 5449.849715 85.909843 0 5891 6437.013569 1266.260064 0 5892 5499.258917 963.542071 0 5893 4883.100258 6638.877419 0 5894 2863.150538 7472.577727 0 5895 9522.01895 3805.317732 0 5896 260.906993 6042.391364 0 5897 2354.371909 2739.407042 0 5898 5280.940818 2544.683053 0 5899 8710.909967 2865.635225 0 5900 1146.521659 6470.33769 0 5901 1205.576841 7430.837133 0 5902 6897.662084 1674.011085 0 5903 2740.664338 3164.108303 0 5904 8951.746558 9711.437786 0 5905 7656.115283 2457.246077 0 5906 9752.30836 2808.526435 0 5907 1932.209886 4774.113076 0 5908 406.102039 8965.622916 0 5909 1894.229122 7224.174418 0 5910 1099.388851 2927.046157 0 5911 9945.409381 5593.76458 0 5912 7644.14498 3142.863889 0 5913 948.442744 4922.072978 0 5914 6068.764243 3303.070471 0 5915 2420.510949 8418.737401 0 5916 7434.241864 2359.98772 0 5917 4877.289813 4815.124851 0 5918 7652.042458 5195.636358 0 5919 5924.511938 6294.250587 0 5920 2382.894269 562.651282 0 5921 6797.697665 3356.488326 0 5922 8106.279509 9342.396003 0 5923 6897.26143 8584.077776 0 5924 538.888721 8426.204297 0 5925 7784.882861 7699.073386 0 5926 3313.507952 156.462993 0 5927 4946.79754 5344.192873 0 5928 9042.177849 4252.274409 0 5929 5040.843749 2951.811906 0 5930 8654.092901 168.786874 0 5931 5543.911016 6040.658237 0 5932 8988.692613 9986.569027 0 5933 2722.161252 252.687783 0 5934 8539.967255 427.950983 0 5935 3291.77201 8940.730367 0 5936 6268.644352 4927.917839 0 5937 6662.021639 4097.773356 0 5938 2591.312947 284.482088 0 5939 7797.246118 4845.727216 0 5940 2806.501161 4348.152841 0 5941 4951.64331 4061.167941 0 5942 5018.124796 5433.310585 0 5943 3118.157828 4742.724624 0 5944 3572.706727 9131.751179 0 5945 1748.440105 6567.432848 0 5946 3492.539318 9379.145805 0 5947 1174.106417 262.880798 0 5948 1514.102694 5353.37014 0 5949 9477.985275 9982.41913 0 5950 7297.345124 3881.286883 0 5951 6260.514294 4482.323266 0 5952 264.551091 5057.383381 0 5953 1215.232523 6275.586145 0 5954 235.368742 7338.747426 0 5955 5322.743682 3062.298397 0 5956 4171.803598 493.215322 0 5957 7102.777906 8088.25941 0 5958 2776.426292 7688.640542 0 5959 8412.679646 3361.000955 0 5960 6014.97731 9358.20109 0 5961 8778.053669 2266.291274 0 5962 5709.179718 128.791773 0 5963 9674.480226 7888.808884 0 5964 5579.789307 5427.014913 0 5965 6548.64182 7344.900587 0 5966 5497.662235 7845.380784 0 5967 7154.244449 5552.583302 0 5968 6715.038046 9152.073024 0 5969 8212.575315 2169.034791 0 5970 3991.6638 8249.318798 0 5971 7809.930401 7071.863637 0 5972 2285.138176 8802.785055 0 5973 9884.179888 5057.218354 0 5974 2255.587263 2424.972111 0 5975 8327.997203 7271.600253 0 5976 1214.32751 5486.911309 0 5977 5954.758517 5147.683111 0 5978 5355.904942 6285.462043 0 5979 4913.286889 2894.237744 0 5980 6824.495096 7999.2061 0 5981 3472.136566 6902.205539 0 5982 7549.489263 9536.320252 0 5983 4622.587139 3312.472635 0 5984 9141.628705 7335.048168 0 5985 9330.36142 1447.507761 0 5986 5957.548447 3037.401542 0 5987 1710.172139 7368.949339 0 5988 1999.761626 4195.362466 0 5989 3282.946924 7765.631744 0 5990 1515.500831 6117.314103 0 5991 132.800605 5982.630458 0 5992 288.791932 73.372527 0 5993 5434.791255 7694.419757 0 5994 2383.989501 8390.362079 0 5995 933.77894 280.830891 0 5996 1648.308369 3693.124709 0 5997 5122.948103 2876.434062 0 5998 6735.36988 4231.308521 0 5999 106.229836 7919.098573 0 6000 895.120126 3178.455194 0 6001 1536.548689 7637.853466 0 6002 8201.913572 8018.726911 0 6003 9673.103625 1224.358598 0 6004 9189.210585 6907.623128 0 6005 1204.215289 9772.02844 0 6006 1132.306691 1053.268225 0 6007 6718.679744 2418.955424 0 6008 1115.084744 9297.373603 0 6009 8837.739534 1907.066594 0 6010 3116.981154 6185.569078 0 6011 5646.1293 8703.793995 0 6012 5777.593417 6170.353188 0 6013 9259.693121 1866.823077 0 6014 158.051304 3316.415153 0 6015 9259.773311 6661.595568 0 6016 4621.13614 657.309031 0 6017 4565.491256 343.010018 0 6018 1941.912999 2120.346184 0 6019 4765.745382 7781.020489 0 6020 1145.395405 7096.037824 0 6021 5096.392782 6846.167811 0 6022 122.915738 9414.324925 0 6023 925.291851 3961.704376 0 6024 1407.454414 6804.175072 0 6025 2925.421438 2455.305609 0 6026 1194.236005 8172.111677 0 6027 2067.562258 2600.127353 0 6028 7997.01667 3906.347351 0 6029 6941.576701 7839.244135 0 6030 8749.501324 5342.832746 0 6031 2238.049367 8177.919507 0 6032 5896.241263 5575.311168 0 6033 1550.246276 6226.735922 0 6034 5987.663154 3589.744894 0 6035 7416.174013 4514.52433 0 6036 2323.076976 6832.721735 0 6037 9084.587693 8221.502059 0 6038 3374.822764 7698.123798 0 6039 7982.427028 145.428831 0 6040 1510.767245 3772.922355 0 6041 6946.711724 3623.512422 0 6042 2838.340706 5464.722588 0 6043 1055.57337 8513.853522 0 6044 9484.028396 7454.381673 0 6045 5364.354009 6076.215554 0 6046 7494.528447 7576.717538 0 6047 4186.529916 1349.925825 0 6048 2459.083476 207.730874 0 6049 5314.819178 7751.32862 0 6050 1318.677287 7182.46919 0 6051 4327.209535 5171.831963 0 6052 2715.310913 478.959431 0 6053 9282.45929 8734.429072 0 6054 4744.040853 500.223114 0 6055 5651.579472 4015.794109 0 6056 5365.459913 4269.014084 0 6057 534.019024 8690.956375 0 6058 771.093866 2016.456348 0 6059 7404.13853 5710.865073 0 6060 6915.365259 2778.145294 0 6061 4523.667003 6609.136622 0 6062 6698.538495 8160.503901 0 6063 8823.125015 9191.907621 0 6064 7925.172947 3388.560132 0 6065 2734.397861 8935.670432 0 6066 913.60465 3969.359322 0 6067 5075.74458 4757.764523 0 6068 5708.491444 9247.124537 0 6069 743.839329 1220.241089 0 6070 2617.370595 9865.141497 0 6071 6008.093972 7823.749081 0 6072 7767.842295 5550.906611 0 6073 8204.929784 5708.804925 0 6074 5508.319831 426.078299 0 6075 3287.332216 5163.517943 0 6076 1750.560327 582.804388 0 6077 9828.488993 2293.772622 0 6078 5429.515369 5452.912058 0 6079 8008.914705 9910.1473 0 6080 4864.026197 999.785614 0 6081 986.63109 1997.690756 0 6082 899.281434 1207.727763 0 6083 8946.675023 9811.684837 0 6084 1460.70621 4706.439919 0 6085 7511.121637 8054.704029 0 6086 1326.334839 6050.561853 0 6087 2603.408062 9781.490649 0 6088 6878.635182 1898.9127 0 6089 7390.908604 416.131439 0 6090 384.100326 2791.187465 0 6091 7273.939511 9953.140187 0 6092 4545.916655 6229.244709 0 6093 8276.577321 7353.071748 0 6094 2139.92949 8347.389066 0 6095 6009.830023 725.975333 0 6096 5851.94557 2322.428199 0 6097 4257.4993 2068.29714 0 6098 1483.136725 2745.812115 0 6099 1069.289669 1439.744112 0 6100 9715.589559 8615.049787 0 6101 9993.493096 6925.132487 0 6102 5493.246348 1122.874838 0 6103 7921.480296 2062.933663 0 6104 3631.688012 1865.72799 0 6105 3985.391623 2571.91315 0 6106 6195.279563 1489.307362 0 6107 8620.544252 9424.643795 0 6108 6750.429721 2601.599654 0 6109 3211.658211 5992.227999 0 6110 8824.188275 7184.67466 0 6111 6135.473714 8578.986724 0 6112 7923.286935 7008.677353 0 6113 1876.080634 4985.769137 0 6114 8438.719463 3930.7544 0 6115 653.655445 893.841096 0 6116 7016.52734 7245.576968 0 6117 2351.263694 2381.097556 0 6118 8318.042995 7950.341542 0 6119 1897.275727 4623.717284 0 6120 1898.024232 2287.352655 0 6121 8501.781835 125.939167 0 6122 9669.894903 1637.552012 0 6123 5586.978 4303.859477 0 6124 3615.340771 9495.451889 0 6125 6670.774297 4097.442061 0 6126 8140.604746 3236.655207 0 6127 3359.100276 8559.508243 0 6128 4248.559875 3590.87944 0 6129 4314.142294 3405.36342 0 6130 8614.696687 5076.82879 0 6131 5416.020164 6160.098964 0 6132 5426.256356 4208.019051 0 6133 820.853206 1231.478252 0 6134 763.954465 2757.907897 0 6135 4541.625722 1371.896139 0 6136 9601.389394 5694.681539 0 6137 4765.671626 3049.536097 0 6138 5479.097878 7252.373976 0 6139 943.587728 6620.167144 0 6140 9884.819023 1926.70839 0 6141 2425.99001 3232.612728 0 6142 6345.488004 6599.42521 0 6143 9778.636933 9043.412943 0 6144 5682.099141 8076.123528 0 6145 5307.945521 6431.116603 0 6146 5464.804355 4706.465182 0 6147 1300.296472 8276.741163 0 6148 1084.330483 4110.518967 0 6149 1035.708939 7800.427991 0 6150 8915.358889 3247.389939 0 6151 8337.389048 2868.76756 0 6152 9097.30425 6916.983909 0 6153 8589.851933 161.850738 0 6154 7324.819607 324.111822 0 6155 3704.295406 2428.719452 0 6156 1537.50009 4681 0 6157 7425.472811 7702.337918 0 6158 9681.62483 2758.818479 0 6159 527.682602 250.704277 0 6160 2978.68539 1377.66062 0 6161 9898.163673 783.859565 0 6162 4311.572809 9765.880969 0 6163 8397.512467 3283.441693 0 6164 2022.955808 2650.104544 0 6165 6416.996484 2801.011386 0 6166 7500.837308 6377.51312 0 6167 1758.45652 5865.169819 0 6168 1662.874091 8171.456954 0 6169 2656.78657 3250.311596 0 6170 4006.043369 3063.80318 0 6171 1064.244311 4683.476626 0 6172 1314.342056 4696.226701 0 6173 5334.033138 8789.690975 0 6174 6439.884699 662.643512 0 6175 609.584176 8909.311868 0 6176 3184.418378 6247.757392 0 6177 9677.566441 1835.890986 0 6178 9384.869075 7260.166454 0 6179 3276.571027 6765.947159 0 6180 4516.264219 3443.460322 0 6181 2905.003362 9618.036438 0 6182 9643.506976 2927.190893 0 6183 1530.016723 5295.782283 0 6184 7299.404486 83.617977 0 6185 1596.602685 4499.415029 0 6186 1685.685265 5955.025402 0 6187 7191.780122 7320.016491 0 6188 9201.469556 9568.009292 0 6189 6210.569082 4032.189773 0 6190 5654.17735 9104.787847 0 6191 6420.919011 9264.47836 0 6192 7001.142941 7578.008342 0 6193 4593.491657 8447.917727 0 6194 7997.985093 8792.060957 0 6195 6814.10443 626.109579 0 6196 5722.964667 3322.431006 0 6197 2101.145496 1158.892439 0 6198 7483.49968 9.413224 0 6199 4934.535191 720.490153 0 6200 4280.440793 9520.971459 0 6201 6185.854866 5149.921106 0 6202 1734.412119 3565.872759 0 6203 9048.982738 8852.984205 0 6204 6861.281068 3435.504566 0 6205 8935.816814 8867.812437 0 6206 7891.117394 7242.775801 0 6207 7477.531353 2706.230443 0 6208 8497.151308 1589.241348 0 6209 2954.357788 4399.98258 0 6210 249.313192 9330.008726 0 6211 4092.453768 5916.432519 0 6212 6212.245166 9325.123231 0 6213 2200.299451 7277.51612 0 6214 5080.144744 9429.249337 0 6215 714.667408 933.555077 0 6216 3260.491827 9577.970592 0 6217 3458.519994 1341.456623 0 6218 2660.605729 3353.366176 0 6219 3233.442216 1354.48641 0 6220 783.858731 3127.163284 0 6221 3087.958249 6706.25732 0 6222 5253.731136 4867.768663 0 6223 3605.384943 5802.730553 0 6224 8704.027218 8150.268069 0 6225 3992.544067 9730.462253 0 6226 9570.476976 6996.785191 0 6227 1032.549637 8976.017471 0 6228 6960.698136 2938.29309 0 6229 7713.47551 178.370002 0 6230 7788.635858 3630.532676 0 6231 3289.577849 5575.154698 0 6232 9046.305443 5083.861886 0 6233 2262.225508 4574.222802 0 6234 3680.63478 7884.290636 0 6235 258.202186 1150.601734 0 6236 9331.973819 5611.881451 0 6237 9956.979992 6273.466758 0 6238 911.807671 9114.811681 0 6239 2285.623476 7286.300108 0 6240 3955.891667 8672.927359 0 6241 8336.101907 5779.983503 0 6242 8101.744417 7541.226323 0 6243 6456.082105 9862.116342 0 6244 7090.059691 8593.801039 0 6245 7822.009681 8295.352954 0 6246 8646.194102 9711.23305 0 6247 6465.80503 3196.287415 0 6248 428.50816 2566.677114 0 6249 7981.747492 7721.698543 0 6250 1489.573984 2688.950254 0 6251 1458.407035 5338.196899 0 6252 476.303535 1800.218439 0 6253 2763.024322 9878.551136 0 6254 1272.368949 7585.185226 0 6255 8022.842661 130.215529 0 6256 7546.546269 5800.205468 0 6257 828.062822 5706.791744 0 6258 5882.78809 7919.201227 0 6259 5365.413169 3686.446093 0 6260 9846.459416 7228.444653 0 6261 1907.147543 8257.570898 0 6262 9997.372818 8114.739628 0 6263 4625.478501 3735.728382 0 6264 9090.214025 9155.255838 0 6265 8808.218747 6701.113652 0 6266 4706.736957 4336.13568 0 6267 8461.159017 4930.284753 0 6268 4455.686651 8093.253866 0 6269 8237.18514 4035.844578 0 6270 9506.500558 1392.65432 0 6271 3913.12567 4302.08415 0 6272 3891.266456 354.092482 0 6273 7585.932458 8053.633965 0 6274 2041.885485 5951.766469 0 6275 3023.241339 9311.840804 0 6276 3393.533448 8303.107634 0 6277 9795.62575 1470.013333 0 6278 9703.413417 5638.267143 0 6279 4215.657641 667.60923 0 6280 1847.693377 4450.691735 0 6281 7108.513692 356.97807 0 6282 9746.477628 114.634966 0 6283 613.814502 101.834934 0 6284 3699.844931 2517.98437 0 6285 9094.759804 7872.506176 0 6286 8256.130052 1012.375897 0 6287 9342.707043 3231.898978 0 6288 6685.881941 4400.55729 0 6289 3290.330859 1441.677808 0 6290 9967.617665 5903.589242 0 6291 3045.969953 7747.710277 0 6292 7695.771098 2696.520866 0 6293 2620.728152 7315.631809 0 6294 3283.590542 4608.473687 0 6295 906.769009 4522.158066 0 6296 5546.148891 9108.572496 0 6297 2089.891519 9358.698731 0 6298 3400.040268 455.529977 0 6299 9093.457034 5861.666632 0 6300 323.921493 679.014698 0 6301 8820.928755 1992.88407 0 6302 7907.169618 1265.675256 0 6303 804.441319 602.219991 0 6304 5728.662056 4731.077255 0 6305 5376.341872 4167.746297 0 6306 4633.496239 4427.765018 0 6307 3988.827484 9942.97761 0 6308 6865.750629 6274.583378 0 6309 8720.487913 3279.919985 0 6310 3029.014393 4401.41391 0 6311 543.229646 8549.511869 0 6312 9504.817991 3649.302246 0 6313 4757.627657 2282.759022 0 6314 6134.085031 2128.802368 0 6315 9357.128746 2982.545739 0 6316 398.320134 7849.132947 0 6317 3349.107796 4912.738644 0 6318 5202.937213 1632.860052 0 6319 9255.131617 2290.800346 0 6320 5379.794169 3976.559541 0 6321 9772.096886 2621.504885 0 6322 3541.85883 1877.962814 0 6323 7099.813411 8441.671396 0 6324 817.582771 5743.62503 0 6325 8273.306784 7462.449147 0 6326 6151.300009 1301.352617 0 6327 1305.962168 7838.437498 0 6328 3897.025997 4292.784223 0 6329 9644.726612 9223.310891 0 6330 605.375316 4846.678302 0 6331 1350.960981 6816.961698 0 6332 4196.915932 9951.128702 0 6333 6021.830147 5706.839013 0 6334 8895.792857 3246.591963 0 6335 2497.598642 7638.154615 0 6336 8172.860535 6720.155857 0 6337 377.616811 8761.189855 0 6338 7143.972128 3075.254814 0 6339 9340.592872 944.854233 0 6340 220.477657 7963.494817 0 6341 8361.197416 2596.266444 0 6342 8883.419849 5220.92779 0 6343 6686.896784 2519.844256 0 6344 722.860083 2255.615316 0 6345 2646.918861 6478.987396 0 6346 9886.956438 5259.166811 0 6347 3921.421068 5253.485377 0 6348 1022.167452 7139.880661 0 6349 6579.647297 6409.040036 0 6350 6440.026206 1346.931536 0 6351 9161.075194 4419.054692 0 6352 3396.440157 3495.669938 0 6353 3192.497794 8935.838298 0 6354 770.06275 5609.912082 0 6355 2585.993516 1014.152009 0 6356 5302.082217 5584.40472 0 6357 3495.816911 3629.804878 0 6358 9190.863429 5484.311855 0 6359 8021.600411 6942.639212 0 6360 6658.458698 9367.944959 0 6361 7446.949738 4554.987064 0 6362 4674.910148 7892.127819 0 6363 8460.219465 7948.521721 0 6364 7650.002974 3322.475022 0 6365 6075.941013 607.749511 0 6366 1845.463151 1414.347106 0 6367 9724.763172 602.580201 0 6368 6893.023807 8295.271722 0 6369 5887.381168 2166.658787 0 6370 6499.169114 7568.40378 0 6371 3058.182695 2976.45216 0 6372 9172.465365 4898.712747 0 6373 2822.273696 1728.595115 0 6374 1007.782739 2613.097885 0 6375 337.39307 2568.082852 0 6376 7406.736729 1481.531612 0 6377 9373.885547 290.388596 0 6378 7344.030304 9825.265917 0 6379 351.425089 1072.481948 0 6380 4411.533577 428.596214 0 6381 7507.021299 2669.845648 0 6382 3872.878779 1626.044852 0 6383 7428.939967 8019.791534 0 6384 2760.417616 5625.011568 0 6385 741.078739 9990.459297 0 6386 8239.321051 8013.581801 0 6387 8426.240122 2602.06549 0 6388 4853.223314 6384.012138 0 6389 1155.010152 4051.545574 0 6390 3244.183627 7117.782965 0 6391 3894.497097 8093.968582 0 6392 6337.317405 406.162512 0 6393 4704.662427 5189.254825 0 6394 616.33379 588.655379 0 6395 8027.325194 2624.477825 0 6396 8349.342189 2878.471131 0 6397 9036.028789 7507.458731 0 6398 7772.913285 9124.38881 0 6399 5249.730044 7695.577294 0 6400 221.949138 6490.115504 0 6401 6222.632522 6331.22865 0 6402 308.41021 3961.945455 0 6403 5441.652298 1576.179312 0 6404 2109.41611 8941.906619 0 6405 839.893045 7087.527697 0 6406 2333.396777 3652.676439 0 6407 2925.793804 8409.419571 0 6408 8981.585717 5024.611269 0 6409 342.753788 1792.164175 0 6410 8510.912813 7479.789197 0 6411 6021.66712 5042.602283 0 6412 3598.69034 4998.903995 0 6413 4888.511754 5022.700477 0 6414 650.341039 6646.465909 0 6415 2630.346501 1568.675039 0 6416 1715.152509 2377.220132 0 6417 6192.212704 9959.190244 0 6418 4040.761704 1220.960744 0 6419 3732.325806 6402.436357 0 6420 1735.570903 5912.839735 0 6421 3551.10872 3729.975224 0 6422 7104.38979 9705.561784 0 6423 7901.867961 1894.298571 0 6424 9486.828867 3080.828913 0 6425 8167.15156 1778.146116 0 6426 7836.088474 8871.972104 0 6427 114.196854 2080.323439 0 6428 9168.860396 816.769056 0 6429 4599.273538 9562.96418 0 6430 6442.774591 1063.20907 0 6431 6524.326733 5635.309844 0 6432 4277.002407 7272.719755 0 6433 6552.201669 1948.128609 0 6434 7193.152635 5533.988162 0 6435 2096.325309 6138.081444 0 6436 4537.387301 3773.514839 0 6437 3551.306418 6629.894507 0 6438 7714.856239 3829.550824 0 6439 1884.716193 9863.6557 0 6440 8731.176411 3144.460178 0 6441 1001.173803 6354.058337 0 6442 8376.720269 1741.949623 0 6443 6785.325754 3651.775792 0 6444 372.582794 6735.114573 0 6445 4269.092359 7932.573029 0 6446 2371.153789 1777.144948 0 6447 3466.425781 7578.5609 0 6448 8793.010689 5736.38138 0 6449 6125.861822 1792.447679 0 6450 1615.562532 247.858779 0 6451 2301.348882 7776.400357 0 6452 8644.404601 1980.525809 0 6453 1343.610685 3949.904994 0 6454 8093.015851 5793.602177 0 6455 7821.233461 703.672581 0 6456 2558.714247 243.046593 0 6457 4682.537786 9788.381364 0 6458 4456.014485 948.789502 0 6459 691.807983 8622.917399 0 6460 785.596225 9931.023647 0 6461 1090.008023 2289.736349 0 6462 4537.669468 715.093422 0 6463 7612.252925 7484.371968 0 6464 2784.130943 1572.797532 0 6465 9448.566539 6910.156159 0 6466 3884.14942 52.575273 0 6467 2146.560964 4871.289788 0 6468 5252.660697 2805.08486 0 6469 9373.190604 1968.584217 0 6470 1503.919057 6315.426833 0 6471 3117.653824 9132.575059 0 6472 8513.375255 4651.947287 0 6473 4893.377736 2998.651295 0 6474 5252.296149 3594.684436 0 6475 9830.23425 5323.891529 0 6476 1196.872237 4583.797263 0 6477 4178.182178 5042.724729 0 6478 2911.73773 5226.49402 0 6479 6498.441639 8230.357468 0 6480 3057.4193 6999.37331 0 6481 3393.403478 7953.540329 0 6482 1903.831421 5730.473173 0 6483 2245.494104 9196.364967 0 6484 4194.754506 5622.24085 0 6485 431.126214 6845.726733 0 6486 5242.90383 2213.35682 0 6487 4207.057877 1980.49218 0 6488 3789.776055 5836.166415 0 6489 1257.061351 5048.809339 0 6490 8092.335835 2022.259331 0 6491 8448.856884 4182.90442 0 6492 6705.667487 4363.154151 0 6493 9002.692417 7640.341228 0 6494 7865.566988 8047.949714 0 6495 3183.291077 3261.195944 0 6496 8226.431139 4763.864643 0 6497 3917.613299 2838.462636 0 6498 2460.028751 6618.964037 0 6499 7002.173208 6037.415907 0 6500 1580.627577 6016.132298 0 6501 6112.48034 8921.086085 0 6502 1812.269769 8706.988822 0 6503 3262.641322 5387.285154 0 6504 3841.801689 5889.767258 0 6505 4590.270323 262.322052 0 6506 889.533912 8053.461719 0 6507 6527.139605 2741.998076 0 6508 7333.873502 8667.789216 0 6509 8903.390875 9168.907226 0 6510 5544.935277 5049.31112 0 6511 2964.08836 7230.271191 0 6512 4352.040073 5980.036553 0 6513 6191.344948 4578.424522 0 6514 9233.361774 364.45746 0 6515 1224.340268 6884.008337 0 6516 3621.924544 2760.756432 0 6517 6346.702606 3228.690416 0 6518 4652.033968 1527.056775 0 6519 9708.847552 1999.37744 0 6520 5417.491511 4617.589852 0 6521 7833.343091 2493.625668 0 6522 5376.175703 4311.228475 0 6523 2251.396193 4568.527795 0 6524 2379.169734 3366.212966 0 6525 2764.426382 5268.252643 0 6526 6705.862815 7437.753511 0 6527 7601.139025 1824.172592 0 6528 9968.77483 9253.101394 0 6529 579.822006 3560.63943 0 6530 7529.612834 4063.652902 0 6531 6857.214532 2801.18057 0 6532 8929.833302 8182.998024 0 6533 4704.235997 4378.816075 0 6534 8636.342407 1926.692598 0 6535 5590.373913 5663.818012 0 6536 6416.089135 1604.830371 0 6537 2105.034603 2788.394922 0 6538 4372.535523 5805.436811 0 6539 4726.462099 7596.959441 0 6540 9751.141128 6721.664486 0 6541 5535.716646 4064.950219 0 6542 6156.193329 3943.937425 0 6543 7177.743615 2636.227571 0 6544 3330.183117 6582.0686 0 6545 5798.445335 6406.778205 0 6546 8817.017645 8618.553783 0 6547 8250.668044 3441.306527 0 6548 5548.302571 4142.799219 0 6549 6210.859257 4004.302329 0 6550 7707.37329 7052.029159 0 6551 7093.417141 9273.237743 0 6552 7289.20747 5252.841165 0 6553 3111.418504 653.758457 0 6554 4953.122289 7191.284172 0 6555 9948.383135 176.753215 0 6556 5326.450162 9411.27948 0 6557 1059.343081 4012.253903 0 6558 6024.944129 7007.873765 0 6559 3699.271572 4019.588106 0 6560 5083.714578 427.525566 0 6561 3622.363219 1857.970486 0 6562 6690.086792 6630.877255 0 6563 2698.155624 50.035111 0 6564 7987.138798 322.645785 0 6565 9763.634757 36.390056 0 6566 8726.872833 5279.534181 0 6567 1977.476751 2452.220642 0 6568 9476.498504 1117.428398 0 6569 3675.271228 5288.455937 0 6570 3473.326208 2857.452531 0 6571 3810.850978 4644.786312 0 6572 3179.267848 1276.472963 0 6573 7135.816591 8780.468283 0 6574 9172.448704 6630.323613 0 6575 6264.859864 7186.443231 0 6576 32.778112 3030.54665 0 6577 6352.170006 7886.958529 0 6578 1854.696714 1223.831272 0 6579 6041.928954 5242.068704 0 6580 5378.276916 4806.665428 0 6581 8353.513854 1116.765332 0 6582 2369.168582 5902.860733 0 6583 8260.795728 5730.033148 0 6584 3853.537488 3478.699853 0 6585 3521.970179 2122.574266 0 6586 9366.560618 7758.221754 0 6587 8864.720678 3521.762725 0 6588 4041.155761 2115.283071 0 6589 215.606453 4683.801744 0 6590 6356.929039 9510.557612 0 6591 9746.568341 2459.845044 0 6592 7703.514791 1721.507613 0 6593 1596.847711 5685.325798 0 6594 8766.992674 3372.910761 0 6595 5964.549174 6952.097955 0 6596 3112.784244 459.827144 0 6597 5795.829977 6306.471478 0 6598 5739.983622 7196.884345 0 6599 5115.296373 1486.347349 0 6600 5559.280662 2013.851438 0 6601 6886.656499 6110.301682 0 6602 4104.44492 8790.086535 0 6603 3138.054506 9941.434807 0 6604 5884.897589 9052.034241 0 6605 5474.522104 5987.597572 0 6606 7679.39906 3167.282124 0 6607 9320.899035 9857.223927 0 6608 1742.035059 944.977433 0 6609 9658.568611 2368.767694 0 6610 133.933775 6094.267921 0 6611 7223.635518 7514.994142 0 6612 7826.227679 740.540967 0 6613 4851.167275 3065.163805 0 6614 8631.154648 6496.116301 0 6615 4658.610474 4113.372166 0 6616 3558.253917 3419.241168 0 6617 6256.812068 5255.096371 0 6618 5061.854157 4456.143142 0 6619 447.872064 110.168169 0 6620 9620.962428 7847.884273 0 6621 8421.865448 683.830334 0 6622 2661.974638 2815.469961 0 6623 2803.607769 4914.097636 0 6624 8518.446235 4431.094332 0 6625 8077.443045 5686.745222 0 6626 3535.267302 1577.620983 0 6627 760.837172 5059.242358 0 6628 7608.861906 8651.441061 0 6629 4803.066929 6432.797392 0 6630 2365.020709 694.256643 0 6631 3559.591379 9152.792117 0 6632 8760.90282 5630.668118 0 6633 6511.098572 8735.150373 0 6634 6869.000525 767.157499 0 6635 9532.98441 6066.018636 0 6636 3794.641237 144.607663 0 6637 3247.44576 6976.556625 0 6638 606.032605 7330.154982 0 6639 936.511285 3961.682442 0 6640 5187.039881 433.023226 0 6641 789.959326 8553.784106 0 6642 9621.260062 1597.263 0 6643 8184.258289 6076.306817 0 6644 9300.286057 9717.944265 0 6645 5267.435879 8957.415902 0 6646 1661.084955 6480.114459 0 6647 9303.474054 2124.403588 0 6648 9875.853367 6699.06194 0 6649 1689.152262 3502.30785 0 6650 423.63022 7470.982442 0 6651 4016.014238 8688.058461 0 6652 6894.057272 988.997751 0 6653 3753.912218 5791.375155 0 6654 8242.405394 1079.749246 0 6655 5273.993135 5308.912431 0 6656 6899.840815 802.743312 0 6657 2302.505406 7350.553543 0 6658 7214.116772 5131.909893 0 6659 461.656518 185.377235 0 6660 3789.302604 2154.07877 0 6661 6827.553171 9011.203658 0 6662 6260.151854 6269.147961 0 6663 3231.08638 3041.815809 0 6664 8681.512925 160.3856 0 6665 2297.441705 5148.796223 0 6666 9870.27842 615.770097 0 6667 1074.597637 2782.810653 0 6668 4668.163857 223.621321 0 6669 2554.180677 5911.054785 0 6670 5021.003807 3405.041701 0 6671 6174.433595 1325.730675 0 6672 1506.929151 2795.772501 0 6673 9506.544183 4205.782257 0 6674 3161.006875 7426.622172 0 6675 8424.766762 1527.371016 0 6676 9097.368632 8147.211636 0 6677 3708.817103 1971.541697 0 6678 4934.713944 8372.680766 0 6679 2085.757381 1692.47816 0 6680 7967.951654 6022.492031 0 6681 7284.226906 4940.638734 0 6682 3100.267134 9630.737021 0 6683 2391.867483 6667.752186 0 6684 3198.601993 133.107546 0 6685 5224.235662 7139.661142 0 6686 8227.786539 5138.184361 0 6687 103.586818 3270.226454 0 6688 5785.331504 5878.502276 0 6689 9254.921015 9585.284658 0 6690 7132.015884 1661.020405 0 6691 7419.130031 1246.142506 0 6692 3340.444605 736.320263 0 6693 8121.408837 5153.470193 0 6694 7174.500376 364.751424 0 6695 1761.3034 2043.974313 0 6696 4918.154937 1586.971479 0 6697 1000.96927 5619.837164 0 6698 1085.694274 9607.33846 0 6699 7771.156027 9926.065675 0 6700 7656.879322 2983.045445 0 6701 8119.470746 2010.013805 0 6702 1231.299723 3172.435395 0 6703 7012.603329 1189.53458 0 6704 8905.30105 676.102129 0 6705 7750.571426 6898.578343 0 6706 5137.486353 7630.479035 0 6707 5478.315657 6939.510498 0 6708 1497.380598 2945.598722 0 6709 5420.453798 6325.856269 0 6710 5884.8297 7310.16777 0 6711 6940.986591 3196.501487 0 6712 9442.253071 9499.574995 0 6713 2964.897044 4591.819454 0 6714 3870.269587 832.377236 0 6715 5491.766466 8138.470062 0 6716 2349.051018 5306.544728 0 6717 6009.378574 1123.465381 0 6718 4181.715575 1037.286436 0 6719 3517.99432 6092.542587 0 6720 6563.148087 9929.795802 0 6721 6971.067304 9004.383835 0 6722 7172.713036 8525.251477 0 6723 4530.482428 2110.287719 0 6724 4941.096727 8079.70006 0 6725 4644.216327 351.501732 0 6726 9803.595783 185.564294 0 6727 2802.357728 5112.103013 0 6728 6172.549157 4231.829074 0 6729 9649.234659 9409.070246 0 6730 2958.556807 2224.427641 0 6731 3663.405619 3523.771819 0 6732 4648.132955 2479.221635 0 6733 1719.369473 2926.458275 0 6734 4571.386228 1516.359068 0 6735 6878.580715 7605.830812 0 6736 2768.901948 1524.38557 0 6737 5743.134453 2773.805049 0 6738 3402.647469 4510.364825 0 6739 4507.969077 8345.491011 0 6740 1036.750994 3355.526777 0 6741 82.97865 9855.911212 0 6742 9638.74733 4742.290328 0 6743 531.868833 4005.628446 0 6744 144.872967 536.89838 0 6745 928.478071 2861.751716 0 6746 501.655401 3181.586168 0 6747 8563.162005 9392.608071 0 6748 544.340591 7150.025168 0 6749 2395.329304 3891.84072 0 6750 9245.961991 3604.701572 0 6751 5512.325599 6907.331923 0 6752 7785.917649 5318.595755 0 6753 532.668365 2686.048649 0 6754 6680.29197 3539.894927 0 6755 5263.908287 7062.112361 0 6756 4567.460484 2350.626539 0 6757 7369.923163 4205.935815 0 6758 7396.299227 3998.248492 0 6759 2780.354628 8452.006826 0 6760 8099.425554 4569.756973 0 6761 3717.430952 4504.773286 0 6762 5956.875804 2363.32237 0 6763 6245.249438 4367.858936 0 6764 4565.559653 4013.637249 0 6765 2421.71239 81.600269 0 6766 3139.889555 9583.758502 0 6767 6471.701735 1534.805296 0 6768 6542.422388 4194.804155 0 6769 1887.297784 4433.064945 0 6770 8631.250316 9624.28625 0 6771 4782.703001 7016.360258 0 6772 7557.492968 6535.589364 0 6773 2080.411688 356.527068 0 6774 8356.718731 3009.572083 0 6775 1283.127794 6624.086639 0 6776 5285.517287 5529.838762 0 6777 5107.259181 2167.223094 0 6778 5932.21549 243.480588 0 6779 4790.77934 13.860537 0 6780 5583.40542 2348.042636 0 6781 8166.014172 9011.74856 0 6782 364.034443 6601.414805 0 6783 9162.822547 6824.286398 0 6784 648.76991 6419.616594 0 6785 651.887828 1526.498357 0 6786 6512.246174 6816.117679 0 6787 324.512229 5802.75211 0 6788 8778.191647 6303.221472 0 6789 6434.091023 2187.293155 0 6790 6428.685264 1493.427347 0 6791 8347.970877 2390.736637 0 6792 8180.877512 241.68602 0 6793 5950.570976 3329.676267 0 6794 3018.784711 6095.191731 0 6795 2441.884006 9786.908142 0 6796 1760.427288 5468.19799 0 6797 6783.602294 3089.246207 0 6798 9181.707092 7799.797249 0 6799 2172.103633 4402.289059 0 6800 5598.436678 247.70234 0 6801 7722.519551 7394.423404 0 6802 3049.690066 7902.690479 0 6803 4170.296524 4350.564038 0 6804 8652.239973 3061.243976 0 6805 7806.963925 7289.715382 0 6806 2015.49922 2931.002745 0 6807 1581.764821 6126.477921 0 6808 2514.493922 9225.240309 0 6809 2030.971178 2454.849753 0 6810 7569.013812 6080.594366 0 6811 4299.696947 16.453842 0 6812 7955.544351 3337.49637 0 6813 5332.44895 3191.617278 0 6814 1905.129828 8942.032376 0 6815 4971.901946 7163.770116 0 6816 8255.56963 4026.540769 0 6817 6431.598026 911.378986 0 6818 496.165584 6050.032844 0 6819 9806.628131 9417.274053 0 6820 9612.084553 5829.040326 0 6821 4496.189672 7165.658971 0 6822 6154.616434 8629.904141 0 6823 9100.328627 6681.469557 0 6824 3078.568874 4963.222363 0 6825 7391.390146 7270.069018 0 6826 818.274398 450.859915 0 6827 2108.558644 1966.984254 0 6828 4203.818999 485.168254 0 6829 6908.321978 3044.442769 0 6830 1315.102381 7015.793971 0 6831 7928.291829 6297.398417 0 6832 9453.608549 7704.89239 0 6833 3285.215098 7291.102452 0 6834 3452.580398 9753.712246 0 6835 760.057723 5466.936145 0 6836 6519.262285 6837.647696 0 6837 2453.765779 4351.618077 0 6838 361.808857 99.219894 0 6839 9982.228983 863.476022 0 6840 4219.407656 7055.360271 0 6841 5033.289121 4073.498098 0 6842 8481.546114 8483.833719 0 6843 1818.397584 8781.993637 0 6844 419.314978 1030.021723 0 6845 1016.030253 3396.882004 0 6846 3290.539382 37.123199 0 6847 2118.613891 5416.096863 0 6848 3640.297614 8765.107146 0 6849 2597.034416 1105.610905 0 6850 112.663934 4544.420656 0 6851 7653.051833 2642.185811 0 6852 773.386863 2851.30521 0 6853 1246.510324 9113.543366 0 6854 121.827339 773.597987 0 6855 8467.790167 1689.358653 0 6856 6915.770596 3320.328031 0 6857 4776.283841 9827.118044 0 6858 6638.769049 2505.793734 0 6859 5706.920145 6525.008136 0 6860 8704.490346 360.472871 0 6861 1329.421503 9638.638278 0 6862 3510.939642 7763.395347 0 6863 3115.391373 6419.475427 0 6864 1075.594858 7205.873195 0 6865 8133.078614 1628.436862 0 6866 1495.349695 4930.396273 0 6867 5925.163897 7392.719772 0 6868 2639.650066 2851.192194 0 6869 5973.809395 8349.786621 0 6870 4211.833009 1769.732119 0 6871 7564.977624 5941.591989 0 6872 8115.686208 9290.51736 0 6873 896.365724 7946.082468 0 6874 6238.431199 8144.341684 0 6875 291.230931 8200.037722 0 6876 9452.437307 2357.912578 0 6877 3219.966998 7244.250265 0 6878 155.931065 3358.325527 0 6879 181.532558 5509.172603 0 6880 4107.041847 5566.403197 0 6881 157.571403 5237.580755 0 6882 8299.183535 9004.56214 0 6883 2149.746472 618.217701 0 6884 8091.493352 4741.092602 0 6885 2850.250524 511.674652 0 6886 9365.714561 1125.24841 0 6887 5720.005924 8020.048647 0 6888 9573.864028 394.248155 0 6889 1233.369226 5267.41861 0 6890 9683.066512 4602.966813 0 6891 3112.18633 397.283111 0 6892 3803.794587 3506.313439 0 6893 3806.759587 3789.479544 0 6894 2464.532696 4695.07182 0 6895 5957.243807 2857.828403 0 6896 7409.748578 6848.963924 0 6897 4117.040514 1713.2496 0 6898 1213.136173 6340.058969 0 6899 528.731263 9654.188194 0 6900 6851.223723 6235.536451 0 6901 3038.584152 5874.352146 0 6902 2368.043638 5851.24859 0 6903 3935.596575 9021.667664 0 6904 9640.48512 7662.170551 0 6905 8195.769327 7873.371185 0 6906 9794.793436 1091.3274 0 6907 7899.915042 9067.567042 0 6908 5081.451215 8721.999823 0 6909 8006.35902 280.662907 0 6910 8037.194921 4814.853317 0 6911 6088.901112 3328.22743 0 6912 5953.862943 5908.337855 0 6913 1477.789997 5004.286792 0 6914 1819.838934 6637.290027 0 6915 512.610281 3571.886408 0 6916 5923.402568 9584.727085 0 6917 985.047349 1545.079124 0 6918 3956.089334 3126.770917 0 6919 7109.061518 8258.872771 0 6920 1291.857719 6715.872064 0 6921 7964.644071 9137.021714 0 6922 3430.393938 2692.611332 0 6923 7465.169533 3985.141639 0 6924 5653.055276 6967.269463 0 6925 3041.375636 7495.53155 0 6926 9335.370299 7343.302478 0 6927 3249.098871 4731.058718 0 6928 9374.050812 5700.425668 0 6929 1102.165563 5023.304895 0 6930 3612.16815 9066.242148 0 6931 5513.921053 1865.518486 0 6932 367.610781 9282.421184 0 6933 1551.985194 6556.922099 0 6934 4093.451338 3647.740817 0 6935 7190.666651 4303.14818 0 6936 1858.746258 2873.967186 0 6937 3900.629541 5824.920826 0 6938 8180.593515 4528.700321 0 6939 9444.825439 3363.909481 0 6940 3817.232137 7996.690999 0 6941 3690.438047 9991.963573 0 6942 5657.504839 6482.161493 0 6943 5347.066257 3382.629868 0 6944 6888.257841 3487.305736 0 6945 877.876065 1389.76951 0 6946 3521.090083 6441.666759 0 6947 2771.804028 3410.285104 0 6948 1343.06687 6976.537346 0 6949 406.892259 9968.269834 0 6950 2789.145577 8616.583633 0 6951 6935.033156 6143.208756 0 6952 5202.369255 5445.942156 0 6953 8207.932237 1599.528749 0 6954 2488.296825 937.234078 0 6955 6768.04426 1916.318129 0 6956 7443.973511 8191.381207 0 6957 3761.914674 7397.912061 0 6958 295.605962 8381.058144 0 6959 9086.14365 390.033884 0 6960 4531.284686 5303.17385 0 6961 3958.266006 810.980513 0 6962 6513.393513 7229.851983 0 6963 9361.009838 1517.16957 0 6964 9175.450975 8186.451132 0 6965 636.227033 5905.662341 0 6966 9832.024805 6598.544483 0 6967 97.463194 7884.744694 0 6968 2269.019505 6422.110814 0 6969 2680.104426 9521.356588 0 6970 4145.215502 1689.4844 0 6971 2793.059445 8275.298049 0 6972 2533.382864 9644.546586 0 6973 5898.230114 7166.985161 0 6974 978.985124 9048.587608 0 6975 8818.038075 9680.318974 0 6976 9599.224454 7661.481712 0 6977 3439.456943 5045.01448 0 6978 9720.20093 377.740234 0 6979 7719.910781 5997.315301 0 6980 6619.199284 8346.783722 0 6981 2304.985248 9146.178228 0 6982 4984.591316 134.7582 0 6983 8068.107306 2311.478329 0 6984 8353.195108 2141.22522 0 6985 1341.343548 5612.657872 0 6986 244.05361 1927.547301 0 6987 7804.005713 5794.00577 0 6988 9392.769769 8758.079844 0 6989 3158.419844 9886.160968 0 6990 2953.656536 8628.25021 0 6991 7103.619335 71.525935 0 6992 7010.568799 4317.674299 0 6993 637.121049 9248.34677 0 6994 5760.886752 8811.969386 0 6995 8799.313594 8727.493425 0 6996 8429.116948 443.138141 0 6997 2443.39711 2743.870831 0 6998 4866.955726 2414.602121 0 6999 7956.626115 1845.991769 0 7000 4321.892297 6608.159273 0 7001 4702.842809 8611.799636 0 7002 5784.59333 2906.923612 0 7003 549.062654 6790.89086 0 7004 2848.646104 5754.541442 0 7005 5814.429714 3188.00177 0 7006 2703.19264 1230.402098 0 7007 8293.686506 2916.207245 0 7008 9848.695618 8741.268834 0 7009 517.593586 2421.759842 0 7010 6163.319499 3754.76336 0 7011 7762.643232 7413.804862 0 7012 9701.960028 3623.694573 0 7013 6943.254266 217.492578 0 7014 720.620878 7849.336741 0 7015 561.245344 3759.160857 0 7016 7749.408113 655.369959 0 7017 8330.132298 3389.489105 0 7018 7612.995172 9911.522195 0 7019 6771.788377 4026.922644 0 7020 8965.061855 2809.982719 0 7021 2249.348388 4717.827051 0 7022 3369.924203 9036.673746 0 7023 3724.76659 9375.490823 0 7024 5744.19363 610.601833 0 7025 4163.651236 994.912305 0 7026 6252.3505 5223.588436 0 7027 5671.476713 6011.795763 0 7028 1563.377041 4390.635728 0 7029 5192.097626 745.390093 0 7030 8894.891037 3440.419284 0 7031 9075.224866 9995.194928 0 7032 5333.535044 6703.506744 0 7033 3280.409094 4768.338749 0 7034 7668.899335 9368.964474 0 7035 6515.5945 3606.949656 0 7036 6421.888542 5247.822804 0 7037 4391.083801 5340.72615 0 7038 6837.031821 1513.682575 0 7039 3972.952361 5041.023128 0 7040 2271.234168 5301.611826 0 7041 5199.356695 5675.180961 0 7042 6187.821154 3140.407734 0 7043 7394.592226 2127.945346 0 7044 4892.852761 8873.148525 0 7045 2592.349888 2900.193197 0 7046 9673.232817 8510.727701 0 7047 585.99897 3349.507904 0 7048 5216.969443 2420.653337 0 7049 6831.384401 3809.597173 0 7050 6601.666453 5699.962407 0 7051 537.759215 9119.539485 0 7052 3509.274865 25.421707 0 7053 9163.239713 9213.199749 0 7054 312.839928 9518.721563 0 7055 2445.173467 282.919541 0 7056 2054.961109 1173.714328 0 7057 3191.914584 5931.748696 0 7058 9409.062944 3890.547095 0 7059 217.114438 7156.205046 0 7060 4074.040155 3151.680661 0 7061 9506.449274 8674.023139 0 7062 2074.186178 2137.852935 0 7063 1230.861679 8118.23052 0 7064 6106.536896 6733.224733 0 7065 7758.517083 2969.692635 0 7066 4718.963866 649.159735 0 7067 3226.605195 2437.377316 0 7068 3684.669048 2196.090745 0 7069 2403.35033 263.545797 0 7070 1771.739224 6161.725487 0 7071 1458.71874 1774.840413 0 7072 8832.516856 1599.799571 0 7073 8886.50587 5256.04086 0 7074 3541.532394 6883.618213 0 7075 6129.477818 9865.839488 0 7076 3634.08549 9581.142483 0 7077 5629.148508 8121.651943 0 7078 5206.209813 2103.607857 0 7079 3377.145334 1918.76509 0 7080 9425.833069 4218.342369 0 7081 7232.630205 79.544871 0 7082 9438.037769 4155.232771 0 7083 613.261517 2090.248438 0 7084 336.734969 4441.958977 0 7085 610.580438 5824.967736 0 7086 3547.898708 438.810031 0 7087 5817.054743 7448.696413 0 7088 5065.285184 2668.715642 0 7089 4792.687651 9681.458125 0 7090 2411.732733 9286.041309 0 7091 3552.971836 288.271941 0 7092 6751.321441 36.541176 0 7093 7551.130152 2055.935648 0 7094 204.929605 1855.187022 0 7095 3046.781589 1601.202263 0 7096 1854.637892 5998.100896 0 7097 9896.037436 3995.391992 0 7098 9291.08887 1733.482058 0 7099 4510.585409 7682.40081 0 7100 3171.035378 9892.783003 0 7101 7245.896573 2430.241485 0 7102 3850.025928 9627.940559 0 7103 7079.048365 3728.833829 0 7104 8387.670267 1137.975881 0 7105 6433.172042 3023.828267 0 7106 8082.350334 5552.306991 0 7107 6479.818511 8611.413113 0 7108 4632.642907 3328.685056 0 7109 6725.692325 8672.258838 0 7110 2618.41486 2130.143815 0 7111 8002.731653 4901.618571 0 7112 4672.976785 9978.690099 0 7113 5030.51801 2078.127351 0 7114 3249.715532 4978.149199 0 7115 5793.864408 4981.045077 0 7116 7528.177788 9240.39328 0 7117 218.363333 2235.871737 0 7118 8325.008034 6436.646798 0 7119 4006.679199 1133.921228 0 7120 8232.232942 3281.46236 0 7121 964.718622 726.471066 0 7122 102.250679 4257.560283 0 7123 5505.903006 1197.58949 0 7124 3668.455149 8034.398921 0 7125 67.843353 140.064875 0 7126 2065.592491 8675.940928 0 7127 6180.480205 6178.931359 0 7128 7955.075635 9549.189616 0 7129 9853.637473 2081.469313 0 7130 8156.392011 5459.436724 0 7131 499.053192 1773.926903 0 7132 2760.742831 343.876537 0 7133 177.065318 7661.300802 0 7134 8534.700562 9432.956992 0 7135 7986.870508 4963.581626 0 7136 5210.879728 2895.75725 0 7137 489.847714 9983.597813 0 7138 9190.23967 7595.277994 0 7139 2703.274224 3619.965591 0 7140 7316.268161 9494.250358 0 7141 4538.652444 8494.407599 0 7142 4884.121272 6944.214112 0 7143 9039.682274 7421.384938 0 7144 6840.512617 7656.862726 0 7145 8514.54176 809.51736 0 7146 5800.775555 5023.702026 0 7147 6550.208372 1761.955094 0 7148 3236.745821 5964.010515 0 7149 7697.909079 2380.541919 0 7150 849.498013 3996.979529 0 7151 5244.791161 4349.990296 0 7152 2848.259387 121.937247 0 7153 6883.087898 7127.234864 0 7154 466.227313 6887.016934 0 7155 2389.658746 1036.601079 0 7156 7981.534091 7472.230801 0 7157 5446.495318 4753.403654 0 7158 3892.473607 1446.471304 0 7159 2983.250304 851.37835 0 7160 842.301213 1226.850427 0 7161 1833.456677 990.337249 0 7162 9248.55064 5620.525426 0 7163 3451.031451 9952.26931 0 7164 5090.258752 2335.132028 0 7165 5305.250036 7992.826739 0 7166 8780.792871 8184.364471 0 7167 3425.987415 1559.55808 0 7168 7150.185705 7358.571195 0 7169 5960.848258 6674.599936 0 7170 6254.705072 4996.398513 0 7171 1590.569755 9772.80799 0 7172 3207.489016 2063.471568 0 7173 6742.366713 712.724301 0 7174 826.015357 3333.259207 0 7175 9538.1892 3876.790547 0 7176 2395.309415 2496.909004 0 7177 4362.4629 571.993939 0 7178 6154.080136 43.231593 0 7179 909.468606 5813.186926 0 7180 9966.506989 4244.20969 0 7181 4524.128527 9520.227921 0 7182 6739.522784 9500.407211 0 7183 1532.937946 4369.491921 0 7184 5658.17072 2777.916277 0 7185 1090.56254 7786.218188 0 7186 4794.236693 6320.867055 0 7187 1019.920923 275.077947 0 7188 9034.126209 9613.523047 0 7189 8993.796869 8008.592669 0 7190 3917.510021 7039.193406 0 7191 6902.677788 2227.738285 0 7192 5939.470201 3967.632301 0 7193 6803.382883 8945.964324 0 7194 1288.689856 6107.166874 0 7195 5298.550781 1871.664652 0 7196 5586.667895 630.473866 0 7197 7736.590918 1676.14356 0 7198 3894.133178 8329.871706 0 7199 3046.985583 6841.495851 0 7200 1262.051857 3985.947228 0 7201 5597.985955 8177.909498 0 7202 3756.933322 1062.366298 0 7203 8221.521588 292.429185 0 7204 5642.082643 5557.800142 0 7205 3387.507428 4336.686556 0 7206 6003.416744 7526.288196 0 7207 5078.761344 2017.125996 0 7208 67.086143 297.311224 0 7209 6139.66668 9877.377156 0 7210 4246.272119 6146.374075 0 7211 5755.260157 2015.452605 0 7212 266.724073 1337.493112 0 7213 1194.587601 2424.227253 0 7214 8706.544064 5297.088243 0 7215 7026.203634 668.697955 0 7216 9490.484521 286.831417 0 7217 8912.20791 215.387524 0 7218 5401.227308 5347.376878 0 7219 95.200434 2920.219201 0 7220 8605.616731 2863.927977 0 7221 2453.899394 5189.08816 0 7222 2086.054163 9069.426815 0 7223 2233.128862 8405.416558 0 7224 3046.821452 6183.824583 0 7225 1208.521467 3875.094578 0 7226 6420.822564 1034.000989 0 7227 7207.588969 2069.845153 0 7228 6191.927206 1884.61112 0 7229 8829.507327 7352.486712 0 7230 2812.319866 7879.182341 0 7231 9019.427697 7410.676976 0 7232 6099.193953 8177.654394 0 7233 5890.680599 9981.806135 0 7234 4469.216527 292.79122 0 7235 8234.70404 4670.549092 0 7236 9097.258521 1557.805143 0 7237 9433.913839 3719.003466 0 7238 7450.466822 4638.292281 0 7239 408.772857 8973.290584 0 7240 7168.182627 6156.139991 0 7241 5323.450653 9825.747515 0 7242 2755.107074 3133.160979 0 7243 8443.721511 6776.690895 0 7244 7749.128144 4935.761304 0 7245 1086.441923 2166.551102 0 7246 3061.868595 3101.395132 0 7247 1903.373892 4485.582747 0 7248 363.328534 3483.810194 0 7249 8879.18519 3868.700147 0 7250 9895.527715 9987.835526 0 7251 8475.70532 255.844276 0 7252 5992.870852 7127.257582 0 7253 1595.921151 5014.477648 0 7254 671.908594 5362.472943 0 7255 895.503591 8499.353058 0 7256 855.084082 9684.745743 0 7257 1311.511867 5315.070906 0 7258 593.057792 2656.952644 0 7259 8406.376844 1580.653557 0 7260 2352.256078 9251.674152 0 7261 8178.457378 2476.451977 0 7262 1366.420145 9174.618991 0 7263 3475.995886 3308.650736 0 7264 7368.257436 4847.193803 0 7265 7848.79192 2356.956134 0 7266 8988.192205 5099.276416 0 7267 1702.427455 2077.031509 0 7268 118.366109 6679.071303 0 7269 8321.51765 603.854377 0 7270 8860.187266 7763.994357 0 7271 7443.624024 1908.873514 0 7272 7307.816163 3687.438218 0 7273 3104.611962 8921.076263 0 7274 8335.474986 124.087392 0 7275 9032.074214 5127.914379 0 7276 2306.584244 3999.944914 0 7277 7867.617446 8876.115133 0 7278 30.911486 5809.257969 0 7279 8750.963849 1700.43816 0 7280 5401.07273 1660.665893 0 7281 8620.124469 7339.128151 0 7282 747.570129 9561.038955 0 7283 6524.556916 8052.159803 0 7284 8243.519106 3790.899962 0 7285 1565.940758 8807.95408 0 7286 2236.18185 8955.067172 0 7287 1533.867348 9181.625589 0 7288 3712.703045 4734.02471 0 7289 7422.683192 542.287111 0 7290 406.116952 5586.579955 0 7291 710.719334 6659.172478 0 7292 208.321903 1099.918141 0 7293 4325.368806 7216.431254 0 7294 5938.526741 4210.320043 0 7295 8298.333742 7074.796756 0 7296 1674.128729 871.459448 0 7297 693.734782 4579.055448 0 7298 8986.726407 8502.942904 0 7299 3957.638559 3731.855572 0 7300 477.772906 2505.525141 0 7301 8890.581366 2328.39795 0 7302 7964.057324 5148.225952 0 7303 5676.378161 9713.167549 0 7304 536.303619 234.349968 0 7305 4320.652067 9398.735198 0 7306 9990.225392 3926.050781 0 7307 7981.061186 3259.35898 0 7308 2739.924767 9816.530135 0 7309 2916.738113 5171.168313 0 7310 2944.64786 8095.428512 0 7311 4998.014939 2658.065119 0 7312 1161.121445 7502.135465 0 7313 2238.465446 336.577975 0 7314 8276.386015 3137.635965 0 7315 3907.915823 3049.639525 0 7316 4488.359934 2364.729049 0 7317 9807.086928 1924.702761 0 7318 8086.842264 7.804451 0 7319 4253.696812 4863.054972 0 7320 5206.900412 3794.219544 0 7321 3792.324279 209.391095 0 7322 8533.215204 9704.534108 0 7323 8274.955713 455.126411 0 7324 9157.819069 4212.268666 0 7325 2137.624158 9776.893418 0 7326 6975.302029 3572.44151 0 7327 5637.033247 2704.073549 0 7328 2311.637193 1735.613898 0 7329 3062.006142 3497.700078 0 7330 315.107517 5081.812974 0 7331 121.669961 4594.820601 0 7332 1317.257506 1268.909976 0 7333 9059.634396 4146.983594 0 7334 9824.275566 6304.268719 0 7335 1742.647709 1294.468889 0 7336 4201.30997 9434.068273 0 7337 7647.538861 2079.798557 0 7338 1582.396699 1194.884483 0 7339 1651.647271 4188.884462 0 7340 3168.855737 7271.591604 0 7341 7733.09905 4812.346378 0 7342 2233.382024 7689.379156 0 7343 3256.081078 1622.799441 0 7344 3851.196706 8193.582257 0 7345 3304.681806 5953.038983 0 7346 2136.03339 9067.39227 0 7347 5761.170129 537.979184 0 7348 8275.516456 3859.994529 0 7349 9323.369818 7603.699786 0 7350 7882.05243 3269.446459 0 7351 6479.692542 3801.573579 0 7352 5038.545718 8466.139213 0 7353 33.320441 1452.550895 0 7354 757.129638 4333.568516 0 7355 6638.334286 7630.938531 0 7356 5325.054512 1273.534349 0 7357 1969.815295 7079.343457 0 7358 9808.397132 4541.450693 0 7359 4844.960297 2699.684175 0 7360 8715.262394 3340.79728 0 7361 6281.541083 893.650111 0 7362 8691.754544 1722.03268 0 7363 3837.443029 1830.055567 0 7364 9076.149099 1603.473267 0 7365 2659.884133 3673.556375 0 7366 7061.9267 7767.565456 0 7367 8701.34608 2164.747513 0 7368 600.696375 3530.219149 0 7369 2845.721228 7118.384105 0 7370 981.871519 5711.268418 0 7371 2148.379995 2760.011039 0 7372 4697.059644 9009.70514 0 7373 5161.522523 411.559559 0 7374 2508.932809 1055.810354 0 7375 9622.571327 3443.381584 0 7376 8502.491152 6462.09362 0 7377 9037.195016 3893.872634 0 7378 8749.766271 2246.17119 0 7379 6230.66017 9806.128575 0 7380 242.266226 959.004321 0 7381 3676.619573 2262.451068 0 7382 9257.759354 5586.564589 0 7383 2010.51126 1412.284319 0 7384 771.019655 6489.856135 0 7385 8608.690218 409.020141 0 7386 7780.091294 4178.757521 0 7387 329.35004 1840.388327 0 7388 7945.018493 7281.00292 0 7389 4013.852346 6887.938056 0 7390 7491.796812 3240.667239 0 7391 4993.137783 9496.074116 0 7392 8513.268439 7231.476124 0 7393 6002.974326 4700.597517 0 7394 7687.274041 1932.487445 0 7395 2922.398278 6935.362162 0 7396 242.342671 589.783482 0 7397 7853.285351 2356.216754 0 7398 7139.22255 6713.806357 0 7399 46.159159 8602.07523 0 7400 7626.929276 51.506906 0 7401 217.173926 8616.618931 0 7402 8979.004235 4531.034668 0 7403 1537.917649 1722.082288 0 7404 4340.831973 6877.851694 0 7405 5577.381165 7508.658904 0 7406 639.824516 7646.7622 0 7407 2733.051981 8084.731158 0 7408 8217.601972 2792.759209 0 7409 8257.064089 77.341466 0 7410 9573.35633 7858.227465 0 7411 5144.454693 8297.515129 0 7412 7755.050167 3956.0656 0 7413 5351.257839 6282.299272 0 7414 1331.031068 8513.850188 0 7415 579.243602 534.340622 0 7416 9270.747318 9877.843961 0 7417 6211.2138 2789.212952 0 7418 52.556902 9996.179073 0 7419 1796.918866 6390.710251 0 7420 5172.13447 1360.260729 0 7421 9559.943733 2900.16405 0 7422 5220.914355 7466.911697 0 7423 9383.169535 7907.80657 0 7424 4791.987075 5452.275713 0 7425 4569.616682 4787.648787 0 7426 2644.61457 3487.842149 0 7427 2591.049154 3567.284521 0 7428 8164.444304 3119.008952 0 7429 2776.301329 2367.22838 0 7430 9664.004084 705.27779 0 7431 5133.722395 1225.839047 0 7432 4776.788282 2151.836562 0 7433 2740.02718 6023.017566 0 7434 3870.289323 868.681675 0 7435 3478.0091 9424.12246 0 7436 4752.85808 8356.948976 0 7437 2738.767381 9977.405384 0 7438 9715.086801 9815.344877 0 7439 9681.864897 5129.776634 0 7440 1827.693821 9875.367383 0 7441 585.733519 8244.868787 0 7442 7600.828704 592.200227 0 7443 8055.576233 9890.76481 0 7444 9747.05201 7203.727888 0 7445 4659.538289 6478.607616 0 7446 9989.26315 9551.132737 0 7447 9435.245095 6966.250571 0 7448 6896.339641 1845.371891 0 7449 7810.931149 2826.229205 0 7450 1233.430539 1388.554744 0 7451 3033.225666 8450.317188 0 7452 872.343938 3931.094739 0 7453 879.922469 1727.004238 0 7454 4936.274967 5889.540378 0 7455 519.334716 3577.544489 0 7456 7763.079441 5271.730347 0 7457 3605.373563 5337.242077 0 7458 6595.149879 9182.989934 0 7459 1280.733072 5580.882242 0 7460 6253.804805 6931.28605 0 7461 5036.289962 2573.18152 0 7462 1688.992323 9603.529046 0 7463 7189.7622 2636.661668 0 7464 4588.315851 4780.30186 0 7465 9867.037128 829.035888 0 7466 9061.515148 2096.206673 0 7467 7560.250163 7047.491014 0 7468 7533.647906 1127.146614 0 7469 162.975681 8227.380638 0 7470 7002.702898 5827.026873 0 7471 8102.037363 9419.184392 0 7472 5497.929973 9794.154947 0 7473 9489.949484 9728.394603 0 7474 5781.436099 510.322647 0 7475 1487.522235 6302.705153 0 7476 1758.527443 4074.610497 0 7477 9395.059195 8575.790196 0 7478 1118.625204 7699.067565 0 7479 9049.167132 8158.511547 0 7480 9469.202586 9457.244269 0 7481 7310.252637 3002.294189 0 7482 3997.151796 4371.809721 0 7483 7056.427643 849.365503 0 7484 2614.506008 9328.695042 0 7485 9386.719097 2952.829233 0 7486 1938.571779 5373.043791 0 7487 2235.222699 2287.998639 0 7488 3523.017563 8288.423524 0 7489 465.464696 592.695573 0 7490 5595.396639 6551.390409 0 7491 7578.447323 9529.627409 0 7492 5894.663114 6839.301149 0 7493 3379.737583 3523.628997 0 7494 195.864521 9748.212906 0 7495 5089.754425 960.024856 0 7496 1059.783339 1409.31108 0 7497 5885.177645 7219.347507 0 7498 1482.635627 3754.739682 0 7499 6354.148568 2354.925732 0 7500 5991.481833 3331.078386 0 7501 6407.433768 5796.027071 0 7502 5477.157392 1207.575452 0 7503 8621.126848 3503.221956 0 7504 1600.304874 7581.790996 0 7505 8460.765014 2185.909996 0 7506 4515.0213 5833.470585 0 7507 3422.673815 3957.38075 0 7508 6542.544822 9349.288261 0 7509 6254.605074 8785.313247 0 7510 221.829421 5391.722323 0 7511 5159.470699 8702.528933 0 7512 4462.186844 7520.720061 0 7513 7396.147073 4784.121705 0 7514 3706.285512 1359.657367 0 7515 4043.762842 5067.019749 0 7516 8752.458599 7384.387757 0 7517 2873.381705 648.76175 0 7518 1856.235927 7571.136648 0 7519 1629.070258 8190.908629 0 7520 7780.16592 1779.777387 0 7521 3305.434769 4551.820701 0 7522 5111.25677 7657.181091 0 7523 894.069311 1182.103805 0 7524 1058.441851 7054.918984 0 7525 4037.316508 1091.65452 0 7526 8089.332141 1212.319471 0 7527 8240.380865 8180.932277 0 7528 2090.570767 6066.294116 0 7529 3634.363214 3229.088425 0 7530 7927.289325 2970.4797 0 7531 2774.40456 5700.779001 0 7532 3696.876215 5719.088512 0 7533 7417.250786 6823.509756 0 7534 9295.180585 505.522558 0 7535 5053.867212 9512.166078 0 7536 9083.585195 5154.501101 0 7537 1857.775125 3303.030831 0 7538 5502.641929 7362.353973 0 7539 3173.545927 8240.931851 0 7540 8286.893822 9715.097994 0 7541 6316.03005 5419.181789 0 7542 9580.809689 8881.882918 0 7543 1583.589312 3970.160922 0 7544 9755.507744 947.14486 0 7545 2564.828343 5335.747196 0 7546 6897.856838 5219.84432 0 7547 3396.140934 8966.841041 0 7548 1926.188406 2498.8786 0 7549 502.201082 9222.028057 0 7550 7774.448997 2580.859473 0 7551 3355.921338 5592.885293 0 7552 2471.773243 8274.982562 0 7553 6732.501217 1847.812675 0 7554 3270.510895 1649.10358 0 7555 2492.798955 829.93837 0 7556 9100.070533 4338.943936 0 7557 8298.595469 8133.328247 0 7558 1355.926466 8397.827658 0 7559 585.199124 9372.737771 0 7560 7559.860235 9598.263335 0 7561 6863.425934 2263.026655 0 7562 1870.814318 7989.797198 0 7563 7707.20414 5535.567952 0 7564 1263.555561 2164.743733 0 7565 4616.453837 2117.17617 0 7566 8404.853378 8714.286962 0 7567 3237.576553 6757.371566 0 7568 2104.300922 6677.882818 0 7569 7529.733191 1647.659433 0 7570 2437.111056 712.463206 0 7571 9394.739402 9666.947299 0 7572 4486.119997 6772.349496 0 7573 7024.982183 969.99221 0 7574 9507.179791 2376.397482 0 7575 657.254598 2741.752386 0 7576 9391.905114 9772.602755 0 7577 4711.854113 3380.452895 0 7578 6967.193555 7389.533727 0 7579 2425.263362 9200.590855 0 7580 3998.546181 1723.373355 0 7581 2235.001583 8429.191693 0 7582 9054.89409 6268.313081 0 7583 1692.640598 2019.749998 0 7584 8293.022069 7349.595545 0 7585 9423.4609 5021.206014 0 7586 1766.784809 1476.255172 0 7587 4417.072401 5480.949556 0 7588 9899.684019 6245.919304 0 7589 9710.162936 9456.549899 0 7590 3653.323654 3473.476093 0 7591 5177.11444 6410.818438 0 7592 2593.144341 4154.025705 0 7593 8637.421827 2830.571668 0 7594 9965.360521 811.844622 0 7595 2874.295906 8314.037739 0 7596 8945.921211 1031.054538 0 7597 8960.826306 6148.69438 0 7598 9283.712456 9292.811727 0 7599 6831.114889 9409.387109 0 7600 293.211822 519.181599 0 7601 545.934535 8867.599419 0 7602 5516.246353 1318.018386 0 7603 2085.795463 559.120732 0 7604 4201.439922 2048.534174 0 7605 5507.045524 2987.682315 0 7606 7797.419062 5734.391415 0 7607 5400.775384 5405.85303 0 7608 4687.158885 2210.017112 0 7609 503.731197 4178.002401 0 7610 1196.435141 106.867183 0 7611 1905.457972 9682.037558 0 7612 1603.745843 5027.484866 0 7613 6693.924639 2161.439764 0 7614 2230.968264 7302.394971 0 7615 3115.650152 9915.077153 0 7616 6050.250601 358.647069 0 7617 472.617909 6216.288537 0 7618 4203.798396 920.391827 0 7619 9012.651674 9665.691925 0 7620 9237.381335 7891.87013 0 7621 2573.278922 178.273008 0 7622 4285.365281 550.148301 0 7623 6033.135048 4729.988824 0 7624 8860.244937 9807.374874 0 7625 1268.522924 4298.356922 0 7626 908.405493 6740.534221 0 7627 5507.322024 9711.533884 0 7628 1513.207303 8615.37473 0 7629 4833.411729 3633.313618 0 7630 7763.538137 4440.6462 0 7631 6071.87806 9631.593633 0 7632 9664.820784 4636.318969 0 7633 1960.349728 3879.045163 0 7634 5791.733912 2330.606295 0 7635 395.12458 1096.376863 0 7636 2748.952362 9322.073466 0 7637 9946.153474 9834.237164 0 7638 6320.805924 4804.732814 0 7639 8084.332776 6060.185195 0 7640 5609.211906 3004.77698 0 7641 9536.502391 9861.979405 0 7642 9953.272782 7823.006174 0 7643 9895.015829 5425.910446 0 7644 4001.464701 7429.033096 0 7645 397.973503 4091.194781 0 7646 7310.17459 5270.132479 0 7647 299.438054 5057.488661 0 7648 8747.380102 1228.67742 0 7649 2271.23294 3621.151722 0 7650 6001.540998 7720.672235 0 7651 5968.247683 956.332671 0 7652 46.921088 7107.951839 0 7653 1614.517013 3918.826224 0 7654 5167.355209 1701.049866 0 7655 6995.920374 5597.805953 0 7656 4668.156274 784.886549 0 7657 4802.737596 4893.98899 0 7658 8757.865222 10.879747 0 7659 7380.631554 2532.223396 0 7660 1286.861571 1378.534058 0 7661 1747.482621 757.565236 0 7662 4684.078765 2881.612388 0 7663 3112.589047 6286.213988 0 7664 7266.190172 5675.610481 0 7665 2027.393657 988.652896 0 7666 8208.077039 9932.891159 0 7667 2373.980449 5937.380126 0 7668 657.96977 853.163104 0 7669 1047.72087 7442.000175 0 7670 7368.542383 3829.979205 0 7671 9874.290099 1617.735407 0 7672 7703.477178 3948.684951 0 7673 7426.076122 158.036948 0 7674 2179.780766 5514.897804 0 7675 320.650848 3199.315106 0 7676 2090.757783 1155.647275 0 7677 8141.728696 1968.086546 0 7678 9541.245639 8705.194463 0 7679 1112.026255 8927.912495 0 7680 749.462697 1767.416038 0 7681 2021.285995 2020.233838 0 7682 8936.328941 1099.510202 0 7683 877.924601 3011.153146 0 7684 6944.137748 9262.26639 0 7685 6767.928618 7781.444316 0 7686 3534.387018 6455.37993 0 7687 3490.75879 7106.475497 0 7688 3896.233888 651.040437 0 7689 8234.292655 3843.221743 0 7690 1747.006136 9852.893538 0 7691 983.539281 3221.388917 0 7692 1217.083437 6586.382819 0 7693 1974.416128 6654.749411 0 7694 2855.123633 2969.567263 0 7695 2222.292414 934.172966 0 7696 6098.590382 7013.357045 0 7697 169.960477 6339.893303 0 7698 3515.5599 9006.73558 0 7699 61.345858 4218.268186 0 7700 5938.503509 6276.168998 0 7701 9817.288532 3440.461802 0 7702 4686.418592 4384.647538 0 7703 7879.781721 2447.402801 0 7704 689.448951 851.647364 0 7705 7197.206386 9014.13299 0 7706 8754.542471 8355.71117 0 7707 3251.925128 6489.894298 0 7708 3213.278927 2424.987109 0 7709 4645.91112 2703.076786 0 7710 5573.739059 3135.717961 0 7711 6537.014543 6041.123796 0 7712 5519.628539 2729.036412 0 7713 7997.42507 3133.467461 0 7714 6191.29627 8736.359259 0 7715 8478.715863 2019.754773 0 7716 50.945569 3283.085093 0 7717 7253.845898 513.164576 0 7718 42.138803 3224.466938 0 7719 4886.597038 6429.331607 0 7720 9832.198112 720.586826 0 7721 5602.824816 2686.484654 0 7722 1378.776695 2039.78035 0 7723 1589.927978 7837.107465 0 7724 9211.921282 2663.468977 0 7725 1265.127691 4095.159697 0 7726 907.506083 380.589756 0 7727 8416.050683 5081.879309 0 7728 4407.700765 4046.978489 0 7729 6911.261344 5721.279024 0 7730 5064.117193 2204.023772 0 7731 5045.28931 7047.494781 0 7732 3339.093414 142.317517 0 7733 9693.79253 6713.736641 0 7734 9294.454604 1647.729891 0 7735 8845.989305 2694.341878 0 7736 7526.721335 8938.71731 0 7737 8929.293139 8177.054579 0 7738 817.810766 9505.192904 0 7739 5620.224407 2730.774062 0 7740 4785.238985 8710.814786 0 7741 7476.035822 5645.370528 0 7742 7833.386912 9257.785593 0 7743 4287.219657 598.939798 0 7744 7930.110898 2304.462461 0 7745 6759.839686 8614.962415 0 7746 9006.515614 477.078249 0 7747 7433.655787 6957.81226 0 7748 3668.302158 6043.682416 0 7749 1690.720981 2009.073852 0 7750 8815.2341 2587.046136 0 7751 7359.4782 6868.775219 0 7752 7230.260403 2798.602371 0 7753 5402.219919 580.992457 0 7754 5957.448041 1140.915182 0 7755 9511.132756 7139.528153 0 7756 1954.708595 4999.232556 0 7757 4552.004417 662.962552 0 7758 6033.653958 1985.795624 0 7759 3435.641873 849.756267 0 7760 1366.812533 6559.254682 0 7761 4575.099898 139.600622 0 7762 6860.537084 7383.78494 0 7763 2149.230427 7533.387628 0 7764 5022.779101 2172.675106 0 7765 1046.405319 7201.446404 0 7766 1822.048953 7017.500119 0 7767 8687.615278 6091.434158 0 7768 8759.504227 3383.152536 0 7769 8512.355293 6110.708622 0 7770 9891.05937 4646.488508 0 7771 6253.770632 4207.231011 0 7772 7024.775603 1944.990911 0 7773 1090.051205 8504.268045 0 7774 224.031061 3483.525397 0 7775 9188.895968 5706.077574 0 7776 1649.509524 4463.357331 0 7777 8843.968634 4522.93321 0 7778 6163.521882 4089.851553 0 7779 8141.369453 6920.930177 0 7780 2781.670005 2965.361213 0 7781 5759.665276 3293.40673 0 7782 5736.417307 7624.031296 0 7783 9765.33018 8721.79564 0 7784 5086.893941 3464.701085 0 7785 1900.059421 4307.042499 0 7786 3527.658942 2797.099266 0 7787 6917.956403 8240.387803 0 7788 8752.090386 9752.672934 0 7789 8979.715849 2047.567974 0 7790 4493.267822 9800.957851 0 7791 5298.159353 5843.965953 0 7792 2064.108774 5747.057727 0 7793 3160.27693 572.404596 0 7794 3086.615402 9555.986836 0 7795 8609.609522 6668.415235 0 7796 5000.081476 7652.246278 0 7797 3593.346906 2567.000973 0 7798 4668.568685 4798.319646 0 7799 4305.135051 3137.113144 0 7800 7101.121686 8049.836735 0 7801 9309.728093 1772.909352 0 7802 1365.910267 2602.647156 0 7803 1837.527972 786.509778 0 7804 2629.551296 9619.002075 0 7805 9574.822232 3737.633224 0 7806 2393.088422 2313.626115 0 7807 835.432244 9489.628943 0 7808 419.512896 8022.68132 0 7809 3476.912562 3425.816908 0 7810 5794.098208 1087.834341 0 7811 7024.323748 7365.878796 0 7812 212.594115 4679.332015 0 7813 8719.676261 7606.981302 0 7814 7255.277296 5990.155631 0 7815 7683.016617 4252.673965 0 7816 3513.093212 8364.594685 0 7817 1286.387201 1674.993363 0 7818 4227.417859 6668.159905 0 7819 7990.076019 317.027717 0 7820 1903.660421 132.265547 0 7821 7299.90081 9014.481843 0 7822 1091.82802 9430.851319 0 7823 9583.427995 5510.107687 0 7824 7685.761062 2082.292083 0 7825 6166.384732 6264.46438 0 7826 8951.07322 2189.23127 0 7827 938.591746 7853.050465 0 7828 8415.265936 7218.61928 0 7829 356.876376 707.801906 0 7830 1844.865812 2547.83163 0 7831 5987.910362 5485.382726 0 7832 1086.04221 7455.062854 0 7833 9532.966017 6674.657046 0 7834 6754.739191 7523.74938 0 7835 999.792245 8371.149371 0 7836 8830.188414 1110.287258 0 7837 9056.172547 4640.289652 0 7838 2883.684574 8180.628914 0 7839 6741.651539 8433.298976 0 7840 6122.477058 9118.449797 0 7841 5067.153576 2198.38836 0 7842 938.616757 4885.639455 0 7843 7806.068927 6445.889383 0 7844 3430.433682 6936.137637 0 7845 3978.233109 5206.234837 0 7846 2278.457194 4587.600371 0 7847 3758.843437 2832.336852 0 7848 6918.186161 6718.493072 0 7849 3725.640041 1494.483722 0 7850 3806.084617 8754.441159 0 7851 538.732921 1782.135337 0 7852 6733.170843 2279.918672 0 7853 8500.037445 1460.635665 0 7854 3332.673771 7624.200837 0 7855 5553.699407 1911.148157 0 7856 3606.249634 9986.17345 0 7857 2526.729487 594.040646 0 7858 1786.837102 7694.891998 0 7859 8400.612487 3689.910123 0 7860 3492.228022 4441.683889 0 7861 1499.481768 5667.35815 0 7862 3395.075927 5566.743295 0 7863 2410.355721 4366.554704 0 7864 4874.886604 3583.705157 0 7865 3293.746555 6900.226636 0 7866 5173.484374 1200.210773 0 7867 3592.616632 7046.271423 0 7868 1946.445168 1236.936447 0 7869 2086.419241 6669.976918 0 7870 215.82682 2544.41863 0 7871 8573.408177 6988.626908 0 7872 9567.824879 4301.089863 0 7873 1212.855423 7498.555016 0 7874 8074.914477 8940.170613 0 7875 6840.879028 1015.42312 0 7876 30.82524 4687.460726 0 7877 7826.089968 1617.45845 0 7878 1230.806208 9316.589697 0 7879 7398.440017 4265.498214 0 7880 4432.20083 9047.175494 0 7881 7442.746391 315.829281 0 7882 5622.24898 6076.783422 0 7883 3046.435755 7001.538592 0 7884 5771.728105 5650.91983 0 7885 6806.118697 3864.040535 0 7886 3063.829392 218.966909 0 7887 7199.834548 8577.224022 0 7888 8031.951003 2609.949727 0 7889 7417.460756 9166.376431 0 7890 2998.630231 6482.739264 0 7891 7487.589109 1571.092953 0 7892 2810.072775 7590.679952 0 7893 6343.367152 1824.56486 0 7894 471.998894 1614.920672 0 7895 1962.714569 7452.565907 0 7896 3207.574011 8134.750489 0 7897 2582.204224 2521.701137 0 7898 8639.151061 154.131131 0 7899 2954.489116 9164.894459 0 7900 4853.824697 6755.742251 0 7901 6052.837658 9654.112992 0 7902 7272.05328 6382.688682 0 7903 3013.389966 122.270122 0 7904 6018.889255 3021.045187 0 7905 7591.862577 8360.071277 0 7906 7523.243229 7551.066891 0 7907 9530.955482 6504.49925 0 7908 4663.830203 9213.23049 0 7909 5157.16408 2810.607908 0 7910 1376.522219 1458.753088 0 7911 1010.717813 1781.431922 0 7912 1693.341773 5865.623206 0 7913 178.535234 9705.106484 0 7914 2640.414213 6279.141711 0 7915 9393.586618 5143.644204 0 7916 9321.495782 6531.597887 0 7917 6781.930266 9854.845398 0 7918 2030.876962 2547.359303 0 7919 5722.344275 5665.066185 0 7920 973.618694 1992.920535 0 7921 3668.960145 5207.184986 0 7922 1008.280802 9989.444182 0 7923 9443.973364 7939.066414 0 7924 1667.971034 7638.339607 0 7925 8448.145584 7682.666356 0 7926 7253.02851 2516.336844 0 7927 6116.080146 7342.914176 0 7928 3612.237896 3694.236626 0 7929 836.499557 9679.3039 0 7930 5158.132421 318.207898 0 7931 6018.803989 9235.571578 0 7932 8622.156287 4703.329619 0 7933 394.551684 3976.385491 0 7934 9023.508319 2785.794953 0 7935 2305.965514 3913.658427 0 7936 7242.682353 5545.866665 0 7937 6442.588698 1594.36419 0 7938 7132.454203 7052.143735 0 7939 8665.423656 3707.133174 0 7940 9952.516615 9644.867075 0 7941 135.344729 7910.128132 0 7942 6848.747135 838.73194 0 7943 9721.135925 647.979782 0 7944 6558.018897 934.737879 0 7945 1107.000436 4844.563572 0 7946 4156.677627 5861.347203 0 7947 8293.27909 3274.933471 0 7948 5752.438341 3913.790402 0 7949 1763.675058 6492.848809 0 7950 6834.540829 9379.394019 0 7951 2455.566514 9135.603992 0 7952 1023.89864 6246.697151 0 7953 9216.032632 5018.950964 0 7954 263.585335 6854.28252 0 7955 9976.567153 7769.170914 0 7956 6715.560671 8619.971623 0 7957 8300.479421 147.365396 0 7958 7675.539992 4179.903662 0 7959 7363.236464 8141.861242 0 7960 8037.215132 8694.754297 0 7961 5376.329513 5228.726365 0 7962 7971.614189 1888.801988 0 7963 4120.440807 3523.861918 0 7964 5384.171224 3838.436877 0 7965 2267.836725 9373.993833 0 7966 7014.963341 4268.259801 0 7967 8950.907973 9615.625459 0 7968 5645.727876 2953.583265 0 7969 6502.238377 4535.460751 0 7970 9761.564989 8988.335501 0 7971 264.130018 57.119287 0 7972 1751.829049 3162.252978 0 7973 5777.879799 2086.2257 0 7974 1216.56477 418.040116 0 7975 1964.412112 1418.534601 0 7976 9622.812879 5652.483634 0 7977 1297.299274 9922.510679 0 7978 6667.265914 5766.759501 0 7979 7479.904652 7732.415916 0 7980 3151.764879 9231.932531 0 7981 1404.342076 5747.355314 0 7982 2648.870099 9995.365351 0 7983 2730.828355 9128.595038 0 7984 2940.079137 170.19422 0 7985 7120.912346 2995.265879 0 7986 1760.728769 5358.616289 0 7987 2888.894943 6346.992474 0 7988 3285.57251 3987.955742 0 7989 8589.068181 4662.014409 0 7990 5406.281733 16.523361 0 7991 7352.138774 6036.375775 0 7992 6166.932873 6840.682746 0 7993 7994.848383 8738.401226 0 7994 9990.644554 6621.999907 0 7995 5619.979435 1378.078337 0 7996 2153.189217 9825.921924 0 7997 5901.201489 8440.245067 0 7998 9166.242143 4881.812572 0 7999 4717.10458 3175.898425 0 8000 6758.287159 9414.368128 0 8001 8279.620897 1095.741606 0 8002 6430.752179 3817.423892 0 8003 4417.662555 1010.834817 0 8004 9789.303315 4523.794178 0 8005 3871.709306 7719.718233 0 8006 8310.5202 6587.241263 0 8007 4177.613263 2479.159845 0 8008 6429.381308 3473.544021 0 8009 6800.372016 1159.260542 0 8010 8800.74176 8808.523796 0 8011 7325.61273 3274.997259 0 8012 3199.763221 5890.591586 0 8013 2953.868397 6901.68308 0 8014 4447.612295 2825.574384 0 8015 149.275274 8571.498676 0 8016 4958.567246 99.509534 0 8017 4732.290491 7523.200727 0 8018 5403.852026 3840.644265 0 8019 3914.252966 4317.447826 0 8020 6477.192404 9803.014843 0 8021 8080.642004 1189.718568 0 8022 9304.253985 2941.724286 0 8023 3958.987152 9753.387165 0 8024 5823.352002 463.283017 0 8025 8775.399591 9148.801251 0 8026 1816.006015 2470.862373 0 8027 8758.164517 9957.791904 0 8028 2979.778827 2731.033296 0 8029 8942.13139 9865.048076 0 8030 7373.709715 1448.304247 0 8031 3573.382087 9721.669657 0 8032 7645.284033 3176.902871 0 8033 5093.049032 4333.612349 0 8034 2433.315349 6397.269383 0 8035 241.303524 3970.452013 0 8036 584.125796 9436.8868 0 8037 8246.791403 9711.267747 0 8038 8130.433169 6273.552737 0 8039 4454.654228 4473.013257 0 8040 953.273527 1498.26898 0 8041 2588.822142 3739.912205 0 8042 9694.355044 2178.065048 0 8043 1542.726049 3790.609094 0 8044 3106.400006 4181.86169 0 8045 3878.948237 949.419696 0 8046 3093.923185 2713.351367 0 8047 934.414969 9184.302356 0 8048 2943.124385 3504.245812 0 8049 9593.298348 7142.346998 0 8050 310.596338 8059.517571 0 8051 2347.951516 3273.631762 0 8052 8951.716903 8753.098142 0 8053 3706.126448 6636.803063 0 8054 9943.601845 4381.839888 0 8055 6474.730873 9779.13619 0 8056 9038.908895 8260.305413 0 8057 1699.296512 3227.477203 0 8058 5743.886242 3129.551466 0 8059 4251.286762 2373.431803 0 8060 316.838932 6852.890172 0 8061 9749.496534 7752.771204 0 8062 7936.707976 2259.744921 0 8063 8618.13046 5105.986219 0 8064 183.149866 4853.087839 0 8065 6043.613732 2003.037032 0 8066 4447.69487 9720.560423 0 8067 2937.336185 6805.438902 0 8068 4854.960708 9866.354612 0 8069 8824.944696 1602.238266 0 8070 3503.601233 2462.358316 0 8071 8765.992234 4695.807547 0 8072 5250.008311 7906.552597 0 8073 9134.922487 6244.832191 0 8074 4146.393962 6156.578137 0 8075 3171.499565 9125.252528 0 8076 7506.665066 7214.463436 0 8077 2704.525612 5936.559028 0 8078 5008.894425 2428.691892 0 8079 1494.394968 6009.300076 0 8080 8507.827082 9935.726112 0 8081 5802.752995 1408.913559 0 8082 7930.982258 3655.368304 0 8083 1219.894768 5806.369149 0 8084 5346.272665 7656.555853 0 8085 3343.269038 1630.717192 0 8086 2936.713721 1720.014108 0 8087 8896.977238 3621.894898 0 8088 5237.668113 8325.031635 0 8089 2705.880322 209.496265 0 8090 289.379326 4133.022473 0 8091 7006.864893 2186.286015 0 8092 5535.235649 6235.334673 0 8093 202.777536 3272.085668 0 8094 6140.32849 7845.307295 0 8095 8514.943869 8194.362431 0 8096 2188.192895 6837.255867 0 8097 5770.723278 4438.285813 0 8098 8623.54457 1326.456483 0 8099 5296.931046 1690.547234 0 8100 9900.66233 9088.37479 0 8101 2115.515656 2293.146935 0 8102 856.759822 7019.959341 0 8103 7181.332487 5565.506449 0 8104 4453.91158 2599.830673 0 8105 4224.17362 2609.740644 0 8106 2911.405929 6893.986702 0 8107 1666.045996 8841.34201 0 8108 3290.162255 9463.471805 0 8109 7871.092987 8786.273884 0 8110 8786.34361 4523.154329 0 8111 2448.928487 9334.650251 0 8112 4748.800432 9469.857904 0 8113 8029.025808 4095.349855 0 8114 2209.793277 9778.645757 0 8115 3392.494985 945.537883 0 8116 9935.829559 2908.160808 0 8117 4554.469876 8415.679675 0 8118 1646.771512 9496.30782 0 8119 7243.717197 1699.399628 0 8120 9957.043005 6625.22178 0 8121 2076.599129 6394.430582 0 8122 238.606571 3898.947135 0 8123 1728.107747 8867.26498 0 8124 3645.995882 5095.701404 0 8125 9377.692019 7596.399926 0 8126 1911.161138 5366.106101 0 8127 4132.711308 6212.879436 0 8128 9310.008235 9153.354754 0 8129 6987.751686 134.433351 0 8130 5818.687819 6701.180639 0 8131 7907.590924 22.961357 0 8132 3796.68335 3519.634091 0 8133 6407.08193 2528.047342 0 8134 1341.959132 6340.669141 0 8135 3679.23541 2590.178561 0 8136 665.641233 9802.206659 0 8137 6421.459481 2525.973757 0 8138 2989.952824 200.893355 0 8139 7874.81431 3789.158352 0 8140 1575.033063 8881.220431 0 8141 2026.057122 1106.406748 0 8142 7816.57671 7652.08432 0 8143 387.986604 1893.029307 0 8144 7062.25104 1046.073538 0 8145 7335.720069 6625.423057 0 8146 3304.303713 8620.797557 0 8147 9173.545269 950.514135 0 8148 8349.94951 489.290468 0 8149 6744.968736 5574.095255 0 8150 1253.826027 2272.949807 0 8151 641.276387 1712.294813 0 8152 2346.542579 1673.398343 0 8153 5504.134761 2635.821465 0 8154 5501.869017 8950.658343 0 8155 6870.574429 1981.533077 0 8156 1316.847358 7235.58721 0 8157 2324.155948 8315.462808 0 8158 9066.550192 6173.415698 0 8159 2832.528245 2567.52254 0 8160 5805.707635 1004.258497 0 8161 4151.279062 8332.977843 0 8162 5711.873625 6729.326907 0 8163 5321.020082 1362.875055 0 8164 6051.315763 5482.883026 0 8165 9849.999792 5119.247138 0 8166 9652.132436 9772.664108 0 8167 2337.1086 5430.603412 0 8168 8358.173902 7822.154332 0 8169 4334.786306 9811.930239 0 8170 1246.797272 5528.088596 0 8171 658.811505 4730.181453 0 8172 423.715139 991.59079 0 8173 3964.79745 9223.093454 0 8174 4341.489572 1154.564343 0 8175 9000.99166 9444.362164 0 8176 5888.980166 4990.169698 0 8177 5792.479717 4378.960697 0 8178 2375.767612 6329.27079 0 8179 1259.462943 2003.892105 0 8180 2445.946905 6493.985592 0 8181 8158.053049 9083.76429 0 8182 4620.175797 205.941838 0 8183 1048.631326 9046.579229 0 8184 181.534294 380.442866 0 8185 3468.638639 4208.056128 0 8186 5884.765728 2113.626359 0 8187 3631.966304 5760.065339 0 8188 6562.638315 1956.250318 0 8189 241.800415 1649.49171 0 8190 1753.352506 2555.198051 0 8191 4809.072145 2163.246069 0 8192 7506.786853 9303.388532 0 8193 8351.084744 6012.547512 0 8194 2574.733408 78.371696 0 8195 9158.19117 4908.668451 0 8196 5999.277768 1482.332398 0 8197 7248.049659 4015.225398 0 8198 2319.068872 7230.596314 0 8199 812.743871 3472.674445 0 8200 9204.103119 1268.580133 0 8201 4069.760033 52.659813 0 8202 8286.85472 552.284466 0 8203 210.263133 1779.81433 0 8204 2753.329874 5805.223099 0 8205 5403.768272 2956.703809 0 8206 6293.617005 8912.729248 0 8207 6933.065134 235.011204 0 8208 1009.949948 6910.586048 0 8209 7952.663895 4161.712314 0 8210 2148.33107 3415.962178 0 8211 8573.272682 5890.854564 0 8212 8391.104698 2802.266396 0 8213 6741.297709 5911.061155 0 8214 996.071404 5452.762905 0 8215 4058.280906 4201.778276 0 8216 3491.76383 116.33116 0 8217 929.73075 2885.238261 0 8218 7962.650855 1320.398396 0 8219 6291.535899 46.087153 0 8220 7052.815594 6588.173805 0 8221 4854.484138 3510.388117 0 8222 3644.735677 1833.761729 0 8223 6798.756185 7970.92014 0 8224 3204.96908 8466.523212 0 8225 333.048439 6844.382663 0 8226 3762.340991 8573.097938 0 8227 4001.172936 4859.051028 0 8228 5053.652641 1761.711165 0 8229 5242.912324 4147.335869 0 8230 5035.604027 4327.51062 0 8231 4961.238062 6897.331903 0 8232 69.657449 851.46672 0 8233 2103.541759 3076.199014 0 8234 514.6433 1865.643481 0 8235 1797.086993 1392.326052 0 8236 3181.653675 2240.979729 0 8237 9706.841123 9564.979133 0 8238 9627.602494 7031.096085 0 8239 733.682552 2425.064523 0 8240 3238.647919 1016.186825 0 8241 7125.537675 6270.762151 0 8242 3243.880025 5176.473822 0 8243 2622.682046 277.927051 0 8244 5812.606024 5682.620991 0 8245 2795.268157 4609.93934 0 8246 4454.685436 9050.6954 0 8247 3312.015675 8887.66625 0 8248 9215.692907 1202.653406 0 8249 9259.942345 5915.776054 0 8250 4955.701089 5743.612679 0 8251 3455.720834 309.756771 0 8252 3095.970086 5898.825068 0 8253 763.746116 8290.734822 0 8254 8726.426942 4391.707081 0 8255 2578.164664 7165.545869 0 8256 8312.455588 6626.502368 0 8257 3239.613418 7872.52983 0 8258 1206.472078 3377.60659 0 8259 4135.399075 436.147799 0 8260 6262.216068 7822.750008 0 8261 4118.339179 6259.080757 0 8262 7673.15359 7612.561942 0 8263 9602.316613 2532.3132 0 8264 9369.492123 5415.429649 0 8265 7711.118536 3588.651986 0 8266 9191.053134 3858.838775 0 8267 8057.739009 311.680603 0 8268 9320.593387 3595.899965 0 8269 8266.41076 3954.7394 0 8270 4849.552638 2127.067572 0 8271 133.471556 9281.257571 0 8272 8846.84361 2542.735153 0 8273 5853.77804 9179.457017 0 8274 3599.702134 5985.61326 0 8275 5755.729269 5179.935253 0 8276 6190.440513 1142.865189 0 8277 1124.827236 2962.474688 0 8278 7186.137712 3892.614435 0 8279 12.417899 7964.557345 0 8280 4737.236538 3861.339901 0 8281 6906.727601 7874.868481 0 8282 362.440932 2221.330545 0 8283 1666.451605 7268.158478 0 8284 5302.724296 1777.601542 0 8285 5586.479573 3418.616084 0 8286 141.160696 9373.68409 0 8287 9298.905439 9340.02359 0 8288 6967.684693 8019.607016 0 8289 1597.359267 6842.833464 0 8290 640.577048 3352.3849 0 8291 7329.612226 5084.329086 0 8292 9592.598052 2924.539715 0 8293 6687.725002 3873.921572 0 8294 9232.30037 5165.977382 0 8295 3327.133161 3761.452565 0 8296 5345.463642 9482.080835 0 8297 3973.845649 5819.067873 0 8298 4381.719908 5672.774039 0 8299 9422.449059 4266.667892 0 8300 7459.976285 6867.915647 0 8301 1771.964691 5243.766772 0 8302 251.867908 5599.250114 0 8303 6280.302157 5823.290938 0 8304 1221.305512 5619.330932 0 8305 9842.962417 425.325063 0 8306 1034.002321 4058.970396 0 8307 5321.430748 1636.773931 0 8308 1903.24103 69.419227 0 8309 6637.98624 820.239827 0 8310 2062.035808 3814.881848 0 8311 8578.702365 8745.273126 0 8312 5883.214547 3751.176081 0 8313 2508.210504 6815.932726 0 8314 1998.283296 4768.893694 0 8315 7709.368785 5509.936062 0 8316 9484.102367 7378.189775 0 8317 5831.432643 5554.106714 0 8318 9881.90759 5307.068123 0 8319 4617.401529 4001.330458 0 8320 8273.45437 6201.156728 0 8321 7526.062219 2892.819541 0 8322 6192.369666 7915.743595 0 8323 6951.600955 9101.956635 0 8324 3353.802455 8765.958657 0 8325 4116.302654 459.285816 0 8326 4772.881245 1064.182339 0 8327 4923.907164 9312.659422 0 8328 6548.366867 5842.452696 0 8329 2971.893668 6351.902735 0 8330 5200.632532 5657.229227 0 8331 8551.31477 2428.873939 0 8332 4180.91669 4628.764978 0 8333 9246.991974 3381.749879 0 8334 7048.634418 1915.091306 0 8335 7625.073816 7950.772679 0 8336 8470.577544 1619.325377 0 8337 4729.498251 1336.866511 0 8338 774.730527 7283.544896 0 8339 3454.272142 4981.872684 0 8340 8710.401187 179.80486 0 8341 3409.294444 7239.701464 0 8342 4224.536682 9747.24269 0 8343 3114.259982 4325.019352 0 8344 9845.990601 2093.866427 0 8345 4081.054104 362.305712 0 8346 2202.857862 5780.673048 0 8347 6606.396907 5916.250369 0 8348 7206.952182 5606.248196 0 8349 8993.975904 1060.202269 0 8350 9597.973175 9200.986479 0 8351 8990.792192 3550.813556 0 8352 9640.065369 1948.513904 0 8353 8451.607756 3063.723708 0 8354 5161.255833 3821.145291 0 8355 4157.506001 8365.512007 0 8356 3134.747628 2940.269895 0 8357 2940.24733 2297.527753 0 8358 2714.795573 7012.255995 0 8359 242.227975 3273.533028 0 8360 4583.600559 4712.120815 0 8361 701.105692 1095.530457 0 8362 7408.744283 516.352222 0 8363 1055.223325 1871.234818 0 8364 1860.609133 5683.639867 0 8365 7768.256776 2663.294716 0 8366 8072.193045 1312.782163 0 8367 6003.468713 6310.618852 0 8368 2314.156348 3552.200095 0 8369 8266.053528 4035.435145 0 8370 6715.790912 1327.000778 0 8371 9765.368438 6099.21159 0 8372 840.78301 4292.315131 0 8373 8924.066901 2320.098383 0 8374 2899.608447 1699.762749 0 8375 2335.826188 3479.308912 0 8376 7941.09246 2802.252074 0 8377 4095.928659 5616.296817 0 8378 3750.80442 8833.048482 0 8379 5760.642334 9241.278951 0 8380 14.457824 5646.812975 0 8381 1896.357108 5216.587111 0 8382 1998.842873 7716.686453 0 8383 1309.936336 2161.611231 0 8384 5174.986455 6061.688259 0 8385 7085.983627 334.951396 0 8386 7083.443821 276.951691 0 8387 1975.873521 1540.864093 0 8388 13.816225 3817.561378 0 8389 3472.440799 234.505509 0 8390 704.204007 6402.30259 0 8391 423.354421 8472.709282 0 8392 9810.429209 1680.801589 0 8393 1397.313526 2644.796849 0 8394 7227.806084 3713.596246 0 8395 4334.215137 2324.995486 0 8396 3214.144559 420.665516 0 8397 7132.153156 2739.195445 0 8398 6030.019218 3327.135921 0 8399 5727.552332 7335.400751 0 8400 3046.873141 1268.767984 0 8401 7292.934707 9956.511206 0 8402 2488.271269 492.269328 0 8403 7037.49549 3681.325344 0 8404 9143.062961 1356.816563 0 8405 1471.966634 5111.468533 0 8406 9793.684245 4696.002137 0 8407 4075.296395 1794.17747 0 8408 8965.268181 9978.261433 0 8409 1385.906906 5030.302496 0 8410 8031.169066 6138.13598 0 8411 2236.043534 8122.368886 0 8412 5293.446101 1431.096875 0 8413 7751.536805 2395.425691 0 8414 2856.708418 8773.221861 0 8415 5769.442425 6868.416896 0 8416 9009.200711 6946.141317 0 8417 8161.968516 4747.196615 0 8418 6971.746531 5732.268971 0 8419 7455.425953 1398.155893 0 8420 2732.162131 3209.962434 0 8421 7821.960575 2086.72202 0 8422 189.558957 3010.920895 0 8423 5234.660045 5967.917456 0 8424 8619.001269 8433.185999 0 8425 5344.664705 2182.699622 0 8426 3435.352773 2020.652952 0 8427 6829.461031 2369.755774 0 8428 8805.730435 8771.218638 0 8429 2811.728299 4211.2177 0 8430 1137.431473 9741.24129 0 8431 4066.59427 3633.292472 0 8432 6107.697133 6195.743597 0 8433 9957.178626 7153.859596 0 8434 6965.359972 7708.947298 0 8435 9458.408766 3426.207551 0 8436 1613.216905 1024.907276 0 8437 9303.690687 4440.393385 0 8438 4615.384696 8824.101063 0 8439 2543.272807 4305.802254 0 8440 2966.138081 2056.845527 0 8441 8142.851668 8248.43227 0 8442 8060.332328 1043.67206 0 8443 6486.859007 1720.849396 0 8444 9282.668969 3760.382042 0 8445 8356.939294 1737.931075 0 8446 4813.399554 2145.865417 0 8447 3754.616201 2227.28822 0 8448 2814.682817 6781.961219 0 8449 2419.326899 5030.860569 0 8450 1352.669028 8878.709269 0 8451 6333.394011 8738.807964 0 8452 7471.816854 5589.124506 0 8453 4117.487031 3848.716305 0 8454 8569.874114 3921.296631 0 8455 5056.734806 4881.96073 0 8456 6037.139184 4338.156655 0 8457 7596.781905 4477.014343 0 8458 8575.242605 3967.357008 0 8459 4987.366142 883.198296 0 8460 6933.182351 6911.903669 0 8461 6247.05135 3462.725148 0 8462 9724.585582 4451.090702 0 8463 5598.630289 6014.032056 0 8464 9145.35454 6249.154075 0 8465 1050.201862 3568.626354 0 8466 4331.326501 5755.240815 0 8467 9381.649579 7925.087903 0 8468 5004.916327 2677.359865 0 8469 530.030228 6589.800957 0 8470 5106.575207 5451.371674 0 8471 5890.665329 9328.505839 0 8472 4246.003661 2317.827368 0 8473 5801.592845 302.703748 0 8474 1294.078037 1273.073812 0 8475 7421.754314 8303.575 0 8476 8307.332516 6804.857598 0 8477 9646.407142 3445.157642 0 8478 8918.776713 8471.109295 0 8479 8839.771069 9883.497904 0 8480 8812.579646 7030.040712 0 8481 2655.977982 3160.445884 0 8482 5401.59299 5272.07787 0 8483 6603.458547 2040.942067 0 8484 1419.47338 4560.363468 0 8485 3791.159823 4995.594118 0 8486 2811.3831 3626.799699 0 8487 4212.189673 5182.826334 0 8488 9778.675986 5528.759135 0 8489 7443.222205 1741.179174 0 8490 536.366975 1498.757886 0 8491 1344.023544 4223.661381 0 8492 7388.061539 3352.156429 0 8493 2674.027946 5560.012049 0 8494 1959.782796 9188.897847 0 8495 1768.296156 4033.226677 0 8496 7560.974719 777.450081 0 8497 3198.927627 4956.237464 0 8498 3184.774172 5768.38842 0 8499 3161.146569 1938.640837 0 8500 9401.305909 218.689061 0 8501 2287.705996 9020.768968 0 8502 3818.277964 4916.081408 0 8503 9462.469383 8839.68174 0 8504 1632.573642 9658.913151 0 8505 7462.082359 9981.39721 0 8506 649.253659 9577.807382 0 8507 9483.496071 6178.912428 0 8508 300.298262 799.115899 0 8509 4019.254019 5242.662237 0 8510 8981.114819 1010.76177 0 8511 9442.079721 3338.114976 0 8512 1556.106473 5268.004329 0 8513 6128.962342 6624.029617 0 8514 6149.788288 7794.968983 0 8515 7520.934978 7164.475969 0 8516 9580.248862 2638.108994 0 8517 4164.451228 1323.841982 0 8518 3199.660072 2226.651457 0 8519 2920.836529 1029.61103 0 8520 5996.936324 3360.814068 0 8521 5094.514045 2321.083716 0 8522 6840.420497 6685.014771 0 8523 9710.584872 4330.309308 0 8524 3740.687262 328.033563 0 8525 4771.312775 6575.099673 0 8526 8596.568039 9030.489936 0 8527 4102.909278 7482.489554 0 8528 2418.412521 9761.366718 0 8529 2455.947915 7996.158636 0 8530 3234.139036 2583.349891 0 8531 3013.718172 1843.977488 0 8532 4059.075434 2910.844253 0 8533 1335.121385 4092.171516 0 8534 500.294444 8933.541437 0 8535 6475.598224 1308.47932 0 8536 6176.436406 2143.639012 0 8537 3583.63665 326.42074 0 8538 1863.246549 14.448916 0 8539 9713.472174 7817.534922 0 8540 714.719549 5684.727336 0 8541 8035.26203 2729.502106 0 8542 8132.435138 5433.724019 0 8543 3878.050946 2163.220773 0 8544 5586.039216 6670.315693 0 8545 2814.008665 2299.445744 0 8546 7314.582178 3073.943272 0 8547 5262.171909 96.64071 0 8548 2314.294432 2384.411663 0 8549 8819.635878 1684.21806 0 8550 9657.982239 2074.16742 0 8551 1085.187088 2279.3383 0 8552 8365.800976 4115.628478 0 8553 1551.302945 6878.671819 0 8554 6369.078584 1966.065555 0 8555 7173.572133 6848.205903 0 8556 4040.094482 2737.233912 0 8557 9368.675578 2293.560626 0 8558 9501.653532 2368.282941 0 8559 3133.073998 4321.347326 0 8560 1374.374231 5625.000328 0 8561 3139.528267 510.318134 0 8562 623.47058 9357.515668 0 8563 3879.248631 6973.649454 0 8564 1654.817605 5797.933086 0 8565 5595.318762 6287.650958 0 8566 5090.558427 4883.35951 0 8567 5730.254854 2162.253757 0 8568 1312.879215 4367.096226 0 8569 9173.217787 6788.957615 0 8570 8289.794541 3002.7942 0 8571 6662.59404 5482.093939 0 8572 5479.781583 4592.215663 0 8573 1039.393473 6923.018978 0 8574 8874.611037 6256.982208 0 8575 3313.471903 8925.62474 0 8576 3318.499558 9133.497424 0 8577 7317.650162 4452.296664 0 8578 8594.077843 3334.322033 0 8579 6387.252832 1989.111383 0 8580 2552.641194 5496.786646 0 8581 9625.652549 1089.111497 0 8582 6258.511875 2623.087806 0 8583 3561.857041 5005.811526 0 8584 3754.537356 6432.091018 0 8585 3021.643752 6824.90102 0 8586 4242.837415 6765.775259 0 8587 805.144095 2411.175534 0 8588 7138.353168 9320.799126 0 8589 7199.12013 57.082241 0 8590 5642.645789 170.830337 0 8591 9270.153836 2628.870488 0 8592 6593.894348 4689.188393 0 8593 3793.278039 2635.672419 0 8594 5720.132755 4119.790925 0 8595 5193.074501 8589.141001 0 8596 8326.943069 4618.368429 0 8597 2165.849178 6172.753291 0 8598 7135.603789 818.28302 0 8599 8916.657207 2741.686037 0 8600 8122.884599 1154.76272 0 8601 2926.829015 4350.39346 0 8602 1297.975959 3586.781699 0 8603 955.702738 1438.585497 0 8604 8274.103069 7698.80746 0 8605 7550.207245 1669.299289 0 8606 4165.054182 7536.932116 0 8607 9946.518431 7026.41242 0 8608 2502.638272 9405.164342 0 8609 2711.644426 2590.62328 0 8610 4280.292004 1462.902558 0 8611 191.559456 942.469156 0 8612 8182.413952 7286.908496 0 8613 6576.70201 4095.343253 0 8614 310.474666 2011.010164 0 8615 9634.471474 5799.810398 0 8616 35.819225 5122.9488 0 8617 2298.33458 9680.254153 0 8618 2577.012165 7723.714373 0 8619 6805.327284 6363.678942 0 8620 9850.57556 6099.581191 0 8621 9923.048311 915.321014 0 8622 9969.926004 4421.245993 0 8623 8261.339115 4344.218138 0 8624 4989.017476 6031.519516 0 8625 2707.142121 3995.77436 0 8626 7061.596045 2533.673103 0 8627 2789.334379 3534.498363 0 8628 4603.659081 2284.991502 0 8629 9969.983471 1099.996398 0 8630 5934.137178 8864.813655 0 8631 9766.667343 4385.060208 0 8632 2136.756643 5440.017304 0 8633 8660.931298 1748.600213 0 8634 5714.755582 2452.087528 0 8635 3543.973745 6519.154164 0 8636 9580.969907 82.788145 0 8637 571.245631 8734.535148 0 8638 6537.933095 4674.661014 0 8639 2426.933483 785.339637 0 8640 4188.729769 8643.230928 0 8641 8601.418918 3591.040388 0 8642 6306.425057 4038.653437 0 8643 662.224351 2334.638228 0 8644 4946.693939 680.458371 0 8645 757.068021 8954.523659 0 8646 5870.757693 3607.784089 0 8647 9460.64743 2246.713899 0 8648 831.106249 8431.431723 0 8649 7725.775773 9270.617806 0 8650 756.312328 8652.114207 0 8651 9392.853103 8765.037988 0 8652 4874.638787 3308.803403 0 8653 8135.941236 2867.821859 0 8654 8210.535269 3117.890961 0 8655 1884.741601 8679.790233 0 8656 8387.067034 7084.298976 0 8657 9024.391892 4710.349068 0 8658 8438.238384 6130.975608 0 8659 346.114817 4391.699274 0 8660 8603.18038 7874.196107 0 8661 8402.049224 3270.530436 0 8662 9070.77018 2543.165505 0 8663 1911.215459 923.757712 0 8664 532.211869 8105.814754 0 8665 6756.286318 4255.375361 0 8666 5761.699545 4173.539073 0 8667 8997.845739 6513.71946 0 8668 2272.231539 3808.940545 0 8669 6894.369864 5759.156248 0 8670 7168.456166 2570.74453 0 8671 447.863205 2154.00092 0 8672 9944.915258 2673.655344 0 8673 8988.456438 6561.54724 0 8674 5191.685949 1336.066121 0 8675 5711.328252 6003.062526 0 8676 6894.51764 1679.360596 0 8677 4900.810468 8433.513612 0 8678 8491.829729 5812.787757 0 8679 3704.957611 6396.628417 0 8680 9052.54599 7044.650813 0 8681 5308.539698 1243.319056 0 8682 3351.111083 494.874927 0 8683 6221.686316 9287.410217 0 8684 2795.604507 5196.007193 0 8685 6133.388189 2777.750969 0 8686 217.879163 1459.898869 0 8687 469.89239 1240.457951 0 8688 2385.840513 6741.418177 0 8689 9652.223634 9310.595486 0 8690 7241.837471 1575.223129 0 8691 2826.940596 6164.293929 0 8692 3053.696495 9929.186434 0 8693 8554.13772 1756.340108 0 8694 9794.106023 9982.851322 0 8695 1401.800315 6093.775641 0 8696 3041.649274 4921.420226 0 8697 6175.659666 1208.748906 0 8698 4045.092066 7192.654921 0 8699 1488.466844 830.637107 0 8700 2373.191624 4688.641176 0 8701 5989.148931 2495.281898 0 8702 8832.747605 2531.757172 0 8703 5687.724945 1285.688083 0 8704 7855.410841 2546.817443 0 8705 3306.531443 4696.50534 0 8706 287.745457 4120.79997 0 8707 7473.187852 3708.698955 0 8708 6586.188405 7869.802014 0 8709 6898.108203 6209.138435 0 8710 6410.200534 3112.001749 0 8711 8735.026158 1600.527383 0 8712 2820.40913 8827.859232 0 8713 8120.989 9413.515803 0 8714 4598.362335 1523.579906 0 8715 7353.192959 940.324881 0 8716 1960.654883 7708.862062 0 8717 4083.637485 3557.380411 0 8718 1973.913551 4672.561477 0 8719 8004.68842 9014.605173 0 8720 1800.928155 9891.273082 0 8721 8113.361034 8245.765192 0 8722 6150.899925 7572.170896 0 8723 1396.193625 9472.995603 0 8724 6126.865389 9556.431569 0 8725 2148.589615 938.694196 0 8726 7865.430067 7593.978782 0 8727 1074.763384 7908.274894 0 8728 5802.029319 8174.08481 0 8729 4994.665414 9083.533595 0 8730 7749.167165 8029.483927 0 8731 1215.762861 4426.41126 0 8732 947.362123 5206.936152 0 8733 8191.78162 6104.073322 0 8734 726.209325 9495.171167 0 8735 928.568206 7342.780517 0 8736 8291.22096 1675.379378 0 8737 3028.62303 1430.768753 0 8738 7875.06456 2354.074211 0 8739 9647.411182 1231.539411 0 8740 1280.057132 6943.765304 0 8741 5544.042634 3063.178502 0 8742 7275.927677 248.798813 0 8743 6832.555151 8689.06767 0 8744 2365.318926 5152.26337 0 8745 9917.21975 6915.173754 0 8746 6714.434277 5407.278002 0 8747 7806.735479 4874.816432 0 8748 3004.87351 5185.470735 0 8749 101.772413 4919.127371 0 8750 3686.064715 5604.014433 0 8751 9781.656476 6962.018444 0 8752 4297.132735 1848.011015 0 8753 9441.429242 477.417898 0 8754 1438.303568 7528.348272 0 8755 9537.300209 9385.51374 0 8756 2137.019534 9135.823753 0 8757 3232.496627 8074.199004 0 8758 2098.681344 7527.48759 0 8759 4852.33778 2716.5557 0 8760 6365.786842 1098.159551 0 8761 8181.260429 5627.663088 0 8762 9809.116984 9277.5141 0 8763 7861.30677 1440.637859 0 8764 6147.249762 1718.543077 0 8765 6842.638544 9492.130518 0 8766 1423.257256 1270.809928 0 8767 5559.758907 3177.684331 0 8768 6623.415664 2832.222424 0 8769 6887.698178 1647.7109 0 8770 9886.697183 4680.934179 0 8771 9793.060591 9739.275404 0 8772 8697.983652 4085.065011 0 8773 5217.143804 4283.250775 0 8774 6827.146291 3056.878739 0 8775 4156.266123 8939.490841 0 8776 2023.962556 4223.358097 0 8777 2298.270469 5092.073427 0 8778 8746.628303 6311.962611 0 8779 7062.167008 348.992547 0 8780 3785.464665 2378.286208 0 8781 3530.478722 2399.080939 0 8782 14.727328 4347.590684 0 8783 6701.417743 2707.555065 0 8784 6001.216396 4091.080118 0 8785 8913.256334 6913.464495 0 8786 4575.21285 7460.893323 0 8787 5022.901892 5554.238069 0 8788 7489.344267 6218.746915 0 8789 4741.404774 7850.676721 0 8790 7149.273967 7001.428506 0 8791 1196.351903 79.409458 0 8792 1192.438491 7343.550507 0 8793 4551.9435 3736.310196 0 8794 1469.568483 5297.783708 0 8795 3875.010596 4742.314146 0 8796 3843.323398 5064.780081 0 8797 2145.882091 233.061047 0 8798 378.508408 8213.862366 0 8799 4980.632412 9416.460989 0 8800 7045.54039 5910.330408 0 8801 220.848508 2351.236455 0 8802 8212.662645 9396.562721 0 8803 7761.93774 5995.33967 0 8804 7165.479165 9100.680839 0 8805 5489.16063 2416.656368 0 8806 8141.697505 6936.655374 0 8807 3639.074719 8485.6905 0 8808 3633.674803 3404.512918 0 8809 4369.16679 4029.30062 0 8810 8021.82043 163.437956 0 8811 9927.644249 4228.654854 0 8812 5795.784332 8796.082346 0 8813 8299.398186 999.479219 0 8814 3311.375053 3564.461042 0 8815 1418.136275 5693.832159 0 8816 9139.678279 8558.60331 0 8817 9171.462965 4690.040498 0 8818 2929.054226 3453.694429 0 8819 6886.968181 6198.490424 0 8820 3007.628774 144.123174 0 8821 8456.638024 5736.809097 0 8822 9998.219076 4979.15841 0 8823 3666.221615 8567.486318 0 8824 1041.566094 5748.21196 0 8825 1793.198655 39.79887 0 8826 61.213071 4932.037055 0 8827 5384.159185 660.668892 0 8828 438.574573 1423.689307 0 8829 1560.895145 4243.362192 0 8830 3122.602252 3255.339344 0 8831 5127.163378 2174.531607 0 8832 5009.417398 9253.809742 0 8833 7823.458447 450.145081 0 8834 2138.659634 8826.696133 0 8835 3518.686696 1489.491231 0 8836 8235.563161 8853.445534 0 8837 9599.586151 195.723199 0 8838 6951.149993 7433.987018 0 8839 8699.095499 6535.97937 0 8840 6345.806238 3689.890048 0 8841 1881.064384 3901.564833 0 8842 846.875302 4291.189024 0 8843 3751.992926 9013.142073 0 8844 5503.257228 6967.622946 0 8845 1471.704357 4316.568983 0 8846 3722.911211 6441.798686 0 8847 3543.170151 8251.352596 0 8848 6455.530465 4880.376472 0 8849 2254.733966 1719.413793 0 8850 5232.062546 1362.911257 0 8851 3376.174416 3650.79811 0 8852 5417.215646 2556.811995 0 8853 2944.381099 1515.747129 0 8854 5308.226099 8424.488073 0 8855 5245.105257 2188.699984 0 8856 7446.257526 2383.74182 0 8857 2054.849049 6687.255645 0 8858 9450.079074 9728.608151 0 8859 373.953541 6388.327246 0 8860 2756.134386 4934.966969 0 8861 2265.051446 4173.62359 0 8862 9582.115918 6157.591869 0 8863 7967.292416 1175.269403 0 8864 1603.670851 5719.485751 0 8865 9745.726197 7638.441402 0 8866 3466.020504 2153.374833 0 8867 6536.275473 9320.507562 0 8868 1274.307174 5872.386083 0 8869 7341.039759 9576.843759 0 8870 8833.027356 5545.42051 0 8871 7528.241834 6230.174109 0 8872 9293.65442 8452.02571 0 8873 9095.769722 9623.486661 0 8874 5391.549445 5970.072766 0 8875 5649.924556 3891.202868 0 8876 2165.737167 6059.042106 0 8877 2558.244795 8601.811914 0 8878 9102.014166 184.131082 0 8879 1475.856807 1340.624308 0 8880 1163.010968 784.32886 0 8881 8951.212616 1887.23551 0 8882 2389.850054 3151.302718 0 8883 8866.699325 7338.827727 0 8884 9310.986116 6313.550631 0 8885 7418.085758 4435.699985 0 8886 2045.643702 403.098871 0 8887 9426.069136 7916.025271 0 8888 8370.845515 7062.467224 0 8889 472.305894 4170.056703 0 8890 5725.096921 9767.289223 0 8891 7458.811078 7504.554106 0 8892 9113.103496 8605.176288 0 8893 8376.561341 4501.160371 0 8894 1458.547525 4352.489006 0 8895 986.595599 4407.065023 0 8896 4851.123413 6080.09974 0 8897 9479.596548 9266.660473 0 8898 8672.360993 5555.238414 0 8899 7778.763588 7856.53365 0 8900 1450.025348 7839.786403 0 8901 3966.316651 5316.012134 0 8902 925.08415 7411.652563 0 8903 3538.62394 3439.659875 0 8904 34.557783 6383.804469 0 8905 5981.385624 7470.877664 0 8906 5701.740538 8145.026883 0 8907 9041.684056 5223.439535 0 8908 8085.624193 7520.74265 0 8909 4170.841908 2547.900991 0 8910 3114.44229 1961.493525 0 8911 9766.763471 9202.827077 0 8912 1062.402205 8862.185003 0 8913 7237.481672 4926.689434 0 8914 1107.304997 1387.909076 0 8915 9614.144174 5204.206611 0 8916 230.840085 2629.789945 0 8917 537.884075 3933.578134 0 8918 8578.167858 7405.917869 0 8919 3830.769545 5138.194896 0 8920 3349.850593 3102.855003 0 8921 2827.090722 5220.528817 0 8922 7912.550859 7159.982893 0 8923 1550.262131 6243.289091 0 8924 1647.394593 4546.465674 0 8925 8155.340922 7194.81221 0 8926 1235.453507 4115.987605 0 8927 8625.556595 5399.074596 0 8928 3526.414822 3521.672612 0 8929 4318.400433 1314.294984 0 8930 7183.261409 8015.14507 0 8931 5942.510023 1323.048825 0 8932 8920.558237 3658.214979 0 8933 9756.860828 9708.223415 0 8934 3601.955041 6891.373969 0 8935 8786.600022 8191.003026 0 8936 1854.808247 5709.901887 0 8937 7931.68388 8296.407647 0 8938 534.732127 3788.936321 0 8939 6460.162871 6112.158568 0 8940 1052.547261 1016.090717 0 8941 9202.327352 8534.75958 0 8942 2555.021119 7120.653848 0 8943 4669.437631 1282.355841 0 8944 9255.214332 4556.973017 0 8945 1035.570783 3416.530112 0 8946 9701.126244 219.468132 0 8947 5618.248706 6515.949828 0 8948 5814.101214 1796.78788 0 8949 9420.892788 7279.310221 0 8950 1268.524918 4319.752102 0 8951 7145.456719 6077.847237 0 8952 2561.53242 2274.07148 0 8953 2335.215437 9237.563502 0 8954 8462.343042 3804.855593 0 8955 9433.083161 8609.77484 0 8956 2741.301703 7283.147569 0 8957 3198.80718 5207.715435 0 8958 5057.16358 7320.873893 0 8959 4324.533289 2309.578511 0 8960 7209.536462 3761.974307 0 8961 1228.378155 2104.780632 0 8962 299.496685 306.720408 0 8963 8325.81078 212.318523 0 8964 729.142547 1269.560091 0 8965 8715.019544 8763.261942 0 8966 1457.94865 2987.708433 0 8967 9848.152779 5031.237122 0 8968 3972.196508 5764.470781 0 8969 6269.77093 3188.564224 0 8970 6312.770084 8000.238491 0 8971 9091.914624 1329.817098 0 8972 9436.900301 8622.738294 0 8973 8520.499186 4298.025763 0 8974 8689.849461 3846.084543 0 8975 7022.181544 614.902965 0 8976 7238.311522 5795.686751 0 8977 2708.036022 7768.491524 0 8978 4762.535056 1613.526635 0 8979 5913.027198 2227.544709 0 8980 6391.097274 4827.450784 0 8981 9721.134845 5960.640059 0 8982 2167.741524 5944.31253 0 8983 8831.116457 4506.333802 0 8984 4245.622154 1717.958248 0 8985 8881.565432 7349.57634 0 8986 7142.396706 5020.812937 0 8987 6725.777721 9295.766735 0 8988 5755.387002 9878.1417 0 8989 6203.064824 6611.604847 0 8990 1465.612896 8120.143858 0 8991 4248.594055 7875.144948 0 8992 4375.203159 6132.47458 0 8993 2862.80642 1041.462698 0 8994 3361.880413 5632.128383 0 8995 3734.948645 3594.517622 0 8996 3393.64787 3894.973825 0 8997 3858.310169 428.379558 0 8998 2424.009557 8443.98111 0 8999 4911.01981 5122.147244 0 9000 1419.722548 96.498358 0 9001 9001.246901 4776.043675 0 9002 2853.729369 9390.696689 0 9003 4584.713425 3690.291872 0 9004 5065.857412 1156.026628 0 9005 5148.553999 9091.243362 0 9006 3095.544984 3419.44933 0 9007 2960.595138 3683.144471 0 9008 9585.312968 7006.115783 0 9009 8679.07649 3847.488951 0 9010 6630.081203 7625.205803 0 9011 4857.933033 7720.230956 0 9012 96.088 6000.16243 0 9013 9040.338818 2793.845813 0 9014 4935.629544 7666.028588 0 9015 5071.410846 6150.520555 0 9016 9464.793346 8356.166593 0 9017 2675.818797 451.708559 0 9018 7397.603384 863.445657 0 9019 4185.906737 3743.642772 0 9020 9367.953161 4247.167104 0 9021 2776.483913 6347.24932 0 9022 8508.312518 135.292713 0 9023 230.58543 9784.746549 0 9024 7062.667695 1813.958376 0 9025 3571.744585 3236.600433 0 9026 9339.764306 7229.193582 0 9027 5034.298257 3338.487191 0 9028 2380.517468 6208.978355 0 9029 3047.347872 7291.546845 0 9030 6185.40623 9402.936565 0 9031 69.203622 1306.905512 0 9032 9023.115815 3590.451338 0 9033 7382.804011 3913.409424 0 9034 6536.790206 2708.067278 0 9035 562.012264 8624.526872 0 9036 5931.194111 7128.231928 0 9037 3064.353036 7670.368129 0 9038 674.109663 9867.433235 0 9039 9961.139452 7591.304348 0 9040 360.06436 200.095392 0 9041 1007.217615 3934.444371 0 9042 6269.352401 4961.19156 0 9043 4932.931397 412.964947 0 9044 7342.495877 6541.862253 0 9045 4676.864253 5859.239341 0 9046 5273.586201 7099.397658 0 9047 7444.410204 6869.801855 0 9048 3798.693663 486.591179 0 9049 5625.909723 3253.651151 0 9050 193.13777 4309.300406 0 9051 1285.460085 5858.450701 0 9052 4577.376427 8080.385818 0 9053 9848.114241 4181.022918 0 9054 9111.910559 9816.199952 0 9055 5114.181824 3647.65873 0 9056 5398.690151 9737.024498 0 9057 2163.700891 3399.65061 0 9058 249.486475 8979.003411 0 9059 4872.342059 1485.220645 0 9060 8407.031039 4901.863433 0 9061 9933.593929 2572.343883 0 9062 1358.402692 9588.092123 0 9063 5696.409992 7865.903122 0 9064 3231.191663 2528.387349 0 9065 9804.103759 5550.722458 0 9066 1092.717573 6669.126763 0 9067 7247.454753 5148.358461 0 9068 3948.551143 4962.588595 0 9069 1419.70664 7819.784319 0 9070 8119.217622 6454.980355 0 9071 451.650566 584.853964 0 9072 8481.961538 9158.143513 0 9073 7528.556537 1119.931167 0 9074 7649.17015 2328.986531 0 9075 5189.478014 5544.444503 0 9076 3901.966168 3432.352336 0 9077 197.768724 7999.990571 0 9078 4122.806987 3257.051868 0 9079 6395.868972 9052.944741 0 9080 3626.34826 8741.043611 0 9081 2252.164678 2396.569532 0 9082 9734.14495 8953.856021 0 9083 4651.615917 5693.334943 0 9084 2164.733195 7658.820577 0 9085 5523.233206 3415.11444 0 9086 9984.982348 185.528349 0 9087 8937.117289 7359.329369 0 9088 216.777527 1268.352193 0 9089 9145.273732 9142.70307 0 9090 8070.009654 9546.391906 0 9091 3866.801282 8538.439497 0 9092 9595.98993 6211.509944 0 9093 4029.964937 9982.38074 0 9094 7631.625356 2675.037125 0 9095 8178.93201 9563.792944 0 9096 7697.585241 2148.530061 0 9097 7124.078605 4209.074758 0 9098 1851.297666 1158.567079 0 9099 9592.932316 5007.120523 0 9100 3596.735604 6801.682152 0 9101 9035.216826 2023.186358 0 9102 9502.07387 3909.850723 0 9103 9672.017706 6150.247511 0 9104 9493.769137 4724.870242 0 9105 6964.496238 7582.019364 0 9106 984.047698 9071.860353 0 9107 7672.606787 1611.291966 0 9108 6554.569894 7708.000221 0 9109 647.484666 604.465232 0 9110 4642.579968 3846.211034 0 9111 2542.507168 6959.101515 0 9112 4608.330401 2602.963823 0 9113 1217.596491 4077.587203 0 9114 3125.063945 1411.135827 0 9115 3702.21873 5787.147035 0 9116 9738.291712 6773.930289 0 9117 1135.143062 2725.127335 0 9118 3144.212849 6261.767597 0 9119 9668.650513 6718.514279 0 9120 1535.431995 7008.836274 0 9121 4256.074824 7386.952059 0 9122 474.736034 3601.257984 0 9123 9643.770169 6228.9725 0 9124 3131.814802 2531.603461 0 9125 4290.690182 8063.025452 0 9126 7531.197098 2665.842733 0 9127 5803.038755 7137.972762 0 9128 841.219545 6604.90578 0 9129 621.768831 9950.224063 0 9130 6722.716021 8132.635461 0 9131 5847.076843 8386.506147 0 9132 7959.663896 5524.69298 0 9133 8100.246664 6793.034983 0 9134 2363.692088 1415.940901 0 9135 6799.032045 8776.141821 0 9136 1428.90336 9530.480232 0 9137 8538.997954 9004.054119 0 9138 4807.213154 2171.579801 0 9139 1301.970736 3641.240289 0 9140 8071.929352 5759.448237 0 9141 2031.711199 8460.174258 0 9142 2809.615541 8496.877576 0 9143 1623.775817 2946.960141 0 9144 1586.576892 2458.594181 0 9145 4928.421118 3751.244329 0 9146 6318.7753 1746.419255 0 9147 291.841288 818.59847 0 9148 7353.248755 9400.206638 0 9149 1573.506081 6432.602298 0 9150 1465.069212 9119.169174 0 9151 3877.282512 824.227254 0 9152 9710.607479 5246.083638 0 9153 5344.86086 3719.320476 0 9154 7111.402286 7769.982324 0 9155 9641.00744 6578.426223 0 9156 1978.071404 3441.899825 0 9157 1601.773739 8069.775241 0 9158 6422.176051 6218.120342 0 9159 8120.691174 5615.629179 0 9160 688.578928 4345.815776 0 9161 5504.901037 2335.422214 0 9162 4002.88041 2347.834612 0 9163 7797.87864 2752.527945 0 9164 4848.362459 1835.77128 0 9165 5598.161444 7405.675451 0 9166 3562.447749 8000.957315 0 9167 3738.740145 2868.89725 0 9168 2101.557333 4549.11867 0 9169 5990.723819 381.846502 0 9170 940.123851 6816.070111 0 9171 1207.549367 3327.357605 0 9172 7081.285245 3167.989752 0 9173 3186.65428 7686.271719 0 9174 5326.954228 5897.106577 0 9175 9303.348736 9220.796741 0 9176 3637.724243 7460.603731 0 9177 7569.031169 1784.366602 0 9178 70.051623 6612.66003 0 9179 9057.442205 7978.709902 0 9180 8075.616467 8307.020554 0 9181 6128.005051 8514.180938 0 9182 8319.16363 4825.127131 0 9183 1311.046543 9800.938225 0 9184 6370.019319 1411.804191 0 9185 9602.175653 5233.637274 0 9186 8263.137412 5825.112725 0 9187 7057.941478 7598.738514 0 9188 9959.472853 3993.503634 0 9189 5039.207455 465.169325 0 9190 9131.775102 6579.648989 0 9191 5914.087678 8787.836788 0 9192 684.343593 2130.769544 0 9193 9873.574405 9274.219399 0 9194 2838.193921 8335.64926 0 9195 2143.098053 3851.368383 0 9196 7352.507835 6165.574467 0 9197 6645.466639 1723.939728 0 9198 2150.93399 3088.807795 0 9199 4396.487313 2667.641909 0 9200 3369.262871 9128.853287 0 9201 6382.214292 9951.082878 0 9202 7632.949111 9714.042969 0 9203 7436.812547 6192.761711 0 9204 2061.258493 3397.9079 0 9205 8706.686648 174.95755 0 9206 9736.214883 8141.861297 0 9207 2381.779581 8464.44992 0 9208 942.525369 4102.103847 0 9209 8016.378019 8539.694016 0 9210 625.188934 4255.415166 0 9211 8029.608505 4100.204565 0 9212 3735.682998 9483.91436 0 9213 1427.733863 2386.699027 0 9214 6226.787094 5255.396305 0 9215 3499.89441 1945.557672 0 9216 5841.839846 7712.577765 0 9217 449.409295 1780.677713 0 9218 4773.086317 6448.008037 0 9219 3078.339705 7736.757388 0 9220 1530.235756 1593.897238 0 9221 3494.290095 4833.414742 0 9222 9242.600996 6137.069386 0 9223 7768.552275 7428.405842 0 9224 5940.739542 4909.816371 0 9225 4622.457291 1298.602763 0 9226 6787.122176 6619.26956 0 9227 8512.346292 6539.72144 0 9228 487.920314 1569.651994 0 9229 3741.616992 3466.849424 0 9230 1440.627133 8650.083807 0 9231 7570.786396 9337.073688 0 9232 8907.30981 9299.823015 0 9233 3413.820673 8258.373717 0 9234 4748.207248 8900.544322 0 9235 8069.515993 1234.499135 0 9236 4392.212656 5497.491202 0 9237 5135.471637 7268.750645 0 9238 5459.33035 6147.209316 0 9239 7621.960177 3883.580637 0 9240 3052.164759 164.243255 0 9241 7510.67563 5427.194865 0 9242 7830.046535 4243.191005 0 9243 4776.196793 6936.040565 0 9244 8867.091523 3658.019908 0 9245 7850.867885 6527.825234 0 9246 1210.834029 7128.407022 0 9247 8210.905822 6634.810543 0 9248 1642.498412 8541.180851 0 9249 5472.457186 7812.424082 0 9250 5840.679348 9712.288712 0 9251 1905.042527 9414.995017 0 9252 8029.760862 5781.964925 0 9253 9660.539974 258.021514 0 9254 315.592957 648.646567 0 9255 440.095681 3373.661425 0 9256 3341.388959 501.538236 0 9257 6533.393309 2883.155878 0 9258 9054.68741 2437.370508 0 9259 6030.349338 5181.373672 0 9260 9352.403436 4789.428662 0 9261 9400.231942 8634.002407 0 9262 2518.445277 836.101727 0 9263 6645.143296 2214.568902 0 9264 1306.322102 7167.372004 0 9265 927.880916 739.242322 0 9266 3610.038181 8798.48446 0 9267 5019.804274 1815.787102 0 9268 4016.311757 4653.323228 0 9269 3977.734108 2278.072593 0 9270 9652.435773 2942.258178 0 9271 9573.479751 9643.224546 0 9272 7124.459278 8232.35492 0 9273 9861.601416 5511.382309 0 9274 9864.162394 3982.891807 0 9275 3435.503188 3092.188807 0 9276 5168.68421 364.526123 0 9277 7804.024668 5110.354076 0 9278 1716.725214 1311.683736 0 9279 7507.318243 3482.36874 0 9280 6368.446595 7857.806236 0 9281 4282.02321 8987.378099 0 9282 3512.706351 5522.953026 0 9283 7343.257949 519.807935 0 9284 6653.402117 9365.518639 0 9285 583.472902 44.002626 0 9286 559.427067 1058.372896 0 9287 1269.921079 8623.785933 0 9288 8068.719561 2019.512647 0 9289 4185.963229 7007.214263 0 9290 306.497479 4620.817415 0 9291 6210.504256 2451.323095 0 9292 6978.683428 8568.497125 0 9293 2684.91692 3367.017671 0 9294 5070.724535 8208.101109 0 9295 2910.693158 9376.784987 0 9296 5798.216481 9941.329699 0 9297 4518.166969 5256.058452 0 9298 6911.245607 7362.728057 0 9299 5351.186328 5646.924642 0 9300 9817.960239 5625.478932 0 9301 9141.759607 3217.247893 0 9302 7586.313965 5938.927939 0 9303 4108.306789 235.924183 0 9304 8916.330588 4907.152487 0 9305 8688.342995 8175.289549 0 9306 2890.488682 6032.013946 0 9307 8382.118859 6748.181983 0 9308 8323.105599 4531.435708 0 9309 1706.405529 842.995373 0 9310 8703.907485 1536.241452 0 9311 6409.879751 3311.436905 0 9312 5956.441768 4524.187568 0 9313 2636.373614 2092.098839 0 9314 1031.003806 5371.577819 0 9315 2944.287497 7760.643577 0 9316 8092.481099 3768.565647 0 9317 7592.842953 7494.315462 0 9318 8914.229914 7123.30652 0 9319 8837.629743 1870.864485 0 9320 9860.651564 2875.582932 0 9321 7802.732395 7932.700233 0 9322 4898.096665 9116.64161 0 9323 404.899137 3065.874804 0 9324 2173.721527 359.23228 0 9325 5412.981768 1979.122933 0 9326 2750.354534 5708.666165 0 9327 7907.945126 1116.734417 0 9328 1181.234046 8779.49586 0 9329 309.370728 5183.289418 0 9330 6177.003188 733.008723 0 9331 4058.697885 8871.823591 0 9332 7441.092036 7423.55298 0 9333 6100.243256 7017.42219 0 9334 5276.275937 2087.235442 0 9335 9418.740956 7625.371892 0 9336 7353.953456 638.347639 0 9337 2237.116276 6163.054459 0 9338 6921.553044 4472.315789 0 9339 5692.098652 1082.964046 0 9340 9004.682532 3640.08853 0 9341 5236.908839 590.14122 0 9342 3906.566009 5731.051678 0 9343 1736.169879 7905.481159 0 9344 7740.502533 9666.759654 0 9345 5787.485832 1879.231075 0 9346 3887.027632 7662.272788 0 9347 4065.974855 4418.592397 0 9348 6423.03289 4325.021211 0 9349 3969.893855 5917.32939 0 9350 5353.432088 2178.789658 0 9351 9696.875615 992.737485 0 9352 9311.306166 8822.049745 0 9353 4111.672423 6426.038616 0 9354 319.993179 5764.537355 0 9355 1976.2228 7344.336738 0 9356 5200.561732 4609.494569 0 9357 3920.859497 8706.915868 0 9358 7957.263498 7466.94267 0 9359 6775.26822 5179.170012 0 9360 5508.248351 2801.316504 0 9361 1835.460251 4972.749673 0 9362 7864.904177 6521.043389 0 9363 2117.021479 5779.553923 0 9364 43.254322 7931.309209 0 9365 2143.455664 4838.333376 0 9366 5297.720003 7865.687049 0 9367 461.293198 1432.867253 0 9368 6638.518576 2075.799462 0 9369 8803.668316 7865.871816 0 9370 9262.762079 8884.302625 0 9371 4930.484487 9430.587181 0 9372 3287.988522 7958.223715 0 9373 7234.90027 2909.485347 0 9374 9756.155719 1412.817758 0 9375 7010.369354 2533.163205 0 9376 1625.884322 6842.018684 0 9377 8238.839262 5769.797964 0 9378 4453.676101 8029.01394 0 9379 9876.331164 7953.922722 0 9380 5776.450308 5780.945172 0 9381 1534.594919 3778.310829 0 9382 3068.277426 9127.459108 0 9383 5605.296749 2660.304253 0 9384 7858.454435 6645.937762 0 9385 2847.842793 1494.217059 0 9386 5913.511131 914.459084 0 9387 3724.906216 3218.591985 0 9388 2930.505016 7167.449705 0 9389 2020.776433 4551.789928 0 9390 285.132988 292.534406 0 9391 7971.342235 609.300505 0 9392 4607.508875 9767.500543 0 9393 9654.293484 9985.797659 0 9394 1648.480498 6022.39924 0 9395 6840.948236 5525.222935 0 9396 774.406964 5951.426395 0 9397 4717.72083 9908.041499 0 9398 6808.696013 9644.466631 0 9399 6877.715742 5186.670006 0 9400 8762.446221 7531.9658 0 9401 9802.965163 5071.14663 0 9402 6886.963807 8965.455669 0 9403 8292.046451 3464.539227 0 9404 8636.731623 1046.393676 0 9405 75.548441 83.224799 0 9406 9114.926109 9317.007327 0 9407 6372.471649 7455.586509 0 9408 5261.868323 4940.085146 0 9409 7147.041301 3718.177945 0 9410 234.816336 7951.275143 0 9411 7173.223477 6880.86597 0 9412 2877.589453 9781.113163 0 9413 8856.189505 7319.497203 0 9414 188.508145 9048.932568 0 9415 5052.943196 6849.50519 0 9416 8966.58165 5346.319167 0 9417 670.636476 2521.688788 0 9418 3772.396823 7175.66922 0 9419 1550.302868 1865.900802 0 9420 5688.242779 8146.974091 0 9421 5268.080676 1760.501211 0 9422 7945.096797 3667.06726 0 9423 6353.471598 5121.937518 0 9424 3215.919026 2843.525461 0 9425 7001.843817 4001.13045 0 9426 6243.675391 2547.043347 0 9427 9114.429512 9725.041911 0 9428 7540.179494 5250.053518 0 9429 2977.803958 2629.539708 0 9430 9663.093154 9301.981787 0 9431 6932.181485 8606.603429 0 9432 3577.939073 5821.187435 0 9433 4765.622895 7392.630363 0 9434 9644.013058 5113.2928 0 9435 6010.509598 7980.677866 0 9436 5310.863808 3855.719519 0 9437 7720.989242 7449.776655 0 9438 1373.324662 4177.592895 0 9439 7423.494126 7263.418467 0 9440 9957.958747 461.966889 0 9441 7301.328181 1889.5707 0 9442 521.496711 2884.894293 0 9443 7408.376137 9047.051804 0 9444 4551.502585 161.231051 0 9445 738.175297 9407.319929 0 9446 8485.544801 5255.858448 0 9447 1989.87494 9075.030195 0 9448 2610.670388 5751.706435 0 9449 7260.095054 7973.326772 0 9450 117.385566 5604.969392 0 9451 2832.082617 5853.3203 0 9452 4879.198164 422.446976 0 9453 9969.17961 7730.184571 0 9454 6807.377725 9227.897928 0 9455 5924.245516 1753.373598 0 9456 9700.352475 523.19712 0 9457 554.616034 6409.621971 0 9458 3317.867212 5502.802647 0 9459 3315.050955 3920.183567 0 9460 7059.096714 6206.428851 0 9461 9376.173513 3363.806629 0 9462 4185.887418 9540.664536 0 9463 9062.800429 1121.894476 0 9464 7929.675252 7883.903653 0 9465 2571.094569 7092.524216 0 9466 9972.517552 2101.641735 0 9467 7685.469975 9618.332513 0 9468 2060.541833 5137.390099 0 9469 9840.17244 5004.331812 0 9470 6219.284009 6837.907306 0 9471 4235.71053 7997.706346 0 9472 2008.151638 1145.122983 0 9473 7313.953627 5422.523646 0 9474 3892.186319 3994.908526 0 9475 4171.524706 3586.357165 0 9476 9601.549177 5277.823298 0 9477 7164.472863 2920.927192 0 9478 1463.397372 3944.293631 0 9479 7297.559945 7114.947848 0 9480 6115.198646 2291.762847 0 9481 7299.543243 536.622878 0 9482 2629.642156 2936.322241 0 9483 788.5207 6393.144132 0 9484 5925.418103 3180.615235 0 9485 8612.897959 9247.34145 0 9486 2391.722665 5456.351808 0 9487 9046.888866 2175.832653 0 9488 988.309009 6660.328658 0 9489 8084.972828 1028.539355 0 9490 6855.036616 7251.003785 0 9491 2300.801735 2941.899375 0 9492 6677.023228 3259.260337 0 9493 309.843409 1209.6305 0 9494 1042.756517 7832.546904 0 9495 5482.627291 1958.981695 0 9496 2928.091282 5829.425574 0 9497 1676.146735 4986.61839 0 9498 6753.939521 6097.603397 0 9499 5880.353525 2222.042486 0 9500 8143.751887 2696.144747 0 9501 8481.310644 2135.675679 0 9502 7415.826641 2276.336737 0 9503 8953.416776 8848.532334 0 9504 7795.068212 6650.612377 0 9505 7197.741978 957.573486 0 9506 3088.314398 7427.351896 0 9507 5026.036707 5992.436802 0 9508 1772.748052 512.094085 0 9509 7305.843925 6072.849918 0 9510 118.370197 1155.227458 0 9511 5071.547291 6676.648037 0 9512 8127.496886 1825.820683 0 9513 9733.671201 9135.94618 0 9514 93.726793 3958.990041 0 9515 8585.415462 302.194582 0 9516 7821.002683 5999.376027 0 9517 8267.885176 8703.04012 0 9518 6467.429387 8299.620164 0 9519 5933.834048 564.359284 0 9520 5176.252501 6863.592241 0 9521 8433.812338 1841.135403 0 9522 6632.520903 371.331755 0 9523 8617.212878 2773.580257 0 9524 5679.668325 7852.301344 0 9525 7729.36411 1298.061762 0 9526 7522.579112 1608.266645 0 9527 9192.88852 5363.712219 0 9528 4104.409909 3851.296728 0 9529 2787.650977 1021.259955 0 9530 1522.095028 8247.90403 0 9531 5453.786434 5122.616202 0 9532 1601.062659 8618.802486 0 9533 9363.285122 6484.82064 0 9534 1971.376606 6560.832832 0 9535 9873.63806 6267.4662 0 9536 6004.366414 5146.280509 0 9537 3520.390745 9802.500146 0 9538 9450.178267 256.694585 0 9539 4526.1322 2115.225712 0 9540 7072.726333 1388.419826 0 9541 5496.985791 6933.558822 0 9542 5837.221933 3021.565474 0 9543 5221.03046 6695.929895 0 9544 8039.580467 3391.667791 0 9545 5622.591489 3648.729833 0 9546 1045.181086 5624.864094 0 9547 2138.630537 3158.115095 0 9548 4965.75928 9123.657016 0 9549 9537.192567 9535.409022 0 9550 2758.537904 4591.748228 0 9551 926.122442 1658.645174 0 9552 9921.475099 4952.395643 0 9553 3755.726945 5905.885717 0 9554 7517.846633 9227.658592 0 9555 7274.331766 1714.882584 0 9556 4381.519916 7587.328078 0 9557 811.12258 555.634329 0 9558 8072.152291 3641.714999 0 9559 8646.729091 547.48088 0 9560 9385.736079 6081.10923 0 9561 2395.674931 9801.278678 0 9562 3296.486532 4403.882965 0 9563 3875.858113 6855.288598 0 9564 7299.125913 6994.08043 0 9565 3186.346186 716.981359 0 9566 511.536844 8859.485495 0 9567 54.170934 3752.515452 0 9568 7880.493811 2453.315468 0 9569 402.716519 2227.815942 0 9570 369.031568 2780.181036 0 9571 2746.785984 4947.031502 0 9572 2660.175261 2346.34855 0 9573 9657.184666 6479.23019 0 9574 2281.169497 5062.691503 0 9575 6650.118826 8568.742742 0 9576 89.532574 6258.252385 0 9577 2037.24669 2439.181244 0 9578 7011.616688 1263.70259 0 9579 9265.286752 7168.872839 0 9580 2795.680638 2124.801717 0 9581 7004.14236 5640.570685 0 9582 1998.681773 1160.36021 0 9583 8108.53208 3668.008044 0 9584 7814.295967 4983.386918 0 9585 9237.942612 2243.457056 0 9586 6778.121372 5221.149088 0 9587 1969.197804 9257.540763 0 9588 1692.045434 9457.504943 0 9589 9743.329075 552.09336 0 9590 7754.814025 5419.299506 0 9591 2180.29054 7270.234893 0 9592 5877.342528 3701.304608 0 9593 6045.935669 9495.159616 0 9594 7586.895349 4239.469942 0 9595 5703.940035 6057.179015 0 9596 7835.637443 8394.643122 0 9597 2652.623671 7060.397737 0 9598 4621.49391 7098.520866 0 9599 8969.855057 510.502396 0 9600 6.600367 4700.43321 0 9601 865.07245 3778.85547 0 9602 3843.984915 2268.834679 0 9603 300.415263 987.781865 0 9604 4416.911541 3412.540301 0 9605 49.324458 5954.091404 0 9606 8213.760751 4532.540015 0 9607 9972.720101 7150.554922 0 9608 5143.999244 8362.808 0 9609 5777.668627 3324.266196 0 9610 6363.485873 5397.191169 0 9611 5402.499404 2421.008222 0 9612 7550.633241 7384.701751 0 9613 3551.502012 3363.210149 0 9614 8529.176051 1991.299128 0 9615 3952.114612 3870.000826 0 9616 5699.073093 1066.560273 0 9617 9115.334477 3941.840293 0 9618 6601.828041 8773.699667 0 9619 8471.46614 755.628141 0 9620 7053.105818 8463.246895 0 9621 3401.080216 2040.567671 0 9622 9666.296826 2986.499036 0 9623 9699.841787 5070.751582 0 9624 3217.394881 4548.437767 0 9625 6491.317683 3387.460384 0 9626 104.817236 9608.289942 0 9627 3952.738794 3991.678153 0 9628 4950.573354 3880.519849 0 9629 7815.921543 4699.190973 0 9630 5931.703896 6279.05539 0 9631 1524.194553 7836.052115 0 9632 8417.123064 1659.493454 0 9633 4334.597061 7083.680123 0 9634 9997.333715 6345.167232 0 9635 8977.252093 7548.840052 0 9636 3352.900626 2912.94376 0 9637 2611.002676 7909.650619 0 9638 4628.093161 46.646656 0 9639 7722.273014 62.182796 0 9640 5467.657378 5910.072706 0 9641 6508.527773 1260.46707 0 9642 1647.743754 2082.242091 0 9643 899.30924 7225.182453 0 9644 7533.511836 4591.517736 0 9645 1016.614669 2346.690231 0 9646 3689.862727 8161.93158 0 9647 3863.747019 279.484769 0 9648 6704.270175 1476.27781 0 9649 534.184683 7791.165936 0 9650 156.400252 7932.615064 0 9651 8452.145215 3575.671934 0 9652 208.921458 2117.199674 0 9653 8384.064441 4017.283427 0 9654 3384.995246 1017.251194 0 9655 5938.379749 2376.707347 0 9656 5727.44236 2583.666513 0 9657 108.014652 6793.050451 0 9658 3540.216042 8826.38381 0 9659 9320.684795 6924.344129 0 9660 2585.894401 8470.320224 0 9661 4002.790922 4450.623084 0 9662 4555.065536 9160.371563 0 9663 4298.400302 409.045442 0 9664 8869.911689 3509.585116 0 9665 2934.704457 4275.666632 0 9666 5488.313655 416.660076 0 9667 1096.319443 3503.357667 0 9668 8352.752369 3542.104385 0 9669 7326.460001 3818.797062 0 9670 3818.877808 3871.631011 0 9671 6383.097458 8886.571124 0 9672 9701.654258 4607.873669 0 9673 7191.974287 9375.655352 0 9674 9935.529684 2345.468444 0 9675 4699.131178 7671.917128 0 9676 4259.208392 6934.457144 0 9677 3280.344446 8567.009939 0 9678 7047.095722 1321.536127 0 9679 6422.149779 2783.074805 0 9680 3245.819043 7591.067118 0 9681 302.175377 5944.757835 0 9682 3917.025525 9439.892956 0 9683 4368.735653 8670.23774 0 9684 2865.893419 4973.40726 0 9685 5232.629635 1494.872531 0 9686 9082.709107 7774.550408 0 9687 963.779126 5492.017419 0 9688 6664.455803 7588.025606 0 9689 2236.07113 9432.836317 0 9690 6152.519313 3333.126797 0 9691 4950.86872 7654.859519 0 9692 7717.925878 3741.458026 0 9693 1695.973255 503.999021 0 9694 7641.230202 7623.806733 0 9695 6281.725147 9085.576748 0 9696 3551.061472 5059.58223 0 9697 7056.298565 2251.908548 0 9698 9735.42178 1464.969294 0 9699 6002.503724 9316.802643 0 9700 2436.877065 4932.879354 0 9701 7472.953922 7129.509132 0 9702 703.051694 3633.137245 0 9703 5397.729159 5813.11368 0 9704 7901.408351 6079.086186 0 9705 7373.35294 6490.183965 0 9706 2659.769722 573.793624 0 9707 5367.568676 6016.264862 0 9708 7182.299877 4205.318917 0 9709 1952.437356 5323.896819 0 9710 7394.5262 4907.351948 0 9711 9008.765426 1060.535128 0 9712 2625.262732 130.439085 0 9713 8001.141092 4746.140365 0 9714 2994.057704 8814.050646 0 9715 8581.530714 6354.9783 0 9716 9223.068548 4209.414422 0 9717 5833.38145 4148.073792 0 9718 9207.939549 7304.916841 0 9719 5373.700873 947.013192 0 9720 8963.853726 5113.297647 0 9721 3361.137911 7037.248336 0 9722 5095.474826 4550.001335 0 9723 7153.827298 340.838401 0 9724 6796.830607 5113.589381 0 9725 7486.477894 9395.989664 0 9726 8311.834872 130.030807 0 9727 4512.254302 3522.932285 0 9728 3148.079657 9363.961056 0 9729 7476.166453 5868.763338 0 9730 385.174116 1152.904386 0 9731 4303.309542 8992.329405 0 9732 8832.438328 4699.911281 0 9733 1628.714095 4925.495853 0 9734 7438.758544 404.597033 0 9735 4393.894967 7756.369035 0 9736 6543.522157 9477.48212 0 9737 4186.543023 7131.622158 0 9738 7266.31208 1487.659003 0 9739 3760.08638 5540.658922 0 9740 5858.894113 8.337119 0 9741 6534.76909 5386.60937 0 9742 9759.589247 3270.104523 0 9743 3082.126381 5238.700194 0 9744 4741.690061 1603.637574 0 9745 4870.475205 1049.05159 0 9746 5255.630411 5821.009087 0 9747 7756.95852 4166.902667 0 9748 9062.849083 1908.870419 0 9749 7433.620885 5675.571502 0 9750 2503.283955 173.230705 0 9751 1651.367754 743.856095 0 9752 4894.948202 6766.712016 0 9753 4931.314081 6505.72726 0 9754 7067.126154 6869.764126 0 9755 276.593521 7754.621151 0 9756 8440.955478 1281.548196 0 9757 1763.288758 6530.978568 0 9758 1396.766799 409.445788 0 9759 9260.136834 6362.781241 0 9760 2678.633265 6486.988808 0 9761 3980.844693 3856.182867 0 9762 1087.270057 9352.019007 0 9763 4388.561004 7016.374599 0 9764 9206.888706 6473.991318 0 9765 7059.559529 6489.35678 0 9766 925.16246 3273.153056 0 9767 8877.320238 3173.704256 0 9768 2527.780536 3725.862846 0 9769 922.620047 4170.471941 0 9770 8500.919908 6037.740365 0 9771 5245.160485 4983.960082 0 9772 6030.65779 3076.262935 0 9773 8069.439061 6014.390681 0 9774 5425.030919 2115.303141 0 9775 7594.985101 9194.347985 0 9776 3840.353279 2762.722174 0 9777 7477.406546 1401.988878 0 9778 1311.360453 9180.03842 0 9779 1017.110907 699.483269 0 9780 9254.528937 9834.672127 0 9781 3497.027359 7029.215709 0 9782 5626.836675 2111.368676 0 9783 5477.615557 4092.193638 0 9784 338.002496 3339.281505 0 9785 9898.61043 2602.13059 0 9786 2221.092473 770.266913 0 9787 8164.24544 5071.423473 0 9788 7993.935663 6619.660695 0 9789 1092.777266 5197.664898 0 9790 858.233583 1776.215686 0 9791 8880.905342 9179.020979 0 9792 5890.455213 4092.598253 0 9793 4545.556914 8826.385737 0 9794 1734.681358 9899.30576 0 9795 4285.809415 4765.424958 0 9796 2716.316608 453.526966 0 9797 6267.903082 7641.504722 0 9798 1039.896325 3131.001808 0 9799 2553.283118 1395.072249 0 9800 7305.275387 6245.142225 0 9801 660.235128 1283.660392 0 9802 3930.288558 6027.008711 0 9803 6288.543803 6752.479348 0 9804 8806.945643 8459.816907 0 9805 9260.061433 6528.29511 0 9806 8416.695158 4692.778494 0 9807 3054.659532 4442.796678 0 9808 695.715967 1738.424169 0 9809 4308.025078 516.131561 0 9810 2798.899261 6538.881969 0 9811 8884.076119 6756.816746 0 9812 2559.710089 4064.32592 0 9813 7318.574037 1575.36013 0 9814 9939.215268 2629.032223 0 9815 8963.709218 9731.879337 0 9816 5335.320062 7632.83178 0 9817 1888.745523 5509.759469 0 9818 4603.183441 7650.557579 0 9819 6289.940091 7534.464546 0 9820 3178.963923 3927.06298 0 9821 3295.421124 7038.887172 0 9822 2329.609525 9841.139462 0 9823 7657.71908 7553.604033 0 9824 1234.657731 5866.224057 0 9825 5104.09866 3259.502043 0 9826 6446.154554 8485.846805 0 9827 6739.227742 1125.366923 0 9828 8365.431143 9437.214195 0 9829 8150.464017 8299.505234 0 9830 7728.989876 7802.282709 0 9831 9658.70546 3450.977443 0 9832 5364.231473 5990.319321 0 9833 3482.667428 2536.287001 0 9834 3307.732862 3425.092767 0 9835 448.576598 9302.172369 0 9836 4609.158114 289.563407 0 9837 5871.727492 8345.463505 0 9838 9829.803717 442.373038 0 9839 5752.979789 8264.895937 0 9840 1722.838101 9335.501584 0 9841 7747.599561 4871.298165 0 9842 3733.726879 2256.095104 0 9843 7004.504384 2591.085212 0 9844 7659.921814 1489.52178 0 9845 5025.461998 7996.093339 0 9846 48.305658 3033.299237 0 9847 5765.853509 2538.268171 0 9848 2614.086266 3308.271272 0 9849 6319.470695 9121.683512 0 9850 3889.503875 6126.52885 0 9851 2701.632568 9207.064481 0 9852 4310.877347 3854.082966 0 9853 460.143623 721.216577 0 9854 793.905984 3090.405552 0 9855 2362.482456 2578.975837 0 9856 662.699342 3953.783731 0 9857 9937.554501 744.750917 0 9858 1903.234045 1533.60269 0 9859 5704.990796 6676.505326 0 9860 9254.446203 2763.758848 0 9861 7622.76607 2442.997028 0 9862 2593.333315 493.254427 0 9863 8353.343835 2731.749852 0 9864 5805.394709 969.926956 0 9865 5278.606708 9205.530647 0 9866 2693.580536 6002.118445 0 9867 1860.490277 3304.075263 0 9868 3336.306085 2739.037624 0 9869 4033.856303 4454.643724 0 9870 951.135264 5051.548217 0 9871 1794.274756 5721.125229 0 9872 7090.024706 3591.848315 0 9873 8051.942208 9141.273368 0 9874 685.579341 4407.179521 0 9875 8395.529906 2807.416487 0 9876 330.544706 4539.044147 0 9877 9371.139794 1054.608481 0 9878 8616.423676 5008.856827 0 9879 5106.413025 1859.412745 0 9880 8496.102653 7729.550162 0 9881 8258.074841 5721.577661 0 9882 9604.300111 6671.6483 0 9883 1824.63411 3926.453649 0 9884 8580.892731 7059.894856 0 9885 5957.832812 3134.857955 0 9886 1286.848758 9219.838668 0 9887 2678.04041 9069.714445 0 9888 4490.019738 7006.709191 0 9889 1132.658383 1306.141885 0 9890 6250.738342 4993.050463 0 9891 6177.838967 6579.129218 0 9892 3136.050611 5202.565551 0 9893 369.486239 8748.336807 0 9894 1463.281288 1837.656768 0 9895 1370.114382 127.65073 0 9896 8516.984474 7660.593344 0 9897 2672.264366 3088.682965 0 9898 6511.533264 6992.722668 0 9899 1595.515337 8314.509978 0 9900 8122.714196 6689.927374 0 9901 318.974777 503.476022 0 9902 990.374594 6991.222091 0 9903 6254.295629 2704.771762 0 9904 4038.501211 2011.284409 0 9905 2596.98384 6992.64269 0 9906 6535.205313 1611.907239 0 9907 1617.157849 8906.04544 0 9908 9525.379552 3257.590659 0 9909 648.945305 3382.174361 0 9910 1740.508034 3184.062632 0 9911 4587.530136 9760.312046 0 9912 793.749432 425.220487 0 9913 2254.925528 4959.880817 0 9914 9660.52158 2288.942347 0 9915 8017.814797 3001.575657 0 9916 9322.862378 5048.501107 0 9917 5637.002302 6133.664171 0 9918 1801.863369 6078.563627 0 9919 2386.869854 3032.255296 0 9920 3071.371766 3523.660147 0 9921 5312.51667 2320.944155 0 9922 126.903365 1279.089569 0 9923 592.936001 6816.027281 0 9924 3590.743722 5127.926753 0 9925 3596.958588 6618.774563 0 9926 9143.466116 7609.961284 0 9927 2217.113857 3651.208305 0 9928 1461.231247 9232.071642 0 9929 3674.95317 5639.111413 0 9930 130.534538 6709.260508 0 9931 7980.24703 4949.401922 0 9932 5464.032492 1609.289674 0 9933 8793.46754 3266.448359 0 9934 7060.814425 646.700922 0 9935 931.674231 678.250023 0 9936 5763.210195 9652.894434 0 9937 7040.559095 2870.37473 0 9938 1596.813284 2868.25654 0 9939 578.617492 6628.345669 0 9940 1252.895219 6094.23248 0 9941 1179.740504 9664.34354 0 9942 1160.930271 6862.15236 0 9943 6749.572239 6744.301107 0 9944 3562.486441 6420.059409 0 9945 1892.882914 4157.529693 0 9946 6177.230187 8242.779383 0 9947 7773.500218 7215.387054 0 9948 8016.06097 578.65405 0 9949 7142.986591 4256.807917 0 9950 8288.219474 2897.403741 0 9951 4715.205409 1598.680894 0 9952 4135.501696 9218.810446 0 9953 2070.328401 1866.795351 0 9954 4132.09549 7399.114171 0 9955 1674.94099 8874.48048 0 9956 418.922588 4712.838987 0 9957 864.441156 1879.016858 0 9958 6074.002414 9306.914242 0 9959 289.710753 6038.876933 0 9960 1624.739838 4588.827968 0 9961 8431.883973 1121.337121 0 9962 5843.465201 8592.482601 0 9963 5921.082444 3478.051065 0 9964 4230.223172 5890.877846 0 9965 2905.613433 8936.813162 0 9966 6491.060805 2341.060757 0 9967 7841.614482 9225.42811 0 9968 3637.667 4355.083089 0 9969 5232.211774 6720.960208 0 9970 6441.698771 1881.547731 0 9971 855.762263 2156.098842 0 9972 1209.199054 4804.786926 0 9973 1412.917635 9404.508265 0 9974 3149.276076 6482.613172 0 9975 5857.910032 5228.176224 0 9976 6623.136871 587.527036 0 9977 5063.309181 9500.041261 0 9978 9581.762079 2923.301613 0 9979 1913.954256 5065.947726 0 9980 4643.347796 6619.372059 0 9981 1262.036684 7872.453742 0 9982 6509.649446 5824.387736 0 9983 5882.956664 6670.624468 0 9984 8859.728934 6623.885421 0 9985 7450.748361 9191.168887 0 9986 420.891456 1185.663318 0 9987 3609.95934 2378.666383 0 9988 8286.278682 3612.372626 0 9989 6457.924554 6467.713858 0 9990 822.366472 7957.037798 0 9991 6530.693909 6038.384096 0 9992 7979.157853 494.970227 0 9993 7031.52261 5389.400152 0 9994 9651.75414 8732.030476 0 9995 3803.331596 740.769935 0 9996 8785.117618 8228.75444 0 9997 4208.992814 1032.834526 0 9998 740.091589 3954.276331 0 9999 3089.274532 7520.692883 0 10000 5000.611279 34996.01168 0 10001 -24995.77061 -14997.95813 0 10002 34996.99316 -14997.95813 0
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/meshes/r10k.1.poly
0 2 0 0 3 1 0 10002 10000 1 1 10001 10002 1 2 10000 10001 1 0
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/meshes/r10k.node
10000 2 0 0 0 8444.218515 7579.544029 0 1 4205.715808 2589.167503 0 2 5112.747214 4049.341375 0 3 7837.985890 3033.127261 0 4 4765.969542 5833.820395 0 5 9081.128852 5046.868558 0 6 2818.378444 7558.042042 0 7 6183.689967 2505.063414 0 8 9097.462560 9827.854760 0 9 8102.172360 9021.659504 0 10 3101.475693 7298.317483 0 11 8988.382880 6839.839319 0 12 4721.427155 1007.012081 0 13 4341.718355 6108.869734 0 14 9130.110532 9666.063678 0 15 4770.097766 8653.099278 0 16 2604.923104 8050.278270 0 17 5486.993038 140.417002 0 18 7197.046864 3988.235422 0 19 8248.449771 6681.532012 0 20 11.428193 4935.778665 0 21 8676.027755 2439.108769 0 22 3252.043627 8704.712321 0 23 1910.670915 5675.107406 0 24 2386.159286 9675.402503 0 25 8031.794693 4479.695714 0 26 804.458186 3200.546047 0 27 5079.406425 9328.338242 0 28 1090.578459 5512.672461 0 29 7065.614099 5474.409113 0 30 8144.668633 5402.836070 0 31 9638.385460 6031.856280 0 32 5876.170642 4449.890263 0 33 5962.868616 3849.011460 0 34 5756.510142 2903.295024 0 35 1893.913286 1867.295283 0 36 6127.731799 6566.593890 0 37 4765.309920 898.243612 0 38 7576.039220 8767.703708 0 39 9233.810159 8424.602231 0 40 8981.731214 9230.824398 0 41 5405.999249 3912.960502 0 42 7052.833999 2756.341213 0 43 8116.287085 8494.859652 0 44 8950.389674 5898.011835 0 45 9497.648732 5796.950107 0 46 4505.631066 6602.453786 0 47 9962.578394 9169.412179 0 48 7933.250841 823.729882 0 49 6127.831050 4864.442020 0 50 6301.473404 8450.775757 0 51 2430.356221 7314.892208 0 52 1171.342932 2204.605369 0 53 7945.829717 3325.361492 0 54 8159.130965 1006.075202 0 55 1463.584889 6976.706402 0 56 452.340679 5738.660368 0 57 9100.160147 5341.979683 0 58 6805.891326 266.967947 0 59 6349.999099 6063.384178 0 60 5759.529480 3912.094093 0 61 3701.399403 9805.166506 0 62 363.920376 216.365099 0 63 9610.312802 1849.719414 0 64 1238.951644 2105.765099 0 65 8007.465904 9369.691586 0 66 227.825757 4256.188320 0 67 1015.002194 2599.198898 0 68 2208.292713 6469.257198 0 69 3502.939674 1803.179015 0 70 5036.365052 393.787071 0 71 1009.212412 9882.351487 0 72 1993.557905 3585.553013 0 73 7315.983062 8383.265652 0 74 9184.820620 1694.246061 0 75 6726.405636 9665.489030 0 76 580.509438 6762.017843 0 77 8454.245937 3423.125411 0 78 2506.873393 5967.913935 0 79 4423.140337 1748.194845 0 80 4716.254151 4099.053957 0 81 5691.127395 5086.001301 0 82 3114.460010 3571.516826 0 83 8376.611744 2509.326648 0 84 5606.002189 124.363188 0 85 7415.743774 3359.165545 0 86 456.964936 2808.831642 0 87 2401.304078 9531.293398 0 88 3522.255615 2878.779149 0 89 3592.011973 9469.058357 0 90 6337.478522 6210.768456 0 91 7156.193503 3880.172353 0 92 4144.179883 6508.328623 0 93 15.242219 1923.095412 0 94 3344.016907 2394.159602 0 95 6373.994011 3786.480703 0 96 8754.233917 5681.514209 0 97 4144.063967 4022.670751 0 98 7018.296239 4182.265533 0 99 6621.958890 467.796860 0 100 4453.521897 2592.269234 0 101 1576.865721 5275.731302 0 102 4872.656011 5614.049256 0 103 7554.847673 8838.751542 0 104 4945.826704 3120.582464 0 105 4668.922354 8090.458574 0 106 8750.163315 8124.149324 0 107 1880.012941 9994.203595 0 108 6330.887599 834.670502 0 109 7255.543555 9868.214802 0 110 4018.168222 6785.150052 0 111 3161.771372 2135.246621 0 112 7173.241433 23.575647 0 113 8227.314105 5283.459769 0 114 977.843418 1189.038948 0 115 6492.654249 8736.538239 0 116 2799.827433 9785.151868 0 117 1001.806891 8539.381096 0 118 3966.961773 813.454168 0 119 2747.138434 4529.781848 0 120 7923.415312 8613.599036 0 121 1334.205542 5208.655284 0 122 6507.832381 3470.530146 0 123 8718.638357 2784.098152 0 124 185.743275 406.632737 0 125 6809.967701 5583.557361 0 126 9465.025542 9384.387997 0 127 9098.511774 420.045320 0 128 7491.348234 7013.248176 0 129 6553.618647 7123.576525 0 130 9027.101506 6401.411998 0 131 3724.492630 5379.287837 0 132 2078.441037 5871.255047 0 133 88.970820 1510.231739 0 134 3334.083880 7896.231589 0 135 7184.994228 3382.559700 0 136 6205.381083 412.029495 0 137 1638.605457 9819.140701 0 138 2895.308536 3947.919830 0 139 5484.842966 2934.070015 0 140 4780.646692 2397.060836 0 141 482.563623 1795.868490 0 142 5230.502317 708.628841 0 143 4031.691464 3285.207100 0 144 4147.216090 994.003382 0 145 9086.575544 4740.046511 0 146 8408.483326 9762.294576 0 147 3436.515937 4790.865192 0 148 6995.952912 4265.353235 0 149 3019.031162 7347.509912 0 150 8943.997782 9196.888444 0 151 6267.420468 3755.713463 0 152 9745.605215 6388.785175 0 153 658.346773 846.695691 0 154 7498.695718 611.561565 0 155 78.510053 3938.079518 0 156 5190.037287 4485.442856 0 157 4886.188044 5848.887020 0 158 6793.025674 4230.380735 0 159 3683.314563 9884.590581 0 160 2609.165354 7771.001545 0 161 4312.210246 3585.203820 0 162 638.579489 8635.789443 0 163 7020.041498 9030.107075 0 164 4516.117927 6769.209668 0 165 1189.102866 3979.536016 0 166 2072.319734 421.014279 0 167 9479.613513 2158.943685 0 168 1463.544898 1979.700436 0 169 3780.319643 5463.912623 0 170 1513.343685 9886.898890 0 171 9829.892105 1484.020171 0 172 4059.068832 6799.294831 0 173 8776.565829 4954.059249 0 174 9170.466728 3224.603149 0 175 4984.408915 4986.465919 0 176 6700.681513 2019.913088 0 177 6097.706104 2187.730969 0 178 3402.203151 9625.664633 0 179 8990.080380 8181.183809 0 180 354.682619 1483.668825 0 181 2568.819121 7841.665682 0 182 8423.333271 5829.481802 0 183 7181.316518 8070.553800 0 184 663.591310 846.431368 0 185 8688.953140 394.158294 0 186 2250.906537 406.320266 0 187 152.851400 8439.546857 0 188 3305.943673 1606.900603 0 189 1488.194903 6560.836618 0 190 9685.982717 5049.996926 0 191 9010.904769 5024.285990 0 192 5738.724775 6785.713568 0 193 8051.099890 7578.463823 0 194 9905.325627 7469.653892 0 195 9057.807234 2061.048321 0 196 5354.163043 5986.142637 0 197 8256.966172 4822.135631 0 198 7910.402117 3885.688902 0 199 5863.884556 8513.166075 0 200 7980.594711 6569.845519 0 201 2.406965 1819.689222 0 202 5068.577869 2544.593985 0 203 656.208433 8598.834221 0 204 9429.470213 3028.048781 0 205 4080.731674 8100.375338 0 206 622.587589 6409.848626 0 207 1273.208129 2870.883400 0 208 8299.406866 555.270459 0 209 359.338334 4178.660448 0 210 4918.309591 8633.251831 0 211 7171.887463 6735.438086 0 212 1513.737724 9867.059242 0 213 4111.401963 6117.708643 0 214 3866.830055 470.329158 0 215 4708.892090 1513.677539 0 216 324.654624 6174.004237 0 217 6299.662912 1052.928247 0 218 5491.437662 3466.679766 0 219 3834.140732 7764.198987 0 220 4903.196775 8812.766154 0 221 6101.197429 4671.884150 0 222 6323.126401 3378.653798 0 223 1243.237925 6825.296187 0 224 6220.374427 7885.664914 0 225 1271.091249 9117.833181 0 226 7993.412114 9168.874081 0 227 8725.347218 6810.064464 0 228 8102.508494 5190.073092 0 229 7854.891494 1891.274679 0 230 7821.141064 4445.796041 0 231 7566.162213 4554.702368 0 232 7895.587283 753.395852 0 233 446.409054 9342.895824 0 234 4861.651007 9010.713996 0 235 9447.832519 6665.111525 0 236 5717.968261 2159.793841 0 237 934.762193 8193.942151 0 238 8887.720676 7793.957107 0 239 6985.024327 4201.111161 0 240 3053.115900 1134.448956 0 241 4259.702481 5660.129742 0 242 9228.805831 9357.547693 0 243 4156.411965 992.109881 0 244 7738.187325 7342.793417 0 245 307.008460 4467.185991 0 246 6864.181043 301.342346 0 247 9192.823534 9622.424865 0 248 7225.427721 785.385397 0 249 703.294659 3592.533148 0 250 293.775078 3478.777273 0 251 99.642413 9743.235128 0 252 8190.066991 705.176115 0 253 8934.350918 2079.780400 0 254 2047.907983 6737.591455 0 255 9382.622682 1231.881212 0 256 71.845673 3691.301472 0 257 246.500144 6048.482376 0 258 8591.756086 1869.917024 0 259 1123.910358 3444.496073 0 260 9591.715206 1301.576944 0 261 9665.192605 3622.398699 0 262 4733.704028 2926.319860 0 263 9371.268442 9581.478950 0 264 6359.157065 1840.455502 0 265 9929.517886 1025.804395 0 266 5808.493816 1564.030601 0 267 8976.753142 9456.783915 0 268 8043.902980 3158.914187 0 269 2428.386900 7548.584132 0 270 2910.595191 4197.853779 0 271 462.556769 1322.338104 0 272 205.496206 779.211201 0 273 732.111494 4202.317022 0 274 5507.771776 7408.788199 0 275 1422.834738 4221.887462 0 276 6369.660374 845.556948 0 277 4448.111551 3692.560392 0 278 9489.319289 578.571139 0 279 4086.262212 4172.254798 0 280 7281.805046 3206.710029 0 281 2039.902759 2933.116552 0 282 4708.875424 9502.683296 0 283 7965.170228 2769.702458 0 284 5581.815884 6882.003036 0 285 7956.571557 4461.643839 0 286 3987.769051 7676.407428 0 287 4317.164956 2479.576689 0 288 4534.470315 9371.046463 0 289 1425.674882 4624.353545 0 290 6373.035244 4832.879883 0 291 2036.399044 18.431606 0 292 6989.917118 6187.355180 0 293 77.766494 2985.601210 0 294 7686.342595 6289.203785 0 295 5452.081159 1562.211098 0 296 7062.940430 4714.349217 0 297 6781.787462 7600.898367 0 298 2323.627214 7619.950131 0 299 2800.883847 9840.151371 0 300 1208.316108 8837.180187 0 301 405.471250 2565.758183 0 302 5261.019088 5816.161834 0 303 3962.349850 1020.317282 0 304 2526.080858 2833.965039 0 305 7552.228546 9087.743252 0 306 5954.099155 354.509657 0 307 7922.364716 3056.039328 0 308 3398.904064 5301.854376 0 309 2490.470476 9199.780879 0 310 1635.547583 4148.304005 0 311 2896.919495 5198.341022 0 312 5739.818031 6271.396891 0 313 5313.758038 4108.045023 0 314 6345.940124 4034.128766 0 315 7785.502591 7881.774253 0 316 2922.541681 3718.043236 0 317 6288.109059 1570.699671 0 318 6970.319310 3814.277530 0 319 5910.624748 1395.330992 0 320 6682.583861 3540.578606 0 321 4726.655762 4151.074008 0 322 4767.152480 6946.956329 0 323 3182.401768 6520.544809 0 324 602.221075 3001.851525 0 325 7452.096902 524.058781 0 326 6211.421953 255.467993 0 327 4715.288683 8885.450437 0 328 101.100940 5268.280207 0 329 664.568297 8671.097761 0 330 6862.965222 7419.538567 0 331 6690.075799 64.234537 0 332 411.778623 6208.768040 0 333 9996.851256 8731.472391 0 334 6996.858067 7270.999543 0 335 2266.870226 7516.139341 0 336 2879.241049 1054.602670 0 337 4608.948955 3301.957725 0 338 1682.553987 4217.098925 0 339 8972.009770 4352.702733 0 340 4472.918952 7088.277574 0 341 5241.618702 1292.230353 0 342 9103.923975 4441.243362 0 343 7893.377392 3888.751300 0 344 8068.460188 3895.364160 0 345 2201.595217 1961.946669 0 346 9400.346443 5865.302586 0 347 497.932651 3883.475962 0 348 2340.292605 846.570646 0 349 1867.558685 569.904800 0 350 6380.736282 1733.738648 0 351 6107.798762 6125.067479 0 352 7049.237107 5121.186506 0 353 2844.239903 8774.574539 0 354 3530.710817 4582.943250 0 355 6318.794317 5161.242982 0 356 9564.683486 9547.176774 0 357 9297.598506 9340.763497 0 358 5809.601356 4902.020637 0 359 7041.168174 2154.195930 0 360 2658.720392 438.072536 0 361 1628.575426 38.745499 0 362 6546.275765 1404.069890 0 363 7866.793456 6805.039959 0 364 9706.757934 3965.144870 0 365 9213.919135 4537.041723 0 366 3395.037398 1023.388699 0 367 8828.321851 7947.901586 0 368 3229.289765 4557.443849 0 369 3251.434658 288.291165 0 370 443.525254 3687.041259 0 371 2095.913281 5245.146032 0 372 1877.850356 2016.215865 0 373 6726.678813 7356.026568 0 374 3122.320959 8599.943994 0 375 2546.391747 3439.403763 0 376 7124.803904 445.029013 0 377 9341.834601 723.377318 0 378 4609.310589 7246.048260 0 379 474.685350 8090.026856 0 380 9788.933433 4605.116728 0 381 1181.236363 814.769957 0 382 987.304362 7654.413741 0 383 4140.128485 9192.341582 0 384 4406.397761 771.433101 0 385 4269.355875 7548.278934 0 386 8293.384268 393.516865 0 387 1803.893913 4900.134520 0 388 1280.854780 8710.926419 0 389 9344.608884 3195.969984 0 390 4348.436826 5570.540644 0 391 2855.057911 5410.756975 0 392 2011.850455 2966.412513 0 393 4417.836332 6046.699022 0 394 5361.650261 2609.879767 0 395 2317.878754 1187.302367 0 396 7834.936359 989.007665 0 397 7328.850062 2487.736957 0 398 2845.569840 7360.834330 0 399 6596.207917 7419.215555 0 400 5152.830588 8590.958197 0 401 1217.938914 6451.969614 0 402 1182.443125 7372.833681 0 403 3589.046615 6748.821044 0 404 7034.839134 6606.084576 0 405 2215.579803 8317.998864 0 406 2401.360874 5181.532972 0 407 6746.457542 2336.031748 0 408 6285.117230 2868.310480 0 409 1713.823761 8097.488285 0 410 5531.227701 3278.847066 0 411 5854.309472 252.863974 0 412 1298.228568 3955.808517 0 413 9757.565795 5104.745179 0 414 764.562051 7650.406152 0 415 7814.438709 7748.021744 0 416 5694.980380 6956.987379 0 417 2134.579363 7325.605909 0 418 8161.739873 7599.665402 0 419 3534.624026 5910.280506 0 420 6289.893575 9008.098537 0 421 1080.138953 8339.337709 0 422 5264.355585 3586.141206 0 423 4556.029015 126.354989 0 424 2200.735923 6527.634201 0 425 6608.492798 4946.989403 0 426 9533.258806 4809.150885 0 427 3139.436595 8477.808392 0 428 2591.582994 6043.059930 0 429 7034.188523 8216.962987 0 430 7853.687502 3840.923305 0 431 591.803060 382.878655 0 432 7264.603879 9616.913814 0 433 3431.653743 4411.950981 0 434 7257.980157 6578.312459 0 435 2601.065885 6715.848458 0 436 3049.024196 3563.579066 0 437 5395.133053 7323.138239 0 438 1512.162116 219.872109 0 439 6278.299545 245.646778 0 440 449.632407 2257.755767 0 441 6538.768733 665.450977 0 442 624.057676 9720.932444 0 443 4226.528938 8924.289340 0 444 2165.242840 4352.131795 0 445 3580.351346 1769.355360 0 446 3288.131858 9867.958187 0 447 7473.090098 3826.682792 0 448 4092.844344 2637.409012 0 449 5313.366786 7356.369121 0 450 6866.466158 4626.498353 0 451 419.390467 9215.078065 0 452 4089.338031 3902.988670 0 453 31.101145 1382.272141 0 454 8688.534175 5139.345962 0 455 7324.348442 1481.678864 0 456 3300.510067 8401.365565 0 457 8206.585212 2467.942681 0 458 219.753083 8064.669735 0 459 1688.440050 7876.813921 0 460 6836.592299 1683.147603 0 461 784.886437 9276.494299 0 462 5978.783973 6205.101731 0 463 4575.118028 1500.709773 0 464 6019.699129 2524.728800 0 465 8058.946560 7327.189548 0 466 272.671850 9324.230096 0 467 363.160483 896.193188 0 468 2927.345609 1508.090605 0 469 2361.450829 3558.094886 0 470 7354.997155 4047.113608 0 471 2698.397547 4923.131536 0 472 3925.932498 3107.641975 0 473 9005.416579 5504.484510 0 474 9773.275110 7729.124094 0 475 5704.992976 2624.465893 0 476 6868.436563 4559.177190 0 477 7213.877150 4037.788089 0 478 4960.050363 206.837674 0 479 7399.585023 342.735444 0 480 6807.253858 5820.036955 0 481 7759.176115 2897.775992 0 482 6861.108151 2070.979756 0 483 5292.720014 3402.803793 0 484 9784.545514 9718.665574 0 485 2089.697355 5660.382359 0 486 3294.426859 9685.381870 0 487 9245.259482 5861.458531 0 488 7200.844551 6813.247567 0 489 3533.556324 9163.615694 0 490 8994.535368 3306.584645 0 491 7473.949106 90.921267 0 492 8163.591106 5648.693454 0 493 9523.067128 3631.930745 0 494 6257.130749 3230.024315 0 495 7827.853814 6007.029968 0 496 9874.710230 10.127931 0 497 1407.587422 436.013821 0 498 1258.478488 9293.852971 0 499 9486.082995 4804.125347 0 500 9466.893946 8183.876102 0 501 7786.177341 7472.819508 0 502 1876.545852 5488.772611 0 503 4238.792306 9497.880476 0 504 1738.335381 1698.588436 0 505 6588.617536 1574.017896 0 506 1100.536730 5039.231973 0 507 7966.609712 6050.456716 0 508 7547.539728 2657.585316 0 509 2849.628330 4287.036417 0 510 9908.478843 7179.182565 0 511 9462.539573 5378.704557 0 512 5545.598516 9900.903355 0 513 1899.882757 7825.904372 0 514 7915.138240 8447.416276 0 515 7500.527092 1553.330182 0 516 6611.276321 9237.031846 0 517 5632.851525 3609.415104 0 518 9495.201486 5615.986505 0 519 4116.363945 6141.334981 0 520 8041.250166 2283.020906 0 521 156.920430 5290.948971 0 522 9413.574201 6802.579626 0 523 6309.080001 6278.151475 0 524 4969.897123 7309.192697 0 525 2491.944400 8917.542640 0 526 2744.726552 9449.450132 0 527 9264.967100 779.245240 0 528 4481.797012 7440.362849 0 529 4496.540715 5088.990248 0 530 8068.239377 7049.921609 0 531 9580.042227 1644.859943 0 532 9235.592862 9279.862525 0 533 6347.489386 9403.908273 0 534 2526.855874 8817.872834 0 535 7734.792930 6096.889997 0 536 906.292446 301.343537 0 537 109.694955 2505.580574 0 538 7623.524099 3866.250324 0 539 7754.467252 6256.424909 0 540 3892.618991 8801.466288 0 541 384.172394 4653.129902 0 542 8298.523394 1268.134830 0 543 7104.875615 3281.158419 0 544 243.012786 4737.249309 0 545 5216.927389 415.862507 0 546 5659.193536 3474.338380 0 547 44.932073 1907.733807 0 548 1108.106723 5406.219547 0 549 431.201630 9281.325701 0 550 8450.619724 9452.976437 0 551 3148.010328 9052.673886 0 552 9843.124225 7647.314343 0 553 2750.826136 6708.893041 0 554 5956.631537 4042.033022 0 555 3060.978540 598.481906 0 556 1253.824748 1339.561560 0 557 4808.928647 6418.933847 0 558 7640.684524 467.137600 0 559 8237.598726 434.712233 0 560 5549.468301 7441.478498 0 561 6312.213718 9496.786757 0 562 3446.983531 5858.833552 0 563 827.990627 5597.965879 0 564 8132.988011 2016.045138 0 565 2609.645004 7004.056402 0 566 2538.819669 2592.454740 0 567 9355.152879 9985.430308 0 568 1551.984307 9001.623873 0 569 5527.264860 386.011424 0 570 5855.027152 6415.496507 0 571 337.956987 7576.919222 0 572 8178.001415 716.432422 0 573 6483.999401 4565.474809 0 574 2387.212873 4586.703816 0 575 1593.897098 3336.659067 0 576 6552.072997 4764.855562 0 577 5559.200947 5434.427938 0 578 8205.942401 3433.827982 0 579 8129.620908 799.870871 0 580 4277.330459 3523.201165 0 581 4515.806387 8335.098205 0 582 5123.994005 9872.466463 0 583 8614.607203 1188.467453 0 584 3168.915356 227.255015 0 585 7337.534213 192.008044 0 586 8859.385148 1933.428648 0 587 4138.362903 620.393060 0 588 3112.548873 3895.149895 0 589 522.309735 7675.506532 0 590 7113.497195 3578.836241 0 591 8351.925532 774.218023 0 592 540.064010 3549.802944 0 593 9018.413322 7564.677019 0 594 6723.176786 5627.357352 0 595 8037.655387 4122.266932 0 596 306.885798 8024.042864 0 597 1904.934343 3876.588498 0 598 3576.093472 1233.656259 0 599 3507.843690 1770.868779 0 600 6160.138301 6534.343578 0 601 136.465529 4564.758524 0 602 5540.526565 8716.629944 0 603 4960.313102 804.504369 0 604 517.238791 8621.090830 0 605 7907.294093 8584.479312 0 606 2622.426676 6479.973608 0 607 957.180473 8265.731117 0 608 3336.129364 9551.472373 0 609 4713.825656 330.676969 0 610 9090.558776 6255.321488 0 611 2870.812860 368.038938 0 612 3766.863967 1568.605598 0 613 5482.803113 1468.836752 0 614 1746.142788 9208.694857 0 615 6401.200345 2425.814118 0 616 8788.962806 6247.158299 0 617 9455.993401 4829.167944 0 618 8879.008340 6784.438073 0 619 441.685559 2402.904901 0 620 2815.764049 1700.166834 0 621 2381.869506 2260.401485 0 622 8783.437492 4628.987935 0 623 8765.118313 1379.978835 0 624 5649.184866 134.676781 0 625 9303.014098 56.371144 0 626 3899.076486 8015.859587 0 627 9998.815592 195.097404 0 628 8240.854839 5100.879595 0 629 381.820205 7771.192709 0 630 1119.024126 6114.741873 0 631 7783.252161 6735.909267 0 632 3798.743247 264.416368 0 633 4362.639678 9136.944837 0 634 3329.233655 2479.587192 0 635 1378.308338 5102.524550 0 636 5333.482727 730.482424 0 637 4077.584860 6586.814549 0 638 9660.506852 4315.411217 0 639 4360.353369 4711.339726 0 640 2250.334912 3948.376420 0 641 6452.647260 3970.592091 0 642 5813.757484 8355.822880 0 643 9979.675731 8850.396836 0 644 3717.966269 217.271343 0 645 6116.045995 4745.507082 0 646 2370.171120 403.040991 0 647 3215.702390 7980.713128 0 648 9641.190069 1066.601391 0 649 8776.394118 487.176712 0 650 7134.758189 267.957134 0 651 4210.496823 8702.308385 0 652 3931.081476 9245.643176 0 653 7131.951411 6041.842808 0 654 1613.790480 3404.957836 0 655 4110.961643 5902.048641 0 656 9960.381602 2837.097478 0 657 5035.628908 9334.479076 0 658 3454.207938 6286.047873 0 659 7661.315387 6302.697250 0 660 7534.306798 1956.930002 0 661 9573.376868 1768.978068 0 662 5836.811760 2960.426091 0 663 6344.230253 2911.104154 0 664 4312.133568 6822.225482 0 665 2690.687506 7278.758824 0 666 3468.776728 1321.560972 0 667 6131.287169 1657.580289 0 668 4305.774463 3983.974119 0 669 761.688474 7107.698374 0 670 6808.235651 7777.950050 0 671 5449.131409 5539.167757 0 672 1692.330029 2074.638990 0 673 2282.494905 5253.035287 0 674 8189.825825 3569.741167 0 675 8818.719881 7358.782685 0 676 7164.471432 3351.721293 0 677 1184.774921 9627.904811 0 678 8546.106356 4088.679908 0 679 8632.181902 8992.171150 0 680 3424.736234 5015.614924 0 681 3317.898403 6951.575141 0 682 9121.673135 9845.441039 0 683 7437.790748 3052.423539 0 684 8804.932901 9926.196290 0 685 3465.261637 9487.123524 0 686 5115.464055 9646.354423 0 687 9958.559901 8129.420958 0 688 6834.370492 1540.144693 0 689 49.172832 5954.708504 0 690 7044.599055 9355.380452 0 691 5171.199002 6968.466027 0 692 6473.559715 2049.201250 0 693 6443.000928 9817.212113 0 694 1111.849566 6885.432432 0 695 6143.051175 3758.547238 0 696 7933.477539 104.858586 0 697 8924.116221 8173.639530 0 698 4807.048315 1081.391549 0 699 4526.285557 5842.528991 0 700 2538.834785 4865.314648 0 701 7757.287639 9227.317956 0 702 5616.450276 8272.417850 0 703 779.332130 8563.680463 0 704 9208.145655 1680.013763 0 705 8274.873618 8495.661703 0 706 8786.588683 5171.395198 0 707 6082.542439 2080.832454 0 708 7081.315494 4050.173034 0 709 211.690857 1342.671135 0 710 3882.180316 8851.798061 0 711 5649.422933 9162.570341 0 712 9294.838444 867.949921 0 713 5882.154137 3345.280382 0 714 5067.951223 4555.248025 0 715 4799.432726 1018.058082 0 716 8331.600838 4902.799618 0 717 6449.875563 4726.787527 0 718 1810.183766 5410.005850 0 719 1595.397391 8521.792561 0 720 8316.040256 1436.387782 0 721 688.439530 684.919169 0 722 3932.440249 9530.414373 0 723 5561.404161 2655.265740 0 724 2296.488271 1108.731948 0 725 1410.712105 8118.632666 0 726 1386.334647 8640.615572 0 727 8229.980742 1368.088021 0 728 5587.247699 70.552679 0 729 8620.361343 5582.771204 0 730 7553.403944 4903.453269 0 731 6904.219993 9312.391242 0 732 5595.458101 8747.054769 0 733 3430.454423 975.325457 0 734 51.446426 2266.502790 0 735 8385.868369 3114.954626 0 736 2246.161476 4956.304234 0 737 9469.041225 5089.784483 0 738 3408.716626 775.017910 0 739 5736.669333 2262.569795 0 740 3674.991277 3811.623667 0 741 7581.843372 2316.288448 0 742 9358.922258 7423.880680 0 743 4811.195408 8804.744913 0 744 3591.679803 3843.398736 0 745 1293.691310 7785.560945 0 746 4011.926528 5002.530282 0 747 4709.686654 6561.818176 0 748 3739.384311 9158.613261 0 749 4319.222590 3592.139778 0 750 4008.780552 7662.957215 0 751 9930.565900 8665.146463 0 752 4797.274985 2913.593435 0 753 4459.870544 3440.155531 0 754 2435.320522 1869.409154 0 755 9558.757345 4993.051904 0 756 1099.748737 3839.066101 0 757 3887.169172 5135.345270 0 758 9800.413246 9766.334966 0 759 5658.941107 6180.915253 0 760 6756.290749 5022.221827 0 761 4866.780582 3145.239392 0 762 6839.217395 918.952783 0 763 3171.452462 8909.785595 0 764 2273.781510 9675.823780 0 765 9841.697220 5753.826631 0 766 404.359803 934.781973 0 767 2003.016377 3268.115683 0 768 1131.082116 7972.107731 0 769 3641.545700 2337.336984 0 770 436.938704 3826.718594 0 771 45.067305 1164.914505 0 772 6046.455101 9349.454113 0 773 1993.659219 7410.612067 0 774 1977.055210 14.951938 0 775 8965.380462 8461.087377 0 776 667.787160 1771.352882 0 777 2343.009280 9283.213646 0 778 3819.290956 8073.817566 0 779 4358.135328 3812.446667 0 780 7653.480548 6157.609966 0 781 2693.176942 5828.105982 0 782 7038.528500 8270.780916 0 783 6771.790792 6407.470713 0 784 5959.023425 920.509491 0 785 9451.890595 7148.419105 0 786 2728.711294 6923.506941 0 787 6208.174361 6588.514457 0 788 3789.089710 5731.758548 0 789 6600.272307 2016.560690 0 790 5080.121644 1203.416553 0 791 1055.304981 9110.605752 0 792 1245.472246 8932.669718 0 793 4697.991995 4549.026158 0 794 3398.153195 4162.177164 0 795 3772.323808 5649.829470 0 796 3355.933191 8219.758635 0 797 2335.617502 2484.701227 0 798 4805.515466 9350.812838 0 799 239.156741 7234.136156 0 800 60.065877 4048.602131 0 801 7642.072497 4460.791217 0 802 4294.889289 2532.168290 0 803 4750.956382 2282.594997 0 804 2835.212898 6532.935611 0 805 5994.470561 9295.455154 0 806 9688.690814 5223.801932 0 807 875.565126 2999.030943 0 808 5178.048956 6731.628934 0 809 9461.972494 1551.074337 0 810 366.847018 8700.356828 0 811 8051.643682 7657.482766 0 812 4686.007678 6777.807041 0 813 4114.692248 1920.516578 0 814 3908.937651 7870.465960 0 815 8018.556220 9611.344661 0 816 8876.671252 6820.845368 0 817 5209.120228 7239.270235 0 818 1832.035893 9230.845313 0 819 7125.765745 5944.855555 0 820 4340.417173 6335.415891 0 821 6176.787279 8988.541265 0 822 5707.363108 2133.771524 0 823 4413.793611 2429.685107 0 824 9049.501688 8435.258144 0 825 5558.191145 1963.915676 0 826 435.420130 1341.694537 0 827 4432.192808 6742.040784 0 828 2239.981045 6845.203497 0 829 8619.493840 7572.410816 0 830 4255.274752 6457.279074 0 831 9883.674330 8854.116029 0 832 3381.495065 6854.470536 0 833 1632.112814 5573.684711 0 834 3565.339649 4381.463184 0 835 4388.988539 6632.329398 0 836 8459.960073 4685.718422 0 837 1465.847881 7541.542732 0 838 7516.430106 9538.452397 0 839 3940.560069 4638.790094 0 840 5405.957416 8921.233965 0 841 7042.165179 212.781236 0 842 2073.226876 8538.948477 0 843 5854.738174 8739.084660 0 844 4113.991375 2104.678872 0 845 41.407269 9960.509588 0 846 1363.815332 6429.687657 0 847 4897.089102 3801.493909 0 848 5372.021501 782.835603 0 849 9700.342024 4927.369412 0 850 152.895168 4193.434314 0 851 7572.019053 3120.836696 0 852 7450.224088 7673.627198 0 853 2391.207189 9679.724862 0 854 278.887494 8636.054841 0 855 5126.491216 1533.794885 0 856 2583.929458 5935.172919 0 857 2784.571639 8384.210764 0 858 2195.285140 3840.612974 0 859 5068.131680 3397.729637 0 860 8241.428032 2638.822044 0 861 889.771733 1547.851884 0 862 6269.454553 5635.626501 0 863 632.983219 9930.491636 0 864 4794.406327 3194.372012 0 865 7291.624015 242.918589 0 866 4342.491448 6644.138391 0 867 9621.362249 7616.377781 0 868 8851.592096 1189.059072 0 869 4297.706056 317.904251 0 870 2719.941978 3842.968651 0 871 3438.210807 3737.407969 0 872 8030.800047 1895.436328 0 873 8244.956102 5419.210871 0 874 3387.451285 5522.357673 0 875 1614.233323 4954.547496 0 876 219.532969 8629.750778 0 877 3315.810348 3440.429493 0 878 9951.519974 6134.557319 0 879 4176.536944 7906.567213 0 880 676.647071 5705.042042 0 881 5207.009619 8612.281680 0 882 5862.003425 4852.724152 0 883 5202.258590 7818.973081 0 884 3473.207958 5577.894139 0 885 7073.902727 9955.554543 0 886 6936.841955 9618.711712 0 887 3990.326613 6087.809928 0 888 7452.948573 3484.159496 0 889 2691.749388 9728.331111 0 890 3485.339729 9999.026771 0 891 8522.709847 2160.681148 0 892 8282.192224 9836.271266 0 893 2768.202242 6644.544138 0 894 7695.892230 832.819988 0 895 8193.318049 3083.607321 0 896 7063.817962 9501.382211 0 897 351.090214 6117.128805 0 898 2924.046278 1146.587891 0 899 7118.548026 9790.465623 0 900 5127.105009 3463.442092 0 901 4490.895948 4146.178849 0 902 5319.019096 4091.758365 0 903 803.724646 9794.277360 0 904 9967.072779 1741.345547 0 905 2410.399663 4369.562914 0 906 6987.329370 313.449355 0 907 8354.975507 6384.333733 0 908 2692.935621 8708.672149 0 909 6612.092131 3169.242813 0 910 5478.459943 9792.375586 0 911 484.329669 7084.620166 0 912 8494.136102 6923.168489 0 913 1400.184129 5971.496035 0 914 7859.552457 4185.959122 0 915 5824.282782 2534.679543 0 916 3127.485507 8085.701431 0 917 4894.981376 4488.117375 0 918 1228.838371 3744.708983 0 919 5207.210559 2310.123347 0 920 8079.355618 3837.007063 0 921 2384.897924 3082.974933 0 922 8244.635327 9041.434760 0 923 9602.978486 151.940800 0 924 7538.941306 5254.840360 0 925 1245.600769 2465.335764 0 926 2816.908305 4042.166876 0 927 4707.212724 9367.888564 0 928 583.550570 7091.693050 0 929 8541.060949 3572.999180 0 930 2492.171984 2213.084906 0 931 3008.391767 1452.979906 0 932 5516.779869 2503.995042 0 933 272.515355 2326.334332 0 934 8206.321055 4173.702220 0 935 8835.362547 9436.156314 0 936 2433.483285 5599.724511 0 937 8810.669097 5814.203373 0 938 1680.002864 2479.532475 0 939 9876.248298 2993.868649 0 940 8677.029822 7950.123378 0 941 7419.847028 7219.422568 0 942 7899.818637 8474.076852 0 943 623.664365 1678.098245 0 944 5055.293246 2124.895259 0 945 5332.180226 4931.823395 0 946 1267.714490 859.611521 0 947 116.527967 8250.361301 0 948 817.416684 9615.653287 0 949 9838.318545 7456.964433 0 950 4503.832808 2757.884635 0 951 4124.524219 3452.932660 0 952 3962.951396 7261.957830 0 953 8925.262076 1577.150269 0 954 2426.705788 2098.969062 0 955 453.459901 8542.005796 0 956 5112.755433 670.347787 0 957 4462.552611 4506.107920 0 958 7779.559560 7613.974486 0 959 1344.889894 6268.756157 0 960 5096.862934 134.917766 0 961 1477.358293 6668.484238 0 962 3670.258062 9636.853955 0 963 5017.503622 6882.831697 0 964 1336.176397 4794.484586 0 965 7341.214712 8334.816758 0 966 1996.074290 3969.067211 0 967 4735.270091 4403.723936 0 968 4754.416706 2959.002252 0 969 8087.207429 9130.779455 0 970 3490.007285 6378.600717 0 971 3807.059183 5787.519917 0 972 6955.389447 5015.162773 0 973 6745.820702 7571.457443 0 974 8432.956355 1888.098898 0 975 2163.848971 5143.713517 0 976 5096.570189 8077.254936 0 977 5173.833725 9000.524695 0 978 7776.028358 5063.158112 0 979 8263.261217 4758.559608 0 980 3417.151590 4334.234394 0 981 4562.080123 6505.319515 0 982 521.570950 7295.086771 0 983 9682.327752 4588.175691 0 984 687.722938 2012.563839 0 985 1032.140393 2563.536613 0 986 7939.071055 10.494353 0 987 8735.793324 9395.471506 0 988 1850.030841 1735.864349 0 989 9657.629629 3603.801549 0 990 8117.763047 90.106776 0 991 9907.915790 164.902063 0 992 6075.705954 9284.503547 0 993 8312.608590 3104.025570 0 994 8220.804128 3930.476369 0 995 4998.064171 3632.780005 0 996 3547.180674 5820.752265 0 997 7820.679852 6994.911285 0 998 7680.779559 142.732679 0 999 5316.933935 3527.886028 0 1000 2086.148327 9208.518221 0 1001 1968.080500 1844.749659 0 1002 1788.140945 6580.949064 0 1003 6117.399304 5056.334690 0 1004 5868.017571 9405.763143 0 1005 8612.100871 9059.345201 0 1006 541.578340 8974.127740 0 1007 313.506473 6476.429451 0 1008 9308.321784 5024.634234 0 1009 4193.206676 3317.429545 0 1010 9161.236184 9259.692641 0 1011 6191.255092 7144.289841 0 1012 3391.270412 1381.747672 0 1013 9790.009780 6570.221167 0 1014 2743.875495 9770.835525 0 1015 6089.699336 3305.850869 0 1016 8958.130005 779.004280 0 1017 8041.536641 1595.790155 0 1018 1076.744460 2589.440685 0 1019 7148.255438 6080.082986 0 1020 4212.783774 1590.461925 0 1021 9237.518640 7662.851745 0 1022 6862.666283 8129.090662 0 1023 7742.452606 1124.250113 0 1024 7733.542182 8387.254341 0 1025 7467.558605 4822.772763 0 1026 6864.456440 1000.076136 0 1027 7643.453585 2622.277683 0 1028 7851.263963 6352.840838 0 1029 5090.784566 5360.171557 0 1030 747.308061 408.979104 0 1031 148.248149 7755.424675 0 1032 1384.953178 1228.665367 0 1033 3850.627898 9777.029714 0 1034 8859.242948 3132.890286 0 1035 8197.984482 850.777753 0 1036 3920.403394 5792.057868 0 1037 9862.469153 487.069578 0 1038 4124.210173 9196.104400 0 1039 276.106823 5990.823789 0 1040 3993.937458 5602.684672 0 1041 7033.494137 4066.954136 0 1042 8920.522405 9557.145226 0 1043 9850.591313 547.784995 0 1044 8368.294570 8783.725093 0 1045 1454.052594 9414.294951 0 1046 1271.138537 2073.140784 0 1047 9555.467156 8307.831592 0 1048 5765.511876 2878.083309 0 1049 2527.154849 4031.385309 0 1050 89.934980 6363.591840 0 1051 515.501091 7738.521381 0 1052 701.636439 102.543804 0 1053 2846.570026 7726.920407 0 1054 8326.370251 5073.027621 0 1055 9382.972940 1145.170253 0 1056 3322.194070 7403.452905 0 1057 3233.199182 1453.607480 0 1058 5783.607643 625.739924 0 1059 3730.168209 2538.687397 0 1060 3318.123645 4851.822218 0 1061 5357.024485 843.574560 0 1062 3155.281129 3836.967407 0 1063 4033.044021 4800.353538 0 1064 4258.720243 740.275823 0 1065 2193.245824 6442.860320 0 1066 8287.640130 5114.406147 0 1067 1481.897673 704.670038 0 1068 1558.941978 3840.471480 0 1069 5652.064168 6642.572363 0 1070 5243.593176 5652.906619 0 1071 3522.334094 6655.969088 0 1072 7268.602437 4021.254002 0 1073 8149.124780 7439.320286 0 1074 9047.439890 4667.483085 0 1075 3452.219310 7772.036679 0 1076 375.934297 3838.762848 0 1077 9771.932093 3422.638833 0 1078 5123.223886 2497.695355 0 1079 769.469773 1109.517468 0 1080 4352.100772 6190.023142 0 1081 5457.484053 5186.822154 0 1082 1116.509361 402.592836 0 1083 3586.961928 9424.848882 0 1084 1798.175524 2692.613861 0 1085 4831.409660 9142.072043 0 1086 9469.743626 13.035745 0 1087 6478.956027 2361.581225 0 1088 6544.816977 7428.466359 0 1089 8871.393900 6834.174827 0 1090 8472.095938 7844.799141 0 1091 1607.161382 436.927658 0 1092 7387.786394 5259.188984 0 1093 9978.655050 1648.905414 0 1094 3852.699376 2877.835757 0 1095 8786.973177 4836.957620 0 1096 9136.495816 7071.900029 0 1097 9988.061683 5997.790160 0 1098 9761.591529 1734.063373 0 1099 4416.800612 5783.912042 0 1100 9782.959106 5678.798241 0 1101 8652.649810 6285.055588 0 1102 5124.010252 3914.413842 0 1103 3686.340480 2952.180374 0 1104 2113.699709 9625.770244 0 1105 5364.612161 8658.695365 0 1106 8849.637611 9422.998611 0 1107 2381.668061 3377.288924 0 1108 6331.398796 3220.540452 0 1109 1439.280945 7598.592137 0 1110 5503.918988 5365.230196 0 1111 7104.710385 1147.402517 0 1112 9219.090078 4798.230842 0 1113 6918.288930 6003.242609 0 1114 6052.329261 7099.116802 0 1115 887.956436 4967.332177 0 1116 2102.894209 3896.838521 0 1117 5117.457897 3539.486367 0 1118 4067.129069 7308.698224 0 1119 433.272659 9565.935895 0 1120 6039.175230 1635.546375 0 1121 5572.187637 809.355620 0 1122 5014.737046 6886.314264 0 1123 4197.779358 3141.813192 0 1124 6737.141068 9352.851860 0 1125 8736.358411 3853.682135 0 1126 8634.022393 1150.341622 0 1127 587.205986 9831.869689 0 1128 7629.087215 6149.884292 0 1129 5587.807554 3088.789474 0 1130 8990.821646 8527.504497 0 1131 4817.150040 2203.828018 0 1132 6763.951785 7261.892414 0 1133 9955.062641 7903.781655 0 1134 912.468620 9899.408446 0 1135 8545.128156 5825.239384 0 1136 3309.311491 7329.277010 0 1137 5966.213047 957.655825 0 1138 5635.126251 201.969299 0 1139 7886.966474 8235.857556 0 1140 7301.155054 914.784135 0 1141 5880.937194 3913.955667 0 1142 1283.930523 8920.904441 0 1143 9422.941202 9222.836913 0 1144 5312.178281 8644.284895 0 1145 1978.362149 2954.839405 0 1146 9087.112411 5903.739702 0 1147 2260.158072 1300.974479 0 1148 2283.119206 4960.068821 0 1149 3034.890975 7344.217421 0 1150 2713.110090 784.376050 0 1151 8982.126478 6638.393060 0 1152 9740.642902 1819.970846 0 1153 8703.875586 171.955478 0 1154 5378.221322 4797.424352 0 1155 1261.963901 8151.187132 0 1156 2708.519331 8984.341526 0 1157 6994.134457 8523.605517 0 1158 8664.809635 7917.829797 0 1159 7364.883514 40.705196 0 1160 1434.300082 2071.320395 0 1161 5774.824148 33.746169 0 1162 1271.565269 4849.667068 0 1163 410.642736 3187.463876 0 1164 2199.883436 1744.070534 0 1165 3166.056474 8812.167677 0 1166 2314.426597 6491.588253 0 1167 7339.981815 6752.805837 0 1168 1887.454622 3498.007245 0 1169 2721.570384 5386.463299 0 1170 9690.351582 2178.725771 0 1171 5523.706927 654.766349 0 1172 3755.671688 9541.729509 0 1173 9084.773112 952.061379 0 1174 8525.258760 7157.063922 0 1175 9179.234573 4608.154606 0 1176 4225.550090 8961.529712 0 1177 5361.573115 7613.674983 0 1178 1776.421051 684.333389 0 1179 4404.938294 3270.515306 0 1180 5118.734542 3443.233358 0 1181 8625.880136 7356.049398 0 1182 3839.568611 1258.664710 0 1183 7098.445722 5410.855529 0 1184 1519.452829 347.847514 0 1185 6167.001832 5162.479487 0 1186 5754.552781 4158.612133 0 1187 4687.118396 3914.262130 0 1188 877.253495 5353.051230 0 1189 1216.042303 6734.886204 0 1190 7494.181741 1679.290386 0 1191 2015.116977 2407.111235 0 1192 5985.101192 4064.925840 0 1193 8875.303032 5479.671673 0 1194 5256.362721 2184.938900 0 1195 908.572539 9247.099896 0 1196 996.389874 1302.250222 0 1197 1953.083616 5768.263677 0 1198 6390.334414 4316.365019 0 1199 3948.975866 6410.272860 0 1200 2620.944505 8004.504477 0 1201 6400.497305 6028.626247 0 1202 288.766053 3453.742935 0 1203 7688.597946 2059.076406 0 1204 6444.941762 9747.197196 0 1205 4405.404792 5179.472616 0 1206 2120.401325 70.167642 0 1207 2366.011326 4718.399651 0 1208 6042.713692 8359.294284 0 1209 2900.188520 3290.444444 0 1210 7206.486384 6642.812632 0 1211 7145.224981 8772.847628 0 1212 886.813075 1244.863780 0 1213 4963.425276 6126.045929 0 1214 6540.715179 2300.974940 0 1215 1360.959814 9214.358619 0 1216 2400.708560 178.282372 0 1217 2829.125385 5171.999249 0 1218 6333.540259 7392.090237 0 1219 1455.887639 5078.761602 0 1220 3201.941452 7246.835163 0 1221 3594.942309 8111.433673 0 1222 1916.196287 9947.020061 0 1223 5214.396320 4238.451321 0 1224 7256.572078 3788.453295 0 1225 354.788090 4408.764249 0 1226 2877.941328 6612.116408 0 1227 5267.145722 8300.981194 0 1228 4892.791238 1553.458913 0 1229 1486.043325 5726.231592 0 1230 2648.739870 2115.992838 0 1231 9417.827141 1392.962593 0 1232 9160.704899 5362.275349 0 1233 9369.081943 8390.330824 0 1234 2988.782953 4701.966463 0 1235 852.830014 3666.713510 0 1236 9267.272808 1009.996794 0 1237 2456.372419 427.264201 0 1238 8608.282634 6835.875869 0 1239 5893.452174 4656.528296 0 1240 2600.435819 5858.435352 0 1241 7027.155799 7929.996504 0 1242 1624.741870 6253.035823 0 1243 6788.257943 5811.737548 0 1244 7277.542113 5177.836356 0 1245 9546.400644 6501.853685 0 1246 6280.476767 131.577643 0 1247 1435.417884 6010.715341 0 1248 7669.116547 1442.581182 0 1249 6368.285788 1543.463755 0 1250 7632.040442 8212.052255 0 1251 6206.139861 679.138981 0 1252 2794.384367 2695.312919 0 1253 4678.335382 7800.651361 0 1254 5783.178316 9919.561151 0 1255 7082.471481 1413.590672 0 1256 9791.291464 586.127814 0 1257 3328.572009 6372.512758 0 1258 3904.865526 221.724956 0 1259 2964.845870 2418.666870 0 1260 7761.490352 5925.539339 0 1261 1439.958978 8726.057226 0 1262 2129.985575 3196.783511 0 1263 8747.233973 7652.163599 0 1264 4208.310886 5192.717429 0 1265 9791.690195 7108.063574 0 1266 7157.291514 6557.821746 0 1267 9882.384717 9240.089297 0 1268 2982.393659 4451.579574 0 1269 6356.861164 2369.004175 0 1270 6472.839509 9032.728581 0 1271 3062.756887 3679.225381 0 1272 4499.396386 3863.176850 0 1273 6433.224190 519.692125 0 1274 7767.360789 2853.422873 0 1275 6220.060868 4238.682946 0 1276 6112.890902 5689.486991 0 1277 5175.578460 1603.231567 0 1278 75.227489 1069.767612 0 1279 3848.933928 2570.974842 0 1280 4847.970223 4708.313664 0 1281 5153.883353 1327.097014 0 1282 4974.087795 9504.868006 0 1283 1719.873674 155.433655 0 1284 3388.883640 7084.993698 0 1285 8607.508303 1092.679475 0 1286 312.027591 3101.367453 0 1287 6220.344731 9204.068496 0 1288 3304.235370 7793.622980 0 1289 1275.166941 6409.725556 0 1290 2499.635172 7611.782754 0 1291 9121.258667 4414.066238 0 1292 6872.183519 3540.376084 0 1293 8490.725565 4101.337445 0 1294 5840.778657 9864.544726 0 1295 5576.371908 4528.302486 0 1296 960.602463 9496.208042 0 1297 5248.997126 7007.913171 0 1298 6545.821837 2374.435469 0 1299 6370.706761 966.287957 0 1300 572.884059 8409.133203 0 1301 6007.820455 3013.725749 0 1302 5268.395925 5579.024827 0 1303 6777.782689 1.342816 0 1304 1444.483698 931.698333 0 1305 7530.860479 4523.347158 0 1306 1983.966026 3744.860581 0 1307 6694.545937 4612.240736 0 1308 5458.590476 9375.332702 0 1309 4003.231974 1032.539234 0 1310 1071.384499 7247.173578 0 1311 3124.695759 1150.380559 0 1312 7781.811603 8888.195685 0 1313 1023.568403 6165.138356 0 1314 7404.883583 2458.346480 0 1315 8366.688796 6840.124143 0 1316 4445.697976 1657.156234 0 1317 2578.327872 8294.681586 0 1318 1678.078282 7046.333464 0 1319 5709.425809 5607.179953 0 1320 163.316724 1227.012880 0 1321 3098.045668 6303.292421 0 1322 3814.354182 2564.918527 0 1323 3838.408234 4631.157565 0 1324 5945.831873 5597.474563 0 1325 3680.180176 4254.622731 0 1326 8062.392474 5890.153231 0 1327 9704.846959 6024.737152 0 1328 2832.906272 5131.155797 0 1329 4729.018333 8529.260886 0 1330 7374.995460 8805.877696 0 1331 7178.293534 2532.757919 0 1332 2728.153003 1638.084068 0 1333 8790.420161 9000.828077 0 1334 3235.643852 232.236413 0 1335 4742.675693 7883.794527 0 1336 7029.565371 6756.037194 0 1337 210.148691 1019.156237 0 1338 7292.159089 8185.511448 0 1339 1822.175324 8163.801610 0 1340 9512.804128 6016.347060 0 1341 5517.201657 329.223535 0 1342 4139.430291 4669.953942 0 1343 9534.540838 4408.611906 0 1344 119.109690 5671.001092 0 1345 681.208930 9920.195947 0 1346 6596.924967 7190.894523 0 1347 6934.871873 9409.961220 0 1348 4049.473078 2789.405451 0 1349 787.147166 228.210356 0 1350 4771.755093 7437.017288 0 1351 7392.411971 28.749421 0 1352 6166.599936 8317.821753 0 1353 8669.497139 7696.248502 0 1354 4188.807491 7039.576360 0 1355 7015.335134 642.034410 0 1356 388.884029 3461.326091 0 1357 6433.557377 3809.663041 0 1358 6449.897192 7615.127462 0 1359 7713.775950 2831.833250 0 1360 9717.371717 5537.946075 0 1361 6279.035839 6352.085418 0 1362 6733.461804 1540.079296 0 1363 6745.798053 4315.374711 0 1364 9686.896681 7141.501749 0 1365 9739.901341 9910.601584 0 1366 8339.999986 5861.931050 0 1367 6006.759577 4696.852233 0 1368 3696.745582 4187.407182 0 1369 9134.927361 6463.048367 0 1370 1699.272271 372.606473 0 1371 4391.511750 4408.662640 0 1372 658.247224 2267.571389 0 1373 3314.005228 3767.328860 0 1374 6249.037336 1559.911607 0 1375 8217.870659 4971.112972 0 1376 691.253675 995.868234 0 1377 9431.735844 319.852175 0 1378 6489.831506 1789.870784 0 1379 6542.052144 9875.936576 0 1380 9182.040816 4372.564679 0 1381 4315.035133 2894.398525 0 1382 4404.140063 9579.237069 0 1383 378.596646 4788.353753 0 1384 8957.258530 1066.111226 0 1385 1167.206949 8147.708605 0 1386 2828.262205 7979.360618 0 1387 3018.071681 323.065041 0 1388 8198.340555 3318.195623 0 1389 4613.055666 598.516894 0 1390 6508.329638 8289.528735 0 1391 2197.559694 9332.063455 0 1392 6335.950740 5481.974850 0 1393 2058.510659 8760.684287 0 1394 4239.490482 426.617026 0 1395 9257.784493 3688.474820 0 1396 2945.899912 580.002144 0 1397 330.957668 431.038451 0 1398 8749.608442 8678.801445 0 1399 4697.319690 812.474756 0 1400 1392.529683 9475.226532 0 1401 5607.111911 7955.916979 0 1402 768.319868 653.190882 0 1403 7771.265332 1158.088088 0 1404 8207.014509 9344.493262 0 1405 4328.310645 1151.308602 0 1406 7176.222269 4456.861689 0 1407 5014.112720 8879.866240 0 1408 5398.563303 1381.966833 0 1409 3725.113551 8496.614726 0 1410 5114.458511 807.469385 0 1411 5065.434721 350.951011 0 1412 8793.068197 2481.148473 0 1413 7291.780918 9946.429385 0 1414 8963.647661 5286.291459 0 1415 3241.472137 6987.476690 0 1416 5466.113194 9088.022136 0 1417 2421.752927 6934.551454 0 1418 1524.853826 4050.921787 0 1419 7773.906437 3643.499444 0 1420 2836.242984 3529.022895 0 1421 3736.540677 79.771280 0 1422 1431.230400 7405.762425 0 1423 6927.872539 6524.823897 0 1424 1368.535100 1158.320593 0 1425 4895.520340 4839.041879 0 1426 1257.995462 9658.229147 0 1427 8173.442270 8722.169402 0 1428 1721.920141 6565.363880 0 1429 8132.308181 3235.148281 0 1430 9853.467690 950.747393 0 1431 7932.290397 1446.112143 0 1432 2513.133460 1895.184788 0 1433 1157.396705 6708.926237 0 1434 2429.591891 7992.529601 0 1435 7694.447868 9574.215731 0 1436 7746.918047 9900.308280 0 1437 5573.257980 319.905105 0 1438 3320.084604 3940.799462 0 1439 9663.157296 4211.298491 0 1440 2701.712309 7997.463134 0 1441 9197.823946 466.748382 0 1442 9809.719717 7226.808226 0 1443 9957.520540 6485.574575 0 1444 77.847524 6783.248280 0 1445 2267.303069 9884.641914 0 1446 9320.839705 8607.582359 0 1447 7086.606039 2533.936230 0 1448 9266.405325 8226.150537 0 1449 6339.284116 1709.526740 0 1450 1992.472848 5669.192866 0 1451 5932.997098 4080.112896 0 1452 8135.186336 6783.772561 0 1453 2580.555454 300.441444 0 1454 6067.875636 3293.979553 0 1455 8898.359567 2342.045723 0 1456 5486.333059 1979.288527 0 1457 9667.289557 6429.395418 0 1458 7530.833547 8908.563270 0 1459 4538.817694 5467.404176 0 1460 4496.391385 6190.781441 0 1461 3347.538632 8219.636034 0 1462 3652.176195 7713.830083 0 1463 166.987584 3636.849387 0 1464 4798.943093 9010.516124 0 1465 7223.662487 7338.042696 0 1466 6366.444961 9007.484894 0 1467 7249.197281 6314.746432 0 1468 9208.560093 7641.952157 0 1469 147.885506 8686.193819 0 1470 1881.924615 7483.751066 0 1471 4133.822304 3923.049358 0 1472 1538.541144 4288.644223 0 1473 9994.439441 8272.905272 0 1474 7367.414215 6429.373678 0 1475 2146.756817 631.684713 0 1476 9327.207517 9085.470778 0 1477 22.189118 9110.860451 0 1478 7488.605841 987.453311 0 1479 1542.225275 1763.696849 0 1480 2566.081026 9028.238330 0 1481 4211.799228 5384.771878 0 1482 4243.435673 4640.972996 0 1483 2508.066118 3151.209523 0 1484 2524.494136 2848.974271 0 1485 6079.208293 233.135708 0 1486 9372.869182 5137.407850 0 1487 5021.229327 4218.778556 0 1488 7310.058374 7613.046274 0 1489 7223.698276 9653.965236 0 1490 4144.969028 856.433582 0 1491 7983.360237 7124.728248 0 1492 254.502820 4928.202680 0 1493 8097.742229 9482.693935 0 1494 3496.808078 4717.498759 0 1495 4449.044507 7440.909202 0 1496 7034.542330 4749.024926 0 1497 1850.183294 5871.409532 0 1498 249.899969 3557.468966 0 1499 3078.618082 666.849630 0 1500 973.935587 7883.162320 0 1501 4531.563940 1287.153958 0 1502 9339.906610 3156.474221 0 1503 4402.269338 6948.143540 0 1504 1545.310429 7824.975174 0 1505 8453.201745 4912.519853 0 1506 7094.561720 7233.790889 0 1507 9918.693842 7752.477605 0 1508 3607.700685 5106.911157 0 1509 3938.390673 5351.054493 0 1510 8957.651227 961.948954 0 1511 8942.129994 5039.078753 0 1512 1454.011207 9338.910903 0 1513 1945.641789 269.775576 0 1514 4708.706146 5736.693034 0 1515 505.409400 6288.734113 0 1516 5631.206940 5631.497373 0 1517 809.506573 3567.474702 0 1518 1305.786660 4679.165625 0 1519 3706.209290 3298.344694 0 1520 8817.984842 6242.448813 0 1521 1100.561865 6573.683270 0 1522 9962.462901 3652.919693 0 1523 7705.231533 6571.483743 0 1524 4750.520692 4046.014967 0 1525 2139.490924 4177.612204 0 1526 2668.128158 4863.059404 0 1527 6693.754903 8868.669672 0 1528 1454.252782 8097.781852 0 1529 7619.610907 6280.694736 0 1530 1920.745914 717.071132 0 1531 1368.516122 3218.503994 0 1532 2913.727447 8103.970844 0 1533 3435.913194 1622.694467 0 1534 9757.208983 7048.934127 0 1535 8033.085258 4972.207185 0 1536 968.989621 5862.592876 0 1537 4447.430576 3180.497227 0 1538 874.817048 3161.120203 0 1539 2723.104055 3562.621896 0 1540 7133.340686 1166.334310 0 1541 3788.410747 7588.658059 0 1542 3096.883620 8559.724000 0 1543 8640.600741 1892.224152 0 1544 6495.877974 6394.164576 0 1545 1697.552118 5577.767056 0 1546 4752.420109 2407.381913 0 1547 7129.982823 8953.795750 0 1548 8964.844250 1057.684425 0 1549 3788.521867 892.505526 0 1550 4638.620949 6631.805833 0 1551 7068.858232 577.052975 0 1552 1130.423855 6321.635032 0 1553 8349.313841 6075.126372 0 1554 939.125067 818.381054 0 1555 5806.107677 2169.046540 0 1556 7476.315416 3021.301541 0 1557 8259.390548 9020.994169 0 1558 5310.617794 7026.649733 0 1559 7640.663932 6266.712112 0 1560 6467.955322 4036.817198 0 1561 8928.123481 1772.023135 0 1562 1618.418606 7243.855975 0 1563 2114.216733 5201.211111 0 1564 9014.637304 3575.815087 0 1565 7356.122692 8690.669753 0 1566 6586.534443 907.950575 0 1567 5163.514869 7970.425024 0 1568 9977.688961 4586.596773 0 1569 562.615629 3491.423143 0 1570 4994.984957 9294.026437 0 1571 651.803846 9158.093912 0 1572 4399.746391 995.321003 0 1573 7516.167479 1210.794696 0 1574 1339.801416 2368.636624 0 1575 5472.401329 6603.183783 0 1576 8603.698637 5897.370128 0 1577 6374.894444 4811.938249 0 1578 5043.045579 6629.657960 0 1579 2699.449418 2959.918903 0 1580 6229.788190 6217.398861 0 1581 1801.959967 1957.102530 0 1582 5484.338679 8332.419776 0 1583 3117.826986 1739.949071 0 1584 485.470105 5301.652475 0 1585 5284.547773 6126.639736 0 1586 5465.659107 6589.534758 0 1587 8701.314734 3174.993963 0 1588 7960.419904 2267.391384 0 1589 3308.709785 4943.836417 0 1590 5196.334773 7376.835931 0 1591 260.521544 7384.138218 0 1592 8061.288606 13.983777 0 1593 5619.914073 187.271673 0 1594 1383.187530 8711.893939 0 1595 549.616540 9074.001857 0 1596 6674.904465 7659.259369 0 1597 6752.260182 7583.811598 0 1598 7319.631292 8948.595210 0 1599 3598.452803 3828.136175 0 1600 6494.261395 5301.642092 0 1601 6785.226314 3681.592785 0 1602 4187.250675 3921.367803 0 1603 396.348208 7368.454801 0 1604 5689.624250 8859.482515 0 1605 7379.068882 4149.041336 0 1606 7754.458949 634.103461 0 1607 6361.260424 9311.912426 0 1608 8916.117235 3164.082076 0 1609 2805.683232 2948.581262 0 1610 8866.509829 3422.509396 0 1611 4133.494384 3296.916992 0 1612 2662.260124 8700.985484 0 1613 4436.668440 5342.148940 0 1614 4013.378968 3353.405888 0 1615 4035.922139 8948.857990 0 1616 2803.176785 6967.283265 0 1617 2140.564162 9092.121923 0 1618 4669.257459 2987.763986 0 1619 4285.705443 7397.572534 0 1620 8564.085657 8125.955662 0 1621 1298.098558 9673.060863 0 1622 4773.232280 9511.045291 0 1623 1708.125072 9409.137884 0 1624 1929.635039 8693.907628 0 1625 2706.808932 8409.506344 0 1626 1638.153761 8547.580330 0 1627 6613.646037 1213.988474 0 1628 9368.612040 4340.229032 0 1629 1836.923966 8436.692800 0 1630 543.985107 382.333301 0 1631 7372.428178 898.711591 0 1632 7464.114481 944.673187 0 1633 9396.662607 1373.419996 0 1634 5629.438476 6460.885954 0 1635 3662.071310 958.022280 0 1636 4882.917339 3356.533168 0 1637 8909.362295 2031.653196 0 1638 2237.789315 5971.925450 0 1639 4439.899892 2869.796313 0 1640 1403.416054 8398.125842 0 1641 955.484044 9039.653852 0 1642 9404.428133 1302.522509 0 1643 9246.369577 2657.102441 0 1644 7924.697375 3246.617106 0 1645 4455.943256 7104.927252 0 1646 5462.393619 7545.869655 0 1647 3963.082955 623.061224 0 1648 3434.608462 8846.350182 0 1649 8023.287157 9261.822285 0 1650 5891.913632 3282.105853 0 1651 4817.143649 4931.903876 0 1652 2450.115411 8712.673613 0 1653 590.707015 3315.691215 0 1654 9781.433351 5603.438934 0 1655 9438.265969 62.158912 0 1656 8116.461830 6255.238664 0 1657 8564.056243 7346.125808 0 1658 9998.630626 3377.459323 0 1659 7439.948056 8446.190273 0 1660 6932.835956 7912.671073 0 1661 8191.626666 2717.848455 0 1662 2832.329275 4044.767161 0 1663 237.744362 9050.500576 0 1664 8110.697203 1318.251029 0 1665 8186.107077 3295.591496 0 1666 6068.127837 4891.977593 0 1667 4446.856976 6090.114960 0 1668 9073.713210 4141.041548 0 1669 266.610257 8513.806997 0 1670 9519.006876 8071.768121 0 1671 1566.726124 4211.789509 0 1672 7568.823882 8636.110459 0 1673 8698.626966 9236.366193 0 1674 6416.137649 1386.641779 0 1675 4201.578485 9594.957109 0 1676 1322.257794 9329.491150 0 1677 3595.781325 5908.791882 0 1678 8134.525722 929.191205 0 1679 1123.598010 4783.677533 0 1680 9043.240005 9702.757660 0 1681 6543.029244 1914.820524 0 1682 7934.215729 3762.200425 0 1683 2643.104967 5899.113063 0 1684 4429.253184 5191.911440 0 1685 9704.454686 383.772352 0 1686 8735.509101 4334.902384 0 1687 8457.350151 8760.753032 0 1688 7368.546705 4737.570659 0 1689 5217.381181 5960.785652 0 1690 3955.148309 7135.414392 0 1691 8547.520549 3369.465412 0 1692 9545.046461 5627.207186 0 1693 2936.351433 1627.391739 0 1694 7263.390699 2810.875118 0 1695 8088.845087 9469.512412 0 1696 3524.979780 3779.824015 0 1697 3017.998547 2556.663134 0 1698 9986.624615 8277.110768 0 1699 8650.833920 276.929041 0 1700 9523.915492 8238.698622 0 1701 8232.699870 9266.142129 0 1702 4117.166629 768.718099 0 1703 5694.464464 5356.924986 0 1704 2159.310156 7423.940484 0 1705 9851.825949 7162.718818 0 1706 7941.425748 7727.368710 0 1707 8105.059333 1595.964563 0 1708 6055.951833 6083.176736 0 1709 8740.325716 4379.010407 0 1710 2601.709084 5366.216903 0 1711 4936.004659 168.272082 0 1712 487.761169 1881.063966 0 1713 4925.716501 6585.434020 0 1714 5209.832064 5748.840402 0 1715 9919.995559 876.432966 0 1716 3727.013681 5453.669936 0 1717 7906.527966 8837.136104 0 1718 6202.399085 6555.693620 0 1719 8943.519708 7919.891792 0 1720 5807.707928 121.801091 0 1721 4126.087006 708.859066 0 1722 9629.775232 8266.341147 0 1723 3459.724845 1004.475303 0 1724 5640.863862 3521.081734 0 1725 7232.655288 8372.969750 0 1726 5969.778963 8183.181763 0 1727 84.745022 2334.586443 0 1728 4306.518403 4650.245107 0 1729 8127.393946 1755.046970 0 1730 5728.921775 5379.265030 0 1731 6478.902010 136.917358 0 1732 437.305257 908.927182 0 1733 3933.943464 5977.515144 0 1734 7340.068088 6509.079676 0 1735 1075.119974 8658.267486 0 1736 3945.079923 8163.586354 0 1737 1711.594525 3802.917155 0 1738 6704.352298 6300.878780 0 1739 5187.904999 9231.385552 0 1740 8115.587708 5958.526078 0 1741 6776.652562 4151.992462 0 1742 5129.018350 6302.580315 0 1743 8374.080720 1999.779667 0 1744 4577.240924 1840.407518 0 1745 1972.001360 356.797963 0 1746 1191.819109 7573.503801 0 1747 3299.512769 3047.506049 0 1748 1438.838778 5763.817856 0 1749 4150.857797 552.648376 0 1750 3825.866192 8076.087319 0 1751 7567.726789 9747.391700 0 1752 8574.756974 4976.905373 0 1753 7923.760889 7853.888886 0 1754 4100.255874 3871.490369 0 1755 5600.950020 4425.617075 0 1756 6229.383997 8137.726066 0 1757 9189.694304 6433.264287 0 1758 5248.078870 2158.247122 0 1759 3995.767943 2242.464317 0 1760 7288.468411 5402.910047 0 1761 1532.848543 1652.205684 0 1762 281.737694 1137.897308 0 1763 6191.683483 6376.427337 0 1764 5282.658087 7894.354923 0 1765 5464.886830 2564.130426 0 1766 7655.520051 3664.324517 0 1767 444.884413 2161.664569 0 1768 4447.483768 6131.156107 0 1769 7795.114101 8614.545311 0 1770 7742.885952 7514.586691 0 1771 5893.447419 1931.996892 0 1772 6661.420696 6943.806025 0 1773 2680.943496 3711.028757 0 1774 2938.282792 9956.506138 0 1775 6971.169346 3591.722644 0 1776 1947.604337 3405.439200 0 1777 2411.811350 8307.803065 0 1778 1880.155033 3784.528235 0 1779 5349.324717 2514.374380 0 1780 1688.856108 9613.809686 0 1781 9036.723330 268.641105 0 1782 5335.792651 437.319468 0 1783 4337.224639 1095.205341 0 1784 8045.234435 2009.934002 0 1785 3006.040136 858.180068 0 1786 9682.195269 5001.241190 0 1787 4221.911555 5528.521490 0 1788 1794.680293 7975.048357 0 1789 2871.146555 8469.264567 0 1790 7391.753626 2946.944622 0 1791 4860.386841 2944.689262 0 1792 9401.969233 8489.749500 0 1793 5389.903231 6897.376719 0 1794 776.869765 8007.330462 0 1795 3582.967477 2685.645814 0 1796 3277.090708 8892.022595 0 1797 1032.964050 9865.056510 0 1798 4635.799514 6273.891803 0 1799 5066.447044 626.982818 0 1800 7657.348324 4010.489268 0 1801 4821.173423 8215.264872 0 1802 3115.735388 1409.598983 0 1803 456.242368 6899.677947 0 1804 663.350557 5934.463902 0 1805 681.420920 1129.062091 0 1806 3938.941079 2918.773191 0 1807 1072.407397 9418.707909 0 1808 9464.720159 9626.663573 0 1809 9804.231341 9095.307740 0 1810 5660.340492 4042.665734 0 1811 7418.233485 5237.682713 0 1812 2273.312873 7757.118661 0 1813 1630.548287 6517.861345 0 1814 9497.664058 5353.005499 0 1815 1454.151369 3583.347834 0 1816 5107.630212 4320.820851 0 1817 1490.920106 5981.803730 0 1818 8800.125583 9716.833259 0 1819 1813.825649 6583.084752 0 1820 217.639158 1498.194643 0 1821 5133.794570 6064.208812 0 1822 2478.770919 7347.227390 0 1823 8920.513657 9700.718442 0 1824 1039.268206 6833.388245 0 1825 5229.902537 6980.796525 0 1826 9334.128834 2864.592994 0 1827 8813.122110 906.098724 0 1828 413.289713 9250.862703 0 1829 2589.293458 7106.481667 0 1830 2197.654545 5882.895805 0 1831 3402.853180 7229.989229 0 1832 7448.100425 9023.353835 0 1833 8033.723669 4501.603380 0 1834 1273.131448 6713.911526 0 1835 4392.496566 7088.041997 0 1836 9881.931675 3347.731624 0 1837 4436.746763 3432.675506 0 1838 3212.927627 2425.021143 0 1839 3528.671468 3620.311169 0 1840 3584.255867 9479.166844 0 1841 3751.970545 174.192145 0 1842 9648.469435 5810.288305 0 1843 3082.010403 7937.678814 0 1844 220.100697 8546.083039 0 1845 1188.178682 241.981181 0 1846 1433.754645 8352.146829 0 1847 507.315595 9137.843591 0 1848 2918.247652 1969.924923 0 1849 6550.393877 2424.233332 0 1850 5652.366734 7639.004903 0 1851 6676.871362 3173.833686 0 1852 6333.280258 6288.085229 0 1853 207.363521 4608.392289 0 1854 6327.251788 3815.807791 0 1855 1604.280004 9126.367081 0 1856 108.659875 8652.750924 0 1857 1667.026473 9913.870370 0 1858 9106.861357 918.305469 0 1859 7676.405911 6678.130643 0 1860 8646.407889 4963.910599 0 1861 3120.943201 7907.833187 0 1862 7364.090804 5363.828191 0 1863 9854.026411 7694.747947 0 1864 4971.408173 9258.092837 0 1865 5058.197515 8431.087567 0 1866 499.528143 1299.088056 0 1867 2129.408193 2321.091376 0 1868 1404.302873 415.333778 0 1869 5596.194945 5899.708035 0 1870 7265.297681 6148.554864 0 1871 4531.567592 4499.118879 0 1872 140.632893 6163.993833 0 1873 6359.109843 6257.350511 0 1874 9616.982290 7032.759974 0 1875 2107.328111 6106.155165 0 1876 5539.242349 6728.060499 0 1877 5948.262999 7574.364398 0 1878 4580.279408 5668.607894 0 1879 9256.495043 2639.105436 0 1880 6624.839180 7379.454979 0 1881 8211.725303 5733.106487 0 1882 9741.885160 9629.280396 0 1883 5137.253722 4522.131044 0 1884 1032.524699 5871.642740 0 1885 3110.445240 6879.992938 0 1886 7162.163216 8660.255025 0 1887 7430.999503 8093.983614 0 1888 8410.985318 9958.713480 0 1889 3290.791648 5888.470047 0 1890 5572.364866 5708.753144 0 1891 6677.757129 9369.255076 0 1892 182.915108 3101.260420 0 1893 4625.930645 5168.251296 0 1894 9068.796264 4996.422733 0 1895 2365.186756 8572.706797 0 1896 5147.034846 7843.004087 0 1897 2641.048446 9449.617173 0 1898 4013.826594 4468.536445 0 1899 4767.582216 3309.836761 0 1900 7585.800578 5762.290267 0 1901 6034.903149 6009.530855 0 1902 2944.081061 3417.224638 0 1903 911.694031 3849.970360 0 1904 2622.603239 3486.736810 0 1905 6247.323745 6849.982511 0 1906 7484.924031 2215.049618 0 1907 1830.642935 9681.681354 0 1908 4664.742221 4757.560946 0 1909 830.340008 6870.713234 0 1910 1724.743735 522.172360 0 1911 2509.775114 9661.515047 0 1912 3324.374360 570.240571 0 1913 6702.949877 1740.219591 0 1914 2847.310892 4761.225361 0 1915 5405.943953 3028.401011 0 1916 9247.693291 7578.382091 0 1917 6268.069619 751.063003 0 1918 8180.256810 8291.662560 0 1919 8083.825368 8310.574116 0 1920 1737.933856 8989.503206 0 1921 2945.820294 2644.297294 0 1922 18.276531 1577.637661 0 1923 3475.838972 2333.164373 0 1924 8741.352382 476.655243 0 1925 4451.756834 3788.598675 0 1926 8647.493914 8354.404124 0 1927 3244.265096 6781.846211 0 1928 4592.132119 2500.452043 0 1929 6965.888826 4652.134784 0 1930 6955.547539 7379.475191 0 1931 5619.680290 2643.326305 0 1932 1371.817966 104.908888 0 1933 4231.079111 6605.883894 0 1934 8266.763805 2848.967597 0 1935 682.370762 4816.184013 0 1936 3384.730761 3343.867900 0 1937 472.817923 5199.316981 0 1938 4422.071094 7074.155511 0 1939 6782.754646 3826.192194 0 1940 426.365102 9715.686282 0 1941 2029.545286 7390.365088 0 1942 5614.183936 301.179649 0 1943 7331.804897 9724.465110 0 1944 1496.928319 7153.469715 0 1945 5720.485038 5406.734831 0 1946 4335.113777 4467.049112 0 1947 1719.664785 3606.946688 0 1948 6754.662566 8490.921695 0 1949 7361.298080 6262.516251 0 1950 2290.119483 54.726084 0 1951 8582.817084 7663.664645 0 1952 9467.861585 1357.565075 0 1953 9739.249095 3301.040597 0 1954 5637.915743 193.695578 0 1955 7944.385822 9349.625719 0 1956 9462.520672 1549.238792 0 1957 1395.494279 5477.570682 0 1958 4074.486970 187.281621 0 1959 2882.130991 7787.005794 0 1960 7642.435805 2372.466519 0 1961 9193.394483 3675.815297 0 1962 7696.239752 3423.535532 0 1963 9863.080202 6762.128076 0 1964 3709.567514 647.145540 0 1965 1877.231699 9471.393075 0 1966 5751.570109 7998.150673 0 1967 2128.001514 5243.697627 0 1968 6002.883623 9389.905022 0 1969 5055.802001 9239.143290 0 1970 3187.009587 5827.318695 0 1971 6252.779113 960.631416 0 1972 1654.956293 2554.136624 0 1973 2622.687328 1849.229514 0 1974 4185.919639 974.026644 0 1975 1497.146805 8556.453049 0 1976 1793.264921 4476.194812 0 1977 809.067069 7966.040997 0 1978 2680.739676 6624.720346 0 1979 8193.341579 4140.231383 0 1980 2069.296181 1577.090962 0 1981 4597.329646 5946.028115 0 1982 6588.860735 5866.214834 0 1983 2442.281378 15.736026 0 1984 1364.804807 4410.874204 0 1985 9689.107233 5676.110745 0 1986 9797.749005 8410.816122 0 1987 9959.809064 2893.958883 0 1988 6898.728251 4308.750704 0 1989 8710.053616 6133.253740 0 1990 4039.588244 9432.240463 0 1991 8411.693196 4937.000468 0 1992 4251.790194 4032.727475 0 1993 4050.457333 3099.709613 0 1994 1673.463498 8303.700933 0 1995 1218.578853 6228.982542 0 1996 1591.595752 8678.484290 0 1997 2278.090247 1257.416774 0 1998 177.781727 9047.309716 0 1999 7886.689661 3136.096185 0 2000 8644.882914 5080.254805 0 2001 2190.475189 5675.835299 0 2002 285.669527 6956.963847 0 2003 2712.493778 3738.041372 0 2004 8627.767733 6233.814242 0 2005 9592.750202 2266.163372 0 2006 66.857429 8519.898340 0 2007 6091.189935 1330.711012 0 2008 2534.988427 9470.997575 0 2009 5772.401229 5537.276804 0 2010 7708.637053 9012.872054 0 2011 3901.918722 8244.986732 0 2012 8690.824356 9550.707991 0 2013 4804.034111 8926.365143 0 2014 8233.124738 4696.195767 0 2015 7179.086491 1350.405666 0 2016 7444.777608 3962.254126 0 2017 8279.099347 3449.714207 0 2018 7975.476693 2901.244309 0 2019 4987.326805 3971.804880 0 2020 9963.811755 2411.062404 0 2021 8420.346190 8078.821222 0 2022 9467.437953 6927.488385 0 2023 4965.879229 9417.121668 0 2024 377.606432 9077.370154 0 2025 7420.564920 2024.934555 0 2026 2924.670926 8639.124217 0 2027 1037.461110 2702.941311 0 2028 1506.753173 2093.135290 0 2029 1303.815332 3471.034781 0 2030 8731.226294 5929.737523 0 2031 1591.843222 1047.487194 0 2032 9979.840736 2523.838846 0 2033 2866.089961 1857.237448 0 2034 2790.295673 9446.133363 0 2035 3710.946821 4136.607294 0 2036 3343.358615 5957.731199 0 2037 5246.206494 2606.600363 0 2038 1076.711562 5547.100152 0 2039 5573.873729 565.774816 0 2040 3414.794335 4241.522447 0 2041 4839.065507 3176.177285 0 2042 6694.093241 8012.677523 0 2043 1193.224074 4218.587648 0 2044 6676.181039 5925.934090 0 2045 8724.155519 8704.765869 0 2046 5454.954531 8878.950903 0 2047 8065.402135 1502.567458 0 2048 92.545385 3864.733713 0 2049 3650.466562 281.836046 0 2050 8104.244794 5163.515627 0 2051 9759.792680 8334.924791 0 2052 8078.279986 3990.177329 0 2053 9434.240752 7132.795983 0 2054 1050.371052 5538.214609 0 2055 2112.381631 6424.640086 0 2056 4024.394538 410.344592 0 2057 8994.877866 9194.922375 0 2058 6367.230293 2078.111088 0 2059 4117.126209 6946.494031 0 2060 1158.592806 2071.863811 0 2061 905.229457 9340.074042 0 2062 7549.184694 1374.263560 0 2063 2356.468731 6572.699304 0 2064 9737.048832 2153.837823 0 2065 8482.440590 4352.408662 0 2066 8574.682489 114.065480 0 2067 5222.963041 4186.591187 0 2068 7872.785867 9611.606710 0 2069 1017.425717 7532.409699 0 2070 3629.578266 8815.622377 0 2071 8639.032046 9973.961655 0 2072 5093.361380 4987.823336 0 2073 2120.434684 511.554969 0 2074 9054.570247 1081.787740 0 2075 4322.035062 1014.514102 0 2076 374.437280 3278.273071 0 2077 1145.087601 2830.176426 0 2078 9927.925773 2405.325389 0 2079 7878.817864 7889.321936 0 2080 649.010844 3915.638736 0 2081 1491.809778 3246.642740 0 2082 1304.511818 1379.169154 0 2083 7143.985001 541.873162 0 2084 4766.224813 5517.705249 0 2085 4243.155708 2475.049586 0 2086 6231.849850 973.032291 0 2087 1746.770644 2953.642540 0 2088 4491.778348 2018.732424 0 2089 6493.316179 2618.585064 0 2090 4789.924189 8048.965518 0 2091 6690.808845 6027.033196 0 2092 8323.253659 4039.858755 0 2093 4300.081451 3905.933884 0 2094 1308.840791 5965.612050 0 2095 4901.841068 7980.003970 0 2096 6085.676022 3452.753699 0 2097 8592.799348 2765.224353 0 2098 3055.763576 8693.909419 0 2099 9799.201182 2117.278233 0 2100 2247.425339 5793.163651 0 2101 244.153169 8150.552886 0 2102 4264.374519 7311.272007 0 2103 252.919761 7945.727380 0 2104 5483.995884 219.306108 0 2105 482.487310 4070.107263 0 2106 6232.131667 4530.390973 0 2107 6437.355580 9003.933412 0 2108 3819.796600 4207.492938 0 2109 7951.416726 436.615780 0 2110 3390.245888 624.846693 0 2111 6536.338166 6742.623431 0 2112 6640.086928 6204.948253 0 2113 7460.079631 139.179519 0 2114 6302.034298 6303.952940 0 2115 8342.715991 7543.729435 0 2116 344.180853 5920.656590 0 2117 4118.722366 2796.191804 0 2118 1083.005904 1215.884228 0 2119 1554.926452 2391.066196 0 2120 4830.723697 6047.390395 0 2121 2599.166438 2041.053254 0 2122 5220.524261 4880.315948 0 2123 751.589825 2285.113642 0 2124 3938.173927 9342.155655 0 2125 4582.364713 2462.484109 0 2126 8737.602663 9981.877664 0 2127 1554.301115 8723.695775 0 2128 4908.714996 2563.297794 0 2129 8122.247546 5493.998009 0 2130 5524.240732 6973.374088 0 2131 3904.902500 7005.366273 0 2132 7415.888203 8087.955500 0 2133 482.263258 3067.177786 0 2134 5829.951054 6662.034575 0 2135 5963.918771 8029.470624 0 2136 3320.891021 6399.752711 0 2137 5329.642388 8423.967888 0 2138 2988.758077 5346.725918 0 2139 2373.515765 9247.145938 0 2140 9629.483798 3037.157077 0 2141 8626.981118 4343.426248 0 2142 2919.972747 3805.966923 0 2143 7432.654971 9838.493604 0 2144 8303.625525 8431.671343 0 2145 3032.824121 1950.982146 0 2146 2425.024912 9428.693617 0 2147 1638.456681 2128.318803 0 2148 7936.601971 8670.403126 0 2149 2447.842976 5227.617915 0 2150 3645.493194 8631.657739 0 2151 5852.881070 4764.897707 0 2152 6796.456881 9848.979202 0 2153 6387.562537 8081.487680 0 2154 8114.522790 2649.499030 0 2155 3902.496501 1988.765674 0 2156 6038.760704 7867.194642 0 2157 4159.405412 3331.323854 0 2158 4269.587458 7215.553550 0 2159 406.276008 9244.578516 0 2160 6611.908000 5725.637793 0 2161 141.827010 862.096849 0 2162 1509.824914 6163.977756 0 2163 5592.150035 1641.865589 0 2164 8593.965823 3321.920516 0 2165 1397.414990 2918.738196 0 2166 7508.576730 4864.605311 0 2167 6378.594941 2694.008138 0 2168 6202.509641 2464.314933 0 2169 132.460661 7170.565577 0 2170 4417.951724 3015.857840 0 2171 5260.958152 3810.149690 0 2172 8075.777115 9703.798352 0 2173 6521.490452 384.788004 0 2174 6538.479094 92.250222 0 2175 3994.628590 916.214509 0 2176 8634.872758 261.095759 0 2177 6779.242596 4621.691310 0 2178 5091.269257 2589.096799 0 2179 3770.261933 4329.016645 0 2180 4502.317232 4884.087456 0 2181 8349.205272 6308.699705 0 2182 8602.969463 5157.189004 0 2183 5235.847400 6287.506876 0 2184 7119.958091 7346.429888 0 2185 5591.284329 3998.463252 0 2186 2772.802877 7374.976545 0 2187 593.730831 9571.704989 0 2188 9898.185527 8967.728919 0 2189 8872.228466 9572.925255 0 2190 6009.625017 8357.278988 0 2191 1854.855724 4590.284659 0 2192 229.171625 3543.798346 0 2193 4349.612139 1733.368191 0 2194 7130.808199 1763.895441 0 2195 1604.523989 7494.573870 0 2196 9100.188591 9252.381233 0 2197 8668.432588 1987.322368 0 2198 6052.054238 5319.507016 0 2199 512.012098 2300.059350 0 2200 5723.264498 8588.443076 0 2201 7550.071878 8122.364078 0 2202 4548.111469 9536.645541 0 2203 6113.783366 2790.198738 0 2204 3310.098797 3744.128419 0 2205 1307.235142 6432.120162 0 2206 5367.166185 8235.687743 0 2207 973.809733 1535.413576 0 2208 3379.588978 2169.147770 0 2209 2511.318678 3520.336719 0 2210 3539.374192 5076.403758 0 2211 7396.904156 5197.171107 0 2212 8912.240336 631.633993 0 2213 6562.907206 6612.787023 0 2214 9321.148478 5757.196235 0 2215 7107.219951 4594.514801 0 2216 740.917232 996.796915 0 2217 4556.416261 6274.717908 0 2218 3818.797375 1846.129478 0 2219 8678.634432 9580.727297 0 2220 3442.078190 2784.196308 0 2221 1411.120972 9738.283652 0 2222 5666.360814 5460.763940 0 2223 3135.726445 8005.613506 0 2224 1885.098037 6659.548491 0 2225 6700.441141 9358.466196 0 2226 8333.341719 4444.937761 0 2227 7233.878644 5070.374415 0 2228 1364.483428 5398.687574 0 2229 7193.726688 9273.090756 0 2230 5558.218971 2651.929412 0 2231 5134.570179 6951.122189 0 2232 2844.888000 1314.119774 0 2233 1929.158913 3004.650387 0 2234 2070.203680 2943.755314 0 2235 421.652006 4363.381233 0 2236 6913.548182 103.383339 0 2237 1665.126508 1032.515866 0 2238 4190.388488 8743.992356 0 2239 2687.952427 4015.783332 0 2240 3541.479600 1551.849449 0 2241 912.618661 2149.842356 0 2242 419.557614 3933.607107 0 2243 7597.502722 2784.628669 0 2244 9891.824811 5040.961110 0 2245 7563.753295 5679.946064 0 2246 5677.459764 7815.865240 0 2247 7844.427023 2053.383014 0 2248 1606.862610 1841.683868 0 2249 2315.302345 783.818140 0 2250 2317.201748 3973.523186 0 2251 6301.478799 275.879960 0 2252 6146.418101 7100.878046 0 2253 8915.074193 6558.158252 0 2254 5673.653499 2980.663217 0 2255 3822.215133 6132.231107 0 2256 8028.042368 3487.228981 0 2257 6658.550908 3637.524785 0 2258 6190.203472 442.979768 0 2259 1011.314344 6589.016874 0 2260 8574.289098 3102.616689 0 2261 7405.789949 7720.361203 0 2262 680.671100 6706.020057 0 2263 4351.615077 2006.210349 0 2264 2043.978310 8215.242070 0 2265 6770.399640 4053.392672 0 2266 4727.773886 1610.029575 0 2267 9891.884625 5248.584856 0 2268 739.638199 4128.002869 0 2269 8779.346548 3200.733360 0 2270 7326.382561 800.782931 0 2271 7676.953894 6123.445879 0 2272 4553.793491 1928.850316 0 2273 4892.812943 7954.303281 0 2274 510.213312 2503.945826 0 2275 2917.686964 2944.192800 0 2276 6680.905628 9295.015468 0 2277 5900.670067 6560.893876 0 2278 4930.723613 4717.760406 0 2279 7211.164345 6840.969887 0 2280 3666.702728 4798.285411 0 2281 699.088622 3082.271607 0 2282 7525.236005 9811.586098 0 2283 4633.684855 4424.708161 0 2284 1447.303651 6894.746459 0 2285 8885.169429 643.647109 0 2286 6478.010309 2091.935991 0 2287 1354.465483 6652.157048 0 2288 2860.575367 810.875235 0 2289 7296.242342 8726.589945 0 2290 5843.971426 7673.426172 0 2291 6909.303583 5378.867012 0 2292 4558.336646 5553.195513 0 2293 2778.323455 51.882701 0 2294 6418.582118 9006.268414 0 2295 3519.597970 4372.180704 0 2296 7015.035444 327.635709 0 2297 2486.583101 7704.376874 0 2298 6519.259296 466.575769 0 2299 3754.187857 5969.359667 0 2300 1170.531755 9405.093194 0 2301 1738.273462 6058.555100 0 2302 670.107828 2514.664006 0 2303 1455.604988 7620.511501 0 2304 9794.535351 8919.269578 0 2305 2170.401084 6406.723426 0 2306 9074.865247 6581.534372 0 2307 614.667297 4490.651450 0 2308 3319.024157 6459.906852 0 2309 617.173454 6589.995816 0 2310 479.447461 561.756241 0 2311 2283.662331 8633.725897 0 2312 7679.264826 2641.353293 0 2313 96.648074 2612.503156 0 2314 9331.457250 5556.534912 0 2315 800.313381 7250.687206 0 2316 6289.173702 8474.961196 0 2317 9800.112188 8469.188998 0 2318 6785.565064 8773.785144 0 2319 6207.158475 2114.022938 0 2320 5147.840676 2989.182586 0 2321 2479.459059 1853.134286 0 2322 673.650809 2852.680938 0 2323 8766.907187 5085.420255 0 2324 5298.774477 1108.756615 0 2325 9572.950929 1205.040799 0 2326 9651.784146 1863.553063 0 2327 492.350042 9408.727404 0 2328 310.308975 2719.458262 0 2329 6593.503635 5727.011485 0 2330 7325.406964 3153.658974 0 2331 7524.112464 552.889775 0 2332 331.385212 2334.497779 0 2333 8273.294443 1120.586517 0 2334 7350.699143 9424.940694 0 2335 9709.479786 913.127235 0 2336 2558.599298 576.174108 0 2337 7620.384329 4233.303758 0 2338 2648.345103 9016.877396 0 2339 5909.891099 9760.107005 0 2340 6809.053923 1107.130564 0 2341 1349.982064 1179.760946 0 2342 3618.118981 7883.881127 0 2343 9176.295576 539.758136 0 2344 4086.788393 9417.145103 0 2345 7991.396886 2798.132812 0 2346 8974.050284 1378.245316 0 2347 3354.551436 2044.731012 0 2348 4241.723295 5339.057122 0 2349 729.590368 1759.729656 0 2350 6184.797081 8400.955688 0 2351 887.911788 9564.873629 0 2352 5008.078945 7747.988580 0 2353 585.065978 3573.056475 0 2354 4618.655711 5647.188589 0 2355 9628.469383 5053.172045 0 2356 9135.992411 9677.667167 0 2357 8941.285774 3515.144510 0 2358 8677.542106 3131.253670 0 2359 7186.168727 6971.077534 0 2360 6022.444265 9000.902762 0 2361 7945.428940 8134.680457 0 2362 4240.151849 8858.506504 0 2363 7291.603990 3156.047269 0 2364 4221.327407 2390.156696 0 2365 8508.701614 3733.515139 0 2366 3751.820844 3878.061750 0 2367 5593.222222 2821.576276 0 2368 8196.099750 6694.299295 0 2369 7920.307234 683.651105 0 2370 3766.742337 2074.966295 0 2371 1933.459345 3370.380015 0 2372 8526.569006 3777.123217 0 2373 630.413361 8477.398314 0 2374 7863.987729 5485.699223 0 2375 464.476225 1528.275547 0 2376 3576.687609 4152.453716 0 2377 3000.490586 7674.725748 0 2378 9674.163559 4275.707732 0 2379 1709.331869 4516.026354 0 2380 1379.403968 4639.701407 0 2381 4092.268314 9822.355854 0 2382 3523.607129 1219.378041 0 2383 9309.296898 7036.111738 0 2384 6961.888996 3254.663547 0 2385 2034.881571 7124.032372 0 2386 2895.220918 6151.786152 0 2387 938.281022 4379.123216 0 2388 6356.766595 5505.672162 0 2389 6387.309850 2304.676549 0 2390 4549.608117 655.883494 0 2391 760.439203 2070.614540 0 2392 6476.868388 7950.768464 0 2393 5983.337253 3560.883132 0 2394 73.123000 6947.913191 0 2395 8502.673632 96.430506 0 2396 6172.654931 3445.538667 0 2397 4107.302135 7332.569559 0 2398 4335.738191 5495.704256 0 2399 6931.707870 6600.312327 0 2400 4757.782593 5367.470136 0 2401 6448.565074 134.472428 0 2402 231.718949 4655.023551 0 2403 7073.549331 9509.898815 0 2404 5264.080767 6740.311318 0 2405 9209.378762 994.986401 0 2406 1274.388049 4766.331209 0 2407 5672.003248 3038.779391 0 2408 3862.790987 8695.763116 0 2409 5312.917905 5731.297673 0 2410 9282.763687 5951.152532 0 2411 4620.511084 1782.347072 0 2412 1910.719276 5053.185505 0 2413 453.134621 5090.571751 0 2414 8808.007276 3884.202485 0 2415 8385.023449 7515.342378 0 2416 8135.094453 3380.162389 0 2417 6097.584333 6528.490754 0 2418 993.716475 1701.632110 0 2419 6718.792666 7209.220801 0 2420 405.966896 4852.563879 0 2421 4796.748852 4244.396033 0 2422 7631.352454 9706.951160 0 2423 312.971676 9296.100806 0 2424 7363.983641 3822.592012 0 2425 2354.165733 5876.399727 0 2426 5349.362167 9485.807359 0 2427 9745.112402 7787.376071 0 2428 8779.659807 6919.216078 0 2429 7854.320578 5335.401858 0 2430 7009.010701 4369.308119 0 2431 9216.562630 9155.710347 0 2432 9966.150798 2562.621860 0 2433 2170.291026 6165.264616 0 2434 3696.251945 3967.181455 0 2435 7722.727046 6760.786544 0 2436 8537.993238 8083.029280 0 2437 4898.359245 1044.313704 0 2438 4221.732271 7893.526171 0 2439 3670.566372 8424.930406 0 2440 3991.216895 8179.202152 0 2441 7591.144771 6715.794821 0 2442 70.735306 9257.416610 0 2443 3669.585825 924.698958 0 2444 126.856742 8609.119052 0 2445 4184.986145 5864.812316 0 2446 9846.911374 9350.146178 0 2447 6298.477120 7315.130882 0 2448 6433.807214 4193.176502 0 2449 1159.945206 2070.426988 0 2450 2979.475116 2140.582673 0 2451 9317.072636 2050.288406 0 2452 2354.224144 6958.766861 0 2453 9707.615929 6375.854561 0 2454 2930.912666 8151.928706 0 2455 1563.354898 6490.276122 0 2456 4941.105545 7519.442598 0 2457 4858.927178 6213.373919 0 2458 30.512088 8435.756150 0 2459 7246.495207 1975.207516 0 2460 9463.325109 9897.546034 0 2461 6283.425528 8359.482563 0 2462 9897.881325 3049.795936 0 2463 1849.682389 3236.596614 0 2464 9668.617897 2958.470982 0 2465 4509.331173 8511.145593 0 2466 1774.746447 4539.010913 0 2467 2640.612108 4194.851864 0 2468 9609.172777 4373.186342 0 2469 616.805579 8927.341088 0 2470 8574.137724 3429.802926 0 2471 489.749113 4944.214252 0 2472 6408.406394 4387.840472 0 2473 673.595890 934.979009 0 2474 7484.405254 5348.132646 0 2475 6496.262243 2956.431629 0 2476 4363.712135 3413.274652 0 2477 6549.583126 4551.000520 0 2478 1115.045648 6787.762005 0 2479 9735.391859 4124.031108 0 2480 329.288870 5416.789528 0 2481 6375.972629 3543.370275 0 2482 8994.671928 9506.810128 0 2483 4703.438278 5039.071337 0 2484 4256.608875 6844.939717 0 2485 589.483751 3051.710391 0 2486 7998.925487 1947.117716 0 2487 5382.805234 2174.553103 0 2488 1147.798561 4048.957759 0 2489 5492.394273 2623.579824 0 2490 3397.625838 4515.255741 0 2491 7292.816100 1493.750103 0 2492 5883.512498 5977.961693 0 2493 9739.215061 6054.833502 0 2494 4065.045211 4821.738174 0 2495 6134.712378 5323.554122 0 2496 6740.703227 2937.283379 0 2497 2465.623612 9782.120824 0 2498 9415.446854 7393.905091 0 2499 9815.637487 9933.742193 0 2500 2707.570405 3454.910978 0 2501 9213.325498 7167.940239 0 2502 1490.567182 7883.066862 0 2503 1936.343071 2055.464598 0 2504 6137.491361 2086.011755 0 2505 3812.525858 1632.344163 0 2506 6895.116218 6151.794425 0 2507 9071.648623 954.787937 0 2508 9861.277023 3077.265637 0 2509 290.366192 3492.512858 0 2510 9475.049187 2902.393662 0 2511 4923.737077 2753.919007 0 2512 6766.421986 3716.286684 0 2513 9246.895061 1091.949411 0 2514 6265.613163 9874.735727 0 2515 3691.632533 5350.871383 0 2516 7734.485708 1456.086160 0 2517 4750.833259 8548.577695 0 2518 8802.188589 5268.133607 0 2519 7980.360409 5338.882443 0 2520 6816.250692 8102.893305 0 2521 761.007305 934.808944 0 2522 447.279043 8980.810169 0 2523 2197.437261 5055.239195 0 2524 3559.303785 3896.413636 0 2525 3485.362079 8672.552760 0 2526 1056.234665 7412.517502 0 2527 5031.310224 5857.054869 0 2528 4700.198175 7742.378727 0 2529 5430.449233 4106.785210 0 2530 4121.936311 4252.174913 0 2531 5524.577019 2440.749117 0 2532 9772.339097 8601.978644 0 2533 3369.918050 5318.940454 0 2534 6485.799791 4933.275615 0 2535 1725.951108 6437.842764 0 2536 6670.481606 5869.656897 0 2537 5209.857713 4689.474388 0 2538 9780.047191 979.454133 0 2539 8853.118324 18.561806 0 2540 7586.292650 4593.318787 0 2541 5322.120210 511.632417 0 2542 9552.380402 1809.098333 0 2543 8266.143091 9959.123854 0 2544 8869.914584 6367.051192 0 2545 1522.439581 5924.829324 0 2546 6760.184783 9291.206934 0 2547 6861.156278 1616.881971 0 2548 380.012924 8075.537571 0 2549 3523.478340 3358.112382 0 2550 3496.892693 9229.570710 0 2551 8362.427533 7908.651661 0 2552 4855.267236 9843.427137 0 2553 5783.775264 8883.830986 0 2554 9675.430475 6016.599738 0 2555 5930.709650 9631.376438 0 2556 302.791025 5384.852698 0 2557 1184.738178 8187.953209 0 2558 9356.334642 5607.736015 0 2559 2989.891907 9011.690685 0 2560 1027.087540 7890.169127 0 2561 415.876203 7763.686075 0 2562 7634.489922 7910.367721 0 2563 6628.518542 1821.687619 0 2564 8226.262069 2240.420310 0 2565 8288.206185 6268.715929 0 2566 8423.531928 5380.678312 0 2567 135.709671 9230.847011 0 2568 5673.218733 4463.436842 0 2569 4572.129653 5660.361032 0 2570 7819.589419 3163.317996 0 2571 4285.994431 1905.311507 0 2572 4802.190367 7769.205957 0 2573 426.471196 8475.595564 0 2574 1594.927170 1634.069124 0 2575 2118.360823 7407.192000 0 2576 6864.824528 8478.228109 0 2577 1890.121365 9042.346330 0 2578 1612.307606 1605.769181 0 2579 4209.071984 3354.023733 0 2580 7598.480823 6755.779643 0 2581 596.526199 1097.870186 0 2582 5251.373955 1041.063813 0 2583 5619.138177 7187.288037 0 2584 6187.480918 94.411220 0 2585 9360.206141 2544.271345 0 2586 4578.453644 5246.927285 0 2587 9773.752849 3091.817944 0 2588 6576.416663 8384.209616 0 2589 5645.713256 2228.544602 0 2590 2780.975458 1307.585160 0 2591 7320.161137 4953.478364 0 2592 3293.342585 9182.428246 0 2593 1997.294369 1267.868038 0 2594 6205.589616 3937.249219 0 2595 3791.615595 5891.707553 0 2596 6091.403275 191.856271 0 2597 984.025882 475.894319 0 2598 339.005377 2113.240429 0 2599 9103.653975 765.897830 0 2600 1932.975875 5766.980980 0 2601 3786.203447 6657.687163 0 2602 2070.312595 6893.479576 0 2603 747.835838 3534.296490 0 2604 4272.862399 6141.688663 0 2605 175.548468 321.418930 0 2606 1151.085019 6015.618255 0 2607 4396.696403 6932.136407 0 2608 4475.821443 74.747000 0 2609 2457.548681 9319.680499 0 2610 8326.839059 7514.540770 0 2611 3162.670045 7214.935162 0 2612 2765.824106 331.313681 0 2613 3909.826530 6927.580327 0 2614 2436.187486 9883.522107 0 2615 3158.773111 6246.711665 0 2616 1052.909944 884.880663 0 2617 8011.133027 5978.796610 0 2618 1061.987917 3915.566599 0 2619 6281.043678 8039.837717 0 2620 4383.690167 4585.143717 0 2621 8758.839213 5879.380114 0 2622 7714.720555 5484.821288 0 2623 6922.964388 8069.161575 0 2624 8337.487249 1841.992220 0 2625 7046.691944 7136.739176 0 2626 4331.642084 3036.645127 0 2627 2068.363587 9412.519418 0 2628 6857.361663 9227.639206 0 2629 6392.144949 3097.329904 0 2630 7822.456363 8657.068469 0 2631 8157.755595 5441.204830 0 2632 4992.323360 8195.120786 0 2633 7065.851922 836.965599 0 2634 7591.607288 8179.410742 0 2635 5050.744358 2221.262241 0 2636 4526.945740 4969.984433 0 2637 8254.179628 4956.350856 0 2638 8646.896285 4242.795076 0 2639 1776.086465 4098.562125 0 2640 7993.192417 6095.654378 0 2641 9131.991013 7092.741216 0 2642 6966.292887 9234.187407 0 2643 7188.988591 5445.381269 0 2644 8668.576681 9206.262693 0 2645 9265.197095 2263.274686 0 2646 4996.809126 6386.329899 0 2647 498.714207 4134.781806 0 2648 6047.059050 8407.577087 0 2649 420.218299 3212.092236 0 2650 3153.003666 1631.570237 0 2651 3252.119409 9913.785075 0 2652 4906.390068 731.465411 0 2653 7856.977425 9858.503263 0 2654 9215.589903 6100.422350 0 2655 4024.401974 8210.589760 0 2656 5732.061158 1783.753129 0 2657 6643.735321 4754.367330 0 2658 6987.586224 2059.881348 0 2659 2901.244729 3046.462382 0 2660 2903.400660 7034.728498 0 2661 3509.984186 6654.389209 0 2662 152.934387 249.966674 0 2663 4682.724095 9167.213436 0 2664 470.216881 857.424368 0 2665 9998.313133 3110.292236 0 2666 739.458794 625.174479 0 2667 801.005511 2239.486188 0 2668 5880.600632 345.266222 0 2669 8401.418301 9415.548095 0 2670 3336.547882 8300.156354 0 2671 6083.675285 238.669554 0 2672 8286.134725 9751.231194 0 2673 7334.640956 7282.971802 0 2674 4041.584677 8553.356425 0 2675 259.345192 3559.417304 0 2676 8288.173848 1706.676514 0 2677 1902.455046 527.189211 0 2678 292.017629 8868.750331 0 2679 7703.462363 5439.051778 0 2680 8447.721176 1517.000839 0 2681 9850.975499 7220.860005 0 2682 8187.199309 2577.126268 0 2683 191.627371 6123.364506 0 2684 7499.089573 9280.366197 0 2685 1490.470084 2241.466033 0 2686 6130.846644 8148.596088 0 2687 2969.844390 3913.211115 0 2688 6966.406239 779.947155 0 2689 4765.572788 2680.105512 0 2690 335.551414 3658.274753 0 2691 2977.878077 8946.164384 0 2692 5653.166417 2333.951272 0 2693 3070.580612 5245.968089 0 2694 9885.819576 2739.407188 0 2695 3778.332135 1120.234706 0 2696 769.896389 1971.287055 0 2697 6494.265137 6846.516057 0 2698 8232.585987 8267.145992 0 2699 2741.875266 3715.085957 0 2700 9452.040717 5242.117825 0 2701 6460.957113 7021.331088 0 2702 9228.402434 4101.283417 0 2703 7751.228179 4445.765827 0 2704 3420.621685 7369.915561 0 2705 6139.887383 3098.748470 0 2706 5876.786616 1053.462910 0 2707 9150.856809 315.567846 0 2708 713.013908 6960.328646 0 2709 7849.961984 9338.137772 0 2710 4227.099467 9408.592159 0 2711 5024.533949 910.578630 0 2712 2955.682480 4954.957028 0 2713 8812.036065 596.742057 0 2714 5422.281523 5499.144342 0 2715 8657.205215 3709.938870 0 2716 4740.103344 6645.673852 0 2717 2265.088706 6359.862987 0 2718 4494.804931 2404.128459 0 2719 2499.865887 5927.717032 0 2720 6780.140403 2835.324340 0 2721 3860.814895 9658.836008 0 2722 3455.485116 5915.160953 0 2723 4569.583098 4147.526559 0 2724 2310.374829 3736.644049 0 2725 8297.990908 4539.534160 0 2726 9965.912006 9535.846511 0 2727 2595.221668 1299.019436 0 2728 7063.507162 361.368281 0 2729 1954.053307 2923.826297 0 2730 2378.288663 4587.512174 0 2731 9523.679207 4870.562833 0 2732 3209.683662 1802.049227 0 2733 5032.980450 33.776254 0 2734 2208.849740 5381.276673 0 2735 8658.318607 3730.197311 0 2736 3326.990324 3099.780172 0 2737 8636.124107 5140.072685 0 2738 8989.457939 6740.612043 0 2739 2566.210277 3873.762359 0 2740 842.453064 576.386899 0 2741 9292.747224 5856.894773 0 2742 8215.738992 2277.768991 0 2743 5603.860542 5393.418724 0 2744 1275.140240 8130.134167 0 2745 9404.118008 9216.267441 0 2746 1724.076059 5840.973592 0 2747 9397.324699 9904.200111 0 2748 4968.575507 8860.388868 0 2749 8616.902199 8783.739898 0 2750 6786.445731 9374.240405 0 2751 6808.694404 1198.136792 0 2752 2101.265478 2206.273239 0 2753 1549.566483 5158.806926 0 2754 3060.616735 2950.281813 0 2755 3431.861714 1350.203787 0 2756 4782.289400 8883.207080 0 2757 5120.411383 7627.836051 0 2758 3891.678846 9913.298504 0 2759 3482.109729 3069.478606 0 2760 6785.084839 6994.867730 0 2761 3767.893720 4089.155400 0 2762 2109.832160 6150.906164 0 2763 2555.266810 5220.844950 0 2764 502.137218 4816.085143 0 2765 8649.983335 4125.333028 0 2766 5973.865832 1741.632523 0 2767 152.814954 2520.205073 0 2768 1759.538209 8181.404772 0 2769 2727.657656 9662.988635 0 2770 7084.618457 8473.209023 0 2771 1026.124461 4068.834539 0 2772 3307.166454 2056.020624 0 2773 9211.819905 7833.808754 0 2774 1642.069211 6026.069480 0 2775 8233.936420 3847.482079 0 2776 8239.087198 5348.986535 0 2777 7369.169604 8126.617638 0 2778 975.309591 7779.897770 0 2779 4526.229472 8444.256866 0 2780 1365.470870 3036.986141 0 2781 5347.217712 6530.689783 0 2782 3409.538401 6792.785034 0 2783 9313.345445 3353.804780 0 2784 676.131165 3632.786907 0 2785 145.375513 1472.262303 0 2786 6645.629947 2765.060431 0 2787 1270.883367 9121.035504 0 2788 1618.673902 3411.553329 0 2789 5012.932585 8626.719114 0 2790 7553.040477 5900.069628 0 2791 9786.697317 5144.944539 0 2792 1949.123259 4886.954638 0 2793 3729.187338 3946.702143 0 2794 4955.855325 8214.499164 0 2795 5463.248445 7027.239747 0 2796 9394.906702 1209.239253 0 2797 7277.777080 7912.825302 0 2798 6211.123605 7323.933637 0 2799 3160.764358 975.837243 0 2800 1505.547139 8347.839953 0 2801 4949.899281 1798.870940 0 2802 4597.035735 5263.027902 0 2803 4807.133312 259.865391 0 2804 1867.652327 6002.812686 0 2805 3405.202579 7764.722368 0 2806 3096.643236 7885.198394 0 2807 5649.477045 3230.587921 0 2808 3025.413948 4049.772835 0 2809 738.680265 7804.361246 0 2810 9182.855831 6399.379098 0 2811 5890.492599 7854.007217 0 2812 941.685512 7468.381086 0 2813 6862.394215 1533.374975 0 2814 5653.407303 8027.654952 0 2815 2420.373933 791.476038 0 2816 1031.686191 3072.044062 0 2817 3840.670011 8341.818774 0 2818 4772.199248 7637.165188 0 2819 2357.552593 6992.294788 0 2820 9760.527263 4137.286826 0 2821 8620.913500 561.669773 0 2822 778.560041 390.812480 0 2823 8598.892657 8320.253576 0 2824 7456.460823 8807.427728 0 2825 3022.098436 7735.478525 0 2826 8832.810880 6008.127544 0 2827 7988.699803 8339.661674 0 2828 6549.770125 7994.097570 0 2829 8951.476258 2147.695111 0 2830 2069.962110 6165.134642 0 2831 8813.798605 8169.244229 0 2832 8168.610089 1553.702956 0 2833 2639.810424 9358.217190 0 2834 7247.366903 7240.188746 0 2835 8440.652738 6790.531377 0 2836 2930.507260 8827.314633 0 2837 3310.303009 9462.347240 0 2838 6474.951428 1948.481398 0 2839 8555.275650 7948.039007 0 2840 8826.465518 6468.853610 0 2841 1448.954144 734.854486 0 2842 1319.436895 5288.512046 0 2843 4834.240400 5849.867541 0 2844 4452.183914 7155.253846 0 2845 5392.227780 6503.006481 0 2846 8557.922347 856.416047 0 2847 8494.489909 2377.705039 0 2848 9698.630340 4573.831829 0 2849 4166.770618 9736.384625 0 2850 5565.523596 440.477269 0 2851 8924.570458 2750.453548 0 2852 4014.167837 1444.875763 0 2853 9949.027466 6418.288411 0 2854 9043.364365 6198.085577 0 2855 8632.835343 8734.477870 0 2856 9575.678174 7600.166811 0 2857 9527.509447 6667.067412 0 2858 7403.010371 9257.355405 0 2859 9425.987311 9785.424962 0 2860 40.508303 5848.248833 0 2861 9604.008873 6490.805599 0 2862 1920.156646 1538.706289 0 2863 3362.156407 5277.242430 0 2864 4083.384133 3691.891103 0 2865 880.973288 6438.997745 0 2866 3882.001051 5108.613024 0 2867 520.776292 9950.785268 0 2868 2940.171309 7108.565274 0 2869 8019.506774 1697.585069 0 2870 3733.288791 3526.977098 0 2871 1715.723459 6566.423955 0 2872 7543.306663 6503.559275 0 2873 7366.920206 934.996614 0 2874 4151.748207 4979.465275 0 2875 9684.059211 4537.779233 0 2876 5392.370499 5249.633261 0 2877 1783.415210 0.232809 0 2878 8911.003392 9314.165569 0 2879 174.384973 1537.278906 0 2880 8806.785295 5707.128648 0 2881 856.415890 5224.567000 0 2882 8037.327910 2598.588938 0 2883 4255.452090 7377.201533 0 2884 3924.439899 42.181442 0 2885 2848.389596 5523.691023 0 2886 6879.381485 4155.428082 0 2887 3175.489269 7047.210210 0 2888 9752.240110 8668.426128 0 2889 4935.264119 1277.248645 0 2890 6605.707633 2101.173420 0 2891 2270.221496 6280.204767 0 2892 2231.869245 7121.908753 0 2893 5042.461402 4331.764899 0 2894 8037.057060 4624.001525 0 2895 7208.626902 6195.359079 0 2896 7443.093924 8922.415407 0 2897 2137.435317 6779.173898 0 2898 44.526212 2159.791095 0 2899 7412.882087 3075.091003 0 2900 2173.572632 5574.076953 0 2901 8875.843168 5408.296685 0 2902 2131.214897 2932.239107 0 2903 1296.559949 3309.053103 0 2904 503.111938 6540.114363 0 2905 5308.948540 1110.936234 0 2906 468.967342 1468.647299 0 2907 8607.797842 9629.348115 0 2908 3050.724047 4411.107607 0 2909 1906.568677 7269.027129 0 2910 5091.777784 123.210237 0 2911 2332.772699 80.332128 0 2912 4376.002570 8711.739055 0 2913 8806.711331 6027.635622 0 2914 9595.751031 9114.091012 0 2915 5105.312660 3933.427774 0 2916 3154.091470 1668.969104 0 2917 5507.697176 4738.414076 0 2918 100.873381 338.368214 0 2919 2172.565395 2597.816755 0 2920 4499.317742 9022.769690 0 2921 9236.117245 2697.677380 0 2922 6785.427973 5561.005282 0 2923 9002.000873 3025.154096 0 2924 4441.459046 5948.937203 0 2925 4194.834091 4181.456223 0 2926 2005.936736 7417.401177 0 2927 8137.026104 6513.312210 0 2928 5627.950373 8803.807397 0 2929 8601.166884 198.088475 0 2930 6791.280737 206.250006 0 2931 4070.960608 2009.003141 0 2932 2049.917156 4356.664576 0 2933 457.693179 7245.569371 0 2934 4914.026293 8727.127038 0 2935 2732.160269 9673.999966 0 2936 9629.856741 3828.629075 0 2937 1543.144631 1250.670926 0 2938 688.188685 421.845341 0 2939 8683.971882 3641.248012 0 2940 4674.639690 4360.304920 0 2941 8019.204453 4010.954876 0 2942 3570.651320 6786.477678 0 2943 3837.383313 6577.099909 0 2944 4581.164568 5682.483435 0 2945 4025.692386 2533.414798 0 2946 9435.091287 5887.226992 0 2947 6360.908015 2865.923879 0 2948 6360.060547 5526.518729 0 2949 5813.725125 5391.182930 0 2950 2574.901740 6544.517173 0 2951 807.343862 3109.986591 0 2952 3036.126625 4343.976052 0 2953 27.367212 2046.607027 0 2954 8539.927772 7919.544816 0 2955 132.731106 6067.308834 0 2956 5150.682055 974.225656 0 2957 7417.163011 3622.331972 0 2958 3822.146276 3658.391813 0 2959 6083.105559 8337.040870 0 2960 8424.342812 3125.680010 0 2961 8975.688220 586.458899 0 2962 6229.592748 7004.917759 0 2963 9557.491440 4172.164284 0 2964 4146.208043 6276.988180 0 2965 3401.672045 9686.617234 0 2966 3478.293297 1468.927362 0 2967 3395.031846 2545.741971 0 2968 9985.166028 8882.975268 0 2969 7340.292159 2742.107335 0 2970 2816.809482 1518.691287 0 2971 5847.629636 2207.345933 0 2972 1045.588719 9009.539184 0 2973 2690.986577 6260.072953 0 2974 1293.822288 2846.380020 0 2975 1384.327184 2760.555003 0 2976 94.033125 3617.861743 0 2977 9388.597731 6259.298557 0 2978 9491.814650 4512.722540 0 2979 595.259016 1535.535450 0 2980 4872.099252 2279.065872 0 2981 916.514256 2626.442946 0 2982 4682.154455 4206.300810 0 2983 7494.950620 9405.523060 0 2984 5432.240455 909.605084 0 2985 1174.039776 4033.436274 0 2986 858.821485 5433.221802 0 2987 7095.073749 2897.207279 0 2988 5218.045860 9790.806696 0 2989 1664.727383 9294.014683 0 2990 4147.776140 8803.477529 0 2991 3738.989850 9181.531390 0 2992 8812.521088 8306.715098 0 2993 3293.308480 2592.760564 0 2994 983.713365 7794.622435 0 2995 4003.342341 4649.295638 0 2996 953.350341 693.243960 0 2997 8415.958349 5586.555171 0 2998 1652.620841 1894.027113 0 2999 3601.662051 2658.127996 0 3000 1364.799573 75.990982 0 3001 9551.787180 4442.973680 0 3002 6612.894591 5655.576908 0 3003 7016.993659 8907.396631 0 3004 3290.320723 6570.534480 0 3005 148.526101 2967.257288 0 3006 261.488515 4435.059792 0 3007 8569.713914 8931.851494 0 3008 6708.941810 8459.478366 0 3009 4728.256223 823.004174 0 3010 4649.684330 7182.444292 0 3011 2252.057960 1278.952628 0 3012 9846.938735 4463.823593 0 3013 6483.267610 9922.760155 0 3014 6981.967833 4141.317891 0 3015 5402.397164 4963.895937 0 3016 4510.911652 5676.822433 0 3017 3091.129667 1147.603028 0 3018 9629.193848 9037.852827 0 3019 6876.843752 4412.322496 0 3020 8903.440356 4653.487939 0 3021 6428.589077 9253.110032 0 3022 1782.644253 7656.577363 0 3023 9338.514481 4111.906427 0 3024 5610.569245 3309.628454 0 3025 9310.899801 3355.370623 0 3026 2432.885429 3920.470712 0 3027 968.323750 1593.463082 0 3028 968.918573 7114.698898 0 3029 3320.831789 373.679017 0 3030 6908.995145 2989.660450 0 3031 8105.571290 9178.835912 0 3032 5852.982228 9320.820638 0 3033 9230.951459 3927.475324 0 3034 7127.303746 198.968669 0 3035 6326.920374 9685.362831 0 3036 5695.652151 2970.089120 0 3037 5397.050124 3819.337360 0 3038 2953.801757 4490.135290 0 3039 2253.992877 4739.227818 0 3040 2384.840981 180.393987 0 3041 222.202639 4236.974727 0 3042 2985.066472 392.100893 0 3043 8165.570557 980.964590 0 3044 3081.949910 8223.626637 0 3045 7351.167883 4284.886364 0 3046 7668.687058 2594.347404 0 3047 4218.578829 8115.314582 0 3048 3116.124539 8038.481063 0 3049 4369.217473 7035.632180 0 3050 1792.681341 4546.713552 0 3051 1341.043718 5634.493096 0 3052 1291.972939 9425.620271 0 3053 9226.319289 2770.011060 0 3054 3167.992690 42.851507 0 3055 9954.613303 5767.711750 0 3056 3179.668377 9959.357533 0 3057 2664.676428 6516.313813 0 3058 4274.456940 1201.407550 0 3059 2569.874502 7053.240329 0 3060 2317.147598 3138.319027 0 3061 1799.285473 373.963633 0 3062 524.022132 1954.413569 0 3063 947.276035 6871.180762 0 3064 8845.781157 4951.569519 0 3065 3065.633341 5044.346180 0 3066 7158.878885 6317.019494 0 3067 1598.396813 7728.969026 0 3068 8988.821931 5024.856920 0 3069 6943.793115 5816.335523 0 3070 1660.731469 3846.584126 0 3071 9640.384230 536.601732 0 3072 7643.348323 6187.003510 0 3073 5687.646472 4928.213726 0 3074 1500.484899 6097.111615 0 3075 9441.432619 5078.382265 0 3076 8489.054062 6845.220482 0 3077 1723.481609 8211.547124 0 3078 1693.052301 9426.813991 0 3079 1602.675141 4114.650108 0 3080 8264.175864 3606.427434 0 3081 6164.001556 6631.010727 0 3082 2903.117106 4050.922052 0 3083 5850.890235 5006.636061 0 3084 9378.438534 7239.150812 0 3085 857.914761 6849.920205 0 3086 5922.882741 5264.499339 0 3087 3246.854196 7772.847100 0 3088 9090.025276 3242.831229 0 3089 4837.067696 7164.042113 0 3090 7609.512873 2826.103774 0 3091 5745.387589 8752.211893 0 3092 713.008572 8273.051014 0 3093 7015.284098 8272.095783 0 3094 8885.566166 7439.419049 0 3095 6660.288504 947.380062 0 3096 5712.608337 340.109714 0 3097 4367.148374 844.557919 0 3098 6082.579489 326.587485 0 3099 7365.583415 6664.383727 0 3100 842.087450 1310.662829 0 3101 7734.124928 7447.969884 0 3102 9082.060967 3512.646413 0 3103 2070.018112 9547.136294 0 3104 4731.032310 5664.906199 0 3105 908.576166 8066.335210 0 3106 2230.785181 9503.491782 0 3107 4629.149651 1579.781209 0 3108 6033.085911 2499.798845 0 3109 1131.668635 4860.826648 0 3110 5040.870731 7113.659908 0 3111 9003.883779 2173.071759 0 3112 8251.881444 4535.483687 0 3113 1259.745790 7509.952621 0 3114 3860.355693 5601.707383 0 3115 32.195635 2473.230178 0 3116 5791.533915 309.553055 0 3117 1315.441064 5246.593290 0 3118 2204.678558 7043.080775 0 3119 8926.489723 1646.029084 0 3120 3716.720209 716.139407 0 3121 9395.966619 7123.949286 0 3122 1438.568958 2325.585147 0 3123 6139.381037 2991.133657 0 3124 1575.440372 8351.889828 0 3125 2759.091206 7009.190461 0 3126 3970.040111 2385.646473 0 3127 8647.694680 7033.895641 0 3128 4131.080408 6270.255366 0 3129 1367.930577 9750.564343 0 3130 7518.196099 8233.795009 0 3131 2062.264619 8396.583203 0 3132 3180.016180 3404.339470 0 3133 6675.081820 8737.921412 0 3134 6824.788379 2902.778774 0 3135 8245.632461 1349.429909 0 3136 9426.726702 7057.115895 0 3137 5615.424353 2090.169070 0 3138 4607.408042 4237.204509 0 3139 5289.660329 7652.416317 0 3140 8235.831087 4823.648298 0 3141 6155.205667 8126.977320 0 3142 7143.837215 5983.560759 0 3143 4023.675854 620.117250 0 3144 8317.790543 2024.580887 0 3145 5692.858203 2110.013476 0 3146 37.880523 4032.539019 0 3147 5407.700175 2606.166263 0 3148 506.172912 7708.521807 0 3149 4836.465631 542.854405 0 3150 1374.156764 7025.142024 0 3151 9852.644108 9379.685418 0 3152 9616.122794 4563.020790 0 3153 6589.476992 837.097630 0 3154 5881.410962 7377.004529 0 3155 8976.545036 826.267000 0 3156 4138.541726 2715.665341 0 3157 1153.923969 2343.758072 0 3158 8005.815929 5551.270797 0 3159 5474.918350 2307.180270 0 3160 8255.954986 4845.652542 0 3161 8345.452474 4383.822769 0 3162 17.383411 2266.889312 0 3163 6089.127177 1668.528996 0 3164 4845.133182 5980.946525 0 3165 3906.576050 285.605410 0 3166 619.794434 8095.559113 0 3167 4950.386405 952.085411 0 3168 2050.151780 3212.880513 0 3169 552.171599 6069.895374 0 3170 5007.726668 7778.783566 0 3171 4765.511939 5445.007737 0 3172 8039.314585 8270.560181 0 3173 3263.690222 976.726238 0 3174 8975.522171 7708.953564 0 3175 196.175595 600.292583 0 3176 8636.172789 4032.803502 0 3177 54.457297 5659.330886 0 3178 9962.770261 9833.792760 0 3179 2442.369965 7381.838107 0 3180 1854.728722 8196.119785 0 3181 6150.406462 8168.219795 0 3182 6874.300870 8313.374703 0 3183 1374.770643 2702.964531 0 3184 1868.187390 1237.320204 0 3185 2220.387022 833.888596 0 3186 4492.851531 3452.099983 0 3187 88.712137 1955.084305 0 3188 7023.195121 434.199938 0 3189 185.987447 8565.611928 0 3190 9150.431795 369.444224 0 3191 2598.598225 3584.099776 0 3192 5809.760176 6272.368182 0 3193 9644.168494 2703.959742 0 3194 4016.087751 3761.924606 0 3195 8385.764980 1931.426266 0 3196 9092.938550 6620.740272 0 3197 4892.023492 7195.197260 0 3198 1967.177469 440.535939 0 3199 8654.611326 3566.678537 0 3200 8734.394845 6234.105658 0 3201 5821.004918 8826.023486 0 3202 3038.437583 3832.080979 0 3203 8447.990115 9074.604513 0 3204 7857.866298 9189.631400 0 3205 5504.510721 1732.923457 0 3206 8482.354537 8833.285419 0 3207 3041.916535 6668.164973 0 3208 188.056210 9261.011031 0 3209 3471.348294 5639.267591 0 3210 6841.247331 8234.390134 0 3211 7069.766510 3270.310886 0 3212 9306.548655 2229.209447 0 3213 7469.148254 5071.006658 0 3214 2534.432040 5127.643583 0 3215 3149.177112 5208.618250 0 3216 2085.553752 2644.141491 0 3217 2446.142061 8615.978272 0 3218 3915.342938 8569.231595 0 3219 3787.590777 3204.527224 0 3220 6641.077655 4045.661561 0 3221 8187.086674 6471.856351 0 3222 6998.106398 9698.200396 0 3223 8449.328846 3416.367832 0 3224 4594.112554 8660.118442 0 3225 8927.838425 5388.853959 0 3226 5456.980604 832.804461 0 3227 2127.551225 1183.145364 0 3228 3253.077012 159.208725 0 3229 5077.260579 5.960774 0 3230 3596.970698 1021.316245 0 3231 2431.661664 6641.248035 0 3232 2644.847114 57.739288 0 3233 8255.777012 5390.230981 0 3234 8825.919902 2685.545077 0 3235 3198.052862 308.438088 0 3236 5076.060054 8947.644801 0 3237 17.860156 5775.221913 0 3238 2403.334265 6868.611773 0 3239 9254.648375 4843.572251 0 3240 8767.624805 3857.055681 0 3241 2176.915722 4226.902705 0 3242 6586.011057 8023.516692 0 3243 6769.876056 718.425761 0 3244 7954.883479 1325.209918 0 3245 1150.600397 2123.478659 0 3246 1742.115899 1931.642066 0 3247 2005.081620 5352.999744 0 3248 8603.035739 5254.104976 0 3249 6573.931570 7822.972232 0 3250 9901.066845 2742.922736 0 3251 9420.450830 1955.402605 0 3252 1927.960312 7958.818736 0 3253 789.615155 9012.291567 0 3254 9031.107397 7021.293178 0 3255 6966.172073 4795.562121 0 3256 707.413375 3458.197104 0 3257 7607.273907 5876.926247 0 3258 3058.463012 1721.984290 0 3259 2106.610687 5341.710497 0 3260 7000.312789 9442.904552 0 3261 7806.330826 7061.130450 0 3262 6328.167880 9980.030756 0 3263 6094.928445 7816.579359 0 3264 4020.863529 1393.458590 0 3265 3671.792132 7923.533358 0 3266 5081.050333 4955.600282 0 3267 2080.334239 3624.449407 0 3268 7493.907854 4171.806518 0 3269 1756.402607 9588.065669 0 3270 9330.785413 8605.871025 0 3271 4892.750477 9867.210689 0 3272 713.072985 6549.282352 0 3273 321.173876 3444.760429 0 3274 5598.654965 4829.719801 0 3275 4364.302220 9373.773528 0 3276 8833.746287 8906.205109 0 3277 7800.743515 2015.504976 0 3278 6612.402204 3699.620470 0 3279 8888.346051 3443.951125 0 3280 5967.678900 8269.457902 0 3281 3288.572665 1213.007922 0 3282 3568.586863 2703.927749 0 3283 3510.514900 9767.405175 0 3284 8594.965735 5845.574971 0 3285 8398.701429 5054.494387 0 3286 9312.474650 2532.484111 0 3287 9008.750928 5640.862216 0 3288 1109.322696 4731.971554 0 3289 3143.678893 2214.298193 0 3290 7869.360852 1683.066743 0 3291 6253.010124 5535.543227 0 3292 5479.723771 1871.149949 0 3293 7012.773762 4732.372573 0 3294 5580.577384 9283.505705 0 3295 9936.398393 6097.197434 0 3296 5023.471844 9777.604692 0 3297 331.159771 1644.058903 0 3298 7048.392657 3143.480597 0 3299 4977.373436 6229.072774 0 3300 4032.619002 5910.664941 0 3301 3178.225394 1597.768162 0 3302 6380.346395 1630.493744 0 3303 1687.962188 8498.713930 0 3304 7754.385309 998.789191 0 3305 7364.060905 8230.651961 0 3306 8255.371443 6230.510564 0 3307 5379.812616 6096.960858 0 3308 3203.794966 5801.277721 0 3309 7896.865875 4445.489833 0 3310 1085.007816 8389.287246 0 3311 2924.660320 4419.177962 0 3312 6583.893139 8036.032317 0 3313 6398.758838 3860.831518 0 3314 1063.078482 9676.468307 0 3315 4974.921009 4417.413412 0 3316 7623.274417 7412.322549 0 3317 7044.646376 9797.354164 0 3318 8322.682880 6279.116746 0 3319 1281.818582 8300.786806 0 3320 5157.171650 5849.530298 0 3321 5569.197345 2221.670391 0 3322 5567.175851 4698.304730 0 3323 8971.252082 9410.968054 0 3324 9830.083297 5293.328186 0 3325 2912.693433 944.263696 0 3326 212.897844 2764.991703 0 3327 395.341656 7175.852154 0 3328 4780.235666 8198.205497 0 3329 8337.409120 4726.718348 0 3330 4818.294837 5301.692138 0 3331 6550.989873 4759.502591 0 3332 9598.662894 2755.715521 0 3333 381.009495 9719.513064 0 3334 876.524689 1880.409510 0 3335 2738.987777 8409.775767 0 3336 3161.735161 6559.025387 0 3337 8462.983085 5433.018387 0 3338 2280.732337 5133.815712 0 3339 228.988138 3661.466838 0 3340 1801.747181 4021.728521 0 3341 601.081710 6700.910694 0 3342 6893.010018 8067.394105 0 3343 5959.050133 1233.332925 0 3344 1455.875813 9842.480396 0 3345 6958.056422 6624.665324 0 3346 4874.005502 3237.374404 0 3347 8501.091344 9397.065205 0 3348 2497.147760 3438.073314 0 3349 3183.500887 9850.833429 0 3350 5759.420574 7424.448086 0 3351 3335.283979 3266.900394 0 3352 7448.790933 8153.203011 0 3353 1429.570499 8754.411048 0 3354 6517.271004 3038.996338 0 3355 1954.513641 9467.875935 0 3356 5217.954722 4391.945170 0 3357 3057.984189 6603.150589 0 3358 89.141191 9113.665617 0 3359 6162.210465 6.153871 0 3360 616.690367 5999.791769 0 3361 2405.689770 3314.374414 0 3362 8735.548060 7865.951813 0 3363 5154.255537 8768.110192 0 3364 5817.239421 2802.442835 0 3365 9760.425697 593.142345 0 3366 689.722073 8960.930323 0 3367 5508.724327 8762.488967 0 3368 7934.091284 7326.167544 0 3369 9560.559477 3445.825710 0 3370 6257.696940 9061.304379 0 3371 2459.820926 60.923505 0 3372 5456.594403 4277.922567 0 3373 3974.936879 3846.827705 0 3374 6760.261440 5266.616270 0 3375 4418.641795 6788.289704 0 3376 3589.767596 4903.410967 0 3377 3346.768460 5276.536971 0 3378 9060.637234 1011.487956 0 3379 6244.012639 1795.939610 0 3380 9233.186293 8211.386943 0 3381 4050.789352 9530.128616 0 3382 575.169231 6095.608336 0 3383 3540.619402 7904.456628 0 3384 9948.714782 2907.503766 0 3385 6158.171332 6526.433804 0 3386 3127.380071 2984.330703 0 3387 1012.023342 9459.861530 0 3388 4940.859604 7014.395405 0 3389 7865.090030 2678.649453 0 3390 1945.220605 3730.207253 0 3391 6098.610974 5287.753939 0 3392 1154.986039 9829.050362 0 3393 9891.975998 8481.811680 0 3394 1702.700185 4192.418664 0 3395 8061.548145 9883.205769 0 3396 6165.327240 1780.139922 0 3397 9042.981893 2959.138319 0 3398 8151.639518 6604.822745 0 3399 3445.947516 6072.112867 0 3400 3758.489907 6010.453604 0 3401 7828.695167 7181.975238 0 3402 5818.600611 7194.167135 0 3403 8035.383903 3776.267464 0 3404 2051.726061 6911.386311 0 3405 2085.055820 6582.030050 0 3406 7367.477624 3372.912966 0 3407 2281.145420 7483.027372 0 3408 9751.450903 7537.350484 0 3409 8718.757089 4767.434147 0 3410 2496.183571 1095.936755 0 3411 1498.434896 2713.590024 0 3412 7821.085030 1287.266819 0 3413 9986.246066 419.103427 0 3414 5696.659288 5753.309854 0 3415 5016.228361 1659.822566 0 3416 4645.759975 8481.000441 0 3417 2568.760028 3687.503385 0 3418 3057.323758 3902.645031 0 3419 6122.390958 5222.385382 0 3420 9575.421469 4691.490288 0 3421 3043.111805 181.886734 0 3422 2936.015994 8320.733044 0 3423 9956.935786 5725.734725 0 3424 4824.580996 3862.152002 0 3425 3317.421952 3500.604675 0 3426 8090.579966 3449.843996 0 3427 5763.743554 1427.187437 0 3428 8801.734165 3071.522123 0 3429 4574.617456 2513.569528 0 3430 1644.170535 9391.731509 0 3431 7037.236130 9276.340647 0 3432 406.256466 5525.456736 0 3433 5996.397151 9641.417166 0 3434 7164.662214 6334.575355 0 3435 2682.346032 8957.094970 0 3436 5913.052660 9.801959 0 3437 6394.569003 8603.128443 0 3438 988.248188 1920.781887 0 3439 5439.058347 418.609227 0 3440 3875.433036 5780.926368 0 3441 2458.586032 8508.706432 0 3442 991.341646 8017.251682 0 3443 2094.571046 8341.624825 0 3444 6555.189844 7460.746010 0 3445 5195.577548 8213.344339 0 3446 1620.206642 7538.294243 0 3447 194.181671 2509.842578 0 3448 852.628723 4520.781360 0 3449 2762.470378 8824.886632 0 3450 406.404988 7621.321004 0 3451 8770.592811 6196.921098 0 3452 1972.199575 17.287518 0 3453 861.091554 8271.472865 0 3454 6425.630778 9058.491991 0 3455 6967.089349 1081.153683 0 3456 6422.946322 3157.154030 0 3457 6263.383864 1794.584433 0 3458 7965.660262 7046.604416 0 3459 5249.417246 6027.635343 0 3460 4320.314122 5132.949742 0 3461 5090.439522 3345.900617 0 3462 2712.324375 3818.387571 0 3463 1093.743337 1.640666 0 3464 7543.264583 8737.346089 0 3465 3446.346730 2944.225337 0 3466 7401.351039 8859.719625 0 3467 469.556032 1825.812457 0 3468 988.282505 3588.843384 0 3469 8319.073837 347.547289 0 3470 3316.863071 9403.143766 0 3471 5724.395977 3169.021315 0 3472 8674.854239 7542.243829 0 3473 547.087349 8832.628946 0 3474 9179.711664 4998.551189 0 3475 6281.641028 4039.222710 0 3476 3424.010751 6309.454668 0 3477 7718.286897 4483.572550 0 3478 5430.708777 1365.379126 0 3479 3421.481031 4441.343987 0 3480 8921.501443 6110.003901 0 3481 3564.957415 8046.758284 0 3482 2394.011941 5809.061499 0 3483 9443.891926 129.552906 0 3484 5780.188309 7730.098278 0 3485 5438.061958 2463.198370 0 3486 8682.390458 6074.103205 0 3487 4167.150258 4410.466868 0 3488 8843.247129 6743.558817 0 3489 9897.732110 6713.372813 0 3490 1077.391729 4931.929990 0 3491 6363.208894 157.540432 0 3492 1557.081691 6451.455112 0 3493 522.080346 7087.861708 0 3494 1342.655360 4339.671146 0 3495 7969.015008 6375.395659 0 3496 2045.426828 5599.075332 0 3497 7155.657859 2086.534871 0 3498 672.136915 1541.334729 0 3499 7799.346522 1991.621658 0 3500 7802.709016 9560.088719 0 3501 7065.738406 8067.787488 0 3502 7848.252410 7323.475814 0 3503 6943.327310 92.788913 0 3504 4619.061166 4003.751596 0 3505 7823.247613 7674.530585 0 3506 4393.430926 7299.724808 0 3507 1746.748349 8614.753798 0 3508 741.855517 4643.948527 0 3509 3242.665662 8373.415163 0 3510 3864.291597 1175.999554 0 3511 6872.109726 1819.590359 0 3512 9104.300932 7274.375822 0 3513 7398.473056 3116.241334 0 3514 9538.909488 4128.021192 0 3515 2671.307691 6536.417345 0 3516 8244.393998 9372.771068 0 3517 4157.568577 7391.422446 0 3518 878.897633 9270.223576 0 3519 92.062785 5415.006986 0 3520 2966.812829 3901.335565 0 3521 4416.293773 4960.381415 0 3522 8082.616398 4766.628556 0 3523 5053.358096 270.078324 0 3524 3626.256975 8204.686213 0 3525 3078.512695 8786.008526 0 3526 4308.631900 2777.899674 0 3527 1266.893150 2420.413057 0 3528 6120.997257 2044.742671 0 3529 9740.308713 8668.119584 0 3530 4950.020157 9535.038136 0 3531 547.170685 6581.453051 0 3532 4716.901173 443.707333 0 3533 6974.999735 6172.651433 0 3534 6871.880430 2281.706600 0 3535 771.863277 2414.860141 0 3536 4240.878937 6594.894353 0 3537 7241.917161 3042.445390 0 3538 8256.063546 6356.155921 0 3539 2140.119095 9743.957267 0 3540 9090.503596 7966.845024 0 3541 5713.092123 2935.402638 0 3542 1473.210878 2550.682889 0 3543 5471.476071 4168.461130 0 3544 2453.625264 6776.411983 0 3545 5078.684895 1359.154423 0 3546 2749.930888 3600.453453 0 3547 2641.225898 9421.129808 0 3548 2189.512689 8108.734022 0 3549 182.275215 6034.662553 0 3550 751.642547 2692.044567 0 3551 9889.306964 303.762954 0 3552 3788.329916 4402.578291 0 3553 3746.788906 7086.663016 0 3554 7741.751208 7251.572518 0 3555 2604.456192 5400.614686 0 3556 8467.212146 3391.887365 0 3557 2905.284837 7336.592811 0 3558 33.115548 7176.977852 0 3559 3755.778137 8150.588524 0 3560 8852.373480 4984.495624 0 3561 4798.080676 3660.544273 0 3562 7956.047815 1579.832138 0 3563 3948.878988 2450.550708 0 3564 1060.271263 7608.234595 0 3565 8830.075108 7836.071320 0 3566 2007.999815 2752.082457 0 3567 5970.491448 2581.923844 0 3568 3025.496309 5192.988004 0 3569 8014.992269 5989.805114 0 3570 9664.508470 3345.748099 0 3571 7888.879006 5690.280868 0 3572 2005.360312 1165.926280 0 3573 4978.585858 2025.953677 0 3574 3943.366588 429.799701 0 3575 4345.594575 3802.204659 0 3576 4636.981996 8115.045369 0 3577 6436.513787 3270.372449 0 3578 216.167483 1423.620391 0 3579 5046.066416 8811.705540 0 3580 4593.463442 4203.638282 0 3581 5063.222798 1305.634838 0 3582 8006.884919 4906.625953 0 3583 734.596689 9129.451442 0 3584 684.639405 285.333464 0 3585 25.714628 5452.278851 0 3586 3247.395729 654.728142 0 3587 452.740581 4702.053483 0 3588 706.819712 1998.181774 0 3589 7423.041519 3091.713362 0 3590 293.794961 9581.128278 0 3591 9334.591365 6376.814408 0 3592 7601.723912 9258.822643 0 3593 3437.796307 6260.448769 0 3594 9757.963050 616.401944 0 3595 8614.508036 4521.105984 0 3596 9172.206710 3766.309697 0 3597 431.873121 5157.598705 0 3598 9300.701632 5508.403113 0 3599 2412.210143 6792.558267 0 3600 5539.227575 5533.585958 0 3601 2389.539559 2204.645756 0 3602 109.159583 9690.202171 0 3603 7511.855963 9009.444652 0 3604 4528.136469 2365.292526 0 3605 4728.149928 9746.281852 0 3606 8711.215683 7294.996181 0 3607 6787.597130 4297.082249 0 3608 5726.469863 7597.461683 0 3609 2399.980370 669.694339 0 3610 7342.354311 4835.018619 0 3611 6615.268452 2884.697761 0 3612 7084.491796 8640.958811 0 3613 6037.926172 54.112614 0 3614 8151.751970 2247.648480 0 3615 4670.562521 892.593327 0 3616 3966.971362 8931.940874 0 3617 4968.278781 7142.460150 0 3618 4510.796566 4952.592183 0 3619 2748.590601 6768.298393 0 3620 2023.179022 9040.484771 0 3621 8413.706091 2533.790860 0 3622 5128.936253 9541.017249 0 3623 8537.978068 1055.347919 0 3624 4079.878998 3771.133686 0 3625 8793.929884 9616.220077 0 3626 7718.160700 6426.021726 0 3627 2652.386192 2646.392020 0 3628 4458.877552 4087.001414 0 3629 7057.798056 4178.950880 0 3630 8861.021309 1023.593314 0 3631 1490.446025 7640.695041 0 3632 8809.636573 5306.728325 0 3633 5557.015882 5806.112917 0 3634 8104.134180 8420.648576 0 3635 3178.100153 3999.837776 0 3636 7256.040864 6916.852220 0 3637 5259.173491 3002.632635 0 3638 6973.617435 7738.012174 0 3639 6793.328728 9159.295113 0 3640 300.769360 2480.048118 0 3641 2020.176729 2068.437773 0 3642 421.392859 6463.809132 0 3643 5870.705018 1857.309293 0 3644 5499.495234 2791.187496 0 3645 7978.525169 6936.917524 0 3646 4932.957804 6885.649052 0 3647 8821.502956 6015.877128 0 3648 3591.900614 1761.265441 0 3649 4784.124593 76.761320 0 3650 2661.172018 5261.651767 0 3651 5468.901601 1766.162195 0 3652 3926.683784 4744.663802 0 3653 8491.505347 2030.812444 0 3654 3675.480148 9193.041741 0 3655 3625.119545 5462.873759 0 3656 5208.575077 9142.661053 0 3657 9465.372060 2838.063053 0 3658 6037.888087 7386.056684 0 3659 469.509215 7523.270642 0 3660 3895.659262 6497.670683 0 3661 3935.078308 1916.818991 0 3662 6555.572876 574.623225 0 3663 5708.599826 5254.593615 0 3664 216.471752 6736.431742 0 3665 4967.171611 2465.750453 0 3666 5358.217830 6519.401490 0 3667 6192.530845 7093.330773 0 3668 2224.732596 9168.398187 0 3669 4968.846867 2768.100968 0 3670 5969.502914 873.938792 0 3671 177.491148 2551.913864 0 3672 8496.134120 1056.932080 0 3673 5315.920700 7471.193520 0 3674 5768.208006 2297.481013 0 3675 4907.855003 4123.078493 0 3676 1184.234685 3534.042226 0 3677 9901.205287 470.251299 0 3678 1537.157809 8510.078872 0 3679 8545.956001 1092.692163 0 3680 8471.188977 8647.487192 0 3681 4845.141872 1743.452573 0 3682 4955.618749 246.331433 0 3683 7702.268787 1930.877291 0 3684 3299.761391 5897.462354 0 3685 6537.244914 2391.476793 0 3686 3849.720918 5901.046492 0 3687 2680.693873 8590.040012 0 3688 5221.937355 6505.087838 0 3689 8546.378340 811.087915 0 3690 8296.660475 2642.189292 0 3691 2080.849379 6828.290521 0 3692 4311.805194 7504.876803 0 3693 919.899568 6263.784242 0 3694 4784.238912 7409.512389 0 3695 255.833584 730.348814 0 3696 6513.919554 9940.553507 0 3697 1128.892345 2521.199840 0 3698 525.506307 8150.785771 0 3699 1064.557709 7170.872508 0 3700 3769.023211 5346.316469 0 3701 3738.941545 2091.864508 0 3702 8495.895226 695.951770 0 3703 3763.383459 7841.035062 0 3704 5037.728785 5188.324514 0 3705 1127.996255 2101.009799 0 3706 7309.495862 3127.652918 0 3707 7378.592801 5987.706110 0 3708 6969.775313 2995.757493 0 3709 4156.046647 8507.888023 0 3710 1921.983180 736.940418 0 3711 8007.330931 8624.987226 0 3712 1792.736868 8163.200597 0 3713 2299.218510 7921.267212 0 3714 6896.524185 4618.402646 0 3715 3930.338182 8701.668103 0 3716 2146.685785 5857.597618 0 3717 1879.353070 9322.250567 0 3718 1008.186796 9369.309649 0 3719 8966.601770 9677.790011 0 3720 7213.072792 9452.193030 0 3721 148.529866 3627.116591 0 3722 5281.058268 5663.480376 0 3723 293.160408 8695.696223 0 3724 1378.217124 1375.701181 0 3725 757.377926 8954.632459 0 3726 2159.255219 6219.846084 0 3727 8998.638329 6927.424498 0 3728 6857.458000 8163.211409 0 3729 813.135866 6548.285685 0 3730 4165.530825 7168.169788 0 3731 6512.958183 3139.896463 0 3732 5680.192526 7650.044718 0 3733 9050.596408 8887.615520 0 3734 1901.572490 4060.486288 0 3735 9253.625731 5972.625231 0 3736 770.202558 2395.790534 0 3737 2926.366846 7114.303093 0 3738 4354.539014 4098.604996 0 3739 7917.308631 624.329626 0 3740 3916.902563 9830.974931 0 3741 8066.510709 7989.810288 0 3742 1019.819901 1129.155425 0 3743 202.740974 441.627355 0 3744 9624.348833 9433.751967 0 3745 9576.745825 5621.685443 0 3746 1431.622691 944.534897 0 3747 8427.228785 5728.411976 0 3748 9682.058722 2051.147688 0 3749 2362.178997 7812.770829 0 3750 723.905198 6586.580927 0 3751 2178.766860 6547.586381 0 3752 7906.103746 9039.173681 0 3753 8567.153541 5387.622292 0 3754 7041.842335 3485.081101 0 3755 6667.209172 6103.331894 0 3756 4349.041163 3790.558844 0 3757 4835.654156 9363.094593 0 3758 8232.011955 72.262154 0 3759 8014.365450 4022.957340 0 3760 9782.008152 1303.167473 0 3761 8489.994911 4901.377765 0 3762 2671.683778 9245.070640 0 3763 5616.632517 7852.735076 0 3764 4167.365641 3245.246201 0 3765 8770.591394 4147.434259 0 3766 1778.229856 6540.451440 0 3767 7437.177771 9113.588661 0 3768 6752.927923 3166.007488 0 3769 1951.480043 5872.088391 0 3770 8198.308377 1089.489563 0 3771 7699.937508 8545.272543 0 3772 5614.815498 6286.732152 0 3773 9865.020308 7422.405985 0 3774 2996.345536 8003.956317 0 3775 5876.468889 3620.577628 0 3776 9213.178494 3364.402576 0 3777 5909.087465 9707.336704 0 3778 9102.348793 9530.332996 0 3779 3487.695536 2473.122803 0 3780 6756.425452 1999.785959 0 3781 8866.943571 3261.768260 0 3782 8329.179413 9350.315305 0 3783 9431.366033 3747.584213 0 3784 2513.699425 6294.179930 0 3785 239.794782 9905.564483 0 3786 2759.745802 4398.236868 0 3787 2759.601091 9281.261287 0 3788 8427.547296 5358.331433 0 3789 5945.131640 9435.771077 0 3790 1198.218985 654.546360 0 3791 2445.444584 559.508661 0 3792 5620.055266 3364.180527 0 3793 8615.984551 761.433749 0 3794 1404.772383 5766.623007 0 3795 1750.056061 7676.544514 0 3796 1339.718719 5280.744692 0 3797 6532.766649 2776.891235 0 3798 6999.787902 5380.328131 0 3799 33.722542 2142.068472 0 3800 1954.123555 4933.791259 0 3801 2554.015289 127.698376 0 3802 7877.746831 2651.653083 0 3803 3041.053704 9858.803622 0 3804 1404.243801 3247.815680 0 3805 5609.200976 8637.296477 0 3806 1073.350124 3374.457643 0 3807 6142.415411 8049.163091 0 3808 6670.454269 2941.429627 0 3809 398.045948 152.818488 0 3810 8427.376455 3072.916512 0 3811 6621.099734 4261.681355 0 3812 4190.732325 6484.577631 0 3813 6109.711654 5280.965987 0 3814 1133.571982 8295.216144 0 3815 4497.526836 3013.740448 0 3816 4759.836577 8865.472856 0 3817 6938.732406 8528.500008 0 3818 8975.851172 9955.371129 0 3819 1049.668663 4453.893994 0 3820 1664.853349 6030.626977 0 3821 5681.728602 1914.055879 0 3822 1614.707970 9281.383598 0 3823 929.809826 8888.814091 0 3824 3665.507756 7915.478371 0 3825 7944.994082 4916.859263 0 3826 5020.541742 414.057101 0 3827 2773.499734 4300.254561 0 3828 5549.890511 5869.824888 0 3829 2820.546180 4259.251805 0 3830 1934.120411 6941.297731 0 3831 2403.229049 6464.381330 0 3832 9761.713047 2248.236828 0 3833 233.864634 4156.559402 0 3834 840.556218 5309.175642 0 3835 9508.234939 2635.043313 0 3836 977.447523 3814.861749 0 3837 7108.836798 8798.050294 0 3838 4470.520846 144.410079 0 3839 7913.410575 1630.225432 0 3840 4971.058461 2120.785661 0 3841 3521.256163 7783.291128 0 3842 1481.627647 4972.353966 0 3843 4938.842796 1843.954783 0 3844 3266.682869 6864.828916 0 3845 1554.055457 8186.546984 0 3846 762.514668 4378.438406 0 3847 5346.744079 4243.649612 0 3848 7455.692533 4474.574375 0 3849 5383.187090 6833.200631 0 3850 1059.682327 2773.535145 0 3851 5785.292690 9282.371375 0 3852 4987.064030 1892.500601 0 3853 1848.544260 312.270405 0 3854 1236.827250 5927.662054 0 3855 1136.655188 1579.509519 0 3856 3311.416208 3003.404404 0 3857 8923.319723 1127.574581 0 3858 5444.323207 3434.790553 0 3859 6260.276600 8837.460629 0 3860 1453.375969 3382.213213 0 3861 7721.726090 2496.994056 0 3862 2859.970066 51.408076 0 3863 2523.966173 7812.365973 0 3864 6222.447302 6397.980751 0 3865 2070.376663 7054.699031 0 3866 9564.183608 244.445214 0 3867 4515.629690 4059.981439 0 3868 5084.798445 7886.921564 0 3869 7272.316647 9735.621029 0 3870 6704.630310 6789.775449 0 3871 4832.877225 2710.396578 0 3872 4285.863015 1959.410815 0 3873 7187.700841 794.297314 0 3874 3499.537622 844.256832 0 3875 6947.590813 8627.655336 0 3876 4165.160223 3433.590753 0 3877 8024.633225 4931.264299 0 3878 3153.693713 1333.782323 0 3879 2941.819621 7238.248266 0 3880 94.798129 1297.984351 0 3881 8515.687001 5513.414985 0 3882 3239.137858 6026.941855 0 3883 4042.331034 2286.582604 0 3884 3319.751358 8040.539744 0 3885 8567.092294 1773.817020 0 3886 8681.843039 2705.730509 0 3887 7563.582605 2233.760871 0 3888 7813.966776 7836.799734 0 3889 7786.195992 6611.295848 0 3890 4051.225328 6697.114247 0 3891 1229.733036 8345.807825 0 3892 4406.576857 6660.850973 0 3893 884.660545 80.106125 0 3894 3088.843301 2299.857854 0 3895 8417.828753 6871.601167 0 3896 6819.927987 8279.510869 0 3897 1320.678009 8925.229637 0 3898 1716.696933 4242.338157 0 3899 9982.572773 6229.272846 0 3900 5294.520108 402.406224 0 3901 1786.594616 8954.257893 0 3902 6043.888830 1331.619268 0 3903 2791.518813 7689.240247 0 3904 9712.242813 1984.306356 0 3905 834.550785 3004.202337 0 3906 5377.903471 6684.210823 0 3907 6677.574093 7008.295357 0 3908 5282.936548 9180.649037 0 3909 3229.607659 6103.673096 0 3910 717.800293 4842.979720 0 3911 5536.259180 9331.244124 0 3912 7130.642158 6284.671543 0 3913 4380.351645 5773.067509 0 3914 2377.166285 7793.838574 0 3915 8073.624157 5442.680192 0 3916 5479.987267 5939.519975 0 3917 8311.153579 562.551202 0 3918 6035.510370 4092.571730 0 3919 9047.455600 2067.475395 0 3920 3224.896938 4370.802915 0 3921 5901.194603 9887.177034 0 3922 4944.206147 8236.224286 0 3923 5713.830524 2775.519257 0 3924 6187.830896 1289.054655 0 3925 2844.906464 6923.103779 0 3926 306.698512 7390.656112 0 3927 9991.938281 5492.156388 0 3928 6960.072886 3746.784827 0 3929 564.298009 1433.817550 0 3930 9335.495676 4562.191471 0 3931 1010.888620 7984.418221 0 3932 600.586479 2292.953517 0 3933 3805.668397 9168.900673 0 3934 1726.606438 7649.586217 0 3935 5095.570539 3653.682202 0 3936 9407.579334 281.713474 0 3937 735.649867 6610.076738 0 3938 4892.305794 7397.951897 0 3939 995.817685 5435.215144 0 3940 982.316352 4806.409443 0 3941 3629.785439 6516.679974 0 3942 1605.689068 5258.702500 0 3943 9135.864708 2068.988360 0 3944 4991.812194 4269.997202 0 3945 8983.731158 615.608231 0 3946 4665.901375 9952.616929 0 3947 9866.650466 4853.879213 0 3948 717.623393 3854.621692 0 3949 9047.074758 1083.412262 0 3950 8714.617670 7632.235251 0 3951 2996.644873 3023.457566 0 3952 1214.251151 7208.532575 0 3953 4244.104899 7456.795261 0 3954 3797.731116 1404.758271 0 3955 9887.790228 748.162039 0 3956 189.113562 6884.433977 0 3957 2271.099561 849.450514 0 3958 1452.903966 6680.364253 0 3959 5042.416186 536.551769 0 3960 2821.078152 7671.580231 0 3961 734.928233 5964.957731 0 3962 8696.188077 676.554768 0 3963 5265.801292 5473.245758 0 3964 8134.292418 6138.766711 0 3965 7893.134561 1148.430198 0 3966 641.984023 4145.161563 0 3967 6099.510460 7379.746480 0 3968 7607.806982 387.325502 0 3969 4037.216702 5869.368963 0 3970 3902.182926 40.257163 0 3971 5363.837652 3730.797877 0 3972 7117.052455 9485.956524 0 3973 8704.515755 36.035500 0 3974 2829.257641 1767.436166 0 3975 2985.223380 9492.499770 0 3976 5590.509771 955.157428 0 3977 6863.884619 1902.685735 0 3978 9616.767484 4473.913898 0 3979 4158.323022 1170.343898 0 3980 76.178946 1304.026333 0 3981 974.309728 7879.833593 0 3982 3879.785057 8270.047497 0 3983 6635.221556 4398.159605 0 3984 9208.567586 8027.012533 0 3985 1966.300997 659.618624 0 3986 1340.923218 7647.599773 0 3987 7808.294747 4246.791398 0 3988 8623.535357 5269.102347 0 3989 8371.166756 5495.763542 0 3990 8756.698569 9253.811648 0 3991 3965.700843 2543.252077 0 3992 3364.567263 6654.886966 0 3993 7230.206185 760.816689 0 3994 5917.256015 968.116659 0 3995 8733.501917 675.827721 0 3996 3359.288675 689.049434 0 3997 4133.559220 2769.773880 0 3998 3990.344344 3085.097514 0 3999 5120.229669 5852.104935 0 4000 572.990143 3061.103413 0 4001 1511.477193 1918.874743 0 4002 4343.922707 6678.013432 0 4003 9072.684400 6899.580971 0 4004 2895.424186 8434.284201 0 4005 9292.003965 9210.721160 0 4006 6388.539582 5767.502520 0 4007 7478.752968 6947.488457 0 4008 2755.704677 3222.644184 0 4009 1657.049744 4277.122270 0 4010 9292.518819 104.839510 0 4011 1475.118298 6686.789868 0 4012 7149.825688 3526.399797 0 4013 4272.970112 3631.583951 0 4014 629.280421 5707.091137 0 4015 3502.142925 9936.404123 0 4016 3420.626607 4608.795055 0 4017 9852.776957 7402.057410 0 4018 7027.388954 7459.316379 0 4019 6222.487357 8379.581529 0 4020 1323.801417 7315.168041 0 4021 3785.458243 5580.089637 0 4022 8589.235897 7473.196959 0 4023 6527.823842 9584.149287 0 4024 4227.665686 242.849178 0 4025 9612.893227 4083.987783 0 4026 6066.471807 8318.995227 0 4027 7841.173508 2133.067482 0 4028 1965.029622 7317.222028 0 4029 4131.522703 6277.381835 0 4030 7336.517609 6765.070210 0 4031 7352.451330 3306.172999 0 4032 6295.447982 9554.626950 0 4033 19.650591 9804.252388 0 4034 3718.131680 2781.362192 0 4035 6853.610916 2320.558979 0 4036 2204.776300 7026.610976 0 4037 5877.279125 6510.453021 0 4038 8855.608447 168.713095 0 4039 3961.419301 2928.112724 0 4040 8384.924708 4056.396200 0 4041 3610.758064 6026.133964 0 4042 5830.659770 1237.674937 0 4043 7871.855999 9349.501398 0 4044 7604.514839 3326.760401 0 4045 3344.877211 941.467778 0 4046 1782.675717 8746.116328 0 4047 1901.305176 4479.650237 0 4048 1644.319296 6749.775978 0 4049 1854.676705 7972.671296 0 4050 550.199728 3051.914218 0 4051 1616.144336 5371.267031 0 4052 3267.104587 6157.093352 0 4053 5720.901235 3261.401879 0 4054 391.656895 3230.759426 0 4055 1143.997096 9874.072851 0 4056 4803.026089 8287.586565 0 4057 8492.048784 5773.810398 0 4058 2763.069615 5740.378169 0 4059 8100.966143 2420.139584 0 4060 2710.228502 6656.210546 0 4061 7330.006402 12.759845 0 4062 6293.716022 4949.209987 0 4063 6621.659398 7632.792704 0 4064 276.174835 39.138501 0 4065 1759.543690 3614.103307 0 4066 4948.518038 5545.096479 0 4067 7738.212186 4039.177608 0 4068 9325.926494 7820.243232 0 4069 9621.648562 8328.626806 0 4070 7369.494946 4623.616799 0 4071 9939.803768 3690.240641 0 4072 1630.826597 8796.567311 0 4073 4619.049565 8636.379020 0 4074 4667.860447 8386.660786 0 4075 782.276835 513.978733 0 4076 4626.810392 8220.950409 0 4077 8327.713466 1126.777647 0 4078 1530.469719 6637.827638 0 4079 1566.297094 5678.140077 0 4080 1248.597804 4321.161015 0 4081 3427.175963 3715.355800 0 4082 4971.004323 9383.572348 0 4083 599.637791 1249.024933 0 4084 9717.826856 4579.670654 0 4085 4939.952226 5405.382375 0 4086 5963.407280 162.862743 0 4087 9266.733016 6968.789618 0 4088 7259.759432 9317.198277 0 4089 1095.488230 5065.943564 0 4090 2300.925978 2479.390025 0 4091 249.340319 6649.069476 0 4092 7693.692079 9073.606881 0 4093 7697.721172 6129.169265 0 4094 9426.993891 3648.598799 0 4095 3155.397633 3181.600289 0 4096 5880.198244 497.287712 0 4097 5244.658406 4900.281139 0 4098 5794.831077 9326.652040 0 4099 6851.753487 3278.915273 0 4100 4779.077631 5075.477077 0 4101 9254.132695 6414.539503 0 4102 3474.634076 8875.401760 0 4103 442.213616 1713.169939 0 4104 2786.854755 9562.545855 0 4105 8764.283235 2446.598132 0 4106 5841.360048 2876.473713 0 4107 9356.788942 6233.474688 0 4108 7287.054483 9312.321132 0 4109 8060.546539 9285.991623 0 4110 1514.350823 2593.989387 0 4111 8711.474688 8463.838733 0 4112 7678.317302 7194.641229 0 4113 8546.165805 4751.100541 0 4114 1003.541452 7271.926016 0 4115 2469.286834 6090.822790 0 4116 5598.282981 3891.031980 0 4117 6554.988085 3854.171256 0 4118 961.108817 8604.729940 0 4119 8468.670033 2829.477651 0 4120 5599.987869 1345.184563 0 4121 7380.174612 4553.090514 0 4122 3831.142889 9314.546975 0 4123 8275.411767 8429.257782 0 4124 8062.842941 7268.922410 0 4125 9032.527389 3193.705626 0 4126 9195.562415 4154.086485 0 4127 7530.770854 3474.444106 0 4128 4711.567417 2488.031688 0 4129 1171.696803 3204.605618 0 4130 536.270507 3126.224227 0 4131 3269.870392 774.028124 0 4132 5748.477662 8412.717732 0 4133 6104.966008 1045.170083 0 4134 2494.661808 2963.462638 0 4135 3121.566407 7287.506117 0 4136 4194.261676 637.327118 0 4137 6954.420657 2264.647207 0 4138 9913.614210 232.691919 0 4139 8198.458978 5105.555474 0 4140 2660.473349 1534.565033 0 4141 2036.210465 2861.791907 0 4142 638.214281 8661.467424 0 4143 2219.347467 668.173285 0 4144 4916.902539 1300.752666 0 4145 3541.309526 8749.105692 0 4146 8667.051451 9505.943908 0 4147 6485.134239 8764.225675 0 4148 4645.344700 6168.108183 0 4149 6083.765403 9618.809727 0 4150 9188.729912 9878.021093 0 4151 9322.243440 2174.142954 0 4152 9601.537857 738.671347 0 4153 2774.600947 7921.796877 0 4154 9978.431298 1161.060453 0 4155 3012.431927 4674.379876 0 4156 3848.400914 1944.873138 0 4157 2498.592965 8108.252466 0 4158 534.195681 8160.973737 0 4159 3358.924188 6814.383951 0 4160 8340.144241 6210.526454 0 4161 2417.913648 6965.134117 0 4162 6569.120062 9183.348722 0 4163 2935.824835 357.070806 0 4164 1737.809437 9672.744934 0 4165 6355.390219 4172.612492 0 4166 6873.669534 3328.829083 0 4167 1175.983136 5958.595866 0 4168 9127.835098 758.167108 0 4169 3779.062379 4711.148347 0 4170 6052.442644 9478.528792 0 4171 8431.037896 9684.081090 0 4172 4731.889493 4101.644067 0 4173 7570.877691 2183.005788 0 4174 4141.790667 1706.293977 0 4175 993.441452 7862.949568 0 4176 174.231029 7028.411341 0 4177 8168.776026 9374.503407 0 4178 8330.831426 8090.147588 0 4179 9526.941935 3865.987893 0 4180 2342.009373 1126.055597 0 4181 1503.551617 1637.587658 0 4182 3736.536198 5690.388801 0 4183 1046.548710 7607.423641 0 4184 8099.245979 263.530303 0 4185 4081.332151 2682.219465 0 4186 9558.732906 7719.834426 0 4187 5113.999978 5447.476101 0 4188 887.473837 3533.425908 0 4189 7928.682168 668.734534 0 4190 3469.617220 8024.014477 0 4191 5018.491495 6800.293016 0 4192 4058.078137 904.675022 0 4193 6542.959814 5113.934359 0 4194 6175.919943 365.205734 0 4195 277.326076 9277.848661 0 4196 8879.802595 5107.493057 0 4197 4111.805842 977.924343 0 4198 8339.301568 7845.646084 0 4199 6571.607057 8023.029249 0 4200 4945.922477 8346.727252 0 4201 1743.490028 687.438934 0 4202 5477.025445 5583.322143 0 4203 5789.642069 2303.029536 0 4204 3938.872105 1209.928116 0 4205 8125.745227 8474.117871 0 4206 6484.878765 9664.277216 0 4207 6284.963686 9355.335501 0 4208 8068.423533 8948.110445 0 4209 3713.450924 937.519081 0 4210 1454.380968 6403.826348 0 4211 7898.369150 4416.997424 0 4212 7921.440720 6795.785292 0 4213 2047.922350 1890.402408 0 4214 2014.338016 2675.441312 0 4215 2522.262152 5445.125830 0 4216 2377.429102 5733.251086 0 4217 6214.006366 7974.957313 0 4218 6622.080578 7633.519075 0 4219 4866.092372 280.199695 0 4220 3312.921381 6269.357349 0 4221 4807.333125 9190.057099 0 4222 1830.888351 315.583127 0 4223 4407.009386 2218.156697 0 4224 8448.342504 5404.706288 0 4225 7155.852532 6460.149047 0 4226 2334.480934 4056.932480 0 4227 8447.835046 2419.838941 0 4228 9311.688827 8051.129149 0 4229 5101.001395 5412.747688 0 4230 5112.328656 7151.184558 0 4231 6404.611300 8156.340670 0 4232 5254.664756 8944.288628 0 4233 825.521949 7897.618599 0 4234 8804.555628 7891.639167 0 4235 1185.686529 5154.704710 0 4236 1273.196511 6655.829706 0 4237 5856.962482 7039.012535 0 4238 6602.902015 5432.526734 0 4239 7440.167670 9522.003283 0 4240 3312.617767 2809.004272 0 4241 9141.351778 5878.734578 0 4242 672.780984 3125.793992 0 4243 3794.231156 4654.277010 0 4244 6128.341599 2883.579811 0 4245 1019.014639 4727.450561 0 4246 9438.304361 2133.669167 0 4247 7503.772081 976.673800 0 4248 5123.282848 5160.298018 0 4249 1899.438638 5720.433469 0 4250 8961.166399 8434.784297 0 4251 9172.386329 2665.911048 0 4252 7440.810761 7716.860453 0 4253 792.277339 9019.170966 0 4254 7274.711747 7441.600426 0 4255 1906.556634 1279.530686 0 4256 6493.705166 9689.054387 0 4257 4863.735507 9432.086176 0 4258 3584.714142 4547.618323 0 4259 2528.054587 7513.991821 0 4260 9916.209686 3279.150378 0 4261 8860.496327 2440.524500 0 4262 173.725310 1329.312862 0 4263 715.807255 4266.854314 0 4264 7318.828269 801.301106 0 4265 5755.489642 2596.926881 0 4266 3463.847179 8039.335175 0 4267 8746.737792 6740.950413 0 4268 7446.778478 9471.560344 0 4269 5675.698944 8427.116852 0 4270 1497.252493 8686.198525 0 4271 446.931904 214.760374 0 4272 2269.881032 7954.968752 0 4273 7091.943209 8805.265035 0 4274 3425.105357 8909.537186 0 4275 8145.280656 4345.815223 0 4276 8572.147067 3265.451997 0 4277 5936.767666 2299.715286 0 4278 2807.856523 7552.503694 0 4279 8891.561116 35.829038 0 4280 8162.598145 8401.431094 0 4281 9726.729265 6737.888639 0 4282 1374.488841 9528.894511 0 4283 8859.682763 7447.710772 0 4284 5086.661407 6768.379272 0 4285 5747.725068 5051.529017 0 4286 870.721426 3854.990259 0 4287 3925.607953 4578.798835 0 4288 8259.672640 2992.983861 0 4289 1081.745042 2037.624334 0 4290 5571.995702 4025.456504 0 4291 9699.790228 1280.033567 0 4292 5160.911299 8055.271339 0 4293 2866.703449 8930.591689 0 4294 8262.319181 4198.156932 0 4295 7608.388723 4281.099309 0 4296 7831.825449 3379.614104 0 4297 5649.792553 4083.810973 0 4298 2871.442556 4543.441958 0 4299 4156.090536 7176.826816 0 4300 2346.939678 9455.088758 0 4301 7494.931835 7505.326629 0 4302 3983.741412 8978.623171 0 4303 5653.639103 8922.736474 0 4304 4749.573375 9644.520595 0 4305 2671.966874 2081.846216 0 4306 2263.695933 3620.180909 0 4307 7790.089863 456.803570 0 4308 6141.279809 3118.150130 0 4309 4917.113076 2963.832285 0 4310 3969.779905 4185.339686 0 4311 1236.291155 7417.444969 0 4312 3445.065529 943.632920 0 4313 8166.209839 2175.612619 0 4314 7256.554248 5950.490496 0 4315 379.201147 9464.178488 0 4316 9703.617991 7323.250500 0 4317 930.695940 6973.626337 0 4318 1920.598845 4633.582935 0 4319 4954.430983 2545.136390 0 4320 8244.164581 1247.442880 0 4321 4782.214785 6053.267068 0 4322 7537.818895 8605.896994 0 4323 5708.415376 9704.602555 0 4324 629.092395 3363.606502 0 4325 8063.693643 2202.575168 0 4326 4128.809561 4373.776267 0 4327 5228.099580 1347.158067 0 4328 7609.622787 9780.059760 0 4329 6369.352826 6941.184966 0 4330 2538.547046 1969.227250 0 4331 3498.347351 2830.427593 0 4332 4116.452921 5348.791338 0 4333 5011.638614 6430.846185 0 4334 2331.724484 1627.004380 0 4335 2361.319302 949.586945 0 4336 2844.892291 2575.232240 0 4337 5608.280458 7867.180512 0 4338 2835.637228 6138.220265 0 4339 3245.477064 1044.398253 0 4340 3981.869424 757.462524 0 4341 5353.511882 9868.150179 0 4342 214.522307 4837.698982 0 4343 2206.960632 9563.296097 0 4344 4223.507441 5973.044544 0 4345 3890.090882 4363.800920 0 4346 828.020806 2834.137311 0 4347 8500.681454 4505.226794 0 4348 7182.744437 2845.693041 0 4349 8060.149993 6323.606294 0 4350 9907.724529 3248.893883 0 4351 2353.679895 2528.642354 0 4352 4757.669257 8508.564979 0 4353 8179.521817 1020.120300 0 4354 7100.066442 1666.539328 0 4355 6859.382541 4962.099453 0 4356 5369.423975 7971.853885 0 4357 3705.418210 5043.949085 0 4358 5846.597830 5800.187117 0 4359 4597.111179 3193.698648 0 4360 2775.570096 7401.970703 0 4361 7532.223205 8218.429358 0 4362 3315.258182 8580.357426 0 4363 1626.893986 3151.058639 0 4364 6233.121197 4368.266870 0 4365 7202.547252 6669.483191 0 4366 6485.775793 4719.902511 0 4367 687.230596 8541.959258 0 4368 2792.177012 492.862897 0 4369 5442.191610 5052.935214 0 4370 412.489547 5110.905787 0 4371 7667.065838 5696.502303 0 4372 7422.626451 2745.506602 0 4373 5672.387162 7353.909067 0 4374 80.208746 1378.821805 0 4375 8547.914569 6705.141674 0 4376 7269.921817 2869.533632 0 4377 4406.637743 4962.875120 0 4378 132.255293 1215.875159 0 4379 1732.251057 492.851198 0 4380 2487.108962 380.132660 0 4381 3789.373689 1958.105942 0 4382 5014.918537 2882.308660 0 4383 5343.267733 6072.383713 0 4384 7868.516833 6157.514806 0 4385 4055.234105 6813.827764 0 4386 9061.366598 9052.995822 0 4387 6519.568636 1191.451842 0 4388 6104.731592 5817.567873 0 4389 7980.654486 5656.803251 0 4390 979.731603 8118.633473 0 4391 4595.715827 5782.625191 0 4392 3520.265565 4108.588700 0 4393 437.197997 5075.229564 0 4394 5331.014920 8241.727289 0 4395 3603.084858 1938.307064 0 4396 9764.100813 8594.899715 0 4397 2707.796778 9592.869662 0 4398 1502.033797 1177.007921 0 4399 8135.340944 297.152390 0 4400 109.728474 9682.308257 0 4401 789.571276 7372.323857 0 4402 2733.141514 5709.451353 0 4403 4777.606824 1429.675175 0 4404 1030.478326 6150.577628 0 4405 2115.189598 5531.406599 0 4406 1858.741725 8034.297739 0 4407 5721.686458 8879.268306 0 4408 2927.300568 1480.704642 0 4409 9602.490644 6151.499306 0 4410 1904.091450 2136.489653 0 4411 1734.164460 6989.620525 0 4412 7661.582251 2972.359103 0 4413 2191.071960 1540.220166 0 4414 8812.314957 6825.491889 0 4415 262.882902 8435.102288 0 4416 923.683750 1097.292450 0 4417 7064.181855 5589.726913 0 4418 439.401073 4156.789479 0 4419 2419.916773 957.347867 0 4420 4654.005254 1495.238434 0 4421 4306.727235 7326.047813 0 4422 5598.645337 8280.805950 0 4423 8418.214813 3311.378539 0 4424 5951.321895 1883.008730 0 4425 3475.028764 4104.948750 0 4426 2086.098228 8015.118460 0 4427 6541.412053 6002.037555 0 4428 3967.517405 1458.637595 0 4429 2203.177082 1960.549750 0 4430 7904.986815 602.059322 0 4431 7903.483253 4668.519579 0 4432 7314.147900 8388.571817 0 4433 6386.408008 6197.681368 0 4434 1887.017179 2247.282050 0 4435 6509.484893 9407.691183 0 4436 5364.680506 175.614191 0 4437 8476.534790 9100.107779 0 4438 1384.041556 3978.116210 0 4439 7141.174085 4326.433929 0 4440 4685.250433 8008.825633 0 4441 7951.076193 5201.082947 0 4442 6780.056191 3022.053511 0 4443 5828.061906 6331.394552 0 4444 2556.067797 296.421721 0 4445 8286.499049 3739.178810 0 4446 9864.020350 1137.227570 0 4447 5873.979825 9873.453105 0 4448 947.353904 5012.530191 0 4449 4999.598517 3895.031829 0 4450 2721.846017 3809.669331 0 4451 9568.287474 84.476061 0 4452 1358.901535 3931.153863 0 4453 2671.943297 6513.940011 0 4454 8568.699531 5265.958597 0 4455 2789.441114 7109.999851 0 4456 1342.568575 5143.349315 0 4457 9694.557483 7376.176199 0 4458 9290.006801 9812.517538 0 4459 597.624084 8248.450188 0 4460 4723.555318 2190.798976 0 4461 4502.387907 1686.357087 0 4462 6016.282736 5314.241808 0 4463 1628.130225 8036.758404 0 4464 7298.464279 243.326388 0 4465 4800.742059 7779.900288 0 4466 6357.709034 5826.768817 0 4467 9157.308028 4181.043703 0 4468 6984.221276 8482.951931 0 4469 301.263306 4000.638496 0 4470 1629.534007 9033.952102 0 4471 5253.214767 7937.684759 0 4472 582.719039 5798.505472 0 4473 1694.767513 4834.237345 0 4474 2911.427360 5479.183382 0 4475 1176.594393 5831.747056 0 4476 245.606914 6079.000633 0 4477 9525.575269 1798.032221 0 4478 7598.582471 7911.632700 0 4479 6687.426259 8402.476866 0 4480 5970.586469 7174.668127 0 4481 3205.198148 9162.481465 0 4482 7121.766578 6576.427546 0 4483 3418.308408 6799.327677 0 4484 6019.803835 4401.462225 0 4485 5574.862823 8764.847269 0 4486 4362.103047 3342.832205 0 4487 6612.341211 945.829649 0 4488 8462.604258 8970.130070 0 4489 7077.618602 8695.299922 0 4490 7695.436233 1966.618086 0 4491 6413.354910 5468.933946 0 4492 7277.336561 4499.934264 0 4493 7723.476705 3537.581380 0 4494 1747.363492 365.933549 0 4495 2318.292462 7590.296178 0 4496 8613.788134 7145.270020 0 4497 3366.563177 8528.181314 0 4498 4555.264275 9632.345172 0 4499 7722.279467 902.200414 0 4500 1926.150774 9630.188235 0 4501 1725.157933 711.487105 0 4502 3917.302770 7301.065192 0 4503 5034.366513 827.995563 0 4504 7903.580228 6714.649723 0 4505 5820.537938 1638.493773 0 4506 156.074250 8400.119778 0 4507 1862.670652 1871.008964 0 4508 5731.734699 6081.477087 0 4509 406.921625 1794.611016 0 4510 9098.094726 4123.875090 0 4511 8707.998364 6906.190345 0 4512 7649.059036 1763.456818 0 4513 6424.606347 5675.760680 0 4514 5170.570972 2926.546849 0 4515 1447.975814 6698.264514 0 4516 8765.944687 1173.884122 0 4517 1768.285502 7696.597707 0 4518 1572.974678 8436.848643 0 4519 3678.989405 4396.094554 0 4520 2396.756563 4491.327360 0 4521 9778.398107 8181.746798 0 4522 87.578692 1883.921512 0 4523 6472.762755 5943.360699 0 4524 2444.657635 2337.154216 0 4525 1823.724081 901.692833 0 4526 1701.900430 8243.935475 0 4527 5826.236579 9201.942726 0 4528 831.852711 745.601558 0 4529 6469.374147 7965.049785 0 4530 700.246389 5742.312686 0 4531 3989.316894 2484.527718 0 4532 3606.380274 1056.617132 0 4533 6155.752525 5154.682974 0 4534 3316.333558 3283.296421 0 4535 4246.813848 3877.859505 0 4536 4666.960615 700.761739 0 4537 7394.231176 775.069969 0 4538 4396.861408 5994.447891 0 4539 3449.108949 8101.670652 0 4540 1206.348365 2843.608418 0 4541 6754.462853 9560.490182 0 4542 1447.080498 1891.737001 0 4543 5322.818461 6475.967748 0 4544 4881.743920 1174.680055 0 4545 2002.353981 4540.513772 0 4546 5765.950616 8718.001600 0 4547 2176.249601 2466.636911 0 4548 6796.534047 1721.374094 0 4549 2087.364054 2345.944580 0 4550 4676.987314 6695.124189 0 4551 5352.994412 3070.154150 0 4552 3566.419621 1471.214130 0 4553 1822.333125 9922.011439 0 4554 2595.805127 6210.071467 0 4555 5445.301406 8636.503907 0 4556 9448.367443 1798.117758 0 4557 579.929907 1710.782386 0 4558 6575.983662 6437.695557 0 4559 1238.745699 3706.713500 0 4560 1895.614198 2677.096366 0 4561 1582.147222 7850.845567 0 4562 716.927980 9933.545036 0 4563 4662.495232 2960.163879 0 4564 9944.800466 3566.792162 0 4565 2786.142374 2222.948462 0 4566 7292.344323 834.297904 0 4567 2375.080075 3846.500203 0 4568 8703.024212 4501.115987 0 4569 770.639822 7916.289414 0 4570 8430.588944 3042.803674 0 4571 5502.073188 6351.029560 0 4572 8419.854908 7294.451270 0 4573 6118.407588 4942.727494 0 4574 7311.912365 7336.917711 0 4575 7526.791972 6519.695065 0 4576 1734.100708 2285.996338 0 4577 8980.407495 976.472549 0 4578 7878.142864 3167.894984 0 4579 1679.719994 9599.176933 0 4580 4307.332864 8319.562784 0 4581 1551.941919 3973.716138 0 4582 8574.396866 523.193756 0 4583 5254.858899 9870.189019 0 4584 1810.251853 6219.951839 0 4585 6882.971283 6627.841605 0 4586 9731.206832 3305.617591 0 4587 3548.358264 2340.700946 0 4588 1725.404320 9109.657670 0 4589 8255.642620 6073.343562 0 4590 928.940974 2450.001029 0 4591 2029.301587 5264.129811 0 4592 2925.325261 6720.795081 0 4593 4119.463325 2084.813636 0 4594 2883.292535 7477.463454 0 4595 4690.554213 1865.378590 0 4596 2487.507724 195.676392 0 4597 6310.724609 5570.436911 0 4598 5382.885390 4293.347676 0 4599 2738.689236 7199.004615 0 4600 358.229575 205.057258 0 4601 7951.371881 4771.970562 0 4602 6870.146051 9680.600810 0 4603 7209.052697 2206.506685 0 4604 7122.537465 3710.782762 0 4605 4157.963377 3022.554395 0 4606 3661.617568 3741.565806 0 4607 7329.023616 738.370169 0 4608 8480.976698 6044.242421 0 4609 2301.066216 6837.098254 0 4610 449.517741 1055.841439 0 4611 7119.110615 8032.143797 0 4612 3760.033188 2136.070066 0 4613 9811.972377 4908.231102 0 4614 7290.367874 1879.778608 0 4615 1825.951189 3778.077551 0 4616 551.251442 6305.420624 0 4617 8292.744975 959.364211 0 4618 7280.536754 5644.645510 0 4619 8125.320585 6945.908885 0 4620 7685.978894 196.623720 0 4621 1855.724324 8790.344408 0 4622 7667.656281 2680.138761 0 4623 7360.415027 3520.816983 0 4624 8558.809714 5124.912917 0 4625 716.976679 7264.280436 0 4626 5189.870453 4260.170656 0 4627 3711.948136 5200.301724 0 4628 579.453265 4426.567881 0 4629 7582.875711 4699.702174 0 4630 5128.511401 3041.978990 0 4631 8724.451409 2979.172218 0 4632 1768.694429 1276.502882 0 4633 7250.740456 7450.978693 0 4634 7796.983100 9955.262330 0 4635 2962.243784 3265.725864 0 4636 3935.169487 4229.064298 0 4637 365.626750 4317.761367 0 4638 6197.637419 9108.641145 0 4639 5316.369831 4745.753375 0 4640 9919.168103 7359.255326 0 4641 8997.566204 5187.407560 0 4642 8744.744149 1430.194304 0 4643 8168.421945 1808.102446 0 4644 7934.177742 6944.924500 0 4645 3167.430773 4981.550634 0 4646 5451.793888 9481.741456 0 4647 5013.383127 6968.435243 0 4648 1930.111204 2070.340236 0 4649 2086.662585 8527.546660 0 4650 9372.279238 22.327323 0 4651 944.265759 4316.891476 0 4652 5860.084245 5144.082130 0 4653 6850.044742 9704.503700 0 4654 212.001540 7726.924635 0 4655 7651.388344 7048.377985 0 4656 2613.959482 1077.419020 0 4657 7092.414006 75.195843 0 4658 7622.483327 8695.493123 0 4659 1697.331089 2302.502778 0 4660 3163.200432 3811.901155 0 4661 9740.703881 7766.475560 0 4662 3194.479223 2466.794003 0 4663 2844.100616 3715.541747 0 4664 281.102647 8100.737711 0 4665 3926.742632 2216.074261 0 4666 3391.318065 1208.630811 0 4667 3656.495375 3618.182228 0 4668 9150.173787 5858.866590 0 4669 4048.325171 2450.746241 0 4670 4996.520568 426.986547 0 4671 6563.637484 3413.551726 0 4672 8812.779077 9066.166801 0 4673 612.120684 3719.658082 0 4674 1000.178178 7219.610634 0 4675 8430.167213 7508.816169 0 4676 7085.430846 2913.712222 0 4677 7553.877492 2089.271624 0 4678 3744.371265 9693.047242 0 4679 8727.266531 8056.754275 0 4680 996.574694 4235.527054 0 4681 6655.497930 8227.410185 0 4682 1459.724721 7862.316995 0 4683 9633.182279 6349.880786 0 4684 189.878548 7730.725082 0 4685 2663.278056 754.015786 0 4686 1375.595427 2693.026716 0 4687 1624.641786 370.350486 0 4688 3804.235179 686.942280 0 4689 3831.437365 7723.057452 0 4690 214.667546 7437.458141 0 4691 2633.642347 8689.735313 0 4692 5716.355376 5718.426446 0 4693 9096.315969 1002.142091 0 4694 4331.814149 2079.764868 0 4695 3820.807586 342.873516 0 4696 8471.925479 52.390354 0 4697 7390.525975 5043.017090 0 4698 6222.107021 98.669756 0 4699 90.613829 2865.010770 0 4700 8407.791869 9401.149826 0 4701 3086.590403 9422.622843 0 4702 6840.066330 4255.685107 0 4703 7687.611896 3036.034373 0 4704 3674.012758 8373.231172 0 4705 9823.844625 6714.987653 0 4706 3593.901151 122.229587 0 4707 279.754629 6049.770398 0 4708 2684.611051 2826.990890 0 4709 8434.126267 6552.909029 0 4710 4453.629584 3991.159196 0 4711 3005.678178 8798.157220 0 4712 221.308638 8005.335832 0 4713 3666.553108 1807.216654 0 4714 3348.939751 3554.239604 0 4715 5490.996740 4333.116426 0 4716 7582.673111 7770.907841 0 4717 9265.228802 7741.600301 0 4718 2953.685014 1905.187635 0 4719 5626.324228 1732.074686 0 4720 4182.367911 169.904885 0 4721 6464.853213 4728.123781 0 4722 2436.946223 2387.623224 0 4723 4719.677846 6041.546494 0 4724 1321.698925 4066.233617 0 4725 9240.379934 5217.509346 0 4726 5372.844738 2542.532051 0 4727 5058.476279 1611.868920 0 4728 3283.710424 7261.399037 0 4729 4402.423354 6470.485032 0 4730 8909.925677 9908.194142 0 4731 3687.824159 8287.876252 0 4732 3172.989965 7281.033405 0 4733 9978.682815 1679.226803 0 4734 7018.043108 4190.757465 0 4735 4270.266303 4257.778703 0 4736 1849.104941 765.253933 0 4737 3249.295844 4194.857179 0 4738 1467.322805 2265.499263 0 4739 5055.125982 2007.222034 0 4740 8867.737415 1880.442300 0 4741 34.020803 7037.344529 0 4742 4190.369820 3914.772859 0 4743 5099.395922 4346.423159 0 4744 4513.306612 3259.516527 0 4745 8977.659715 1639.120406 0 4746 5725.124594 7383.613902 0 4747 8183.018241 7688.745944 0 4748 748.978211 1810.211090 0 4749 4730.500276 1738.250196 0 4750 8771.217786 7354.202990 0 4751 3887.689473 8499.150415 0 4752 1536.168841 6359.143689 0 4753 485.875842 2022.569262 0 4754 702.728101 2946.385618 0 4755 4677.242575 5089.013061 0 4756 4402.237950 2049.024360 0 4757 4032.725461 3754.614889 0 4758 1271.419346 5169.730158 0 4759 3793.977507 1859.813722 0 4760 4884.946826 3893.133330 0 4761 2503.382426 4091.648289 0 4762 5390.788382 4810.155989 0 4763 1768.024125 8637.278641 0 4764 5073.834493 6729.856897 0 4765 4376.910889 4242.657693 0 4766 3027.579762 1387.696884 0 4767 5355.491296 9971.820070 0 4768 308.879188 7615.191256 0 4769 5166.360962 5901.773933 0 4770 5111.521501 2326.395516 0 4771 7178.747271 4675.598426 0 4772 5466.229848 5925.544842 0 4773 5681.787533 436.829922 0 4774 7767.341623 7177.259890 0 4775 1583.529777 2199.564668 0 4776 6787.980122 4300.770709 0 4777 9930.552860 364.131573 0 4778 6124.074751 7897.666284 0 4779 3092.801501 9498.536942 0 4780 2449.839234 3189.120083 0 4781 4028.572911 730.780159 0 4782 6466.150530 6979.212114 0 4783 7825.247626 896.572883 0 4784 3251.549157 5903.906221 0 4785 5333.755560 6527.016272 0 4786 4683.333494 8683.633282 0 4787 9222.933833 7775.155416 0 4788 487.647207 1391.013295 0 4789 1767.286942 8922.927016 0 4790 30.193496 3957.762774 0 4791 9631.521509 9376.581209 0 4792 8184.773753 5318.522603 0 4793 3461.496291 7338.840202 0 4794 6062.408949 6898.634101 0 4795 5651.845025 5018.506630 0 4796 3806.050281 8653.836435 0 4797 605.907499 6191.196234 0 4798 6279.964848 5843.094831 0 4799 1814.072206 4258.459041 0 4800 4798.909652 6560.291310 0 4801 4935.420376 909.463289 0 4802 250.729585 5811.257612 0 4803 7495.887928 1606.123730 0 4804 3320.344711 7760.326776 0 4805 4640.326229 1284.249708 0 4806 7815.642089 4145.694441 0 4807 1473.360960 7772.869459 0 4808 9779.134423 3191.151474 0 4809 7336.380386 6610.228016 0 4810 5011.230532 6810.595666 0 4811 4767.340618 5491.592918 0 4812 1415.017085 9988.531105 0 4813 1529.165865 4052.832944 0 4814 1152.891651 3511.973515 0 4815 2222.395391 3730.129825 0 4816 1036.267914 7037.330607 0 4817 3667.703327 9519.968145 0 4818 9795.271855 449.738719 0 4819 7928.347553 9082.801256 0 4820 8466.002824 2729.623792 0 4821 5952.530498 9015.228588 0 4822 8915.493927 8617.875012 0 4823 8812.928282 7265.374891 0 4824 9336.762217 9225.080561 0 4825 8610.833109 3469.883384 0 4826 1147.494870 1158.885774 0 4827 6525.346240 723.163775 0 4828 7996.633895 9714.037687 0 4829 6852.300661 9099.797023 0 4830 7934.345344 8351.551249 0 4831 1523.276822 2291.696019 0 4832 1753.590116 5165.187544 0 4833 3036.032662 5079.856640 0 4834 315.884037 4047.211624 0 4835 4278.865241 9236.783449 0 4836 7935.579925 2296.074194 0 4837 3486.713103 9218.084450 0 4838 2353.470316 4937.905811 0 4839 3337.315229 5568.712238 0 4840 2837.027420 2888.507951 0 4841 202.856289 861.980057 0 4842 2660.574441 8824.007032 0 4843 2876.203167 5993.460349 0 4844 6739.843217 9652.658644 0 4845 6318.641545 4016.708827 0 4846 4327.937390 5942.913393 0 4847 592.777539 4441.203672 0 4848 1833.449775 2495.602946 0 4849 2627.458859 8037.706042 0 4850 6787.231669 6308.699277 0 4851 9336.332225 2528.501744 0 4852 8369.316255 4716.947714 0 4853 9560.400017 6641.263476 0 4854 6183.163202 7615.005666 0 4855 3382.867010 8785.370820 0 4856 8619.073833 7852.483459 0 4857 7033.461321 163.249969 0 4858 178.452902 8336.780290 0 4859 2295.061888 6185.507220 0 4860 1461.593646 1781.985096 0 4861 4862.868899 3422.054232 0 4862 6066.478369 3554.166285 0 4863 4744.206254 3036.049005 0 4864 7255.547670 343.881653 0 4865 252.309519 5003.308753 0 4866 2174.826752 6565.644961 0 4867 5114.121562 1314.130048 0 4868 4124.254018 8152.057242 0 4869 3949.595293 6567.370542 0 4870 1528.646733 1892.900702 0 4871 6002.124536 1946.046904 0 4872 6220.993173 8444.160203 0 4873 5360.542873 144.919815 0 4874 7596.915298 2741.684353 0 4875 4085.750702 2878.560516 0 4876 1598.325382 6468.823750 0 4877 7348.764823 426.571919 0 4878 3742.527240 7378.797103 0 4879 8373.774274 9752.419298 0 4880 121.619278 1116.876973 0 4881 342.892906 580.321790 0 4882 9519.216055 2231.238961 0 4883 837.312414 2699.910322 0 4884 6194.156748 9118.742954 0 4885 8838.504169 8902.765170 0 4886 7671.732905 7907.043510 0 4887 2125.256372 4768.109918 0 4888 1416.954349 3351.591206 0 4889 4366.274799 6862.023077 0 4890 6421.307833 4558.593387 0 4891 3245.406125 7159.396509 0 4892 6892.533885 5092.952399 0 4893 130.039448 9013.935070 0 4894 5856.725836 1895.632910 0 4895 3843.713043 1292.969688 0 4896 369.925801 7707.520989 0 4897 4057.699088 4625.909644 0 4898 6806.066562 4101.611630 0 4899 4435.974811 3871.097357 0 4900 4072.057487 7229.189201 0 4901 201.453305 2205.574969 0 4902 6451.686537 6496.808088 0 4903 8739.166541 723.745133 0 4904 693.717327 700.358579 0 4905 9438.214603 787.656573 0 4906 1843.838789 1445.238253 0 4907 2404.760957 6723.788249 0 4908 3241.284758 6842.461479 0 4909 7118.683016 9340.542702 0 4910 2535.760907 6288.203639 0 4911 5038.573630 1120.709711 0 4912 1247.101008 2474.010426 0 4913 3098.572978 1836.493930 0 4914 4730.805712 2107.935526 0 4915 4958.264349 6661.534826 0 4916 8074.309039 3813.987146 0 4917 31.586498 9760.462280 0 4918 3652.195599 9457.394899 0 4919 2804.239977 8190.176544 0 4920 1010.795252 187.013168 0 4921 1820.759596 5724.203237 0 4922 1720.574662 3579.099993 0 4923 2817.265011 388.154245 0 4924 8382.420964 7297.474730 0 4925 9102.289289 4551.191032 0 4926 5076.617356 568.333493 0 4927 862.837490 5411.999823 0 4928 2205.288701 1326.136289 0 4929 5876.035910 259.232175 0 4930 6584.759127 1710.078493 0 4931 1175.882561 3726.389342 0 4932 8432.193291 8048.368255 0 4933 6334.382484 5522.367858 0 4934 3356.386101 2332.071579 0 4935 414.634926 8753.509664 0 4936 8244.154129 7412.874254 0 4937 2979.085631 4727.175687 0 4938 7652.920413 8811.199920 0 4939 9546.159919 3599.057848 0 4940 4095.982757 7584.844130 0 4941 1755.065552 2027.483174 0 4942 2175.552733 9122.554524 0 4943 8528.051342 8198.217087 0 4944 996.115720 8864.491018 0 4945 9518.864389 227.974175 0 4946 9978.926938 1989.313726 0 4947 2529.472016 3111.130239 0 4948 4739.443107 7378.504673 0 4949 2828.515854 8168.638801 0 4950 3897.325379 109.864587 0 4951 7650.356283 4908.891636 0 4952 7666.634922 401.029785 0 4953 3958.348341 5770.822884 0 4954 9162.245057 5047.334234 0 4955 9335.368251 5722.347421 0 4956 4626.681087 3167.637900 0 4957 7545.394006 7724.545794 0 4958 206.028164 3316.087035 0 4959 3127.384384 2274.260292 0 4960 5496.929323 3379.530782 0 4961 1568.338435 7501.649752 0 4962 1518.509359 3351.302908 0 4963 8925.878136 7766.744339 0 4964 3510.629010 4277.223479 0 4965 3661.659109 6997.247029 0 4966 9791.572420 7727.372597 0 4967 15.694351 392.030328 0 4968 3773.255716 9455.407997 0 4969 5806.560629 3832.086004 0 4970 8377.150122 5150.726187 0 4971 7467.087716 5504.263950 0 4972 2408.970686 6905.499123 0 4973 2036.383801 1185.552403 0 4974 6130.038261 112.348532 0 4975 4642.577305 2644.187731 0 4976 3962.278907 4097.586530 0 4977 4274.835240 924.194594 0 4978 5300.445262 2645.388712 0 4979 9127.690629 932.203949 0 4980 8495.211484 6183.994893 0 4981 3492.829109 5371.482264 0 4982 5426.148943 5604.970748 0 4983 8838.415998 5629.096720 0 4984 671.203470 7350.869172 0 4985 838.204840 7823.722535 0 4986 4963.425336 1669.287156 0 4987 3152.401469 6746.200497 0 4988 8366.210602 6235.085898 0 4989 7708.287284 1906.785237 0 4990 5923.057228 1517.785134 0 4991 9161.010318 9777.556041 0 4992 49.161544 6864.357861 0 4993 814.073241 1791.399381 0 4994 7013.770845 2617.747687 0 4995 460.819527 8278.845146 0 4996 1256.134019 1296.025297 0 4997 8845.939325 9717.714386 0 4998 7248.768560 3042.480071 0 4999 6189.688443 5882.681495 0 5000 8134.267157 6303.253744 0 5001 6490.336076 845.266346 0 5002 5633.674869 7208.726062 0 5003 972.558280 1470.335018 0 5004 2015.941695 2454.185278 0 5005 7687.605215 1062.352258 0 5006 4614.201381 2062.027425 0 5007 6116.850392 5603.112179 0 5008 6470.812117 9971.121818 0 5009 3959.077044 4188.137042 0 5010 891.389874 5274.936609 0 5011 659.387321 3907.400520 0 5012 8699.477998 9557.782421 0 5013 6250.189531 6759.240335 0 5014 7492.125832 230.375631 0 5015 8849.137537 7254.033194 0 5016 8840.614614 5533.974641 0 5017 5833.935525 7691.284955 0 5018 933.499680 6743.754625 0 5019 5640.127843 5802.276862 0 5020 3294.052617 3757.541412 0 5021 9178.238042 5675.758914 0 5022 3016.236749 179.862690 0 5023 1240.533648 178.071246 0 5024 2655.832735 5528.690437 0 5025 3207.067111 5652.518404 0 5026 5388.496664 2400.689058 0 5027 7097.129219 4669.444087 0 5028 4703.190986 4919.756743 0 5029 9880.071357 8224.349882 0 5030 2452.577523 3418.956682 0 5031 2248.320424 3324.150367 0 5032 3992.056781 2005.932046 0 5033 5228.526634 8456.964329 0 5034 6163.178489 5848.251064 0 5035 4086.831171 279.444914 0 5036 62.330453 5318.867796 0 5037 6686.999090 6552.479450 0 5038 5694.595003 4445.981626 0 5039 8207.917049 8586.283623 0 5040 7780.549808 217.227878 0 5041 5752.891407 7532.686541 0 5042 2904.276071 2500.135141 0 5043 5541.043167 8030.063576 0 5044 5192.750710 4360.939893 0 5045 8839.880278 8315.945362 0 5046 7303.960532 6986.425995 0 5047 6523.257926 6163.722003 0 5048 1924.628969 1020.300591 0 5049 2317.571710 9627.144297 0 5050 1508.900601 7713.511976 0 5051 2406.873090 4210.156494 0 5052 5594.589130 4153.550570 0 5053 9015.444667 9545.442380 0 5054 4147.875488 4756.604073 0 5055 5887.697605 4300.251379 0 5056 9772.251016 6306.739907 0 5057 6111.463322 1765.083129 0 5058 823.847511 495.668762 0 5059 2680.226159 1905.016978 0 5060 2924.831364 5932.490586 0 5061 6998.185908 9234.046991 0 5062 7047.802410 6304.936187 0 5063 2920.852950 8550.548768 0 5064 8215.054362 7670.839630 0 5065 7327.051558 7326.972084 0 5066 7956.014531 5635.099700 0 5067 2625.084371 2884.558307 0 5068 9508.923625 1641.818482 0 5069 4609.759350 389.094158 0 5070 5505.109330 4879.012861 0 5071 2794.798637 342.726146 0 5072 3010.000733 5584.717736 0 5073 7703.319314 283.204256 0 5074 1104.344443 4596.119732 0 5075 8030.405878 7985.332288 0 5076 7127.089957 3096.294739 0 5077 9445.165687 6102.844358 0 5078 532.297058 2745.344410 0 5079 4956.939878 430.737648 0 5080 8958.383090 4221.536365 0 5081 5301.740564 272.607549 0 5082 2566.534523 3649.849958 0 5083 5786.298104 5126.028177 0 5084 6799.227425 1779.122788 0 5085 5219.307840 3885.910971 0 5086 6045.839149 7282.438716 0 5087 3417.277837 3645.450743 0 5088 5611.966368 8268.138010 0 5089 6254.354817 7434.917232 0 5090 7193.382409 5828.607110 0 5091 6291.597361 1514.475487 0 5092 6246.594247 7283.104328 0 5093 634.426594 3.579986 0 5094 7135.401546 8462.533053 0 5095 243.302169 5638.748574 0 5096 7077.194117 8892.424214 0 5097 3829.527966 3959.957081 0 5098 5808.475191 6606.404369 0 5099 209.676516 4630.160548 0 5100 3029.231660 122.500989 0 5101 7777.589152 3936.894067 0 5102 5746.950084 7100.032439 0 5103 201.645747 1201.097641 0 5104 8763.701433 3910.733786 0 5105 34.864466 9886.244730 0 5106 8143.719691 3313.826906 0 5107 800.937825 5567.925722 0 5108 2696.846989 785.862186 0 5109 5620.922631 272.734226 0 5110 7808.051224 5609.595643 0 5111 2332.989153 4407.863657 0 5112 531.595946 488.529415 0 5113 2625.747532 3788.927973 0 5114 4050.348142 6371.968071 0 5115 7871.592731 3062.769623 0 5116 2203.665834 4635.261026 0 5117 4820.538455 6670.565695 0 5118 3998.635436 938.212291 0 5119 7468.658068 624.552289 0 5120 7273.667799 568.389351 0 5121 8386.480320 2293.779015 0 5122 1008.677731 7836.357293 0 5123 1406.363062 2521.415336 0 5124 8906.199686 8653.120440 0 5125 3600.678650 119.281867 0 5126 2361.796235 4341.337512 0 5127 4686.097698 6690.176776 0 5128 4427.171353 3839.790885 0 5129 1216.575760 5983.888735 0 5130 7871.620644 3274.990899 0 5131 4098.882802 7530.830937 0 5132 8241.598765 7598.954155 0 5133 1711.071110 3450.203421 0 5134 9791.955635 9806.255752 0 5135 8590.505172 6764.843554 0 5136 955.185888 4088.136502 0 5137 6614.796700 8076.512308 0 5138 6341.089224 7841.730028 0 5139 277.556399 2385.521370 0 5140 8120.641318 938.357042 0 5141 5765.513655 8469.091641 0 5142 4619.623789 5980.893984 0 5143 9613.295371 9030.472922 0 5144 112.660323 1293.556552 0 5145 6598.603769 2858.405313 0 5146 619.530022 2773.589272 0 5147 9637.121207 8157.725102 0 5148 5626.935308 8920.997610 0 5149 5838.289616 831.574155 0 5150 4104.014824 4991.571299 0 5151 3678.384020 7214.535603 0 5152 2781.521805 1026.592075 0 5153 1636.726228 3074.375908 0 5154 5790.170627 6924.431978 0 5155 81.401032 5538.065165 0 5156 8062.424188 5292.461085 0 5157 4253.201646 9558.605434 0 5158 9268.673426 9375.797223 0 5159 6177.384608 1188.004432 0 5160 4429.744061 9292.239438 0 5161 7383.761690 5471.175281 0 5162 8629.187989 3037.965907 0 5163 6381.473095 7041.142513 0 5164 7258.710253 6090.708793 0 5165 4024.487506 4081.762193 0 5166 3276.413287 2584.763152 0 5167 6255.333250 6773.126158 0 5168 3585.585876 5710.112610 0 5169 3424.849688 2029.143959 0 5170 9708.195463 7537.034479 0 5171 6991.205422 55.901174 0 5172 6745.276718 3723.930146 0 5173 5073.535532 9326.220572 0 5174 2462.559517 1492.733486 0 5175 7070.128392 5312.845512 0 5176 894.981841 4012.663550 0 5177 8861.732571 3982.873398 0 5178 8843.758617 4963.619476 0 5179 8669.408888 7026.809201 0 5180 7692.213272 2754.296663 0 5181 8968.185538 9840.757860 0 5182 9109.759075 8244.559051 0 5183 8458.123413 1105.701370 0 5184 7418.458195 9778.087356 0 5185 5721.262859 1774.196207 0 5186 3669.855781 7153.886923 0 5187 5984.738173 1648.222319 0 5188 5392.999973 725.151399 0 5189 7640.734853 377.108202 0 5190 8256.859904 2928.921261 0 5191 9976.893443 9131.737458 0 5192 9950.778131 5916.468602 0 5193 5421.497827 7580.207387 0 5194 902.743976 7941.355446 0 5195 8593.854833 5071.092237 0 5196 3868.600509 4031.777583 0 5197 7337.299843 5237.608532 0 5198 2122.806679 8307.696854 0 5199 3606.143942 268.886202 0 5200 6444.870263 5020.370314 0 5201 6879.583928 5239.857697 0 5202 6235.622657 3845.655113 0 5203 362.280883 2347.154994 0 5204 2912.291682 5214.738129 0 5205 4617.564628 4137.419267 0 5206 1133.407492 4106.416438 0 5207 2917.609548 8380.016143 0 5208 7817.540259 59.614671 0 5209 8050.586729 7819.687819 0 5210 4046.036366 5367.568151 0 5211 6416.472974 651.571401 0 5212 7881.735295 9031.298122 0 5213 8762.983200 103.933691 0 5214 4525.878637 2340.854242 0 5215 8122.898338 105.213051 0 5216 1668.450276 5307.005541 0 5217 7505.663599 6049.758852 0 5218 2421.318853 2093.931547 0 5219 2935.945951 6527.009666 0 5220 4715.233910 9732.968293 0 5221 1915.408653 5060.150975 0 5222 5524.948703 7349.082483 0 5223 9981.523694 8518.225514 0 5224 4578.295986 3651.520756 0 5225 3113.864337 6739.402721 0 5226 904.289032 3021.317124 0 5227 8775.655967 2621.675602 0 5228 4000.729852 4831.045630 0 5229 8059.320410 6026.427278 0 5230 4228.713058 3662.846279 0 5231 5682.904908 716.883886 0 5232 7723.842993 8019.056350 0 5233 6098.553185 1212.648891 0 5234 2610.138732 7218.269608 0 5235 2749.555091 9188.009337 0 5236 6621.283505 8813.474292 0 5237 1008.145796 687.804537 0 5238 4495.248730 7757.639988 0 5239 2023.456348 4682.578091 0 5240 3471.533863 7800.963605 0 5241 4869.178620 9299.761153 0 5242 7724.508952 232.955560 0 5243 2775.060414 7112.993340 0 5244 8998.015309 389.742912 0 5245 5156.606688 3918.610630 0 5246 188.977360 3354.211515 0 5247 3497.009347 3889.179184 0 5248 7846.223065 2733.451294 0 5249 8956.726246 9965.071659 0 5250 4914.819622 7906.959526 0 5251 5770.162517 1828.885883 0 5252 6165.169702 44.837721 0 5253 8939.192204 2548.976313 0 5254 1688.595268 9976.965421 0 5255 7733.173697 5703.710685 0 5256 9582.784094 8671.736581 0 5257 7749.765957 1675.407260 0 5258 7963.002062 1149.238842 0 5259 2882.125541 2693.390015 0 5260 8635.249819 7263.068285 0 5261 2089.453976 1303.352805 0 5262 5773.158748 6852.319885 0 5263 2198.137446 9386.403267 0 5264 2634.437666 8321.084200 0 5265 4468.154422 3160.418523 0 5266 8569.753765 9724.593437 0 5267 4793.027526 5496.938088 0 5268 3075.956910 6177.757315 0 5269 2512.863058 6650.874591 0 5270 9103.497573 5343.759275 0 5271 8996.038636 7876.818246 0 5272 619.513620 8775.185687 0 5273 7408.741196 4646.402696 0 5274 4792.239854 7804.312385 0 5275 3432.058653 2895.638231 0 5276 5752.062002 160.712001 0 5277 4170.675158 475.555282 0 5278 1362.171898 7851.211092 0 5279 6239.442049 2038.852271 0 5280 8658.335156 5443.361072 0 5281 2541.246950 4824.440208 0 5282 3489.928446 6192.650255 0 5283 9976.950654 6589.619628 0 5284 4148.541032 5589.783255 0 5285 5476.962112 6841.414121 0 5286 6987.965682 5392.961309 0 5287 4689.076697 5772.325486 0 5288 2575.301424 4089.559705 0 5289 1182.381285 4369.987814 0 5290 6473.183500 4600.981743 0 5291 5400.505424 8616.322445 0 5292 5803.166721 183.766834 0 5293 7855.344768 3035.849363 0 5294 3848.797752 9669.364120 0 5295 8449.106585 3122.592718 0 5296 2325.137575 3997.967911 0 5297 2156.021797 7530.560866 0 5298 686.482367 7.340173 0 5299 4386.059890 30.200744 0 5300 6436.828789 7012.983939 0 5301 568.279604 9267.732630 0 5302 2730.202957 9906.992866 0 5303 8957.080688 4390.757515 0 5304 3806.710081 5434.687990 0 5305 6398.445081 1164.366373 0 5306 144.253344 9597.822398 0 5307 4162.689174 2104.555410 0 5308 8069.324215 3596.860529 0 5309 7860.561051 9259.685749 0 5310 5687.769982 5118.265669 0 5311 7331.055342 489.799414 0 5312 8910.828255 2228.196958 0 5313 2101.334518 3217.316176 0 5314 5648.801018 4830.639067 0 5315 8231.256481 7105.544402 0 5316 4910.715323 2503.470899 0 5317 8972.155873 3020.216036 0 5318 5728.980276 6965.947250 0 5319 5319.780896 7445.348807 0 5320 927.039576 1360.935019 0 5321 2529.181434 7311.435559 0 5322 4721.647968 880.767113 0 5323 1801.267803 8334.210060 0 5324 8547.527391 3309.192000 0 5325 2167.843791 5521.498760 0 5326 2562.646779 3818.368256 0 5327 5222.170360 7367.457131 0 5328 9302.507360 4674.454236 0 5329 9689.372249 335.879067 0 5330 6659.564218 3234.584419 0 5331 1412.606290 5340.923417 0 5332 4556.627992 2018.953878 0 5333 6933.417426 220.956071 0 5334 1588.352024 9877.634589 0 5335 1131.216289 5515.569246 0 5336 3773.487808 7838.105336 0 5337 346.485167 2232.901320 0 5338 616.733330 2576.130442 0 5339 4847.031937 193.170209 0 5340 5131.362277 1098.727935 0 5341 6235.707727 5862.624589 0 5342 1562.942312 2345.860606 0 5343 627.579364 9665.397737 0 5344 9330.810038 435.849605 0 5345 6512.708750 4229.138772 0 5346 6316.248488 8492.991492 0 5347 1878.432249 7266.117445 0 5348 9766.092961 5286.472388 0 5349 6578.030028 4990.358868 0 5350 9508.202897 4967.221827 0 5351 5261.721416 5593.200050 0 5352 4185.435920 1968.607576 0 5353 2897.896762 7692.024976 0 5354 789.486235 3885.658778 0 5355 185.775670 9505.162584 0 5356 510.262929 165.163211 0 5357 8531.973000 6256.178023 0 5358 2959.168045 480.250092 0 5359 2227.434405 7240.388330 0 5360 7999.594693 6900.634235 0 5361 578.805491 8018.067953 0 5362 8250.055370 3047.333990 0 5363 2477.954846 7314.048522 0 5364 3538.133646 8936.800464 0 5365 6187.803844 4781.237921 0 5366 6404.199171 5663.928088 0 5367 8397.831773 4567.980993 0 5368 9373.192429 2600.875774 0 5369 982.250526 9431.418600 0 5370 3513.821808 5191.727907 0 5371 2912.602318 3748.919525 0 5372 6110.353690 5608.663758 0 5373 5269.061991 5719.096216 0 5374 6286.149541 892.521715 0 5375 8381.722408 2210.961703 0 5376 4977.081717 4193.689421 0 5377 2058.197352 9636.474373 0 5378 2763.743502 446.946571 0 5379 1204.077976 3586.955345 0 5380 1665.726948 5145.505214 0 5381 9748.703183 3268.489015 0 5382 9904.869445 319.541860 0 5383 5224.303994 7431.932911 0 5384 9322.754286 6702.521042 0 5385 8910.383321 1126.760212 0 5386 4652.276507 7363.342019 0 5387 5386.455033 3268.876020 0 5388 8606.708911 5961.881820 0 5389 346.819975 4586.492610 0 5390 7848.615895 4188.779925 0 5391 1657.248059 4846.698030 0 5392 5522.717022 2400.194804 0 5393 6323.051964 5183.923567 0 5394 9532.764254 3728.645572 0 5395 8531.490385 8846.434386 0 5396 7875.788088 7029.217477 0 5397 5450.021143 674.049894 0 5398 5372.191764 1372.547287 0 5399 3662.743101 2348.380592 0 5400 4952.580827 1386.742715 0 5401 8566.112167 837.983872 0 5402 8588.125730 928.937590 0 5403 9713.786378 5386.695865 0 5404 153.979247 750.976562 0 5405 9975.148436 568.450119 0 5406 6384.568553 365.533143 0 5407 9852.797225 8110.483496 0 5408 4125.991591 5404.145235 0 5409 2670.098843 4712.695422 0 5410 6854.644275 8682.300272 0 5411 9559.301178 6636.965947 0 5412 1928.325172 9348.719967 0 5413 7466.085118 7100.892628 0 5414 1449.944730 6478.653991 0 5415 3822.023334 358.516533 0 5416 1172.381038 5688.608025 0 5417 5997.800553 9543.483257 0 5418 8992.658485 1707.492673 0 5419 2824.438897 5239.185928 0 5420 2457.115696 4052.747871 0 5421 1983.864109 9174.413577 0 5422 4653.653491 9031.941149 0 5423 1682.801467 3727.043302 0 5424 9580.649295 6672.075102 0 5425 5802.956180 3685.186987 0 5426 8805.433702 5965.260590 0 5427 992.601690 6435.679125 0 5428 7804.990072 8379.429904 0 5429 2960.910473 9898.210503 0 5430 1360.943454 2857.889285 0 5431 1184.857518 1046.593243 0 5432 5119.852877 5775.917757 0 5433 1753.504508 6867.105864 0 5434 8767.529052 6934.122352 0 5435 1977.087273 6327.142213 0 5436 9596.535608 4071.443252 0 5437 9347.592317 7218.870223 0 5438 4557.384406 1979.459558 0 5439 4628.477397 889.876719 0 5440 8623.233884 5004.800511 0 5441 5708.357276 8299.054226 0 5442 1594.495521 5039.490614 0 5443 7745.264867 3213.645093 0 5444 9270.778757 7621.633209 0 5445 7783.369732 6773.584675 0 5446 7058.954190 7370.523438 0 5447 6428.259145 1567.738744 0 5448 6474.470384 302.490700 0 5449 1679.558510 9832.900483 0 5450 7723.956883 300.066811 0 5451 5143.356822 4084.146624 0 5452 1696.138954 3917.459256 0 5453 9244.965088 1137.633611 0 5454 9680.540204 6533.993961 0 5455 2623.585995 6833.271256 0 5456 9581.480005 9085.727017 0 5457 9430.173466 8499.558250 0 5458 8913.640374 4999.837944 0 5459 8697.921018 7203.605982 0 5460 1776.834905 2025.758535 0 5461 2941.616580 8881.882849 0 5462 8913.132958 7857.015279 0 5463 9887.030810 265.655057 0 5464 644.341593 3645.990060 0 5465 3973.006042 8448.078709 0 5466 926.100831 3731.257285 0 5467 2022.982575 9623.330028 0 5468 3725.957533 2228.093665 0 5469 4925.876101 732.200384 0 5470 3735.151785 3658.722444 0 5471 4386.469963 5171.264913 0 5472 1501.462498 979.149704 0 5473 6767.521346 3860.677811 0 5474 3119.160281 3551.515374 0 5475 5075.242337 2304.163346 0 5476 2709.549790 9629.146931 0 5477 3664.115459 8119.155845 0 5478 3558.113174 1274.749039 0 5479 729.462747 2020.338633 0 5480 9899.175693 4204.284662 0 5481 9885.752078 8551.446402 0 5482 6050.569744 1737.549269 0 5483 1655.507480 7753.361018 0 5484 2429.689505 4764.094056 0 5485 4052.267826 5570.319014 0 5486 2198.208634 7325.507208 0 5487 9523.809086 7307.423164 0 5488 2463.399408 8465.485674 0 5489 1541.109915 3332.228971 0 5490 3845.731743 5522.766511 0 5491 3489.732205 3131.910965 0 5492 1577.130440 3894.953290 0 5493 6902.174494 7483.272512 0 5494 9751.992549 6294.978200 0 5495 5939.999586 469.633043 0 5496 7731.729898 4481.353705 0 5497 2352.885000 9883.255148 0 5498 101.190776 4747.853117 0 5499 9258.500524 2281.074745 0 5500 2398.531706 1306.885403 0 5501 6967.937318 6635.621204 0 5502 6635.611898 7082.501778 0 5503 6992.128086 496.534958 0 5504 9256.241847 7207.952655 0 5505 5521.209214 5257.259432 0 5506 8205.224938 4554.104788 0 5507 8619.716679 6966.767229 0 5508 4107.698294 7139.300338 0 5509 7960.852223 7310.733597 0 5510 6134.744161 2491.912514 0 5511 1920.116883 8330.902715 0 5512 835.490147 1054.289718 0 5513 1677.456540 5498.794192 0 5514 5224.060974 4297.854592 0 5515 7520.473112 7114.417453 0 5516 1421.535765 3005.988139 0 5517 7245.998742 6225.904522 0 5518 2769.734093 4400.390919 0 5519 9647.791874 8324.010159 0 5520 6034.364894 8756.155173 0 5521 6724.822990 5525.468915 0 5522 5058.852991 3169.009531 0 5523 7620.195958 4479.524477 0 5524 5408.362342 7769.971409 0 5525 9657.339934 8166.194199 0 5526 4461.092756 5873.673918 0 5527 1083.065376 6239.879663 0 5528 8129.195914 9662.738200 0 5529 6342.092754 1964.767325 0 5530 2049.723502 2467.934922 0 5531 6791.286519 6364.741024 0 5532 5557.851773 4591.411316 0 5533 3718.141406 7679.919319 0 5534 5936.515090 4087.726921 0 5535 9779.737642 3840.434575 0 5536 1883.082613 9052.904212 0 5537 4076.617703 951.244324 0 5538 8552.040113 2528.902782 0 5539 6398.817639 7688.192754 0 5540 7137.039155 2045.512203 0 5541 4758.777271 3081.118089 0 5542 3469.581595 6258.955365 0 5543 1506.513762 2722.229243 0 5544 5504.256648 1825.039751 0 5545 9323.283613 9297.416405 0 5546 9758.370792 553.108339 0 5547 6795.422303 8756.781569 0 5548 3102.589083 6193.739239 0 5549 6694.857873 1292.227894 0 5550 8248.997860 3986.225814 0 5551 709.356574 9231.666433 0 5552 6344.476185 2804.087455 0 5553 8846.691863 2984.778027 0 5554 8406.193925 6113.269069 0 5555 3820.252788 1838.107781 0 5556 4705.198146 5723.388226 0 5557 891.747732 1610.527089 0 5558 5377.309361 1412.683013 0 5559 4070.889114 66.979866 0 5560 6719.721457 8559.462205 0 5561 8184.758074 3355.159634 0 5562 6555.799226 3154.905644 0 5563 921.280972 9250.469524 0 5564 2594.890957 3492.433969 0 5565 1592.554463 8627.429131 0 5566 5834.361555 1449.388927 0 5567 8263.451371 7744.294501 0 5568 6378.005741 6703.140773 0 5569 4105.083305 1525.048170 0 5570 7066.426603 8579.069082 0 5571 3345.659300 1003.331334 0 5572 6176.773962 8395.763922 0 5573 9831.956255 1559.417196 0 5574 7750.619851 581.033397 0 5575 5185.427785 54.614222 0 5576 1240.545485 617.034969 0 5577 7918.595449 9990.732334 0 5578 6006.950058 1745.808358 0 5579 2959.267147 1889.376636 0 5580 3472.710177 5070.482499 0 5581 6213.451547 3475.423160 0 5582 3373.255328 878.288743 0 5583 208.281750 2957.680691 0 5584 8632.527849 8781.762434 0 5585 9408.088638 5009.356640 0 5586 2646.858754 4479.374717 0 5587 1054.752177 4624.526229 0 5588 2897.369633 1369.719304 0 5589 3388.730729 851.114862 0 5590 8345.711631 3368.044301 0 5591 9961.795587 1662.964461 0 5592 5665.884046 448.426029 0 5593 8203.587834 4180.554549 0 5594 2102.494048 9946.390085 0 5595 2612.434524 8252.933841 0 5596 2072.511104 4618.259056 0 5597 7570.728380 3154.257982 0 5598 4164.802427 476.782024 0 5599 2273.006619 4712.446613 0 5600 2475.091617 6543.627325 0 5601 3285.916873 7635.941867 0 5602 9756.050926 2602.538583 0 5603 9575.465316 8251.452146 0 5604 3027.679241 3761.236955 0 5605 3119.003412 1164.388475 0 5606 7808.472790 7654.953199 0 5607 9978.489493 4251.862542 0 5608 3913.914063 5037.769235 0 5609 6602.271726 9025.359939 0 5610 8852.091326 2389.201832 0 5611 3294.748068 7046.676323 0 5612 3700.066028 5799.676075 0 5613 6968.443245 4357.404743 0 5614 7317.914450 6690.805566 0 5615 4558.996114 8396.729620 0 5616 6460.959132 2405.556106 0 5617 9773.804260 7284.122333 0 5618 7667.315862 3693.471855 0 5619 9866.891257 9670.220232 0 5620 2777.306333 6613.464578 0 5621 1819.582617 6735.162445 0 5622 5708.481867 5674.374020 0 5623 1157.651617 8455.616375 0 5624 7338.202040 5396.365042 0 5625 4450.511467 7225.898425 0 5626 1414.208675 8267.371653 0 5627 7164.542926 7638.140135 0 5628 5261.793085 5653.357174 0 5629 3840.052105 1196.042883 0 5630 9055.243804 1262.042549 0 5631 4739.460218 4075.803045 0 5632 6857.190394 456.489600 0 5633 7356.707276 9849.229234 0 5634 1785.149623 4187.827570 0 5635 5108.970313 5644.629628 0 5636 1643.709890 4044.914697 0 5637 2759.046870 1456.552570 0 5638 2102.532365 4560.203193 0 5639 4972.167736 2240.415293 0 5640 7332.535013 2083.195720 0 5641 339.858478 398.526605 0 5642 493.449074 5603.285297 0 5643 6828.829336 8849.544952 0 5644 8898.456577 5180.168838 0 5645 6920.989239 8145.771500 0 5646 2823.105022 2363.677484 0 5647 962.152389 4125.223335 0 5648 8008.849320 5806.735146 0 5649 4596.831747 8298.833168 0 5650 1470.038279 586.385419 0 5651 7438.981731 7243.511794 0 5652 8915.359127 6899.769205 0 5653 91.728484 5339.389117 0 5654 639.888005 3719.586764 0 5655 6858.108048 8491.215737 0 5656 2926.722869 1713.141813 0 5657 4503.432589 1054.391018 0 5658 9542.978850 1294.134977 0 5659 5531.279093 4943.673803 0 5660 9215.760064 8127.947138 0 5661 3477.840755 9067.065962 0 5662 704.256719 2203.986613 0 5663 7634.841256 5677.584376 0 5664 3768.226492 3810.079525 0 5665 3316.881506 2711.972346 0 5666 3928.461458 4063.852165 0 5667 3926.483295 2871.817965 0 5668 6639.619791 7391.371339 0 5669 1969.133147 9784.253019 0 5670 1644.627590 176.712897 0 5671 8758.853075 3801.849675 0 5672 1516.767714 2148.652367 0 5673 5343.057039 3993.458367 0 5674 1886.704640 1070.543684 0 5675 9942.459086 7097.950866 0 5676 7045.267314 1203.409885 0 5677 4140.031506 5959.419070 0 5678 5938.750888 1406.054777 0 5679 8959.242339 5956.396603 0 5680 2315.584522 4692.341655 0 5681 5488.648969 9886.847686 0 5682 4514.146400 1398.478348 0 5683 2850.264850 3719.839640 0 5684 7740.194724 6406.577741 0 5685 4714.250506 1722.385855 0 5686 4038.365044 6978.322409 0 5687 5421.567115 6027.719215 0 5688 8230.517959 1018.390975 0 5689 9122.004385 5554.150369 0 5690 5386.643192 4075.037546 0 5691 6226.592672 8755.655181 0 5692 9478.849461 4955.943321 0 5693 2078.461100 3748.607703 0 5694 6127.692516 9338.419521 0 5695 9499.523107 5669.164541 0 5696 350.916222 8505.676162 0 5697 9949.849182 4470.905437 0 5698 7003.816419 5954.540632 0 5699 6267.912445 7900.347797 0 5700 4208.394147 2694.222897 0 5701 2935.944722 1652.431140 0 5702 7058.033462 7659.449900 0 5703 2732.634811 4900.657847 0 5704 6048.851121 5683.655008 0 5705 4997.592574 736.495203 0 5706 2449.115496 7139.200106 0 5707 4812.478035 3472.764138 0 5708 934.622353 6106.748382 0 5709 4812.028095 1372.366498 0 5710 5336.776499 5635.959073 0 5711 4949.063893 3392.812924 0 5712 6385.659435 2129.982366 0 5713 4563.118658 1461.455857 0 5714 9784.125333 9193.138234 0 5715 105.637761 2060.238786 0 5716 1409.035865 7699.592383 0 5717 3256.340300 2322.139355 0 5718 1906.592596 4436.449952 0 5719 4737.817459 7611.325638 0 5720 2384.418241 9294.499076 0 5721 3053.866493 8695.401056 0 5722 823.162806 7755.067428 0 5723 8585.820749 3419.827899 0 5724 8080.792800 9621.235557 0 5725 310.088310 1400.646565 0 5726 7510.934237 3806.431166 0 5727 4204.979748 9261.043310 0 5728 5120.497305 1074.532203 0 5729 8399.014446 5386.817318 0 5730 1153.226298 2440.789235 0 5731 6275.452175 8816.375312 0 5732 1950.586489 9742.500859 0 5733 3898.950814 1698.960122 0 5734 2830.822651 6932.545838 0 5735 4175.417097 2631.696543 0 5736 6001.362843 2930.304641 0 5737 1290.140140 1695.879460 0 5738 3856.024224 4213.146367 0 5739 5815.364115 7546.643249 0 5740 4029.262015 5424.184689 0 5741 7983.931450 260.370768 0 5742 1827.336478 7770.846971 0 5743 147.871715 9209.815024 0 5744 9194.191869 2921.849010 0 5745 4947.082660 219.772538 0 5746 5007.289343 2915.238947 0 5747 5453.815283 5814.689402 0 5748 2805.620841 4408.805830 0 5749 8589.516949 7172.564734 0 5750 130.333081 4981.151292 0 5751 8535.024435 8230.364550 0 5752 9304.131030 3435.183440 0 5753 4448.458323 1550.383502 0 5754 1022.006037 1785.292910 0 5755 9095.590853 6256.603406 0 5756 1382.725157 525.416986 0 5757 8963.354782 2475.661013 0 5758 1663.307575 1832.103200 0 5759 827.761340 619.854043 0 5760 5992.353197 5994.147755 0 5761 2300.108041 7727.391808 0 5762 7696.976680 9318.930893 0 5763 54.731742 4278.332674 0 5764 5690.363387 3398.368746 0 5765 9914.393515 599.002134 0 5766 219.559467 6366.415822 0 5767 1236.796329 5735.875767 0 5768 931.890443 1999.755899 0 5769 8239.806280 5768.239610 0 5770 9052.189065 2450.192292 0 5771 2752.668918 3128.284865 0 5772 4651.590133 108.755049 0 5773 5451.888836 3684.732493 0 5774 8033.621299 5613.730419 0 5775 483.122003 4149.600032 0 5776 9166.509560 7215.260242 0 5777 5643.207584 1253.814570 0 5778 9074.914586 6212.473100 0 5779 7379.583643 7858.681851 0 5780 9182.166945 764.618674 0 5781 2358.831204 505.623821 0 5782 6159.705250 9501.394346 0 5783 3141.880216 4879.663242 0 5784 6554.656687 1242.955584 0 5785 9740.322541 5597.162310 0 5786 5554.314027 5324.375637 0 5787 300.237800 2721.740650 0 5788 255.183763 7403.446518 0 5789 3585.045494 9041.066146 0 5790 1266.236079 575.173587 0 5791 365.796378 1777.164047 0 5792 5609.138196 5792.360803 0 5793 7032.272995 4568.206505 0 5794 1847.980419 5070.346338 0 5795 2042.428228 5702.753407 0 5796 2102.834615 8822.095316 0 5797 4425.569987 7679.168994 0 5798 2038.590159 9169.234039 0 5799 51.715064 6730.037150 0 5800 9290.035873 7962.743412 0 5801 6282.998232 268.857050 0 5802 9488.795428 198.670908 0 5803 7000.721226 1256.783011 0 5804 7087.584375 2904.842624 0 5805 3635.061747 8688.690829 0 5806 573.346502 3362.117021 0 5807 4621.437562 5675.901593 0 5808 9782.022971 2376.290076 0 5809 7251.795000 3306.361609 0 5810 2713.051614 1439.713283 0 5811 989.311258 164.490226 0 5812 486.595953 7336.537325 0 5813 9388.297324 2065.222038 0 5814 1286.384551 6035.012497 0 5815 7508.882731 953.381699 0 5816 1171.651925 9365.634157 0 5817 3563.432193 1379.214269 0 5818 2767.127581 2535.886901 0 5819 6290.176960 8520.604770 0 5820 3801.705523 9929.272904 0 5821 4644.773998 1539.615020 0 5822 1745.249013 5002.633625 0 5823 5024.948205 4233.116188 0 5824 1968.297306 886.301662 0 5825 5843.655584 1376.791483 0 5826 5062.178201 8102.934455 0 5827 912.493630 8920.402125 0 5828 250.565868 3109.862841 0 5829 2418.552427 9470.678561 0 5830 8533.632367 6814.587257 0 5831 7430.711953 8942.620724 0 5832 3738.008949 5221.220706 0 5833 2344.718541 4360.957931 0 5834 4925.042095 6892.174833 0 5835 5735.470951 6657.376490 0 5836 6412.971365 1087.983267 0 5837 526.676171 178.475407 0 5838 2160.550578 8357.915420 0 5839 533.557449 6910.311466 0 5840 487.325624 5599.596850 0 5841 9126.952123 8559.330944 0 5842 2573.612610 8431.062559 0 5843 3331.191041 2217.520732 0 5844 61.869771 5674.021287 0 5845 2571.341354 8567.633621 0 5846 3326.149462 4144.573609 0 5847 2512.685802 318.782933 0 5848 177.196247 3405.752814 0 5849 6264.326605 1838.341701 0 5850 2437.481291 634.423355 0 5851 2557.084965 7008.050979 0 5852 1123.966016 4970.471954 0 5853 5517.872407 5889.400886 0 5854 6550.720431 2199.947599 0 5855 7372.577721 6686.845115 0 5856 7547.373486 6660.496735 0 5857 6485.764618 6227.851115 0 5858 7226.740942 1595.609792 0 5859 6071.350805 8049.812812 0 5860 6474.031923 9055.748922 0 5861 9024.250789 8266.097404 0 5862 5201.896613 8058.838949 0 5863 9715.727568 8651.392693 0 5864 2301.675890 5686.926602 0 5865 2054.081246 4824.465202 0 5866 9869.464179 9844.564678 0 5867 6175.227505 7851.381930 0 5868 2501.866313 5832.231845 0 5869 5261.750745 6455.434543 0 5870 4003.830208 8780.535681 0 5871 1443.904238 3378.741228 0 5872 2466.830915 2079.375712 0 5873 9556.120988 4368.217449 0 5874 9368.256081 1794.289136 0 5875 802.947989 537.055755 0 5876 723.416991 931.369431 0 5877 9952.111498 5549.749442 0 5878 6982.854323 997.101989 0 5879 5570.289118 5192.827976 0 5880 6353.888504 4217.405965 0 5881 3035.794442 9448.988340 0 5882 8023.122111 410.811484 0 5883 3249.437445 3279.166487 0 5884 3306.624066 4014.028922 0 5885 811.446076 1748.792928 0 5886 1638.348695 5545.612768 0 5887 6787.078355 356.501846 0 5888 3161.044125 9493.565292 0 5889 7310.018293 7170.850599 0 5890 5449.849715 85.909843 0 5891 6437.013569 1266.260064 0 5892 5499.258917 963.542071 0 5893 4883.100258 6638.877419 0 5894 2863.150538 7472.577727 0 5895 9522.018950 3805.317732 0 5896 260.906993 6042.391364 0 5897 2354.371909 2739.407042 0 5898 5280.940818 2544.683053 0 5899 8710.909967 2865.635225 0 5900 1146.521659 6470.337690 0 5901 1205.576841 7430.837133 0 5902 6897.662084 1674.011085 0 5903 2740.664338 3164.108303 0 5904 8951.746558 9711.437786 0 5905 7656.115283 2457.246077 0 5906 9752.308360 2808.526435 0 5907 1932.209886 4774.113076 0 5908 406.102039 8965.622916 0 5909 1894.229122 7224.174418 0 5910 1099.388851 2927.046157 0 5911 9945.409381 5593.764580 0 5912 7644.144980 3142.863889 0 5913 948.442744 4922.072978 0 5914 6068.764243 3303.070471 0 5915 2420.510949 8418.737401 0 5916 7434.241864 2359.987720 0 5917 4877.289813 4815.124851 0 5918 7652.042458 5195.636358 0 5919 5924.511938 6294.250587 0 5920 2382.894269 562.651282 0 5921 6797.697665 3356.488326 0 5922 8106.279509 9342.396003 0 5923 6897.261430 8584.077776 0 5924 538.888721 8426.204297 0 5925 7784.882861 7699.073386 0 5926 3313.507952 156.462993 0 5927 4946.797540 5344.192873 0 5928 9042.177849 4252.274409 0 5929 5040.843749 2951.811906 0 5930 8654.092901 168.786874 0 5931 5543.911016 6040.658237 0 5932 8988.692613 9986.569027 0 5933 2722.161252 252.687783 0 5934 8539.967255 427.950983 0 5935 3291.772010 8940.730367 0 5936 6268.644352 4927.917839 0 5937 6662.021639 4097.773356 0 5938 2591.312947 284.482088 0 5939 7797.246118 4845.727216 0 5940 2806.501161 4348.152841 0 5941 4951.643310 4061.167941 0 5942 5018.124796 5433.310585 0 5943 3118.157828 4742.724624 0 5944 3572.706727 9131.751179 0 5945 1748.440105 6567.432848 0 5946 3492.539318 9379.145805 0 5947 1174.106417 262.880798 0 5948 1514.102694 5353.370140 0 5949 9477.985275 9982.419130 0 5950 7297.345124 3881.286883 0 5951 6260.514294 4482.323266 0 5952 264.551091 5057.383381 0 5953 1215.232523 6275.586145 0 5954 235.368742 7338.747426 0 5955 5322.743682 3062.298397 0 5956 4171.803598 493.215322 0 5957 7102.777906 8088.259410 0 5958 2776.426292 7688.640542 0 5959 8412.679646 3361.000955 0 5960 6014.977310 9358.201090 0 5961 8778.053669 2266.291274 0 5962 5709.179718 128.791773 0 5963 9674.480226 7888.808884 0 5964 5579.789307 5427.014913 0 5965 6548.641820 7344.900587 0 5966 5497.662235 7845.380784 0 5967 7154.244449 5552.583302 0 5968 6715.038046 9152.073024 0 5969 8212.575315 2169.034791 0 5970 3991.663800 8249.318798 0 5971 7809.930401 7071.863637 0 5972 2285.138176 8802.785055 0 5973 9884.179888 5057.218354 0 5974 2255.587263 2424.972111 0 5975 8327.997203 7271.600253 0 5976 1214.327510 5486.911309 0 5977 5954.758517 5147.683111 0 5978 5355.904942 6285.462043 0 5979 4913.286889 2894.237744 0 5980 6824.495096 7999.206100 0 5981 3472.136566 6902.205539 0 5982 7549.489263 9536.320252 0 5983 4622.587139 3312.472635 0 5984 9141.628705 7335.048168 0 5985 9330.361420 1447.507761 0 5986 5957.548447 3037.401542 0 5987 1710.172139 7368.949339 0 5988 1999.761626 4195.362466 0 5989 3282.946924 7765.631744 0 5990 1515.500831 6117.314103 0 5991 132.800605 5982.630458 0 5992 288.791932 73.372527 0 5993 5434.791255 7694.419757 0 5994 2383.989501 8390.362079 0 5995 933.778940 280.830891 0 5996 1648.308369 3693.124709 0 5997 5122.948103 2876.434062 0 5998 6735.369880 4231.308521 0 5999 106.229836 7919.098573 0 6000 895.120126 3178.455194 0 6001 1536.548689 7637.853466 0 6002 8201.913572 8018.726911 0 6003 9673.103625 1224.358598 0 6004 9189.210585 6907.623128 0 6005 1204.215289 9772.028440 0 6006 1132.306691 1053.268225 0 6007 6718.679744 2418.955424 0 6008 1115.084744 9297.373603 0 6009 8837.739534 1907.066594 0 6010 3116.981154 6185.569078 0 6011 5646.129300 8703.793995 0 6012 5777.593417 6170.353188 0 6013 9259.693121 1866.823077 0 6014 158.051304 3316.415153 0 6015 9259.773311 6661.595568 0 6016 4621.136140 657.309031 0 6017 4565.491256 343.010018 0 6018 1941.912999 2120.346184 0 6019 4765.745382 7781.020489 0 6020 1145.395405 7096.037824 0 6021 5096.392782 6846.167811 0 6022 122.915738 9414.324925 0 6023 925.291851 3961.704376 0 6024 1407.454414 6804.175072 0 6025 2925.421438 2455.305609 0 6026 1194.236005 8172.111677 0 6027 2067.562258 2600.127353 0 6028 7997.016670 3906.347351 0 6029 6941.576701 7839.244135 0 6030 8749.501324 5342.832746 0 6031 2238.049367 8177.919507 0 6032 5896.241263 5575.311168 0 6033 1550.246276 6226.735922 0 6034 5987.663154 3589.744894 0 6035 7416.174013 4514.524330 0 6036 2323.076976 6832.721735 0 6037 9084.587693 8221.502059 0 6038 3374.822764 7698.123798 0 6039 7982.427028 145.428831 0 6040 1510.767245 3772.922355 0 6041 6946.711724 3623.512422 0 6042 2838.340706 5464.722588 0 6043 1055.573370 8513.853522 0 6044 9484.028396 7454.381673 0 6045 5364.354009 6076.215554 0 6046 7494.528447 7576.717538 0 6047 4186.529916 1349.925825 0 6048 2459.083476 207.730874 0 6049 5314.819178 7751.328620 0 6050 1318.677287 7182.469190 0 6051 4327.209535 5171.831963 0 6052 2715.310913 478.959431 0 6053 9282.459290 8734.429072 0 6054 4744.040853 500.223114 0 6055 5651.579472 4015.794109 0 6056 5365.459913 4269.014084 0 6057 534.019024 8690.956375 0 6058 771.093866 2016.456348 0 6059 7404.138530 5710.865073 0 6060 6915.365259 2778.145294 0 6061 4523.667003 6609.136622 0 6062 6698.538495 8160.503901 0 6063 8823.125015 9191.907621 0 6064 7925.172947 3388.560132 0 6065 2734.397861 8935.670432 0 6066 913.604650 3969.359322 0 6067 5075.744580 4757.764523 0 6068 5708.491444 9247.124537 0 6069 743.839329 1220.241089 0 6070 2617.370595 9865.141497 0 6071 6008.093972 7823.749081 0 6072 7767.842295 5550.906611 0 6073 8204.929784 5708.804925 0 6074 5508.319831 426.078299 0 6075 3287.332216 5163.517943 0 6076 1750.560327 582.804388 0 6077 9828.488993 2293.772622 0 6078 5429.515369 5452.912058 0 6079 8008.914705 9910.147300 0 6080 4864.026197 999.785614 0 6081 986.631090 1997.690756 0 6082 899.281434 1207.727763 0 6083 8946.675023 9811.684837 0 6084 1460.706210 4706.439919 0 6085 7511.121637 8054.704029 0 6086 1326.334839 6050.561853 0 6087 2603.408062 9781.490649 0 6088 6878.635182 1898.912700 0 6089 7390.908604 416.131439 0 6090 384.100326 2791.187465 0 6091 7273.939511 9953.140187 0 6092 4545.916655 6229.244709 0 6093 8276.577321 7353.071748 0 6094 2139.929490 8347.389066 0 6095 6009.830023 725.975333 0 6096 5851.945570 2322.428199 0 6097 4257.499300 2068.297140 0 6098 1483.136725 2745.812115 0 6099 1069.289669 1439.744112 0 6100 9715.589559 8615.049787 0 6101 9993.493096 6925.132487 0 6102 5493.246348 1122.874838 0 6103 7921.480296 2062.933663 0 6104 3631.688012 1865.727990 0 6105 3985.391623 2571.913150 0 6106 6195.279563 1489.307362 0 6107 8620.544252 9424.643795 0 6108 6750.429721 2601.599654 0 6109 3211.658211 5992.227999 0 6110 8824.188275 7184.674660 0 6111 6135.473714 8578.986724 0 6112 7923.286935 7008.677353 0 6113 1876.080634 4985.769137 0 6114 8438.719463 3930.754400 0 6115 653.655445 893.841096 0 6116 7016.527340 7245.576968 0 6117 2351.263694 2381.097556 0 6118 8318.042995 7950.341542 0 6119 1897.275727 4623.717284 0 6120 1898.024232 2287.352655 0 6121 8501.781835 125.939167 0 6122 9669.894903 1637.552012 0 6123 5586.978000 4303.859477 0 6124 3615.340771 9495.451889 0 6125 6670.774297 4097.442061 0 6126 8140.604746 3236.655207 0 6127 3359.100276 8559.508243 0 6128 4248.559875 3590.879440 0 6129 4314.142294 3405.363420 0 6130 8614.696687 5076.828790 0 6131 5416.020164 6160.098964 0 6132 5426.256356 4208.019051 0 6133 820.853206 1231.478252 0 6134 763.954465 2757.907897 0 6135 4541.625722 1371.896139 0 6136 9601.389394 5694.681539 0 6137 4765.671626 3049.536097 0 6138 5479.097878 7252.373976 0 6139 943.587728 6620.167144 0 6140 9884.819023 1926.708390 0 6141 2425.990010 3232.612728 0 6142 6345.488004 6599.425210 0 6143 9778.636933 9043.412943 0 6144 5682.099141 8076.123528 0 6145 5307.945521 6431.116603 0 6146 5464.804355 4706.465182 0 6147 1300.296472 8276.741163 0 6148 1084.330483 4110.518967 0 6149 1035.708939 7800.427991 0 6150 8915.358889 3247.389939 0 6151 8337.389048 2868.767560 0 6152 9097.304250 6916.983909 0 6153 8589.851933 161.850738 0 6154 7324.819607 324.111822 0 6155 3704.295406 2428.719452 0 6156 1537.500090 4681.000000 0 6157 7425.472811 7702.337918 0 6158 9681.624830 2758.818479 0 6159 527.682602 250.704277 0 6160 2978.685390 1377.660620 0 6161 9898.163673 783.859565 0 6162 4311.572809 9765.880969 0 6163 8397.512467 3283.441693 0 6164 2022.955808 2650.104544 0 6165 6416.996484 2801.011386 0 6166 7500.837308 6377.513120 0 6167 1758.456520 5865.169819 0 6168 1662.874091 8171.456954 0 6169 2656.786570 3250.311596 0 6170 4006.043369 3063.803180 0 6171 1064.244311 4683.476626 0 6172 1314.342056 4696.226701 0 6173 5334.033138 8789.690975 0 6174 6439.884699 662.643512 0 6175 609.584176 8909.311868 0 6176 3184.418378 6247.757392 0 6177 9677.566441 1835.890986 0 6178 9384.869075 7260.166454 0 6179 3276.571027 6765.947159 0 6180 4516.264219 3443.460322 0 6181 2905.003362 9618.036438 0 6182 9643.506976 2927.190893 0 6183 1530.016723 5295.782283 0 6184 7299.404486 83.617977 0 6185 1596.602685 4499.415029 0 6186 1685.685265 5955.025402 0 6187 7191.780122 7320.016491 0 6188 9201.469556 9568.009292 0 6189 6210.569082 4032.189773 0 6190 5654.177350 9104.787847 0 6191 6420.919011 9264.478360 0 6192 7001.142941 7578.008342 0 6193 4593.491657 8447.917727 0 6194 7997.985093 8792.060957 0 6195 6814.104430 626.109579 0 6196 5722.964667 3322.431006 0 6197 2101.145496 1158.892439 0 6198 7483.499680 9.413224 0 6199 4934.535191 720.490153 0 6200 4280.440793 9520.971459 0 6201 6185.854866 5149.921106 0 6202 1734.412119 3565.872759 0 6203 9048.982738 8852.984205 0 6204 6861.281068 3435.504566 0 6205 8935.816814 8867.812437 0 6206 7891.117394 7242.775801 0 6207 7477.531353 2706.230443 0 6208 8497.151308 1589.241348 0 6209 2954.357788 4399.982580 0 6210 249.313192 9330.008726 0 6211 4092.453768 5916.432519 0 6212 6212.245166 9325.123231 0 6213 2200.299451 7277.516120 0 6214 5080.144744 9429.249337 0 6215 714.667408 933.555077 0 6216 3260.491827 9577.970592 0 6217 3458.519994 1341.456623 0 6218 2660.605729 3353.366176 0 6219 3233.442216 1354.486410 0 6220 783.858731 3127.163284 0 6221 3087.958249 6706.257320 0 6222 5253.731136 4867.768663 0 6223 3605.384943 5802.730553 0 6224 8704.027218 8150.268069 0 6225 3992.544067 9730.462253 0 6226 9570.476976 6996.785191 0 6227 1032.549637 8976.017471 0 6228 6960.698136 2938.293090 0 6229 7713.475510 178.370002 0 6230 7788.635858 3630.532676 0 6231 3289.577849 5575.154698 0 6232 9046.305443 5083.861886 0 6233 2262.225508 4574.222802 0 6234 3680.634780 7884.290636 0 6235 258.202186 1150.601734 0 6236 9331.973819 5611.881451 0 6237 9956.979992 6273.466758 0 6238 911.807671 9114.811681 0 6239 2285.623476 7286.300108 0 6240 3955.891667 8672.927359 0 6241 8336.101907 5779.983503 0 6242 8101.744417 7541.226323 0 6243 6456.082105 9862.116342 0 6244 7090.059691 8593.801039 0 6245 7822.009681 8295.352954 0 6246 8646.194102 9711.233050 0 6247 6465.805030 3196.287415 0 6248 428.508160 2566.677114 0 6249 7981.747492 7721.698543 0 6250 1489.573984 2688.950254 0 6251 1458.407035 5338.196899 0 6252 476.303535 1800.218439 0 6253 2763.024322 9878.551136 0 6254 1272.368949 7585.185226 0 6255 8022.842661 130.215529 0 6256 7546.546269 5800.205468 0 6257 828.062822 5706.791744 0 6258 5882.788090 7919.201227 0 6259 5365.413169 3686.446093 0 6260 9846.459416 7228.444653 0 6261 1907.147543 8257.570898 0 6262 9997.372818 8114.739628 0 6263 4625.478501 3735.728382 0 6264 9090.214025 9155.255838 0 6265 8808.218747 6701.113652 0 6266 4706.736957 4336.135680 0 6267 8461.159017 4930.284753 0 6268 4455.686651 8093.253866 0 6269 8237.185140 4035.844578 0 6270 9506.500558 1392.654320 0 6271 3913.125670 4302.084150 0 6272 3891.266456 354.092482 0 6273 7585.932458 8053.633965 0 6274 2041.885485 5951.766469 0 6275 3023.241339 9311.840804 0 6276 3393.533448 8303.107634 0 6277 9795.625750 1470.013333 0 6278 9703.413417 5638.267143 0 6279 4215.657641 667.609230 0 6280 1847.693377 4450.691735 0 6281 7108.513692 356.978070 0 6282 9746.477628 114.634966 0 6283 613.814502 101.834934 0 6284 3699.844931 2517.984370 0 6285 9094.759804 7872.506176 0 6286 8256.130052 1012.375897 0 6287 9342.707043 3231.898978 0 6288 6685.881941 4400.557290 0 6289 3290.330859 1441.677808 0 6290 9967.617665 5903.589242 0 6291 3045.969953 7747.710277 0 6292 7695.771098 2696.520866 0 6293 2620.728152 7315.631809 0 6294 3283.590542 4608.473687 0 6295 906.769009 4522.158066 0 6296 5546.148891 9108.572496 0 6297 2089.891519 9358.698731 0 6298 3400.040268 455.529977 0 6299 9093.457034 5861.666632 0 6300 323.921493 679.014698 0 6301 8820.928755 1992.884070 0 6302 7907.169618 1265.675256 0 6303 804.441319 602.219991 0 6304 5728.662056 4731.077255 0 6305 5376.341872 4167.746297 0 6306 4633.496239 4427.765018 0 6307 3988.827484 9942.977610 0 6308 6865.750629 6274.583378 0 6309 8720.487913 3279.919985 0 6310 3029.014393 4401.413910 0 6311 543.229646 8549.511869 0 6312 9504.817991 3649.302246 0 6313 4757.627657 2282.759022 0 6314 6134.085031 2128.802368 0 6315 9357.128746 2982.545739 0 6316 398.320134 7849.132947 0 6317 3349.107796 4912.738644 0 6318 5202.937213 1632.860052 0 6319 9255.131617 2290.800346 0 6320 5379.794169 3976.559541 0 6321 9772.096886 2621.504885 0 6322 3541.858830 1877.962814 0 6323 7099.813411 8441.671396 0 6324 817.582771 5743.625030 0 6325 8273.306784 7462.449147 0 6326 6151.300009 1301.352617 0 6327 1305.962168 7838.437498 0 6328 3897.025997 4292.784223 0 6329 9644.726612 9223.310891 0 6330 605.375316 4846.678302 0 6331 1350.960981 6816.961698 0 6332 4196.915932 9951.128702 0 6333 6021.830147 5706.839013 0 6334 8895.792857 3246.591963 0 6335 2497.598642 7638.154615 0 6336 8172.860535 6720.155857 0 6337 377.616811 8761.189855 0 6338 7143.972128 3075.254814 0 6339 9340.592872 944.854233 0 6340 220.477657 7963.494817 0 6341 8361.197416 2596.266444 0 6342 8883.419849 5220.927790 0 6343 6686.896784 2519.844256 0 6344 722.860083 2255.615316 0 6345 2646.918861 6478.987396 0 6346 9886.956438 5259.166811 0 6347 3921.421068 5253.485377 0 6348 1022.167452 7139.880661 0 6349 6579.647297 6409.040036 0 6350 6440.026206 1346.931536 0 6351 9161.075194 4419.054692 0 6352 3396.440157 3495.669938 0 6353 3192.497794 8935.838298 0 6354 770.062750 5609.912082 0 6355 2585.993516 1014.152009 0 6356 5302.082217 5584.404720 0 6357 3495.816911 3629.804878 0 6358 9190.863429 5484.311855 0 6359 8021.600411 6942.639212 0 6360 6658.458698 9367.944959 0 6361 7446.949738 4554.987064 0 6362 4674.910148 7892.127819 0 6363 8460.219465 7948.521721 0 6364 7650.002974 3322.475022 0 6365 6075.941013 607.749511 0 6366 1845.463151 1414.347106 0 6367 9724.763172 602.580201 0 6368 6893.023807 8295.271722 0 6369 5887.381168 2166.658787 0 6370 6499.169114 7568.403780 0 6371 3058.182695 2976.452160 0 6372 9172.465365 4898.712747 0 6373 2822.273696 1728.595115 0 6374 1007.782739 2613.097885 0 6375 337.393070 2568.082852 0 6376 7406.736729 1481.531612 0 6377 9373.885547 290.388596 0 6378 7344.030304 9825.265917 0 6379 351.425089 1072.481948 0 6380 4411.533577 428.596214 0 6381 7507.021299 2669.845648 0 6382 3872.878779 1626.044852 0 6383 7428.939967 8019.791534 0 6384 2760.417616 5625.011568 0 6385 741.078739 9990.459297 0 6386 8239.321051 8013.581801 0 6387 8426.240122 2602.065490 0 6388 4853.223314 6384.012138 0 6389 1155.010152 4051.545574 0 6390 3244.183627 7117.782965 0 6391 3894.497097 8093.968582 0 6392 6337.317405 406.162512 0 6393 4704.662427 5189.254825 0 6394 616.333790 588.655379 0 6395 8027.325194 2624.477825 0 6396 8349.342189 2878.471131 0 6397 9036.028789 7507.458731 0 6398 7772.913285 9124.388810 0 6399 5249.730044 7695.577294 0 6400 221.949138 6490.115504 0 6401 6222.632522 6331.228650 0 6402 308.410210 3961.945455 0 6403 5441.652298 1576.179312 0 6404 2109.416110 8941.906619 0 6405 839.893045 7087.527697 0 6406 2333.396777 3652.676439 0 6407 2925.793804 8409.419571 0 6408 8981.585717 5024.611269 0 6409 342.753788 1792.164175 0 6410 8510.912813 7479.789197 0 6411 6021.667120 5042.602283 0 6412 3598.690340 4998.903995 0 6413 4888.511754 5022.700477 0 6414 650.341039 6646.465909 0 6415 2630.346501 1568.675039 0 6416 1715.152509 2377.220132 0 6417 6192.212704 9959.190244 0 6418 4040.761704 1220.960744 0 6419 3732.325806 6402.436357 0 6420 1735.570903 5912.839735 0 6421 3551.108720 3729.975224 0 6422 7104.389790 9705.561784 0 6423 7901.867961 1894.298571 0 6424 9486.828867 3080.828913 0 6425 8167.151560 1778.146116 0 6426 7836.088474 8871.972104 0 6427 114.196854 2080.323439 0 6428 9168.860396 816.769056 0 6429 4599.273538 9562.964180 0 6430 6442.774591 1063.209070 0 6431 6524.326733 5635.309844 0 6432 4277.002407 7272.719755 0 6433 6552.201669 1948.128609 0 6434 7193.152635 5533.988162 0 6435 2096.325309 6138.081444 0 6436 4537.387301 3773.514839 0 6437 3551.306418 6629.894507 0 6438 7714.856239 3829.550824 0 6439 1884.716193 9863.655700 0 6440 8731.176411 3144.460178 0 6441 1001.173803 6354.058337 0 6442 8376.720269 1741.949623 0 6443 6785.325754 3651.775792 0 6444 372.582794 6735.114573 0 6445 4269.092359 7932.573029 0 6446 2371.153789 1777.144948 0 6447 3466.425781 7578.560900 0 6448 8793.010689 5736.381380 0 6449 6125.861822 1792.447679 0 6450 1615.562532 247.858779 0 6451 2301.348882 7776.400357 0 6452 8644.404601 1980.525809 0 6453 1343.610685 3949.904994 0 6454 8093.015851 5793.602177 0 6455 7821.233461 703.672581 0 6456 2558.714247 243.046593 0 6457 4682.537786 9788.381364 0 6458 4456.014485 948.789502 0 6459 691.807983 8622.917399 0 6460 785.596225 9931.023647 0 6461 1090.008023 2289.736349 0 6462 4537.669468 715.093422 0 6463 7612.252925 7484.371968 0 6464 2784.130943 1572.797532 0 6465 9448.566539 6910.156159 0 6466 3884.149420 52.575273 0 6467 2146.560964 4871.289788 0 6468 5252.660697 2805.084860 0 6469 9373.190604 1968.584217 0 6470 1503.919057 6315.426833 0 6471 3117.653824 9132.575059 0 6472 8513.375255 4651.947287 0 6473 4893.377736 2998.651295 0 6474 5252.296149 3594.684436 0 6475 9830.234250 5323.891529 0 6476 1196.872237 4583.797263 0 6477 4178.182178 5042.724729 0 6478 2911.737730 5226.494020 0 6479 6498.441639 8230.357468 0 6480 3057.419300 6999.373310 0 6481 3393.403478 7953.540329 0 6482 1903.831421 5730.473173 0 6483 2245.494104 9196.364967 0 6484 4194.754506 5622.240850 0 6485 431.126214 6845.726733 0 6486 5242.903830 2213.356820 0 6487 4207.057877 1980.492180 0 6488 3789.776055 5836.166415 0 6489 1257.061351 5048.809339 0 6490 8092.335835 2022.259331 0 6491 8448.856884 4182.904420 0 6492 6705.667487 4363.154151 0 6493 9002.692417 7640.341228 0 6494 7865.566988 8047.949714 0 6495 3183.291077 3261.195944 0 6496 8226.431139 4763.864643 0 6497 3917.613299 2838.462636 0 6498 2460.028751 6618.964037 0 6499 7002.173208 6037.415907 0 6500 1580.627577 6016.132298 0 6501 6112.480340 8921.086085 0 6502 1812.269769 8706.988822 0 6503 3262.641322 5387.285154 0 6504 3841.801689 5889.767258 0 6505 4590.270323 262.322052 0 6506 889.533912 8053.461719 0 6507 6527.139605 2741.998076 0 6508 7333.873502 8667.789216 0 6509 8903.390875 9168.907226 0 6510 5544.935277 5049.311120 0 6511 2964.088360 7230.271191 0 6512 4352.040073 5980.036553 0 6513 6191.344948 4578.424522 0 6514 9233.361774 364.457460 0 6515 1224.340268 6884.008337 0 6516 3621.924544 2760.756432 0 6517 6346.702606 3228.690416 0 6518 4652.033968 1527.056775 0 6519 9708.847552 1999.377440 0 6520 5417.491511 4617.589852 0 6521 7833.343091 2493.625668 0 6522 5376.175703 4311.228475 0 6523 2251.396193 4568.527795 0 6524 2379.169734 3366.212966 0 6525 2764.426382 5268.252643 0 6526 6705.862815 7437.753511 0 6527 7601.139025 1824.172592 0 6528 9968.774830 9253.101394 0 6529 579.822006 3560.639430 0 6530 7529.612834 4063.652902 0 6531 6857.214532 2801.180570 0 6532 8929.833302 8182.998024 0 6533 4704.235997 4378.816075 0 6534 8636.342407 1926.692598 0 6535 5590.373913 5663.818012 0 6536 6416.089135 1604.830371 0 6537 2105.034603 2788.394922 0 6538 4372.535523 5805.436811 0 6539 4726.462099 7596.959441 0 6540 9751.141128 6721.664486 0 6541 5535.716646 4064.950219 0 6542 6156.193329 3943.937425 0 6543 7177.743615 2636.227571 0 6544 3330.183117 6582.068600 0 6545 5798.445335 6406.778205 0 6546 8817.017645 8618.553783 0 6547 8250.668044 3441.306527 0 6548 5548.302571 4142.799219 0 6549 6210.859257 4004.302329 0 6550 7707.373290 7052.029159 0 6551 7093.417141 9273.237743 0 6552 7289.207470 5252.841165 0 6553 3111.418504 653.758457 0 6554 4953.122289 7191.284172 0 6555 9948.383135 176.753215 0 6556 5326.450162 9411.279480 0 6557 1059.343081 4012.253903 0 6558 6024.944129 7007.873765 0 6559 3699.271572 4019.588106 0 6560 5083.714578 427.525566 0 6561 3622.363219 1857.970486 0 6562 6690.086792 6630.877255 0 6563 2698.155624 50.035111 0 6564 7987.138798 322.645785 0 6565 9763.634757 36.390056 0 6566 8726.872833 5279.534181 0 6567 1977.476751 2452.220642 0 6568 9476.498504 1117.428398 0 6569 3675.271228 5288.455937 0 6570 3473.326208 2857.452531 0 6571 3810.850978 4644.786312 0 6572 3179.267848 1276.472963 0 6573 7135.816591 8780.468283 0 6574 9172.448704 6630.323613 0 6575 6264.859864 7186.443231 0 6576 32.778112 3030.546650 0 6577 6352.170006 7886.958529 0 6578 1854.696714 1223.831272 0 6579 6041.928954 5242.068704 0 6580 5378.276916 4806.665428 0 6581 8353.513854 1116.765332 0 6582 2369.168582 5902.860733 0 6583 8260.795728 5730.033148 0 6584 3853.537488 3478.699853 0 6585 3521.970179 2122.574266 0 6586 9366.560618 7758.221754 0 6587 8864.720678 3521.762725 0 6588 4041.155761 2115.283071 0 6589 215.606453 4683.801744 0 6590 6356.929039 9510.557612 0 6591 9746.568341 2459.845044 0 6592 7703.514791 1721.507613 0 6593 1596.847711 5685.325798 0 6594 8766.992674 3372.910761 0 6595 5964.549174 6952.097955 0 6596 3112.784244 459.827144 0 6597 5795.829977 6306.471478 0 6598 5739.983622 7196.884345 0 6599 5115.296373 1486.347349 0 6600 5559.280662 2013.851438 0 6601 6886.656499 6110.301682 0 6602 4104.444920 8790.086535 0 6603 3138.054506 9941.434807 0 6604 5884.897589 9052.034241 0 6605 5474.522104 5987.597572 0 6606 7679.399060 3167.282124 0 6607 9320.899035 9857.223927 0 6608 1742.035059 944.977433 0 6609 9658.568611 2368.767694 0 6610 133.933775 6094.267921 0 6611 7223.635518 7514.994142 0 6612 7826.227679 740.540967 0 6613 4851.167275 3065.163805 0 6614 8631.154648 6496.116301 0 6615 4658.610474 4113.372166 0 6616 3558.253917 3419.241168 0 6617 6256.812068 5255.096371 0 6618 5061.854157 4456.143142 0 6619 447.872064 110.168169 0 6620 9620.962428 7847.884273 0 6621 8421.865448 683.830334 0 6622 2661.974638 2815.469961 0 6623 2803.607769 4914.097636 0 6624 8518.446235 4431.094332 0 6625 8077.443045 5686.745222 0 6626 3535.267302 1577.620983 0 6627 760.837172 5059.242358 0 6628 7608.861906 8651.441061 0 6629 4803.066929 6432.797392 0 6630 2365.020709 694.256643 0 6631 3559.591379 9152.792117 0 6632 8760.902820 5630.668118 0 6633 6511.098572 8735.150373 0 6634 6869.000525 767.157499 0 6635 9532.984410 6066.018636 0 6636 3794.641237 144.607663 0 6637 3247.445760 6976.556625 0 6638 606.032605 7330.154982 0 6639 936.511285 3961.682442 0 6640 5187.039881 433.023226 0 6641 789.959326 8553.784106 0 6642 9621.260062 1597.263000 0 6643 8184.258289 6076.306817 0 6644 9300.286057 9717.944265 0 6645 5267.435879 8957.415902 0 6646 1661.084955 6480.114459 0 6647 9303.474054 2124.403588 0 6648 9875.853367 6699.061940 0 6649 1689.152262 3502.307850 0 6650 423.630220 7470.982442 0 6651 4016.014238 8688.058461 0 6652 6894.057272 988.997751 0 6653 3753.912218 5791.375155 0 6654 8242.405394 1079.749246 0 6655 5273.993135 5308.912431 0 6656 6899.840815 802.743312 0 6657 2302.505406 7350.553543 0 6658 7214.116772 5131.909893 0 6659 461.656518 185.377235 0 6660 3789.302604 2154.078770 0 6661 6827.553171 9011.203658 0 6662 6260.151854 6269.147961 0 6663 3231.086380 3041.815809 0 6664 8681.512925 160.385600 0 6665 2297.441705 5148.796223 0 6666 9870.278420 615.770097 0 6667 1074.597637 2782.810653 0 6668 4668.163857 223.621321 0 6669 2554.180677 5911.054785 0 6670 5021.003807 3405.041701 0 6671 6174.433595 1325.730675 0 6672 1506.929151 2795.772501 0 6673 9506.544183 4205.782257 0 6674 3161.006875 7426.622172 0 6675 8424.766762 1527.371016 0 6676 9097.368632 8147.211636 0 6677 3708.817103 1971.541697 0 6678 4934.713944 8372.680766 0 6679 2085.757381 1692.478160 0 6680 7967.951654 6022.492031 0 6681 7284.226906 4940.638734 0 6682 3100.267134 9630.737021 0 6683 2391.867483 6667.752186 0 6684 3198.601993 133.107546 0 6685 5224.235662 7139.661142 0 6686 8227.786539 5138.184361 0 6687 103.586818 3270.226454 0 6688 5785.331504 5878.502276 0 6689 9254.921015 9585.284658 0 6690 7132.015884 1661.020405 0 6691 7419.130031 1246.142506 0 6692 3340.444605 736.320263 0 6693 8121.408837 5153.470193 0 6694 7174.500376 364.751424 0 6695 1761.303400 2043.974313 0 6696 4918.154937 1586.971479 0 6697 1000.969270 5619.837164 0 6698 1085.694274 9607.338460 0 6699 7771.156027 9926.065675 0 6700 7656.879322 2983.045445 0 6701 8119.470746 2010.013805 0 6702 1231.299723 3172.435395 0 6703 7012.603329 1189.534580 0 6704 8905.301050 676.102129 0 6705 7750.571426 6898.578343 0 6706 5137.486353 7630.479035 0 6707 5478.315657 6939.510498 0 6708 1497.380598 2945.598722 0 6709 5420.453798 6325.856269 0 6710 5884.829700 7310.167770 0 6711 6940.986591 3196.501487 0 6712 9442.253071 9499.574995 0 6713 2964.897044 4591.819454 0 6714 3870.269587 832.377236 0 6715 5491.766466 8138.470062 0 6716 2349.051018 5306.544728 0 6717 6009.378574 1123.465381 0 6718 4181.715575 1037.286436 0 6719 3517.994320 6092.542587 0 6720 6563.148087 9929.795802 0 6721 6971.067304 9004.383835 0 6722 7172.713036 8525.251477 0 6723 4530.482428 2110.287719 0 6724 4941.096727 8079.700060 0 6725 4644.216327 351.501732 0 6726 9803.595783 185.564294 0 6727 2802.357728 5112.103013 0 6728 6172.549157 4231.829074 0 6729 9649.234659 9409.070246 0 6730 2958.556807 2224.427641 0 6731 3663.405619 3523.771819 0 6732 4648.132955 2479.221635 0 6733 1719.369473 2926.458275 0 6734 4571.386228 1516.359068 0 6735 6878.580715 7605.830812 0 6736 2768.901948 1524.385570 0 6737 5743.134453 2773.805049 0 6738 3402.647469 4510.364825 0 6739 4507.969077 8345.491011 0 6740 1036.750994 3355.526777 0 6741 82.978650 9855.911212 0 6742 9638.747330 4742.290328 0 6743 531.868833 4005.628446 0 6744 144.872967 536.898380 0 6745 928.478071 2861.751716 0 6746 501.655401 3181.586168 0 6747 8563.162005 9392.608071 0 6748 544.340591 7150.025168 0 6749 2395.329304 3891.840720 0 6750 9245.961991 3604.701572 0 6751 5512.325599 6907.331923 0 6752 7785.917649 5318.595755 0 6753 532.668365 2686.048649 0 6754 6680.291970 3539.894927 0 6755 5263.908287 7062.112361 0 6756 4567.460484 2350.626539 0 6757 7369.923163 4205.935815 0 6758 7396.299227 3998.248492 0 6759 2780.354628 8452.006826 0 6760 8099.425554 4569.756973 0 6761 3717.430952 4504.773286 0 6762 5956.875804 2363.322370 0 6763 6245.249438 4367.858936 0 6764 4565.559653 4013.637249 0 6765 2421.712390 81.600269 0 6766 3139.889555 9583.758502 0 6767 6471.701735 1534.805296 0 6768 6542.422388 4194.804155 0 6769 1887.297784 4433.064945 0 6770 8631.250316 9624.286250 0 6771 4782.703001 7016.360258 0 6772 7557.492968 6535.589364 0 6773 2080.411688 356.527068 0 6774 8356.718731 3009.572083 0 6775 1283.127794 6624.086639 0 6776 5285.517287 5529.838762 0 6777 5107.259181 2167.223094 0 6778 5932.215490 243.480588 0 6779 4790.779340 13.860537 0 6780 5583.405420 2348.042636 0 6781 8166.014172 9011.748560 0 6782 364.034443 6601.414805 0 6783 9162.822547 6824.286398 0 6784 648.769910 6419.616594 0 6785 651.887828 1526.498357 0 6786 6512.246174 6816.117679 0 6787 324.512229 5802.752110 0 6788 8778.191647 6303.221472 0 6789 6434.091023 2187.293155 0 6790 6428.685264 1493.427347 0 6791 8347.970877 2390.736637 0 6792 8180.877512 241.686020 0 6793 5950.570976 3329.676267 0 6794 3018.784711 6095.191731 0 6795 2441.884006 9786.908142 0 6796 1760.427288 5468.197990 0 6797 6783.602294 3089.246207 0 6798 9181.707092 7799.797249 0 6799 2172.103633 4402.289059 0 6800 5598.436678 247.702340 0 6801 7722.519551 7394.423404 0 6802 3049.690066 7902.690479 0 6803 4170.296524 4350.564038 0 6804 8652.239973 3061.243976 0 6805 7806.963925 7289.715382 0 6806 2015.499220 2931.002745 0 6807 1581.764821 6126.477921 0 6808 2514.493922 9225.240309 0 6809 2030.971178 2454.849753 0 6810 7569.013812 6080.594366 0 6811 4299.696947 16.453842 0 6812 7955.544351 3337.496370 0 6813 5332.448950 3191.617278 0 6814 1905.129828 8942.032376 0 6815 4971.901946 7163.770116 0 6816 8255.569630 4026.540769 0 6817 6431.598026 911.378986 0 6818 496.165584 6050.032844 0 6819 9806.628131 9417.274053 0 6820 9612.084553 5829.040326 0 6821 4496.189672 7165.658971 0 6822 6154.616434 8629.904141 0 6823 9100.328627 6681.469557 0 6824 3078.568874 4963.222363 0 6825 7391.390146 7270.069018 0 6826 818.274398 450.859915 0 6827 2108.558644 1966.984254 0 6828 4203.818999 485.168254 0 6829 6908.321978 3044.442769 0 6830 1315.102381 7015.793971 0 6831 7928.291829 6297.398417 0 6832 9453.608549 7704.892390 0 6833 3285.215098 7291.102452 0 6834 3452.580398 9753.712246 0 6835 760.057723 5466.936145 0 6836 6519.262285 6837.647696 0 6837 2453.765779 4351.618077 0 6838 361.808857 99.219894 0 6839 9982.228983 863.476022 0 6840 4219.407656 7055.360271 0 6841 5033.289121 4073.498098 0 6842 8481.546114 8483.833719 0 6843 1818.397584 8781.993637 0 6844 419.314978 1030.021723 0 6845 1016.030253 3396.882004 0 6846 3290.539382 37.123199 0 6847 2118.613891 5416.096863 0 6848 3640.297614 8765.107146 0 6849 2597.034416 1105.610905 0 6850 112.663934 4544.420656 0 6851 7653.051833 2642.185811 0 6852 773.386863 2851.305210 0 6853 1246.510324 9113.543366 0 6854 121.827339 773.597987 0 6855 8467.790167 1689.358653 0 6856 6915.770596 3320.328031 0 6857 4776.283841 9827.118044 0 6858 6638.769049 2505.793734 0 6859 5706.920145 6525.008136 0 6860 8704.490346 360.472871 0 6861 1329.421503 9638.638278 0 6862 3510.939642 7763.395347 0 6863 3115.391373 6419.475427 0 6864 1075.594858 7205.873195 0 6865 8133.078614 1628.436862 0 6866 1495.349695 4930.396273 0 6867 5925.163897 7392.719772 0 6868 2639.650066 2851.192194 0 6869 5973.809395 8349.786621 0 6870 4211.833009 1769.732119 0 6871 7564.977624 5941.591989 0 6872 8115.686208 9290.517360 0 6873 896.365724 7946.082468 0 6874 6238.431199 8144.341684 0 6875 291.230931 8200.037722 0 6876 9452.437307 2357.912578 0 6877 3219.966998 7244.250265 0 6878 155.931065 3358.325527 0 6879 181.532558 5509.172603 0 6880 4107.041847 5566.403197 0 6881 157.571403 5237.580755 0 6882 8299.183535 9004.562140 0 6883 2149.746472 618.217701 0 6884 8091.493352 4741.092602 0 6885 2850.250524 511.674652 0 6886 9365.714561 1125.248410 0 6887 5720.005924 8020.048647 0 6888 9573.864028 394.248155 0 6889 1233.369226 5267.418610 0 6890 9683.066512 4602.966813 0 6891 3112.186330 397.283111 0 6892 3803.794587 3506.313439 0 6893 3806.759587 3789.479544 0 6894 2464.532696 4695.071820 0 6895 5957.243807 2857.828403 0 6896 7409.748578 6848.963924 0 6897 4117.040514 1713.249600 0 6898 1213.136173 6340.058969 0 6899 528.731263 9654.188194 0 6900 6851.223723 6235.536451 0 6901 3038.584152 5874.352146 0 6902 2368.043638 5851.248590 0 6903 3935.596575 9021.667664 0 6904 9640.485120 7662.170551 0 6905 8195.769327 7873.371185 0 6906 9794.793436 1091.327400 0 6907 7899.915042 9067.567042 0 6908 5081.451215 8721.999823 0 6909 8006.359020 280.662907 0 6910 8037.194921 4814.853317 0 6911 6088.901112 3328.227430 0 6912 5953.862943 5908.337855 0 6913 1477.789997 5004.286792 0 6914 1819.838934 6637.290027 0 6915 512.610281 3571.886408 0 6916 5923.402568 9584.727085 0 6917 985.047349 1545.079124 0 6918 3956.089334 3126.770917 0 6919 7109.061518 8258.872771 0 6920 1291.857719 6715.872064 0 6921 7964.644071 9137.021714 0 6922 3430.393938 2692.611332 0 6923 7465.169533 3985.141639 0 6924 5653.055276 6967.269463 0 6925 3041.375636 7495.531550 0 6926 9335.370299 7343.302478 0 6927 3249.098871 4731.058718 0 6928 9374.050812 5700.425668 0 6929 1102.165563 5023.304895 0 6930 3612.168150 9066.242148 0 6931 5513.921053 1865.518486 0 6932 367.610781 9282.421184 0 6933 1551.985194 6556.922099 0 6934 4093.451338 3647.740817 0 6935 7190.666651 4303.148180 0 6936 1858.746258 2873.967186 0 6937 3900.629541 5824.920826 0 6938 8180.593515 4528.700321 0 6939 9444.825439 3363.909481 0 6940 3817.232137 7996.690999 0 6941 3690.438047 9991.963573 0 6942 5657.504839 6482.161493 0 6943 5347.066257 3382.629868 0 6944 6888.257841 3487.305736 0 6945 877.876065 1389.769510 0 6946 3521.090083 6441.666759 0 6947 2771.804028 3410.285104 0 6948 1343.066870 6976.537346 0 6949 406.892259 9968.269834 0 6950 2789.145577 8616.583633 0 6951 6935.033156 6143.208756 0 6952 5202.369255 5445.942156 0 6953 8207.932237 1599.528749 0 6954 2488.296825 937.234078 0 6955 6768.044260 1916.318129 0 6956 7443.973511 8191.381207 0 6957 3761.914674 7397.912061 0 6958 295.605962 8381.058144 0 6959 9086.143650 390.033884 0 6960 4531.284686 5303.173850 0 6961 3958.266006 810.980513 0 6962 6513.393513 7229.851983 0 6963 9361.009838 1517.169570 0 6964 9175.450975 8186.451132 0 6965 636.227033 5905.662341 0 6966 9832.024805 6598.544483 0 6967 97.463194 7884.744694 0 6968 2269.019505 6422.110814 0 6969 2680.104426 9521.356588 0 6970 4145.215502 1689.484400 0 6971 2793.059445 8275.298049 0 6972 2533.382864 9644.546586 0 6973 5898.230114 7166.985161 0 6974 978.985124 9048.587608 0 6975 8818.038075 9680.318974 0 6976 9599.224454 7661.481712 0 6977 3439.456943 5045.014480 0 6978 9720.200930 377.740234 0 6979 7719.910781 5997.315301 0 6980 6619.199284 8346.783722 0 6981 2304.985248 9146.178228 0 6982 4984.591316 134.758200 0 6983 8068.107306 2311.478329 0 6984 8353.195108 2141.225220 0 6985 1341.343548 5612.657872 0 6986 244.053610 1927.547301 0 6987 7804.005713 5794.005770 0 6988 9392.769769 8758.079844 0 6989 3158.419844 9886.160968 0 6990 2953.656536 8628.250210 0 6991 7103.619335 71.525935 0 6992 7010.568799 4317.674299 0 6993 637.121049 9248.346770 0 6994 5760.886752 8811.969386 0 6995 8799.313594 8727.493425 0 6996 8429.116948 443.138141 0 6997 2443.397110 2743.870831 0 6998 4866.955726 2414.602121 0 6999 7956.626115 1845.991769 0 7000 4321.892297 6608.159273 0 7001 4702.842809 8611.799636 0 7002 5784.593330 2906.923612 0 7003 549.062654 6790.890860 0 7004 2848.646104 5754.541442 0 7005 5814.429714 3188.001770 0 7006 2703.192640 1230.402098 0 7007 8293.686506 2916.207245 0 7008 9848.695618 8741.268834 0 7009 517.593586 2421.759842 0 7010 6163.319499 3754.763360 0 7011 7762.643232 7413.804862 0 7012 9701.960028 3623.694573 0 7013 6943.254266 217.492578 0 7014 720.620878 7849.336741 0 7015 561.245344 3759.160857 0 7016 7749.408113 655.369959 0 7017 8330.132298 3389.489105 0 7018 7612.995172 9911.522195 0 7019 6771.788377 4026.922644 0 7020 8965.061855 2809.982719 0 7021 2249.348388 4717.827051 0 7022 3369.924203 9036.673746 0 7023 3724.766590 9375.490823 0 7024 5744.193630 610.601833 0 7025 4163.651236 994.912305 0 7026 6252.350500 5223.588436 0 7027 5671.476713 6011.795763 0 7028 1563.377041 4390.635728 0 7029 5192.097626 745.390093 0 7030 8894.891037 3440.419284 0 7031 9075.224866 9995.194928 0 7032 5333.535044 6703.506744 0 7033 3280.409094 4768.338749 0 7034 7668.899335 9368.964474 0 7035 6515.594500 3606.949656 0 7036 6421.888542 5247.822804 0 7037 4391.083801 5340.726150 0 7038 6837.031821 1513.682575 0 7039 3972.952361 5041.023128 0 7040 2271.234168 5301.611826 0 7041 5199.356695 5675.180961 0 7042 6187.821154 3140.407734 0 7043 7394.592226 2127.945346 0 7044 4892.852761 8873.148525 0 7045 2592.349888 2900.193197 0 7046 9673.232817 8510.727701 0 7047 585.998970 3349.507904 0 7048 5216.969443 2420.653337 0 7049 6831.384401 3809.597173 0 7050 6601.666453 5699.962407 0 7051 537.759215 9119.539485 0 7052 3509.274865 25.421707 0 7053 9163.239713 9213.199749 0 7054 312.839928 9518.721563 0 7055 2445.173467 282.919541 0 7056 2054.961109 1173.714328 0 7057 3191.914584 5931.748696 0 7058 9409.062944 3890.547095 0 7059 217.114438 7156.205046 0 7060 4074.040155 3151.680661 0 7061 9506.449274 8674.023139 0 7062 2074.186178 2137.852935 0 7063 1230.861679 8118.230520 0 7064 6106.536896 6733.224733 0 7065 7758.517083 2969.692635 0 7066 4718.963866 649.159735 0 7067 3226.605195 2437.377316 0 7068 3684.669048 2196.090745 0 7069 2403.350330 263.545797 0 7070 1771.739224 6161.725487 0 7071 1458.718740 1774.840413 0 7072 8832.516856 1599.799571 0 7073 8886.505870 5256.040860 0 7074 3541.532394 6883.618213 0 7075 6129.477818 9865.839488 0 7076 3634.085490 9581.142483 0 7077 5629.148508 8121.651943 0 7078 5206.209813 2103.607857 0 7079 3377.145334 1918.765090 0 7080 9425.833069 4218.342369 0 7081 7232.630205 79.544871 0 7082 9438.037769 4155.232771 0 7083 613.261517 2090.248438 0 7084 336.734969 4441.958977 0 7085 610.580438 5824.967736 0 7086 3547.898708 438.810031 0 7087 5817.054743 7448.696413 0 7088 5065.285184 2668.715642 0 7089 4792.687651 9681.458125 0 7090 2411.732733 9286.041309 0 7091 3552.971836 288.271941 0 7092 6751.321441 36.541176 0 7093 7551.130152 2055.935648 0 7094 204.929605 1855.187022 0 7095 3046.781589 1601.202263 0 7096 1854.637892 5998.100896 0 7097 9896.037436 3995.391992 0 7098 9291.088870 1733.482058 0 7099 4510.585409 7682.400810 0 7100 3171.035378 9892.783003 0 7101 7245.896573 2430.241485 0 7102 3850.025928 9627.940559 0 7103 7079.048365 3728.833829 0 7104 8387.670267 1137.975881 0 7105 6433.172042 3023.828267 0 7106 8082.350334 5552.306991 0 7107 6479.818511 8611.413113 0 7108 4632.642907 3328.685056 0 7109 6725.692325 8672.258838 0 7110 2618.414860 2130.143815 0 7111 8002.731653 4901.618571 0 7112 4672.976785 9978.690099 0 7113 5030.518010 2078.127351 0 7114 3249.715532 4978.149199 0 7115 5793.864408 4981.045077 0 7116 7528.177788 9240.393280 0 7117 218.363333 2235.871737 0 7118 8325.008034 6436.646798 0 7119 4006.679199 1133.921228 0 7120 8232.232942 3281.462360 0 7121 964.718622 726.471066 0 7122 102.250679 4257.560283 0 7123 5505.903006 1197.589490 0 7124 3668.455149 8034.398921 0 7125 67.843353 140.064875 0 7126 2065.592491 8675.940928 0 7127 6180.480205 6178.931359 0 7128 7955.075635 9549.189616 0 7129 9853.637473 2081.469313 0 7130 8156.392011 5459.436724 0 7131 499.053192 1773.926903 0 7132 2760.742831 343.876537 0 7133 177.065318 7661.300802 0 7134 8534.700562 9432.956992 0 7135 7986.870508 4963.581626 0 7136 5210.879728 2895.757250 0 7137 489.847714 9983.597813 0 7138 9190.239670 7595.277994 0 7139 2703.274224 3619.965591 0 7140 7316.268161 9494.250358 0 7141 4538.652444 8494.407599 0 7142 4884.121272 6944.214112 0 7143 9039.682274 7421.384938 0 7144 6840.512617 7656.862726 0 7145 8514.541760 809.517360 0 7146 5800.775555 5023.702026 0 7147 6550.208372 1761.955094 0 7148 3236.745821 5964.010515 0 7149 7697.909079 2380.541919 0 7150 849.498013 3996.979529 0 7151 5244.791161 4349.990296 0 7152 2848.259387 121.937247 0 7153 6883.087898 7127.234864 0 7154 466.227313 6887.016934 0 7155 2389.658746 1036.601079 0 7156 7981.534091 7472.230801 0 7157 5446.495318 4753.403654 0 7158 3892.473607 1446.471304 0 7159 2983.250304 851.378350 0 7160 842.301213 1226.850427 0 7161 1833.456677 990.337249 0 7162 9248.550640 5620.525426 0 7163 3451.031451 9952.269310 0 7164 5090.258752 2335.132028 0 7165 5305.250036 7992.826739 0 7166 8780.792871 8184.364471 0 7167 3425.987415 1559.558080 0 7168 7150.185705 7358.571195 0 7169 5960.848258 6674.599936 0 7170 6254.705072 4996.398513 0 7171 1590.569755 9772.807990 0 7172 3207.489016 2063.471568 0 7173 6742.366713 712.724301 0 7174 826.015357 3333.259207 0 7175 9538.189200 3876.790547 0 7176 2395.309415 2496.909004 0 7177 4362.462900 571.993939 0 7178 6154.080136 43.231593 0 7179 909.468606 5813.186926 0 7180 9966.506989 4244.209690 0 7181 4524.128527 9520.227921 0 7182 6739.522784 9500.407211 0 7183 1532.937946 4369.491921 0 7184 5658.170720 2777.916277 0 7185 1090.562540 7786.218188 0 7186 4794.236693 6320.867055 0 7187 1019.920923 275.077947 0 7188 9034.126209 9613.523047 0 7189 8993.796869 8008.592669 0 7190 3917.510021 7039.193406 0 7191 6902.677788 2227.738285 0 7192 5939.470201 3967.632301 0 7193 6803.382883 8945.964324 0 7194 1288.689856 6107.166874 0 7195 5298.550781 1871.664652 0 7196 5586.667895 630.473866 0 7197 7736.590918 1676.143560 0 7198 3894.133178 8329.871706 0 7199 3046.985583 6841.495851 0 7200 1262.051857 3985.947228 0 7201 5597.985955 8177.909498 0 7202 3756.933322 1062.366298 0 7203 8221.521588 292.429185 0 7204 5642.082643 5557.800142 0 7205 3387.507428 4336.686556 0 7206 6003.416744 7526.288196 0 7207 5078.761344 2017.125996 0 7208 67.086143 297.311224 0 7209 6139.666680 9877.377156 0 7210 4246.272119 6146.374075 0 7211 5755.260157 2015.452605 0 7212 266.724073 1337.493112 0 7213 1194.587601 2424.227253 0 7214 8706.544064 5297.088243 0 7215 7026.203634 668.697955 0 7216 9490.484521 286.831417 0 7217 8912.207910 215.387524 0 7218 5401.227308 5347.376878 0 7219 95.200434 2920.219201 0 7220 8605.616731 2863.927977 0 7221 2453.899394 5189.088160 0 7222 2086.054163 9069.426815 0 7223 2233.128862 8405.416558 0 7224 3046.821452 6183.824583 0 7225 1208.521467 3875.094578 0 7226 6420.822564 1034.000989 0 7227 7207.588969 2069.845153 0 7228 6191.927206 1884.611120 0 7229 8829.507327 7352.486712 0 7230 2812.319866 7879.182341 0 7231 9019.427697 7410.676976 0 7232 6099.193953 8177.654394 0 7233 5890.680599 9981.806135 0 7234 4469.216527 292.791220 0 7235 8234.704040 4670.549092 0 7236 9097.258521 1557.805143 0 7237 9433.913839 3719.003466 0 7238 7450.466822 4638.292281 0 7239 408.772857 8973.290584 0 7240 7168.182627 6156.139991 0 7241 5323.450653 9825.747515 0 7242 2755.107074 3133.160979 0 7243 8443.721511 6776.690895 0 7244 7749.128144 4935.761304 0 7245 1086.441923 2166.551102 0 7246 3061.868595 3101.395132 0 7247 1903.373892 4485.582747 0 7248 363.328534 3483.810194 0 7249 8879.185190 3868.700147 0 7250 9895.527715 9987.835526 0 7251 8475.705320 255.844276 0 7252 5992.870852 7127.257582 0 7253 1595.921151 5014.477648 0 7254 671.908594 5362.472943 0 7255 895.503591 8499.353058 0 7256 855.084082 9684.745743 0 7257 1311.511867 5315.070906 0 7258 593.057792 2656.952644 0 7259 8406.376844 1580.653557 0 7260 2352.256078 9251.674152 0 7261 8178.457378 2476.451977 0 7262 1366.420145 9174.618991 0 7263 3475.995886 3308.650736 0 7264 7368.257436 4847.193803 0 7265 7848.791920 2356.956134 0 7266 8988.192205 5099.276416 0 7267 1702.427455 2077.031509 0 7268 118.366109 6679.071303 0 7269 8321.517650 603.854377 0 7270 8860.187266 7763.994357 0 7271 7443.624024 1908.873514 0 7272 7307.816163 3687.438218 0 7273 3104.611962 8921.076263 0 7274 8335.474986 124.087392 0 7275 9032.074214 5127.914379 0 7276 2306.584244 3999.944914 0 7277 7867.617446 8876.115133 0 7278 30.911486 5809.257969 0 7279 8750.963849 1700.438160 0 7280 5401.072730 1660.665893 0 7281 8620.124469 7339.128151 0 7282 747.570129 9561.038955 0 7283 6524.556916 8052.159803 0 7284 8243.519106 3790.899962 0 7285 1565.940758 8807.954080 0 7286 2236.181850 8955.067172 0 7287 1533.867348 9181.625589 0 7288 3712.703045 4734.024710 0 7289 7422.683192 542.287111 0 7290 406.116952 5586.579955 0 7291 710.719334 6659.172478 0 7292 208.321903 1099.918141 0 7293 4325.368806 7216.431254 0 7294 5938.526741 4210.320043 0 7295 8298.333742 7074.796756 0 7296 1674.128729 871.459448 0 7297 693.734782 4579.055448 0 7298 8986.726407 8502.942904 0 7299 3957.638559 3731.855572 0 7300 477.772906 2505.525141 0 7301 8890.581366 2328.397950 0 7302 7964.057324 5148.225952 0 7303 5676.378161 9713.167549 0 7304 536.303619 234.349968 0 7305 4320.652067 9398.735198 0 7306 9990.225392 3926.050781 0 7307 7981.061186 3259.358980 0 7308 2739.924767 9816.530135 0 7309 2916.738113 5171.168313 0 7310 2944.647860 8095.428512 0 7311 4998.014939 2658.065119 0 7312 1161.121445 7502.135465 0 7313 2238.465446 336.577975 0 7314 8276.386015 3137.635965 0 7315 3907.915823 3049.639525 0 7316 4488.359934 2364.729049 0 7317 9807.086928 1924.702761 0 7318 8086.842264 7.804451 0 7319 4253.696812 4863.054972 0 7320 5206.900412 3794.219544 0 7321 3792.324279 209.391095 0 7322 8533.215204 9704.534108 0 7323 8274.955713 455.126411 0 7324 9157.819069 4212.268666 0 7325 2137.624158 9776.893418 0 7326 6975.302029 3572.441510 0 7327 5637.033247 2704.073549 0 7328 2311.637193 1735.613898 0 7329 3062.006142 3497.700078 0 7330 315.107517 5081.812974 0 7331 121.669961 4594.820601 0 7332 1317.257506 1268.909976 0 7333 9059.634396 4146.983594 0 7334 9824.275566 6304.268719 0 7335 1742.647709 1294.468889 0 7336 4201.309970 9434.068273 0 7337 7647.538861 2079.798557 0 7338 1582.396699 1194.884483 0 7339 1651.647271 4188.884462 0 7340 3168.855737 7271.591604 0 7341 7733.099050 4812.346378 0 7342 2233.382024 7689.379156 0 7343 3256.081078 1622.799441 0 7344 3851.196706 8193.582257 0 7345 3304.681806 5953.038983 0 7346 2136.033390 9067.392270 0 7347 5761.170129 537.979184 0 7348 8275.516456 3859.994529 0 7349 9323.369818 7603.699786 0 7350 7882.052430 3269.446459 0 7351 6479.692542 3801.573579 0 7352 5038.545718 8466.139213 0 7353 33.320441 1452.550895 0 7354 757.129638 4333.568516 0 7355 6638.334286 7630.938531 0 7356 5325.054512 1273.534349 0 7357 1969.815295 7079.343457 0 7358 9808.397132 4541.450693 0 7359 4844.960297 2699.684175 0 7360 8715.262394 3340.797280 0 7361 6281.541083 893.650111 0 7362 8691.754544 1722.032680 0 7363 3837.443029 1830.055567 0 7364 9076.149099 1603.473267 0 7365 2659.884133 3673.556375 0 7366 7061.926700 7767.565456 0 7367 8701.346080 2164.747513 0 7368 600.696375 3530.219149 0 7369 2845.721228 7118.384105 0 7370 981.871519 5711.268418 0 7371 2148.379995 2760.011039 0 7372 4697.059644 9009.705140 0 7373 5161.522523 411.559559 0 7374 2508.932809 1055.810354 0 7375 9622.571327 3443.381584 0 7376 8502.491152 6462.093620 0 7377 9037.195016 3893.872634 0 7378 8749.766271 2246.171190 0 7379 6230.660170 9806.128575 0 7380 242.266226 959.004321 0 7381 3676.619573 2262.451068 0 7382 9257.759354 5586.564589 0 7383 2010.511260 1412.284319 0 7384 771.019655 6489.856135 0 7385 8608.690218 409.020141 0 7386 7780.091294 4178.757521 0 7387 329.350040 1840.388327 0 7388 7945.018493 7281.002920 0 7389 4013.852346 6887.938056 0 7390 7491.796812 3240.667239 0 7391 4993.137783 9496.074116 0 7392 8513.268439 7231.476124 0 7393 6002.974326 4700.597517 0 7394 7687.274041 1932.487445 0 7395 2922.398278 6935.362162 0 7396 242.342671 589.783482 0 7397 7853.285351 2356.216754 0 7398 7139.222550 6713.806357 0 7399 46.159159 8602.075230 0 7400 7626.929276 51.506906 0 7401 217.173926 8616.618931 0 7402 8979.004235 4531.034668 0 7403 1537.917649 1722.082288 0 7404 4340.831973 6877.851694 0 7405 5577.381165 7508.658904 0 7406 639.824516 7646.762200 0 7407 2733.051981 8084.731158 0 7408 8217.601972 2792.759209 0 7409 8257.064089 77.341466 0 7410 9573.356330 7858.227465 0 7411 5144.454693 8297.515129 0 7412 7755.050167 3956.065600 0 7413 5351.257839 6282.299272 0 7414 1331.031068 8513.850188 0 7415 579.243602 534.340622 0 7416 9270.747318 9877.843961 0 7417 6211.213800 2789.212952 0 7418 52.556902 9996.179073 0 7419 1796.918866 6390.710251 0 7420 5172.134470 1360.260729 0 7421 9559.943733 2900.164050 0 7422 5220.914355 7466.911697 0 7423 9383.169535 7907.806570 0 7424 4791.987075 5452.275713 0 7425 4569.616682 4787.648787 0 7426 2644.614570 3487.842149 0 7427 2591.049154 3567.284521 0 7428 8164.444304 3119.008952 0 7429 2776.301329 2367.228380 0 7430 9664.004084 705.277790 0 7431 5133.722395 1225.839047 0 7432 4776.788282 2151.836562 0 7433 2740.027180 6023.017566 0 7434 3870.289323 868.681675 0 7435 3478.009100 9424.122460 0 7436 4752.858080 8356.948976 0 7437 2738.767381 9977.405384 0 7438 9715.086801 9815.344877 0 7439 9681.864897 5129.776634 0 7440 1827.693821 9875.367383 0 7441 585.733519 8244.868787 0 7442 7600.828704 592.200227 0 7443 8055.576233 9890.764810 0 7444 9747.052010 7203.727888 0 7445 4659.538289 6478.607616 0 7446 9989.263150 9551.132737 0 7447 9435.245095 6966.250571 0 7448 6896.339641 1845.371891 0 7449 7810.931149 2826.229205 0 7450 1233.430539 1388.554744 0 7451 3033.225666 8450.317188 0 7452 872.343938 3931.094739 0 7453 879.922469 1727.004238 0 7454 4936.274967 5889.540378 0 7455 519.334716 3577.544489 0 7456 7763.079441 5271.730347 0 7457 3605.373563 5337.242077 0 7458 6595.149879 9182.989934 0 7459 1280.733072 5580.882242 0 7460 6253.804805 6931.286050 0 7461 5036.289962 2573.181520 0 7462 1688.992323 9603.529046 0 7463 7189.762200 2636.661668 0 7464 4588.315851 4780.301860 0 7465 9867.037128 829.035888 0 7466 9061.515148 2096.206673 0 7467 7560.250163 7047.491014 0 7468 7533.647906 1127.146614 0 7469 162.975681 8227.380638 0 7470 7002.702898 5827.026873 0 7471 8102.037363 9419.184392 0 7472 5497.929973 9794.154947 0 7473 9489.949484 9728.394603 0 7474 5781.436099 510.322647 0 7475 1487.522235 6302.705153 0 7476 1758.527443 4074.610497 0 7477 9395.059195 8575.790196 0 7478 1118.625204 7699.067565 0 7479 9049.167132 8158.511547 0 7480 9469.202586 9457.244269 0 7481 7310.252637 3002.294189 0 7482 3997.151796 4371.809721 0 7483 7056.427643 849.365503 0 7484 2614.506008 9328.695042 0 7485 9386.719097 2952.829233 0 7486 1938.571779 5373.043791 0 7487 2235.222699 2287.998639 0 7488 3523.017563 8288.423524 0 7489 465.464696 592.695573 0 7490 5595.396639 6551.390409 0 7491 7578.447323 9529.627409 0 7492 5894.663114 6839.301149 0 7493 3379.737583 3523.628997 0 7494 195.864521 9748.212906 0 7495 5089.754425 960.024856 0 7496 1059.783339 1409.311080 0 7497 5885.177645 7219.347507 0 7498 1482.635627 3754.739682 0 7499 6354.148568 2354.925732 0 7500 5991.481833 3331.078386 0 7501 6407.433768 5796.027071 0 7502 5477.157392 1207.575452 0 7503 8621.126848 3503.221956 0 7504 1600.304874 7581.790996 0 7505 8460.765014 2185.909996 0 7506 4515.021300 5833.470585 0 7507 3422.673815 3957.380750 0 7508 6542.544822 9349.288261 0 7509 6254.605074 8785.313247 0 7510 221.829421 5391.722323 0 7511 5159.470699 8702.528933 0 7512 4462.186844 7520.720061 0 7513 7396.147073 4784.121705 0 7514 3706.285512 1359.657367 0 7515 4043.762842 5067.019749 0 7516 8752.458599 7384.387757 0 7517 2873.381705 648.761750 0 7518 1856.235927 7571.136648 0 7519 1629.070258 8190.908629 0 7520 7780.165920 1779.777387 0 7521 3305.434769 4551.820701 0 7522 5111.256770 7657.181091 0 7523 894.069311 1182.103805 0 7524 1058.441851 7054.918984 0 7525 4037.316508 1091.654520 0 7526 8089.332141 1212.319471 0 7527 8240.380865 8180.932277 0 7528 2090.570767 6066.294116 0 7529 3634.363214 3229.088425 0 7530 7927.289325 2970.479700 0 7531 2774.404560 5700.779001 0 7532 3696.876215 5719.088512 0 7533 7417.250786 6823.509756 0 7534 9295.180585 505.522558 0 7535 5053.867212 9512.166078 0 7536 9083.585195 5154.501101 0 7537 1857.775125 3303.030831 0 7538 5502.641929 7362.353973 0 7539 3173.545927 8240.931851 0 7540 8286.893822 9715.097994 0 7541 6316.030050 5419.181789 0 7542 9580.809689 8881.882918 0 7543 1583.589312 3970.160922 0 7544 9755.507744 947.144860 0 7545 2564.828343 5335.747196 0 7546 6897.856838 5219.844320 0 7547 3396.140934 8966.841041 0 7548 1926.188406 2498.878600 0 7549 502.201082 9222.028057 0 7550 7774.448997 2580.859473 0 7551 3355.921338 5592.885293 0 7552 2471.773243 8274.982562 0 7553 6732.501217 1847.812675 0 7554 3270.510895 1649.103580 0 7555 2492.798955 829.938370 0 7556 9100.070533 4338.943936 0 7557 8298.595469 8133.328247 0 7558 1355.926466 8397.827658 0 7559 585.199124 9372.737771 0 7560 7559.860235 9598.263335 0 7561 6863.425934 2263.026655 0 7562 1870.814318 7989.797198 0 7563 7707.204140 5535.567952 0 7564 1263.555561 2164.743733 0 7565 4616.453837 2117.176170 0 7566 8404.853378 8714.286962 0 7567 3237.576553 6757.371566 0 7568 2104.300922 6677.882818 0 7569 7529.733191 1647.659433 0 7570 2437.111056 712.463206 0 7571 9394.739402 9666.947299 0 7572 4486.119997 6772.349496 0 7573 7024.982183 969.992210 0 7574 9507.179791 2376.397482 0 7575 657.254598 2741.752386 0 7576 9391.905114 9772.602755 0 7577 4711.854113 3380.452895 0 7578 6967.193555 7389.533727 0 7579 2425.263362 9200.590855 0 7580 3998.546181 1723.373355 0 7581 2235.001583 8429.191693 0 7582 9054.894090 6268.313081 0 7583 1692.640598 2019.749998 0 7584 8293.022069 7349.595545 0 7585 9423.460900 5021.206014 0 7586 1766.784809 1476.255172 0 7587 4417.072401 5480.949556 0 7588 9899.684019 6245.919304 0 7589 9710.162936 9456.549899 0 7590 3653.323654 3473.476093 0 7591 5177.114440 6410.818438 0 7592 2593.144341 4154.025705 0 7593 8637.421827 2830.571668 0 7594 9965.360521 811.844622 0 7595 2874.295906 8314.037739 0 7596 8945.921211 1031.054538 0 7597 8960.826306 6148.694380 0 7598 9283.712456 9292.811727 0 7599 6831.114889 9409.387109 0 7600 293.211822 519.181599 0 7601 545.934535 8867.599419 0 7602 5516.246353 1318.018386 0 7603 2085.795463 559.120732 0 7604 4201.439922 2048.534174 0 7605 5507.045524 2987.682315 0 7606 7797.419062 5734.391415 0 7607 5400.775384 5405.853030 0 7608 4687.158885 2210.017112 0 7609 503.731197 4178.002401 0 7610 1196.435141 106.867183 0 7611 1905.457972 9682.037558 0 7612 1603.745843 5027.484866 0 7613 6693.924639 2161.439764 0 7614 2230.968264 7302.394971 0 7615 3115.650152 9915.077153 0 7616 6050.250601 358.647069 0 7617 472.617909 6216.288537 0 7618 4203.798396 920.391827 0 7619 9012.651674 9665.691925 0 7620 9237.381335 7891.870130 0 7621 2573.278922 178.273008 0 7622 4285.365281 550.148301 0 7623 6033.135048 4729.988824 0 7624 8860.244937 9807.374874 0 7625 1268.522924 4298.356922 0 7626 908.405493 6740.534221 0 7627 5507.322024 9711.533884 0 7628 1513.207303 8615.374730 0 7629 4833.411729 3633.313618 0 7630 7763.538137 4440.646200 0 7631 6071.878060 9631.593633 0 7632 9664.820784 4636.318969 0 7633 1960.349728 3879.045163 0 7634 5791.733912 2330.606295 0 7635 395.124580 1096.376863 0 7636 2748.952362 9322.073466 0 7637 9946.153474 9834.237164 0 7638 6320.805924 4804.732814 0 7639 8084.332776 6060.185195 0 7640 5609.211906 3004.776980 0 7641 9536.502391 9861.979405 0 7642 9953.272782 7823.006174 0 7643 9895.015829 5425.910446 0 7644 4001.464701 7429.033096 0 7645 397.973503 4091.194781 0 7646 7310.174590 5270.132479 0 7647 299.438054 5057.488661 0 7648 8747.380102 1228.677420 0 7649 2271.232940 3621.151722 0 7650 6001.540998 7720.672235 0 7651 5968.247683 956.332671 0 7652 46.921088 7107.951839 0 7653 1614.517013 3918.826224 0 7654 5167.355209 1701.049866 0 7655 6995.920374 5597.805953 0 7656 4668.156274 784.886549 0 7657 4802.737596 4893.988990 0 7658 8757.865222 10.879747 0 7659 7380.631554 2532.223396 0 7660 1286.861571 1378.534058 0 7661 1747.482621 757.565236 0 7662 4684.078765 2881.612388 0 7663 3112.589047 6286.213988 0 7664 7266.190172 5675.610481 0 7665 2027.393657 988.652896 0 7666 8208.077039 9932.891159 0 7667 2373.980449 5937.380126 0 7668 657.969770 853.163104 0 7669 1047.720870 7442.000175 0 7670 7368.542383 3829.979205 0 7671 9874.290099 1617.735407 0 7672 7703.477178 3948.684951 0 7673 7426.076122 158.036948 0 7674 2179.780766 5514.897804 0 7675 320.650848 3199.315106 0 7676 2090.757783 1155.647275 0 7677 8141.728696 1968.086546 0 7678 9541.245639 8705.194463 0 7679 1112.026255 8927.912495 0 7680 749.462697 1767.416038 0 7681 2021.285995 2020.233838 0 7682 8936.328941 1099.510202 0 7683 877.924601 3011.153146 0 7684 6944.137748 9262.266390 0 7685 6767.928618 7781.444316 0 7686 3534.387018 6455.379930 0 7687 3490.758790 7106.475497 0 7688 3896.233888 651.040437 0 7689 8234.292655 3843.221743 0 7690 1747.006136 9852.893538 0 7691 983.539281 3221.388917 0 7692 1217.083437 6586.382819 0 7693 1974.416128 6654.749411 0 7694 2855.123633 2969.567263 0 7695 2222.292414 934.172966 0 7696 6098.590382 7013.357045 0 7697 169.960477 6339.893303 0 7698 3515.559900 9006.735580 0 7699 61.345858 4218.268186 0 7700 5938.503509 6276.168998 0 7701 9817.288532 3440.461802 0 7702 4686.418592 4384.647538 0 7703 7879.781721 2447.402801 0 7704 689.448951 851.647364 0 7705 7197.206386 9014.132990 0 7706 8754.542471 8355.711170 0 7707 3251.925128 6489.894298 0 7708 3213.278927 2424.987109 0 7709 4645.911120 2703.076786 0 7710 5573.739059 3135.717961 0 7711 6537.014543 6041.123796 0 7712 5519.628539 2729.036412 0 7713 7997.425070 3133.467461 0 7714 6191.296270 8736.359259 0 7715 8478.715863 2019.754773 0 7716 50.945569 3283.085093 0 7717 7253.845898 513.164576 0 7718 42.138803 3224.466938 0 7719 4886.597038 6429.331607 0 7720 9832.198112 720.586826 0 7721 5602.824816 2686.484654 0 7722 1378.776695 2039.780350 0 7723 1589.927978 7837.107465 0 7724 9211.921282 2663.468977 0 7725 1265.127691 4095.159697 0 7726 907.506083 380.589756 0 7727 8416.050683 5081.879309 0 7728 4407.700765 4046.978489 0 7729 6911.261344 5721.279024 0 7730 5064.117193 2204.023772 0 7731 5045.289310 7047.494781 0 7732 3339.093414 142.317517 0 7733 9693.792530 6713.736641 0 7734 9294.454604 1647.729891 0 7735 8845.989305 2694.341878 0 7736 7526.721335 8938.717310 0 7737 8929.293139 8177.054579 0 7738 817.810766 9505.192904 0 7739 5620.224407 2730.774062 0 7740 4785.238985 8710.814786 0 7741 7476.035822 5645.370528 0 7742 7833.386912 9257.785593 0 7743 4287.219657 598.939798 0 7744 7930.110898 2304.462461 0 7745 6759.839686 8614.962415 0 7746 9006.515614 477.078249 0 7747 7433.655787 6957.812260 0 7748 3668.302158 6043.682416 0 7749 1690.720981 2009.073852 0 7750 8815.234100 2587.046136 0 7751 7359.478200 6868.775219 0 7752 7230.260403 2798.602371 0 7753 5402.219919 580.992457 0 7754 5957.448041 1140.915182 0 7755 9511.132756 7139.528153 0 7756 1954.708595 4999.232556 0 7757 4552.004417 662.962552 0 7758 6033.653958 1985.795624 0 7759 3435.641873 849.756267 0 7760 1366.812533 6559.254682 0 7761 4575.099898 139.600622 0 7762 6860.537084 7383.784940 0 7763 2149.230427 7533.387628 0 7764 5022.779101 2172.675106 0 7765 1046.405319 7201.446404 0 7766 1822.048953 7017.500119 0 7767 8687.615278 6091.434158 0 7768 8759.504227 3383.152536 0 7769 8512.355293 6110.708622 0 7770 9891.059370 4646.488508 0 7771 6253.770632 4207.231011 0 7772 7024.775603 1944.990911 0 7773 1090.051205 8504.268045 0 7774 224.031061 3483.525397 0 7775 9188.895968 5706.077574 0 7776 1649.509524 4463.357331 0 7777 8843.968634 4522.933210 0 7778 6163.521882 4089.851553 0 7779 8141.369453 6920.930177 0 7780 2781.670005 2965.361213 0 7781 5759.665276 3293.406730 0 7782 5736.417307 7624.031296 0 7783 9765.330180 8721.795640 0 7784 5086.893941 3464.701085 0 7785 1900.059421 4307.042499 0 7786 3527.658942 2797.099266 0 7787 6917.956403 8240.387803 0 7788 8752.090386 9752.672934 0 7789 8979.715849 2047.567974 0 7790 4493.267822 9800.957851 0 7791 5298.159353 5843.965953 0 7792 2064.108774 5747.057727 0 7793 3160.276930 572.404596 0 7794 3086.615402 9555.986836 0 7795 8609.609522 6668.415235 0 7796 5000.081476 7652.246278 0 7797 3593.346906 2567.000973 0 7798 4668.568685 4798.319646 0 7799 4305.135051 3137.113144 0 7800 7101.121686 8049.836735 0 7801 9309.728093 1772.909352 0 7802 1365.910267 2602.647156 0 7803 1837.527972 786.509778 0 7804 2629.551296 9619.002075 0 7805 9574.822232 3737.633224 0 7806 2393.088422 2313.626115 0 7807 835.432244 9489.628943 0 7808 419.512896 8022.681320 0 7809 3476.912562 3425.816908 0 7810 5794.098208 1087.834341 0 7811 7024.323748 7365.878796 0 7812 212.594115 4679.332015 0 7813 8719.676261 7606.981302 0 7814 7255.277296 5990.155631 0 7815 7683.016617 4252.673965 0 7816 3513.093212 8364.594685 0 7817 1286.387201 1674.993363 0 7818 4227.417859 6668.159905 0 7819 7990.076019 317.027717 0 7820 1903.660421 132.265547 0 7821 7299.900810 9014.481843 0 7822 1091.828020 9430.851319 0 7823 9583.427995 5510.107687 0 7824 7685.761062 2082.292083 0 7825 6166.384732 6264.464380 0 7826 8951.073220 2189.231270 0 7827 938.591746 7853.050465 0 7828 8415.265936 7218.619280 0 7829 356.876376 707.801906 0 7830 1844.865812 2547.831630 0 7831 5987.910362 5485.382726 0 7832 1086.042210 7455.062854 0 7833 9532.966017 6674.657046 0 7834 6754.739191 7523.749380 0 7835 999.792245 8371.149371 0 7836 8830.188414 1110.287258 0 7837 9056.172547 4640.289652 0 7838 2883.684574 8180.628914 0 7839 6741.651539 8433.298976 0 7840 6122.477058 9118.449797 0 7841 5067.153576 2198.388360 0 7842 938.616757 4885.639455 0 7843 7806.068927 6445.889383 0 7844 3430.433682 6936.137637 0 7845 3978.233109 5206.234837 0 7846 2278.457194 4587.600371 0 7847 3758.843437 2832.336852 0 7848 6918.186161 6718.493072 0 7849 3725.640041 1494.483722 0 7850 3806.084617 8754.441159 0 7851 538.732921 1782.135337 0 7852 6733.170843 2279.918672 0 7853 8500.037445 1460.635665 0 7854 3332.673771 7624.200837 0 7855 5553.699407 1911.148157 0 7856 3606.249634 9986.173450 0 7857 2526.729487 594.040646 0 7858 1786.837102 7694.891998 0 7859 8400.612487 3689.910123 0 7860 3492.228022 4441.683889 0 7861 1499.481768 5667.358150 0 7862 3395.075927 5566.743295 0 7863 2410.355721 4366.554704 0 7864 4874.886604 3583.705157 0 7865 3293.746555 6900.226636 0 7866 5173.484374 1200.210773 0 7867 3592.616632 7046.271423 0 7868 1946.445168 1236.936447 0 7869 2086.419241 6669.976918 0 7870 215.826820 2544.418630 0 7871 8573.408177 6988.626908 0 7872 9567.824879 4301.089863 0 7873 1212.855423 7498.555016 0 7874 8074.914477 8940.170613 0 7875 6840.879028 1015.423120 0 7876 30.825240 4687.460726 0 7877 7826.089968 1617.458450 0 7878 1230.806208 9316.589697 0 7879 7398.440017 4265.498214 0 7880 4432.200830 9047.175494 0 7881 7442.746391 315.829281 0 7882 5622.248980 6076.783422 0 7883 3046.435755 7001.538592 0 7884 5771.728105 5650.919830 0 7885 6806.118697 3864.040535 0 7886 3063.829392 218.966909 0 7887 7199.834548 8577.224022 0 7888 8031.951003 2609.949727 0 7889 7417.460756 9166.376431 0 7890 2998.630231 6482.739264 0 7891 7487.589109 1571.092953 0 7892 2810.072775 7590.679952 0 7893 6343.367152 1824.564860 0 7894 471.998894 1614.920672 0 7895 1962.714569 7452.565907 0 7896 3207.574011 8134.750489 0 7897 2582.204224 2521.701137 0 7898 8639.151061 154.131131 0 7899 2954.489116 9164.894459 0 7900 4853.824697 6755.742251 0 7901 6052.837658 9654.112992 0 7902 7272.053280 6382.688682 0 7903 3013.389966 122.270122 0 7904 6018.889255 3021.045187 0 7905 7591.862577 8360.071277 0 7906 7523.243229 7551.066891 0 7907 9530.955482 6504.499250 0 7908 4663.830203 9213.230490 0 7909 5157.164080 2810.607908 0 7910 1376.522219 1458.753088 0 7911 1010.717813 1781.431922 0 7912 1693.341773 5865.623206 0 7913 178.535234 9705.106484 0 7914 2640.414213 6279.141711 0 7915 9393.586618 5143.644204 0 7916 9321.495782 6531.597887 0 7917 6781.930266 9854.845398 0 7918 2030.876962 2547.359303 0 7919 5722.344275 5665.066185 0 7920 973.618694 1992.920535 0 7921 3668.960145 5207.184986 0 7922 1008.280802 9989.444182 0 7923 9443.973364 7939.066414 0 7924 1667.971034 7638.339607 0 7925 8448.145584 7682.666356 0 7926 7253.028510 2516.336844 0 7927 6116.080146 7342.914176 0 7928 3612.237896 3694.236626 0 7929 836.499557 9679.303900 0 7930 5158.132421 318.207898 0 7931 6018.803989 9235.571578 0 7932 8622.156287 4703.329619 0 7933 394.551684 3976.385491 0 7934 9023.508319 2785.794953 0 7935 2305.965514 3913.658427 0 7936 7242.682353 5545.866665 0 7937 6442.588698 1594.364190 0 7938 7132.454203 7052.143735 0 7939 8665.423656 3707.133174 0 7940 9952.516615 9644.867075 0 7941 135.344729 7910.128132 0 7942 6848.747135 838.731940 0 7943 9721.135925 647.979782 0 7944 6558.018897 934.737879 0 7945 1107.000436 4844.563572 0 7946 4156.677627 5861.347203 0 7947 8293.279090 3274.933471 0 7948 5752.438341 3913.790402 0 7949 1763.675058 6492.848809 0 7950 6834.540829 9379.394019 0 7951 2455.566514 9135.603992 0 7952 1023.898640 6246.697151 0 7953 9216.032632 5018.950964 0 7954 263.585335 6854.282520 0 7955 9976.567153 7769.170914 0 7956 6715.560671 8619.971623 0 7957 8300.479421 147.365396 0 7958 7675.539992 4179.903662 0 7959 7363.236464 8141.861242 0 7960 8037.215132 8694.754297 0 7961 5376.329513 5228.726365 0 7962 7971.614189 1888.801988 0 7963 4120.440807 3523.861918 0 7964 5384.171224 3838.436877 0 7965 2267.836725 9373.993833 0 7966 7014.963341 4268.259801 0 7967 8950.907973 9615.625459 0 7968 5645.727876 2953.583265 0 7969 6502.238377 4535.460751 0 7970 9761.564989 8988.335501 0 7971 264.130018 57.119287 0 7972 1751.829049 3162.252978 0 7973 5777.879799 2086.225700 0 7974 1216.564770 418.040116 0 7975 1964.412112 1418.534601 0 7976 9622.812879 5652.483634 0 7977 1297.299274 9922.510679 0 7978 6667.265914 5766.759501 0 7979 7479.904652 7732.415916 0 7980 3151.764879 9231.932531 0 7981 1404.342076 5747.355314 0 7982 2648.870099 9995.365351 0 7983 2730.828355 9128.595038 0 7984 2940.079137 170.194220 0 7985 7120.912346 2995.265879 0 7986 1760.728769 5358.616289 0 7987 2888.894943 6346.992474 0 7988 3285.572510 3987.955742 0 7989 8589.068181 4662.014409 0 7990 5406.281733 16.523361 0 7991 7352.138774 6036.375775 0 7992 6166.932873 6840.682746 0 7993 7994.848383 8738.401226 0 7994 9990.644554 6621.999907 0 7995 5619.979435 1378.078337 0 7996 2153.189217 9825.921924 0 7997 5901.201489 8440.245067 0 7998 9166.242143 4881.812572 0 7999 4717.104580 3175.898425 0 8000 6758.287159 9414.368128 0 8001 8279.620897 1095.741606 0 8002 6430.752179 3817.423892 0 8003 4417.662555 1010.834817 0 8004 9789.303315 4523.794178 0 8005 3871.709306 7719.718233 0 8006 8310.520200 6587.241263 0 8007 4177.613263 2479.159845 0 8008 6429.381308 3473.544021 0 8009 6800.372016 1159.260542 0 8010 8800.741760 8808.523796 0 8011 7325.612730 3274.997259 0 8012 3199.763221 5890.591586 0 8013 2953.868397 6901.683080 0 8014 4447.612295 2825.574384 0 8015 149.275274 8571.498676 0 8016 4958.567246 99.509534 0 8017 4732.290491 7523.200727 0 8018 5403.852026 3840.644265 0 8019 3914.252966 4317.447826 0 8020 6477.192404 9803.014843 0 8021 8080.642004 1189.718568 0 8022 9304.253985 2941.724286 0 8023 3958.987152 9753.387165 0 8024 5823.352002 463.283017 0 8025 8775.399591 9148.801251 0 8026 1816.006015 2470.862373 0 8027 8758.164517 9957.791904 0 8028 2979.778827 2731.033296 0 8029 8942.131390 9865.048076 0 8030 7373.709715 1448.304247 0 8031 3573.382087 9721.669657 0 8032 7645.284033 3176.902871 0 8033 5093.049032 4333.612349 0 8034 2433.315349 6397.269383 0 8035 241.303524 3970.452013 0 8036 584.125796 9436.886800 0 8037 8246.791403 9711.267747 0 8038 8130.433169 6273.552737 0 8039 4454.654228 4473.013257 0 8040 953.273527 1498.268980 0 8041 2588.822142 3739.912205 0 8042 9694.355044 2178.065048 0 8043 1542.726049 3790.609094 0 8044 3106.400006 4181.861690 0 8045 3878.948237 949.419696 0 8046 3093.923185 2713.351367 0 8047 934.414969 9184.302356 0 8048 2943.124385 3504.245812 0 8049 9593.298348 7142.346998 0 8050 310.596338 8059.517571 0 8051 2347.951516 3273.631762 0 8052 8951.716903 8753.098142 0 8053 3706.126448 6636.803063 0 8054 9943.601845 4381.839888 0 8055 6474.730873 9779.136190 0 8056 9038.908895 8260.305413 0 8057 1699.296512 3227.477203 0 8058 5743.886242 3129.551466 0 8059 4251.286762 2373.431803 0 8060 316.838932 6852.890172 0 8061 9749.496534 7752.771204 0 8062 7936.707976 2259.744921 0 8063 8618.130460 5105.986219 0 8064 183.149866 4853.087839 0 8065 6043.613732 2003.037032 0 8066 4447.694870 9720.560423 0 8067 2937.336185 6805.438902 0 8068 4854.960708 9866.354612 0 8069 8824.944696 1602.238266 0 8070 3503.601233 2462.358316 0 8071 8765.992234 4695.807547 0 8072 5250.008311 7906.552597 0 8073 9134.922487 6244.832191 0 8074 4146.393962 6156.578137 0 8075 3171.499565 9125.252528 0 8076 7506.665066 7214.463436 0 8077 2704.525612 5936.559028 0 8078 5008.894425 2428.691892 0 8079 1494.394968 6009.300076 0 8080 8507.827082 9935.726112 0 8081 5802.752995 1408.913559 0 8082 7930.982258 3655.368304 0 8083 1219.894768 5806.369149 0 8084 5346.272665 7656.555853 0 8085 3343.269038 1630.717192 0 8086 2936.713721 1720.014108 0 8087 8896.977238 3621.894898 0 8088 5237.668113 8325.031635 0 8089 2705.880322 209.496265 0 8090 289.379326 4133.022473 0 8091 7006.864893 2186.286015 0 8092 5535.235649 6235.334673 0 8093 202.777536 3272.085668 0 8094 6140.328490 7845.307295 0 8095 8514.943869 8194.362431 0 8096 2188.192895 6837.255867 0 8097 5770.723278 4438.285813 0 8098 8623.544570 1326.456483 0 8099 5296.931046 1690.547234 0 8100 9900.662330 9088.374790 0 8101 2115.515656 2293.146935 0 8102 856.759822 7019.959341 0 8103 7181.332487 5565.506449 0 8104 4453.911580 2599.830673 0 8105 4224.173620 2609.740644 0 8106 2911.405929 6893.986702 0 8107 1666.045996 8841.342010 0 8108 3290.162255 9463.471805 0 8109 7871.092987 8786.273884 0 8110 8786.343610 4523.154329 0 8111 2448.928487 9334.650251 0 8112 4748.800432 9469.857904 0 8113 8029.025808 4095.349855 0 8114 2209.793277 9778.645757 0 8115 3392.494985 945.537883 0 8116 9935.829559 2908.160808 0 8117 4554.469876 8415.679675 0 8118 1646.771512 9496.307820 0 8119 7243.717197 1699.399628 0 8120 9957.043005 6625.221780 0 8121 2076.599129 6394.430582 0 8122 238.606571 3898.947135 0 8123 1728.107747 8867.264980 0 8124 3645.995882 5095.701404 0 8125 9377.692019 7596.399926 0 8126 1911.161138 5366.106101 0 8127 4132.711308 6212.879436 0 8128 9310.008235 9153.354754 0 8129 6987.751686 134.433351 0 8130 5818.687819 6701.180639 0 8131 7907.590924 22.961357 0 8132 3796.683350 3519.634091 0 8133 6407.081930 2528.047342 0 8134 1341.959132 6340.669141 0 8135 3679.235410 2590.178561 0 8136 665.641233 9802.206659 0 8137 6421.459481 2525.973757 0 8138 2989.952824 200.893355 0 8139 7874.814310 3789.158352 0 8140 1575.033063 8881.220431 0 8141 2026.057122 1106.406748 0 8142 7816.576710 7652.084320 0 8143 387.986604 1893.029307 0 8144 7062.251040 1046.073538 0 8145 7335.720069 6625.423057 0 8146 3304.303713 8620.797557 0 8147 9173.545269 950.514135 0 8148 8349.949510 489.290468 0 8149 6744.968736 5574.095255 0 8150 1253.826027 2272.949807 0 8151 641.276387 1712.294813 0 8152 2346.542579 1673.398343 0 8153 5504.134761 2635.821465 0 8154 5501.869017 8950.658343 0 8155 6870.574429 1981.533077 0 8156 1316.847358 7235.587210 0 8157 2324.155948 8315.462808 0 8158 9066.550192 6173.415698 0 8159 2832.528245 2567.522540 0 8160 5805.707635 1004.258497 0 8161 4151.279062 8332.977843 0 8162 5711.873625 6729.326907 0 8163 5321.020082 1362.875055 0 8164 6051.315763 5482.883026 0 8165 9849.999792 5119.247138 0 8166 9652.132436 9772.664108 0 8167 2337.108600 5430.603412 0 8168 8358.173902 7822.154332 0 8169 4334.786306 9811.930239 0 8170 1246.797272 5528.088596 0 8171 658.811505 4730.181453 0 8172 423.715139 991.590790 0 8173 3964.797450 9223.093454 0 8174 4341.489572 1154.564343 0 8175 9000.991660 9444.362164 0 8176 5888.980166 4990.169698 0 8177 5792.479717 4378.960697 0 8178 2375.767612 6329.270790 0 8179 1259.462943 2003.892105 0 8180 2445.946905 6493.985592 0 8181 8158.053049 9083.764290 0 8182 4620.175797 205.941838 0 8183 1048.631326 9046.579229 0 8184 181.534294 380.442866 0 8185 3468.638639 4208.056128 0 8186 5884.765728 2113.626359 0 8187 3631.966304 5760.065339 0 8188 6562.638315 1956.250318 0 8189 241.800415 1649.491710 0 8190 1753.352506 2555.198051 0 8191 4809.072145 2163.246069 0 8192 7506.786853 9303.388532 0 8193 8351.084744 6012.547512 0 8194 2574.733408 78.371696 0 8195 9158.191170 4908.668451 0 8196 5999.277768 1482.332398 0 8197 7248.049659 4015.225398 0 8198 2319.068872 7230.596314 0 8199 812.743871 3472.674445 0 8200 9204.103119 1268.580133 0 8201 4069.760033 52.659813 0 8202 8286.854720 552.284466 0 8203 210.263133 1779.814330 0 8204 2753.329874 5805.223099 0 8205 5403.768272 2956.703809 0 8206 6293.617005 8912.729248 0 8207 6933.065134 235.011204 0 8208 1009.949948 6910.586048 0 8209 7952.663895 4161.712314 0 8210 2148.331070 3415.962178 0 8211 8573.272682 5890.854564 0 8212 8391.104698 2802.266396 0 8213 6741.297709 5911.061155 0 8214 996.071404 5452.762905 0 8215 4058.280906 4201.778276 0 8216 3491.763830 116.331160 0 8217 929.730750 2885.238261 0 8218 7962.650855 1320.398396 0 8219 6291.535899 46.087153 0 8220 7052.815594 6588.173805 0 8221 4854.484138 3510.388117 0 8222 3644.735677 1833.761729 0 8223 6798.756185 7970.920140 0 8224 3204.969080 8466.523212 0 8225 333.048439 6844.382663 0 8226 3762.340991 8573.097938 0 8227 4001.172936 4859.051028 0 8228 5053.652641 1761.711165 0 8229 5242.912324 4147.335869 0 8230 5035.604027 4327.510620 0 8231 4961.238062 6897.331903 0 8232 69.657449 851.466720 0 8233 2103.541759 3076.199014 0 8234 514.643300 1865.643481 0 8235 1797.086993 1392.326052 0 8236 3181.653675 2240.979729 0 8237 9706.841123 9564.979133 0 8238 9627.602494 7031.096085 0 8239 733.682552 2425.064523 0 8240 3238.647919 1016.186825 0 8241 7125.537675 6270.762151 0 8242 3243.880025 5176.473822 0 8243 2622.682046 277.927051 0 8244 5812.606024 5682.620991 0 8245 2795.268157 4609.939340 0 8246 4454.685436 9050.695400 0 8247 3312.015675 8887.666250 0 8248 9215.692907 1202.653406 0 8249 9259.942345 5915.776054 0 8250 4955.701089 5743.612679 0 8251 3455.720834 309.756771 0 8252 3095.970086 5898.825068 0 8253 763.746116 8290.734822 0 8254 8726.426942 4391.707081 0 8255 2578.164664 7165.545869 0 8256 8312.455588 6626.502368 0 8257 3239.613418 7872.529830 0 8258 1206.472078 3377.606590 0 8259 4135.399075 436.147799 0 8260 6262.216068 7822.750008 0 8261 4118.339179 6259.080757 0 8262 7673.153590 7612.561942 0 8263 9602.316613 2532.313200 0 8264 9369.492123 5415.429649 0 8265 7711.118536 3588.651986 0 8266 9191.053134 3858.838775 0 8267 8057.739009 311.680603 0 8268 9320.593387 3595.899965 0 8269 8266.410760 3954.739400 0 8270 4849.552638 2127.067572 0 8271 133.471556 9281.257571 0 8272 8846.843610 2542.735153 0 8273 5853.778040 9179.457017 0 8274 3599.702134 5985.613260 0 8275 5755.729269 5179.935253 0 8276 6190.440513 1142.865189 0 8277 1124.827236 2962.474688 0 8278 7186.137712 3892.614435 0 8279 12.417899 7964.557345 0 8280 4737.236538 3861.339901 0 8281 6906.727601 7874.868481 0 8282 362.440932 2221.330545 0 8283 1666.451605 7268.158478 0 8284 5302.724296 1777.601542 0 8285 5586.479573 3418.616084 0 8286 141.160696 9373.684090 0 8287 9298.905439 9340.023590 0 8288 6967.684693 8019.607016 0 8289 1597.359267 6842.833464 0 8290 640.577048 3352.384900 0 8291 7329.612226 5084.329086 0 8292 9592.598052 2924.539715 0 8293 6687.725002 3873.921572 0 8294 9232.300370 5165.977382 0 8295 3327.133161 3761.452565 0 8296 5345.463642 9482.080835 0 8297 3973.845649 5819.067873 0 8298 4381.719908 5672.774039 0 8299 9422.449059 4266.667892 0 8300 7459.976285 6867.915647 0 8301 1771.964691 5243.766772 0 8302 251.867908 5599.250114 0 8303 6280.302157 5823.290938 0 8304 1221.305512 5619.330932 0 8305 9842.962417 425.325063 0 8306 1034.002321 4058.970396 0 8307 5321.430748 1636.773931 0 8308 1903.241030 69.419227 0 8309 6637.986240 820.239827 0 8310 2062.035808 3814.881848 0 8311 8578.702365 8745.273126 0 8312 5883.214547 3751.176081 0 8313 2508.210504 6815.932726 0 8314 1998.283296 4768.893694 0 8315 7709.368785 5509.936062 0 8316 9484.102367 7378.189775 0 8317 5831.432643 5554.106714 0 8318 9881.907590 5307.068123 0 8319 4617.401529 4001.330458 0 8320 8273.454370 6201.156728 0 8321 7526.062219 2892.819541 0 8322 6192.369666 7915.743595 0 8323 6951.600955 9101.956635 0 8324 3353.802455 8765.958657 0 8325 4116.302654 459.285816 0 8326 4772.881245 1064.182339 0 8327 4923.907164 9312.659422 0 8328 6548.366867 5842.452696 0 8329 2971.893668 6351.902735 0 8330 5200.632532 5657.229227 0 8331 8551.314770 2428.873939 0 8332 4180.916690 4628.764978 0 8333 9246.991974 3381.749879 0 8334 7048.634418 1915.091306 0 8335 7625.073816 7950.772679 0 8336 8470.577544 1619.325377 0 8337 4729.498251 1336.866511 0 8338 774.730527 7283.544896 0 8339 3454.272142 4981.872684 0 8340 8710.401187 179.804860 0 8341 3409.294444 7239.701464 0 8342 4224.536682 9747.242690 0 8343 3114.259982 4325.019352 0 8344 9845.990601 2093.866427 0 8345 4081.054104 362.305712 0 8346 2202.857862 5780.673048 0 8347 6606.396907 5916.250369 0 8348 7206.952182 5606.248196 0 8349 8993.975904 1060.202269 0 8350 9597.973175 9200.986479 0 8351 8990.792192 3550.813556 0 8352 9640.065369 1948.513904 0 8353 8451.607756 3063.723708 0 8354 5161.255833 3821.145291 0 8355 4157.506001 8365.512007 0 8356 3134.747628 2940.269895 0 8357 2940.247330 2297.527753 0 8358 2714.795573 7012.255995 0 8359 242.227975 3273.533028 0 8360 4583.600559 4712.120815 0 8361 701.105692 1095.530457 0 8362 7408.744283 516.352222 0 8363 1055.223325 1871.234818 0 8364 1860.609133 5683.639867 0 8365 7768.256776 2663.294716 0 8366 8072.193045 1312.782163 0 8367 6003.468713 6310.618852 0 8368 2314.156348 3552.200095 0 8369 8266.053528 4035.435145 0 8370 6715.790912 1327.000778 0 8371 9765.368438 6099.211590 0 8372 840.783010 4292.315131 0 8373 8924.066901 2320.098383 0 8374 2899.608447 1699.762749 0 8375 2335.826188 3479.308912 0 8376 7941.092460 2802.252074 0 8377 4095.928659 5616.296817 0 8378 3750.804420 8833.048482 0 8379 5760.642334 9241.278951 0 8380 14.457824 5646.812975 0 8381 1896.357108 5216.587111 0 8382 1998.842873 7716.686453 0 8383 1309.936336 2161.611231 0 8384 5174.986455 6061.688259 0 8385 7085.983627 334.951396 0 8386 7083.443821 276.951691 0 8387 1975.873521 1540.864093 0 8388 13.816225 3817.561378 0 8389 3472.440799 234.505509 0 8390 704.204007 6402.302590 0 8391 423.354421 8472.709282 0 8392 9810.429209 1680.801589 0 8393 1397.313526 2644.796849 0 8394 7227.806084 3713.596246 0 8395 4334.215137 2324.995486 0 8396 3214.144559 420.665516 0 8397 7132.153156 2739.195445 0 8398 6030.019218 3327.135921 0 8399 5727.552332 7335.400751 0 8400 3046.873141 1268.767984 0 8401 7292.934707 9956.511206 0 8402 2488.271269 492.269328 0 8403 7037.495490 3681.325344 0 8404 9143.062961 1356.816563 0 8405 1471.966634 5111.468533 0 8406 9793.684245 4696.002137 0 8407 4075.296395 1794.177470 0 8408 8965.268181 9978.261433 0 8409 1385.906906 5030.302496 0 8410 8031.169066 6138.135980 0 8411 2236.043534 8122.368886 0 8412 5293.446101 1431.096875 0 8413 7751.536805 2395.425691 0 8414 2856.708418 8773.221861 0 8415 5769.442425 6868.416896 0 8416 9009.200711 6946.141317 0 8417 8161.968516 4747.196615 0 8418 6971.746531 5732.268971 0 8419 7455.425953 1398.155893 0 8420 2732.162131 3209.962434 0 8421 7821.960575 2086.722020 0 8422 189.558957 3010.920895 0 8423 5234.660045 5967.917456 0 8424 8619.001269 8433.185999 0 8425 5344.664705 2182.699622 0 8426 3435.352773 2020.652952 0 8427 6829.461031 2369.755774 0 8428 8805.730435 8771.218638 0 8429 2811.728299 4211.217700 0 8430 1137.431473 9741.241290 0 8431 4066.594270 3633.292472 0 8432 6107.697133 6195.743597 0 8433 9957.178626 7153.859596 0 8434 6965.359972 7708.947298 0 8435 9458.408766 3426.207551 0 8436 1613.216905 1024.907276 0 8437 9303.690687 4440.393385 0 8438 4615.384696 8824.101063 0 8439 2543.272807 4305.802254 0 8440 2966.138081 2056.845527 0 8441 8142.851668 8248.432270 0 8442 8060.332328 1043.672060 0 8443 6486.859007 1720.849396 0 8444 9282.668969 3760.382042 0 8445 8356.939294 1737.931075 0 8446 4813.399554 2145.865417 0 8447 3754.616201 2227.288220 0 8448 2814.682817 6781.961219 0 8449 2419.326899 5030.860569 0 8450 1352.669028 8878.709269 0 8451 6333.394011 8738.807964 0 8452 7471.816854 5589.124506 0 8453 4117.487031 3848.716305 0 8454 8569.874114 3921.296631 0 8455 5056.734806 4881.960730 0 8456 6037.139184 4338.156655 0 8457 7596.781905 4477.014343 0 8458 8575.242605 3967.357008 0 8459 4987.366142 883.198296 0 8460 6933.182351 6911.903669 0 8461 6247.051350 3462.725148 0 8462 9724.585582 4451.090702 0 8463 5598.630289 6014.032056 0 8464 9145.354540 6249.154075 0 8465 1050.201862 3568.626354 0 8466 4331.326501 5755.240815 0 8467 9381.649579 7925.087903 0 8468 5004.916327 2677.359865 0 8469 530.030228 6589.800957 0 8470 5106.575207 5451.371674 0 8471 5890.665329 9328.505839 0 8472 4246.003661 2317.827368 0 8473 5801.592845 302.703748 0 8474 1294.078037 1273.073812 0 8475 7421.754314 8303.575000 0 8476 8307.332516 6804.857598 0 8477 9646.407142 3445.157642 0 8478 8918.776713 8471.109295 0 8479 8839.771069 9883.497904 0 8480 8812.579646 7030.040712 0 8481 2655.977982 3160.445884 0 8482 5401.592990 5272.077870 0 8483 6603.458547 2040.942067 0 8484 1419.473380 4560.363468 0 8485 3791.159823 4995.594118 0 8486 2811.383100 3626.799699 0 8487 4212.189673 5182.826334 0 8488 9778.675986 5528.759135 0 8489 7443.222205 1741.179174 0 8490 536.366975 1498.757886 0 8491 1344.023544 4223.661381 0 8492 7388.061539 3352.156429 0 8493 2674.027946 5560.012049 0 8494 1959.782796 9188.897847 0 8495 1768.296156 4033.226677 0 8496 7560.974719 777.450081 0 8497 3198.927627 4956.237464 0 8498 3184.774172 5768.388420 0 8499 3161.146569 1938.640837 0 8500 9401.305909 218.689061 0 8501 2287.705996 9020.768968 0 8502 3818.277964 4916.081408 0 8503 9462.469383 8839.681740 0 8504 1632.573642 9658.913151 0 8505 7462.082359 9981.397210 0 8506 649.253659 9577.807382 0 8507 9483.496071 6178.912428 0 8508 300.298262 799.115899 0 8509 4019.254019 5242.662237 0 8510 8981.114819 1010.761770 0 8511 9442.079721 3338.114976 0 8512 1556.106473 5268.004329 0 8513 6128.962342 6624.029617 0 8514 6149.788288 7794.968983 0 8515 7520.934978 7164.475969 0 8516 9580.248862 2638.108994 0 8517 4164.451228 1323.841982 0 8518 3199.660072 2226.651457 0 8519 2920.836529 1029.611030 0 8520 5996.936324 3360.814068 0 8521 5094.514045 2321.083716 0 8522 6840.420497 6685.014771 0 8523 9710.584872 4330.309308 0 8524 3740.687262 328.033563 0 8525 4771.312775 6575.099673 0 8526 8596.568039 9030.489936 0 8527 4102.909278 7482.489554 0 8528 2418.412521 9761.366718 0 8529 2455.947915 7996.158636 0 8530 3234.139036 2583.349891 0 8531 3013.718172 1843.977488 0 8532 4059.075434 2910.844253 0 8533 1335.121385 4092.171516 0 8534 500.294444 8933.541437 0 8535 6475.598224 1308.479320 0 8536 6176.436406 2143.639012 0 8537 3583.636650 326.420740 0 8538 1863.246549 14.448916 0 8539 9713.472174 7817.534922 0 8540 714.719549 5684.727336 0 8541 8035.262030 2729.502106 0 8542 8132.435138 5433.724019 0 8543 3878.050946 2163.220773 0 8544 5586.039216 6670.315693 0 8545 2814.008665 2299.445744 0 8546 7314.582178 3073.943272 0 8547 5262.171909 96.640710 0 8548 2314.294432 2384.411663 0 8549 8819.635878 1684.218060 0 8550 9657.982239 2074.167420 0 8551 1085.187088 2279.338300 0 8552 8365.800976 4115.628478 0 8553 1551.302945 6878.671819 0 8554 6369.078584 1966.065555 0 8555 7173.572133 6848.205903 0 8556 4040.094482 2737.233912 0 8557 9368.675578 2293.560626 0 8558 9501.653532 2368.282941 0 8559 3133.073998 4321.347326 0 8560 1374.374231 5625.000328 0 8561 3139.528267 510.318134 0 8562 623.470580 9357.515668 0 8563 3879.248631 6973.649454 0 8564 1654.817605 5797.933086 0 8565 5595.318762 6287.650958 0 8566 5090.558427 4883.359510 0 8567 5730.254854 2162.253757 0 8568 1312.879215 4367.096226 0 8569 9173.217787 6788.957615 0 8570 8289.794541 3002.794200 0 8571 6662.594040 5482.093939 0 8572 5479.781583 4592.215663 0 8573 1039.393473 6923.018978 0 8574 8874.611037 6256.982208 0 8575 3313.471903 8925.624740 0 8576 3318.499558 9133.497424 0 8577 7317.650162 4452.296664 0 8578 8594.077843 3334.322033 0 8579 6387.252832 1989.111383 0 8580 2552.641194 5496.786646 0 8581 9625.652549 1089.111497 0 8582 6258.511875 2623.087806 0 8583 3561.857041 5005.811526 0 8584 3754.537356 6432.091018 0 8585 3021.643752 6824.901020 0 8586 4242.837415 6765.775259 0 8587 805.144095 2411.175534 0 8588 7138.353168 9320.799126 0 8589 7199.120130 57.082241 0 8590 5642.645789 170.830337 0 8591 9270.153836 2628.870488 0 8592 6593.894348 4689.188393 0 8593 3793.278039 2635.672419 0 8594 5720.132755 4119.790925 0 8595 5193.074501 8589.141001 0 8596 8326.943069 4618.368429 0 8597 2165.849178 6172.753291 0 8598 7135.603789 818.283020 0 8599 8916.657207 2741.686037 0 8600 8122.884599 1154.762720 0 8601 2926.829015 4350.393460 0 8602 1297.975959 3586.781699 0 8603 955.702738 1438.585497 0 8604 8274.103069 7698.807460 0 8605 7550.207245 1669.299289 0 8606 4165.054182 7536.932116 0 8607 9946.518431 7026.412420 0 8608 2502.638272 9405.164342 0 8609 2711.644426 2590.623280 0 8610 4280.292004 1462.902558 0 8611 191.559456 942.469156 0 8612 8182.413952 7286.908496 0 8613 6576.702010 4095.343253 0 8614 310.474666 2011.010164 0 8615 9634.471474 5799.810398 0 8616 35.819225 5122.948800 0 8617 2298.334580 9680.254153 0 8618 2577.012165 7723.714373 0 8619 6805.327284 6363.678942 0 8620 9850.575560 6099.581191 0 8621 9923.048311 915.321014 0 8622 9969.926004 4421.245993 0 8623 8261.339115 4344.218138 0 8624 4989.017476 6031.519516 0 8625 2707.142121 3995.774360 0 8626 7061.596045 2533.673103 0 8627 2789.334379 3534.498363 0 8628 4603.659081 2284.991502 0 8629 9969.983471 1099.996398 0 8630 5934.137178 8864.813655 0 8631 9766.667343 4385.060208 0 8632 2136.756643 5440.017304 0 8633 8660.931298 1748.600213 0 8634 5714.755582 2452.087528 0 8635 3543.973745 6519.154164 0 8636 9580.969907 82.788145 0 8637 571.245631 8734.535148 0 8638 6537.933095 4674.661014 0 8639 2426.933483 785.339637 0 8640 4188.729769 8643.230928 0 8641 8601.418918 3591.040388 0 8642 6306.425057 4038.653437 0 8643 662.224351 2334.638228 0 8644 4946.693939 680.458371 0 8645 757.068021 8954.523659 0 8646 5870.757693 3607.784089 0 8647 9460.647430 2246.713899 0 8648 831.106249 8431.431723 0 8649 7725.775773 9270.617806 0 8650 756.312328 8652.114207 0 8651 9392.853103 8765.037988 0 8652 4874.638787 3308.803403 0 8653 8135.941236 2867.821859 0 8654 8210.535269 3117.890961 0 8655 1884.741601 8679.790233 0 8656 8387.067034 7084.298976 0 8657 9024.391892 4710.349068 0 8658 8438.238384 6130.975608 0 8659 346.114817 4391.699274 0 8660 8603.180380 7874.196107 0 8661 8402.049224 3270.530436 0 8662 9070.770180 2543.165505 0 8663 1911.215459 923.757712 0 8664 532.211869 8105.814754 0 8665 6756.286318 4255.375361 0 8666 5761.699545 4173.539073 0 8667 8997.845739 6513.719460 0 8668 2272.231539 3808.940545 0 8669 6894.369864 5759.156248 0 8670 7168.456166 2570.744530 0 8671 447.863205 2154.000920 0 8672 9944.915258 2673.655344 0 8673 8988.456438 6561.547240 0 8674 5191.685949 1336.066121 0 8675 5711.328252 6003.062526 0 8676 6894.517640 1679.360596 0 8677 4900.810468 8433.513612 0 8678 8491.829729 5812.787757 0 8679 3704.957611 6396.628417 0 8680 9052.545990 7044.650813 0 8681 5308.539698 1243.319056 0 8682 3351.111083 494.874927 0 8683 6221.686316 9287.410217 0 8684 2795.604507 5196.007193 0 8685 6133.388189 2777.750969 0 8686 217.879163 1459.898869 0 8687 469.892390 1240.457951 0 8688 2385.840513 6741.418177 0 8689 9652.223634 9310.595486 0 8690 7241.837471 1575.223129 0 8691 2826.940596 6164.293929 0 8692 3053.696495 9929.186434 0 8693 8554.137720 1756.340108 0 8694 9794.106023 9982.851322 0 8695 1401.800315 6093.775641 0 8696 3041.649274 4921.420226 0 8697 6175.659666 1208.748906 0 8698 4045.092066 7192.654921 0 8699 1488.466844 830.637107 0 8700 2373.191624 4688.641176 0 8701 5989.148931 2495.281898 0 8702 8832.747605 2531.757172 0 8703 5687.724945 1285.688083 0 8704 7855.410841 2546.817443 0 8705 3306.531443 4696.505340 0 8706 287.745457 4120.799970 0 8707 7473.187852 3708.698955 0 8708 6586.188405 7869.802014 0 8709 6898.108203 6209.138435 0 8710 6410.200534 3112.001749 0 8711 8735.026158 1600.527383 0 8712 2820.409130 8827.859232 0 8713 8120.989000 9413.515803 0 8714 4598.362335 1523.579906 0 8715 7353.192959 940.324881 0 8716 1960.654883 7708.862062 0 8717 4083.637485 3557.380411 0 8718 1973.913551 4672.561477 0 8719 8004.688420 9014.605173 0 8720 1800.928155 9891.273082 0 8721 8113.361034 8245.765192 0 8722 6150.899925 7572.170896 0 8723 1396.193625 9472.995603 0 8724 6126.865389 9556.431569 0 8725 2148.589615 938.694196 0 8726 7865.430067 7593.978782 0 8727 1074.763384 7908.274894 0 8728 5802.029319 8174.084810 0 8729 4994.665414 9083.533595 0 8730 7749.167165 8029.483927 0 8731 1215.762861 4426.411260 0 8732 947.362123 5206.936152 0 8733 8191.781620 6104.073322 0 8734 726.209325 9495.171167 0 8735 928.568206 7342.780517 0 8736 8291.220960 1675.379378 0 8737 3028.623030 1430.768753 0 8738 7875.064560 2354.074211 0 8739 9647.411182 1231.539411 0 8740 1280.057132 6943.765304 0 8741 5544.042634 3063.178502 0 8742 7275.927677 248.798813 0 8743 6832.555151 8689.067670 0 8744 2365.318926 5152.263370 0 8745 9917.219750 6915.173754 0 8746 6714.434277 5407.278002 0 8747 7806.735479 4874.816432 0 8748 3004.873510 5185.470735 0 8749 101.772413 4919.127371 0 8750 3686.064715 5604.014433 0 8751 9781.656476 6962.018444 0 8752 4297.132735 1848.011015 0 8753 9441.429242 477.417898 0 8754 1438.303568 7528.348272 0 8755 9537.300209 9385.513740 0 8756 2137.019534 9135.823753 0 8757 3232.496627 8074.199004 0 8758 2098.681344 7527.487590 0 8759 4852.337780 2716.555700 0 8760 6365.786842 1098.159551 0 8761 8181.260429 5627.663088 0 8762 9809.116984 9277.514100 0 8763 7861.306770 1440.637859 0 8764 6147.249762 1718.543077 0 8765 6842.638544 9492.130518 0 8766 1423.257256 1270.809928 0 8767 5559.758907 3177.684331 0 8768 6623.415664 2832.222424 0 8769 6887.698178 1647.710900 0 8770 9886.697183 4680.934179 0 8771 9793.060591 9739.275404 0 8772 8697.983652 4085.065011 0 8773 5217.143804 4283.250775 0 8774 6827.146291 3056.878739 0 8775 4156.266123 8939.490841 0 8776 2023.962556 4223.358097 0 8777 2298.270469 5092.073427 0 8778 8746.628303 6311.962611 0 8779 7062.167008 348.992547 0 8780 3785.464665 2378.286208 0 8781 3530.478722 2399.080939 0 8782 14.727328 4347.590684 0 8783 6701.417743 2707.555065 0 8784 6001.216396 4091.080118 0 8785 8913.256334 6913.464495 0 8786 4575.212850 7460.893323 0 8787 5022.901892 5554.238069 0 8788 7489.344267 6218.746915 0 8789 4741.404774 7850.676721 0 8790 7149.273967 7001.428506 0 8791 1196.351903 79.409458 0 8792 1192.438491 7343.550507 0 8793 4551.943500 3736.310196 0 8794 1469.568483 5297.783708 0 8795 3875.010596 4742.314146 0 8796 3843.323398 5064.780081 0 8797 2145.882091 233.061047 0 8798 378.508408 8213.862366 0 8799 4980.632412 9416.460989 0 8800 7045.540390 5910.330408 0 8801 220.848508 2351.236455 0 8802 8212.662645 9396.562721 0 8803 7761.937740 5995.339670 0 8804 7165.479165 9100.680839 0 8805 5489.160630 2416.656368 0 8806 8141.697505 6936.655374 0 8807 3639.074719 8485.690500 0 8808 3633.674803 3404.512918 0 8809 4369.166790 4029.300620 0 8810 8021.820430 163.437956 0 8811 9927.644249 4228.654854 0 8812 5795.784332 8796.082346 0 8813 8299.398186 999.479219 0 8814 3311.375053 3564.461042 0 8815 1418.136275 5693.832159 0 8816 9139.678279 8558.603310 0 8817 9171.462965 4690.040498 0 8818 2929.054226 3453.694429 0 8819 6886.968181 6198.490424 0 8820 3007.628774 144.123174 0 8821 8456.638024 5736.809097 0 8822 9998.219076 4979.158410 0 8823 3666.221615 8567.486318 0 8824 1041.566094 5748.211960 0 8825 1793.198655 39.798870 0 8826 61.213071 4932.037055 0 8827 5384.159185 660.668892 0 8828 438.574573 1423.689307 0 8829 1560.895145 4243.362192 0 8830 3122.602252 3255.339344 0 8831 5127.163378 2174.531607 0 8832 5009.417398 9253.809742 0 8833 7823.458447 450.145081 0 8834 2138.659634 8826.696133 0 8835 3518.686696 1489.491231 0 8836 8235.563161 8853.445534 0 8837 9599.586151 195.723199 0 8838 6951.149993 7433.987018 0 8839 8699.095499 6535.979370 0 8840 6345.806238 3689.890048 0 8841 1881.064384 3901.564833 0 8842 846.875302 4291.189024 0 8843 3751.992926 9013.142073 0 8844 5503.257228 6967.622946 0 8845 1471.704357 4316.568983 0 8846 3722.911211 6441.798686 0 8847 3543.170151 8251.352596 0 8848 6455.530465 4880.376472 0 8849 2254.733966 1719.413793 0 8850 5232.062546 1362.911257 0 8851 3376.174416 3650.798110 0 8852 5417.215646 2556.811995 0 8853 2944.381099 1515.747129 0 8854 5308.226099 8424.488073 0 8855 5245.105257 2188.699984 0 8856 7446.257526 2383.741820 0 8857 2054.849049 6687.255645 0 8858 9450.079074 9728.608151 0 8859 373.953541 6388.327246 0 8860 2756.134386 4934.966969 0 8861 2265.051446 4173.623590 0 8862 9582.115918 6157.591869 0 8863 7967.292416 1175.269403 0 8864 1603.670851 5719.485751 0 8865 9745.726197 7638.441402 0 8866 3466.020504 2153.374833 0 8867 6536.275473 9320.507562 0 8868 1274.307174 5872.386083 0 8869 7341.039759 9576.843759 0 8870 8833.027356 5545.420510 0 8871 7528.241834 6230.174109 0 8872 9293.654420 8452.025710 0 8873 9095.769722 9623.486661 0 8874 5391.549445 5970.072766 0 8875 5649.924556 3891.202868 0 8876 2165.737167 6059.042106 0 8877 2558.244795 8601.811914 0 8878 9102.014166 184.131082 0 8879 1475.856807 1340.624308 0 8880 1163.010968 784.328860 0 8881 8951.212616 1887.235510 0 8882 2389.850054 3151.302718 0 8883 8866.699325 7338.827727 0 8884 9310.986116 6313.550631 0 8885 7418.085758 4435.699985 0 8886 2045.643702 403.098871 0 8887 9426.069136 7916.025271 0 8888 8370.845515 7062.467224 0 8889 472.305894 4170.056703 0 8890 5725.096921 9767.289223 0 8891 7458.811078 7504.554106 0 8892 9113.103496 8605.176288 0 8893 8376.561341 4501.160371 0 8894 1458.547525 4352.489006 0 8895 986.595599 4407.065023 0 8896 4851.123413 6080.099740 0 8897 9479.596548 9266.660473 0 8898 8672.360993 5555.238414 0 8899 7778.763588 7856.533650 0 8900 1450.025348 7839.786403 0 8901 3966.316651 5316.012134 0 8902 925.084150 7411.652563 0 8903 3538.623940 3439.659875 0 8904 34.557783 6383.804469 0 8905 5981.385624 7470.877664 0 8906 5701.740538 8145.026883 0 8907 9041.684056 5223.439535 0 8908 8085.624193 7520.742650 0 8909 4170.841908 2547.900991 0 8910 3114.442290 1961.493525 0 8911 9766.763471 9202.827077 0 8912 1062.402205 8862.185003 0 8913 7237.481672 4926.689434 0 8914 1107.304997 1387.909076 0 8915 9614.144174 5204.206611 0 8916 230.840085 2629.789945 0 8917 537.884075 3933.578134 0 8918 8578.167858 7405.917869 0 8919 3830.769545 5138.194896 0 8920 3349.850593 3102.855003 0 8921 2827.090722 5220.528817 0 8922 7912.550859 7159.982893 0 8923 1550.262131 6243.289091 0 8924 1647.394593 4546.465674 0 8925 8155.340922 7194.812210 0 8926 1235.453507 4115.987605 0 8927 8625.556595 5399.074596 0 8928 3526.414822 3521.672612 0 8929 4318.400433 1314.294984 0 8930 7183.261409 8015.145070 0 8931 5942.510023 1323.048825 0 8932 8920.558237 3658.214979 0 8933 9756.860828 9708.223415 0 8934 3601.955041 6891.373969 0 8935 8786.600022 8191.003026 0 8936 1854.808247 5709.901887 0 8937 7931.683880 8296.407647 0 8938 534.732127 3788.936321 0 8939 6460.162871 6112.158568 0 8940 1052.547261 1016.090717 0 8941 9202.327352 8534.759580 0 8942 2555.021119 7120.653848 0 8943 4669.437631 1282.355841 0 8944 9255.214332 4556.973017 0 8945 1035.570783 3416.530112 0 8946 9701.126244 219.468132 0 8947 5618.248706 6515.949828 0 8948 5814.101214 1796.787880 0 8949 9420.892788 7279.310221 0 8950 1268.524918 4319.752102 0 8951 7145.456719 6077.847237 0 8952 2561.532420 2274.071480 0 8953 2335.215437 9237.563502 0 8954 8462.343042 3804.855593 0 8955 9433.083161 8609.774840 0 8956 2741.301703 7283.147569 0 8957 3198.807180 5207.715435 0 8958 5057.163580 7320.873893 0 8959 4324.533289 2309.578511 0 8960 7209.536462 3761.974307 0 8961 1228.378155 2104.780632 0 8962 299.496685 306.720408 0 8963 8325.810780 212.318523 0 8964 729.142547 1269.560091 0 8965 8715.019544 8763.261942 0 8966 1457.948650 2987.708433 0 8967 9848.152779 5031.237122 0 8968 3972.196508 5764.470781 0 8969 6269.770930 3188.564224 0 8970 6312.770084 8000.238491 0 8971 9091.914624 1329.817098 0 8972 9436.900301 8622.738294 0 8973 8520.499186 4298.025763 0 8974 8689.849461 3846.084543 0 8975 7022.181544 614.902965 0 8976 7238.311522 5795.686751 0 8977 2708.036022 7768.491524 0 8978 4762.535056 1613.526635 0 8979 5913.027198 2227.544709 0 8980 6391.097274 4827.450784 0 8981 9721.134845 5960.640059 0 8982 2167.741524 5944.312530 0 8983 8831.116457 4506.333802 0 8984 4245.622154 1717.958248 0 8985 8881.565432 7349.576340 0 8986 7142.396706 5020.812937 0 8987 6725.777721 9295.766735 0 8988 5755.387002 9878.141700 0 8989 6203.064824 6611.604847 0 8990 1465.612896 8120.143858 0 8991 4248.594055 7875.144948 0 8992 4375.203159 6132.474580 0 8993 2862.806420 1041.462698 0 8994 3361.880413 5632.128383 0 8995 3734.948645 3594.517622 0 8996 3393.647870 3894.973825 0 8997 3858.310169 428.379558 0 8998 2424.009557 8443.981110 0 8999 4911.019810 5122.147244 0 9000 1419.722548 96.498358 0 9001 9001.246901 4776.043675 0 9002 2853.729369 9390.696689 0 9003 4584.713425 3690.291872 0 9004 5065.857412 1156.026628 0 9005 5148.553999 9091.243362 0 9006 3095.544984 3419.449330 0 9007 2960.595138 3683.144471 0 9008 9585.312968 7006.115783 0 9009 8679.076490 3847.488951 0 9010 6630.081203 7625.205803 0 9011 4857.933033 7720.230956 0 9012 96.088000 6000.162430 0 9013 9040.338818 2793.845813 0 9014 4935.629544 7666.028588 0 9015 5071.410846 6150.520555 0 9016 9464.793346 8356.166593 0 9017 2675.818797 451.708559 0 9018 7397.603384 863.445657 0 9019 4185.906737 3743.642772 0 9020 9367.953161 4247.167104 0 9021 2776.483913 6347.249320 0 9022 8508.312518 135.292713 0 9023 230.585430 9784.746549 0 9024 7062.667695 1813.958376 0 9025 3571.744585 3236.600433 0 9026 9339.764306 7229.193582 0 9027 5034.298257 3338.487191 0 9028 2380.517468 6208.978355 0 9029 3047.347872 7291.546845 0 9030 6185.406230 9402.936565 0 9031 69.203622 1306.905512 0 9032 9023.115815 3590.451338 0 9033 7382.804011 3913.409424 0 9034 6536.790206 2708.067278 0 9035 562.012264 8624.526872 0 9036 5931.194111 7128.231928 0 9037 3064.353036 7670.368129 0 9038 674.109663 9867.433235 0 9039 9961.139452 7591.304348 0 9040 360.064360 200.095392 0 9041 1007.217615 3934.444371 0 9042 6269.352401 4961.191560 0 9043 4932.931397 412.964947 0 9044 7342.495877 6541.862253 0 9045 4676.864253 5859.239341 0 9046 5273.586201 7099.397658 0 9047 7444.410204 6869.801855 0 9048 3798.693663 486.591179 0 9049 5625.909723 3253.651151 0 9050 193.137770 4309.300406 0 9051 1285.460085 5858.450701 0 9052 4577.376427 8080.385818 0 9053 9848.114241 4181.022918 0 9054 9111.910559 9816.199952 0 9055 5114.181824 3647.658730 0 9056 5398.690151 9737.024498 0 9057 2163.700891 3399.650610 0 9058 249.486475 8979.003411 0 9059 4872.342059 1485.220645 0 9060 8407.031039 4901.863433 0 9061 9933.593929 2572.343883 0 9062 1358.402692 9588.092123 0 9063 5696.409992 7865.903122 0 9064 3231.191663 2528.387349 0 9065 9804.103759 5550.722458 0 9066 1092.717573 6669.126763 0 9067 7247.454753 5148.358461 0 9068 3948.551143 4962.588595 0 9069 1419.706640 7819.784319 0 9070 8119.217622 6454.980355 0 9071 451.650566 584.853964 0 9072 8481.961538 9158.143513 0 9073 7528.556537 1119.931167 0 9074 7649.170150 2328.986531 0 9075 5189.478014 5544.444503 0 9076 3901.966168 3432.352336 0 9077 197.768724 7999.990571 0 9078 4122.806987 3257.051868 0 9079 6395.868972 9052.944741 0 9080 3626.348260 8741.043611 0 9081 2252.164678 2396.569532 0 9082 9734.144950 8953.856021 0 9083 4651.615917 5693.334943 0 9084 2164.733195 7658.820577 0 9085 5523.233206 3415.114440 0 9086 9984.982348 185.528349 0 9087 8937.117289 7359.329369 0 9088 216.777527 1268.352193 0 9089 9145.273732 9142.703070 0 9090 8070.009654 9546.391906 0 9091 3866.801282 8538.439497 0 9092 9595.989930 6211.509944 0 9093 4029.964937 9982.380740 0 9094 7631.625356 2675.037125 0 9095 8178.932010 9563.792944 0 9096 7697.585241 2148.530061 0 9097 7124.078605 4209.074758 0 9098 1851.297666 1158.567079 0 9099 9592.932316 5007.120523 0 9100 3596.735604 6801.682152 0 9101 9035.216826 2023.186358 0 9102 9502.073870 3909.850723 0 9103 9672.017706 6150.247511 0 9104 9493.769137 4724.870242 0 9105 6964.496238 7582.019364 0 9106 984.047698 9071.860353 0 9107 7672.606787 1611.291966 0 9108 6554.569894 7708.000221 0 9109 647.484666 604.465232 0 9110 4642.579968 3846.211034 0 9111 2542.507168 6959.101515 0 9112 4608.330401 2602.963823 0 9113 1217.596491 4077.587203 0 9114 3125.063945 1411.135827 0 9115 3702.218730 5787.147035 0 9116 9738.291712 6773.930289 0 9117 1135.143062 2725.127335 0 9118 3144.212849 6261.767597 0 9119 9668.650513 6718.514279 0 9120 1535.431995 7008.836274 0 9121 4256.074824 7386.952059 0 9122 474.736034 3601.257984 0 9123 9643.770169 6228.972500 0 9124 3131.814802 2531.603461 0 9125 4290.690182 8063.025452 0 9126 7531.197098 2665.842733 0 9127 5803.038755 7137.972762 0 9128 841.219545 6604.905780 0 9129 621.768831 9950.224063 0 9130 6722.716021 8132.635461 0 9131 5847.076843 8386.506147 0 9132 7959.663896 5524.692980 0 9133 8100.246664 6793.034983 0 9134 2363.692088 1415.940901 0 9135 6799.032045 8776.141821 0 9136 1428.903360 9530.480232 0 9137 8538.997954 9004.054119 0 9138 4807.213154 2171.579801 0 9139 1301.970736 3641.240289 0 9140 8071.929352 5759.448237 0 9141 2031.711199 8460.174258 0 9142 2809.615541 8496.877576 0 9143 1623.775817 2946.960141 0 9144 1586.576892 2458.594181 0 9145 4928.421118 3751.244329 0 9146 6318.775300 1746.419255 0 9147 291.841288 818.598470 0 9148 7353.248755 9400.206638 0 9149 1573.506081 6432.602298 0 9150 1465.069212 9119.169174 0 9151 3877.282512 824.227254 0 9152 9710.607479 5246.083638 0 9153 5344.860860 3719.320476 0 9154 7111.402286 7769.982324 0 9155 9641.007440 6578.426223 0 9156 1978.071404 3441.899825 0 9157 1601.773739 8069.775241 0 9158 6422.176051 6218.120342 0 9159 8120.691174 5615.629179 0 9160 688.578928 4345.815776 0 9161 5504.901037 2335.422214 0 9162 4002.880410 2347.834612 0 9163 7797.878640 2752.527945 0 9164 4848.362459 1835.771280 0 9165 5598.161444 7405.675451 0 9166 3562.447749 8000.957315 0 9167 3738.740145 2868.897250 0 9168 2101.557333 4549.118670 0 9169 5990.723819 381.846502 0 9170 940.123851 6816.070111 0 9171 1207.549367 3327.357605 0 9172 7081.285245 3167.989752 0 9173 3186.654280 7686.271719 0 9174 5326.954228 5897.106577 0 9175 9303.348736 9220.796741 0 9176 3637.724243 7460.603731 0 9177 7569.031169 1784.366602 0 9178 70.051623 6612.660030 0 9179 9057.442205 7978.709902 0 9180 8075.616467 8307.020554 0 9181 6128.005051 8514.180938 0 9182 8319.163630 4825.127131 0 9183 1311.046543 9800.938225 0 9184 6370.019319 1411.804191 0 9185 9602.175653 5233.637274 0 9186 8263.137412 5825.112725 0 9187 7057.941478 7598.738514 0 9188 9959.472853 3993.503634 0 9189 5039.207455 465.169325 0 9190 9131.775102 6579.648989 0 9191 5914.087678 8787.836788 0 9192 684.343593 2130.769544 0 9193 9873.574405 9274.219399 0 9194 2838.193921 8335.649260 0 9195 2143.098053 3851.368383 0 9196 7352.507835 6165.574467 0 9197 6645.466639 1723.939728 0 9198 2150.933990 3088.807795 0 9199 4396.487313 2667.641909 0 9200 3369.262871 9128.853287 0 9201 6382.214292 9951.082878 0 9202 7632.949111 9714.042969 0 9203 7436.812547 6192.761711 0 9204 2061.258493 3397.907900 0 9205 8706.686648 174.957550 0 9206 9736.214883 8141.861297 0 9207 2381.779581 8464.449920 0 9208 942.525369 4102.103847 0 9209 8016.378019 8539.694016 0 9210 625.188934 4255.415166 0 9211 8029.608505 4100.204565 0 9212 3735.682998 9483.914360 0 9213 1427.733863 2386.699027 0 9214 6226.787094 5255.396305 0 9215 3499.894410 1945.557672 0 9216 5841.839846 7712.577765 0 9217 449.409295 1780.677713 0 9218 4773.086317 6448.008037 0 9219 3078.339705 7736.757388 0 9220 1530.235756 1593.897238 0 9221 3494.290095 4833.414742 0 9222 9242.600996 6137.069386 0 9223 7768.552275 7428.405842 0 9224 5940.739542 4909.816371 0 9225 4622.457291 1298.602763 0 9226 6787.122176 6619.269560 0 9227 8512.346292 6539.721440 0 9228 487.920314 1569.651994 0 9229 3741.616992 3466.849424 0 9230 1440.627133 8650.083807 0 9231 7570.786396 9337.073688 0 9232 8907.309810 9299.823015 0 9233 3413.820673 8258.373717 0 9234 4748.207248 8900.544322 0 9235 8069.515993 1234.499135 0 9236 4392.212656 5497.491202 0 9237 5135.471637 7268.750645 0 9238 5459.330350 6147.209316 0 9239 7621.960177 3883.580637 0 9240 3052.164759 164.243255 0 9241 7510.675630 5427.194865 0 9242 7830.046535 4243.191005 0 9243 4776.196793 6936.040565 0 9244 8867.091523 3658.019908 0 9245 7850.867885 6527.825234 0 9246 1210.834029 7128.407022 0 9247 8210.905822 6634.810543 0 9248 1642.498412 8541.180851 0 9249 5472.457186 7812.424082 0 9250 5840.679348 9712.288712 0 9251 1905.042527 9414.995017 0 9252 8029.760862 5781.964925 0 9253 9660.539974 258.021514 0 9254 315.592957 648.646567 0 9255 440.095681 3373.661425 0 9256 3341.388959 501.538236 0 9257 6533.393309 2883.155878 0 9258 9054.687410 2437.370508 0 9259 6030.349338 5181.373672 0 9260 9352.403436 4789.428662 0 9261 9400.231942 8634.002407 0 9262 2518.445277 836.101727 0 9263 6645.143296 2214.568902 0 9264 1306.322102 7167.372004 0 9265 927.880916 739.242322 0 9266 3610.038181 8798.484460 0 9267 5019.804274 1815.787102 0 9268 4016.311757 4653.323228 0 9269 3977.734108 2278.072593 0 9270 9652.435773 2942.258178 0 9271 9573.479751 9643.224546 0 9272 7124.459278 8232.354920 0 9273 9861.601416 5511.382309 0 9274 9864.162394 3982.891807 0 9275 3435.503188 3092.188807 0 9276 5168.684210 364.526123 0 9277 7804.024668 5110.354076 0 9278 1716.725214 1311.683736 0 9279 7507.318243 3482.368740 0 9280 6368.446595 7857.806236 0 9281 4282.023210 8987.378099 0 9282 3512.706351 5522.953026 0 9283 7343.257949 519.807935 0 9284 6653.402117 9365.518639 0 9285 583.472902 44.002626 0 9286 559.427067 1058.372896 0 9287 1269.921079 8623.785933 0 9288 8068.719561 2019.512647 0 9289 4185.963229 7007.214263 0 9290 306.497479 4620.817415 0 9291 6210.504256 2451.323095 0 9292 6978.683428 8568.497125 0 9293 2684.916920 3367.017671 0 9294 5070.724535 8208.101109 0 9295 2910.693158 9376.784987 0 9296 5798.216481 9941.329699 0 9297 4518.166969 5256.058452 0 9298 6911.245607 7362.728057 0 9299 5351.186328 5646.924642 0 9300 9817.960239 5625.478932 0 9301 9141.759607 3217.247893 0 9302 7586.313965 5938.927939 0 9303 4108.306789 235.924183 0 9304 8916.330588 4907.152487 0 9305 8688.342995 8175.289549 0 9306 2890.488682 6032.013946 0 9307 8382.118859 6748.181983 0 9308 8323.105599 4531.435708 0 9309 1706.405529 842.995373 0 9310 8703.907485 1536.241452 0 9311 6409.879751 3311.436905 0 9312 5956.441768 4524.187568 0 9313 2636.373614 2092.098839 0 9314 1031.003806 5371.577819 0 9315 2944.287497 7760.643577 0 9316 8092.481099 3768.565647 0 9317 7592.842953 7494.315462 0 9318 8914.229914 7123.306520 0 9319 8837.629743 1870.864485 0 9320 9860.651564 2875.582932 0 9321 7802.732395 7932.700233 0 9322 4898.096665 9116.641610 0 9323 404.899137 3065.874804 0 9324 2173.721527 359.232280 0 9325 5412.981768 1979.122933 0 9326 2750.354534 5708.666165 0 9327 7907.945126 1116.734417 0 9328 1181.234046 8779.495860 0 9329 309.370728 5183.289418 0 9330 6177.003188 733.008723 0 9331 4058.697885 8871.823591 0 9332 7441.092036 7423.552980 0 9333 6100.243256 7017.422190 0 9334 5276.275937 2087.235442 0 9335 9418.740956 7625.371892 0 9336 7353.953456 638.347639 0 9337 2237.116276 6163.054459 0 9338 6921.553044 4472.315789 0 9339 5692.098652 1082.964046 0 9340 9004.682532 3640.088530 0 9341 5236.908839 590.141220 0 9342 3906.566009 5731.051678 0 9343 1736.169879 7905.481159 0 9344 7740.502533 9666.759654 0 9345 5787.485832 1879.231075 0 9346 3887.027632 7662.272788 0 9347 4065.974855 4418.592397 0 9348 6423.032890 4325.021211 0 9349 3969.893855 5917.329390 0 9350 5353.432088 2178.789658 0 9351 9696.875615 992.737485 0 9352 9311.306166 8822.049745 0 9353 4111.672423 6426.038616 0 9354 319.993179 5764.537355 0 9355 1976.222800 7344.336738 0 9356 5200.561732 4609.494569 0 9357 3920.859497 8706.915868 0 9358 7957.263498 7466.942670 0 9359 6775.268220 5179.170012 0 9360 5508.248351 2801.316504 0 9361 1835.460251 4972.749673 0 9362 7864.904177 6521.043389 0 9363 2117.021479 5779.553923 0 9364 43.254322 7931.309209 0 9365 2143.455664 4838.333376 0 9366 5297.720003 7865.687049 0 9367 461.293198 1432.867253 0 9368 6638.518576 2075.799462 0 9369 8803.668316 7865.871816 0 9370 9262.762079 8884.302625 0 9371 4930.484487 9430.587181 0 9372 3287.988522 7958.223715 0 9373 7234.900270 2909.485347 0 9374 9756.155719 1412.817758 0 9375 7010.369354 2533.163205 0 9376 1625.884322 6842.018684 0 9377 8238.839262 5769.797964 0 9378 4453.676101 8029.013940 0 9379 9876.331164 7953.922722 0 9380 5776.450308 5780.945172 0 9381 1534.594919 3778.310829 0 9382 3068.277426 9127.459108 0 9383 5605.296749 2660.304253 0 9384 7858.454435 6645.937762 0 9385 2847.842793 1494.217059 0 9386 5913.511131 914.459084 0 9387 3724.906216 3218.591985 0 9388 2930.505016 7167.449705 0 9389 2020.776433 4551.789928 0 9390 285.132988 292.534406 0 9391 7971.342235 609.300505 0 9392 4607.508875 9767.500543 0 9393 9654.293484 9985.797659 0 9394 1648.480498 6022.399240 0 9395 6840.948236 5525.222935 0 9396 774.406964 5951.426395 0 9397 4717.720830 9908.041499 0 9398 6808.696013 9644.466631 0 9399 6877.715742 5186.670006 0 9400 8762.446221 7531.965800 0 9401 9802.965163 5071.146630 0 9402 6886.963807 8965.455669 0 9403 8292.046451 3464.539227 0 9404 8636.731623 1046.393676 0 9405 75.548441 83.224799 0 9406 9114.926109 9317.007327 0 9407 6372.471649 7455.586509 0 9408 5261.868323 4940.085146 0 9409 7147.041301 3718.177945 0 9410 234.816336 7951.275143 0 9411 7173.223477 6880.865970 0 9412 2877.589453 9781.113163 0 9413 8856.189505 7319.497203 0 9414 188.508145 9048.932568 0 9415 5052.943196 6849.505190 0 9416 8966.581650 5346.319167 0 9417 670.636476 2521.688788 0 9418 3772.396823 7175.669220 0 9419 1550.302868 1865.900802 0 9420 5688.242779 8146.974091 0 9421 5268.080676 1760.501211 0 9422 7945.096797 3667.067260 0 9423 6353.471598 5121.937518 0 9424 3215.919026 2843.525461 0 9425 7001.843817 4001.130450 0 9426 6243.675391 2547.043347 0 9427 9114.429512 9725.041911 0 9428 7540.179494 5250.053518 0 9429 2977.803958 2629.539708 0 9430 9663.093154 9301.981787 0 9431 6932.181485 8606.603429 0 9432 3577.939073 5821.187435 0 9433 4765.622895 7392.630363 0 9434 9644.013058 5113.292800 0 9435 6010.509598 7980.677866 0 9436 5310.863808 3855.719519 0 9437 7720.989242 7449.776655 0 9438 1373.324662 4177.592895 0 9439 7423.494126 7263.418467 0 9440 9957.958747 461.966889 0 9441 7301.328181 1889.570700 0 9442 521.496711 2884.894293 0 9443 7408.376137 9047.051804 0 9444 4551.502585 161.231051 0 9445 738.175297 9407.319929 0 9446 8485.544801 5255.858448 0 9447 1989.874940 9075.030195 0 9448 2610.670388 5751.706435 0 9449 7260.095054 7973.326772 0 9450 117.385566 5604.969392 0 9451 2832.082617 5853.320300 0 9452 4879.198164 422.446976 0 9453 9969.179610 7730.184571 0 9454 6807.377725 9227.897928 0 9455 5924.245516 1753.373598 0 9456 9700.352475 523.197120 0 9457 554.616034 6409.621971 0 9458 3317.867212 5502.802647 0 9459 3315.050955 3920.183567 0 9460 7059.096714 6206.428851 0 9461 9376.173513 3363.806629 0 9462 4185.887418 9540.664536 0 9463 9062.800429 1121.894476 0 9464 7929.675252 7883.903653 0 9465 2571.094569 7092.524216 0 9466 9972.517552 2101.641735 0 9467 7685.469975 9618.332513 0 9468 2060.541833 5137.390099 0 9469 9840.172440 5004.331812 0 9470 6219.284009 6837.907306 0 9471 4235.710530 7997.706346 0 9472 2008.151638 1145.122983 0 9473 7313.953627 5422.523646 0 9474 3892.186319 3994.908526 0 9475 4171.524706 3586.357165 0 9476 9601.549177 5277.823298 0 9477 7164.472863 2920.927192 0 9478 1463.397372 3944.293631 0 9479 7297.559945 7114.947848 0 9480 6115.198646 2291.762847 0 9481 7299.543243 536.622878 0 9482 2629.642156 2936.322241 0 9483 788.520700 6393.144132 0 9484 5925.418103 3180.615235 0 9485 8612.897959 9247.341450 0 9486 2391.722665 5456.351808 0 9487 9046.888866 2175.832653 0 9488 988.309009 6660.328658 0 9489 8084.972828 1028.539355 0 9490 6855.036616 7251.003785 0 9491 2300.801735 2941.899375 0 9492 6677.023228 3259.260337 0 9493 309.843409 1209.630500 0 9494 1042.756517 7832.546904 0 9495 5482.627291 1958.981695 0 9496 2928.091282 5829.425574 0 9497 1676.146735 4986.618390 0 9498 6753.939521 6097.603397 0 9499 5880.353525 2222.042486 0 9500 8143.751887 2696.144747 0 9501 8481.310644 2135.675679 0 9502 7415.826641 2276.336737 0 9503 8953.416776 8848.532334 0 9504 7795.068212 6650.612377 0 9505 7197.741978 957.573486 0 9506 3088.314398 7427.351896 0 9507 5026.036707 5992.436802 0 9508 1772.748052 512.094085 0 9509 7305.843925 6072.849918 0 9510 118.370197 1155.227458 0 9511 5071.547291 6676.648037 0 9512 8127.496886 1825.820683 0 9513 9733.671201 9135.946180 0 9514 93.726793 3958.990041 0 9515 8585.415462 302.194582 0 9516 7821.002683 5999.376027 0 9517 8267.885176 8703.040120 0 9518 6467.429387 8299.620164 0 9519 5933.834048 564.359284 0 9520 5176.252501 6863.592241 0 9521 8433.812338 1841.135403 0 9522 6632.520903 371.331755 0 9523 8617.212878 2773.580257 0 9524 5679.668325 7852.301344 0 9525 7729.364110 1298.061762 0 9526 7522.579112 1608.266645 0 9527 9192.888520 5363.712219 0 9528 4104.409909 3851.296728 0 9529 2787.650977 1021.259955 0 9530 1522.095028 8247.904030 0 9531 5453.786434 5122.616202 0 9532 1601.062659 8618.802486 0 9533 9363.285122 6484.820640 0 9534 1971.376606 6560.832832 0 9535 9873.638060 6267.466200 0 9536 6004.366414 5146.280509 0 9537 3520.390745 9802.500146 0 9538 9450.178267 256.694585 0 9539 4526.132200 2115.225712 0 9540 7072.726333 1388.419826 0 9541 5496.985791 6933.558822 0 9542 5837.221933 3021.565474 0 9543 5221.030460 6695.929895 0 9544 8039.580467 3391.667791 0 9545 5622.591489 3648.729833 0 9546 1045.181086 5624.864094 0 9547 2138.630537 3158.115095 0 9548 4965.759280 9123.657016 0 9549 9537.192567 9535.409022 0 9550 2758.537904 4591.748228 0 9551 926.122442 1658.645174 0 9552 9921.475099 4952.395643 0 9553 3755.726945 5905.885717 0 9554 7517.846633 9227.658592 0 9555 7274.331766 1714.882584 0 9556 4381.519916 7587.328078 0 9557 811.122580 555.634329 0 9558 8072.152291 3641.714999 0 9559 8646.729091 547.480880 0 9560 9385.736079 6081.109230 0 9561 2395.674931 9801.278678 0 9562 3296.486532 4403.882965 0 9563 3875.858113 6855.288598 0 9564 7299.125913 6994.080430 0 9565 3186.346186 716.981359 0 9566 511.536844 8859.485495 0 9567 54.170934 3752.515452 0 9568 7880.493811 2453.315468 0 9569 402.716519 2227.815942 0 9570 369.031568 2780.181036 0 9571 2746.785984 4947.031502 0 9572 2660.175261 2346.348550 0 9573 9657.184666 6479.230190 0 9574 2281.169497 5062.691503 0 9575 6650.118826 8568.742742 0 9576 89.532574 6258.252385 0 9577 2037.246690 2439.181244 0 9578 7011.616688 1263.702590 0 9579 9265.286752 7168.872839 0 9580 2795.680638 2124.801717 0 9581 7004.142360 5640.570685 0 9582 1998.681773 1160.360210 0 9583 8108.532080 3668.008044 0 9584 7814.295967 4983.386918 0 9585 9237.942612 2243.457056 0 9586 6778.121372 5221.149088 0 9587 1969.197804 9257.540763 0 9588 1692.045434 9457.504943 0 9589 9743.329075 552.093360 0 9590 7754.814025 5419.299506 0 9591 2180.290540 7270.234893 0 9592 5877.342528 3701.304608 0 9593 6045.935669 9495.159616 0 9594 7586.895349 4239.469942 0 9595 5703.940035 6057.179015 0 9596 7835.637443 8394.643122 0 9597 2652.623671 7060.397737 0 9598 4621.493910 7098.520866 0 9599 8969.855057 510.502396 0 9600 6.600367 4700.433210 0 9601 865.072450 3778.855470 0 9602 3843.984915 2268.834679 0 9603 300.415263 987.781865 0 9604 4416.911541 3412.540301 0 9605 49.324458 5954.091404 0 9606 8213.760751 4532.540015 0 9607 9972.720101 7150.554922 0 9608 5143.999244 8362.808000 0 9609 5777.668627 3324.266196 0 9610 6363.485873 5397.191169 0 9611 5402.499404 2421.008222 0 9612 7550.633241 7384.701751 0 9613 3551.502012 3363.210149 0 9614 8529.176051 1991.299128 0 9615 3952.114612 3870.000826 0 9616 5699.073093 1066.560273 0 9617 9115.334477 3941.840293 0 9618 6601.828041 8773.699667 0 9619 8471.466140 755.628141 0 9620 7053.105818 8463.246895 0 9621 3401.080216 2040.567671 0 9622 9666.296826 2986.499036 0 9623 9699.841787 5070.751582 0 9624 3217.394881 4548.437767 0 9625 6491.317683 3387.460384 0 9626 104.817236 9608.289942 0 9627 3952.738794 3991.678153 0 9628 4950.573354 3880.519849 0 9629 7815.921543 4699.190973 0 9630 5931.703896 6279.055390 0 9631 1524.194553 7836.052115 0 9632 8417.123064 1659.493454 0 9633 4334.597061 7083.680123 0 9634 9997.333715 6345.167232 0 9635 8977.252093 7548.840052 0 9636 3352.900626 2912.943760 0 9637 2611.002676 7909.650619 0 9638 4628.093161 46.646656 0 9639 7722.273014 62.182796 0 9640 5467.657378 5910.072706 0 9641 6508.527773 1260.467070 0 9642 1647.743754 2082.242091 0 9643 899.309240 7225.182453 0 9644 7533.511836 4591.517736 0 9645 1016.614669 2346.690231 0 9646 3689.862727 8161.931580 0 9647 3863.747019 279.484769 0 9648 6704.270175 1476.277810 0 9649 534.184683 7791.165936 0 9650 156.400252 7932.615064 0 9651 8452.145215 3575.671934 0 9652 208.921458 2117.199674 0 9653 8384.064441 4017.283427 0 9654 3384.995246 1017.251194 0 9655 5938.379749 2376.707347 0 9656 5727.442360 2583.666513 0 9657 108.014652 6793.050451 0 9658 3540.216042 8826.383810 0 9659 9320.684795 6924.344129 0 9660 2585.894401 8470.320224 0 9661 4002.790922 4450.623084 0 9662 4555.065536 9160.371563 0 9663 4298.400302 409.045442 0 9664 8869.911689 3509.585116 0 9665 2934.704457 4275.666632 0 9666 5488.313655 416.660076 0 9667 1096.319443 3503.357667 0 9668 8352.752369 3542.104385 0 9669 7326.460001 3818.797062 0 9670 3818.877808 3871.631011 0 9671 6383.097458 8886.571124 0 9672 9701.654258 4607.873669 0 9673 7191.974287 9375.655352 0 9674 9935.529684 2345.468444 0 9675 4699.131178 7671.917128 0 9676 4259.208392 6934.457144 0 9677 3280.344446 8567.009939 0 9678 7047.095722 1321.536127 0 9679 6422.149779 2783.074805 0 9680 3245.819043 7591.067118 0 9681 302.175377 5944.757835 0 9682 3917.025525 9439.892956 0 9683 4368.735653 8670.237740 0 9684 2865.893419 4973.407260 0 9685 5232.629635 1494.872531 0 9686 9082.709107 7774.550408 0 9687 963.779126 5492.017419 0 9688 6664.455803 7588.025606 0 9689 2236.071130 9432.836317 0 9690 6152.519313 3333.126797 0 9691 4950.868720 7654.859519 0 9692 7717.925878 3741.458026 0 9693 1695.973255 503.999021 0 9694 7641.230202 7623.806733 0 9695 6281.725147 9085.576748 0 9696 3551.061472 5059.582230 0 9697 7056.298565 2251.908548 0 9698 9735.421780 1464.969294 0 9699 6002.503724 9316.802643 0 9700 2436.877065 4932.879354 0 9701 7472.953922 7129.509132 0 9702 703.051694 3633.137245 0 9703 5397.729159 5813.113680 0 9704 7901.408351 6079.086186 0 9705 7373.352940 6490.183965 0 9706 2659.769722 573.793624 0 9707 5367.568676 6016.264862 0 9708 7182.299877 4205.318917 0 9709 1952.437356 5323.896819 0 9710 7394.526200 4907.351948 0 9711 9008.765426 1060.535128 0 9712 2625.262732 130.439085 0 9713 8001.141092 4746.140365 0 9714 2994.057704 8814.050646 0 9715 8581.530714 6354.978300 0 9716 9223.068548 4209.414422 0 9717 5833.381450 4148.073792 0 9718 9207.939549 7304.916841 0 9719 5373.700873 947.013192 0 9720 8963.853726 5113.297647 0 9721 3361.137911 7037.248336 0 9722 5095.474826 4550.001335 0 9723 7153.827298 340.838401 0 9724 6796.830607 5113.589381 0 9725 7486.477894 9395.989664 0 9726 8311.834872 130.030807 0 9727 4512.254302 3522.932285 0 9728 3148.079657 9363.961056 0 9729 7476.166453 5868.763338 0 9730 385.174116 1152.904386 0 9731 4303.309542 8992.329405 0 9732 8832.438328 4699.911281 0 9733 1628.714095 4925.495853 0 9734 7438.758544 404.597033 0 9735 4393.894967 7756.369035 0 9736 6543.522157 9477.482120 0 9737 4186.543023 7131.622158 0 9738 7266.312080 1487.659003 0 9739 3760.086380 5540.658922 0 9740 5858.894113 8.337119 0 9741 6534.769090 5386.609370 0 9742 9759.589247 3270.104523 0 9743 3082.126381 5238.700194 0 9744 4741.690061 1603.637574 0 9745 4870.475205 1049.051590 0 9746 5255.630411 5821.009087 0 9747 7756.958520 4166.902667 0 9748 9062.849083 1908.870419 0 9749 7433.620885 5675.571502 0 9750 2503.283955 173.230705 0 9751 1651.367754 743.856095 0 9752 4894.948202 6766.712016 0 9753 4931.314081 6505.727260 0 9754 7067.126154 6869.764126 0 9755 276.593521 7754.621151 0 9756 8440.955478 1281.548196 0 9757 1763.288758 6530.978568 0 9758 1396.766799 409.445788 0 9759 9260.136834 6362.781241 0 9760 2678.633265 6486.988808 0 9761 3980.844693 3856.182867 0 9762 1087.270057 9352.019007 0 9763 4388.561004 7016.374599 0 9764 9206.888706 6473.991318 0 9765 7059.559529 6489.356780 0 9766 925.162460 3273.153056 0 9767 8877.320238 3173.704256 0 9768 2527.780536 3725.862846 0 9769 922.620047 4170.471941 0 9770 8500.919908 6037.740365 0 9771 5245.160485 4983.960082 0 9772 6030.657790 3076.262935 0 9773 8069.439061 6014.390681 0 9774 5425.030919 2115.303141 0 9775 7594.985101 9194.347985 0 9776 3840.353279 2762.722174 0 9777 7477.406546 1401.988878 0 9778 1311.360453 9180.038420 0 9779 1017.110907 699.483269 0 9780 9254.528937 9834.672127 0 9781 3497.027359 7029.215709 0 9782 5626.836675 2111.368676 0 9783 5477.615557 4092.193638 0 9784 338.002496 3339.281505 0 9785 9898.610430 2602.130590 0 9786 2221.092473 770.266913 0 9787 8164.245440 5071.423473 0 9788 7993.935663 6619.660695 0 9789 1092.777266 5197.664898 0 9790 858.233583 1776.215686 0 9791 8880.905342 9179.020979 0 9792 5890.455213 4092.598253 0 9793 4545.556914 8826.385737 0 9794 1734.681358 9899.305760 0 9795 4285.809415 4765.424958 0 9796 2716.316608 453.526966 0 9797 6267.903082 7641.504722 0 9798 1039.896325 3131.001808 0 9799 2553.283118 1395.072249 0 9800 7305.275387 6245.142225 0 9801 660.235128 1283.660392 0 9802 3930.288558 6027.008711 0 9803 6288.543803 6752.479348 0 9804 8806.945643 8459.816907 0 9805 9260.061433 6528.295110 0 9806 8416.695158 4692.778494 0 9807 3054.659532 4442.796678 0 9808 695.715967 1738.424169 0 9809 4308.025078 516.131561 0 9810 2798.899261 6538.881969 0 9811 8884.076119 6756.816746 0 9812 2559.710089 4064.325920 0 9813 7318.574037 1575.360130 0 9814 9939.215268 2629.032223 0 9815 8963.709218 9731.879337 0 9816 5335.320062 7632.831780 0 9817 1888.745523 5509.759469 0 9818 4603.183441 7650.557579 0 9819 6289.940091 7534.464546 0 9820 3178.963923 3927.062980 0 9821 3295.421124 7038.887172 0 9822 2329.609525 9841.139462 0 9823 7657.719080 7553.604033 0 9824 1234.657731 5866.224057 0 9825 5104.098660 3259.502043 0 9826 6446.154554 8485.846805 0 9827 6739.227742 1125.366923 0 9828 8365.431143 9437.214195 0 9829 8150.464017 8299.505234 0 9830 7728.989876 7802.282709 0 9831 9658.705460 3450.977443 0 9832 5364.231473 5990.319321 0 9833 3482.667428 2536.287001 0 9834 3307.732862 3425.092767 0 9835 448.576598 9302.172369 0 9836 4609.158114 289.563407 0 9837 5871.727492 8345.463505 0 9838 9829.803717 442.373038 0 9839 5752.979789 8264.895937 0 9840 1722.838101 9335.501584 0 9841 7747.599561 4871.298165 0 9842 3733.726879 2256.095104 0 9843 7004.504384 2591.085212 0 9844 7659.921814 1489.521780 0 9845 5025.461998 7996.093339 0 9846 48.305658 3033.299237 0 9847 5765.853509 2538.268171 0 9848 2614.086266 3308.271272 0 9849 6319.470695 9121.683512 0 9850 3889.503875 6126.528850 0 9851 2701.632568 9207.064481 0 9852 4310.877347 3854.082966 0 9853 460.143623 721.216577 0 9854 793.905984 3090.405552 0 9855 2362.482456 2578.975837 0 9856 662.699342 3953.783731 0 9857 9937.554501 744.750917 0 9858 1903.234045 1533.602690 0 9859 5704.990796 6676.505326 0 9860 9254.446203 2763.758848 0 9861 7622.766070 2442.997028 0 9862 2593.333315 493.254427 0 9863 8353.343835 2731.749852 0 9864 5805.394709 969.926956 0 9865 5278.606708 9205.530647 0 9866 2693.580536 6002.118445 0 9867 1860.490277 3304.075263 0 9868 3336.306085 2739.037624 0 9869 4033.856303 4454.643724 0 9870 951.135264 5051.548217 0 9871 1794.274756 5721.125229 0 9872 7090.024706 3591.848315 0 9873 8051.942208 9141.273368 0 9874 685.579341 4407.179521 0 9875 8395.529906 2807.416487 0 9876 330.544706 4539.044147 0 9877 9371.139794 1054.608481 0 9878 8616.423676 5008.856827 0 9879 5106.413025 1859.412745 0 9880 8496.102653 7729.550162 0 9881 8258.074841 5721.577661 0 9882 9604.300111 6671.648300 0 9883 1824.634110 3926.453649 0 9884 8580.892731 7059.894856 0 9885 5957.832812 3134.857955 0 9886 1286.848758 9219.838668 0 9887 2678.040410 9069.714445 0 9888 4490.019738 7006.709191 0 9889 1132.658383 1306.141885 0 9890 6250.738342 4993.050463 0 9891 6177.838967 6579.129218 0 9892 3136.050611 5202.565551 0 9893 369.486239 8748.336807 0 9894 1463.281288 1837.656768 0 9895 1370.114382 127.650730 0 9896 8516.984474 7660.593344 0 9897 2672.264366 3088.682965 0 9898 6511.533264 6992.722668 0 9899 1595.515337 8314.509978 0 9900 8122.714196 6689.927374 0 9901 318.974777 503.476022 0 9902 990.374594 6991.222091 0 9903 6254.295629 2704.771762 0 9904 4038.501211 2011.284409 0 9905 2596.983840 6992.642690 0 9906 6535.205313 1611.907239 0 9907 1617.157849 8906.045440 0 9908 9525.379552 3257.590659 0 9909 648.945305 3382.174361 0 9910 1740.508034 3184.062632 0 9911 4587.530136 9760.312046 0 9912 793.749432 425.220487 0 9913 2254.925528 4959.880817 0 9914 9660.521580 2288.942347 0 9915 8017.814797 3001.575657 0 9916 9322.862378 5048.501107 0 9917 5637.002302 6133.664171 0 9918 1801.863369 6078.563627 0 9919 2386.869854 3032.255296 0 9920 3071.371766 3523.660147 0 9921 5312.516670 2320.944155 0 9922 126.903365 1279.089569 0 9923 592.936001 6816.027281 0 9924 3590.743722 5127.926753 0 9925 3596.958588 6618.774563 0 9926 9143.466116 7609.961284 0 9927 2217.113857 3651.208305 0 9928 1461.231247 9232.071642 0 9929 3674.953170 5639.111413 0 9930 130.534538 6709.260508 0 9931 7980.247030 4949.401922 0 9932 5464.032492 1609.289674 0 9933 8793.467540 3266.448359 0 9934 7060.814425 646.700922 0 9935 931.674231 678.250023 0 9936 5763.210195 9652.894434 0 9937 7040.559095 2870.374730 0 9938 1596.813284 2868.256540 0 9939 578.617492 6628.345669 0 9940 1252.895219 6094.232480 0 9941 1179.740504 9664.343540 0 9942 1160.930271 6862.152360 0 9943 6749.572239 6744.301107 0 9944 3562.486441 6420.059409 0 9945 1892.882914 4157.529693 0 9946 6177.230187 8242.779383 0 9947 7773.500218 7215.387054 0 9948 8016.060970 578.654050 0 9949 7142.986591 4256.807917 0 9950 8288.219474 2897.403741 0 9951 4715.205409 1598.680894 0 9952 4135.501696 9218.810446 0 9953 2070.328401 1866.795351 0 9954 4132.095490 7399.114171 0 9955 1674.940990 8874.480480 0 9956 418.922588 4712.838987 0 9957 864.441156 1879.016858 0 9958 6074.002414 9306.914242 0 9959 289.710753 6038.876933 0 9960 1624.739838 4588.827968 0 9961 8431.883973 1121.337121 0 9962 5843.465201 8592.482601 0 9963 5921.082444 3478.051065 0 9964 4230.223172 5890.877846 0 9965 2905.613433 8936.813162 0 9966 6491.060805 2341.060757 0 9967 7841.614482 9225.428110 0 9968 3637.667000 4355.083089 0 9969 5232.211774 6720.960208 0 9970 6441.698771 1881.547731 0 9971 855.762263 2156.098842 0 9972 1209.199054 4804.786926 0 9973 1412.917635 9404.508265 0 9974 3149.276076 6482.613172 0 9975 5857.910032 5228.176224 0 9976 6623.136871 587.527036 0 9977 5063.309181 9500.041261 0 9978 9581.762079 2923.301613 0 9979 1913.954256 5065.947726 0 9980 4643.347796 6619.372059 0 9981 1262.036684 7872.453742 0 9982 6509.649446 5824.387736 0 9983 5882.956664 6670.624468 0 9984 8859.728934 6623.885421 0 9985 7450.748361 9191.168887 0 9986 420.891456 1185.663318 0 9987 3609.959340 2378.666383 0 9988 8286.278682 3612.372626 0 9989 6457.924554 6467.713858 0 9990 822.366472 7957.037798 0 9991 6530.693909 6038.384096 0 9992 7979.157853 494.970227 0 9993 7031.522610 5389.400152 0 9994 9651.754140 8732.030476 0 9995 3803.331596 740.769935 0 9996 8785.117618 8228.754440 0 9997 4208.992814 1032.834526 0 9998 740.091589 3954.276331 0 9999 3089.274532 7520.692883 0
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/scalefree/CMakeLists.txt
function(rgraph base numnodes numedges) add_custom_command(OUTPUT ${base}.dimacs COMMAND python ${CMAKE_BINARY_DIR}/tools/generators/rmat.py ${CMAKE_BINARY_DIR}/tools/bin/GTgraph-rmat -n ${numnodes} -m ${numedges} ${base}.rmat DEPENDS ${CMAKE_BINARY_DIR}/tools/bin/GTgraph-rmat) add_custom_command(OUTPUT ${base}.gr COMMAND graph-convert-standalone -dimacs2gr ${base}.rmat ${base}.gr DEPENDS ${base}.dimacs graph-convert-standalone) endfunction(rgraph) rgraph(rmat8-2e14 16384 131072) rgraph(rmat8-2e18 262144 2097152) rgraph(rmat16-2e24 16777216 268435456) rgraph(rmat8-2e26 67108864 536870912) add_custom_target(more-scalefree-graphs DEPENDS rmat8-2e14.gr rmat8-2e18.gr rmat16-2e24.gr rmat8-2e26.gr) add_dependencies(more-inputs more-scalefree-graphs) add_dependencies(more-scalefree-graphs more-tools)
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/koggeStone8bit.net
// Lonestar Benchmark Suite for irregular applications that exhibit // amorphous data-parallelism. // // Center for Grid and Distributed Computing // The University of Texas at Austin // // Copyright (C) 2007, 2008, 2009 The University of Texas at Austin // // Licensed under the Eclipse Public License, Version 1.0 (the "License"); // you may not use this file except in compliance with the License. // You may obtain a copy of the License at // // http://www.eclipse.org/legal/epl-v10.html // // Unless required by applicable law or agreed to in writing, software // distributed under the License is distributed on an "AS IS" BASIS, // WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. // See the License for the specific language governing permissions and // limitations under the License. // // File: koggeStone8bit.net finish 100000 inputs cin, a0, a1, a2, a3, a4, a5, a6, a7, b0, b1, b2, b3, b4, b5, b6, b7 end outputs cout, s0, s1, s2, s3, s4, s5, s6, s7 end initlist a0 0,0 15,1 61,0 109,1 142,0 200,1 210,0 251,1 276,0 345,1 427,0 444,1 466,0 485,1 553,0 641,1 674,0 733,1 758,0 850,1 905,0 943,1 1042,0 1079,1 1093,0 1159,1 1161,0 1190,1 1212,0 1267,1 1323,0 1406,1 1447,0 1522,1 1588,0 1617,1 1658,0 1681,1 1756,0 1769,1 1795,0 1867,1 1897,0 1967,1 1980,0 2014,1 2062,0 2144,1 2221,0 2297,1 2345,0 2373,1 2394,0 2479,1 2579,0 2600,1 2661,0 2672,1 2687,0 2772,1 2827,0 2840,1 2881,0 2920,1 2985,0 3018,1 3099,0 3134,1 3185,0 3207,1 3208,0 3231,1 3284,0 3351,1 3380,0 3479,1 3489,0 3539,1 3573,0 3575,1 3664,0 3751,1 3789,0 3883,1 3970,0 4049,1 4143,0 4239,1 4246,0 4249,1 4327,0 4423,1 4453,0 4473,1 4478,0 4531,1 4610,0 4683,1 4765,0 4827,1 4887,0 4916,1 4940,0 5029,1 5091,0 5170,1 5235,0 5299,1 5306,0 5321,1 5403,0 5442,1 5501,0 5542,1 5628,0 5673,1 5685,0 5701,1 5795,0 5883,1 5977,0 6003,1 6023,0 6058,1 6110,0 6115,1 6120,0 6158,1 6203,0 6250,1 6270,0 6329,1 6345,0 6424,1 6503,0 6523,1 6567,0 6574,1 6636,0 6658,1 6715,0 6762,1 6835,0 6854,1 6878,0 6935,1 6963,0 7035,1 7131,0 7151,1 7198,0 7295,1 7329,0 7401,1 7460,0 7497,1 7544,0 7589,1 7615,0 7704,1 7766,0 7836,1 7860,0 7945,1 7965,0 8038,1 8073,0 8143,1 8153,0 8229,1 8230,0 8291,1 8317,0 8323,1 8332,0 8377,1 8393,0 8469,1 8471,0 8540,1 8574,0 8653,1 8709,0 8764,1 8787,0 8822,1 8834,0 8905,1 8985,0 9033,1 9047,0 9106,1 9159,0 9246,1 9249,0 9295,1 9349,0 9449,1 9471,0 9523,1 9568,0 9593,1 9636,0 9708,1 9793,0 9839,1 9939,0 10012,1 10111,0 10124,1 10139,0 10143,1 10180,0 10186,1 10210,0 10271,1 10333,0 10394,1 10437,0 10511,1 10550,0 10581,1 10620,0 10705,1 10777,0 10851,1 10936,0 11000,1 11096,0 11112,1 11211,0 11278,1 11289,0 11380,1 11476,0 11488,1 11490,0 11569,1 11592,0 11640,1 11704,0 11766,1 11833,0 11881,1 11923,0 12018,1 12083,0 12142,1 12185,0 12205,1 12270,0 12277,1 12313,0 12354,1 12405,0 12417,1 12506,0 12514,1 12560,0 12583,1 12632,0 12657,1 12678,0 12768,1 12795,0 12821,1 12907,0 12917,1 12979,0 12997,1 13073,0 13154,1 13161,0 13163,1 13259,0 13263,1 13349,0 13351,1 13383,0 13385,1 13424,0 13462,1 13554,0 13632,1 13706,0 13780,1 13839,0 13908,1 13995,0 14069,1 14148,0 14199,1 14262,0 14290,1 14336,0 14408,1 14492,0 14498,1 14579,0 14651,1 14741,0 14777,1 14873,0 14954,1 15023,0 15075,1 15155,0 15251,1 15330,0 15340,1 15361,0 15410,1 15469,0 15517,1 15561,0 15642,1 15668,0 15705,1 15793,0 15830,1 15873,0 15906,1 15950,0 16025,1 16102,0 16173,1 16216,0 16312,1 16361,0 16446,1 16457,0 16472,1 16482,0 16575,1 16654,0 16681,1 16741,0 16778,1 16832,0 16891,1 16922,0 16956,1 17043,0 17092,1 17103,0 17197,1 17292,0 17295,1 17384,0 17397,1 17479,0 17550,1 17572,0 17611,1 17676,0 17684,1 17724,0 17780,1 17813,0 17869,1 17967,0 17991,1 18029,0 18039,1 18132,0 18226,1 18289,0 18292,1 18334,0 18430,1 18522,0 18610,1 18692,0 18789,1 18825,0 18893,1 18913,0 18980,1 19063,0 19114,1 19158,0 19217,1 19288,0 19309,1 19359,0 19369,1 19374,0 19398,1 19464,0 19526,1 19560,0 19645,1 19686,0 19764,1 19795,0 19851,1 19899,0 19905,1 19911,0 19974,1 19975,0 20071,1 20166,0 20256,1 20344,0 20398,1 20423,0 20511,1 20578,0 20668,1 20724,0 20763,1 20851,0 20864,1 20949,0 21049,1 21052,0 21097,1 21186,0 21234,1 21296,0 21316,1 21362,0 21363,1 21437,0 21495,1 21584,0 21631,1 21640,0 21642,1 21678,0 21745,1 21815,0 21816,1 21869,0 21958,1 21964,0 22048,1 22094,0 22156,1 22228,0 22256,1 22343,0 22349,1 22429,0 22470,1 22509,0 22561,1 22635,0 22637,1 22642,0 22682,1 22766,0 22860,1 22891,0 22907,1 22925,0 22961,1 23022,0 23113,1 23164,0 23237,1 23329,0 23370,1 23418,0 23454,1 23463,0 23505,1 23545,0 23572,1 23590,0 23626,1 23630,0 23683,1 23697,0 23784,1 23838,0 23911,1 23967,0 24033,1 24093,0 24113,1 24164,0 24168,1 24247,0 24278,1 24314,0 24362,1 24364,0 24410,1 24432,0 24442,1 24453,0 24520,1 24555,0 24568,1 24634,0 24645,1 24737,0 24740,1 24820,0 24920,1 24971,0 24989,1 25026,0 25058,1 25119,0 25131,1 25180,0 25278,1 25346,0 25439,1 25456,0 25554,1 25619,0 25691,1 25734,0 25741,1 25752,0 25759,1 25772,0 25790,1 25838,0 25928,1 25967,0 26055,1 26112,0 26182,1 26236,0 26274,1 26334,0 26432,1 26437,0 26481,1 26512,0 26545,1 26567,0 26643,1 26721,0 26788,1 26888,0 26934,1 26983,0 26992,1 27040,0 27063,1 27160,0 27188,1 27262,0 27301,1 27373,0 27450,1 27548,0 27645,1 27683,0 27705,1 27750,0 27775,1 27825,0 27912,1 27960,0 27971,1 27980,0 28030,1 28112,0 28170,1 28245,0 28258,1 28276,0 28277,1 28337,0 28413,1 28465,0 28481,1 28515,0 28593,1 28643,0 28695,1 28758,0 28760,1 28797,0 28798,1 28856,0 28930,1 28970,0 28986,1 29023,0 29104,1 29192,0 29238,1 29320,0 29411,1 29511,0 29587,1 29681,0 29695,1 29720,0 29783,1 29881,0 29950,1 29986,0 30043,1 30136,0 30182,1 30215,0 30217,1 30279,0 30341,1 30434,0 30476,1 30517,0 30521,1 30537,0 30539,1 30569,0 30576,1 30648,0 30694,1 30710,0 30718,1 30772,0 30789,1 30816,0 30898,1 30933,0 30995,1 31001,0 31065,1 31113,0 31165,1 31224,0 31231,1 31263,0 31336,1 31405,0 31442,1 31494,0 31561,1 31568,0 31603,1 31674,0 31716,1 31774,0 31802,1 31901,0 31967,1 32030,0 32128,1 32207,0 32294,1 32338,0 32360,1 32433,0 32522,1 32528,0 32618,1 32622,0 32632,1 32709,0 32794,1 32877,0 32947,1 32965,0 32989,1 33013,0 33071,1 33104,0 33193,1 33243,0 33248,1 33288,0 33327,1 33391,0 33411,1 33415,0 33510,1 33537,0 33616,1 33707,0 33731,1 33759,0 33813,1 33829,0 33863,1 33894,0 33901,1 33979,0 33983,1 34065,0 34119,1 34149,0 34171,1 34265,0 34349,1 34418,0 34463,1 34521,0 34548,1 34551,0 34632,1 34716,0 34772,1 34839,0 34881,1 34971,0 35033,1 35082,0 35153,1 35241,0 35278,1 35312,0 35320,1 35409,0 35507,1 35583,0 35683,1 35704,0 35789,1 35836,0 35856,1 35921,0 35926,1 35985,0 36016,1 36060,0 36133,1 36219,0 36260,1 36351,0 36436,1 36449,0 36489,1 36547,0 36561,1 36567,0 36613,1 36676,0 36678,1 36762,0 36777,1 36856,0 36909,1 36990,0 37023,1 37109,0 37127,1 37223,0 37287,1 37376,0 37389,1 37404,0 37472,1 37494,0 37581,1 37635,0 37724,1 37797,0 37814,1 37855,0 37947,1 37973,0 38000,1 38036,0 38120,1 38205,0 38287,1 38330,0 38422,1 38458,0 38486,1 38543,0 38553,1 38652,0 38731,1 38783,0 38787,1 38826,0 38836,1 38891,0 38941,1 38950,0 38971,1 39022,0 39083,1 39109,0 39182,1 39239,0 39247,1 39266,0 39274,1 39316,0 39339,1 39403,0 39406,1 39435,0 39458,1 39470,0 39487,1 39501,0 39516,1 39569,0 39582,1 39630,0 39649,1 39669,0 39743,1 39766,0 39801,1 39835,0 39847,1 39909,0 39952,1 40019,0 40091,1 40102,0 40117,1 40168,0 40246,1 40316,0 40317,1 40369,0 40418,1 40457,0 40548,1 40560,0 40655,1 40708,0 40787,1 40838,0 40871,1 40953,0 41050,1 41138,0 41160,1 41187,0 41218,1 41310,0 41404,1 41435,0 41524,1 41602,0 41681,1 41766,0 41775,1 41845,0 41871,1 41936,0 42036,1 42095,0 42139,1 42212,0 42266,1 42322,0 42406,1 42452,0 42502,1 42506,0 42570,1 42594,0 42670,1 42762,0 42846,1 42875,0 42945,1 43040,0 43093,1 43145,0 43168,1 43186,0 43216,1 43240,0 43270,1 43367,0 43422,1 43455,0 43468,1 43521,0 43541,1 43625,0 43679,1 43706,0 43797,1 43814,0 43872,1 43888,0 43903,1 43945,0 43995,1 44071,0 44077,1 44106,0 44150,1 44167,0 44171,1 44213,0 44226,1 44261,0 44309,1 44368,0 44383,1 44443,0 44499,1 44516,0 44555,1 44566,0 44648,1 44678,0 44758,1 44788,0 44811,1 44843,0 44876,1 44962,0 45018,1 45039,0 45080,1 45138,0 45183,1 45262,0 45292,1 45348,0 45420,1 45499,0 45595,1 45687,0 45730,1 45757,0 45765,1 45790,0 45820,1 45902,0 45951,1 45982,0 46023,1 46099,0 46140,1 46182,0 46280,1 46325,0 46367,1 46397,0 46405,1 46417,0 46444,1 46537,0 46631,1 46662,0 46718,1 46812,0 46825,1 46892,0 46935,1 46947,0 46958,1 46986,0 47004,1 47068,0 47105,1 47109,0 47194,1 47253,0 47277,1 47344,0 47390,1 47395,0 47457,1 47467,0 47558,1 47574,0 47648,1 47671,0 47707,1 47784,0 47883,1 47903,0 48003,1 48016,0 48092,1 48190,0 48263,1 48283,0 48340,1 48412,0 48478,1 48486,0 48549,1 48573,0 48600,1 48638,0 48728,1 48760,0 48777,1 48826,0 48925,1 48948,0 49045,1 49055,0 49135,1 49229,0 49299,1 49392,0 49433,1 end initlist a1 0,0 65,1 152,0 210,1 245,0 307,1 315,0 350,1 389,0 405,1 436,0 452,1 511,0 605,1 655,0 682,1 765,0 797,1 845,0 897,1 984,0 1002,1 1024,0 1067,1 1157,0 1214,1 1250,0 1303,1 1325,0 1327,1 1381,0 1461,1 1521,0 1525,1 1563,0 1604,1 1609,0 1672,1 1708,0 1805,1 1848,0 1917,1 2007,0 2106,1 2131,0 2182,1 2235,0 2326,1 2340,0 2423,1 2481,0 2517,1 2531,0 2591,1 2595,0 2654,1 2699,0 2752,1 2786,0 2801,1 2820,0 2888,1 2961,0 3048,1 3121,0 3162,1 3238,0 3308,1 3315,0 3368,1 3383,0 3435,1 3505,0 3551,1 3591,0 3677,1 3732,0 3773,1 3785,0 3838,1 3926,0 4022,1 4070,0 4143,1 4160,0 4226,1 4325,0 4425,1 4475,0 4507,1 4593,0 4679,1 4740,0 4794,1 4848,0 4906,1 4910,0 4983,1 5070,0 5083,1 5159,0 5196,1 5250,0 5283,1 5320,0 5392,1 5407,0 5409,1 5439,0 5458,1 5557,0 5647,1 5728,0 5762,1 5813,0 5850,1 5905,0 5913,1 5978,0 6059,1 6140,0 6198,1 6214,0 6280,1 6376,0 6426,1 6486,0 6530,1 6568,0 6642,1 6664,0 6760,1 6788,0 6831,1 6886,0 6949,1 7000,0 7089,1 7149,0 7242,1 7341,0 7387,1 7402,0 7468,1 7553,0 7575,1 7668,0 7704,1 7715,0 7772,1 7849,0 7886,1 7917,0 7940,1 8009,0 8013,1 8067,0 8151,1 8248,0 8306,1 8358,0 8437,1 8528,0 8606,1 8689,0 8747,1 8793,0 8862,1 8933,0 8998,1 9007,0 9107,1 9197,0 9250,1 9320,0 9410,1 9462,0 9465,1 9564,0 9597,1 9677,0 9726,1 9791,0 9838,1 9907,0 9986,1 10018,0 10029,1 10042,0 10100,1 10128,0 10194,1 10218,0 10230,1 10285,0 10302,1 10306,0 10342,1 10433,0 10466,1 10488,0 10542,1 10552,0 10581,1 10587,0 10668,1 10766,0 10816,1 10858,0 10920,1 10956,0 11026,1 11045,0 11083,1 11138,0 11173,1 11242,0 11289,1 11323,0 11328,1 11413,0 11505,1 11560,0 11617,1 11706,0 11731,1 11796,0 11876,1 11881,0 11884,1 11904,0 11951,1 11960,0 12039,1 12103,0 12177,1 12232,0 12263,1 12325,0 12367,1 12405,0 12482,1 12483,0 12557,1 12644,0 12713,1 12767,0 12855,1 12928,0 13005,1 13080,0 13108,1 13162,0 13169,1 13175,0 13235,1 13315,0 13387,1 13470,0 13508,1 13593,0 13614,1 13651,0 13670,1 13753,0 13822,1 13830,0 13881,1 13943,0 14036,1 14124,0 14196,1 14281,0 14328,1 14376,0 14435,1 14460,0 14503,1 14544,0 14598,1 14623,0 14707,1 14745,0 14845,1 14870,0 14872,1 14957,0 14988,1 15000,0 15002,1 15057,0 15065,1 15091,0 15151,1 15200,0 15265,1 15277,0 15290,1 15305,0 15382,1 15398,0 15482,1 15577,0 15633,1 15710,0 15754,1 15820,0 15834,1 15875,0 15888,1 15987,0 16041,1 16075,0 16103,1 16134,0 16177,1 16207,0 16279,1 16315,0 16403,1 16456,0 16542,1 16616,0 16702,1 16722,0 16749,1 16820,0 16876,1 16975,0 17052,1 17092,0 17148,1 17246,0 17310,1 17365,0 17454,1 17527,0 17566,1 17650,0 17743,1 17777,0 17830,1 17883,0 17955,1 17974,0 18058,1 18064,0 18106,1 18150,0 18180,1 18246,0 18266,1 18303,0 18354,1 18436,0 18448,1 18506,0 18604,1 18657,0 18722,1 18728,0 18764,1 18841,0 18865,1 18909,0 18978,1 19016,0 19034,1 19103,0 19161,1 19204,0 19283,1 19302,0 19373,1 19422,0 19486,1 19555,0 19595,1 19602,0 19679,1 19732,0 19795,1 19872,0 19912,1 19972,0 20043,1 20114,0 20153,1 20200,0 20213,1 20295,0 20346,1 20375,0 20438,1 20503,0 20587,1 20679,0 20683,1 20781,0 20857,1 20946,0 20954,1 21031,0 21088,1 21180,0 21271,1 21313,0 21352,1 21446,0 21544,1 21551,0 21641,1 21681,0 21765,1 21830,0 21844,1 21869,0 21912,1 21930,0 21964,1 22055,0 22123,1 22130,0 22181,1 22254,0 22288,1 22295,0 22305,1 22362,0 22435,1 22482,0 22511,1 22548,0 22578,1 22652,0 22712,1 22808,0 22887,1 22908,0 22976,1 23070,0 23167,1 23231,0 23253,1 23277,0 23313,1 23340,0 23372,1 23441,0 23469,1 23492,0 23566,1 23567,0 23644,1 23681,0 23693,1 23775,0 23776,1 23812,0 23856,1 23953,0 24011,1 24065,0 24145,1 24210,0 24243,1 24290,0 24318,1 24347,0 24385,1 24428,0 24487,1 24491,0 24526,1 24592,0 24682,1 24683,0 24760,1 24786,0 24847,1 24882,0 24969,1 25049,0 25128,1 25193,0 25217,1 25283,0 25307,1 25377,0 25442,1 25537,0 25587,1 25592,0 25629,1 25673,0 25754,1 25762,0 25804,1 25876,0 25909,1 25957,0 26004,1 26014,0 26067,1 26142,0 26167,1 26263,0 26296,1 26355,0 26379,1 26457,0 26487,1 26511,0 26574,1 26620,0 26662,1 26713,0 26803,1 26873,0 26874,1 26875,0 26904,1 26962,0 27034,1 27124,0 27175,1 27202,0 27207,1 27236,0 27268,1 27318,0 27335,1 27358,0 27430,1 27476,0 27477,1 27499,0 27537,1 27630,0 27719,1 27802,0 27879,1 27963,0 27969,1 27970,0 28040,1 28093,0 28188,1 28256,0 28325,1 28350,0 28401,1 28477,0 28525,1 28600,0 28645,1 28732,0 28740,1 28750,0 28788,1 28815,0 28899,1 28925,0 28927,1 29006,0 29021,1 29046,0 29100,1 29105,0 29192,1 29213,0 29266,1 29298,0 29395,1 29487,0 29584,1 29662,0 29691,1 29698,0 29767,1 29826,0 29883,1 29888,0 29896,1 29963,0 30014,1 30069,0 30077,1 30127,0 30172,1 30223,0 30234,1 30306,0 30320,1 30360,0 30374,1 30468,0 30507,1 30602,0 30633,1 30716,0 30811,1 30851,0 30913,1 30931,0 31005,1 31009,0 31059,1 31098,0 31106,1 31145,0 31237,1 31296,0 31328,1 31425,0 31473,1 31530,0 31604,1 31668,0 31740,1 31825,0 31838,1 31839,0 31901,1 31987,0 32014,1 32043,0 32112,1 32192,0 32223,1 32276,0 32281,1 32380,0 32382,1 32477,0 32536,1 32580,0 32619,1 32624,0 32695,1 32756,0 32759,1 32796,0 32877,1 32947,0 32950,1 33045,0 33103,1 33132,0 33188,1 33263,0 33357,1 33414,0 33447,1 33519,0 33564,1 33617,0 33671,1 33732,0 33811,1 33832,0 33873,1 33888,0 33955,1 33995,0 34060,1 34145,0 34226,1 34276,0 34350,1 34398,0 34437,1 34504,0 34537,1 34567,0 34640,1 34657,0 34718,1 34734,0 34834,1 34894,0 34939,1 34962,0 35061,1 35096,0 35160,1 35163,0 35215,1 35300,0 35304,1 35333,0 35358,1 35360,0 35416,1 35458,0 35464,1 35487,0 35572,1 35639,0 35674,1 35694,0 35752,1 35805,0 35861,1 35933,0 36009,1 36070,0 36122,1 36137,0 36220,1 36311,0 36340,1 36402,0 36475,1 36490,0 36500,1 36521,0 36571,1 36625,0 36723,1 36733,0 36832,1 36895,0 36937,1 37019,0 37073,1 37131,0 37198,1 37256,0 37292,1 37328,0 37419,1 37509,0 37529,1 37592,0 37664,1 37730,0 37734,1 37735,0 37739,1 37753,0 37803,1 37877,0 37974,1 38005,0 38039,1 38086,0 38114,1 38123,0 38201,1 38294,0 38305,1 38321,0 38352,1 38364,0 38438,1 38504,0 38594,1 38612,0 38635,1 38677,0 38694,1 38731,0 38797,1 38823,0 38843,1 38864,0 38919,1 39010,0 39089,1 39150,0 39232,1 39287,0 39302,1 39336,0 39349,1 39394,0 39434,1 39506,0 39527,1 39558,0 39568,1 39583,0 39667,1 39683,0 39776,1 39818,0 39858,1 39880,0 39947,1 40025,0 40057,1 40078,0 40083,1 40144,0 40168,1 40266,0 40305,1 40400,0 40438,1 40491,0 40528,1 40566,0 40660,1 40672,0 40755,1 40821,0 40919,1 40980,0 41052,1 41130,0 41190,1 41223,0 41254,1 41298,0 41337,1 41411,0 41454,1 41457,0 41529,1 41620,0 41651,1 41664,0 41667,1 41760,0 41798,1 41857,0 41921,1 41940,0 41943,1 41969,0 41978,1 42001,0 42031,1 42092,0 42188,1 42224,0 42268,1 42342,0 42427,1 42498,0 42506,1 42524,0 42584,1 42618,0 42689,1 42773,0 42817,1 42862,0 42892,1 42902,0 42967,1 43014,0 43068,1 43098,0 43141,1 43212,0 43298,1 43350,0 43383,1 43474,0 43480,1 43509,0 43586,1 43670,0 43736,1 43816,0 43830,1 43917,0 43928,1 44009,0 44030,1 44082,0 44141,1 44184,0 44267,1 44290,0 44327,1 44366,0 44415,1 44501,0 44563,1 44659,0 44756,1 44803,0 44851,1 44886,0 44909,1 44997,0 45062,1 45117,0 45130,1 45140,0 45218,1 45232,0 45310,1 45370,0 45469,1 45506,0 45574,1 45649,0 45673,1 45684,0 45695,1 45770,0 45833,1 45930,0 45958,1 45991,0 46016,1 46101,0 46176,1 46247,0 46279,1 46360,0 46415,1 46450,0 46509,1 46603,0 46618,1 46687,0 46722,1 46820,0 46869,1 46946,0 46988,1 47043,0 47109,1 47195,0 47219,1 47314,0 47344,1 47422,0 47468,1 47567,0 47627,1 47638,0 47641,1 47654,0 47745,1 47796,0 47839,1 47857,0 47870,1 47948,0 48033,1 48039,0 48083,1 48117,0 48208,1 48256,0 48314,1 48350,0 48385,1 48446,0 48486,1 48553,0 48574,1 48663,0 48698,1 48770,0 48781,1 48829,0 48903,1 48978,0 49008,1 49073,0 49141,1 49232,0 49307,1 49365,0 49386,1 49400,0 49407,1 49451,0 49538,1 49626,0 49676,1 49766,0 49860,1 49947,0 49964,1 49987,0 50071,1 50157,0 50168,1 50267,0 50337,1 50348,0 50383,1 50438,0 50469,1 50472,0 50527,1 50605,0 50675,1 50733,0 50817,1 50842,0 50858,1 50926,0 51006,1 end initlist a2 0,0 98,1 124,0 156,1 214,0 266,1 289,0 340,1 440,0 489,1 534,0 624,1 640,0 729,1 809,0 905,1 978,0 1074,1 1087,0 1116,1 1159,0 1224,1 1316,0 1341,1 1403,0 1406,1 1470,0 1526,1 1620,0 1685,1 1687,0 1719,1 1791,0 1890,1 1979,0 2079,1 2117,0 2142,1 2223,0 2282,1 2375,0 2410,1 2454,0 2537,1 2632,0 2651,1 2663,0 2673,1 2725,0 2818,1 2884,0 2962,1 3044,0 3064,1 3146,0 3226,1 3272,0 3341,1 3347,0 3382,1 3438,0 3482,1 3554,0 3577,1 3599,0 3653,1 3690,0 3729,1 3732,0 3769,1 3859,0 3953,1 3979,0 4022,1 4031,0 4047,1 4088,0 4186,1 4261,0 4307,1 4391,0 4447,1 4511,0 4564,1 4609,0 4654,1 4702,0 4721,1 4790,0 4827,1 4889,0 4907,1 4970,0 5040,1 5041,0 5139,1 5181,0 5226,1 5235,0 5259,1 5344,0 5430,1 5485,0 5568,1 5648,0 5687,1 5692,0 5775,1 5831,0 5859,1 5878,0 5965,1 6051,0 6066,1 6083,0 6183,1 6241,0 6327,1 6401,0 6464,1 6550,0 6554,1 6626,0 6698,1 6795,0 6895,1 6967,0 6974,1 7001,0 7025,1 7104,0 7145,1 7234,0 7247,1 7304,0 7323,1 7399,0 7441,1 7534,0 7567,1 7589,0 7674,1 7763,0 7852,1 7925,0 7961,1 7995,0 8080,1 8180,0 8197,1 8257,0 8309,1 8347,0 8376,1 8471,0 8495,1 8579,0 8590,1 8688,0 8693,1 8748,0 8795,1 8883,0 8916,1 8967,0 9027,1 9059,0 9156,1 9173,0 9219,1 9310,0 9351,1 9403,0 9473,1 9518,0 9599,1 9655,0 9731,1 9799,0 9869,1 9884,0 9889,1 9983,0 10010,1 10059,0 10146,1 10244,0 10282,1 10329,0 10330,1 10373,0 10457,1 10557,0 10559,1 10581,0 10650,1 10666,0 10678,1 10720,0 10737,1 10787,0 10871,1 10969,0 11030,1 11093,0 11107,1 11206,0 11280,1 11367,0 11434,1 11480,0 11532,1 11599,0 11688,1 11735,0 11749,1 11814,0 11846,1 11883,0 11900,1 11919,0 11977,1 12073,0 12115,1 12127,0 12137,1 12234,0 12245,1 12333,0 12404,1 12422,0 12518,1 12520,0 12554,1 12596,0 12639,1 12681,0 12762,1 12792,0 12856,1 12936,0 13011,1 13030,0 13036,1 13132,0 13158,1 13228,0 13258,1 13262,0 13349,1 13424,0 13502,1 13572,0 13624,1 13654,0 13717,1 13725,0 13741,1 13838,0 13938,1 14035,0 14063,1 14070,0 14117,1 14164,0 14236,1 14320,0 14343,1 14380,0 14395,1 14406,0 14453,1 14537,0 14633,1 14635,0 14722,1 14734,0 14770,1 14778,0 14876,1 14926,0 14962,1 15054,0 15099,1 15174,0 15185,1 15207,0 15256,1 15277,0 15320,1 15337,0 15371,1 15406,0 15465,1 15544,0 15619,1 15664,0 15722,1 15771,0 15851,1 15881,0 15974,1 15995,0 16019,1 16048,0 16074,1 16105,0 16145,1 16230,0 16247,1 16257,0 16344,1 16392,0 16450,1 16491,0 16505,1 16510,0 16516,1 16577,0 16623,1 16696,0 16743,1 16800,0 16875,1 16887,0 16901,1 16949,0 16986,1 16993,0 17072,1 17087,0 17161,1 17208,0 17227,1 17300,0 17324,1 17347,0 17416,1 17422,0 17491,1 17567,0 17642,1 17714,0 17761,1 17811,0 17860,1 17947,0 17982,1 18046,0 18068,1 18072,0 18103,1 18199,0 18231,1 18253,0 18296,1 18379,0 18421,1 18467,0 18476,1 18508,0 18523,1 18541,0 18577,1 18614,0 18641,1 18650,0 18657,1 18688,0 18704,1 18765,0 18782,1 18854,0 18856,1 18917,0 18997,1 19060,0 19151,1 19244,0 19312,1 19350,0 19397,1 19432,0 19525,1 19606,0 19669,1 19740,0 19777,1 19862,0 19962,1 19975,0 20003,1 20079,0 20152,1 20182,0 20238,1 20239,0 20261,1 20290,0 20384,1 20472,0 20531,1 20539,0 20635,1 20685,0 20761,1 20836,0 20846,1 20892,0 20902,1 21000,0 21065,1 21160,0 21194,1 21261,0 21339,1 21418,0 21460,1 21539,0 21586,1 21646,0 21746,1 21791,0 21833,1 21924,0 21958,1 22002,0 22009,1 22094,0 22119,1 22201,0 22275,1 22282,0 22369,1 22389,0 22424,1 22474,0 22496,1 22590,0 22668,1 22672,0 22754,1 22782,0 22791,1 22890,0 22984,1 23023,0 23040,1 23059,0 23142,1 23181,0 23274,1 23354,0 23396,1 23443,0 23468,1 23562,0 23635,1 23669,0 23747,1 23765,0 23834,1 23919,0 23959,1 23983,0 23989,1 24068,0 24147,1 24231,0 24310,1 24364,0 24405,1 24446,0 24469,1 24476,0 24562,1 24637,0 24689,1 24756,0 24785,1 24877,0 24921,1 25002,0 25051,1 25101,0 25184,1 25237,0 25248,1 25251,0 25345,1 25367,0 25407,1 25428,0 25518,1 25530,0 25624,1 25647,0 25691,1 25754,0 25853,1 25889,0 25919,1 25937,0 26033,1 26037,0 26069,1 26071,0 26095,1 26180,0 26214,1 26300,0 26303,1 26342,0 26408,1 26441,0 26446,1 26476,0 26568,1 26621,0 26706,1 26717,0 26747,1 26766,0 26785,1 26842,0 26909,1 26913,0 27004,1 27014,0 27099,1 27105,0 27167,1 27186,0 27237,1 27310,0 27318,1 27400,0 27417,1 27483,0 27533,1 27586,0 27615,1 27656,0 27706,1 27718,0 27782,1 27877,0 27976,1 28001,0 28043,1 28120,0 28215,1 28238,0 28304,1 28380,0 28384,1 28437,0 28502,1 28560,0 28610,1 28678,0 28762,1 28852,0 28856,1 28868,0 28872,1 28888,0 28956,1 28963,0 29032,1 29049,0 29071,1 29079,0 29150,1 29227,0 29276,1 29316,0 29340,1 29400,0 29401,1 29491,0 29581,1 29674,0 29698,1 29725,0 29750,1 29756,0 29816,1 29883,0 29903,1 29931,0 30028,1 30079,0 30085,1 30100,0 30167,1 30215,0 30279,1 30350,0 30389,1 30391,0 30420,1 30428,0 30503,1 30576,0 30669,1 30746,0 30788,1 30854,0 30911,1 30953,0 31018,1 31030,0 31119,1 31178,0 31261,1 31298,0 31373,1 31390,0 31469,1 31489,0 31521,1 31527,0 31610,1 31676,0 31730,1 31820,0 31861,1 31958,0 32042,1 32142,0 32195,1 32225,0 32320,1 32360,0 32411,1 32479,0 32491,1 32584,0 32623,1 32708,0 32764,1 32820,0 32839,1 32845,0 32936,1 33032,0 33088,1 33148,0 33150,1 33166,0 33199,1 33272,0 33366,1 33389,0 33417,1 33511,0 33536,1 33554,0 33619,1 33710,0 33804,1 33839,0 33922,1 34018,0 34037,1 34102,0 34131,1 34196,0 34278,1 34304,0 34371,1 34430,0 34439,1 34441,0 34481,1 34562,0 34644,1 34649,0 34723,1 34762,0 34859,1 34883,0 34954,1 35034,0 35068,1 35089,0 35135,1 35235,0 35271,1 35363,0 35398,1 35440,0 35479,1 35485,0 35549,1 35595,0 35651,1 35682,0 35732,1 35782,0 35853,1 35861,0 35891,1 35925,0 35943,1 35945,0 36008,1 36032,0 36039,1 36047,0 36091,1 36119,0 36138,1 36200,0 36208,1 36282,0 36378,1 36427,0 36523,1 36598,0 36694,1 36778,0 36849,1 36857,0 36907,1 37007,0 37107,1 37124,0 37221,1 37240,0 37280,1 37329,0 37345,1 37366,0 37376,1 37400,0 37466,1 37506,0 37572,1 37629,0 37658,1 37697,0 37792,1 37823,0 37891,1 37940,0 38001,1 38033,0 38058,1 38089,0 38090,1 38164,0 38211,1 38264,0 38358,1 38406,0 38462,1 38562,0 38576,1 38667,0 38712,1 38727,0 38748,1 38795,0 38892,1 38919,0 38998,1 39007,0 39012,1 39073,0 39172,1 39182,0 39259,1 39313,0 39404,1 39477,0 39506,1 39574,0 39663,1 39738,0 39833,1 39889,0 39899,1 39983,0 40020,1 40058,0 40118,1 40146,0 40172,1 40241,0 40322,1 40415,0 40506,1 40587,0 40620,1 40698,0 40786,1 40818,0 40875,1 40968,0 41046,1 41107,0 41192,1 41255,0 41282,1 41369,0 41421,1 41471,0 41503,1 41552,0 41616,1 41666,0 41710,1 41747,0 41769,1 41856,0 41933,1 42004,0 42103,1 42115,0 42170,1 42181,0 42185,1 42282,0 42302,1 42364,0 42392,1 42401,0 42432,1 42486,0 42563,1 42641,0 42707,1 42755,0 42820,1 42826,0 42894,1 42927,0 42973,1 43068,0 43149,1 43163,0 43214,1 43254,0 43304,1 43306,0 43354,1 43410,0 43432,1 43512,0 43531,1 43538,0 43614,1 43681,0 43764,1 43840,0 43865,1 43952,0 44041,1 44132,0 44214,1 44255,0 44354,1 44453,0 44530,1 44617,0 44633,1 44707,0 44721,1 44797,0 44892,1 44918,0 44921,1 44964,0 44989,1 45047,0 45060,1 45105,0 45144,1 45187,0 45228,1 45240,0 45249,1 45344,0 45370,1 45371,0 45387,1 45441,0 45491,1 45497,0 45513,1 45525,0 45610,1 45687,0 45711,1 45780,0 45824,1 45841,0 45851,1 45949,0 46038,1 46074,0 46113,1 46131,0 46184,1 46187,0 46277,1 46349,0 46426,1 46431,0 46485,1 46581,0 46586,1 46621,0 46631,1 46642,0 46663,1 46674,0 46772,1 46785,0 46819,1 46844,0 46878,1 46882,0 46897,1 46942,0 47009,1 47106,0 47186,1 47244,0 47297,1 47314,0 47372,1 47441,0 47463,1 47515,0 47572,1 47666,0 47703,1 47717,0 47779,1 47800,0 47894,1 47974,0 48039,1 48114,0 48204,1 48223,0 48321,1 48362,0 48410,1 48502,0 48595,1 48671,0 48738,1 48800,0 48849,1 48931,0 48953,1 48958,0 48994,1 49074,0 49133,1 49159,0 49199,1 49283,0 49321,1 49404,0 49503,1 49562,0 49565,1 49580,0 49613,1 49617,0 49685,1 49702,0 49761,1 49784,0 49856,1 49879,0 49947,1 49956,0 49997,1 50041,0 50137,1 50220,0 50265,1 50280,0 50286,1 50368,0 50455,1 50474,0 50486,1 50553,0 50652,1 50727,0 50787,1 50802,0 50897,1 50990,0 51038,1 end initlist a3 0,0 13,1 90,0 120,1 198,0 278,1 313,0 340,1 430,0 506,1 585,0 669,1 693,0 724,1 787,0 876,1 964,0 1028,1 1093,0 1104,1 1122,0 1218,1 1306,0 1373,1 1454,0 1500,1 1600,0 1604,1 1688,0 1689,1 1727,0 1786,1 1820,0 1859,1 1953,0 2038,1 2066,0 2129,1 2202,0 2208,1 2257,0 2313,1 2347,0 2419,1 2489,0 2570,1 2638,0 2657,1 2751,0 2780,1 2869,0 2914,1 2982,0 3065,1 3122,0 3165,1 3222,0 3228,1 3237,0 3267,1 3360,0 3393,1 3484,0 3492,1 3544,0 3637,1 3719,0 3734,1 3812,0 3901,1 3925,0 4008,1 4012,0 4067,1 4129,0 4145,1 4245,0 4274,1 4342,0 4346,1 4426,0 4438,1 4538,0 4548,1 4601,0 4651,1 4657,0 4737,1 4813,0 4898,1 4899,0 4971,1 5013,0 5015,1 5079,0 5164,1 5196,0 5279,1 5280,0 5304,1 5364,0 5449,1 5518,0 5542,1 5569,0 5630,1 5694,0 5790,1 5890,0 5905,1 5919,0 5966,1 6063,0 6068,1 6152,0 6245,1 6270,0 6319,1 6379,0 6473,1 6505,0 6553,1 6623,0 6649,1 6705,0 6720,1 6789,0 6796,1 6822,0 6884,1 6916,0 6953,1 6961,0 7060,1 7134,0 7155,1 7254,0 7266,1 7349,0 7382,1 7383,0 7398,1 7415,0 7454,1 7522,0 7542,1 7628,0 7708,1 7761,0 7825,1 7913,0 7940,1 7952,0 7976,1 8022,0 8096,1 8108,0 8121,1 8130,0 8164,1 8224,0 8305,1 8358,0 8434,1 8513,0 8575,1 8647,0 8665,1 8712,0 8739,1 8780,0 8799,1 8850,0 8881,1 8939,0 9007,1 9081,0 9137,1 9218,0 9241,1 9297,0 9348,1 9436,0 9506,1 9598,0 9647,1 9649,0 9704,1 9762,0 9817,1 9888,0 9913,1 9921,0 9989,1 10061,0 10081,1 10149,0 10158,1 10171,0 10195,1 10249,0 10317,1 10393,0 10435,1 10480,0 10558,1 10595,0 10616,1 10691,0 10781,1 10796,0 10802,1 10869,0 10936,1 11007,0 11089,1 11125,0 11182,1 11278,0 11334,1 11351,0 11360,1 11452,0 11457,1 11486,0 11551,1 11597,0 11693,1 11766,0 11808,1 11852,0 11919,1 11931,0 12007,1 12051,0 12109,1 12175,0 12264,1 12279,0 12325,1 12353,0 12432,1 12509,0 12585,1 12647,0 12705,1 12706,0 12794,1 12843,0 12921,1 13007,0 13080,1 13108,0 13112,1 13151,0 13177,1 13203,0 13287,1 13340,0 13395,1 13455,0 13498,1 13568,0 13603,1 13643,0 13688,1 13711,0 13767,1 13854,0 13879,1 13965,0 13972,1 14018,0 14101,1 14127,0 14195,1 14216,0 14248,1 14282,0 14358,1 14398,0 14487,1 14574,0 14667,1 14741,0 14830,1 14873,0 14908,1 14979,0 15008,1 15060,0 15134,1 15210,0 15238,1 15273,0 15323,1 15367,0 15428,1 15505,0 15567,1 15656,0 15660,1 15711,0 15804,1 15857,0 15955,1 16007,0 16011,1 16069,0 16159,1 16168,0 16231,1 16260,0 16327,1 16338,0 16377,1 16423,0 16476,1 16541,0 16572,1 16615,0 16652,1 16750,0 16796,1 16857,0 16917,1 17005,0 17044,1 17095,0 17176,1 17211,0 17254,1 17284,0 17304,1 17327,0 17352,1 17425,0 17436,1 17439,0 17520,1 17595,0 17638,1 17682,0 17761,1 17836,0 17935,1 17969,0 18010,1 18102,0 18162,1 18172,0 18213,1 18258,0 18334,1 18378,0 18472,1 18480,0 18574,1 18639,0 18674,1 18750,0 18835,1 18848,0 18906,1 18947,0 19046,1 19069,0 19084,1 19107,0 19171,1 19200,0 19229,1 19321,0 19412,1 19490,0 19492,1 19535,0 19627,1 19681,0 19755,1 19760,0 19792,1 19856,0 19926,1 19948,0 20017,1 20112,0 20186,1 20210,0 20297,1 20358,0 20429,1 20493,0 20553,1 20616,0 20708,1 20773,0 20812,1 20829,0 20855,1 20893,0 20939,1 20941,0 21011,1 21111,0 21193,1 21215,0 21232,1 21320,0 21356,1 21430,0 21442,1 21534,0 21592,1 21687,0 21770,1 21835,0 21915,1 21968,0 21974,1 22011,0 22046,1 22064,0 22069,1 22142,0 22196,1 22259,0 22304,1 22329,0 22409,1 22453,0 22534,1 22632,0 22714,1 22770,0 22801,1 22888,0 22921,1 22978,0 23009,1 23097,0 23172,1 23251,0 23306,1 23394,0 23439,1 23504,0 23561,1 23578,0 23592,1 23604,0 23692,1 23694,0 23772,1 23869,0 23913,1 23932,0 24006,1 24033,0 24042,1 24079,0 24144,1 24219,0 24290,1 24379,0 24439,1 24534,0 24605,1 24693,0 24735,1 24771,0 24777,1 24861,0 24889,1 24920,0 24993,1 25043,0 25136,1 25148,0 25206,1 25261,0 25347,1 25393,0 25432,1 25493,0 25527,1 25597,0 25691,1 25766,0 25809,1 25878,0 25970,1 26018,0 26049,1 26122,0 26143,1 26206,0 26262,1 26284,0 26340,1 26349,0 26394,1 26432,0 26479,1 26554,0 26567,1 26632,0 26655,1 26740,0 26762,1 26800,0 26897,1 26985,0 26992,1 27034,0 27060,1 27155,0 27250,1 27251,0 27257,1 27282,0 27288,1 27363,0 27398,1 27429,0 27518,1 27606,0 27647,1 27684,0 27772,1 27815,0 27864,1 27941,0 28014,1 28037,0 28050,1 28067,0 28095,1 28098,0 28175,1 28248,0 28260,1 28331,0 28341,1 28364,0 28392,1 28424,0 28447,1 28473,0 28530,1 28568,0 28625,1 28693,0 28789,1 28820,0 28894,1 28975,0 29012,1 29046,0 29094,1 29178,0 29250,1 29338,0 29389,1 29448,0 29507,1 29544,0 29629,1 29708,0 29738,1 29796,0 29822,1 29839,0 29938,1 29974,0 29984,1 30030,0 30043,1 30111,0 30160,1 30184,0 30199,1 30294,0 30313,1 30403,0 30445,1 30511,0 30605,1 30696,0 30752,1 30770,0 30837,1 30911,0 30923,1 31023,0 31073,1 31082,0 31119,1 31146,0 31191,1 31291,0 31367,1 31441,0 31447,1 31536,0 31626,1 31715,0 31787,1 31858,0 31926,1 32016,0 32060,1 32115,0 32194,1 32248,0 32313,1 32388,0 32436,1 32481,0 32511,1 32537,0 32576,1 32626,0 32627,1 32722,0 32811,1 32864,0 32890,1 32980,0 33071,1 33168,0 33193,1 33202,0 33260,1 33303,0 33384,1 33385,0 33410,1 33481,0 33565,1 33578,0 33665,1 33717,0 33732,1 33764,0 33831,1 33878,0 33945,1 34030,0 34032,1 34108,0 34168,1 34227,0 34243,1 34338,0 34427,1 34454,0 34533,1 34562,0 34631,1 34642,0 34645,1 34719,0 34780,1 34822,0 34917,1 34975,0 35031,1 35105,0 35160,1 35181,0 35213,1 35232,0 35302,1 35326,0 35353,1 35367,0 35388,1 35453,0 35475,1 35555,0 35624,1 35698,0 35741,1 35767,0 35866,1 35879,0 35899,1 35905,0 35977,1 36009,0 36049,1 36101,0 36143,1 36164,0 36177,1 36195,0 36229,1 36278,0 36336,1 36368,0 36455,1 36463,0 36517,1 36537,0 36588,1 36647,0 36713,1 36719,0 36807,1 36846,0 36929,1 36944,0 36945,1 36977,0 37028,1 37063,0 37084,1 37128,0 37173,1 37199,0 37231,1 37285,0 37338,1 37437,0 37496,1 37554,0 37558,1 37575,0 37673,1 37729,0 37759,1 37851,0 37873,1 37896,0 37919,1 37977,0 38071,1 38112,0 38148,1 38248,0 38277,1 38335,0 38342,1 38409,0 38449,1 38497,0 38544,1 38634,0 38639,1 38712,0 38752,1 38793,0 38831,1 38907,0 38914,1 38974,0 38997,1 39025,0 39035,1 39055,0 39092,1 39168,0 39169,1 39256,0 39327,1 39414,0 39417,1 39435,0 39440,1 39532,0 39576,1 39603,0 39605,1 39656,0 39664,1 39701,0 39736,1 39805,0 39857,1 39929,0 39954,1 39997,0 40070,1 40073,0 40152,1 40184,0 40205,1 40211,0 40265,1 40333,0 40404,1 40449,0 40487,1 40539,0 40608,1 40678,0 40742,1 40772,0 40806,1 40841,0 40852,1 40911,0 40916,1 40963,0 41024,1 41034,0 41075,1 41168,0 41217,1 41296,0 41358,1 41399,0 41489,1 41542,0 41555,1 41651,0 41682,1 41780,0 41815,1 41896,0 41904,1 41937,0 42002,1 42047,0 42081,1 42123,0 42184,1 42248,0 42284,1 42355,0 42444,1 42464,0 42518,1 42581,0 42618,1 42661,0 42695,1 42771,0 42842,1 42924,0 43012,1 43023,0 43078,1 43166,0 43193,1 43290,0 43338,1 43350,0 43428,1 43479,0 43488,1 43529,0 43585,1 43608,0 43699,1 43707,0 43775,1 43796,0 43797,1 43888,0 43894,1 43967,0 44023,1 44071,0 44120,1 44151,0 44240,1 44306,0 44321,1 44383,0 44469,1 44550,0 44561,1 44567,0 44614,1 44615,0 44700,1 44790,0 44841,1 44863,0 44888,1 44931,0 45016,1 45076,0 45087,1 45141,0 45159,1 45173,0 45234,1 45299,0 45359,1 45398,0 45423,1 45436,0 45535,1 45604,0 45669,1 45752,0 45794,1 45864,0 45903,1 45955,0 46048,1 46067,0 46135,1 46218,0 46252,1 46255,0 46288,1 46328,0 46370,1 46451,0 46499,1 46554,0 46604,1 46671,0 46720,1 46766,0 46811,1 46902,0 46935,1 47005,0 47020,1 47037,0 47073,1 47080,0 47121,1 47202,0 47264,1 47269,0 47317,1 47324,0 47394,1 47414,0 47469,1 47508,0 47524,1 47593,0 47680,1 47765,0 47853,1 47854,0 47858,1 47896,0 47940,1 48005,0 48064,1 48119,0 48205,1 48248,0 48271,1 48308,0 48334,1 48391,0 48474,1 48520,0 48608,1 48668,0 48694,1 48721,0 48774,1 48853,0 48908,1 48921,0 48984,1 49016,0 49033,1 49065,0 49131,1 49169,0 49204,1 49216,0 49251,1 49319,0 49322,1 49400,0 49408,1 49498,0 49563,1 49571,0 49612,1 49668,0 49763,1 49801,0 49887,1 49889,0 49956,1 49989,0 50046,1 50118,0 50216,1 50271,0 50295,1 50394,0 50442,1 50486,0 50542,1 50619,0 50681,1 50687,0 50689,1 end initlist a4 0,0 1,1 96,0 129,1 196,0 266,1 316,0 381,1 399,0 443,1 447,0 458,1 514,0 554,1 649,0 692,1 732,0 790,1 875,0 963,1 1003,0 1070,1 1140,0 1235,1 1316,0 1354,1 1446,0 1462,1 1484,0 1549,1 1616,0 1646,1 1685,0 1702,1 1798,0 1861,1 1889,0 1975,1 2044,0 2060,1 2101,0 2178,1 2266,0 2342,1 2349,0 2435,1 2489,0 2535,1 2566,0 2570,1 2571,0 2590,1 2634,0 2711,1 2713,0 2720,1 2768,0 2777,1 2866,0 2951,1 3004,0 3069,1 3155,0 3171,1 3221,0 3269,1 3316,0 3376,1 3454,0 3521,1 3539,0 3624,1 3678,0 3697,1 3749,0 3797,1 3860,0 3917,1 4003,0 4027,1 4090,0 4172,1 4208,0 4279,1 4322,0 4370,1 4437,0 4484,1 4579,0 4650,1 4678,0 4714,1 4727,0 4736,1 4762,0 4836,1 4860,0 4893,1 4990,0 5071,1 5117,0 5205,1 5304,0 5373,1 5452,0 5464,1 5478,0 5506,1 5555,0 5583,1 5649,0 5725,1 5809,0 5871,1 5971,0 6017,1 6060,0 6069,1 6106,0 6200,1 6226,0 6261,1 6322,0 6334,1 6343,0 6372,1 6436,0 6536,1 6544,0 6559,1 6600,0 6634,1 6654,0 6742,1 6777,0 6803,1 6840,0 6888,1 6970,0 7050,1 7094,0 7174,1 7260,0 7279,1 7369,0 7465,1 7546,0 7607,1 7613,0 7662,1 7705,0 7709,1 7790,0 7797,1 7860,0 7905,1 7949,0 8020,1 8062,0 8103,1 8171,0 8248,1 8270,0 8273,1 8292,0 8353,1 8384,0 8405,1 8423,0 8511,1 8586,0 8634,1 8724,0 8821,1 8840,0 8931,1 8998,0 9097,1 9163,0 9257,1 9343,0 9412,1 9474,0 9495,1 9501,0 9538,1 9561,0 9601,1 9685,0 9714,1 9725,0 9823,1 9859,0 9895,1 9969,0 10046,1 10049,0 10067,1 10165,0 10238,1 10296,0 10392,1 10491,0 10552,1 10587,0 10592,1 10636,0 10643,1 10693,0 10712,1 10738,0 10804,1 10824,0 10863,1 10949,0 10968,1 11011,0 11018,1 11032,0 11081,1 11179,0 11246,1 11303,0 11403,1 11490,0 11538,1 11598,0 11642,1 11706,0 11717,1 11785,0 11825,1 11877,0 11921,1 11950,0 11999,1 12085,0 12115,1 12202,0 12221,1 12244,0 12281,1 12299,0 12302,1 12337,0 12365,1 12464,0 12559,1 12637,0 12652,1 12656,0 12659,1 12683,0 12742,1 12805,0 12815,1 12897,0 12965,1 13018,0 13111,1 13162,0 13185,1 13252,0 13254,1 13313,0 13356,1 13404,0 13450,1 13546,0 13636,1 13656,0 13690,1 13724,0 13774,1 13832,0 13879,1 13888,0 13925,1 13979,0 14075,1 14087,0 14097,1 14130,0 14168,1 14174,0 14185,1 14251,0 14270,1 14325,0 14341,1 14359,0 14444,1 14534,0 14552,1 14636,0 14712,1 14754,0 14790,1 14883,0 14887,1 14950,0 14952,1 15036,0 15075,1 15131,0 15221,1 15238,0 15276,1 15322,0 15333,1 15381,0 15383,1 15478,0 15491,1 15529,0 15597,1 15650,0 15653,1 15698,0 15756,1 15827,0 15839,1 15866,0 15888,1 15910,0 15975,1 16065,0 16103,1 16114,0 16135,1 16188,0 16278,1 16340,0 16376,1 16434,0 16503,1 16556,0 16576,1 16653,0 16702,1 16712,0 16766,1 16866,0 16898,1 16974,0 17071,1 17118,0 17180,1 17246,0 17269,1 17366,0 17466,1 17476,0 17477,1 17552,0 17642,1 17683,0 17695,1 17755,0 17833,1 17928,0 17966,1 18049,0 18052,1 18138,0 18208,1 18266,0 18364,1 18464,0 18537,1 18555,0 18645,1 18709,0 18721,1 18749,0 18764,1 18784,0 18833,1 18844,0 18912,1 19008,0 19014,1 19074,0 19160,1 19196,0 19254,1 19295,0 19305,1 19363,0 19406,1 19451,0 19497,1 19511,0 19587,1 19654,0 19718,1 19741,0 19838,1 19924,0 19994,1 20002,0 20066,1 20129,0 20191,1 20270,0 20340,1 20364,0 20445,1 20484,0 20569,1 20591,0 20621,1 20687,0 20759,1 20771,0 20805,1 20895,0 20976,1 21017,0 21061,1 21113,0 21189,1 21231,0 21280,1 21365,0 21427,1 21518,0 21550,1 21593,0 21632,1 21730,0 21776,1 21779,0 21824,1 21873,0 21965,1 22004,0 22022,1 22062,0 22080,1 22172,0 22237,1 22283,0 22349,1 22371,0 22445,1 22460,0 22537,1 22598,0 22653,1 22676,0 22696,1 22754,0 22809,1 22825,0 22857,1 22881,0 22932,1 23002,0 23096,1 23116,0 23121,1 23159,0 23254,1 23255,0 23284,1 23347,0 23350,1 23371,0 23396,1 23449,0 23495,1 23593,0 23634,1 23694,0 23726,1 23776,0 23810,1 23854,0 23936,1 24026,0 24049,1 24110,0 24127,1 24163,0 24237,1 24261,0 24272,1 24357,0 24366,1 24449,0 24525,1 24587,0 24646,1 24720,0 24820,1 24869,0 24938,1 24942,0 25012,1 25082,0 25160,1 25220,0 25281,1 25300,0 25313,1 25316,0 25358,1 25376,0 25476,1 25532,0 25629,1 25679,0 25685,1 25772,0 25826,1 25904,0 25999,1 26084,0 26170,1 26267,0 26364,1 26431,0 26464,1 26542,0 26574,1 26582,0 26600,1 26659,0 26753,1 26758,0 26778,1 26823,0 26866,1 26907,0 27001,1 27054,0 27080,1 27094,0 27181,1 27276,0 27358,1 27405,0 27487,1 27537,0 27581,1 27608,0 27663,1 27759,0 27764,1 27821,0 27829,1 27861,0 27902,1 27918,0 27972,1 28023,0 28066,1 28160,0 28193,1 28292,0 28296,1 28374,0 28382,1 28452,0 28533,1 28585,0 28625,1 28725,0 28782,1 28790,0 28890,1 28971,0 28985,1 29027,0 29092,1 29120,0 29206,1 29273,0 29279,1 29332,0 29394,1 29450,0 29486,1 29558,0 29570,1 29603,0 29655,1 29709,0 29775,1 29794,0 29879,1 29967,0 29992,1 30027,0 30061,1 30104,0 30186,1 30281,0 30381,1 30418,0 30479,1 30503,0 30524,1 30546,0 30641,1 30721,0 30803,1 30865,0 30957,1 30985,0 31078,1 31141,0 31220,1 31303,0 31330,1 31343,0 31423,1 31518,0 31588,1 31648,0 31654,1 31751,0 31835,1 31884,0 31900,1 31912,0 31960,1 32019,0 32086,1 32093,0 32192,1 32258,0 32357,1 32367,0 32378,1 32416,0 32470,1 32504,0 32550,1 32615,0 32706,1 32779,0 32816,1 32862,0 32864,1 32963,0 32999,1 33063,0 33159,1 33227,0 33287,1 33299,0 33319,1 33346,0 33437,1 33490,0 33539,1 33621,0 33711,1 33803,0 33902,1 33934,0 33944,1 34015,0 34036,1 34127,0 34191,1 34220,0 34317,1 34330,0 34425,1 34431,0 34482,1 34499,0 34595,1 34645,0 34666,1 34761,0 34803,1 34884,0 34913,1 34950,0 35044,1 35115,0 35156,1 35218,0 35317,1 35347,0 35368,1 35438,0 35450,1 35532,0 35594,1 35605,0 35664,1 35714,0 35752,1 35812,0 35881,1 35977,0 36049,1 36064,0 36136,1 36151,0 36155,1 36230,0 36311,1 36333,0 36409,1 36431,0 36508,1 36603,0 36644,1 36727,0 36767,1 36797,0 36858,1 36900,0 36974,1 37051,0 37108,1 37155,0 37198,1 37287,0 37338,1 37391,0 37424,1 37473,0 37521,1 37585,0 37655,1 37701,0 37723,1 37777,0 37860,1 37867,0 37946,1 37954,0 37978,1 38026,0 38126,1 38142,0 38233,1 38320,0 38341,1 38415,0 38484,1 38497,0 38502,1 38544,0 38636,1 38655,0 38696,1 38737,0 38777,1 38829,0 38862,1 38893,0 38965,1 39045,0 39092,1 39102,0 39180,1 39186,0 39240,1 39274,0 39359,1 39454,0 39548,1 39557,0 39627,1 39673,0 39721,1 39791,0 39807,1 39847,0 39890,1 39901,0 39927,1 39950,0 40017,1 40096,0 40141,1 40217,0 40248,1 40262,0 40330,1 40335,0 40350,1 40397,0 40457,1 40497,0 40593,1 40652,0 40726,1 40747,0 40842,1 40850,0 40910,1 40933,0 40992,1 41082,0 41102,1 41129,0 41205,1 41219,0 41288,1 41335,0 41430,1 41506,0 41545,1 41642,0 41684,1 41716,0 41751,1 41831,0 41834,1 41897,0 41969,1 41983,0 42062,1 42095,0 42195,1 42196,0 42274,1 42322,0 42390,1 42455,0 42524,1 42596,0 42603,1 42684,0 42716,1 42723,0 42810,1 42816,0 42914,1 42954,0 42999,1 43001,0 43032,1 43075,0 43163,1 43257,0 43267,1 43298,0 43337,1 43340,0 43431,1 43520,0 43609,1 43669,0 43704,1 43721,0 43819,1 43841,0 43939,1 44036,0 44093,1 44121,0 44171,1 44226,0 44255,1 44307,0 44393,1 44474,0 44496,1 44577,0 44665,1 44696,0 44752,1 44783,0 44872,1 44965,0 44971,1 45060,0 45086,1 45136,0 45204,1 45233,0 45277,1 45355,0 45390,1 45431,0 45465,1 45487,0 45504,1 45518,0 45609,1 45656,0 45682,1 45712,0 45759,1 45796,0 45830,1 45858,0 45896,1 45956,0 45996,1 46059,0 46128,1 46163,0 46228,1 46245,0 46278,1 46363,0 46415,1 46428,0 46485,1 46555,0 46643,1 46679,0 46756,1 46821,0 46862,1 46894,0 46989,1 47023,0 47069,1 47107,0 47163,1 47238,0 47291,1 47389,0 47452,1 47511,0 47544,1 47610,0 47685,1 47771,0 47782,1 47863,0 47910,1 47954,0 48012,1 48081,0 48148,1 48183,0 48191,1 48280,0 48307,1 48359,0 48399,1 48428,0 48482,1 48485,0 48551,1 48602,0 48605,1 48608,0 48647,1 48696,0 48705,1 48754,0 48814,1 48885,0 48964,1 49042,0 49095,1 49111,0 49164,1 49257,0 49325,1 49348,0 49374,1 49401,0 49408,1 49482,0 49545,1 49594,0 49641,1 49658,0 49663,1 49734,0 49757,1 49832,0 49878,1 49887,0 49939,1 50026,0 50039,1 50052,0 50128,1 50205,0 50264,1 50318,0 50385,1 50462,0 50480,1 50575,0 50616,1 50690,0 50779,1 50783,0 50850,1 50917,0 50986,1 51035,0 51119,1 51214,0 51281,1 end initlist a5 0,0 66,1 94,0 146,1 153,0 220,1 292,0 390,1 428,0 460,1 521,0 565,1 588,0 666,1 745,0 801,1 898,0 962,1 1048,0 1079,1 1116,0 1151,1 1242,0 1267,1 1296,0 1373,1 1438,0 1476,1 1523,0 1582,1 1640,0 1705,1 1730,0 1787,1 1852,0 1890,1 1926,0 1984,1 2084,0 2155,1 2156,0 2233,1 2284,0 2316,1 2379,0 2397,1 2455,0 2536,1 2559,0 2636,1 2662,0 2671,1 2762,0 2768,1 2823,0 2825,1 2827,0 2864,1 2924,0 2982,1 3009,0 3075,1 3116,0 3123,1 3195,0 3221,1 3240,0 3265,1 3303,0 3364,1 3405,0 3465,1 3474,0 3538,1 3579,0 3657,1 3700,0 3754,1 3774,0 3799,1 3866,0 3868,1 3904,0 3938,1 3967,0 3968,1 4049,0 4081,1 4135,0 4194,1 4230,0 4255,1 4300,0 4366,1 4390,0 4454,1 4508,0 4587,1 4647,0 4700,1 4798,0 4882,1 4930,0 5010,1 5048,0 5096,1 5099,0 5192,1 5215,0 5300,1 5394,0 5469,1 5531,0 5542,1 5596,0 5643,1 5707,0 5791,1 5827,0 5833,1 5908,0 5949,1 6020,0 6104,1 6132,0 6209,1 6266,0 6319,1 6329,0 6411,1 6473,0 6484,1 6529,0 6552,1 6649,0 6749,1 6844,0 6898,1 6950,0 7002,1 7041,0 7126,1 7152,0 7183,1 7190,0 7219,1 7319,0 7413,1 7483,0 7500,1 7554,0 7584,1 7678,0 7699,1 7766,0 7786,1 7884,0 7901,1 7919,0 7944,1 8022,0 8117,1 8179,0 8241,1 8250,0 8277,1 8324,0 8368,1 8397,0 8490,1 8554,0 8581,1 8629,0 8707,1 8797,0 8822,1 8899,0 8910,1 8981,0 9063,1 9123,0 9198,1 9266,0 9269,1 9341,0 9434,1 9458,0 9510,1 9526,0 9610,1 9640,0 9689,1 9764,0 9862,1 9910,0 9966,1 10040,0 10115,1 10116,0 10178,1 10261,0 10346,1 10430,0 10463,1 10504,0 10543,1 10609,0 10610,1 10643,0 10683,1 10766,0 10832,1 10917,0 11009,1 11075,0 11151,1 11216,0 11277,1 11313,0 11360,1 11382,0 11472,1 11537,0 11543,1 11639,0 11718,1 11740,0 11830,1 11921,0 11935,1 11963,0 12052,1 12070,0 12130,1 12198,0 12239,1 12301,0 12369,1 12410,0 12427,1 12499,0 12514,1 12528,0 12529,1 12539,0 12548,1 12583,0 12617,1 12702,0 12790,1 12842,0 12872,1 12875,0 12965,1 13062,0 13070,1 13149,0 13180,1 13260,0 13330,1 13416,0 13427,1 13512,0 13576,1 13656,0 13728,1 13743,0 13832,1 13930,0 14018,1 14086,0 14093,1 14167,0 14234,1 14326,0 14345,1 14374,0 14417,1 14449,0 14514,1 14541,0 14638,1 14672,0 14691,1 14752,0 14819,1 14858,0 14879,1 14977,0 14982,1 15059,0 15072,1 15096,0 15166,1 15263,0 15318,1 15365,0 15453,1 15485,0 15543,1 15625,0 15653,1 15706,0 15772,1 15870,0 15928,1 16015,0 16090,1 16125,0 16182,1 16213,0 16261,1 16357,0 16411,1 16501,0 16558,1 16573,0 16584,1 16618,0 16631,1 16652,0 16713,1 16716,0 16773,1 16848,0 16906,1 16948,0 16982,1 16986,0 17076,1 17162,0 17224,1 17283,0 17302,1 17401,0 17491,1 17562,0 17571,1 17620,0 17643,1 17684,0 17747,1 17752,0 17778,1 17780,0 17786,1 17802,0 17864,1 17960,0 18015,1 18039,0 18052,1 18145,0 18236,1 18281,0 18288,1 18316,0 18412,1 18500,0 18553,1 18565,0 18613,1 18705,0 18793,1 18859,0 18930,1 19009,0 19055,1 19076,0 19091,1 19131,0 19189,1 19249,0 19261,1 19348,0 19355,1 19410,0 19413,1 19502,0 19582,1 19658,0 19664,1 19741,0 19836,1 19923,0 19954,1 20017,0 20104,1 20117,0 20180,1 20220,0 20301,1 20398,0 20415,1 20507,0 20565,1 20647,0 20725,1 20793,0 20890,1 20899,0 20982,1 21008,0 21087,1 21106,0 21126,1 21188,0 21230,1 21253,0 21327,1 21412,0 21473,1 21566,0 21598,1 21693,0 21751,1 21826,0 21876,1 21921,0 21952,1 22021,0 22084,1 22121,0 22158,1 22192,0 22291,1 22351,0 22390,1 22473,0 22565,1 22657,0 22704,1 22712,0 22777,1 22835,0 22864,1 22917,0 23007,1 23041,0 23069,1 23163,0 23256,1 23306,0 23324,1 23333,0 23374,1 23444,0 23495,1 23569,0 23593,1 23677,0 23757,1 23774,0 23778,1 23835,0 23918,1 23978,0 23998,1 24005,0 24073,1 24144,0 24176,1 24229,0 24283,1 24354,0 24360,1 24368,0 24425,1 24441,0 24506,1 24536,0 24635,1 24636,0 24721,1 24807,0 24842,1 24906,0 24926,1 24959,0 25044,1 25050,0 25133,1 25164,0 25186,1 25273,0 25313,1 25393,0 25407,1 25473,0 25559,1 25566,0 25606,1 25615,0 25669,1 25735,0 25790,1 25841,0 25928,1 26024,0 26069,1 26153,0 26222,1 26301,0 26336,1 26390,0 26422,1 26517,0 26558,1 26621,0 26688,1 26727,0 26809,1 26846,0 26903,1 26975,0 26999,1 27041,0 27069,1 27115,0 27120,1 27145,0 27194,1 27221,0 27223,1 27254,0 27316,1 27376,0 27435,1 27452,0 27547,1 27625,0 27695,1 27762,0 27848,1 27873,0 27931,1 27954,0 27976,1 28015,0 28051,1 28108,0 28187,1 28244,0 28272,1 28299,0 28382,1 28453,0 28478,1 28535,0 28579,1 28662,0 28726,1 28737,0 28784,1 28857,0 28862,1 28913,0 28997,1 29000,0 29059,1 29065,0 29136,1 29155,0 29180,1 29195,0 29229,1 29244,0 29293,1 29338,0 29427,1 29482,0 29570,1 29635,0 29668,1 29754,0 29806,1 29867,0 29878,1 29927,0 29938,1 29939,0 29952,1 29977,0 30012,1 30048,0 30112,1 30154,0 30221,1 30276,0 30352,1 30445,0 30447,1 30535,0 30634,1 30663,0 30733,1 30771,0 30837,1 30861,0 30912,1 30981,0 30983,1 31071,0 31145,1 31221,0 31248,1 31330,0 31335,1 31428,0 31504,1 31533,0 31580,1 31647,0 31656,1 31749,0 31751,1 31833,0 31886,1 31983,0 31986,1 32076,0 32080,1 32145,0 32230,1 32288,0 32353,1 32434,0 32490,1 32501,0 32567,1 32620,0 32714,1 32741,0 32784,1 32866,0 32966,1 32967,0 32982,1 32995,0 33073,1 33135,0 33205,1 33211,0 33213,1 33221,0 33275,1 33358,0 33413,1 33477,0 33564,1 33597,0 33648,1 33680,0 33729,1 33794,0 33800,1 33838,0 33894,1 33993,0 34059,1 34061,0 34144,1 34205,0 34209,1 34265,0 34298,1 34377,0 34437,1 34450,0 34542,1 34552,0 34563,1 34597,0 34673,1 34765,0 34791,1 34814,0 34906,1 34911,0 34961,1 35034,0 35106,1 35186,0 35257,1 35314,0 35398,1 35444,0 35490,1 35506,0 35543,1 35565,0 35595,1 35673,0 35719,1 35795,0 35829,1 35851,0 35902,1 35991,0 36070,1 36088,0 36169,1 36238,0 36281,1 36289,0 36389,1 36472,0 36490,1 36535,0 36608,1 36635,0 36665,1 36717,0 36796,1 36886,0 36930,1 37012,0 37099,1 37124,0 37222,1 37307,0 37370,1 37406,0 37475,1 37513,0 37540,1 37580,0 37662,1 37676,0 37772,1 37834,0 37920,1 37944,0 38019,1 38051,0 38101,1 38146,0 38218,1 38223,0 38266,1 38348,0 38442,1 38517,0 38560,1 38622,0 38677,1 38740,0 38777,1 38801,0 38817,1 38879,0 38910,1 38937,0 39005,1 39097,0 39196,1 39219,0 39301,1 39325,0 39355,1 39393,0 39437,1 39457,0 39535,1 39583,0 39653,1 39677,0 39708,1 39776,0 39819,1 39894,0 39945,1 40002,0 40062,1 40101,0 40123,1 40194,0 40232,1 40290,0 40368,1 40381,0 40401,1 40409,0 40412,1 40504,0 40592,1 40672,0 40740,1 40794,0 40833,1 40918,0 40983,1 41057,0 41109,1 41125,0 41143,1 41152,0 41207,1 41277,0 41356,1 41443,0 41486,1 41530,0 41568,1 41575,0 41582,1 41617,0 41674,1 41710,0 41765,1 41805,0 41886,1 41918,0 41938,1 42002,0 42007,1 42029,0 42098,1 42198,0 42256,1 42300,0 42366,1 42463,0 42490,1 42525,0 42573,1 42605,0 42617,1 42681,0 42682,1 42746,0 42840,1 42925,0 42969,1 43030,0 43036,1 43107,0 43139,1 43205,0 43237,1 43249,0 43276,1 43288,0 43385,1 43393,0 43408,1 43426,0 43486,1 43557,0 43656,1 43735,0 43752,1 43791,0 43875,1 43884,0 43923,1 44016,0 44091,1 44098,0 44124,1 44158,0 44160,1 44190,0 44278,1 44311,0 44395,1 44402,0 44472,1 44520,0 44614,1 44662,0 44721,1 44766,0 44823,1 44910,0 44920,1 44952,0 45020,1 45104,0 45148,1 45224,0 45249,1 45339,0 45393,1 45432,0 45491,1 45582,0 45642,1 45645,0 45668,1 45682,0 45771,1 45832,0 45842,1 45859,0 45893,1 45966,0 46058,1 46119,0 46183,1 46221,0 46241,1 46272,0 46339,1 46340,0 46364,1 46411,0 46461,1 46491,0 46505,1 46533,0 46604,1 46618,0 46628,1 46649,0 46712,1 46750,0 46792,1 46796,0 46819,1 46915,0 46922,1 46979,0 47005,1 47074,0 47103,1 47198,0 47297,1 47319,0 47393,1 47423,0 47514,1 47564,0 47647,1 47730,0 47822,1 47897,0 47948,1 47975,0 48039,1 48099,0 48140,1 48236,0 48327,1 48336,0 48391,1 48427,0 48445,1 48494,0 48583,1 48635,0 48729,1 48800,0 48838,1 48862,0 48939,1 48990,0 48993,1 49086,0 49108,1 49151,0 49152,1 49165,0 49237,1 49239,0 49321,1 49395,0 49423,1 49459,0 49556,1 49559,0 49561,1 49623,0 49626,1 49640,0 49704,1 49747,0 49817,1 49914,0 50000,1 50050,0 50075,1 50140,0 50156,1 50206,0 50248,1 50301,0 50357,1 50411,0 50471,1 50497,0 50584,1 50630,0 50689,1 50720,0 50764,1 50843,0 50937,1 50955,0 51027,1 51079,0 51090,1 end initlist a6 0,0 3,1 52,0 85,1 86,0 96,1 132,0 228,1 238,0 307,1 329,0 341,1 429,0 487,1 565,0 604,1 669,0 727,1 813,0 911,1 958,0 1023,1 1051,0 1099,1 1100,0 1184,1 1238,0 1330,1 1367,0 1382,1 1410,0 1461,1 1469,0 1479,1 1563,0 1623,1 1722,0 1723,1 1816,0 1912,1 1972,0 2062,1 2135,0 2186,1 2207,0 2237,1 2302,0 2353,1 2386,0 2455,1 2531,0 2619,1 2647,0 2651,1 2687,0 2750,1 2810,0 2890,1 2987,0 3071,1 3161,0 3220,1 3237,0 3303,1 3318,0 3415,1 3500,0 3569,1 3669,0 3760,1 3783,0 3793,1 3878,0 3903,1 3969,0 4026,1 4070,0 4097,1 4129,0 4164,1 4260,0 4293,1 4373,0 4439,1 4511,0 4574,1 4666,0 4724,1 4789,0 4882,1 4937,0 4981,1 5014,0 5052,1 5084,0 5090,1 5125,0 5181,1 5236,0 5276,1 5342,0 5390,1 5440,0 5466,1 5492,0 5575,1 5586,0 5636,1 5701,0 5754,1 5818,0 5874,1 5898,0 5920,1 6011,0 6058,1 6154,0 6241,1 6251,0 6281,1 6294,0 6381,1 6468,0 6540,1 6586,0 6683,1 6688,0 6711,1 6792,0 6848,1 6942,0 6976,1 7075,0 7167,1 7247,0 7338,1 7402,0 7421,1 7502,0 7517,1 7600,0 7646,1 7701,0 7799,1 7889,0 7897,1 7913,0 7915,1 7923,0 8015,1 8019,0 8076,1 8129,0 8200,1 8202,0 8244,1 8269,0 8276,1 8298,0 8396,1 8422,0 8511,1 8608,0 8696,1 8751,0 8800,1 8815,0 8848,1 8878,0 8974,1 8983,0 9041,1 9067,0 9163,1 9240,0 9255,1 9260,0 9306,1 9403,0 9424,1 9425,0 9519,1 9575,0 9640,1 9662,0 9684,1 9685,0 9706,1 9759,0 9840,1 9887,0 9910,1 9940,0 9994,1 10093,0 10110,1 10139,0 10167,1 10247,0 10284,1 10367,0 10409,1 10473,0 10524,1 10598,0 10630,1 10693,0 10781,1 10821,0 10840,1 10841,0 10872,1 10916,0 11004,1 11026,0 11094,1 11183,0 11222,1 11316,0 11402,1 11496,0 11500,1 11589,0 11593,1 11667,0 11696,1 11729,0 11821,1 11890,0 11951,1 11972,0 11987,1 12018,0 12068,1 12111,0 12199,1 12228,0 12277,1 12362,0 12413,1 12510,0 12605,1 12663,0 12745,1 12774,0 12790,1 12817,0 12848,1 12902,0 12963,1 13042,0 13044,1 13084,0 13100,1 13191,0 13250,1 13325,0 13398,1 13452,0 13474,1 13537,0 13601,1 13616,0 13636,1 13661,0 13750,1 13788,0 13821,1 13881,0 13890,1 13934,0 13947,1 14019,0 14065,1 14143,0 14236,1 14246,0 14328,1 14334,0 14433,1 14489,0 14505,1 14519,0 14606,1 14687,0 14780,1 14828,0 14868,1 14883,0 14904,1 14968,0 14972,1 15024,0 15084,1 15133,0 15187,1 15277,0 15328,1 15353,0 15436,1 15535,0 15609,1 15665,0 15715,1 15775,0 15847,1 15850,0 15922,1 15928,0 15979,1 16011,0 16060,1 16098,0 16144,1 16179,0 16223,1 16249,0 16343,1 16396,0 16440,1 16476,0 16489,1 16492,0 16582,1 16601,0 16631,1 16642,0 16671,1 16705,0 16711,1 16740,0 16757,1 16770,0 16789,1 16835,0 16928,1 16988,0 17088,1 17130,0 17218,1 17305,0 17308,1 17392,0 17408,1 17426,0 17472,1 17545,0 17629,1 17678,0 17683,1 17761,0 17814,1 17873,0 17877,1 17920,0 17938,1 17942,0 17960,1 18009,0 18023,1 18117,0 18118,1 18120,0 18184,1 18210,0 18285,1 18328,0 18412,1 18432,0 18511,1 18558,0 18579,1 18605,0 18669,1 18681,0 18714,1 18726,0 18812,1 18827,0 18836,1 18926,0 18966,1 19035,0 19098,1 19171,0 19195,1 19249,0 19299,1 19390,0 19454,1 19504,0 19540,1 19597,0 19657,1 19739,0 19795,1 19811,0 19862,1 19946,0 19982,1 20057,0 20100,1 20169,0 20229,1 20269,0 20366,1 20402,0 20448,1 20519,0 20572,1 20642,0 20731,1 20801,0 20853,1 20943,0 20978,1 21015,0 21021,1 21085,0 21172,1 21195,0 21199,1 21278,0 21350,1 21367,0 21402,1 21473,0 21476,1 21536,0 21625,1 21633,0 21684,1 21715,0 21807,1 21853,0 21938,1 22028,0 22098,1 22139,0 22189,1 22261,0 22329,1 22399,0 22499,1 22573,0 22662,1 22733,0 22780,1 22836,0 22903,1 22994,0 23080,1 23176,0 23254,1 23289,0 23378,1 23390,0 23437,1 23523,0 23566,1 23631,0 23728,1 23803,0 23853,1 23901,0 23921,1 24004,0 24098,1 24175,0 24252,1 24262,0 24355,1 24368,0 24392,1 24475,0 24529,1 24566,0 24632,1 24646,0 24706,1 24783,0 24847,1 24926,0 24977,1 25046,0 25065,1 25143,0 25219,1 25313,0 25398,1 25427,0 25453,1 25482,0 25493,1 25557,0 25610,1 25666,0 25734,1 25797,0 25811,1 25895,0 25942,1 25991,0 25995,1 26062,0 26065,1 26123,0 26214,1 26220,0 26305,1 26398,0 26477,1 26527,0 26620,1 26716,0 26751,1 26808,0 26856,1 26921,0 26948,1 27026,0 27031,1 27068,0 27136,1 27140,0 27179,1 27278,0 27354,1 27429,0 27458,1 27499,0 27549,1 27581,0 27675,1 27731,0 27820,1 27863,0 27876,1 27957,0 28022,1 28122,0 28185,1 28203,0 28250,1 28260,0 28331,1 28371,0 28471,1 28522,0 28566,1 28624,0 28642,1 28668,0 28732,1 28775,0 28810,1 28892,0 28926,1 28979,0 29061,1 29134,0 29204,1 29277,0 29314,1 29383,0 29450,1 29523,0 29573,1 29576,0 29672,1 29743,0 29829,1 29878,0 29889,1 29986,0 30001,1 30029,0 30084,1 30092,0 30100,1 30102,0 30131,1 30176,0 30202,1 30213,0 30284,1 30305,0 30311,1 30390,0 30438,1 30520,0 30561,1 30585,0 30595,1 30633,0 30644,1 30719,0 30753,1 30844,0 30914,1 30998,0 31068,1 31137,0 31198,1 31227,0 31254,1 31304,0 31356,1 31442,0 31489,1 31558,0 31614,1 31659,0 31679,1 31704,0 31750,1 31760,0 31834,1 31877,0 31936,1 31990,0 32008,1 32046,0 32093,1 32099,0 32115,1 32197,0 32283,1 32289,0 32350,1 32384,0 32412,1 32491,0 32523,1 32609,0 32704,1 32779,0 32812,1 32842,0 32879,1 32890,0 32928,1 32931,0 32971,1 33061,0 33161,1 33176,0 33235,1 33322,0 33374,1 33392,0 33425,1 33441,0 33464,1 33470,0 33516,1 33608,0 33664,1 33717,0 33779,1 33824,0 33864,1 33953,0 34025,1 34052,0 34149,1 34191,0 34269,1 34368,0 34395,1 34493,0 34572,1 34608,0 34643,1 34689,0 34769,1 34805,0 34860,1 34879,0 34965,1 35058,0 35110,1 35153,0 35180,1 35246,0 35332,1 35360,0 35376,1 35464,0 35526,1 35602,0 35628,1 35629,0 35728,1 35760,0 35784,1 35835,0 35934,1 35980,0 36024,1 36092,0 36173,1 36271,0 36302,1 36332,0 36355,1 36453,0 36509,1 36578,0 36606,1 36616,0 36712,1 36779,0 36805,1 36843,0 36904,1 36936,0 36978,1 37022,0 37090,1 37155,0 37212,1 37214,0 37307,1 37315,0 37377,1 37463,0 37514,1 37525,0 37554,1 37639,0 37653,1 37657,0 37710,1 37796,0 37817,1 37857,0 37877,1 37910,0 37922,1 37999,0 38046,1 38131,0 38133,1 38183,0 38203,1 38292,0 38365,1 38401,0 38446,1 38470,0 38556,1 38591,0 38688,1 38787,0 38818,1 38895,0 38896,1 38973,0 39028,1 39040,0 39070,1 39124,0 39128,1 39169,0 39216,1 39285,0 39371,1 39385,0 39446,1 39526,0 39599,1 39647,0 39705,1 39740,0 39753,1 39845,0 39905,1 39983,0 40079,1 40137,0 40185,1 40202,0 40299,1 40317,0 40379,1 40406,0 40436,1 40480,0 40506,1 40532,0 40569,1 40584,0 40621,1 40702,0 40729,1 40823,0 40903,1 40990,0 41011,1 41042,0 41118,1 41125,0 41151,1 41235,0 41276,1 41346,0 41417,1 41505,0 41586,1 41612,0 41665,1 41691,0 41715,1 41805,0 41884,1 41943,0 42019,1 42065,0 42129,1 42199,0 42273,1 42309,0 42388,1 42395,0 42464,1 42470,0 42519,1 42612,0 42621,1 42627,0 42650,1 42657,0 42750,1 42813,0 42830,1 42832,0 42861,1 42939,0 42980,1 43074,0 43140,1 43147,0 43180,1 43183,0 43236,1 43318,0 43411,1 43444,0 43514,1 43522,0 43604,1 43652,0 43686,1 43704,0 43706,1 43787,0 43849,1 43900,0 43950,1 43983,0 44038,1 44103,0 44166,1 44186,0 44225,1 44261,0 44273,1 44321,0 44329,1 44364,0 44455,1 44531,0 44555,1 44649,0 44748,1 44756,0 44807,1 44858,0 44919,1 45017,0 45087,1 45175,0 45275,1 45323,0 45394,1 45403,0 45437,1 45502,0 45567,1 45607,0 45640,1 45719,0 45806,1 45823,0 45866,1 45867,0 45939,1 46004,0 46076,1 46175,0 46194,1 46232,0 46259,1 46300,0 46372,1 46440,0 46503,1 46531,0 46602,1 46641,0 46706,1 46749,0 46790,1 46886,0 46909,1 46983,0 47068,1 47095,0 47157,1 47222,0 47287,1 47304,0 47342,1 47432,0 47442,1 47482,0 47567,1 47615,0 47713,1 47778,0 47870,1 47948,0 47994,1 47998,0 48007,1 48105,0 48169,1 48221,0 48317,1 48377,0 48418,1 48436,0 48524,1 48598,0 48640,1 48664,0 48727,1 48788,0 48861,1 48888,0 48982,1 49042,0 49130,1 49142,0 49144,1 49152,0 49162,1 49195,0 49200,1 49204,0 49232,1 49245,0 49298,1 49351,0 49357,1 49439,0 49469,1 49472,0 49492,1 49511,0 49522,1 49576,0 49650,1 49717,0 49799,1 49801,0 49843,1 49922,0 50015,1 50099,0 50120,1 50204,0 50302,1 50309,0 50321,1 50418,0 50449,1 50500,0 50501,1 50581,0 50599,1 50659,0 50679,1 50717,0 50762,1 50823,0 50836,1 50868,0 50944,1 50978,0 50980,1 end initlist a7 0,0 20,1 95,0 175,1 193,0 219,1 294,0 366,1 417,0 467,1 560,0 568,1 571,0 651,1 710,0 809,1 883,0 983,1 999,0 1073,1 1099,0 1109,1 1137,0 1162,1 1214,0 1292,1 1390,0 1391,1 1454,0 1479,1 1516,0 1562,1 1653,0 1738,1 1836,0 1930,1 2005,0 2086,1 2090,0 2173,1 2178,0 2240,1 2269,0 2310,1 2314,0 2339,1 2344,0 2375,1 2451,0 2461,1 2515,0 2565,1 2636,0 2650,1 2699,0 2708,1 2801,0 2839,1 2915,0 2973,1 3049,0 3148,1 3170,0 3231,1 3243,0 3291,1 3336,0 3369,1 3429,0 3447,1 3539,0 3593,1 3668,0 3728,1 3761,0 3799,1 3858,0 3925,1 3986,0 4013,1 4104,0 4134,1 4151,0 4248,1 4268,0 4329,1 4344,0 4433,1 4531,0 4551,1 4646,0 4649,1 4719,0 4758,1 4761,0 4802,1 4856,0 4898,1 4929,0 4935,1 4968,0 4988,1 5030,0 5120,1 5141,0 5223,1 5234,0 5242,1 5251,0 5304,1 5368,0 5433,1 5502,0 5527,1 5557,0 5595,1 5630,0 5706,1 5718,0 5796,1 5895,0 5947,1 6040,0 6054,1 6145,0 6170,1 6239,0 6323,1 6373,0 6389,1 6427,0 6443,1 6510,0 6541,1 6625,0 6707,1 6777,0 6844,1 6892,0 6958,1 7031,0 7099,1 7105,0 7172,1 7205,0 7230,1 7327,0 7330,1 7398,0 7406,1 7412,0 7489,1 7513,0 7592,1 7616,0 7691,1 7753,0 7836,1 7856,0 7870,1 7910,0 7937,1 7948,0 8023,1 8110,0 8164,1 8200,0 8210,1 8261,0 8305,1 8353,0 8442,1 8488,0 8515,1 8557,0 8647,1 8742,0 8758,1 8786,0 8851,1 8949,0 9017,1 9114,0 9148,1 9157,0 9225,1 9240,0 9241,1 9248,0 9268,1 9321,0 9411,1 9507,0 9558,1 9642,0 9695,1 9749,0 9774,1 9789,0 9873,1 9914,0 9972,1 10037,0 10059,1 10157,0 10204,1 10231,0 10309,1 10346,0 10432,1 10448,0 10469,1 10480,0 10537,1 10592,0 10677,1 10720,0 10790,1 10822,0 10858,1 10944,0 11002,1 11008,0 11015,1 11054,0 11123,1 11197,0 11216,1 11226,0 11245,1 11310,0 11391,1 11461,0 11541,1 11617,0 11702,1 11714,0 11786,1 11799,0 11813,1 11846,0 11905,1 11930,0 12027,1 12117,0 12171,1 12265,0 12267,1 12269,0 12359,1 12374,0 12454,1 12552,0 12600,1 12682,0 12707,1 12716,0 12790,1 12804,0 12817,1 12890,0 12918,1 12956,0 12985,1 13030,0 13088,1 13124,0 13149,1 13165,0 13242,1 13317,0 13357,1 13382,0 13471,1 13493,0 13502,1 13560,0 13565,1 13593,0 13610,1 13624,0 13644,1 13672,0 13760,1 13761,0 13852,1 13880,0 13954,1 13982,0 14030,1 14081,0 14097,1 14190,0 14266,1 14348,0 14430,1 14456,0 14494,1 14578,0 14656,1 14714,0 14734,1 14741,0 14810,1 14850,0 14889,1 14898,0 14942,1 14970,0 15040,1 15096,0 15162,1 15177,0 15257,1 15327,0 15423,1 15431,0 15456,1 15467,0 15469,1 15487,0 15555,1 15636,0 15686,1 15742,0 15749,1 15841,0 15879,1 15900,0 15936,1 15965,0 16038,1 16111,0 16197,1 16227,0 16293,1 16365,0 16381,1 16397,0 16497,1 16504,0 16571,1 16606,0 16701,1 16744,0 16763,1 16766,0 16785,1 16873,0 16911,1 16947,0 17039,1 17054,0 17130,1 17185,0 17252,1 17303,0 17402,1 17468,0 17526,1 17562,0 17649,1 17724,0 17763,1 17854,0 17922,1 18007,0 18038,1 18122,0 18218,1 18305,0 18337,1 18343,0 18416,1 18500,0 18596,1 18605,0 18630,1 18677,0 18762,1 18802,0 18834,1 18889,0 18913,1 18944,0 19021,1 19033,0 19110,1 19193,0 19258,1 19278,0 19295,1 19336,0 19363,1 19407,0 19474,1 19514,0 19554,1 19587,0 19622,1 19720,0 19723,1 19750,0 19829,1 19830,0 19859,1 19933,0 20033,1 20053,0 20151,1 20232,0 20261,1 20353,0 20372,1 20407,0 20414,1 20431,0 20438,1 20531,0 20598,1 20651,0 20728,1 20738,0 20802,1 20897,0 20959,1 20992,0 21055,1 21147,0 21219,1 21254,0 21326,1 21420,0 21503,1 21540,0 21623,1 21630,0 21728,1 21772,0 21871,1 21940,0 21969,1 21986,0 22010,1 22061,0 22127,1 22136,0 22182,1 22255,0 22278,1 22358,0 22411,1 22489,0 22555,1 22569,0 22580,1 22663,0 22740,1 22796,0 22856,1 22954,0 22989,1 23037,0 23093,1 23183,0 23204,1 23225,0 23309,1 23408,0 23433,1 23445,0 23478,1 23556,0 23596,1 23682,0 23765,1 23856,0 23929,1 24007,0 24105,1 24163,0 24232,1 24240,0 24260,1 24343,0 24400,1 24424,0 24455,1 24472,0 24490,1 24525,0 24552,1 24620,0 24672,1 24766,0 24798,1 24844,0 24906,1 24978,0 25005,1 25048,0 25103,1 25109,0 25203,1 25222,0 25256,1 25340,0 25426,1 25513,0 25516,1 25524,0 25570,1 25616,0 25672,1 25681,0 25686,1 25714,0 25791,1 25879,0 25965,1 26005,0 26026,1 26100,0 26125,1 26170,0 26198,1 26247,0 26293,1 26331,0 26404,1 26435,0 26461,1 26541,0 26585,1 26672,0 26677,1 26751,0 26756,1 26796,0 26883,1 26968,0 27005,1 27082,0 27151,1 27240,0 27264,1 27297,0 27359,1 27375,0 27472,1 27543,0 27607,1 27608,0 27626,1 27700,0 27772,1 27791,0 27827,1 27828,0 27842,1 27905,0 27914,1 27947,0 27992,1 28006,0 28047,1 28051,0 28063,1 28140,0 28198,1 28242,0 28279,1 28309,0 28403,1 28409,0 28443,1 28460,0 28479,1 28571,0 28640,1 28666,0 28710,1 28777,0 28818,1 28857,0 28937,1 28974,0 29023,1 29058,0 29140,1 29170,0 29220,1 29227,0 29249,1 29263,0 29304,1 29367,0 29421,1 29451,0 29501,1 29601,0 29687,1 29774,0 29868,1 29881,0 29939,1 29989,0 30058,1 30102,0 30148,1 30233,0 30253,1 30284,0 30338,1 30361,0 30422,1 30444,0 30489,1 30501,0 30516,1 30557,0 30576,1 30639,0 30647,1 30697,0 30761,1 30772,0 30794,1 30894,0 30978,1 31010,0 31033,1 31050,0 31112,1 31185,0 31233,1 31318,0 31402,1 31478,0 31557,1 31583,0 31628,1 31674,0 31733,1 31775,0 31863,1 31878,0 31913,1 31916,0 31998,1 32025,0 32087,1 32122,0 32169,1 32209,0 32278,1 32308,0 32353,1 32381,0 32444,1 32509,0 32566,1 32587,0 32649,1 32661,0 32748,1 32785,0 32813,1 32905,0 32920,1 33007,0 33034,1 33042,0 33076,1 33150,0 33245,1 33282,0 33374,1 33417,0 33473,1 33512,0 33548,1 33609,0 33690,1 33734,0 33787,1 33848,0 33890,1 33936,0 34021,1 34108,0 34149,1 34220,0 34227,1 34275,0 34363,1 34431,0 34478,1 34511,0 34545,1 34620,0 34678,1 34724,0 34787,1 34815,0 34895,1 34979,0 35040,1 35055,0 35080,1 35152,0 35197,1 35214,0 35228,1 35237,0 35311,1 35321,0 35374,1 35418,0 35439,1 35461,0 35469,1 35513,0 35538,1 35609,0 35676,1 35738,0 35799,1 35892,0 35925,1 35962,0 36001,1 36088,0 36175,1 36216,0 36239,1 36257,0 36298,1 36338,0 36399,1 36433,0 36451,1 36544,0 36636,1 36679,0 36727,1 36808,0 36870,1 36872,0 36930,1 36996,0 37044,1 37048,0 37091,1 37093,0 37184,1 37211,0 37227,1 37249,0 37282,1 37319,0 37386,1 37393,0 37416,1 37493,0 37498,1 37547,0 37611,1 37661,0 37688,1 37703,0 37751,1 37826,0 37842,1 37873,0 37923,1 37963,0 38059,1 38156,0 38208,1 38243,0 38286,1 38295,0 38325,1 38351,0 38417,1 38490,0 38573,1 38609,0 38625,1 38703,0 38784,1 38819,0 38911,1 38981,0 39059,1 39156,0 39181,1 39225,0 39304,1 39392,0 39429,1 39448,0 39449,1 39541,0 39581,1 39650,0 39662,1 39676,0 39711,1 39724,0 39822,1 39845,0 39902,1 39994,0 40061,1 40161,0 40198,1 40248,0 40253,1 40314,0 40335,1 40430,0 40481,1 40532,0 40603,1 40661,0 40702,1 40771,0 40786,1 40788,0 40839,1 40918,0 40933,1 41003,0 41030,1 41115,0 41151,1 41178,0 41217,1 41240,0 41316,1 41362,0 41378,1 41406,0 41423,1 41437,0 41471,1 41552,0 41645,1 41667,0 41730,1 41742,0 41818,1 41866,0 41945,1 41989,0 42028,1 42103,0 42203,1 42279,0 42341,1 42391,0 42466,1 42521,0 42605,1 42630,0 42692,1 42751,0 42801,1 42853,0 42933,1 42949,0 43019,1 43047,0 43140,1 43189,0 43235,1 43304,0 43371,1 43428,0 43457,1 43555,0 43578,1 43622,0 43696,1 43763,0 43789,1 43820,0 43894,1 43906,0 43935,1 43949,0 44047,1 44061,0 44084,1 44157,0 44252,1 44303,0 44306,1 44317,0 44392,1 44453,0 44491,1 44562,0 44616,1 44678,0 44734,1 44743,0 44751,1 44837,0 44854,1 44864,0 44895,1 44972,0 45010,1 45105,0 45122,1 45171,0 45251,1 45329,0 45355,1 45448,0 45542,1 45613,0 45658,1 45663,0 45751,1 45809,0 45862,1 45927,0 45960,1 46053,0 46090,1 46189,0 46215,1 46224,0 46295,1 46301,0 46339,1 46416,0 46490,1 46527,0 46620,1 46625,0 46634,1 46660,0 46736,1 46778,0 46811,1 46825,0 46911,1 46997,0 47045,1 47115,0 47201,1 47262,0 47288,1 47300,0 47357,1 47454,0 47517,1 47522,0 47598,1 47614,0 47668,1 47713,0 47785,1 47795,0 47829,1 47879,0 47964,1 48052,0 48138,1 48200,0 48277,1 48322,0 48391,1 48397,0 48423,1 48427,0 48514,1 48553,0 48589,1 48592,0 48687,1 48730,0 48761,1 48850,0 48940,1 48972,0 49037,1 49067,0 49117,1 49192,0 49244,1 49263,0 49284,1 49327,0 49342,1 49432,0 49502,1 end initlist b0 0,0 39,1 118,0 123,1 182,0 254,1 292,0 353,1 442,0 542,1 642,0 694,1 751,0 776,1 856,0 890,1 924,0 963,1 990,0 1064,1 1068,0 1166,1 1254,0 1341,1 1342,0 1365,1 1421,0 1502,1 1581,0 1650,1 1696,0 1791,1 1887,0 1960,1 1961,0 2032,1 2110,0 2180,1 2184,0 2248,1 2290,0 2384,1 2398,0 2477,1 2484,0 2537,1 2551,0 2626,1 2630,0 2640,1 2687,0 2777,1 2841,0 2894,1 2902,0 2930,1 3006,0 3092,1 3129,0 3136,1 3145,0 3175,1 3219,0 3273,1 3365,0 3424,1 3521,0 3528,1 3555,0 3591,1 3633,0 3664,1 3674,0 3735,1 3806,0 3872,1 3889,0 3954,1 4029,0 4076,1 4171,0 4263,1 4344,0 4429,1 4492,0 4516,1 4531,0 4563,1 4613,0 4682,1 4690,0 4736,1 4743,0 4842,1 4894,0 4932,1 5024,0 5069,1 5163,0 5263,1 5285,0 5331,1 5424,0 5483,1 5541,0 5636,1 5646,0 5656,1 5666,0 5701,1 5715,0 5767,1 5848,0 5925,1 5966,0 6066,1 6156,0 6187,1 6279,0 6358,1 6371,0 6375,1 6418,0 6503,1 6586,0 6662,1 6719,0 6808,1 6882,0 6974,1 6991,0 7022,1 7093,0 7140,1 7154,0 7197,1 7284,0 7331,1 7401,0 7457,1 7498,0 7564,1 7649,0 7675,1 7746,0 7799,1 7898,0 7972,1 8051,0 8055,1 8083,0 8172,1 8179,0 8203,1 8222,0 8303,1 8348,0 8443,1 8543,0 8598,1 8671,0 8716,1 8773,0 8778,1 8817,0 8883,1 8963,0 8994,1 9047,0 9062,1 9076,0 9158,1 9243,0 9325,1 9327,0 9350,1 9356,0 9417,1 9418,0 9471,1 9553,0 9587,1 9598,0 9652,1 9678,0 9707,1 9744,0 9810,1 9817,0 9865,1 9959,0 10045,1 10137,0 10168,1 10207,0 10222,1 10264,0 10342,1 10425,0 10426,1 10496,0 10530,1 10597,0 10688,1 10765,0 10803,1 10822,0 10912,1 10993,0 10999,1 11098,0 11171,1 11185,0 11219,1 11280,0 11300,1 11341,0 11406,1 11497,0 11579,1 11653,0 11711,1 11787,0 11834,1 11868,0 11927,1 11966,0 12065,1 12103,0 12109,1 12110,0 12119,1 12184,0 12203,1 12220,0 12275,1 12336,0 12363,1 12439,0 12510,1 12525,0 12619,1 12683,0 12742,1 12839,0 12868,1 12904,0 12973,1 13073,0 13163,1 13174,0 13179,1 13243,0 13315,1 13373,0 13455,1 13485,0 13532,1 13535,0 13579,1 13637,0 13718,1 13782,0 13847,1 13880,0 13887,1 13919,0 13991,1 14075,0 14085,1 14147,0 14150,1 14186,0 14213,1 14240,0 14332,1 14422,0 14477,1 14552,0 14602,1 14646,0 14708,1 14768,0 14855,1 14950,0 15048,1 15071,0 15072,1 15164,0 15211,1 15226,0 15305,1 15338,0 15368,1 15447,0 15533,1 15567,0 15625,1 15655,0 15719,1 15725,0 15762,1 15816,0 15866,1 15894,0 15908,1 15995,0 16087,1 16105,0 16203,1 16219,0 16225,1 16324,0 16329,1 16336,0 16422,1 16436,0 16502,1 16513,0 16533,1 16594,0 16601,1 16668,0 16681,1 16728,0 16761,1 16823,0 16882,1 16972,0 17021,1 17097,0 17194,1 17243,0 17336,1 17406,0 17422,1 17503,0 17549,1 17599,0 17672,1 17751,0 17778,1 17836,0 17890,1 17985,0 17989,1 18029,0 18051,1 18148,0 18179,1 18231,0 18248,1 18328,0 18354,1 18432,0 18496,1 18497,0 18596,1 18626,0 18721,1 18753,0 18782,1 18810,0 18852,1 18913,0 18951,1 19040,0 19041,1 19048,0 19136,1 19184,0 19193,1 19254,0 19333,1 19421,0 19483,1 19528,0 19600,1 19673,0 19693,1 19771,0 19869,1 19963,0 20008,1 20068,0 20105,1 20122,0 20153,1 20155,0 20169,1 20262,0 20357,1 20392,0 20457,1 20465,0 20514,1 20540,0 20609,1 20707,0 20746,1 20809,0 20839,1 20909,0 20982,1 21006,0 21040,1 21096,0 21168,1 21229,0 21278,1 21364,0 21434,1 21494,0 21590,1 21660,0 21720,1 21795,0 21889,1 21956,0 22014,1 22067,0 22075,1 22081,0 22177,1 22190,0 22244,1 22271,0 22344,1 22429,0 22500,1 22503,0 22581,1 22615,0 22673,1 22755,0 22845,1 22851,0 22888,1 22908,0 22935,1 22963,0 23040,1 23089,0 23172,1 23221,0 23288,1 23356,0 23367,1 23409,0 23499,1 23502,0 23543,1 23620,0 23718,1 23748,0 23783,1 23784,0 23807,1 23834,0 23840,1 23843,0 23846,1 23900,0 23938,1 23963,0 24052,1 24115,0 24177,1 24259,0 24276,1 24304,0 24346,1 24360,0 24459,1 24553,0 24618,1 24692,0 24697,1 24734,0 24770,1 24812,0 24878,1 24885,0 24914,1 24950,0 24994,1 25039,0 25134,1 25224,0 25312,1 25396,0 25461,1 25503,0 25566,1 25621,0 25633,1 25649,0 25664,1 25688,0 25692,1 25745,0 25796,1 25875,0 25954,1 25993,0 26029,1 26094,0 26167,1 26192,0 26204,1 26294,0 26321,1 26338,0 26396,1 26491,0 26556,1 26648,0 26730,1 26807,0 26873,1 26928,0 26947,1 26975,0 27058,1 27151,0 27237,1 27308,0 27361,1 27381,0 27397,1 27441,0 27495,1 27586,0 27610,1 27631,0 27694,1 27773,0 27869,1 27883,0 27894,1 27978,0 27986,1 28037,0 28134,1 28144,0 28183,1 28267,0 28291,1 28346,0 28420,1 28487,0 28575,1 28611,0 28657,1 28675,0 28730,1 28829,0 28860,1 28887,0 28978,1 28991,0 29082,1 29173,0 29272,1 29276,0 29309,1 29330,0 29338,1 29367,0 29419,1 29497,0 29586,1 29655,0 29699,1 29700,0 29719,1 29801,0 29894,1 29962,0 30045,1 30122,0 30154,1 30221,0 30231,1 30241,0 30318,1 30360,0 30452,1 30500,0 30593,1 30601,0 30647,1 30704,0 30746,1 30805,0 30868,1 30935,0 31026,1 31104,0 31184,1 31185,0 31237,1 31333,0 31361,1 31428,0 31517,1 31572,0 31638,1 31709,0 31792,1 31830,0 31930,1 31958,0 32015,1 32090,0 32118,1 32131,0 32194,1 32258,0 32285,1 32338,0 32346,1 32385,0 32453,1 32550,0 32636,1 32722,0 32743,1 32811,0 32882,1 32890,0 32958,1 33045,0 33051,1 33072,0 33108,1 33202,0 33205,1 33255,0 33274,1 33304,0 33365,1 33375,0 33397,1 33426,0 33483,1 33568,0 33616,1 33679,0 33743,1 33842,0 33872,1 33873,0 33951,1 34029,0 34101,1 34164,0 34185,1 34282,0 34357,1 34378,0 34426,1 34492,0 34589,1 34633,0 34730,1 34786,0 34804,1 34829,0 34918,1 34983,0 35069,1 35072,0 35131,1 35221,0 35310,1 35367,0 35443,1 35538,0 35555,1 35576,0 35648,1 35690,0 35762,1 35852,0 35946,1 36031,0 36130,1 36158,0 36170,1 36191,0 36243,1 36338,0 36430,1 36480,0 36527,1 36582,0 36651,1 36742,0 36805,1 36875,0 36916,1 36955,0 37034,1 37120,0 37145,1 37202,0 37287,1 37292,0 37296,1 37312,0 37394,1 37453,0 37484,1 37497,0 37594,1 37627,0 37708,1 37807,0 37881,1 37963,0 38002,1 38035,0 38095,1 38100,0 38145,1 38175,0 38188,1 38197,0 38247,1 38317,0 38381,1 38389,0 38439,1 38472,0 38477,1 38495,0 38548,1 38629,0 38704,1 38732,0 38832,1 38870,0 38893,1 38966,0 38978,1 39040,0 39094,1 39152,0 39184,1 39281,0 39374,1 39435,0 39496,1 39570,0 39648,1 39676,0 39735,1 39804,0 39873,1 39929,0 39967,1 40016,0 40031,1 40096,0 40124,1 40211,0 40225,1 40291,0 40332,1 40382,0 40475,1 40505,0 40592,1 40606,0 40615,1 40700,0 40787,1 40879,0 40905,1 40966,0 41039,1 41105,0 41107,1 41195,0 41242,1 41333,0 41428,1 41504,0 41515,1 41584,0 41665,1 41746,0 41771,1 41863,0 41905,1 41966,0 42047,1 42070,0 42139,1 42174,0 42223,1 42270,0 42282,1 42322,0 42393,1 42474,0 42500,1 42504,0 42563,1 42606,0 42625,1 42696,0 42708,1 42745,0 42750,1 42823,0 42833,1 42894,0 42974,1 43064,0 43148,1 43244,0 43260,1 43314,0 43410,1 43463,0 43477,1 43572,0 43662,1 43695,0 43758,1 43826,0 43916,1 43937,0 44001,1 44037,0 44065,1 44071,0 44103,1 44179,0 44268,1 44349,0 44402,1 44457,0 44475,1 44531,0 44595,1 44621,0 44644,1 44677,0 44694,1 44790,0 44818,1 44863,0 44963,1 45061,0 45112,1 45209,0 45284,1 45380,0 45438,1 45462,0 45520,1 45600,0 45613,1 45629,0 45682,1 45733,0 45746,1 45824,0 45907,1 45995,0 46074,1 46140,0 46152,1 46192,0 46283,1 46288,0 46323,1 46344,0 46378,1 46424,0 46474,1 46558,0 46632,1 46713,0 46791,1 46826,0 46831,1 46843,0 46913,1 46929,0 46987,1 47034,0 47113,1 47190,0 47218,1 47315,0 47319,1 47346,0 47383,1 47393,0 47478,1 47540,0 47598,1 47614,0 47713,1 47792,0 47849,1 47903,0 47993,1 48077,0 48131,1 48207,0 48213,1 48259,0 48300,1 48310,0 48331,1 48378,0 48400,1 48450,0 48542,1 48631,0 48674,1 48751,0 48779,1 48788,0 48801,1 48828,0 48841,1 48896,0 48965,1 49063,0 49082,1 49182,0 49196,1 49243,0 49280,1 49304,0 49355,1 49435,0 49504,1 49526,0 49583,1 49642,0 49672,1 49703,0 49794,1 49832,0 49859,1 49875,0 49889,1 49958,0 49967,1 49997,0 50056,1 50138,0 50184,1 50191,0 50259,1 50300,0 50332,1 50395,0 50400,1 50485,0 50575,1 50602,0 50633,1 50650,0 50739,1 50794,0 50824,1 50825,0 50857,1 50938,0 50983,1 51016,0 51103,1 51175,0 51256,1 51313,0 51398,1 51482,0 51558,1 51656,0 51685,1 51688,0 51713,1 51751,0 51850,1 51907,0 51962,1 52039,0 52092,1 52175,0 52235,1 52318,0 52367,1 52448,0 52530,1 end initlist b1 0,0 37,1 60,0 68,1 140,0 224,1 257,0 309,1 334,0 393,1 475,0 496,1 548,0 560,1 576,0 657,1 752,0 756,1 789,0 812,1 827,0 866,1 882,0 939,1 1017,0 1020,1 1049,0 1124,1 1154,0 1156,1 1195,0 1294,1 1312,0 1408,1 1494,0 1552,1 1559,0 1629,1 1716,0 1804,1 1858,0 1931,1 1985,0 2040,1 2066,0 2071,1 2157,0 2238,1 2326,0 2413,1 2461,0 2494,1 2591,0 2643,1 2690,0 2699,1 2751,0 2844,1 2934,0 2960,1 3033,0 3066,1 3084,0 3135,1 3148,0 3192,1 3223,0 3231,1 3263,0 3332,1 3408,0 3493,1 3590,0 3592,1 3668,0 3765,1 3805,0 3875,1 3975,0 4006,1 4016,0 4082,1 4178,0 4195,1 4279,0 4342,1 4416,0 4515,1 4528,0 4537,1 4543,0 4545,1 4609,0 4652,1 4750,0 4818,1 4824,0 4919,1 4973,0 5000,1 5057,0 5127,1 5163,0 5230,1 5280,0 5297,1 5330,0 5331,1 5408,0 5504,1 5560,0 5655,1 5755,0 5762,1 5838,0 5917,1 5961,0 6030,1 6068,0 6071,1 6085,0 6112,1 6143,0 6228,1 6297,0 6316,1 6385,0 6412,1 6414,0 6499,1 6576,0 6672,1 6710,0 6741,1 6823,0 6861,1 6935,0 6984,1 6992,0 7051,1 7099,0 7114,1 7204,0 7281,1 7375,0 7404,1 7423,0 7486,1 7499,0 7563,1 7591,0 7681,1 7745,0 7813,1 7818,0 7870,1 7957,0 7982,1 8018,0 8039,1 8109,0 8159,1 8207,0 8214,1 8250,0 8321,1 8342,0 8380,1 8479,0 8526,1 8576,0 8641,1 8703,0 8734,1 8811,0 8874,1 8943,0 9003,1 9084,0 9127,1 9196,0 9265,1 9342,0 9392,1 9451,0 9528,1 9562,0 9611,1 9631,0 9645,1 9681,0 9763,1 9856,0 9916,1 10000,0 10058,1 10129,0 10177,1 10276,0 10336,1 10374,0 10466,1 10505,0 10506,1 10553,0 10584,1 10608,0 10647,1 10716,0 10787,1 10801,0 10847,1 10865,0 10923,1 10947,0 10956,1 10996,0 11001,1 11023,0 11117,1 11121,0 11165,1 11245,0 11250,1 11271,0 11345,1 11372,0 11388,1 11485,0 11535,1 11572,0 11649,1 11718,0 11770,1 11812,0 11901,1 11966,0 11985,1 12001,0 12025,1 12068,0 12121,1 12182,0 12233,1 12266,0 12289,1 12375,0 12458,1 12517,0 12553,1 12646,0 12737,1 12807,0 12864,1 12926,0 12939,1 13019,0 13069,1 13122,0 13190,1 13258,0 13304,1 13404,0 13433,1 13461,0 13466,1 13530,0 13589,1 13664,0 13711,1 13775,0 13859,1 13940,0 14020,1 14065,0 14084,1 14183,0 14224,1 14310,0 14322,1 14388,0 14409,1 14461,0 14526,1 14595,0 14648,1 14747,0 14769,1 14841,0 14912,1 15000,0 15037,1 15070,0 15144,1 15199,0 15223,1 15293,0 15382,1 15466,0 15543,1 15627,0 15685,1 15775,0 15837,1 15893,0 15906,1 15973,0 16073,1 16101,0 16177,1 16182,0 16213,1 16215,0 16274,1 16319,0 16418,1 16438,0 16474,1 16514,0 16566,1 16608,0 16648,1 16720,0 16813,1 16832,0 16914,1 16979,0 17067,1 17106,0 17131,1 17231,0 17330,1 17386,0 17416,1 17441,0 17524,1 17586,0 17672,1 17681,0 17747,1 17812,0 17893,1 17972,0 17997,1 18013,0 18089,1 18148,0 18159,1 18191,0 18244,1 18248,0 18286,1 18319,0 18393,1 18429,0 18457,1 18498,0 18595,1 18662,0 18697,1 18705,0 18777,1 18818,0 18901,1 18907,0 18945,1 18991,0 19071,1 19131,0 19167,1 19211,0 19241,1 19312,0 19360,1 19381,0 19401,1 19486,0 19547,1 19557,0 19575,1 19614,0 19714,1 19797,0 19882,1 19981,0 20055,1 20087,0 20108,1 20205,0 20267,1 20358,0 20452,1 20487,0 20537,1 20541,0 20562,1 20606,0 20608,1 20627,0 20721,1 20739,0 20754,1 20797,0 20880,1 20976,0 21015,1 21112,0 21165,1 21227,0 21323,1 21404,0 21452,1 21466,0 21490,1 21571,0 21595,1 21621,0 21624,1 21688,0 21758,1 21763,0 21850,1 21908,0 21950,1 22023,0 22114,1 22162,0 22197,1 22212,0 22283,1 22364,0 22456,1 22523,0 22571,1 22573,0 22593,1 22619,0 22694,1 22711,0 22801,1 22825,0 22865,1 22912,0 22945,1 23043,0 23135,1 23150,0 23159,1 23250,0 23274,1 23357,0 23372,1 23378,0 23455,1 23478,0 23481,1 23486,0 23555,1 23570,0 23660,1 23744,0 23824,1 23857,0 23923,1 23963,0 24033,1 24087,0 24175,1 24199,0 24210,1 24293,0 24307,1 24360,0 24371,1 24416,0 24469,1 24473,0 24537,1 24584,0 24604,1 24639,0 24695,1 24768,0 24794,1 24812,0 24887,1 24985,0 25034,1 25076,0 25125,1 25138,0 25213,1 25231,0 25276,1 25346,0 25390,1 25421,0 25426,1 25436,0 25448,1 25492,0 25550,1 25603,0 25656,1 25658,0 25679,1 25718,0 25782,1 25817,0 25830,1 25919,0 25925,1 26008,0 26097,1 26106,0 26194,1 26253,0 26323,1 26337,0 26408,1 26438,0 26454,1 26471,0 26564,1 26573,0 26614,1 26637,0 26717,1 26758,0 26794,1 26872,0 26928,1 26968,0 27068,1 27131,0 27231,1 27248,0 27258,1 27277,0 27348,1 27430,0 27498,1 27527,0 27552,1 27619,0 27636,1 27641,0 27679,1 27692,0 27725,1 27793,0 27841,1 27864,0 27892,1 27936,0 27966,1 27968,0 27971,1 28006,0 28068,1 28110,0 28116,1 28132,0 28188,1 28228,0 28279,1 28343,0 28400,1 28428,0 28456,1 28460,0 28552,1 28587,0 28589,1 28620,0 28663,1 28763,0 28788,1 28816,0 28828,1 28905,0 28922,1 28930,0 29016,1 29093,0 29136,1 29170,0 29191,1 29246,0 29264,1 29309,0 29408,1 29429,0 29442,1 29503,0 29584,1 29612,0 29624,1 29639,0 29707,1 29800,0 29825,1 29905,0 29963,1 30031,0 30057,1 30123,0 30133,1 30186,0 30283,1 30292,0 30330,1 30364,0 30438,1 30440,0 30502,1 30504,0 30581,1 30589,0 30593,1 30605,0 30650,1 30673,0 30693,1 30747,0 30786,1 30876,0 30958,1 31040,0 31105,1 31196,0 31286,1 31315,0 31395,1 31426,0 31437,1 31482,0 31531,1 31537,0 31540,1 31621,0 31707,1 31724,0 31764,1 31785,0 31833,1 31879,0 31902,1 31930,0 31957,1 31999,0 32072,1 32075,0 32089,1 32185,0 32241,1 32291,0 32359,1 32423,0 32479,1 32500,0 32571,1 32624,0 32668,1 32745,0 32786,1 32802,0 32842,1 32936,0 32975,1 33022,0 33078,1 33136,0 33229,1 33257,0 33347,1 33366,0 33446,1 33504,0 33514,1 33553,0 33584,1 33588,0 33589,1 33646,0 33707,1 33733,0 33768,1 33800,0 33846,1 33940,0 34039,1 34053,0 34054,1 34082,0 34085,1 34151,0 34162,1 34198,0 34201,1 34208,0 34242,1 34252,0 34287,1 34343,0 34351,1 34412,0 34476,1 34512,0 34595,1 34600,0 34622,1 34642,0 34737,1 34751,0 34840,1 34886,0 34929,1 35022,0 35080,1 35164,0 35183,1 35280,0 35364,1 35450,0 35519,1 35568,0 35632,1 35638,0 35669,1 35714,0 35715,1 35718,0 35793,1 35851,0 35872,1 35904,0 35977,1 35987,0 36044,1 36059,0 36106,1 36124,0 36129,1 36197,0 36245,1 36313,0 36376,1 36413,0 36494,1 36507,0 36596,1 36627,0 36647,1 36721,0 36737,1 36837,0 36844,1 36851,0 36908,1 36985,0 37004,1 37056,0 37089,1 37110,0 37190,1 37282,0 37311,1 37371,0 37469,1 37503,0 37594,1 37626,0 37719,1 37767,0 37860,1 37878,0 37953,1 38036,0 38043,1 38124,0 38219,1 38291,0 38314,1 38412,0 38449,1 38524,0 38539,1 38567,0 38599,1 38665,0 38699,1 38756,0 38765,1 38831,0 38929,1 39001,0 39037,1 39105,0 39134,1 39208,0 39302,1 39353,0 39443,1 39463,0 39531,1 39533,0 39596,1 39631,0 39703,1 39707,0 39750,1 39850,0 39906,1 39997,0 40070,1 40161,0 40182,1 40267,0 40353,1 40448,0 40508,1 40597,0 40696,1 40733,0 40769,1 40803,0 40886,1 40913,0 40956,1 41046,0 41064,1 41121,0 41189,1 41281,0 41327,1 41411,0 41502,1 41519,0 41566,1 41581,0 41658,1 41693,0 41736,1 41760,0 41793,1 41801,0 41835,1 41890,0 41970,1 42070,0 42073,1 42097,0 42110,1 42134,0 42149,1 42225,0 42247,1 42272,0 42369,1 42428,0 42488,1 42516,0 42597,1 42626,0 42659,1 42711,0 42757,1 42800,0 42830,1 42851,0 42904,1 42961,0 42989,1 43022,0 43118,1 43137,0 43200,1 43292,0 43353,1 43418,0 43435,1 43462,0 43547,1 43586,0 43659,1 43661,0 43718,1 43768,0 43789,1 43887,0 43981,1 44001,0 44022,1 44027,0 44034,1 44132,0 44209,1 44213,0 44214,1 44272,0 44315,1 44347,0 44397,1 44445,0 44540,1 44564,0 44662,1 44720,0 44725,1 44794,0 44820,1 44905,0 44952,1 45018,0 45108,1 45190,0 45209,1 45304,0 45339,1 45370,0 45421,1 45441,0 45476,1 45555,0 45595,1 45605,0 45702,1 45704,0 45754,1 45766,0 45792,1 45886,0 45926,1 45967,0 46026,1 46033,0 46068,1 46146,0 46148,1 46246,0 46275,1 46361,0 46460,1 46526,0 46583,1 46605,0 46705,1 46784,0 46812,1 46899,0 46965,1 47032,0 47118,1 47195,0 47240,1 47324,0 47413,1 47503,0 47526,1 47531,0 47540,1 47542,0 47569,1 47632,0 47643,1 47674,0 47678,1 47728,0 47757,1 47772,0 47861,1 47952,0 48036,1 48122,0 48212,1 48216,0 48273,1 48368,0 48386,1 48408,0 48456,1 48463,0 48485,1 48576,0 48624,1 48642,0 48650,1 48749,0 48822,1 48876,0 48956,1 48960,0 49038,1 49076,0 49118,1 49218,0 49295,1 49379,0 49455,1 49474,0 49515,1 end initlist b2 0,0 63,1 68,0 168,1 262,0 278,1 308,0 352,1 412,0 415,1 473,0 482,1 515,0 589,1 606,0 632,1 674,0 682,1 735,0 786,1 847,0 915,1 1005,0 1077,1 1148,0 1201,1 1277,0 1303,1 1312,0 1337,1 1388,0 1406,1 1453,0 1500,1 1507,0 1561,1 1602,0 1655,1 1663,0 1709,1 1767,0 1854,1 1913,0 1998,1 2059,0 2155,1 2227,0 2253,1 2350,0 2355,1 2439,0 2501,1 2534,0 2587,1 2589,0 2610,1 2640,0 2723,1 2730,0 2769,1 2835,0 2882,1 2906,0 2932,1 3029,0 3069,1 3154,0 3158,1 3238,0 3298,1 3339,0 3425,1 3458,0 3495,1 3566,0 3614,1 3617,0 3707,1 3735,0 3747,1 3810,0 3854,1 3951,0 4039,1 4111,0 4187,1 4221,0 4320,1 4339,0 4401,1 4480,0 4574,1 4674,0 4756,1 4855,0 4866,1 4918,0 4946,1 5040,0 5058,1 5088,0 5141,1 5152,0 5182,1 5237,0 5246,1 5327,0 5388,1 5467,0 5526,1 5554,0 5592,1 5686,0 5742,1 5783,0 5820,1 5891,0 5945,1 5968,0 5974,1 6013,0 6025,1 6079,0 6088,1 6171,0 6217,1 6309,0 6329,1 6368,0 6417,1 6469,0 6550,1 6553,0 6568,1 6595,0 6633,1 6650,0 6715,1 6722,0 6747,1 6815,0 6895,1 6941,0 6995,1 7089,0 7172,1 7241,0 7248,1 7340,0 7373,1 7382,0 7430,1 7434,0 7532,1 7608,0 7669,1 7672,0 7707,1 7793,0 7865,1 7957,0 8004,1 8059,0 8091,1 8099,0 8103,1 8163,0 8206,1 8272,0 8369,1 8396,0 8450,1 8550,0 8602,1 8696,0 8706,1 8762,0 8796,1 8824,0 8914,1 8948,0 9042,1 9070,0 9170,1 9192,0 9277,1 9350,0 9362,1 9438,0 9529,1 9535,0 9565,1 9574,0 9665,1 9727,0 9729,1 9825,0 9839,1 9932,0 9989,1 10044,0 10120,1 10206,0 10217,1 10221,0 10283,1 10349,0 10387,1 10447,0 10481,1 10528,0 10531,1 10588,0 10618,1 10663,0 10685,1 10735,0 10779,1 10852,0 10870,1 10902,0 10919,1 10968,0 11040,1 11127,0 11145,1 11231,0 11324,1 11399,0 11433,1 11489,0 11544,1 11547,0 11635,1 11661,0 11718,1 11762,0 11763,1 11833,0 11921,1 11979,0 11993,1 12047,0 12130,1 12144,0 12193,1 12282,0 12354,1 12413,0 12488,1 12563,0 12635,1 12652,0 12728,1 12749,0 12788,1 12876,0 12910,1 12973,0 13035,1 13103,0 13158,1 13229,0 13313,1 13393,0 13489,1 13494,0 13546,1 13640,0 13643,1 13729,0 13772,1 13794,0 13892,1 13991,0 14002,1 14037,0 14086,1 14116,0 14190,1 14243,0 14315,1 14330,0 14360,1 14423,0 14441,1 14478,0 14564,1 14638,0 14683,1 14712,0 14749,1 14791,0 14870,1 14944,0 14998,1 15077,0 15157,1 15187,0 15252,1 15275,0 15314,1 15330,0 15411,1 15497,0 15524,1 15525,0 15623,1 15645,0 15664,1 15721,0 15809,1 15822,0 15825,1 15915,0 15985,1 16066,0 16072,1 16107,0 16118,1 16187,0 16228,1 16293,0 16335,1 16414,0 16485,1 16550,0 16597,1 16635,0 16648,1 16731,0 16778,1 16783,0 16806,1 16878,0 16894,1 16936,0 17016,1 17021,0 17117,1 17120,0 17129,1 17136,0 17169,1 17269,0 17311,1 17402,0 17439,1 17458,0 17525,1 17563,0 17648,1 17743,0 17756,1 17815,0 17872,1 17892,0 17904,1 17921,0 17933,1 17968,0 17978,1 18046,0 18051,1 18088,0 18166,1 18201,0 18291,1 18319,0 18354,1 18414,0 18495,1 18579,0 18610,1 18687,0 18695,1 18758,0 18760,1 18836,0 18849,1 18893,0 18931,1 18968,0 19024,1 19064,0 19088,1 19119,0 19200,1 19247,0 19254,1 19277,0 19358,1 19389,0 19405,1 19440,0 19481,1 19577,0 19595,1 19659,0 19710,1 19792,0 19814,1 19821,0 19878,1 19945,0 19973,1 19977,0 20045,1 20070,0 20101,1 20164,0 20245,1 20331,0 20373,1 20403,0 20464,1 20556,0 20562,1 20644,0 20685,1 20726,0 20809,1 20811,0 20877,1 20975,0 21039,1 21075,0 21169,1 21259,0 21349,1 21432,0 21494,1 21571,0 21595,1 21689,0 21712,1 21778,0 21847,1 21870,0 21871,1 21938,0 21943,1 22006,0 22020,1 22029,0 22084,1 22153,0 22162,1 22166,0 22188,1 22286,0 22372,1 22447,0 22487,1 22520,0 22601,1 22684,0 22753,1 22816,0 22860,1 22914,0 22933,1 23031,0 23045,1 23069,0 23133,1 23221,0 23292,1 23382,0 23401,1 23486,0 23545,1 23627,0 23709,1 23730,0 23785,1 23832,0 23837,1 23906,0 23978,1 24014,0 24059,1 24135,0 24179,1 24271,0 24272,1 24337,0 24375,1 24437,0 24441,1 24446,0 24467,1 24506,0 24534,1 24543,0 24607,1 24672,0 24707,1 24734,0 24783,1 24802,0 24831,1 24897,0 24985,1 25031,0 25088,1 25103,0 25120,1 25179,0 25239,1 25262,0 25305,1 25321,0 25326,1 25344,0 25402,1 25408,0 25418,1 25459,0 25535,1 25567,0 25667,1 25755,0 25830,1 25878,0 25938,1 25987,0 26063,1 26081,0 26110,1 26176,0 26223,1 26277,0 26283,1 26308,0 26319,1 26359,0 26436,1 26490,0 26573,1 26625,0 26679,1 26764,0 26777,1 26858,0 26914,1 26952,0 27029,1 27121,0 27150,1 27250,0 27314,1 27405,0 27436,1 27488,0 27543,1 27605,0 27667,1 27680,0 27770,1 27795,0 27796,1 27851,0 27900,1 27954,0 27955,1 28015,0 28029,1 28128,0 28183,1 28211,0 28237,1 28266,0 28362,1 28415,0 28416,1 28463,0 28467,1 28499,0 28545,1 28547,0 28630,1 28729,0 28758,1 28811,0 28836,1 28924,0 28962,1 28974,0 29061,1 29075,0 29160,1 29210,0 29242,1 29265,0 29279,1 29327,0 29398,1 29410,0 29492,1 29504,0 29546,1 29610,0 29628,1 29728,0 29743,1 29762,0 29775,1 29817,0 29877,1 29949,0 29975,1 30047,0 30054,1 30063,0 30127,1 30181,0 30243,1 30266,0 30344,1 30392,0 30437,1 30471,0 30556,1 30629,0 30657,1 30742,0 30762,1 30800,0 30871,1 30931,0 30970,1 31011,0 31019,1 31057,0 31130,1 31142,0 31237,1 31260,0 31315,1 31394,0 31454,1 31513,0 31543,1 31590,0 31628,1 31660,0 31720,1 31815,0 31906,1 31979,0 31986,1 32036,0 32118,1 32119,0 32169,1 32211,0 32228,1 32283,0 32316,1 32390,0 32404,1 32479,0 32517,1 32519,0 32588,1 32672,0 32741,1 32796,0 32839,1 32911,0 32971,1 33065,0 33158,1 33251,0 33340,1 33440,0 33445,1 33534,0 33556,1 33631,0 33669,1 33689,0 33731,1 33757,0 33760,1 33818,0 33821,1 33837,0 33923,1 34017,0 34062,1 34081,0 34137,1 34196,0 34252,1 34311,0 34339,1 34404,0 34412,1 34492,0 34538,1 34606,0 34697,1 34711,0 34720,1 34736,0 34759,1 34835,0 34912,1 34949,0 35048,1 35103,0 35144,1 35227,0 35283,1 35354,0 35372,1 35432,0 35492,1 35561,0 35574,1 35621,0 35652,1 35738,0 35793,1 35830,0 35865,1 35945,0 36012,1 36050,0 36105,1 36192,0 36251,1 36341,0 36383,1 36384,0 36424,1 36482,0 36532,1 36552,0 36647,1 36690,0 36694,1 36712,0 36769,1 36771,0 36822,1 36824,0 36871,1 36930,0 37010,1 37096,0 37132,1 37156,0 37240,1 37311,0 37365,1 37415,0 37449,1 37455,0 37497,1 37577,0 37588,1 37625,0 37716,1 37809,0 37827,1 37845,0 37927,1 37991,0 38090,1 38123,0 38187,1 38189,0 38245,1 38310,0 38325,1 38335,0 38433,1 38481,0 38512,1 38538,0 38562,1 38573,0 38595,1 38666,0 38727,1 38775,0 38817,1 38904,0 38929,1 39012,0 39050,1 39066,0 39142,1 39171,0 39180,1 39244,0 39265,1 39337,0 39344,1 39367,0 39431,1 39447,0 39492,1 39498,0 39591,1 39683,0 39713,1 39741,0 39812,1 39843,0 39858,1 39912,0 39950,1 40049,0 40123,1 40209,0 40215,1 40284,0 40312,1 40332,0 40424,1 40430,0 40458,1 40553,0 40583,1 40680,0 40728,1 40813,0 40815,1 40898,0 40930,1 41004,0 41055,1 41097,0 41182,1 41233,0 41258,1 41273,0 41337,1 41381,0 41437,1 41529,0 41556,1 41652,0 41687,1 41703,0 41732,1 41747,0 41837,1 41856,0 41858,1 41943,0 42030,1 42063,0 42143,1 42221,0 42239,1 42312,0 42354,1 42417,0 42448,1 42479,0 42490,1 42513,0 42592,1 42600,0 42653,1 42660,0 42710,1 42787,0 42847,1 42859,0 42916,1 42927,0 42963,1 43056,0 43070,1 43109,0 43115,1 43118,0 43146,1 43231,0 43239,1 43299,0 43382,1 43479,0 43560,1 43635,0 43682,1 43762,0 43816,1 43875,0 43899,1 43920,0 44012,1 44035,0 44102,1 44123,0 44154,1 44169,0 44176,1 44269,0 44368,1 44411,0 44473,1 44541,0 44547,1 44575,0 44638,1 44643,0 44678,1 44705,0 44712,1 44779,0 44781,1 44870,0 44952,1 45048,0 45055,1 45139,0 45219,1 45296,0 45322,1 45410,0 45507,1 45536,0 45630,1 45710,0 45785,1 45850,0 45937,1 45989,0 45990,1 46076,0 46129,1 46138,0 46156,1 46161,0 46181,1 46253,0 46266,1 46331,0 46373,1 46445,0 46540,1 46552,0 46576,1 46583,0 46605,1 46693,0 46694,1 46779,0 46842,1 46884,0 46921,1 46943,0 47010,1 47083,0 47133,1 47145,0 47181,1 47182,0 47198,1 47224,0 47283,1 47339,0 47393,1 47429,0 47498,1 47521,0 47536,1 47597,0 47664,1 47750,0 47767,1 47865,0 47926,1 48023,0 48071,1 48076,0 48113,1 48162,0 48167,1 48209,0 48233,1 48240,0 48316,1 48368,0 48452,1 48513,0 48580,1 48615,0 48649,1 48696,0 48759,1 48791,0 48846,1 48888,0 48938,1 end initlist b3 0,0 24,1 117,0 200,1 272,0 333,1 417,0 466,1 491,0 540,1 615,0 629,1 688,0 692,1 714,0 762,1 763,0 814,1 831,0 856,1 870,0 936,1 956,0 1012,1 1066,0 1075,1 1153,0 1241,1 1249,0 1290,1 1361,0 1381,1 1468,0 1507,1 1512,0 1555,1 1580,0 1645,1 1682,0 1687,1 1702,0 1756,1 1776,0 1796,1 1893,0 1957,1 2003,0 2083,1 2086,0 2181,1 2229,0 2328,1 2339,0 2421,1 2489,0 2516,1 2588,0 2590,1 2616,0 2688,1 2730,0 2784,1 2815,0 2900,1 2977,0 3021,1 3084,0 3177,1 3206,0 3281,1 3305,0 3333,1 3402,0 3468,1 3550,0 3641,1 3672,0 3769,1 3837,0 3855,1 3907,0 3960,1 3982,0 4014,1 4020,0 4109,1 4126,0 4147,1 4188,0 4208,1 4305,0 4342,1 4436,0 4519,1 4582,0 4662,1 4755,0 4757,1 4793,0 4828,1 4863,0 4881,1 4940,0 4956,1 4996,0 5086,1 5143,0 5174,1 5178,0 5203,1 5208,0 5225,1 5301,0 5314,1 5407,0 5455,1 5499,0 5553,1 5583,0 5589,1 5667,0 5718,1 5752,0 5763,1 5821,0 5921,1 5952,0 5953,1 5989,0 5994,1 6073,0 6128,1 6159,0 6211,1 6218,0 6313,1 6351,0 6413,1 6440,0 6527,1 6626,0 6664,1 6669,0 6716,1 6758,0 6796,1 6824,0 6852,1 6943,0 6976,1 7070,0 7118,1 7208,0 7287,1 7348,0 7406,1 7471,0 7484,1 7494,0 7546,1 7598,0 7686,1 7751,0 7789,1 7883,0 7982,1 7988,0 8062,1 8070,0 8080,1 8141,0 8165,1 8251,0 8350,1 8417,0 8489,1 8562,0 8594,1 8660,0 8680,1 8764,0 8808,1 8889,0 8946,1 9041,0 9053,1 9140,0 9236,1 9297,0 9307,1 9327,0 9404,1 9409,0 9476,1 9502,0 9583,1 9586,0 9655,1 9689,0 9690,1 9734,0 9788,1 9874,0 9878,1 9965,0 10002,1 10065,0 10119,1 10183,0 10249,1 10259,0 10325,1 10394,0 10445,1 10519,0 10579,1 10580,0 10653,1 10658,0 10704,1 10729,0 10757,1 10853,0 10894,1 10993,0 11053,1 11104,0 11151,1 11211,0 11226,1 11280,0 11342,1 11345,0 11355,1 11429,0 11453,1 11470,0 11473,1 11494,0 11511,1 11570,0 11571,1 11663,0 11757,1 11830,0 11837,1 11845,0 11894,1 11906,0 11917,1 11952,0 12022,1 12117,0 12208,1 12246,0 12332,1 12403,0 12433,1 12531,0 12549,1 12625,0 12701,1 12714,0 12806,1 12869,0 12886,1 12890,0 12946,1 12994,0 13008,1 13102,0 13119,1 13147,0 13217,1 13303,0 13341,1 13403,0 13407,1 13482,0 13541,1 13638,0 13717,1 13782,0 13814,1 13847,0 13924,1 14005,0 14041,1 14056,0 14068,1 14122,0 14203,1 14272,0 14322,1 14341,0 14371,1 14431,0 14505,1 14552,0 14601,1 14648,0 14686,1 14786,0 14872,1 14873,0 14934,1 15024,0 15043,1 15083,0 15169,1 15212,0 15224,1 15294,0 15316,1 15353,0 15402,1 15500,0 15548,1 15592,0 15678,1 15767,0 15832,1 15844,0 15866,1 15887,0 15944,1 16006,0 16077,1 16165,0 16167,1 16181,0 16217,1 16255,0 16351,1 16397,0 16476,1 16480,0 16530,1 16583,0 16634,1 16664,0 16737,1 16780,0 16876,1 16931,0 16969,1 16996,0 17061,1 17120,0 17130,1 17138,0 17165,1 17213,0 17222,1 17225,0 17279,1 17324,0 17358,1 17383,0 17458,1 17531,0 17535,1 17567,0 17663,1 17703,0 17789,1 17803,0 17897,1 17957,0 18005,1 18080,0 18091,1 18181,0 18220,1 18283,0 18298,1 18345,0 18394,1 18469,0 18485,1 18504,0 18546,1 18616,0 18674,1 18736,0 18814,1 18850,0 18897,1 18915,0 18931,1 18965,0 19039,1 19040,0 19108,1 19194,0 19216,1 19240,0 19269,1 19319,0 19412,1 19492,0 19580,1 19629,0 19659,1 19681,0 19686,1 19701,0 19762,1 19821,0 19867,1 19874,0 19889,1 19962,0 20009,1 20033,0 20078,1 20137,0 20201,1 20296,0 20387,1 20409,0 20458,1 20553,0 20581,1 20615,0 20676,1 20763,0 20812,1 20859,0 20900,1 21000,0 21094,1 21117,0 21142,1 21223,0 21280,1 21289,0 21381,1 21390,0 21459,1 21534,0 21570,1 21573,0 21607,1 21683,0 21758,1 21773,0 21827,1 21877,0 21963,1 22012,0 22081,1 22126,0 22217,1 22292,0 22377,1 22445,0 22498,1 22501,0 22590,1 22601,0 22618,1 22665,0 22740,1 22791,0 22878,1 22923,0 22960,1 23004,0 23082,1 23180,0 23272,1 23349,0 23423,1 23485,0 23585,1 23642,0 23714,1 23744,0 23779,1 23865,0 23897,1 23910,0 23965,1 24062,0 24107,1 24172,0 24255,1 24344,0 24393,1 24409,0 24425,1 24519,0 24575,1 24582,0 24623,1 24671,0 24701,1 24719,0 24779,1 24875,0 24898,1 24931,0 24984,1 25069,0 25161,1 25170,0 25261,1 25286,0 25382,1 25434,0 25518,1 25614,0 25651,1 25674,0 25701,1 25789,0 25872,1 25967,0 26033,1 26096,0 26147,1 26200,0 26267,1 26269,0 26354,1 26377,0 26476,1 26510,0 26552,1 26609,0 26639,1 26695,0 26789,1 26872,0 26894,1 26962,0 26974,1 26982,0 27026,1 27064,0 27121,1 27177,0 27224,1 27270,0 27304,1 27373,0 27379,1 27388,0 27481,1 27505,0 27542,1 27567,0 27579,1 27605,0 27694,1 27697,0 27724,1 27729,0 27731,1 27774,0 27832,1 27877,0 27879,1 27905,0 27968,1 28039,0 28106,1 28175,0 28230,1 28237,0 28302,1 28359,0 28392,1 28460,0 28476,1 28566,0 28603,1 28633,0 28732,1 28818,0 28843,1 28922,0 28942,1 28954,0 28989,1 29048,0 29054,1 29129,0 29201,1 29284,0 29287,1 29289,0 29312,1 29398,0 29434,1 29524,0 29621,1 29696,0 29734,1 29739,0 29775,1 29861,0 29914,1 29970,0 29973,1 30035,0 30088,1 30132,0 30133,1 30210,0 30293,1 30330,0 30389,1 30468,0 30534,1 30614,0 30672,1 30689,0 30717,1 30751,0 30839,1 30845,0 30918,1 30983,0 31044,1 31114,0 31141,1 31168,0 31196,1 31236,0 31247,1 31320,0 31384,1 31438,0 31454,1 31482,0 31537,1 31563,0 31575,1 31620,0 31631,1 31706,0 31792,1 31886,0 31950,1 31956,0 32024,1 32096,0 32182,1 32205,0 32283,1 32370,0 32408,1 32451,0 32480,1 32533,0 32629,1 32709,0 32757,1 32857,0 32872,1 32928,0 33004,1 33039,0 33045,1 33078,0 33096,1 33138,0 33153,1 33214,0 33305,1 33335,0 33384,1 33433,0 33442,1 33475,0 33572,1 33621,0 33639,1 33715,0 33724,1 33810,0 33882,1 33934,0 33972,1 34005,0 34035,1 34082,0 34162,1 34240,0 34302,1 34396,0 34471,1 34527,0 34612,1 34625,0 34701,1 34796,0 34798,1 34799,0 34849,1 34900,0 34979,1 34987,0 35077,1 35130,0 35173,1 35244,0 35316,1 35324,0 35390,1 35413,0 35475,1 35476,0 35477,1 35485,0 35497,1 35543,0 35624,1 35716,0 35781,1 35806,0 35863,1 35892,0 35917,1 35983,0 36016,1 36070,0 36151,1 36242,0 36291,1 36329,0 36422,1 36490,0 36524,1 36579,0 36655,1 36663,0 36692,1 36760,0 36840,1 36914,0 36949,1 37030,0 37109,1 37179,0 37255,1 37274,0 37373,1 37461,0 37466,1 37512,0 37606,1 37690,0 37739,1 37758,0 37836,1 37920,0 37937,1 37952,0 38041,1 38068,0 38087,1 38113,0 38150,1 38194,0 38247,1 38336,0 38354,1 38387,0 38403,1 38498,0 38580,1 38628,0 38658,1 38749,0 38831,1 38929,0 39009,1 39083,0 39133,1 39143,0 39163,1 39210,0 39242,1 39298,0 39397,1 39405,0 39455,1 39466,0 39474,1 39484,0 39545,1 39580,0 39603,1 39628,0 39684,1 39762,0 39843,1 39919,0 39998,1 40042,0 40102,1 40114,0 40157,1 40217,0 40218,1 40311,0 40381,1 40383,0 40452,1 40465,0 40549,1 40618,0 40704,1 40725,0 40729,1 40733,0 40744,1 40795,0 40829,1 40837,0 40854,1 40936,0 40937,1 41027,0 41099,1 41133,0 41229,1 41246,0 41249,1 41267,0 41352,1 41415,0 41430,1 41435,0 41485,1 41503,0 41506,1 41604,0 41643,1 41740,0 41828,1 41893,0 41919,1 42012,0 42076,1 42083,0 42175,1 42274,0 42307,1 42381,0 42453,1 42456,0 42522,1 42556,0 42620,1 42645,0 42712,1 42803,0 42889,1 42952,0 43029,1 43098,0 43108,1 43182,0 43258,1 43296,0 43357,1 43403,0 43414,1 43463,0 43464,1 43563,0 43602,1 43672,0 43678,1 43772,0 43808,1 43840,0 43869,1 43931,0 43972,1 44050,0 44146,1 44174,0 44227,1 44313,0 44406,1 44493,0 44555,1 44621,0 44647,1 44705,0 44764,1 44793,0 44886,1 44889,0 44896,1 44958,0 45000,1 45071,0 45103,1 45134,0 45172,1 45173,0 45231,1 45246,0 45292,1 45380,0 45415,1 45501,0 45549,1 45580,0 45618,1 45636,0 45712,1 45724,0 45752,1 45844,0 45855,1 45946,0 46008,1 46023,0 46119,1 46215,0 46270,1 46344,0 46382,1 46424,0 46443,1 46486,0 46528,1 46615,0 46682,1 46744,0 46799,1 46869,0 46915,1 46968,0 47068,1 47128,0 47176,1 47241,0 47280,1 47294,0 47309,1 47344,0 47368,1 47452,0 47506,1 47588,0 47622,1 47646,0 47650,1 47667,0 47698,1 47712,0 47785,1 47847,0 47880,1 47967,0 48005,1 48046,0 48088,1 48160,0 48239,1 48280,0 48341,1 48351,0 48360,1 48399,0 48486,1 48525,0 48543,1 48549,0 48601,1 48674,0 48718,1 48773,0 48789,1 48843,0 48930,1 48995,0 49045,1 49078,0 49147,1 49224,0 49254,1 49259,0 49263,1 49330,0 49385,1 49423,0 49446,1 49454,0 49509,1 49587,0 49589,1 49667,0 49724,1 end initlist b4 0,0 53,1 107,0 150,1 226,0 246,1 264,0 348,1 357,0 454,1 483,0 523,1 589,0 685,1 722,0 774,1 785,0 861,1 931,0 944,1 969,0 979,1 1075,0 1076,1 1174,0 1274,1 1347,0 1391,1 1482,0 1559,1 1617,0 1685,1 1735,0 1752,1 1843,0 1931,1 1993,0 2082,1 2124,0 2139,1 2208,0 2308,1 2390,0 2407,1 2418,0 2419,1 2468,0 2518,1 2615,0 2665,1 2749,0 2848,1 2929,0 2970,1 3033,0 3086,1 3175,0 3219,1 3298,0 3365,1 3442,0 3529,1 3551,0 3614,1 3684,0 3763,1 3856,0 3914,1 4011,0 4108,1 4151,0 4159,1 4252,0 4261,1 4325,0 4374,1 4437,0 4480,1 4541,0 4609,1 4697,0 4778,1 4831,0 4839,1 4903,0 4980,1 5064,0 5089,1 5107,0 5192,1 5264,0 5305,1 5351,0 5387,1 5474,0 5556,1 5578,0 5610,1 5670,0 5701,1 5710,0 5755,1 5756,0 5782,1 5850,0 5932,1 5986,0 6067,1 6125,0 6137,1 6230,0 6322,1 6331,0 6429,1 6450,0 6549,1 6584,0 6669,1 6707,0 6790,1 6849,0 6852,1 6865,0 6881,1 6949,0 6974,1 7055,0 7068,1 7094,0 7145,1 7189,0 7281,1 7360,0 7367,1 7411,0 7416,1 7446,0 7455,1 7529,0 7570,1 7649,0 7704,1 7706,0 7790,1 7876,0 7933,1 7992,0 8001,1 8010,0 8033,1 8062,0 8157,1 8174,0 8256,1 8336,0 8370,1 8437,0 8455,1 8534,0 8595,1 8602,0 8634,1 8710,0 8768,1 8772,0 8843,1 8928,0 9001,1 9042,0 9089,1 9132,0 9139,1 9216,0 9309,1 9377,0 9413,1 9486,0 9551,1 9562,0 9648,1 9693,0 9760,1 9806,0 9906,1 9950,0 9961,1 10055,0 10091,1 10157,0 10191,1 10266,0 10352,1 10422,0 10481,1 10532,0 10621,1 10639,0 10656,1 10676,0 10702,1 10774,0 10815,1 10913,0 10940,1 10996,0 11033,1 11089,0 11143,1 11232,0 11274,1 11301,0 11328,1 11331,0 11346,1 11360,0 11415,1 11515,0 11595,1 11641,0 11686,1 11713,0 11780,1 11825,0 11911,1 11923,0 11954,1 11976,0 11988,1 11989,0 11998,1 12040,0 12048,1 12087,0 12158,1 12189,0 12203,1 12278,0 12361,1 12362,0 12365,1 12391,0 12472,1 12504,0 12567,1 12591,0 12610,1 12692,0 12702,1 12779,0 12825,1 12889,0 12935,1 12949,0 12954,1 13019,0 13086,1 13124,0 13141,1 13192,0 13223,1 13265,0 13295,1 13312,0 13361,1 13399,0 13489,1 13589,0 13671,1 13764,0 13777,1 13845,0 13916,1 13990,0 14049,1 14114,0 14159,1 14241,0 14335,1 14431,0 14500,1 14562,0 14563,1 14636,0 14671,1 14721,0 14801,1 14831,0 14896,1 14899,0 14979,1 15037,0 15082,1 15179,0 15201,1 15270,0 15275,1 15317,0 15407,1 15462,0 15533,1 15575,0 15637,1 15678,0 15777,1 15780,0 15820,1 15884,0 15956,1 16019,0 16068,1 16081,0 16154,1 16226,0 16228,1 16229,0 16309,1 16316,0 16331,1 16352,0 16400,1 16458,0 16478,1 16518,0 16574,1 16663,0 16747,1 16780,0 16837,1 16928,0 16981,1 17014,0 17017,1 17066,0 17067,1 17151,0 17185,1 17258,0 17274,1 17294,0 17318,1 17326,0 17333,1 17338,0 17411,1 17432,0 17438,1 17519,0 17556,1 17628,0 17633,1 17705,0 17782,1 17807,0 17896,1 17983,0 18076,1 18094,0 18155,1 18173,0 18179,1 18225,0 18262,1 18341,0 18366,1 18435,0 18518,1 18544,0 18584,1 18684,0 18745,1 18815,0 18862,1 18946,0 18985,1 19081,0 19105,1 19172,0 19238,1 19332,0 19420,1 19485,0 19578,1 19672,0 19712,1 19786,0 19815,1 19871,0 19876,1 19880,0 19971,1 20006,0 20044,1 20083,0 20126,1 20152,0 20245,1 20324,0 20329,1 20356,0 20394,1 20441,0 20455,1 20525,0 20548,1 20573,0 20652,1 20737,0 20800,1 20879,0 20911,1 20918,0 20945,1 20968,0 21045,1 21131,0 21179,1 21213,0 21288,1 21346,0 21434,1 21472,0 21529,1 21566,0 21645,1 21726,0 21739,1 21839,0 21877,1 21961,0 21995,1 22060,0 22066,1 22137,0 22203,1 22300,0 22306,1 22307,0 22378,1 22397,0 22415,1 22512,0 22524,1 22579,0 22646,1 22680,0 22694,1 22707,0 22714,1 22810,0 22897,1 22987,0 23069,1 23141,0 23226,1 23243,0 23256,1 23325,0 23342,1 23437,0 23506,1 23586,0 23629,1 23729,0 23823,1 23920,0 24013,1 24050,0 24096,1 24141,0 24230,1 24270,0 24364,1 24370,0 24414,1 24435,0 24443,1 24487,0 24548,1 24618,0 24664,1 24724,0 24764,1 24850,0 24935,1 24949,0 24995,1 25024,0 25031,1 25083,0 25151,1 25218,0 25283,1 25309,0 25329,1 25391,0 25411,1 25458,0 25538,1 25541,0 25604,1 25626,0 25705,1 25780,0 25875,1 25970,0 25989,1 26039,0 26048,1 26055,0 26063,1 26069,0 26097,1 26170,0 26219,1 26236,0 26289,1 26353,0 26362,1 26427,0 26509,1 26604,0 26627,1 26715,0 26813,1 26892,0 26978,1 26994,0 27058,1 27152,0 27250,1 27282,0 27304,1 27356,0 27446,1 27464,0 27482,1 27530,0 27551,1 27624,0 27653,1 27670,0 27711,1 27753,0 27759,1 27760,0 27819,1 27820,0 27835,1 27888,0 27891,1 27935,0 27936,1 27939,0 27956,1 27993,0 28040,1 28075,0 28151,1 28202,0 28253,1 28331,0 28397,1 28414,0 28472,1 28540,0 28559,1 28605,0 28687,1 28693,0 28711,1 28767,0 28844,1 28918,0 28925,1 28970,0 29048,1 29147,0 29195,1 29259,0 29322,1 29341,0 29359,1 29425,0 29427,1 29466,0 29545,1 29587,0 29636,1 29669,0 29706,1 29752,0 29784,1 29821,0 29893,1 29913,0 30010,1 30049,0 30092,1 30111,0 30149,1 30213,0 30278,1 30339,0 30361,1 30393,0 30405,1 30501,0 30575,1 30600,0 30615,1 30634,0 30704,1 30801,0 30821,1 30904,0 30945,1 30953,0 31035,1 31087,0 31119,1 31186,0 31280,1 31340,0 31386,1 31391,0 31468,1 31483,0 31510,1 31527,0 31599,1 31628,0 31633,1 31675,0 31737,1 31777,0 31791,1 31884,0 31890,1 31908,0 31951,1 31983,0 32058,1 32147,0 32222,1 32262,0 32273,1 32296,0 32385,1 32418,0 32493,1 32568,0 32652,1 32710,0 32731,1 32830,0 32923,1 32953,0 33025,1 33037,0 33102,1 33164,0 33245,1 33268,0 33357,1 33442,0 33468,1 33494,0 33562,1 33631,0 33645,1 33735,0 33816,1 33833,0 33870,1 33914,0 33917,1 33962,0 34055,1 34095,0 34129,1 34218,0 34270,1 34304,0 34322,1 34361,0 34449,1 34454,0 34531,1 34581,0 34614,1 34635,0 34716,1 34792,0 34860,1 34935,0 34970,1 35017,0 35034,1 35106,0 35167,1 35260,0 35313,1 35339,0 35388,1 35435,0 35527,1 35620,0 35662,1 35687,0 35772,1 35785,0 35824,1 35870,0 35967,1 36063,0 36123,1 36213,0 36225,1 36251,0 36319,1 36411,0 36423,1 36505,0 36515,1 36541,0 36634,1 36677,0 36725,1 36821,0 36891,1 36965,0 37050,1 37058,0 37143,1 37190,0 37230,1 37266,0 37346,1 37429,0 37491,1 37573,0 37615,1 37680,0 37684,1 37739,0 37812,1 37827,0 37857,1 37954,0 38032,1 38035,0 38061,1 38098,0 38130,1 38172,0 38194,1 38268,0 38304,1 38363,0 38422,1 38423,0 38513,1 38566,0 38582,1 38675,0 38743,1 38746,0 38774,1 38784,0 38855,1 38910,0 39005,1 39023,0 39043,1 39095,0 39178,1 39221,0 39301,1 39349,0 39413,1 39470,0 39545,1 39588,0 39638,1 39728,0 39754,1 39759,0 39844,1 39935,0 39976,1 39989,0 40050,1 40099,0 40152,1 40168,0 40211,1 40281,0 40317,1 40415,0 40486,1 40493,0 40514,1 40518,0 40563,1 40615,0 40670,1 40717,0 40724,1 40789,0 40850,1 40938,0 40949,1 40954,0 41048,1 41057,0 41143,1 41179,0 41250,1 41266,0 41344,1 41430,0 41508,1 41580,0 41656,1 41693,0 41759,1 41832,0 41840,1 41894,0 41974,1 42037,0 42134,1 42214,0 42262,1 42358,0 42425,1 42507,0 42588,1 42592,0 42653,1 42707,0 42789,1 42857,0 42933,1 43022,0 43064,1 43152,0 43215,1 43305,0 43371,1 43399,0 43406,1 43414,0 43505,1 43592,0 43598,1 43693,0 43725,1 43766,0 43772,1 43847,0 43903,1 43935,0 43978,1 44007,0 44086,1 44184,0 44262,1 44303,0 44360,1 44387,0 44453,1 44478,0 44523,1 44605,0 44648,1 44713,0 44730,1 44816,0 44904,1 44936,0 44944,1 45041,0 45105,1 45180,0 45248,1 45286,0 45296,1 45384,0 45465,1 45560,0 45659,1 45709,0 45803,1 45872,0 45945,1 45977,0 45992,1 46048,0 46078,1 46083,0 46132,1 46231,0 46251,1 46336,0 46425,1 46502,0 46545,1 46591,0 46596,1 46692,0 46752,1 46794,0 46808,1 46870,0 46956,1 47027,0 47110,1 47180,0 47247,1 47290,0 47389,1 47400,0 47491,1 47518,0 47556,1 47644,0 47695,1 47709,0 47779,1 47865,0 47885,1 47981,0 47985,1 48019,0 48056,1 48154,0 48177,1 48239,0 48335,1 48394,0 48426,1 48519,0 48577,1 48594,0 48630,1 48684,0 48753,1 48818,0 48897,1 48956,0 49015,1 49076,0 49097,1 49155,0 49167,1 49237,0 49317,1 49350,0 49352,1 49360,0 49387,1 49401,0 49465,1 49493,0 49576,1 49659,0 49705,1 49749,0 49787,1 49878,0 49976,1 50047,0 50085,1 50087,0 50122,1 50209,0 50234,1 50325,0 50394,1 50400,0 50411,1 50488,0 50535,1 50583,0 50618,1 50695,0 50760,1 50787,0 50820,1 50875,0 50888,1 50941,0 51013,1 51048,0 51145,1 51205,0 51302,1 51354,0 51448,1 51495,0 51553,1 end initlist b5 0,0 57,1 152,0 166,1 180,0 276,1 369,0 380,1 469,0 470,1 537,0 572,1 602,0 686,1 750,0 784,1 819,0 832,1 916,0 951,1 1042,0 1077,1 1104,0 1195,1 1233,0 1249,1 1300,0 1388,1 1479,0 1573,1 1578,0 1670,1 1740,0 1803,1 1888,0 1962,1 2010,0 2077,1 2141,0 2225,1 2322,0 2346,1 2363,0 2438,1 2476,0 2490,1 2588,0 2604,1 2698,0 2727,1 2780,0 2787,1 2817,0 2831,1 2919,0 3018,1 3048,0 3060,1 3113,0 3151,1 3182,0 3282,1 3325,0 3328,1 3417,0 3424,1 3441,0 3537,1 3578,0 3594,1 3660,0 3665,1 3740,0 3794,1 3849,0 3888,1 3953,0 4051,1 4052,0 4130,1 4214,0 4293,1 4331,0 4385,1 4485,0 4553,1 4618,0 4627,1 4690,0 4728,1 4822,0 4827,1 4871,0 4933,1 4960,0 4984,1 4989,0 5031,1 5050,0 5085,1 5124,0 5157,1 5230,0 5301,1 5358,0 5411,1 5412,0 5423,1 5458,0 5534,1 5610,0 5653,1 5666,0 5727,1 5807,0 5901,1 5954,0 6043,1 6073,0 6154,1 6230,0 6279,1 6310,0 6399,1 6460,0 6506,1 6567,0 6618,1 6686,0 6732,1 6747,0 6777,1 6799,0 6886,1 6939,0 6968,1 6991,0 6997,1 7008,0 7060,1 7106,0 7150,1 7152,0 7153,1 7165,0 7190,1 7284,0 7377,1 7443,0 7455,1 7476,0 7529,1 7591,0 7663,1 7718,0 7797,1 7803,0 7832,1 7835,0 7906,1 7951,0 8019,1 8094,0 8125,1 8140,0 8240,1 8268,0 8314,1 8399,0 8448,1 8476,0 8551,1 8591,0 8679,1 8705,0 8774,1 8813,0 8880,1 8917,0 9011,1 9106,0 9145,1 9199,0 9242,1 9318,0 9366,1 9449,0 9483,1 9578,0 9625,1 9683,0 9732,1 9758,0 9851,1 9909,0 9946,1 10005,0 10052,1 10143,0 10190,1 10260,0 10295,1 10379,0 10421,1 10506,0 10569,1 10668,0 10691,1 10728,0 10803,1 10889,0 10965,1 10992,0 11019,1 11040,0 11075,1 11128,0 11162,1 11189,0 11202,1 11286,0 11291,1 11300,0 11327,1 11425,0 11501,1 11588,0 11682,1 11781,0 11807,1 11859,0 11928,1 11977,0 12054,1 12147,0 12186,1 12234,0 12286,1 12370,0 12438,1 12532,0 12594,1 12663,0 12666,1 12733,0 12792,1 12830,0 12837,1 12843,0 12844,1 12934,0 13033,1 13047,0 13052,1 13118,0 13186,1 13248,0 13336,1 13343,0 13347,1 13380,0 13438,1 13486,0 13562,1 13622,0 13650,1 13653,0 13716,1 13803,0 13870,1 13964,0 14038,1 14113,0 14158,1 14179,0 14184,1 14197,0 14275,1 14350,0 14407,1 14450,0 14451,1 14476,0 14548,1 14565,0 14600,1 14659,0 14665,1 14695,0 14738,1 14827,0 14917,1 14997,0 15055,1 15121,0 15219,1 15296,0 15334,1 15378,0 15472,1 15494,0 15528,1 15542,0 15596,1 15645,0 15670,1 15759,0 15803,1 15880,0 15897,1 15939,0 15997,1 16046,0 16080,1 16109,0 16189,1 16203,0 16265,1 16314,0 16370,1 16425,0 16460,1 16469,0 16546,1 16555,0 16594,1 16632,0 16661,1 16738,0 16779,1 16796,0 16872,1 16903,0 16928,1 16979,0 16990,1 17074,0 17170,1 17226,0 17239,1 17326,0 17403,1 17460,0 17475,1 17571,0 17643,1 17647,0 17702,1 17778,0 17781,1 17862,0 17877,1 17921,0 17969,1 18039,0 18063,1 18147,0 18228,1 18281,0 18325,1 18371,0 18405,1 18497,0 18580,1 18608,0 18672,1 18733,0 18750,1 18790,0 18859,1 18879,0 18905,1 18939,0 18952,1 19012,0 19068,1 19086,0 19174,1 19218,0 19248,1 19323,0 19324,1 19371,0 19403,1 19409,0 19493,1 19507,0 19584,1 19657,0 19692,1 19730,0 19814,1 19909,0 19982,1 20032,0 20127,1 20191,0 20278,1 20294,0 20365,1 20397,0 20414,1 20507,0 20542,1 20550,0 20609,1 20629,0 20650,1 20662,0 20712,1 20812,0 20910,1 21008,0 21066,1 21079,0 21142,1 21220,0 21279,1 21337,0 21406,1 21477,0 21574,1 21627,0 21679,1 21680,0 21742,1 21767,0 21826,1 21829,0 21900,1 21935,0 22017,1 22110,0 22146,1 22201,0 22235,1 22307,0 22371,1 22457,0 22536,1 22539,0 22548,1 22605,0 22679,1 22733,0 22827,1 22859,0 22959,1 23055,0 23080,1 23109,0 23151,1 23240,0 23247,1 23299,0 23377,1 23440,0 23512,1 23606,0 23664,1 23695,0 23718,1 23781,0 23819,1 23914,0 23947,1 23963,0 23968,1 23995,0 24068,1 24094,0 24149,1 24188,0 24244,1 24344,0 24444,1 24484,0 24541,1 24575,0 24659,1 24691,0 24739,1 24767,0 24788,1 24844,0 24873,1 24946,0 24951,1 25044,0 25075,1 25139,0 25206,1 25242,0 25278,1 25293,0 25386,1 25472,0 25490,1 25541,0 25576,1 25586,0 25595,1 25611,0 25691,1 25737,0 25812,1 25904,0 25953,1 25958,0 26012,1 26013,0 26102,1 26183,0 26203,1 26284,0 26381,1 26467,0 26513,1 26594,0 26621,1 26627,0 26691,1 26707,0 26727,1 26746,0 26842,1 26903,0 26946,1 27021,0 27058,1 27093,0 27176,1 27271,0 27277,1 27288,0 27330,1 27342,0 27403,1 27437,0 27513,1 27576,0 27619,1 27631,0 27725,1 27745,0 27774,1 27807,0 27885,1 27943,0 27988,1 28025,0 28085,1 28137,0 28235,1 28269,0 28324,1 28406,0 28479,1 28563,0 28586,1 28617,0 28715,1 28759,0 28777,1 28798,0 28842,1 28911,0 28988,1 29026,0 29068,1 29108,0 29174,1 29193,0 29224,1 29309,0 29329,1 29332,0 29385,1 29402,0 29444,1 29508,0 29519,1 29552,0 29619,1 29672,0 29680,1 29777,0 29854,1 29892,0 29942,1 30013,0 30099,1 30143,0 30188,1 30255,0 30258,1 30270,0 30301,1 30365,0 30413,1 30423,0 30474,1 30568,0 30599,1 30633,0 30680,1 30758,0 30824,1 30868,0 30891,1 30960,0 31009,1 31076,0 31089,1 31133,0 31136,1 31210,0 31250,1 31312,0 31412,1 31415,0 31451,1 31535,0 31544,1 31625,0 31647,1 31730,0 31784,1 31825,0 31910,1 31946,0 32012,1 32056,0 32073,1 32100,0 32200,1 32299,0 32315,1 32407,0 32503,1 32530,0 32533,1 32557,0 32629,1 32659,0 32758,1 32806,0 32832,1 32929,0 33001,1 33094,0 33101,1 33115,0 33143,1 33205,0 33285,1 33303,0 33386,1 33424,0 33468,1 33550,0 33623,1 33665,0 33670,1 33715,0 33719,1 33790,0 33854,1 33915,0 33921,1 33952,0 33987,1 34087,0 34130,1 34181,0 34258,1 34305,0 34384,1 34447,0 34472,1 34512,0 34557,1 34559,0 34635,1 34660,0 34708,1 34806,0 34816,1 34878,0 34973,1 35073,0 35154,1 35250,0 35293,1 35340,0 35396,1 35443,0 35501,1 35531,0 35538,1 35584,0 35666,1 35732,0 35749,1 35757,0 35803,1 35876,0 35896,1 35953,0 35981,1 36034,0 36049,1 36117,0 36158,1 36179,0 36223,1 36244,0 36266,1 36322,0 36348,1 36396,0 36484,1 36492,0 36522,1 36535,0 36545,1 36548,0 36616,1 36683,0 36693,1 36725,0 36821,1 36865,0 36884,1 36941,0 36970,1 37070,0 37079,1 37104,0 37203,1 37255,0 37322,1 37370,0 37409,1 37465,0 37491,1 37577,0 37604,1 37631,0 37686,1 37743,0 37835,1 37866,0 37963,1 38061,0 38076,1 38128,0 38170,1 38247,0 38283,1 38310,0 38402,1 38403,0 38462,1 38543,0 38586,1 38661,0 38684,1 38763,0 38844,1 38937,0 38959,1 39025,0 39086,1 39125,0 39174,1 39214,0 39256,1 39324,0 39397,1 39422,0 39454,1 39554,0 39563,1 39606,0 39652,1 39677,0 39731,1 39758,0 39852,1 39917,0 39997,1 40003,0 40102,1 40106,0 40123,1 40184,0 40200,1 40285,0 40301,1 40326,0 40415,1 40515,0 40540,1 40612,0 40619,1 40699,0 40798,1 40820,0 40884,1 40979,0 41061,1 41118,0 41130,1 41199,0 41239,1 41297,0 41327,1 41390,0 41477,1 41573,0 41619,1 41677,0 41735,1 41788,0 41856,1 41878,0 41887,1 41977,0 42024,1 42051,0 42108,1 42170,0 42254,1 42319,0 42330,1 42369,0 42404,1 42472,0 42564,1 42626,0 42628,1 42661,0 42710,1 42769,0 42834,1 42891,0 42911,1 42923,0 42966,1 42967,0 42994,1 43093,0 43185,1 43276,0 43356,1 43385,0 43390,1 43485,0 43552,1 43623,0 43683,1 43743,0 43831,1 43931,0 43988,1 43996,0 44035,1 44047,0 44137,1 44169,0 44235,1 44259,0 44334,1 44392,0 44475,1 44536,0 44620,1 44702,0 44791,1 44826,0 44915,1 44924,0 44930,1 44966,0 44987,1 45025,0 45078,1 45089,0 45115,1 45205,0 45289,1 45377,0 45456,1 45461,0 45520,1 45532,0 45609,1 45650,0 45683,1 45732,0 45768,1 45865,0 45886,1 45896,0 45919,1 46002,0 46044,1 46070,0 46121,1 46147,0 46150,1 46187,0 46240,1 46254,0 46303,1 46332,0 46395,1 46396,0 46421,1 46448,0 46497,1 46537,0 46572,1 46619,0 46690,1 46735,0 46794,1 46891,0 46979,1 47065,0 47101,1 47181,0 47223,1 47284,0 47368,1 47416,0 47514,1 47591,0 47638,1 47692,0 47768,1 47827,0 47910,1 47917,0 47970,1 48007,0 48046,1 48078,0 48096,1 48137,0 48204,1 48255,0 48351,1 48367,0 48460,1 48478,0 48483,1 48515,0 48594,1 48669,0 48705,1 48798,0 48888,1 48910,0 48993,1 49031,0 49055,1 49123,0 49211,1 49253,0 49263,1 49286,0 49372,1 49459,0 49486,1 49552,0 49595,1 49632,0 49642,1 49667,0 49719,1 49722,0 49763,1 49789,0 49841,1 49903,0 49991,1 50021,0 50096,1 50141,0 50240,1 50301,0 50364,1 50448,0 50516,1 50530,0 50558,1 50582,0 50673,1 50700,0 50719,1 end initlist b6 0,0 78,1 124,0 126,1 219,0 308,1 372,0 402,1 409,0 436,1 465,0 512,1 593,0 669,1 692,0 749,1 772,0 833,1 905,0 970,1 1000,0 1057,1 1073,0 1153,1 1167,0 1251,1 1260,0 1277,1 1321,0 1349,1 1368,0 1399,1 1491,0 1495,1 1587,0 1676,1 1679,0 1751,1 1832,0 1866,1 1868,0 1955,1 1967,0 1990,1 2002,0 2060,1 2157,0 2177,1 2243,0 2314,1 2335,0 2344,1 2421,0 2478,1 2560,0 2619,1 2636,0 2734,1 2764,0 2790,1 2871,0 2889,1 2933,0 2935,1 2939,0 3018,1 3034,0 3067,1 3082,0 3099,1 3176,0 3231,1 3317,0 3370,1 3396,0 3420,1 3502,0 3553,1 3563,0 3611,1 3620,0 3707,1 3752,0 3852,1 3938,0 4008,1 4098,0 4151,1 4239,0 4299,1 4329,0 4372,1 4451,0 4491,1 4584,0 4620,1 4712,0 4777,1 4807,0 4885,1 4943,0 4995,1 5095,0 5102,1 5104,0 5108,1 5129,0 5153,1 5200,0 5260,1 5264,0 5298,1 5337,0 5413,1 5446,0 5477,1 5542,0 5589,1 5658,0 5717,1 5812,0 5843,1 5908,0 5982,1 6034,0 6083,1 6164,0 6181,1 6251,0 6346,1 6436,0 6517,1 6525,0 6527,1 6535,0 6566,1 6612,0 6633,1 6684,0 6774,1 6851,0 6875,1 6971,0 6974,1 7066,0 7104,1 7116,0 7168,1 7212,0 7251,1 7278,0 7334,1 7378,0 7452,1 7480,0 7564,1 7662,0 7671,1 7750,0 7765,1 7853,0 7941,1 7953,0 8018,1 8074,0 8142,1 8152,0 8205,1 8287,0 8339,1 8372,0 8436,1 8524,0 8572,1 8616,0 8627,1 8726,0 8761,1 8792,0 8820,1 8847,0 8897,1 8902,0 8934,1 8975,0 9047,1 9137,0 9199,1 9285,0 9303,1 9402,0 9440,1 9518,0 9578,1 9635,0 9676,1 9727,0 9823,1 9862,0 9905,1 9960,0 9997,1 10078,0 10163,1 10256,0 10330,1 10393,0 10398,1 10439,0 10487,1 10553,0 10650,1 10700,0 10773,1 10850,0 10896,1 10963,0 10993,1 11044,0 11107,1 11168,0 11253,1 11294,0 11369,1 11398,0 11487,1 11533,0 11597,1 11687,0 11750,1 11848,0 11886,1 11932,0 11980,1 12063,0 12163,1 12249,0 12291,1 12309,0 12327,1 12387,0 12400,1 12454,0 12531,1 12538,0 12635,1 12690,0 12762,1 12781,0 12791,1 12842,0 12895,1 12926,0 12969,1 13030,0 13119,1 13164,0 13238,1 13279,0 13339,1 13430,0 13484,1 13521,0 13589,1 13607,0 13697,1 13756,0 13769,1 13805,0 13905,1 13977,0 13993,1 14070,0 14137,1 14170,0 14249,1 14337,0 14346,1 14400,0 14472,1 14549,0 14607,1 14698,0 14724,1 14806,0 14819,1 14919,0 14921,1 14957,0 15004,1 15056,0 15139,1 15148,0 15208,1 15219,0 15263,1 15270,0 15281,1 15338,0 15364,1 15396,0 15397,1 15415,0 15501,1 15564,0 15647,1 15674,0 15748,1 15824,0 15885,1 15935,0 15993,1 16032,0 16093,1 16101,0 16129,1 16188,0 16285,1 16316,0 16341,1 16429,0 16508,1 16521,0 16569,1 16598,0 16662,1 16723,0 16777,1 16792,0 16867,1 16898,0 16916,1 16938,0 16981,1 17032,0 17108,1 17132,0 17150,1 17181,0 17235,1 17300,0 17329,1 17332,0 17414,1 17485,0 17486,1 17559,0 17610,1 17688,0 17722,1 17796,0 17887,1 17951,0 17991,1 18076,0 18169,1 18181,0 18233,1 18313,0 18327,1 18362,0 18405,1 18457,0 18471,1 18480,0 18487,1 18521,0 18590,1 18624,0 18665,1 18702,0 18752,1 18784,0 18822,1 18892,0 18910,1 18941,0 18972,1 19006,0 19050,1 19069,0 19142,1 19165,0 19186,1 19278,0 19334,1 19358,0 19373,1 19390,0 19394,1 19492,0 19523,1 19602,0 19626,1 19634,0 19727,1 19767,0 19797,1 19801,0 19825,1 19906,0 19985,1 20049,0 20104,1 20130,0 20221,1 20309,0 20373,1 20381,0 20428,1 20505,0 20585,1 20614,0 20630,1 20676,0 20776,1 20851,0 20861,1 20940,0 20974,1 21040,0 21062,1 21123,0 21146,1 21190,0 21216,1 21255,0 21338,1 21394,0 21472,1 21543,0 21574,1 21642,0 21688,1 21720,0 21812,1 21836,0 21880,1 21925,0 21965,1 21995,0 22091,1 22137,0 22180,1 22199,0 22277,1 22367,0 22454,1 22551,0 22603,1 22662,0 22696,1 22793,0 22818,1 22838,0 22882,1 22963,0 23041,1 23092,0 23093,1 23124,0 23177,1 23231,0 23279,1 23297,0 23382,1 23416,0 23505,1 23593,0 23692,1 23706,0 23717,1 23816,0 23881,1 23955,0 24035,1 24104,0 24113,1 24176,0 24205,1 24250,0 24297,1 24315,0 24349,1 24399,0 24488,1 24502,0 24576,1 24672,0 24727,1 24797,0 24877,1 24947,0 24949,1 24957,0 25009,1 25049,0 25142,1 25196,0 25201,1 25202,0 25243,1 25327,0 25422,1 25508,0 25521,1 25585,0 25649,1 25672,0 25718,1 25743,0 25758,1 25779,0 25807,1 25830,0 25859,1 25909,0 25964,1 26036,0 26045,1 26103,0 26174,1 26255,0 26287,1 26288,0 26348,1 26448,0 26506,1 26606,0 26667,1 26749,0 26804,1 26805,0 26893,1 26950,0 26957,1 27002,0 27084,1 27182,0 27208,1 27209,0 27228,1 27277,0 27304,1 27394,0 27492,1 27522,0 27587,1 27607,0 27681,1 27776,0 27792,1 27829,0 27912,1 28009,0 28015,1 28038,0 28132,1 28196,0 28266,1 28309,0 28408,1 28490,0 28582,1 28671,0 28760,1 28788,0 28872,1 28878,0 28930,1 29015,0 29111,1 29196,0 29280,1 29375,0 29416,1 29512,0 29541,1 29589,0 29675,1 29758,0 29790,1 29866,0 29960,1 30012,0 30061,1 30078,0 30159,1 30209,0 30289,1 30297,0 30382,1 30417,0 30491,1 30540,0 30626,1 30665,0 30700,1 30741,0 30785,1 30862,0 30938,1 30975,0 30987,1 31024,0 31040,1 31092,0 31109,1 31133,0 31141,1 31151,0 31161,1 31166,0 31264,1 31344,0 31434,1 31483,0 31489,1 31509,0 31559,1 31569,0 31653,1 31657,0 31694,1 31738,0 31765,1 31782,0 31840,1 31925,0 31943,1 31971,0 31994,1 32012,0 32067,1 32158,0 32202,1 32293,0 32324,1 32419,0 32458,1 32492,0 32579,1 32607,0 32694,1 32720,0 32783,1 32856,0 32885,1 32968,0 32973,1 33009,0 33055,1 33092,0 33163,1 33187,0 33286,1 33331,0 33347,1 33414,0 33431,1 33439,0 33539,1 33560,0 33618,1 33657,0 33755,1 33804,0 33886,1 33950,0 34010,1 34021,0 34073,1 34107,0 34186,1 34249,0 34319,1 34344,0 34442,1 34454,0 34552,1 34590,0 34648,1 34712,0 34766,1 34788,0 34813,1 34876,0 34884,1 34954,0 34980,1 35058,0 35102,1 35191,0 35225,1 35274,0 35311,1 35368,0 35386,1 35463,0 35497,1 35546,0 35602,1 35636,0 35675,1 35701,0 35748,1 35820,0 35900,1 35973,0 35974,1 36050,0 36089,1 36133,0 36180,1 36240,0 36303,1 36361,0 36452,1 36461,0 36525,1 36593,0 36602,1 36678,0 36760,1 36843,0 36933,1 36937,0 37032,1 37117,0 37133,1 37141,0 37234,1 37266,0 37322,1 37376,0 37475,1 37564,0 37620,1 37695,0 37779,1 37810,0 37882,1 37952,0 37953,1 37989,0 38032,1 38107,0 38115,1 38154,0 38184,1 38280,0 38328,1 38351,0 38447,1 38479,0 38558,1 38602,0 38641,1 38738,0 38826,1 38905,0 39005,1 39015,0 39038,1 39120,0 39189,1 39225,0 39292,1 39340,0 39348,1 39440,0 39499,1 39526,0 39585,1 39643,0 39743,1 39757,0 39844,1 39910,0 39963,1 40020,0 40117,1 40121,0 40129,1 40205,0 40238,1 40295,0 40323,1 40395,0 40436,1 40520,0 40618,1 40627,0 40716,1 40780,0 40875,1 40945,0 40975,1 40985,0 41021,1 41085,0 41125,1 41135,0 41215,1 41293,0 41342,1 41415,0 41451,1 41487,0 41570,1 41615,0 41676,1 41727,0 41756,1 41807,0 41878,1 41886,0 41973,1 42016,0 42080,1 42098,0 42183,1 42257,0 42284,1 42384,0 42441,1 42442,0 42498,1 42558,0 42625,1 42699,0 42712,1 42724,0 42730,1 42739,0 42819,1 42909,0 42940,1 42999,0 43019,1 43033,0 43086,1 43105,0 43108,1 43167,0 43231,1 43248,0 43269,1 43293,0 43376,1 43378,0 43439,1 43442,0 43481,1 43494,0 43515,1 43605,0 43665,1 43710,0 43753,1 43779,0 43818,1 43879,0 43964,1 44058,0 44081,1 44109,0 44159,1 44171,0 44257,1 44350,0 44410,1 44459,0 44559,1 44616,0 44678,1 44687,0 44744,1 44816,0 44915,1 45014,0 45024,1 45075,0 45154,1 45155,0 45204,1 45257,0 45331,1 45389,0 45489,1 45509,0 45540,1 45589,0 45683,1 45709,0 45728,1 45754,0 45760,1 45845,0 45942,1 46003,0 46064,1 46089,0 46139,1 46204,0 46238,1 46280,0 46347,1 46377,0 46415,1 46448,0 46525,1 46550,0 46600,1 46698,0 46713,1 46746,0 46797,1 46886,0 46956,1 47029,0 47106,1 47173,0 47203,1 47235,0 47326,1 47327,0 47394,1 47454,0 47506,1 47539,0 47589,1 47684,0 47763,1 47772,0 47797,1 47881,0 47894,1 47958,0 47985,1 48076,0 48138,1 48160,0 48207,1 48228,0 48313,1 48383,0 48391,1 48417,0 48447,1 48533,0 48543,1 48548,0 48625,1 48641,0 48642,1 48736,0 48775,1 48833,0 48839,1 48928,0 48957,1 49039,0 49063,1 49134,0 49149,1 49208,0 49223,1 49315,0 49353,1 49446,0 49542,1 49602,0 49604,1 49661,0 49747,1 49792,0 49815,1 49860,0 49903,1 49988,0 50080,1 50153,0 50216,1 50283,0 50324,1 50401,0 50446,1 50538,0 50544,1 50586,0 50668,1 50751,0 50761,1 50802,0 50827,1 50869,0 50886,1 50963,0 51031,1 51088,0 51155,1 end initlist b7 0,0 84,1 114,0 213,1 250,0 286,1 322,0 385,1 388,0 410,1 414,0 438,1 519,0 548,1 560,0 575,1 657,0 735,1 825,0 840,1 885,0 910,1 912,0 917,1 919,0 962,1 985,0 1023,1 1116,0 1133,1 1203,0 1239,1 1324,0 1402,1 1489,0 1560,1 1638,0 1708,1 1771,0 1798,1 1819,0 1915,1 1952,0 1967,1 1979,0 2008,1 2030,0 2104,1 2179,0 2203,1 2262,0 2264,1 2353,0 2373,1 2383,0 2444,1 2477,0 2554,1 2611,0 2703,1 2747,0 2771,1 2804,0 2828,1 2915,0 2939,1 2952,0 3036,1 3124,0 3216,1 3242,0 3252,1 3279,0 3358,1 3419,0 3514,1 3567,0 3660,1 3760,0 3788,1 3879,0 3890,1 3932,0 3971,1 4028,0 4038,1 4060,0 4088,1 4117,0 4121,1 4136,0 4183,1 4242,0 4248,1 4333,0 4338,1 4361,0 4454,1 4521,0 4572,1 4620,0 4642,1 4670,0 4710,1 4761,0 4777,1 4851,0 4942,1 4952,0 5040,1 5125,0 5160,1 5178,0 5226,1 5261,0 5344,1 5382,0 5431,1 5475,0 5494,1 5539,0 5632,1 5673,0 5675,1 5732,0 5807,1 5825,0 5861,1 5914,0 5942,1 5977,0 6064,1 6075,0 6089,1 6167,0 6172,1 6272,0 6321,1 6346,0 6351,1 6426,0 6455,1 6472,0 6480,1 6494,0 6539,1 6634,0 6685,1 6768,0 6842,1 6892,0 6917,1 7010,0 7034,1 7053,0 7106,1 7203,0 7230,1 7281,0 7320,1 7384,0 7460,1 7548,0 7563,1 7663,0 7707,1 7737,0 7785,1 7867,0 7944,1 8022,0 8033,1 8102,0 8145,1 8191,0 8202,1 8253,0 8353,1 8411,0 8462,1 8532,0 8617,1 8658,0 8748,1 8766,0 8784,1 8869,0 8930,1 8955,0 9050,1 9092,0 9114,1 9115,0 9168,1 9195,0 9210,1 9213,0 9309,1 9349,0 9384,1 9479,0 9548,1 9574,0 9591,1 9642,0 9667,1 9689,0 9723,1 9810,0 9871,1 9943,0 10015,1 10101,0 10141,1 10203,0 10272,1 10348,0 10389,1 10401,0 10417,1 10512,0 10542,1 10556,0 10564,1 10616,0 10715,1 10778,0 10861,1 10864,0 10946,1 11040,0 11053,1 11108,0 11174,1 11193,0 11230,1 11252,0 11313,1 11330,0 11409,1 11446,0 11527,1 11624,0 11632,1 11707,0 11727,1 11732,0 11748,1 11806,0 11829,1 11861,0 11899,1 11929,0 11993,1 12032,0 12129,1 12182,0 12246,1 12338,0 12370,1 12373,0 12427,1 12483,0 12524,1 12604,0 12642,1 12671,0 12704,1 12793,0 12831,1 12859,0 12875,1 12946,0 12994,1 13004,0 13062,1 13066,0 13166,1 13231,0 13286,1 13298,0 13357,1 13376,0 13433,1 13483,0 13583,1 13612,0 13641,1 13689,0 13768,1 13779,0 13875,1 13975,0 14037,1 14129,0 14142,1 14155,0 14187,1 14217,0 14275,1 14313,0 14337,1 14356,0 14419,1 14517,0 14528,1 14617,0 14666,1 14763,0 14765,1 14853,0 14933,1 14952,0 14974,1 14989,0 15035,1 15076,0 15152,1 15235,0 15326,1 15392,0 15454,1 15469,0 15555,1 15599,0 15695,1 15700,0 15750,1 15759,0 15827,1 15846,0 15920,1 15970,0 16012,1 16055,0 16083,1 16175,0 16255,1 16353,0 16386,1 16472,0 16518,1 16583,0 16625,1 16684,0 16739,1 16761,0 16792,1 16892,0 16957,1 17005,0 17017,1 17068,0 17079,1 17121,0 17165,1 17203,0 17280,1 17328,0 17419,1 17472,0 17514,1 17563,0 17639,1 17676,0 17774,1 17868,0 17948,1 17951,0 17973,1 18020,0 18032,1 18065,0 18145,1 18168,0 18228,1 18266,0 18353,1 18380,0 18419,1 18425,0 18478,1 18507,0 18517,1 18529,0 18557,1 18561,0 18610,1 18651,0 18681,1 18738,0 18779,1 18822,0 18879,1 18885,0 18962,1 18983,0 18998,1 19049,0 19125,1 19223,0 19249,1 19306,0 19344,1 19405,0 19427,1 19486,0 19507,1 19605,0 19615,1 19715,0 19756,1 19836,0 19871,1 19892,0 19921,1 19952,0 19983,1 20038,0 20064,1 20069,0 20072,1 20124,0 20155,1 20164,0 20239,1 20330,0 20346,1 20372,0 20392,1 20437,0 20457,1 20553,0 20627,1 20724,0 20761,1 20826,0 20894,1 20968,0 20975,1 21070,0 21166,1 21187,0 21213,1 21281,0 21283,1 21367,0 21385,1 21463,0 21562,1 21617,0 21713,1 21718,0 21799,1 21860,0 21886,1 21977,0 22071,1 22127,0 22144,1 22164,0 22198,1 22213,0 22296,1 22335,0 22408,1 22439,0 22448,1 22476,0 22490,1 22540,0 22544,1 22601,0 22668,1 22756,0 22822,1 22829,0 22882,1 22918,0 22928,1 23026,0 23028,1 23095,0 23132,1 23145,0 23175,1 23190,0 23241,1 23297,0 23334,1 23371,0 23440,1 23504,0 23520,1 23618,0 23663,1 23702,0 23800,1 23832,0 23887,1 23900,0 23946,1 23967,0 24013,1 24016,0 24021,1 24061,0 24078,1 24095,0 24175,1 24177,0 24217,1 24311,0 24377,1 24422,0 24513,1 24582,0 24628,1 24686,0 24747,1 24824,0 24908,1 24953,0 25015,1 25032,0 25039,1 25137,0 25141,1 25220,0 25308,1 25317,0 25396,1 25468,0 25516,1 25609,0 25648,1 25707,0 25724,1 25793,0 25806,1 25888,0 25977,1 26047,0 26107,1 26196,0 26219,1 26285,0 26357,1 26444,0 26475,1 26514,0 26543,1 26585,0 26681,1 26736,0 26782,1 26829,0 26867,1 26959,0 26971,1 27052,0 27114,1 27213,0 27222,1 27237,0 27309,1 27367,0 27379,1 27396,0 27436,1 27493,0 27583,1 27633,0 27727,1 27732,0 27829,1 27913,0 28010,1 28054,0 28073,1 28130,0 28199,1 28212,0 28294,1 28328,0 28427,1 28472,0 28513,1 28603,0 28629,1 28648,0 28714,1 28742,0 28832,1 28907,0 28913,1 28920,0 28947,1 29003,0 29061,1 29159,0 29161,1 29243,0 29247,1 29272,0 29315,1 29389,0 29396,1 29482,0 29551,1 29641,0 29703,1 29795,0 29839,1 29857,0 29906,1 29945,0 29994,1 30037,0 30106,1 30130,0 30167,1 30262,0 30293,1 30350,0 30418,1 30429,0 30516,1 30543,0 30574,1 30601,0 30699,1 30767,0 30787,1 30847,0 30931,1 31005,0 31026,1 31052,0 31118,1 31163,0 31250,1 31307,0 31331,1 31394,0 31433,1 31509,0 31574,1 31595,0 31654,1 31676,0 31723,1 31816,0 31860,1 31887,0 31914,1 31915,0 31977,1 32052,0 32080,1 32121,0 32204,1 32221,0 32257,1 32295,0 32349,1 32409,0 32483,1 32514,0 32596,1 32677,0 32745,1 32795,0 32844,1 32872,0 32905,1 32984,0 33073,1 33130,0 33206,1 33234,0 33246,1 33343,0 33429,1 33464,0 33510,1 33549,0 33583,1 33590,0 33650,1 33724,0 33816,1 33869,0 33969,1 34040,0 34076,1 34106,0 34107,1 34152,0 34168,1 34186,0 34244,1 34324,0 34379,1 34424,0 34454,1 34544,0 34627,1 34688,0 34704,1 34774,0 34784,1 34850,0 34878,1 34953,0 35015,1 35080,0 35160,1 35162,0 35231,1 35330,0 35407,1 35426,0 35460,1 35525,0 35588,1 35668,0 35757,1 35789,0 35836,1 35930,0 35940,1 35992,0 36091,1 36130,0 36178,1 36270,0 36361,1 36411,0 36501,1 36557,0 36562,1 36585,0 36634,1 36635,0 36664,1 36670,0 36769,1 36839,0 36939,1 37022,0 37101,1 37122,0 37200,1 37254,0 37282,1 37285,0 37329,1 37343,0 37345,1 37349,0 37397,1 37441,0 37468,1 37550,0 37640,1 37702,0 37720,1 37777,0 37797,1 37836,0 37841,1 37886,0 37967,1 37968,0 38023,1 38055,0 38099,1 38187,0 38191,1 38239,0 38285,1 38368,0 38376,1 38396,0 38449,1 38547,0 38620,1 38691,0 38722,1 38736,0 38819,1 38898,0 38981,1 38999,0 39097,1 39100,0 39197,1 39263,0 39317,1 39372,0 39431,1 39488,0 39511,1 39601,0 39612,1 39630,0 39641,1 39733,0 39752,1 39821,0 39855,1 39917,0 39993,1 40001,0 40077,1 40090,0 40104,1 40158,0 40178,1 40241,0 40276,1 40340,0 40383,1 40408,0 40436,1 40509,0 40557,1 40561,0 40652,1 40713,0 40792,1 40795,0 40864,1 40869,0 40915,1 40997,0 41009,1 41099,0 41107,1 41121,0 41191,1 41201,0 41204,1 41246,0 41345,1 41364,0 41398,1 41489,0 41523,1 41554,0 41632,1 41728,0 41730,1 41753,0 41839,1 41930,0 41931,1 41955,0 41966,1 42059,0 42159,1 42195,0 42241,1 42278,0 42357,1 42417,0 42460,1 42483,0 42575,1 42650,0 42699,1 42732,0 42767,1 42806,0 42830,1 42927,0 42986,1 43010,0 43046,1 43058,0 43070,1 43098,0 43145,1 43153,0 43249,1 43291,0 43323,1 43331,0 43363,1 43368,0 43460,1 43514,0 43556,1 43565,0 43662,1 43700,0 43764,1 43799,0 43861,1 43864,0 43946,1 43985,0 43990,1 44041,0 44111,1 44176,0 44273,1 44352,0 44376,1 44418,0 44494,1 44520,0 44612,1 44650,0 44670,1 44751,0 44848,1 44884,0 44906,1 45000,0 45006,1 45101,0 45109,1 45193,0 45278,1 45360,0 45460,1 45484,0 45496,1 45580,0 45622,1 45645,0 45661,1 45746,0 45819,1 45852,0 45904,1 45994,0 46015,1 46068,0 46099,1 46111,0 46162,1 46251,0 46335,1 46348,0 46362,1 46385,0 46452,1 46492,0 46541,1 46641,0 46662,1 46739,0 46814,1 46870,0 46953,1 47006,0 47049,1 47096,0 47127,1 47216,0 47292,1 47300,0 47389,1 47402,0 47404,1 47477,0 47489,1 47566,0 47628,1 47652,0 47682,1 47756,0 47842,1 47853,0 47914,1 47953,0 48035,1 48106,0 48132,1 48157,0 48231,1 48287,0 48318,1 48390,0 48462,1 48533,0 48577,1 48612,0 48621,1 48679,0 48708,1 48804,0 48877,1 48935,0 49004,1 49045,0 49056,1 49141,0 49226,1 end initlist cin 0, 0 14, 1 end outvalues s0 1, s1 1, s2 1, s3 1, s4 1, s5 1, s6 1, s7 1, , cout 1, end netlist // PGgen (g0,p0,a0,b0) xor2(p0,a0,b0)#5 and2(g0,a0,b0)#5 end netlist // PGgen (g1,p1,a1,b1) xor2(p1,a1,b1)#5 and2(g1,a1,b1)#5 end netlist // PGgen (g2,p2,a2,b2) xor2(p2,a2,b2)#5 and2(g2,a2,b2)#5 end netlist // PGgen (g3,p3,a3,b3) xor2(p3,a3,b3)#5 and2(g3,a3,b3)#5 end netlist // PGgen (g4,p4,a4,b4) xor2(p4,a4,b4)#5 and2(g4,a4,b4)#5 end netlist // PGgen (g5,p5,a5,b5) xor2(p5,a5,b5)#5 and2(g5,a5,b5)#5 end netlist // PGgen (g6,p6,a6,b6) xor2(p6,a6,b6)#5 and2(g6,a6,b6)#5 end netlist // PGgen (g7,p7,a7,b7) xor2(p7,a7,b7)#5 and2(g7,a7,b7)#5 end netlist // Gcombine (g_0_cin, g0, cin, p0 ) and2(w0g_0_cin, p0, cin )#5 or2( g_0_cin, w0g_0_cin, g0 )#5 end netlist // PGcombine (g_1_0,p_1_0,g1,p1,g0,p0) and2( w0g_1_0, p1, g0 )#5 or2( g_1_0, w0g_1_0, g1 )#5 and2( p_1_0, p1, p0)#5 end netlist // PGcombine (g_2_1,p_2_1,g2,p2,g1,p1) and2( w0g_2_1, p2, g1 )#5 or2( g_2_1, w0g_2_1, g2 )#5 and2( p_2_1, p2, p1)#5 end netlist // PGcombine (g_3_2,p_3_2,g3,p3,g2,p2) and2( w0g_3_2, p3, g2 )#5 or2( g_3_2, w0g_3_2, g3 )#5 and2( p_3_2, p3, p2)#5 end netlist // PGcombine (g_4_3,p_4_3,g4,p4,g3,p3) and2( w0g_4_3, p4, g3 )#5 or2( g_4_3, w0g_4_3, g4 )#5 and2( p_4_3, p4, p3)#5 end netlist // PGcombine (g_5_4,p_5_4,g5,p5,g4,p4) and2( w0g_5_4, p5, g4 )#5 or2( g_5_4, w0g_5_4, g5 )#5 and2( p_5_4, p5, p4)#5 end netlist // PGcombine (g_6_5,p_6_5,g6,p6,g5,p5) and2( w0g_6_5, p6, g5 )#5 or2( g_6_5, w0g_6_5, g6 )#5 and2( p_6_5, p6, p5)#5 end netlist // PGcombine (g_7_6,p_7_6,g7,p7,g6,p6) and2( w0g_7_6, p7, g6 )#5 or2( g_7_6, w0g_7_6, g7 )#5 and2( p_7_6, p7, p6)#5 end netlist // Gcombine (g_1_cin, g_1_0, cin, p_1_0 ) and2(w0g_1_cin, p_1_0, cin )#5 or2( g_1_cin, w0g_1_cin, g_1_0 )#5 end netlist // Gcombine (g_2_cin, g_2_1, g_0_cin, p_2_1 ) and2(w0g_2_cin, p_2_1, g_0_cin )#5 or2( g_2_cin, w0g_2_cin, g_2_1 )#5 end netlist // PGcombine (g_3_0,p_3_0,g_3_2,p_3_2,g_1_0,p_1_0) and2( w0g_3_0, p_3_2, g_1_0 )#5 or2( g_3_0, w0g_3_0, g_3_2 )#5 and2( p_3_0, p_3_2, p_1_0)#5 end netlist // PGcombine (g_4_1,p_4_1,g_4_3,p_4_3,g_2_1,p_2_1) and2( w0g_4_1, p_4_3, g_2_1 )#5 or2( g_4_1, w0g_4_1, g_4_3 )#5 and2( p_4_1, p_4_3, p_2_1)#5 end netlist // PGcombine (g_5_2,p_5_2,g_5_4,p_5_4,g_3_2,p_3_2) and2( w0g_5_2, p_5_4, g_3_2 )#5 or2( g_5_2, w0g_5_2, g_5_4 )#5 and2( p_5_2, p_5_4, p_3_2)#5 end netlist // PGcombine (g_6_3,p_6_3,g_6_5,p_6_5,g_4_3,p_4_3) and2( w0g_6_3, p_6_5, g_4_3 )#5 or2( g_6_3, w0g_6_3, g_6_5 )#5 and2( p_6_3, p_6_5, p_4_3)#5 end netlist // PGcombine (g_7_4,p_7_4,g_7_6,p_7_6,g_5_4,p_5_4) and2( w0g_7_4, p_7_6, g_5_4 )#5 or2( g_7_4, w0g_7_4, g_7_6 )#5 and2( p_7_4, p_7_6, p_5_4)#5 end netlist // Gcombine (g_3_cin, g_3_0, cin, p_3_0 ) and2(w0g_3_cin, p_3_0, cin )#5 or2( g_3_cin, w0g_3_cin, g_3_0 )#5 end netlist // Gcombine (g_4_cin, g_4_1, g_0_cin, p_4_1 ) and2(w0g_4_cin, p_4_1, g_0_cin )#5 or2( g_4_cin, w0g_4_cin, g_4_1 )#5 end netlist // Gcombine (g_5_cin, g_5_2, g_1_cin, p_5_2 ) and2(w0g_5_cin, p_5_2, g_1_cin )#5 or2( g_5_cin, w0g_5_cin, g_5_2 )#5 end netlist // Gcombine (g_6_cin, g_6_3, g_2_cin, p_6_3 ) and2(w0g_6_cin, p_6_3, g_2_cin )#5 or2( g_6_cin, w0g_6_cin, g_6_3 )#5 end netlist // PGcombine (g_7_0,p_7_0,g_7_4,p_7_4,g_3_0,p_3_0) and2( w0g_7_0, p_7_4, g_3_0 )#5 or2( g_7_0, w0g_7_0, g_7_4 )#5 and2( p_7_0, p_7_4, p_3_0)#5 end netlist // Gcombine (cout, g_7_0, cin, p_7_0 ) and2(w0cout, p_7_0, cin )#5 or2( cout, w0cout, g_7_0 )#5 end netlist xor2( s0, p0,cin )#5 xor2( s1, p1,g_0_cin )#5 xor2( s2, p2,g_1_cin )#5 xor2( s3, p3,g_2_cin )#5 xor2( s4, p4,g_3_cin )#5 xor2( s5, p5,g_4_cin )#5 xor2( s6, p6,g_5_cin )#5 xor2( s7, p7,g_6_cin )#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/koggeStone16bit.net
// Lonestar Benchmark Suite for irregular applications that exhibit // amorphous data-parallelism. // // Center for Grid and Distributed Computing // The University of Texas at Austin // // Copyright (C) 2007, 2008, 2009 The University of Texas at Austin // // Licensed under the Eclipse Public License, Version 1.0 (the "License"); // you may not use this file except in compliance with the License. // You may obtain a copy of the License at // // http://www.eclipse.org/legal/epl-v10.html // // Unless required by applicable law or agreed to in writing, software // distributed under the License is distributed on an "AS IS" BASIS, // WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. // See the License for the specific language governing permissions and // limitations under the License. // // File: koggeStone16bit.net finish 100000 inputs cin, a0, a1, a2, a3, a4, a5, a6, a7, a8, a9, a10, a11, a12, a13, a14, a15, b0, b1, b2, b3, b4, b5, b6, b7, b8, b9, b10, b11, b12, b13, b14, b15 end outputs cout, s0, s1, s2, s3, s4, s5, s6, s7, s8, s9, s10, s11, s12, s13, s14, s15 end initlist a0 0,0 4,1 22,0 31,1 126,0 172,1 189,0 254,1 271,0 364,1 459,0 463,1 559,0 623,1 639,0 737,1 758,0 776,1 823,0 863,1 900,0 989,1 991,0 1057,1 1060,0 1150,1 1156,0 1162,1 1216,0 1281,1 1308,0 1318,1 1328,0 1424,1 1440,0 1486,1 1558,0 1653,1 1684,0 1752,1 1780,0 1781,1 1829,0 1865,1 1959,0 2038,1 2126,0 2132,1 2207,0 2293,1 2355,0 2426,1 2454,0 2534,1 2604,0 2695,1 2788,0 2811,1 2898,0 2917,1 2963,0 3034,1 3115,0 3151,1 3190,0 3207,1 3224,0 3315,1 3365,0 3432,1 3499,0 3569,1 3643,0 3683,1 3755,0 3765,1 3793,0 3884,1 3893,0 3941,1 3962,0 3985,1 4027,0 4059,1 4131,0 4133,1 4206,0 4267,1 4326,0 4370,1 4428,0 4501,1 4546,0 4624,1 4692,0 4718,1 4750,0 4802,1 4855,0 4938,1 5034,0 5075,1 5160,0 5248,1 5261,0 5310,1 5367,0 5404,1 5430,0 5500,1 5521,0 5544,1 5557,0 5560,1 5604,0 5646,1 5669,0 5754,1 5826,0 5849,1 5922,0 5994,1 6073,0 6093,1 6107,0 6165,1 6223,0 6250,1 6290,0 6294,1 6362,0 6425,1 6503,0 6513,1 6606,0 6684,1 6772,0 6861,1 6943,0 7022,1 7044,0 7045,1 7088,0 7105,1 7107,0 7129,1 7150,0 7159,1 7185,0 7218,1 7231,0 7284,1 7307,0 7396,1 7442,0 7464,1 7553,0 7635,1 7732,0 7750,1 7754,0 7840,1 7874,0 7903,1 7971,0 8051,1 8136,0 8226,1 8237,0 8334,1 8368,0 8446,1 8464,0 8528,1 8590,0 8633,1 8717,0 8762,1 8843,0 8936,1 9009,0 9074,1 9123,0 9125,1 9156,0 9181,1 9190,0 9218,1 9309,0 9311,1 9352,0 9439,1 9473,0 9569,1 9620,0 9698,1 9768,0 9867,1 9931,0 10017,1 10038,0 10114,1 10142,0 10171,1 10237,0 10319,1 10344,0 10360,1 10400,0 10463,1 10509,0 10587,1 10607,0 10684,1 10765,0 10808,1 10884,0 10900,1 10909,0 10910,1 10927,0 10956,1 10981,0 11038,1 11063,0 11071,1 11162,0 11236,1 11267,0 11294,1 11306,0 11368,1 11449,0 11525,1 11601,0 11642,1 11710,0 11797,1 11891,0 11984,1 12007,0 12103,1 12188,0 12189,1 12288,0 12383,1 12453,0 12495,1 12570,0 12638,1 12731,0 12814,1 12852,0 12907,1 12914,0 12922,1 12957,0 13010,1 13032,0 13124,1 13200,0 13226,1 13286,0 13329,1 13389,0 13400,1 13461,0 13509,1 13601,0 13661,1 13666,0 13708,1 13753,0 13849,1 13902,0 13983,1 14078,0 14133,1 14203,0 14226,1 14307,0 14405,1 14455,0 14465,1 14528,0 14597,1 14655,0 14707,1 14795,0 14806,1 14886,0 14887,1 14911,0 14915,1 15004,0 15079,1 15133,0 15204,1 15261,0 15268,1 15365,0 15458,1 15539,0 15622,1 15631,0 15641,1 15737,0 15745,1 15756,0 15830,1 15856,0 15924,1 15952,0 16024,1 16059,0 16114,1 16140,0 16164,1 16179,0 16183,1 16232,0 16331,1 16349,0 16366,1 16402,0 16464,1 16505,0 16594,1 16674,0 16746,1 16791,0 16832,1 16921,0 16937,1 16992,0 17047,1 17090,0 17128,1 17195,0 17227,1 17232,0 17278,1 17370,0 17470,1 17471,0 17496,1 17594,0 17626,1 17657,0 17752,1 17834,0 17841,1 17864,0 17932,1 17933,0 18031,1 18064,0 18075,1 18136,0 18212,1 18229,0 18318,1 18414,0 18489,1 18561,0 18614,1 18663,0 18714,1 18785,0 18828,1 18834,0 18850,1 18861,0 18889,1 18909,0 18912,1 18965,0 19051,1 19061,0 19087,1 19104,0 19188,1 19190,0 19234,1 19260,0 19347,1 19434,0 19439,1 19486,0 19572,1 19614,0 19631,1 19658,0 19696,1 19729,0 19738,1 19778,0 19817,1 19876,0 19962,1 20056,0 20124,1 20157,0 20238,1 20269,0 20323,1 20393,0 20430,1 20470,0 20536,1 20635,0 20717,1 20805,0 20829,1 20895,0 20908,1 20981,0 21036,1 21077,0 21083,1 21140,0 21162,1 21168,0 21195,1 21200,0 21244,1 21304,0 21396,1 21454,0 21521,1 21620,0 21648,1 21657,0 21659,1 21665,0 21684,1 21702,0 21738,1 21817,0 21890,1 21901,0 21968,1 22033,0 22049,1 22112,0 22136,1 22235,0 22328,1 22375,0 22458,1 22502,0 22555,1 22595,0 22638,1 22728,0 22793,1 22822,0 22865,1 22945,0 22981,1 23068,0 23167,1 23211,0 23276,1 23306,0 23353,1 23437,0 23439,1 23461,0 23558,1 23625,0 23655,1 23666,0 23715,1 23745,0 23838,1 23923,0 23931,1 24018,0 24075,1 24158,0 24164,1 24202,0 24290,1 24303,0 24304,1 24369,0 24416,1 24443,0 24524,1 24599,0 24614,1 24709,0 24808,1 24850,0 24883,1 24937,0 24974,1 25038,0 25088,1 25116,0 25200,1 25293,0 25332,1 25373,0 25390,1 25435,0 25455,1 25504,0 25514,1 25587,0 25678,1 25706,0 25784,1 25838,0 25875,1 25968,0 25998,1 26053,0 26082,1 26120,0 26170,1 26245,0 26265,1 26280,0 26321,1 26342,0 26421,1 26443,0 26503,1 26525,0 26530,1 26591,0 26611,1 26652,0 26750,1 26779,0 26848,1 26889,0 26900,1 26999,0 27053,1 27145,0 27200,1 27223,0 27305,1 27387,0 27410,1 27459,0 27511,1 27610,0 27704,1 27715,0 27724,1 27807,0 27901,1 27993,0 28027,1 28087,0 28176,1 28213,0 28248,1 28270,0 28326,1 28411,0 28447,1 28523,0 28583,1 28644,0 28704,1 28749,0 28819,1 28857,0 28939,1 29028,0 29078,1 29134,0 29163,1 29195,0 29264,1 29330,0 29428,1 29439,0 29442,1 29523,0 29576,1 29676,0 29694,1 29761,0 29776,1 29838,0 29886,1 29951,0 30035,1 30070,0 30144,1 30202,0 30236,1 30250,0 30258,1 30283,0 30312,1 30332,0 30364,1 30368,0 30453,1 30519,0 30540,1 30577,0 30652,1 30677,0 30700,1 30800,0 30884,1 30957,0 31021,1 31105,0 31172,1 31176,0 31260,1 31319,0 31387,1 31476,0 31543,1 31638,0 31698,1 31720,0 31819,1 31909,0 31948,1 32008,0 32080,1 32084,0 32124,1 32215,0 32249,1 32310,0 32377,1 32386,0 32464,1 32510,0 32529,1 32609,0 32682,1 32739,0 32829,1 32866,0 32911,1 32966,0 32978,1 32995,0 33010,1 33091,0 33107,1 33203,0 33238,1 33331,0 33412,1 33442,0 33474,1 33533,0 33611,1 33687,0 33706,1 33799,0 33891,1 33972,0 34020,1 34082,0 34099,1 34147,0 34193,1 34199,0 34229,1 34259,0 34340,1 34392,0 34402,1 34461,0 34483,1 34548,0 34566,1 34604,0 34681,1 34734,0 34753,1 34784,0 34835,1 34932,0 34937,1 34989,0 35073,1 35098,0 35147,1 35151,0 35248,1 35313,0 35351,1 35389,0 35417,1 35435,0 35454,1 35456,0 35485,1 35507,0 35550,1 35587,0 35589,1 35682,0 35777,1 35812,0 35876,1 35910,0 36008,1 36077,0 36104,1 36156,0 36220,1 36251,0 36322,1 36343,0 36363,1 36460,0 36487,1 36583,0 36596,1 36611,0 36662,1 36715,0 36785,1 36863,0 36895,1 36939,0 37002,1 37052,0 37066,1 37116,0 37211,1 37246,0 37282,1 37328,0 37395,1 37469,0 37520,1 37610,0 37674,1 37759,0 37824,1 37879,0 37936,1 38024,0 38060,1 38153,0 38227,1 38252,0 38257,1 38265,0 38346,1 38377,0 38458,1 38546,0 38567,1 38569,0 38624,1 38636,0 38730,1 38818,0 38894,1 38924,0 38946,1 39011,0 39069,1 39100,0 39131,1 39205,0 39242,1 39246,0 39321,1 39342,0 39360,1 39382,0 39481,1 39486,0 39502,1 39507,0 39523,1 39617,0 39662,1 39707,0 39734,1 39792,0 39878,1 39925,0 39953,1 40002,0 40038,1 40112,0 40177,1 40194,0 40229,1 40275,0 40373,1 40421,0 40494,1 40587,0 40644,1 40677,0 40708,1 40771,0 40853,1 40943,0 40966,1 41036,0 41108,1 41133,0 41172,1 41267,0 41352,1 41426,0 41452,1 41524,0 41611,1 41707,0 41751,1 41817,0 41830,1 41839,0 41914,1 41917,0 41948,1 41955,0 41963,1 42026,0 42066,1 42114,0 42173,1 42273,0 42327,1 42387,0 42432,1 42460,0 42462,1 42479,0 42529,1 42617,0 42622,1 42676,0 42709,1 42745,0 42746,1 42809,0 42859,1 42879,0 42964,1 43022,0 43103,1 43157,0 43181,1 43258,0 43283,1 43378,0 43421,1 43425,0 43436,1 43509,0 43554,1 43620,0 43655,1 43681,0 43702,1 43732,0 43771,1 43796,0 43888,1 43902,0 43921,1 43969,0 44023,1 44074,0 44121,1 44195,0 44203,1 44282,0 44357,1 44425,0 44479,1 44551,0 44622,1 44697,0 44791,1 44863,0 44958,1 45050,0 45130,1 45135,0 45195,1 45222,0 45226,1 45255,0 45268,1 45324,0 45413,1 45444,0 45487,1 45514,0 45573,1 45634,0 45691,1 45735,0 45792,1 45806,0 45903,1 45954,0 45972,1 46031,0 46074,1 46163,0 46244,1 46331,0 46355,1 46387,0 46451,1 46535,0 46561,1 46628,0 46710,1 46789,0 46808,1 46890,0 46933,1 46947,0 47022,1 47093,0 47126,1 47177,0 47254,1 47312,0 47363,1 47396,0 47447,1 47488,0 47495,1 47528,0 47610,1 47701,0 47713,1 47729,0 47803,1 47893,0 47929,1 47991,0 48007,1 48029,0 48047,1 48144,0 48227,1 48254,0 48287,1 48342,0 48395,1 48415,0 48451,1 48512,0 48544,1 48611,0 48699,1 48773,0 48817,1 48912,0 48915,1 48943,0 48983,1 49026,0 49121,1 49162,0 49188,1 49259,0 49295,1 49315,0 49370,1 49383,0 49420,1 49484,0 49579,1 49666,0 49752,1 49792,0 49803,1 49886,0 49915,1 49969,0 49991,1 50084,0 50137,1 50157,0 50174,1 50218,0 50238,1 50338,0 50362,1 50363,0 50423,1 end initlist a1 0,0 53,1 55,0 128,1 209,0 238,1 333,0 379,1 433,0 464,1 555,0 589,1 687,0 728,1 763,0 797,1 856,0 864,1 877,0 910,1 911,0 1008,1 1085,0 1123,1 1202,0 1293,1 1348,0 1374,1 1386,0 1461,1 1499,0 1534,1 1578,0 1676,1 1763,0 1843,1 1866,0 1927,1 1961,0 2029,1 2127,0 2177,1 2234,0 2250,1 2259,0 2268,1 2335,0 2398,1 2469,0 2479,1 2574,0 2587,1 2615,0 2655,1 2663,0 2677,1 2739,0 2740,1 2799,0 2868,1 2873,0 2931,1 2946,0 2954,1 2966,0 3032,1 3063,0 3105,1 3143,0 3193,1 3275,0 3330,1 3408,0 3445,1 3454,0 3524,1 3622,0 3637,1 3686,0 3740,1 3830,0 3928,1 3955,0 4022,1 4120,0 4123,1 4207,0 4220,1 4260,0 4323,1 4336,0 4417,1 4458,0 4541,1 4569,0 4585,1 4634,0 4645,1 4672,0 4684,1 4713,0 4753,1 4762,0 4816,1 4902,0 4932,1 5029,0 5096,1 5126,0 5139,1 5165,0 5228,1 5306,0 5319,1 5390,0 5464,1 5533,0 5553,1 5602,0 5690,1 5776,0 5860,1 5944,0 5977,1 6057,0 6124,1 6162,0 6175,1 6229,0 6241,1 6318,0 6364,1 6397,0 6440,1 6468,0 6521,1 6575,0 6617,1 6650,0 6701,1 6787,0 6799,1 6820,0 6898,1 6967,0 6978,1 7007,0 7011,1 7075,0 7148,1 7160,0 7225,1 7272,0 7320,1 7327,0 7422,1 7426,0 7435,1 7532,0 7596,1 7662,0 7720,1 7816,0 7905,1 7944,0 8029,1 8055,0 8147,1 8163,0 8220,1 8286,0 8293,1 8368,0 8413,1 8430,0 8516,1 8615,0 8631,1 8689,0 8713,1 8786,0 8847,1 8936,0 8998,1 9089,0 9139,1 9149,0 9199,1 9299,0 9336,1 9403,0 9438,1 9515,0 9594,1 9693,0 9724,1 9751,0 9755,1 9831,0 9849,1 9873,0 9971,1 9982,0 10018,1 10050,0 10148,1 10217,0 10219,1 10287,0 10328,1 10428,0 10467,1 10567,0 10613,1 10652,0 10743,1 10785,0 10789,1 10801,0 10835,1 10870,0 10913,1 11009,0 11078,1 11161,0 11242,1 11281,0 11302,1 11385,0 11449,1 11517,0 11556,1 11613,0 11617,1 11701,0 11781,1 11826,0 11899,1 11912,0 12012,1 12060,0 12105,1 12188,0 12267,1 12361,0 12398,1 12454,0 12535,1 12578,0 12580,1 12637,0 12699,1 12701,0 12774,1 12784,0 12880,1 12912,0 12936,1 12968,0 13033,1 13055,0 13067,1 13082,0 13108,1 13200,0 13272,1 13360,0 13409,1 13481,0 13488,1 13586,0 13597,1 13615,0 13672,1 13710,0 13731,1 13774,0 13820,1 13872,0 13941,1 14029,0 14081,1 14098,0 14171,1 14232,0 14330,1 14391,0 14416,1 14417,0 14430,1 14458,0 14522,1 14620,0 14675,1 14761,0 14770,1 14842,0 14850,1 14863,0 14868,1 14951,0 14969,1 14983,0 15012,1 15076,0 15106,1 15190,0 15249,1 15296,0 15382,1 15477,0 15491,1 15579,0 15635,1 15675,0 15737,1 15789,0 15829,1 15918,0 15992,1 16064,0 16085,1 16159,0 16203,1 16224,0 16310,1 16314,0 16339,1 16364,0 16412,1 16491,0 16541,1 16633,0 16648,1 16703,0 16779,1 16859,0 16923,1 16952,0 16958,1 17009,0 17052,1 17097,0 17187,1 17196,0 17277,1 17347,0 17379,1 17383,0 17466,1 17514,0 17601,1 17641,0 17675,1 17689,0 17719,1 17770,0 17788,1 17867,0 17927,1 18017,0 18099,1 18195,0 18258,1 18274,0 18304,1 18368,0 18443,1 18495,0 18560,1 18599,0 18652,1 18715,0 18802,1 18836,0 18928,1 18971,0 19032,1 19125,0 19161,1 19173,0 19212,1 19251,0 19326,1 19340,0 19368,1 19462,0 19471,1 19484,0 19560,1 19568,0 19606,1 19692,0 19744,1 19814,0 19858,1 19881,0 19900,1 19918,0 20006,1 20047,0 20117,1 20146,0 20190,1 20214,0 20267,1 20317,0 20337,1 20387,0 20473,1 20545,0 20580,1 20595,0 20690,1 20693,0 20752,1 20814,0 20871,1 20967,0 20998,1 21081,0 21176,1 21276,0 21287,1 21382,0 21433,1 21452,0 21466,1 21478,0 21562,1 21662,0 21719,1 21757,0 21759,1 21776,0 21797,1 21868,0 21935,1 22003,0 22087,1 22116,0 22156,1 22163,0 22205,1 22243,0 22260,1 22295,0 22324,1 22356,0 22443,1 22514,0 22519,1 22608,0 22679,1 22752,0 22842,1 22928,0 23026,1 23070,0 23079,1 23150,0 23207,1 23209,0 23220,1 23255,0 23352,1 23443,0 23523,1 23568,0 23613,1 23691,0 23771,1 23839,0 23852,1 23927,0 24021,1 24056,0 24094,1 24141,0 24147,1 24177,0 24209,1 24227,0 24262,1 24351,0 24380,1 24462,0 24542,1 24591,0 24604,1 24605,0 24645,1 24721,0 24734,1 24755,0 24834,1 24887,0 24949,1 25008,0 25010,1 25109,0 25136,1 25204,0 25294,1 25311,0 25372,1 25375,0 25376,1 25475,0 25573,1 25622,0 25641,1 25712,0 25754,1 25802,0 25849,1 25918,0 25951,1 25963,0 26021,1 26094,0 26159,1 26191,0 26237,1 26303,0 26347,1 26436,0 26499,1 26591,0 26594,1 26692,0 26779,1 26824,0 26915,1 27012,0 27065,1 27105,0 27152,1 27169,0 27190,1 27263,0 27333,1 27426,0 27514,1 27596,0 27681,1 27776,0 27833,1 27841,0 27857,1 27956,0 28004,1 28038,0 28066,1 28069,0 28075,1 28134,0 28189,1 28275,0 28298,1 28341,0 28420,1 28503,0 28570,1 28575,0 28673,1 28697,0 28758,1 28857,0 28884,1 28910,0 28931,1 28953,0 28994,1 29016,0 29040,1 29128,0 29217,1 29238,0 29265,1 29334,0 29391,1 29417,0 29465,1 29494,0 29591,1 29679,0 29736,1 29776,0 29808,1 29900,0 29919,1 29929,0 29966,1 29996,0 30020,1 30118,0 30143,1 30174,0 30196,1 30199,0 30216,1 30296,0 30354,1 30369,0 30442,1 30528,0 30552,1 30588,0 30662,1 30719,0 30790,1 30845,0 30918,1 30958,0 31006,1 31023,0 31051,1 31120,0 31176,1 31274,0 31301,1 31331,0 31397,1 31401,0 31463,1 31471,0 31554,1 31585,0 31603,1 31702,0 31750,1 31847,0 31946,1 32009,0 32053,1 32114,0 32135,1 32201,0 32297,1 32313,0 32357,1 32404,0 32441,1 32528,0 32587,1 32633,0 32732,1 32739,0 32764,1 32851,0 32905,1 32932,0 32938,1 32972,0 33016,1 33062,0 33077,1 33139,0 33153,1 33187,0 33227,1 33308,0 33328,1 33343,0 33365,1 33431,0 33471,1 33529,0 33571,1 33635,0 33707,1 33721,0 33793,1 33816,0 33863,1 33922,0 33963,1 33983,0 34062,1 34113,0 34169,1 34260,0 34282,1 34362,0 34392,1 34407,0 34430,1 34469,0 34555,1 34567,0 34574,1 34658,0 34696,1 34717,0 34783,1 34860,0 34891,1 34979,0 35000,1 35094,0 35133,1 35229,0 35285,1 35342,0 35382,1 35464,0 35480,1 35487,0 35570,1 35571,0 35578,1 35663,0 35681,1 35736,0 35816,1 35905,0 35996,1 36053,0 36097,1 36143,0 36168,1 36237,0 36292,1 36378,0 36380,1 36458,0 36478,1 36521,0 36612,1 36626,0 36705,1 36770,0 36783,1 36837,0 36886,1 36985,0 37062,1 37160,0 37175,1 37223,0 37226,1 37231,0 37279,1 37362,0 37387,1 37477,0 37550,1 37581,0 37655,1 37755,0 37767,1 37811,0 37817,1 37827,0 37836,1 37874,0 37923,1 38015,0 38111,1 38120,0 38165,1 38196,0 38198,1 38239,0 38288,1 38363,0 38384,1 38478,0 38526,1 38560,0 38590,1 38633,0 38673,1 38685,0 38762,1 38808,0 38862,1 38878,0 38945,1 39014,0 39105,1 39163,0 39211,1 39294,0 39345,1 39424,0 39471,1 39523,0 39616,1 39670,0 39710,1 39784,0 39846,1 39866,0 39940,1 39990,0 39991,1 40069,0 40128,1 40139,0 40185,1 40278,0 40330,1 40365,0 40400,1 40473,0 40502,1 40510,0 40515,1 40552,0 40627,1 40657,0 40683,1 40715,0 40764,1 40780,0 40878,1 40932,0 40941,1 41004,0 41044,1 41068,0 41069,1 41102,0 41125,1 41199,0 41264,1 41275,0 41295,1 41394,0 41444,1 41480,0 41507,1 41564,0 41633,1 41727,0 41791,1 41796,0 41798,1 41884,0 41909,1 41980,0 41992,1 42058,0 42114,1 42158,0 42169,1 42205,0 42233,1 42261,0 42311,1 42400,0 42475,1 42518,0 42594,1 42646,0 42735,1 42739,0 42780,1 42863,0 42936,1 42937,0 42994,1 43006,0 43060,1 43138,0 43231,1 43281,0 43359,1 43447,0 43503,1 43534,0 43574,1 43660,0 43742,1 43789,0 43877,1 43950,0 44012,1 44099,0 44125,1 44190,0 44243,1 44326,0 44397,1 44399,0 44473,1 44537,0 44558,1 44625,0 44683,1 44752,0 44767,1 44858,0 44875,1 44951,0 45038,1 45091,0 45166,1 45197,0 45198,1 45257,0 45318,1 45360,0 45418,1 45510,0 45593,1 45630,0 45697,1 45714,0 45763,1 45844,0 45862,1 45923,0 45989,1 46021,0 46106,1 46108,0 46166,1 46210,0 46279,1 46362,0 46441,1 46466,0 46508,1 46599,0 46635,1 46663,0 46738,1 46787,0 46857,1 46942,0 46976,1 46985,0 47023,1 47085,0 47162,1 47199,0 47254,1 47260,0 47360,1 47403,0 47442,1 47526,0 47553,1 47641,0 47741,1 47793,0 47876,1 47945,0 47950,1 47964,0 47981,1 48054,0 48130,1 48165,0 48265,1 48298,0 48309,1 48399,0 48493,1 48504,0 48591,1 48601,0 48617,1 48688,0 48738,1 48789,0 48851,1 48907,0 48949,1 48970,0 49021,1 49102,0 49187,1 49202,0 49215,1 49256,0 49301,1 49331,0 49379,1 49442,0 49480,1 49501,0 49502,1 49586,0 49637,1 49722,0 49805,1 49811,0 49850,1 49859,0 49952,1 49979,0 50055,1 50121,0 50211,1 50231,0 50324,1 50360,0 50392,1 end initlist a2 0,0 28,1 126,0 201,1 261,0 352,1 441,0 452,1 482,0 547,1 595,0 655,1 676,0 715,1 798,0 842,1 918,0 958,1 1009,0 1011,1 1086,0 1105,1 1165,0 1211,1 1296,0 1362,1 1382,0 1385,1 1415,0 1465,1 1493,0 1524,1 1532,0 1620,1 1623,0 1717,1 1736,0 1814,1 1851,0 1854,1 1917,0 2008,1 2023,0 2044,1 2064,0 2069,1 2163,0 2239,1 2304,0 2379,1 2471,0 2571,1 2657,0 2674,1 2764,0 2767,1 2804,0 2885,1 2935,0 2990,1 3058,0 3140,1 3157,0 3209,1 3288,0 3331,1 3360,0 3442,1 3523,0 3612,1 3648,0 3710,1 3803,0 3848,1 3920,0 3981,1 4075,0 4106,1 4113,0 4150,1 4195,0 4288,1 4369,0 4449,1 4483,0 4510,1 4588,0 4633,1 4649,0 4733,1 4799,0 4863,1 4946,0 4979,1 5079,0 5162,1 5186,0 5229,1 5238,0 5281,1 5309,0 5352,1 5369,0 5420,1 5448,0 5514,1 5556,0 5572,1 5628,0 5681,1 5742,0 5800,1 5828,0 5845,1 5893,0 5939,1 5956,0 5995,1 6055,0 6112,1 6146,0 6223,1 6314,0 6381,1 6475,0 6494,1 6567,0 6615,1 6671,0 6726,1 6792,0 6839,1 6903,0 6959,1 7000,0 7051,1 7122,0 7129,1 7223,0 7253,1 7303,0 7335,1 7376,0 7474,1 7543,0 7596,1 7668,0 7736,1 7776,0 7802,1 7840,0 7931,1 7968,0 8038,1 8055,0 8064,1 8076,0 8103,1 8116,0 8144,1 8163,0 8262,1 8297,0 8364,1 8436,0 8527,1 8594,0 8690,1 8744,0 8781,1 8786,0 8807,1 8905,0 8910,1 9006,0 9041,1 9115,0 9166,1 9195,0 9262,1 9280,0 9380,1 9431,0 9483,1 9484,0 9528,1 9623,0 9647,1 9743,0 9759,1 9760,0 9849,1 9856,0 9938,1 9985,0 10040,1 10138,0 10141,1 10177,0 10250,1 10254,0 10273,1 10354,0 10394,1 10475,0 10561,1 10638,0 10718,1 10754,0 10837,1 10852,0 10898,1 10939,0 11039,1 11114,0 11190,1 11270,0 11276,1 11289,0 11322,1 11390,0 11472,1 11560,0 11616,1 11653,0 11743,1 11757,0 11761,1 11855,0 11875,1 11880,0 11916,1 11994,0 12003,1 12012,0 12090,1 12186,0 12261,1 12314,0 12393,1 12456,0 12460,1 12462,0 12499,1 12521,0 12550,1 12559,0 12605,1 12652,0 12733,1 12750,0 12775,1 12807,0 12864,1 12927,0 13015,1 13057,0 13141,1 13208,0 13244,1 13333,0 13335,1 13434,0 13522,1 13554,0 13567,1 13625,0 13692,1 13745,0 13845,1 13881,0 13912,1 13956,0 14009,1 14085,0 14086,1 14182,0 14185,1 14187,0 14284,1 14374,0 14383,1 14405,0 14446,1 14496,0 14572,1 14639,0 14652,1 14677,0 14729,1 14824,0 14905,1 14929,0 14978,1 14992,0 15064,1 15119,0 15186,1 15198,0 15227,1 15273,0 15345,1 15440,0 15525,1 15529,0 15546,1 15638,0 15677,1 15681,0 15751,1 15806,0 15866,1 15875,0 15946,1 16008,0 16053,1 16083,0 16155,1 16156,0 16206,1 16229,0 16297,1 16342,0 16426,1 16434,0 16517,1 16559,0 16589,1 16625,0 16712,1 16768,0 16786,1 16845,0 16928,1 17010,0 17081,1 17174,0 17215,1 17238,0 17302,1 17337,0 17369,1 17435,0 17532,1 17594,0 17610,1 17646,0 17653,1 17715,0 17754,1 17845,0 17848,1 17885,0 17985,1 18002,0 18097,1 18140,0 18216,1 18257,0 18335,1 18342,0 18375,1 18460,0 18471,1 18528,0 18627,1 18657,0 18756,1 18824,0 18830,1 18853,0 18926,1 18971,0 18997,1 19049,0 19126,1 19137,0 19168,1 19261,0 19320,1 19388,0 19412,1 19444,0 19482,1 19558,0 19589,1 19606,0 19701,1 19769,0 19825,1 19854,0 19895,1 19897,0 19937,1 20015,0 20105,1 20203,0 20212,1 20288,0 20379,1 20386,0 20432,1 20507,0 20593,1 20632,0 20663,1 20679,0 20712,1 20730,0 20825,1 20826,0 20894,1 20895,0 20987,1 20990,0 21013,1 21071,0 21098,1 21111,0 21118,1 21189,0 21247,1 21274,0 21277,1 21282,0 21349,1 21437,0 21511,1 21554,0 21625,1 21684,0 21771,1 21788,0 21829,1 21900,0 21989,1 22019,0 22037,1 22125,0 22195,1 22241,0 22327,1 22398,0 22486,1 22550,0 22561,1 22619,0 22687,1 22717,0 22737,1 22784,0 22814,1 22838,0 22891,1 22910,0 22939,1 22949,0 22968,1 23064,0 23109,1 23189,0 23191,1 23228,0 23306,1 23379,0 23416,1 23481,0 23513,1 23564,0 23586,1 23593,0 23651,1 23654,0 23731,1 23791,0 23815,1 23882,0 23898,1 23974,0 23988,1 24037,0 24069,1 24110,0 24183,1 24263,0 24285,1 24351,0 24440,1 24509,0 24585,1 24667,0 24686,1 24727,0 24799,1 24871,0 24891,1 24945,0 24999,1 25055,0 25100,1 25163,0 25238,1 25326,0 25383,1 25473,0 25539,1 25558,0 25632,1 25640,0 25735,1 25741,0 25769,1 25844,0 25866,1 25938,0 25941,1 26040,0 26045,1 26078,0 26134,1 26186,0 26187,1 26253,0 26267,1 26319,0 26365,1 26410,0 26475,1 26484,0 26502,1 26550,0 26649,1 26651,0 26699,1 26717,0 26763,1 26765,0 26783,1 26816,0 26899,1 26997,0 27043,1 27101,0 27146,1 27173,0 27242,1 27276,0 27371,1 27405,0 27503,1 27582,0 27597,1 27694,0 27751,1 27809,0 27875,1 27926,0 27949,1 27992,0 28077,1 28090,0 28162,1 28207,0 28296,1 28315,0 28369,1 28416,0 28492,1 28519,0 28546,1 28551,0 28629,1 28631,0 28692,1 28786,0 28806,1 28859,0 28935,1 29001,0 29098,1 29137,0 29167,1 29214,0 29254,1 29324,0 29421,1 29498,0 29529,1 29585,0 29610,1 29668,0 29672,1 29734,0 29758,1 29774,0 29837,1 29911,0 29971,1 29974,0 30000,1 30091,0 30177,1 30195,0 30209,1 30238,0 30324,1 30382,0 30402,1 30463,0 30483,1 30561,0 30657,1 30708,0 30785,1 30809,0 30885,1 30899,0 30965,1 31056,0 31104,1 31105,0 31189,1 31262,0 31287,1 31343,0 31413,1 31505,0 31572,1 31580,0 31652,1 31749,0 31838,1 31853,0 31950,1 32009,0 32010,1 32046,0 32141,1 32159,0 32188,1 32255,0 32266,1 32297,0 32298,1 32380,0 32442,1 32448,0 32545,1 32563,0 32641,1 32655,0 32737,1 32744,0 32824,1 32881,0 32949,1 32968,0 33012,1 33057,0 33103,1 33182,0 33194,1 33258,0 33309,1 33315,0 33382,1 33395,0 33434,1 33514,0 33566,1 33605,0 33608,1 33706,0 33709,1 33729,0 33750,1 33841,0 33935,1 33957,0 34029,1 34084,0 34088,1 34114,0 34141,1 34182,0 34258,1 34301,0 34399,1 34407,0 34463,1 34554,0 34608,1 34679,0 34756,1 34843,0 34853,1 34919,0 34972,1 34983,0 35019,1 35105,0 35191,1 35258,0 35277,1 35294,0 35305,1 35318,0 35391,1 35455,0 35545,1 35616,0 35712,1 35771,0 35802,1 35857,0 35946,1 36041,0 36141,1 36159,0 36232,1 36289,0 36345,1 36416,0 36433,1 36499,0 36590,1 36643,0 36727,1 36765,0 36864,1 36929,0 36968,1 37031,0 37074,1 37125,0 37209,1 37217,0 37304,1 37394,0 37460,1 37531,0 37567,1 37582,0 37617,1 37679,0 37716,1 37796,0 37830,1 37889,0 37919,1 38015,0 38082,1 38094,0 38171,1 38237,0 38250,1 38349,0 38383,1 38481,0 38539,1 38597,0 38611,1 38658,0 38696,1 38731,0 38794,1 38859,0 38905,1 38972,0 39070,1 39110,0 39141,1 39182,0 39215,1 39299,0 39339,1 39412,0 39448,1 39539,0 39550,1 39565,0 39593,1 39598,0 39628,1 39632,0 39640,1 39723,0 39728,1 39785,0 39854,1 39942,0 39961,1 40018,0 40057,1 40108,0 40200,1 40221,0 40250,1 40329,0 40380,1 40446,0 40499,1 40557,0 40582,1 40584,0 40661,1 40703,0 40774,1 40789,0 40826,1 40903,0 40942,1 40964,0 41029,1 41079,0 41090,1 41099,0 41149,1 41227,0 41306,1 41386,0 41427,1 41505,0 41539,1 41603,0 41669,1 41675,0 41698,1 41722,0 41766,1 41793,0 41800,1 41824,0 41874,1 41968,0 42036,1 42080,0 42113,1 42172,0 42255,1 42256,0 42329,1 42397,0 42472,1 42495,0 42500,1 42596,0 42616,1 42656,0 42657,1 42706,0 42754,1 42852,0 42931,1 42942,0 42958,1 43014,0 43054,1 43127,0 43160,1 43243,0 43316,1 43337,0 43436,1 43480,0 43541,1 43552,0 43622,1 43675,0 43710,1 43757,0 43793,1 43874,0 43920,1 43921,0 43961,1 44003,0 44084,1 44109,0 44170,1 44213,0 44233,1 44295,0 44356,1 44422,0 44489,1 44491,0 44518,1 44532,0 44540,1 44626,0 44717,1 44738,0 44758,1 44817,0 44821,1 44878,0 44915,1 45008,0 45093,1 45147,0 45226,1 45228,0 45286,1 45296,0 45340,1 45393,0 45423,1 45433,0 45456,1 45475,0 45567,1 45576,0 45594,1 45651,0 45715,1 45759,0 45777,1 45830,0 45901,1 45925,0 45988,1 46071,0 46111,1 46168,0 46238,1 46328,0 46389,1 46428,0 46485,1 46542,0 46593,1 46631,0 46684,1 46692,0 46722,1 46819,0 46888,1 46969,0 47051,1 47120,0 47205,1 47210,0 47275,1 47368,0 47407,1 47488,0 47570,1 47639,0 47657,1 47714,0 47749,1 47828,0 47853,1 47935,0 48010,1 48031,0 48090,1 48153,0 48194,1 48225,0 48310,1 48326,0 48387,1 48485,0 48534,1 48585,0 48621,1 48699,0 48734,1 48770,0 48797,1 48810,0 48827,1 48860,0 48948,1 49010,0 49070,1 49165,0 49208,1 49278,0 49351,1 49387,0 49389,1 49427,0 49443,1 49481,0 49525,1 49556,0 49573,1 49612,0 49679,1 49703,0 49794,1 49847,0 49867,1 49900,0 49914,1 50004,0 50023,1 50089,0 50176,1 end initlist a3 0,0 93,1 190,0 196,1 238,0 257,1 329,0 358,1 435,0 451,1 480,0 562,1 588,0 647,1 672,0 748,1 832,0 884,1 898,0 966,1 1001,0 1083,1 1124,0 1190,1 1252,0 1289,1 1325,0 1406,1 1491,0 1535,1 1549,0 1567,1 1652,0 1693,1 1715,0 1752,1 1827,0 1842,1 1936,0 1967,1 1988,0 2026,1 2094,0 2191,1 2267,0 2367,1 2435,0 2526,1 2535,0 2602,1 2667,0 2682,1 2687,0 2702,1 2720,0 2736,1 2814,0 2870,1 2958,0 2968,1 3034,0 3062,1 3144,0 3233,1 3236,0 3331,1 3404,0 3456,1 3504,0 3552,1 3599,0 3688,1 3738,0 3812,1 3855,0 3873,1 3937,0 4018,1 4025,0 4032,1 4091,0 4094,1 4143,0 4145,1 4230,0 4290,1 4378,0 4406,1 4498,0 4590,1 4622,0 4657,1 4741,0 4753,1 4774,0 4781,1 4881,0 4953,1 4959,0 4975,1 5050,0 5135,1 5147,0 5161,1 5240,0 5322,1 5383,0 5433,1 5508,0 5553,1 5559,0 5592,1 5631,0 5712,1 5785,0 5786,1 5822,0 5856,1 5956,0 6039,1 6102,0 6108,1 6202,0 6205,1 6292,0 6321,1 6403,0 6419,1 6424,0 6506,1 6550,0 6616,1 6642,0 6704,1 6711,0 6800,1 6879,0 6899,1 6920,0 7008,1 7094,0 7113,1 7151,0 7165,1 7241,0 7242,1 7292,0 7327,1 7414,0 7449,1 7548,0 7589,1 7682,0 7755,1 7840,0 7934,1 7958,0 8055,1 8109,0 8169,1 8242,0 8328,1 8389,0 8473,1 8517,0 8567,1 8630,0 8631,1 8648,0 8727,1 8779,0 8825,1 8868,0 8877,1 8975,0 9018,1 9022,0 9112,1 9185,0 9227,1 9295,0 9378,1 9385,0 9446,1 9473,0 9498,1 9510,0 9606,1 9671,0 9674,1 9737,0 9761,1 9818,0 9886,1 9895,0 9956,1 10012,0 10086,1 10168,0 10218,1 10287,0 10327,1 10376,0 10464,1 10552,0 10630,1 10680,0 10742,1 10829,0 10842,1 10901,0 10945,1 11015,0 11066,1 11079,0 11099,1 11141,0 11181,1 11193,0 11287,1 11292,0 11383,1 11418,0 11434,1 11478,0 11557,1 11595,0 11681,1 11727,0 11801,1 11812,0 11822,1 11889,0 11906,1 11980,0 12073,1 12075,0 12140,1 12205,0 12231,1 12265,0 12321,1 12336,0 12408,1 12487,0 12535,1 12539,0 12549,1 12561,0 12606,1 12680,0 12715,1 12721,0 12738,1 12809,0 12825,1 12841,0 12931,1 13002,0 13023,1 13039,0 13062,1 13068,0 13125,1 13146,0 13168,1 13230,0 13253,1 13257,0 13339,1 13340,0 13393,1 13457,0 13523,1 13593,0 13691,1 13727,0 13824,1 13837,0 13872,1 13931,0 13994,1 14092,0 14094,1 14118,0 14124,1 14219,0 14272,1 14344,0 14357,1 14418,0 14423,1 14519,0 14594,1 14605,0 14665,1 14744,0 14758,1 14843,0 14871,1 14943,0 14989,1 15062,0 15098,1 15151,0 15220,1 15253,0 15283,1 15346,0 15408,1 15412,0 15495,1 15566,0 15632,1 15657,0 15726,1 15796,0 15872,1 15874,0 15929,1 16001,0 16042,1 16048,0 16088,1 16150,0 16234,1 16258,0 16295,1 16352,0 16422,1 16448,0 16499,1 16512,0 16518,1 16574,0 16626,1 16654,0 16692,1 16713,0 16716,1 16739,0 16810,1 16880,0 16979,1 17001,0 17089,1 17102,0 17166,1 17232,0 17298,1 17385,0 17413,1 17458,0 17511,1 17566,0 17578,1 17670,0 17714,1 17798,0 17861,1 17874,0 17915,1 17925,0 17998,1 18052,0 18142,1 18225,0 18243,1 18304,0 18351,1 18353,0 18385,1 18431,0 18518,1 18593,0 18622,1 18666,0 18696,1 18788,0 18799,1 18824,0 18851,1 18924,0 18934,1 18952,0 18982,1 19038,0 19126,1 19153,0 19154,1 19188,0 19251,1 19334,0 19368,1 19411,0 19463,1 19549,0 19596,1 19682,0 19735,1 19825,0 19892,1 19910,0 19985,1 20067,0 20139,1 20145,0 20222,1 20229,0 20257,1 20305,0 20387,1 20417,0 20440,1 20455,0 20499,1 20505,0 20547,1 20553,0 20604,1 20683,0 20773,1 20790,0 20829,1 20892,0 20960,1 20973,0 20987,1 21014,0 21033,1 21046,0 21129,1 21177,0 21234,1 21257,0 21304,1 21332,0 21341,1 21410,0 21426,1 21482,0 21505,1 21601,0 21628,1 21664,0 21753,1 21768,0 21805,1 21839,0 21893,1 21935,0 21942,1 21981,0 22023,1 22068,0 22158,1 22222,0 22292,1 22380,0 22402,1 22446,0 22546,1 22646,0 22703,1 22728,0 22818,1 22907,0 22948,1 23029,0 23039,1 23133,0 23159,1 23207,0 23285,1 23365,0 23380,1 23452,0 23454,1 23551,0 23586,1 23592,0 23682,1 23715,0 23754,1 23788,0 23800,1 23891,0 23956,1 24053,0 24089,1 24180,0 24191,1 24271,0 24301,1 24324,0 24325,1 24351,0 24423,1 24462,0 24473,1 24528,0 24602,1 24685,0 24764,1 24811,0 24819,1 24885,0 24935,1 25002,0 25010,1 25012,0 25093,1 25103,0 25119,1 25129,0 25153,1 25231,0 25315,1 25382,0 25389,1 25428,0 25457,1 25518,0 25612,1 25665,0 25738,1 25832,0 25916,1 25987,0 25994,1 26042,0 26098,1 26135,0 26182,1 26254,0 26307,1 26332,0 26388,1 26446,0 26450,1 26525,0 26590,1 26637,0 26725,1 26806,0 26900,1 26999,0 27097,1 27176,0 27269,1 27293,0 27329,1 27358,0 27412,1 27507,0 27538,1 27595,0 27623,1 27663,0 27688,1 27776,0 27818,1 27882,0 27945,1 27949,0 27977,1 28011,0 28107,1 28124,0 28200,1 28202,0 28220,1 28240,0 28276,1 28368,0 28370,1 28453,0 28499,1 28594,0 28686,1 28729,0 28751,1 28776,0 28792,1 28837,0 28898,1 28973,0 29055,1 29089,0 29115,1 29147,0 29154,1 29204,0 29270,1 29370,0 29426,1 29496,0 29560,1 29649,0 29656,1 29735,0 29804,1 29826,0 29851,1 29898,0 29902,1 29985,0 30062,1 30123,0 30208,1 30243,0 30248,1 30266,0 30288,1 30340,0 30403,1 30413,0 30436,1 30510,0 30513,1 30555,0 30621,1 30712,0 30748,1 30846,0 30938,1 30986,0 30989,1 30997,0 31001,1 31069,0 31155,1 31162,0 31184,1 31226,0 31263,1 31353,0 31389,1 31487,0 31517,1 31524,0 31589,1 31603,0 31661,1 31715,0 31815,1 31904,0 31945,1 32024,0 32075,1 32133,0 32182,1 32187,0 32214,1 32260,0 32267,1 32284,0 32364,1 32427,0 32456,1 32543,0 32586,1 32659,0 32745,1 32795,0 32797,1 32834,0 32895,1 32936,0 32998,1 33063,0 33092,1 33187,0 33279,1 33378,0 33453,1 33547,0 33583,1 33609,0 33700,1 33753,0 33832,1 33879,0 33880,1 33935,0 33958,1 34029,0 34043,1 34137,0 34190,1 34253,0 34334,1 34429,0 34446,1 34539,0 34575,1 34670,0 34722,1 34791,0 34862,1 34909,0 34922,1 35011,0 35051,1 35088,0 35148,1 35232,0 35286,1 35363,0 35431,1 35477,0 35533,1 35610,0 35691,1 35781,0 35786,1 35834,0 35874,1 35942,0 36004,1 36033,0 36091,1 36104,0 36114,1 36192,0 36282,1 36305,0 36381,1 36419,0 36457,1 36516,0 36525,1 36624,0 36693,1 36743,0 36761,1 36763,0 36803,1 36854,0 36916,1 36997,0 37094,1 37130,0 37169,1 37237,0 37306,1 37400,0 37449,1 37532,0 37535,1 37568,0 37602,1 37630,0 37637,1 37647,0 37747,1 37803,0 37898,1 37929,0 37977,1 38002,0 38009,1 38044,0 38097,1 38148,0 38215,1 38223,0 38279,1 38332,0 38428,1 38490,0 38506,1 38578,0 38647,1 38724,0 38769,1 38790,0 38803,1 38863,0 38889,1 38980,0 39016,1 39091,0 39142,1 39189,0 39262,1 39322,0 39331,1 39389,0 39457,1 39486,0 39497,1 39588,0 39680,1 39703,0 39802,1 39829,0 39844,1 39923,0 39997,1 40052,0 40116,1 40177,0 40268,1 40361,0 40439,1 40500,0 40570,1 40613,0 40659,1 40740,0 40797,1 40824,0 40878,1 40882,0 40970,1 40993,0 41058,1 41116,0 41177,1 41216,0 41244,1 41342,0 41353,1 41408,0 41430,1 41442,0 41465,1 41540,0 41614,1 41634,0 41710,1 41808,0 41852,1 41863,0 41883,1 41947,0 41989,1 42068,0 42142,1 42215,0 42310,1 42356,0 42451,1 42481,0 42513,1 42590,0 42680,1 42733,0 42782,1 42829,0 42883,1 42896,0 42958,1 42972,0 43036,1 43056,0 43141,1 43199,0 43249,1 43336,0 43375,1 43459,0 43488,1 43572,0 43632,1 43668,0 43677,1 43695,0 43789,1 43835,0 43921,1 43948,0 44038,1 44040,0 44117,1 44204,0 44226,1 44249,0 44281,1 44340,0 44404,1 44405,0 44420,1 44484,0 44529,1 44547,0 44554,1 44587,0 44685,1 44755,0 44852,1 44925,0 45016,1 45099,0 45126,1 45167,0 45205,1 45303,0 45356,1 45402,0 45460,1 45554,0 45560,1 45588,0 45589,1 45613,0 45688,1 45755,0 45800,1 45812,0 45902,1 45904,0 45974,1 46044,0 46112,1 46195,0 46265,1 46269,0 46324,1 46361,0 46388,1 46413,0 46455,1 46471,0 46518,1 46541,0 46616,1 46714,0 46761,1 46839,0 46905,1 46989,0 47027,1 47126,0 47167,1 47225,0 47282,1 47329,0 47411,1 47468,0 47490,1 47500,0 47553,1 47636,0 47731,1 47781,0 47835,1 47906,0 47922,1 47965,0 47994,1 48092,0 48101,1 48176,0 48224,1 48282,0 48365,1 48410,0 48454,1 48529,0 48586,1 48588,0 48592,1 48595,0 48674,1 48751,0 48777,1 48876,0 48964,1 48965,0 48967,1 49037,0 49123,1 49200,0 49241,1 49334,0 49355,1 49382,0 49444,1 49515,0 49532,1 49553,0 49641,1 49657,0 49693,1 49772,0 49792,1 49872,0 49927,1 49967,0 50029,1 50076,0 50140,1 50197,0 50214,1 50258,0 50315,1 50332,0 50420,1 50520,0 50571,1 end initlist a4 0,0 5,1 82,0 136,1 172,0 224,1 294,0 339,1 394,0 430,1 445,0 525,1 604,0 623,1 656,0 663,1 694,0 714,1 736,0 748,1 832,0 899,1 967,0 992,1 1022,0 1084,1 1163,0 1219,1 1254,0 1334,1 1430,0 1452,1 1532,0 1604,1 1613,0 1681,1 1747,0 1828,1 1849,0 1913,1 1964,0 2058,1 2119,0 2187,1 2279,0 2281,1 2296,0 2377,1 2460,0 2521,1 2540,0 2576,1 2630,0 2677,1 2682,0 2779,1 2868,0 2890,1 2944,0 3027,1 3073,0 3108,1 3156,0 3174,1 3192,0 3265,1 3294,0 3365,1 3403,0 3427,1 3482,0 3536,1 3551,0 3602,1 3625,0 3714,1 3805,0 3863,1 3876,0 3957,1 4047,0 4120,1 4201,0 4219,1 4287,0 4351,1 4426,0 4523,1 4593,0 4636,1 4678,0 4721,1 4761,0 4826,1 4868,0 4956,1 5033,0 5035,1 5097,0 5161,1 5194,0 5215,1 5245,0 5263,1 5320,0 5339,1 5391,0 5398,1 5412,0 5452,1 5472,0 5493,1 5540,0 5549,1 5564,0 5596,1 5604,0 5638,1 5667,0 5699,1 5782,0 5809,1 5866,0 5928,1 5995,0 5998,1 6096,0 6166,1 6239,0 6248,1 6273,0 6328,1 6369,0 6393,1 6467,0 6533,1 6560,0 6568,1 6612,0 6705,1 6712,0 6765,1 6863,0 6948,1 6994,0 7046,1 7104,0 7123,1 7186,0 7271,1 7301,0 7338,1 7364,0 7390,1 7476,0 7486,1 7505,0 7547,1 7598,0 7599,1 7692,0 7727,1 7764,0 7838,1 7871,0 7959,1 8006,0 8074,1 8174,0 8223,1 8278,0 8330,1 8352,0 8407,1 8442,0 8469,1 8488,0 8588,1 8686,0 8715,1 8778,0 8783,1 8817,0 8903,1 8959,0 9044,1 9121,0 9195,1 9294,0 9374,1 9469,0 9493,1 9534,0 9536,1 9590,0 9596,1 9667,0 9706,1 9771,0 9866,1 9912,0 9935,1 10012,0 10033,1 10109,0 10209,1 10287,0 10314,1 10408,0 10439,1 10492,0 10495,1 10567,0 10570,1 10633,0 10661,1 10731,0 10759,1 10776,0 10818,1 10885,0 10915,1 10922,0 10980,1 10990,0 11014,1 11028,0 11116,1 11214,0 11304,1 11319,0 11329,1 11371,0 11445,1 11466,0 11559,1 11646,0 11733,1 11803,0 11857,1 11862,0 11871,1 11950,0 11992,1 12087,0 12122,1 12205,0 12297,1 12361,0 12410,1 12442,0 12473,1 12573,0 12640,1 12654,0 12663,1 12697,0 12758,1 12772,0 12779,1 12846,0 12885,1 12913,0 12957,1 13036,0 13067,1 13123,0 13132,1 13206,0 13267,1 13321,0 13404,1 13496,0 13558,1 13599,0 13608,1 13645,0 13685,1 13758,0 13761,1 13858,0 13897,1 13974,0 13983,1 14016,0 14062,1 14107,0 14163,1 14230,0 14322,1 14414,0 14482,1 14536,0 14547,1 14596,0 14617,1 14624,0 14630,1 14686,0 14768,1 14818,0 14832,1 14916,0 14928,1 15004,0 15007,1 15016,0 15033,1 15112,0 15163,1 15178,0 15246,1 15274,0 15289,1 15337,0 15414,1 15427,0 15476,1 15497,0 15571,1 15616,0 15657,1 15700,0 15773,1 15777,0 15867,1 15919,0 15988,1 16054,0 16070,1 16166,0 16254,1 16308,0 16349,1 16359,0 16406,1 16421,0 16449,1 16463,0 16523,1 16533,0 16543,1 16596,0 16681,1 16744,0 16837,1 16921,0 16960,1 16991,0 17004,1 17037,0 17062,1 17131,0 17143,1 17180,0 17236,1 17296,0 17380,1 17450,0 17529,1 17598,0 17668,1 17735,0 17822,1 17914,0 18010,1 18074,0 18149,1 18179,0 18229,1 18263,0 18284,1 18357,0 18407,1 18497,0 18509,1 18584,0 18639,1 18640,0 18666,1 18742,0 18816,1 18877,0 18969,1 19041,0 19125,1 19203,0 19235,1 19272,0 19364,1 19421,0 19479,1 19549,0 19626,1 19667,0 19675,1 19693,0 19789,1 19804,0 19812,1 19841,0 19859,1 19901,0 19924,1 19987,0 20083,1 20128,0 20185,1 20219,0 20280,1 20377,0 20395,1 20459,0 20462,1 20537,0 20621,1 20638,0 20652,1 20706,0 20719,1 20785,0 20880,1 20945,0 20960,1 21028,0 21060,1 21098,0 21168,1 21185,0 21225,1 21264,0 21284,1 21367,0 21429,1 21501,0 21567,1 21611,0 21635,1 21686,0 21722,1 21731,0 21796,1 21799,0 21815,1 21891,0 21943,1 22023,0 22097,1 22160,0 22253,1 22290,0 22314,1 22398,0 22447,1 22512,0 22562,1 22574,0 22584,1 22644,0 22716,1 22743,0 22806,1 22850,0 22899,1 22903,0 22934,1 22996,0 23089,1 23106,0 23147,1 23162,0 23212,1 23288,0 23350,1 23357,0 23370,1 23460,0 23555,1 23598,0 23619,1 23692,0 23712,1 23786,0 23875,1 23877,0 23887,1 23955,0 24035,1 24076,0 24122,1 24145,0 24243,1 24312,0 24314,1 24332,0 24426,1 24510,0 24566,1 24575,0 24630,1 24635,0 24658,1 24672,0 24693,1 24698,0 24747,1 24754,0 24761,1 24775,0 24855,1 24920,0 24934,1 25023,0 25046,1 25070,0 25097,1 25111,0 25166,1 25266,0 25326,1 25342,0 25363,1 25414,0 25427,1 25445,0 25459,1 25490,0 25565,1 25595,0 25596,1 25690,0 25789,1 25884,0 25957,1 26015,0 26074,1 26127,0 26139,1 26195,0 26219,1 26224,0 26290,1 26323,0 26326,1 26369,0 26468,1 26552,0 26559,1 26645,0 26678,1 26750,0 26795,1 26887,0 26915,1 26988,0 27053,1 27123,0 27217,1 27271,0 27367,1 27424,0 27468,1 27497,0 27549,1 27635,0 27675,1 27758,0 27846,1 27873,0 27897,1 27926,0 28007,1 28009,0 28098,1 28114,0 28172,1 28214,0 28217,1 28282,0 28296,1 28376,0 28390,1 28397,0 28443,1 28528,0 28586,1 28664,0 28743,1 28807,0 28849,1 28890,0 28950,1 29031,0 29076,1 29150,0 29187,1 29192,0 29244,1 29265,0 29353,1 29416,0 29499,1 29575,0 29629,1 29672,0 29769,1 29813,0 29819,1 29904,0 29956,1 30017,0 30098,1 30162,0 30238,1 30297,0 30322,1 30396,0 30448,1 30528,0 30583,1 30671,0 30709,1 30733,0 30828,1 30896,0 30941,1 31006,0 31083,1 31106,0 31124,1 31214,0 31224,1 31295,0 31341,1 31350,0 31436,1 31521,0 31543,1 31576,0 31577,1 31632,0 31714,1 31774,0 31800,1 31858,0 31934,1 32029,0 32118,1 32119,0 32196,1 32228,0 32284,1 32331,0 32394,1 32462,0 32487,1 32573,0 32618,1 32640,0 32672,1 32713,0 32752,1 32815,0 32824,1 32918,0 32923,1 32983,0 32992,1 33009,0 33026,1 33113,0 33185,1 33228,0 33245,1 33295,0 33350,1 33415,0 33483,1 33545,0 33567,1 33571,0 33644,1 33698,0 33713,1 33731,0 33759,1 33805,0 33868,1 33879,0 33905,1 33975,0 34002,1 34078,0 34163,1 34225,0 34262,1 34299,0 34365,1 34452,0 34547,1 34630,0 34663,1 34706,0 34708,1 34756,0 34852,1 34922,0 34996,1 35027,0 35031,1 35047,0 35056,1 35106,0 35128,1 35143,0 35151,1 35210,0 35258,1 35323,0 35361,1 35396,0 35440,1 35469,0 35485,1 35500,0 35593,1 35618,0 35680,1 35685,0 35756,1 35802,0 35826,1 35902,0 35963,1 35973,0 36062,1 36071,0 36076,1 36129,0 36194,1 36290,0 36369,1 36415,0 36418,1 36518,0 36598,1 36616,0 36682,1 36688,0 36712,1 36730,0 36774,1 36802,0 36867,1 36892,0 36917,1 36990,0 37004,1 37010,0 37060,1 37078,0 37089,1 37096,0 37187,1 37251,0 37262,1 37295,0 37327,1 37333,0 37400,1 37420,0 37488,1 37566,0 37630,1 37682,0 37773,1 37845,0 37886,1 37936,0 37981,1 38011,0 38088,1 38175,0 38212,1 38219,0 38296,1 38365,0 38407,1 38420,0 38515,1 38552,0 38616,1 38646,0 38737,1 38778,0 38789,1 38870,0 38929,1 38987,0 38989,1 38995,0 39046,1 39100,0 39132,1 39174,0 39249,1 39267,0 39358,1 39401,0 39464,1 39494,0 39525,1 39604,0 39679,1 39750,0 39787,1 39837,0 39878,1 39937,0 40022,1 40098,0 40103,1 40132,0 40168,1 40192,0 40278,1 40325,0 40405,1 40445,0 40474,1 40499,0 40539,1 40608,0 40628,1 40663,0 40731,1 40734,0 40775,1 40818,0 40871,1 40910,0 40928,1 40946,0 40961,1 41040,0 41064,1 41131,0 41217,1 41241,0 41260,1 41301,0 41314,1 41385,0 41477,1 41519,0 41570,1 41584,0 41633,1 41690,0 41719,1 41742,0 41788,1 41842,0 41881,1 41978,0 41983,1 42040,0 42115,1 42128,0 42224,1 42286,0 42380,1 42449,0 42463,1 42496,0 42585,1 42603,0 42659,1 42726,0 42737,1 42795,0 42838,1 42841,0 42855,1 42928,0 43023,1 43100,0 43200,1 43223,0 43228,1 43299,0 43327,1 43413,0 43433,1 43501,0 43552,1 43608,0 43635,1 43730,0 43792,1 43875,0 43954,1 43984,0 44012,1 44062,0 44096,1 44115,0 44139,1 44231,0 44293,1 44312,0 44356,1 44383,0 44444,1 44471,0 44513,1 44596,0 44668,1 44719,0 44769,1 44835,0 44935,1 45015,0 45105,1 45151,0 45154,1 45155,0 45229,1 45251,0 45284,1 45346,0 45396,1 45491,0 45548,1 45643,0 45689,1 45762,0 45812,1 45839,0 45897,1 45936,0 45977,1 46077,0 46120,1 46200,0 46216,1 46281,0 46308,1 46404,0 46497,1 46592,0 46677,1 46686,0 46728,1 46740,0 46762,1 46845,0 46922,1 46974,0 47054,1 47069,0 47151,1 47167,0 47233,1 47273,0 47321,1 47350,0 47422,1 47481,0 47535,1 47586,0 47662,1 47684,0 47773,1 47829,0 47901,1 47984,0 47998,1 48082,0 48116,1 48146,0 48200,1 48222,0 48284,1 48323,0 48409,1 48473,0 48551,1 48566,0 48582,1 48596,0 48600,1 48653,0 48705,1 48760,0 48776,1 48822,0 48900,1 48953,0 49036,1 49091,0 49153,1 end initlist a5 0,0 66,1 163,0 176,1 272,0 315,1 397,0 400,1 419,0 449,1 547,0 611,1 650,0 676,1 707,0 805,1 822,0 891,1 946,0 1041,1 1117,0 1173,1 1254,0 1345,1 1437,0 1497,1 1550,0 1590,1 1620,0 1642,1 1643,0 1669,1 1706,0 1735,1 1780,0 1796,1 1887,0 1932,1 1984,0 1992,1 2025,0 2084,1 2183,0 2217,1 2234,0 2291,1 2374,0 2415,1 2493,0 2534,1 2631,0 2719,1 2783,0 2861,1 2916,0 2999,1 3088,0 3118,1 3141,0 3238,1 3271,0 3369,1 3411,0 3490,1 3576,0 3658,1 3696,0 3697,1 3792,0 3892,1 3924,0 3935,1 3950,0 4039,1 4065,0 4112,1 4197,0 4214,1 4266,0 4313,1 4408,0 4454,1 4492,0 4549,1 4577,0 4593,1 4609,0 4636,1 4732,0 4796,1 4801,0 4818,1 4855,0 4939,1 4990,0 5079,1 5151,0 5166,1 5226,0 5294,1 5312,0 5392,1 5434,0 5459,1 5529,0 5552,1 5628,0 5668,1 5710,0 5744,1 5789,0 5851,1 5894,0 5962,1 6013,0 6046,1 6079,0 6104,1 6125,0 6158,1 6218,0 6252,1 6280,0 6376,1 6409,0 6461,1 6540,0 6598,1 6601,0 6632,1 6673,0 6695,1 6761,0 6861,1 6935,0 6995,1 7081,0 7167,1 7203,0 7266,1 7276,0 7339,1 7376,0 7471,1 7486,0 7582,1 7621,0 7622,1 7674,0 7686,1 7732,0 7812,1 7826,0 7828,1 7916,0 7938,1 7993,0 8018,1 8078,0 8146,1 8183,0 8260,1 8290,0 8382,1 8475,0 8553,1 8604,0 8643,1 8690,0 8726,1 8728,0 8744,1 8830,0 8888,1 8969,0 9004,1 9036,0 9129,1 9164,0 9222,1 9271,0 9312,1 9324,0 9410,1 9489,0 9524,1 9557,0 9622,1 9649,0 9706,1 9725,0 9798,1 9858,0 9926,1 10000,0 10040,1 10099,0 10107,1 10201,0 10258,1 10332,0 10426,1 10520,0 10612,1 10659,0 10732,1 10817,0 10852,1 10901,0 10907,1 10947,0 11045,1 11119,0 11212,1 11263,0 11337,1 11353,0 11413,1 11469,0 11564,1 11565,0 11629,1 11712,0 11799,1 11886,0 11966,1 12050,0 12079,1 12118,0 12124,1 12161,0 12204,1 12265,0 12303,1 12392,0 12480,1 12556,0 12595,1 12610,0 12621,1 12626,0 12669,1 12735,0 12800,1 12845,0 12944,1 12985,0 13034,1 13127,0 13143,1 13194,0 13282,1 13309,0 13366,1 13394,0 13399,1 13422,0 13465,1 13483,0 13561,1 13598,0 13655,1 13708,0 13793,1 13830,0 13851,1 13909,0 13927,1 13975,0 14034,1 14086,0 14092,1 14169,0 14268,1 14295,0 14326,1 14380,0 14398,1 14476,0 14546,1 14558,0 14607,1 14685,0 14750,1 14771,0 14795,1 14816,0 14841,1 14904,0 14995,1 15034,0 15104,1 15145,0 15177,1 15211,0 15255,1 15265,0 15323,1 15354,0 15447,1 15480,0 15573,1 15653,0 15725,1 15791,0 15836,1 15864,0 15904,1 15951,0 15959,1 15987,0 16023,1 16059,0 16159,1 16253,0 16273,1 16337,0 16346,1 16355,0 16455,1 16499,0 16522,1 16620,0 16677,1 16775,0 16790,1 16864,0 16903,1 16951,0 16981,1 17027,0 17127,1 17192,0 17241,1 17273,0 17286,1 17380,0 17444,1 17445,0 17532,1 17567,0 17589,1 17594,0 17655,1 17736,0 17772,1 17862,0 17935,1 17936,0 17987,1 18074,0 18166,1 18196,0 18211,1 18301,0 18309,1 18331,0 18427,1 18432,0 18449,1 18491,0 18547,1 18590,0 18647,1 18666,0 18737,1 18796,0 18851,1 18884,0 18946,1 18991,0 19045,1 19127,0 19129,1 19164,0 19239,1 19252,0 19337,1 19428,0 19451,1 19516,0 19529,1 19556,0 19612,1 19674,0 19717,1 19752,0 19814,1 19831,0 19901,1 19951,0 20044,1 20144,0 20236,1 20269,0 20329,1 20390,0 20420,1 20483,0 20552,1 20590,0 20599,1 20609,0 20690,1 20705,0 20715,1 20755,0 20852,1 20859,0 20957,1 21027,0 21046,1 21054,0 21120,1 21204,0 21231,1 21263,0 21322,1 21354,0 21371,1 21420,0 21430,1 21443,0 21526,1 21557,0 21642,1 21656,0 21659,1 21664,0 21674,1 21725,0 21742,1 21768,0 21834,1 21918,0 21919,1 21939,0 21979,1 21997,0 22045,1 22053,0 22076,1 22097,0 22127,1 22183,0 22258,1 22313,0 22350,1 22377,0 22454,1 22487,0 22516,1 22530,0 22570,1 22660,0 22752,1 22802,0 22865,1 22934,0 22936,1 22976,0 22985,1 23037,0 23103,1 23148,0 23189,1 23209,0 23210,1 23263,0 23339,1 23375,0 23405,1 23460,0 23469,1 23512,0 23551,1 23611,0 23641,1 23663,0 23690,1 23776,0 23789,1 23889,0 23938,1 24005,0 24089,1 24113,0 24124,1 24205,0 24283,1 24378,0 24456,1 24526,0 24540,1 24600,0 24610,1 24702,0 24728,1 24803,0 24856,1 24893,0 24929,1 24944,0 24989,1 25003,0 25014,1 25099,0 25129,1 25217,0 25303,1 25348,0 25354,1 25400,0 25434,1 25510,0 25571,1 25618,0 25632,1 25705,0 25769,1 25849,0 25932,1 25961,0 26015,1 26028,0 26036,1 26067,0 26135,1 26164,0 26232,1 26321,0 26395,1 26480,0 26528,1 26567,0 26652,1 26717,0 26759,1 26765,0 26766,1 26772,0 26815,1 26861,0 26952,1 27037,0 27098,1 27136,0 27202,1 27257,0 27331,1 27362,0 27414,1 27465,0 27529,1 27531,0 27540,1 27564,0 27613,1 27627,0 27716,1 27754,0 27777,1 27840,0 27885,1 27981,0 28002,1 28048,0 28101,1 28197,0 28206,1 28297,0 28372,1 28465,0 28501,1 28529,0 28624,1 28682,0 28765,1 28830,0 28896,1 28929,0 28938,1 28984,0 29048,1 29136,0 29140,1 29222,0 29260,1 29335,0 29410,1 29444,0 29473,1 29556,0 29588,1 29678,0 29746,1 29827,0 29877,1 29930,0 29991,1 30059,0 30065,1 30147,0 30175,1 30228,0 30294,1 30295,0 30297,1 30335,0 30354,1 30444,0 30533,1 30534,0 30591,1 30598,0 30681,1 30687,0 30693,1 30747,0 30828,1 30880,0 30960,1 30965,0 31008,1 31012,0 31106,1 31186,0 31267,1 31332,0 31345,1 31395,0 31456,1 31524,0 31611,1 31680,0 31701,1 31761,0 31803,1 31838,0 31925,1 31958,0 32058,1 32126,0 32147,1 32235,0 32295,1 32322,0 32363,1 32364,0 32404,1 32489,0 32545,1 32563,0 32589,1 32591,0 32631,1 32646,0 32703,1 32742,0 32748,1 32766,0 32767,1 32806,0 32855,1 32892,0 32990,1 33084,0 33133,1 33231,0 33296,1 33312,0 33334,1 33363,0 33455,1 33475,0 33549,1 33566,0 33596,1 33676,0 33768,1 33862,0 33922,1 33950,0 33998,1 34084,0 34100,1 34155,0 34209,1 34259,0 34357,1 34400,0 34466,1 34520,0 34555,1 34593,0 34692,1 34693,0 34785,1 34798,0 34887,1 34924,0 34937,1 34980,0 35009,1 35101,0 35142,1 35145,0 35206,1 35303,0 35335,1 35385,0 35409,1 35420,0 35459,1 35466,0 35481,1 35545,0 35553,1 35563,0 35654,1 35749,0 35783,1 35845,0 35864,1 35940,0 35970,1 36000,0 36080,1 36134,0 36226,1 36297,0 36368,1 36466,0 36550,1 36561,0 36579,1 36582,0 36643,1 36694,0 36708,1 36769,0 36802,1 36832,0 36913,1 36957,0 37028,1 37073,0 37126,1 37131,0 37221,1 37228,0 37303,1 37381,0 37390,1 37472,0 37542,1 37615,0 37650,1 37728,0 37822,1 37882,0 37929,1 37971,0 38017,1 38078,0 38106,1 38155,0 38227,1 38283,0 38322,1 38365,0 38461,1 38470,0 38525,1 38550,0 38590,1 38634,0 38727,1 38800,0 38864,1 38890,0 38981,1 39004,0 39077,1 39117,0 39138,1 39215,0 39222,1 39290,0 39310,1 39390,0 39488,1 39491,0 39528,1 39599,0 39675,1 39733,0 39774,1 39809,0 39825,1 39902,0 39994,1 40033,0 40101,1 40102,0 40103,1 40120,0 40209,1 40308,0 40388,1 40465,0 40556,1 40605,0 40667,1 40708,0 40744,1 40814,0 40841,1 40923,0 40925,1 40948,0 40994,1 41094,0 41149,1 41205,0 41271,1 41362,0 41383,1 41391,0 41438,1 41506,0 41539,1 41560,0 41589,1 41635,0 41681,1 41735,0 41820,1 41847,0 41905,1 41949,0 42002,1 42035,0 42096,1 42186,0 42269,1 42342,0 42436,1 42451,0 42526,1 42536,0 42578,1 42664,0 42740,1 42768,0 42826,1 42921,0 43021,1 43058,0 43106,1 43151,0 43198,1 43222,0 43291,1 43367,0 43441,1 43498,0 43508,1 43598,0 43633,1 43668,0 43721,1 43780,0 43844,1 43922,0 44007,1 44082,0 44128,1 44144,0 44224,1 44281,0 44308,1 44375,0 44400,1 44406,0 44476,1 44502,0 44588,1 44621,0 44623,1 44652,0 44691,1 44766,0 44812,1 44867,0 44947,1 45002,0 45095,1 45104,0 45111,1 45197,0 45293,1 45302,0 45350,1 45441,0 45530,1 45593,0 45663,1 45684,0 45750,1 45812,0 45829,1 45894,0 45898,1 45924,0 46009,1 46087,0 46106,1 46201,0 46243,1 46251,0 46263,1 46332,0 46352,1 46386,0 46441,1 46527,0 46592,1 46685,0 46761,1 46782,0 46788,1 46862,0 46868,1 46949,0 47026,1 47092,0 47094,1 47141,0 47232,1 47253,0 47316,1 47351,0 47366,1 47376,0 47395,1 47483,0 47569,1 47633,0 47708,1 47738,0 47752,1 47825,0 47839,1 47930,0 48014,1 48093,0 48166,1 48216,0 48265,1 48287,0 48320,1 48370,0 48411,1 48462,0 48546,1 48583,0 48661,1 48696,0 48756,1 48835,0 48908,1 48913,0 48981,1 49072,0 49111,1 49177,0 49221,1 49318,0 49352,1 49396,0 49398,1 49400,0 49415,1 49474,0 49532,1 49564,0 49610,1 49678,0 49709,1 49723,0 49769,1 49841,0 49875,1 49903,0 49919,1 49944,0 50019,1 50077,0 50122,1 50219,0 50280,1 end initlist a6 0,0 9,1 38,0 45,1 61,0 98,1 194,0 251,1 296,0 350,1 423,0 463,1 496,0 515,1 570,0 599,1 663,0 714,1 795,0 880,1 914,0 967,1 1043,0 1071,1 1141,0 1153,1 1243,0 1326,1 1337,0 1397,1 1424,0 1487,1 1505,0 1595,1 1610,0 1612,1 1658,0 1675,1 1753,0 1760,1 1828,0 1909,1 1999,0 2066,1 2120,0 2139,1 2228,0 2231,1 2313,0 2391,1 2392,0 2440,1 2489,0 2504,1 2565,0 2589,1 2649,0 2672,1 2695,0 2788,1 2830,0 2832,1 2873,0 2969,1 2977,0 2998,1 3036,0 3091,1 3186,0 3199,1 3232,0 3258,1 3349,0 3429,1 3430,0 3496,1 3571,0 3610,1 3704,0 3787,1 3823,0 3829,1 3840,0 3902,1 4002,0 4024,1 4091,0 4187,1 4256,0 4350,1 4362,0 4382,1 4446,0 4535,1 4560,0 4649,1 4681,0 4744,1 4817,0 4849,1 4853,0 4877,1 4969,0 5065,1 5079,0 5121,1 5177,0 5233,1 5281,0 5306,1 5331,0 5375,1 5393,0 5396,1 5401,0 5455,1 5465,0 5539,1 5579,0 5639,1 5719,0 5816,1 5895,0 5985,1 6011,0 6044,1 6051,0 6074,1 6126,0 6135,1 6187,0 6220,1 6226,0 6273,1 6294,0 6302,1 6332,0 6390,1 6406,0 6480,1 6545,0 6551,1 6648,0 6674,1 6751,0 6841,1 6886,0 6944,1 6986,0 7077,1 7154,0 7218,1 7297,0 7300,1 7351,0 7401,1 7441,0 7459,1 7479,0 7541,1 7582,0 7604,1 7648,0 7730,1 7765,0 7801,1 7828,0 7913,1 7945,0 8021,1 8077,0 8103,1 8199,0 8210,1 8262,0 8351,1 8398,0 8417,1 8488,0 8567,1 8661,0 8701,1 8795,0 8846,1 8936,0 9035,1 9124,0 9218,1 9275,0 9301,1 9322,0 9351,1 9356,0 9381,1 9392,0 9426,1 9443,0 9523,1 9619,0 9675,1 9766,0 9824,1 9857,0 9891,1 9905,0 9968,1 10013,0 10085,1 10158,0 10178,1 10183,0 10186,1 10276,0 10298,1 10328,0 10334,1 10350,0 10391,1 10411,0 10486,1 10545,0 10602,1 10670,0 10683,1 10709,0 10776,1 10841,0 10887,1 10968,0 11006,1 11087,0 11114,1 11188,0 11272,1 11355,0 11449,1 11512,0 11608,1 11625,0 11638,1 11719,0 11777,1 11855,0 11952,1 11978,0 12010,1 12053,0 12066,1 12111,0 12190,1 12196,0 12278,1 12284,0 12301,1 12397,0 12459,1 12529,0 12559,1 12645,0 12709,1 12752,0 12757,1 12776,0 12870,1 12916,0 12970,1 13057,0 13075,1 13080,0 13144,1 13236,0 13317,1 13357,0 13409,1 13461,0 13501,1 13515,0 13592,1 13643,0 13729,1 13781,0 13783,1 13803,0 13813,1 13817,0 13914,1 13963,0 13974,1 13991,0 14012,1 14066,0 14141,1 14168,0 14201,1 14203,0 14258,1 14348,0 14395,1 14458,0 14463,1 14478,0 14547,1 14601,0 14657,1 14727,0 14728,1 14797,0 14851,1 14926,0 15002,1 15063,0 15084,1 15152,0 15213,1 15275,0 15360,1 15391,0 15414,1 15428,0 15515,1 15572,0 15573,1 15608,0 15676,1 15720,0 15801,1 15879,0 15943,1 15972,0 16040,1 16063,0 16146,1 16198,0 16276,1 16327,0 16353,1 16396,0 16474,1 16568,0 16639,1 16674,0 16685,1 16720,0 16742,1 16786,0 16796,1 16872,0 16968,1 17046,0 17143,1 17153,0 17209,1 17222,0 17322,1 17401,0 17470,1 17484,0 17505,1 17508,0 17594,1 17653,0 17701,1 17761,0 17845,1 17927,0 17989,1 18069,0 18110,1 18141,0 18168,1 18246,0 18330,1 18403,0 18467,1 18522,0 18562,1 18646,0 18675,1 18692,0 18761,1 18814,0 18914,1 18991,0 19034,1 19053,0 19121,1 19203,0 19281,1 19333,0 19407,1 19430,0 19522,1 19602,0 19649,1 19749,0 19837,1 19913,0 19936,1 19938,0 20008,1 20050,0 20084,1 20109,0 20153,1 20213,0 20312,1 20338,0 20430,1 20507,0 20573,1 20577,0 20627,1 20721,0 20819,1 20844,0 20938,1 20973,0 20984,1 21034,0 21118,1 21199,0 21201,1 21211,0 21263,1 21308,0 21408,1 21493,0 21498,1 21553,0 21595,1 21619,0 21641,1 21650,0 21743,1 21817,0 21862,1 21925,0 21965,1 22030,0 22121,1 22205,0 22256,1 22293,0 22332,1 22385,0 22393,1 22474,0 22489,1 22504,0 22571,1 22598,0 22679,1 22705,0 22729,1 22751,0 22829,1 22834,0 22897,1 22920,0 22945,1 22961,0 22980,1 23009,0 23082,1 23144,0 23190,1 23274,0 23322,1 23359,0 23442,1 23480,0 23535,1 23574,0 23611,1 23707,0 23732,1 23817,0 23877,1 23968,0 24017,1 24021,0 24089,1 24123,0 24186,1 24213,0 24214,1 24240,0 24293,1 24366,0 24378,1 24432,0 24530,1 24532,0 24563,1 24628,0 24679,1 24735,0 24767,1 24804,0 24894,1 24965,0 24975,1 25061,0 25093,1 25097,0 25112,1 25209,0 25282,1 25284,0 25306,1 25333,0 25369,1 25469,0 25499,1 25565,0 25582,1 25612,0 25646,1 25685,0 25701,1 25777,0 25811,1 25815,0 25905,1 25961,0 26036,1 26113,0 26142,1 26227,0 26317,1 26358,0 26402,1 26442,0 26482,1 26570,0 26667,1 26689,0 26742,1 26781,0 26792,1 26834,0 26860,1 26903,0 27000,1 27038,0 27081,1 27180,0 27278,1 27282,0 27312,1 27343,0 27378,1 27414,0 27488,1 27534,0 27602,1 27615,0 27663,1 27672,0 27747,1 27789,0 27873,1 27930,0 27983,1 28082,0 28157,1 28178,0 28249,1 28290,0 28294,1 28298,0 28374,1 28375,0 28426,1 28468,0 28485,1 28524,0 28610,1 28666,0 28668,1 28699,0 28788,1 28834,0 28866,1 28903,0 28978,1 29021,0 29082,1 29164,0 29257,1 29294,0 29312,1 29386,0 29468,1 29479,0 29497,1 29578,0 29663,1 29721,0 29728,1 29764,0 29808,1 29858,0 29910,1 29985,0 29995,1 30086,0 30132,1 30214,0 30249,1 30332,0 30347,1 30375,0 30433,1 30526,0 30624,1 30644,0 30713,1 30721,0 30768,1 30833,0 30917,1 31002,0 31059,1 31141,0 31189,1 31243,0 31309,1 31358,0 31450,1 31505,0 31605,1 31692,0 31773,1 31825,0 31889,1 31955,0 32046,1 32085,0 32179,1 32222,0 32223,1 32311,0 32382,1 32413,0 32509,1 32557,0 32613,1 32670,0 32741,1 32778,0 32795,1 32857,0 32953,1 33012,0 33106,1 33119,0 33215,1 33301,0 33361,1 33400,0 33490,1 33576,0 33647,1 33713,0 33801,1 33844,0 33927,1 33928,0 33935,1 34027,0 34079,1 34133,0 34196,1 34279,0 34357,1 34380,0 34399,1 34420,0 34441,1 34504,0 34514,1 34583,0 34651,1 34669,0 34759,1 34828,0 34844,1 34942,0 34998,1 35031,0 35131,1 35198,0 35259,1 35316,0 35376,1 35461,0 35473,1 35570,0 35636,1 35653,0 35752,1 35841,0 35845,1 35877,0 35907,1 36001,0 36055,1 36072,0 36121,1 36165,0 36172,1 36259,0 36335,1 36347,0 36418,1 36469,0 36562,1 36640,0 36728,1 36810,0 36909,1 37007,0 37070,1 37091,0 37124,1 37199,0 37201,1 37242,0 37342,1 37359,0 37368,1 37422,0 37460,1 37494,0 37556,1 37582,0 37674,1 37747,0 37778,1 37862,0 37903,1 37927,0 37949,1 37981,0 38080,1 38172,0 38238,1 38268,0 38367,1 38393,0 38396,1 38494,0 38570,1 38621,0 38651,1 38668,0 38698,1 38798,0 38816,1 38838,0 38847,1 38907,0 38961,1 38973,0 39067,1 39094,0 39186,1 39216,0 39223,1 39299,0 39370,1 39409,0 39430,1 39437,0 39455,1 39513,0 39551,1 39631,0 39667,1 39691,0 39745,1 39829,0 39872,1 39916,0 39934,1 39939,0 39994,1 40040,0 40107,1 40142,0 40222,1 40250,0 40279,1 40349,0 40438,1 40462,0 40465,1 40521,0 40593,1 40614,0 40688,1 40736,0 40785,1 40852,0 40949,1 40963,0 40994,1 41017,0 41032,1 41067,0 41069,1 41074,0 41144,1 41231,0 41324,1 41409,0 41451,1 41471,0 41495,1 41571,0 41604,1 41621,0 41710,1 41743,0 41835,1 41886,0 41892,1 41980,0 42065,1 42146,0 42176,1 42243,0 42289,1 42354,0 42404,1 42417,0 42498,1 42588,0 42658,1 42751,0 42797,1 42821,0 42828,1 42856,0 42876,1 42973,0 43044,1 43116,0 43145,1 43146,0 43195,1 43247,0 43270,1 43311,0 43344,1 43407,0 43500,1 43540,0 43601,1 43617,0 43696,1 43783,0 43802,1 43844,0 43866,1 43957,0 43985,1 43989,0 44074,1 44094,0 44193,1 44289,0 44316,1 44374,0 44385,1 44441,0 44500,1 44543,0 44549,1 44635,0 44636,1 44662,0 44721,1 44772,0 44824,1 44898,0 44959,1 44995,0 45085,1 45110,0 45191,1 45232,0 45250,1 45274,0 45346,1 45374,0 45456,1 45550,0 45630,1 45677,0 45710,1 45768,0 45833,1 45883,0 45890,1 45896,0 45974,1 46040,0 46072,1 46157,0 46192,1 46282,0 46354,1 46410,0 46431,1 46462,0 46489,1 46510,0 46539,1 46631,0 46663,1 46728,0 46808,1 46849,0 46874,1 46888,0 46982,1 47002,0 47006,1 47070,0 47159,1 47203,0 47237,1 47266,0 47292,1 47319,0 47345,1 47377,0 47457,1 47557,0 47564,1 47631,0 47681,1 47696,0 47792,1 47876,0 47938,1 47972,0 48068,1 48136,0 48199,1 48296,0 48347,1 48400,0 48424,1 48447,0 48499,1 48551,0 48582,1 48593,0 48615,1 48621,0 48698,1 48794,0 48878,1 48920,0 48936,1 49028,0 49067,1 49165,0 49244,1 49344,0 49435,1 49525,0 49582,1 49626,0 49717,1 49787,0 49803,1 49892,0 49943,1 50017,0 50018,1 50062,0 50152,1 50229,0 50322,1 50344,0 50371,1 50440,0 50521,1 50612,0 50676,1 50701,0 50721,1 50737,0 50763,1 50827,0 50842,1 50927,0 51020,1 end initlist a7 0,0 94,1 138,0 215,1 285,0 349,1 442,0 489,1 551,0 556,1 632,0 697,1 713,0 768,1 815,0 828,1 918,0 947,1 950,0 1015,1 1075,0 1164,1 1242,0 1258,1 1292,0 1378,1 1462,0 1498,1 1532,0 1556,1 1616,0 1688,1 1691,0 1731,1 1765,0 1847,1 1885,0 1980,1 2031,0 2127,1 2223,0 2288,1 2360,0 2385,1 2469,0 2470,1 2569,0 2604,1 2621,0 2633,1 2658,0 2696,1 2749,0 2797,1 2818,0 2915,1 2985,0 3058,1 3082,0 3103,1 3161,0 3229,1 3281,0 3319,1 3398,0 3407,1 3422,0 3514,1 3565,0 3605,1 3665,0 3699,1 3757,0 3855,1 3904,0 3936,1 3975,0 4072,1 4171,0 4191,1 4242,0 4335,1 4394,0 4423,1 4481,0 4494,1 4565,0 4624,1 4675,0 4688,1 4779,0 4850,1 4944,0 4985,1 4992,0 5046,1 5092,0 5116,1 5168,0 5179,1 5239,0 5243,1 5322,0 5363,1 5420,0 5515,1 5589,0 5636,1 5664,0 5735,1 5790,0 5872,1 5876,0 5929,1 5933,0 6011,1 6061,0 6111,1 6210,0 6223,1 6304,0 6314,1 6327,0 6371,1 6386,0 6415,1 6425,0 6507,1 6526,0 6599,1 6627,0 6710,1 6788,0 6887,1 6934,0 6965,1 6981,0 7076,1 7123,0 7215,1 7238,0 7281,1 7358,0 7389,1 7397,0 7483,1 7573,0 7656,1 7705,0 7714,1 7716,0 7726,1 7735,0 7774,1 7856,0 7911,1 7935,0 7953,1 7955,0 8009,1 8084,0 8087,1 8126,0 8140,1 8164,0 8215,1 8251,0 8308,1 8321,0 8400,1 8433,0 8531,1 8555,0 8563,1 8654,0 8713,1 8747,0 8839,1 8939,0 8973,1 9021,0 9065,1 9126,0 9223,1 9269,0 9311,1 9323,0 9421,1 9495,0 9516,1 9594,0 9688,1 9759,0 9788,1 9805,0 9820,1 9917,0 9984,1 10055,0 10108,1 10127,0 10222,1 10223,0 10239,1 10291,0 10311,1 10380,0 10476,1 10551,0 10573,1 10629,0 10724,1 10726,0 10777,1 10855,0 10912,1 10913,0 11010,1 11016,0 11064,1 11066,0 11087,1 11104,0 11110,1 11171,0 11192,1 11223,0 11270,1 11301,0 11341,1 11395,0 11466,1 11482,0 11548,1 11636,0 11655,1 11749,0 11752,1 11785,0 11848,1 11911,0 11929,1 12025,0 12035,1 12042,0 12098,1 12147,0 12210,1 12232,0 12318,1 12412,0 12497,1 12532,0 12607,1 12624,0 12635,1 12706,0 12718,1 12732,0 12827,1 12912,0 12947,1 12988,0 13051,1 13055,0 13095,1 13160,0 13222,1 13255,0 13322,1 13400,0 13486,1 13537,0 13633,1 13645,0 13709,1 13762,0 13764,1 13783,0 13877,1 13938,0 13966,1 14042,0 14136,1 14149,0 14192,1 14262,0 14314,1 14372,0 14446,1 14510,0 14542,1 14543,0 14640,1 14677,0 14732,1 14826,0 14843,1 14875,0 14908,1 14928,0 14981,1 15046,0 15062,1 15089,0 15123,1 15204,0 15264,1 15335,0 15427,1 15496,0 15582,1 15607,0 15627,1 15667,0 15757,1 15830,0 15902,1 15939,0 15976,1 16004,0 16026,1 16103,0 16125,1 16129,0 16168,1 16214,0 16285,1 16373,0 16388,1 16399,0 16468,1 16511,0 16591,1 16627,0 16631,1 16722,0 16724,1 16783,0 16847,1 16878,0 16919,1 17006,0 17041,1 17115,0 17153,1 17239,0 17259,1 17324,0 17330,1 17396,0 17457,1 17509,0 17598,1 17652,0 17660,1 17736,0 17796,1 17816,0 17860,1 17900,0 17919,1 17989,0 18042,1 18077,0 18099,1 18199,0 18285,1 18355,0 18448,1 18514,0 18563,1 18625,0 18696,1 18770,0 18799,1 18892,0 18940,1 18961,0 19052,1 19070,0 19128,1 19133,0 19199,1 19226,0 19245,1 19281,0 19326,1 19387,0 19432,1 19515,0 19589,1 19607,0 19676,1 19720,0 19800,1 19879,0 19967,1 20005,0 20026,1 20120,0 20215,1 20246,0 20267,1 20273,0 20293,1 20326,0 20376,1 20386,0 20462,1 20525,0 20592,1 20626,0 20722,1 20785,0 20855,1 20893,0 20930,1 20943,0 20956,1 21010,0 21096,1 21144,0 21226,1 21254,0 21277,1 21367,0 21379,1 21429,0 21459,1 21539,0 21576,1 21578,0 21645,1 21677,0 21716,1 21809,0 21905,1 21990,0 22077,1 22167,0 22256,1 22267,0 22270,1 22324,0 22420,1 22489,0 22531,1 22602,0 22643,1 22709,0 22776,1 22785,0 22869,1 22968,0 22975,1 23028,0 23093,1 23131,0 23218,1 23269,0 23323,1 23325,0 23359,1 23382,0 23442,1 23539,0 23551,1 23615,0 23655,1 23733,0 23764,1 23842,0 23880,1 23913,0 23954,1 23980,0 23996,1 24062,0 24110,1 24128,0 24190,1 24273,0 24362,1 24407,0 24492,1 24575,0 24668,1 24719,0 24816,1 24889,0 24918,1 25015,0 25079,1 25174,0 25270,1 25345,0 25376,1 25471,0 25473,1 25474,0 25516,1 25539,0 25610,1 25628,0 25629,1 25644,0 25686,1 25742,0 25770,1 25787,0 25822,1 25862,0 25914,1 26009,0 26064,1 26127,0 26215,1 26273,0 26301,1 26364,0 26419,1 26428,0 26432,1 26517,0 26617,1 26671,0 26725,1 26772,0 26786,1 26878,0 26968,1 26980,0 27035,1 27048,0 27127,1 27141,0 27241,1 27265,0 27354,1 27422,0 27493,1 27534,0 27625,1 27647,0 27686,1 27689,0 27703,1 27759,0 27842,1 27885,0 27956,1 28042,0 28064,1 28076,0 28162,1 28170,0 28187,1 28223,0 28282,1 28374,0 28452,1 28551,0 28609,1 28626,0 28697,1 28775,0 28776,1 28849,0 28865,1 28900,0 28914,1 28949,0 29019,1 29074,0 29118,1 29197,0 29207,1 29226,0 29311,1 29355,0 29424,1 29465,0 29490,1 29545,0 29617,1 29714,0 29775,1 29838,0 29893,1 29935,0 29949,1 29958,0 29996,1 30072,0 30103,1 30202,0 30299,1 30322,0 30342,1 30430,0 30500,1 30580,0 30584,1 30610,0 30680,1 30739,0 30775,1 30836,0 30896,1 30988,0 31044,1 31135,0 31136,1 31188,0 31193,1 31277,0 31372,1 31448,0 31489,1 31493,0 31543,1 31609,0 31616,1 31651,0 31713,1 31751,0 31786,1 31834,0 31912,1 32006,0 32046,1 32052,0 32064,1 32113,0 32142,1 32164,0 32198,1 32210,0 32241,1 32249,0 32316,1 32374,0 32386,1 32436,0 32449,1 32512,0 32560,1 32586,0 32648,1 32736,0 32761,1 32842,0 32876,1 32944,0 32950,1 32969,0 32993,1 33005,0 33016,1 33085,0 33120,1 33159,0 33197,1 33231,0 33301,1 33317,0 33368,1 33415,0 33477,1 33540,0 33545,1 33644,0 33682,1 33746,0 33801,1 33889,0 33960,1 33987,0 34007,1 34092,0 34163,1 34240,0 34298,1 34323,0 34402,1 34418,0 34474,1 34494,0 34552,1 34648,0 34702,1 34794,0 34843,1 34928,0 34965,1 34991,0 34997,1 35019,0 35065,1 35136,0 35205,1 35272,0 35340,1 35398,0 35480,1 35508,0 35569,1 35617,0 35620,1 35638,0 35703,1 35747,0 35776,1 35826,0 35874,1 35905,0 35938,1 35987,0 36026,1 36098,0 36151,1 36224,0 36226,1 36261,0 36310,1 36327,0 36371,1 36385,0 36423,1 36504,0 36523,1 36546,0 36634,1 36692,0 36759,1 36810,0 36854,1 36917,0 36944,1 37020,0 37082,1 37164,0 37213,1 37269,0 37289,1 37369,0 37440,1 37512,0 37603,1 37615,0 37647,1 37728,0 37781,1 37799,0 37846,1 37923,0 37981,1 38054,0 38065,1 38083,0 38149,1 38189,0 38220,1 38304,0 38335,1 38342,0 38363,1 38398,0 38471,1 38513,0 38561,1 38657,0 38721,1 38773,0 38820,1 38862,0 38868,1 38968,0 39007,1 39024,0 39085,1 39092,0 39121,1 39210,0 39307,1 39379,0 39380,1 39461,0 39497,1 39533,0 39595,1 39691,0 39751,1 39813,0 39815,1 39897,0 39964,1 39995,0 40031,1 40039,0 40099,1 40125,0 40221,1 40273,0 40323,1 40389,0 40414,1 40470,0 40483,1 40512,0 40573,1 40655,0 40731,1 40752,0 40817,1 40886,0 40946,1 40947,0 41033,1 41057,0 41138,1 41189,0 41232,1 41318,0 41376,1 41445,0 41495,1 41564,0 41638,1 41639,0 41692,1 41696,0 41783,1 41816,0 41836,1 41921,0 41959,1 42012,0 42082,1 42135,0 42191,1 42286,0 42342,1 42426,0 42509,1 42581,0 42582,1 42668,0 42712,1 42733,0 42808,1 42893,0 42926,1 42952,0 42992,1 43059,0 43083,1 43084,0 43179,1 43184,0 43280,1 43369,0 43450,1 43537,0 43604,1 43675,0 43723,1 43816,0 43908,1 43923,0 43928,1 43956,0 43994,1 44090,0 44160,1 44185,0 44277,1 44301,0 44314,1 44401,0 44459,1 44473,0 44525,1 44558,0 44591,1 44664,0 44675,1 44704,0 44717,1 44757,0 44845,1 44862,0 44936,1 44949,0 45001,1 45101,0 45190,1 45196,0 45218,1 45229,0 45308,1 45384,0 45438,1 45495,0 45593,1 45640,0 45673,1 45754,0 45853,1 45879,0 45913,1 45978,0 46031,1 46039,0 46076,1 46149,0 46227,1 46247,0 46340,1 46401,0 46501,1 46544,0 46570,1 46639,0 46728,1 46758,0 46830,1 46834,0 46883,1 46890,0 46904,1 46988,0 47032,1 47069,0 47076,1 47084,0 47114,1 47181,0 47213,1 47238,0 47295,1 47312,0 47324,1 47367,0 47419,1 47461,0 47478,1 47576,0 47617,1 47686,0 47717,1 47752,0 47768,1 47822,0 47903,1 47908,0 47979,1 48001,0 48087,1 48156,0 48247,1 48259,0 48353,1 48416,0 48492,1 48577,0 48591,1 48650,0 48700,1 48761,0 48781,1 48827,0 48869,1 48926,0 48940,1 48975,0 49002,1 49006,0 49052,1 49144,0 49226,1 49253,0 49318,1 49341,0 49386,1 49394,0 49403,1 49411,0 49438,1 49468,0 49512,1 49582,0 49611,1 49687,0 49759,1 49837,0 49927,1 49946,0 50035,1 50108,0 50142,1 end initlist a8 0,0 36,1 69,0 79,1 133,0 161,1 207,0 238,1 308,0 361,1 418,0 462,1 488,0 568,1 612,0 712,1 740,0 762,1 849,0 874,1 907,0 989,1 1070,0 1092,1 1183,0 1229,1 1317,0 1367,1 1465,0 1489,1 1535,0 1628,1 1634,0 1639,1 1697,0 1711,1 1718,0 1767,1 1789,0 1842,1 1860,0 1959,1 1990,0 2000,1 2034,0 2071,1 2084,0 2171,1 2203,0 2289,1 2309,0 2319,1 2361,0 2427,1 2518,0 2538,1 2563,0 2572,1 2654,0 2729,1 2731,0 2792,1 2829,0 2924,1 3018,0 3056,1 3151,0 3232,1 3305,0 3377,1 3422,0 3459,1 3528,0 3618,1 3707,0 3797,1 3825,0 3849,1 3856,0 3930,1 3953,0 3975,1 4050,0 4087,1 4144,0 4145,1 4171,0 4199,1 4244,0 4316,1 4325,0 4367,1 4436,0 4447,1 4477,0 4525,1 4561,0 4655,1 4732,0 4784,1 4881,0 4970,1 5014,0 5103,1 5152,0 5199,1 5237,0 5282,1 5312,0 5357,1 5383,0 5471,1 5476,0 5537,1 5633,0 5661,1 5685,0 5737,1 5816,0 5876,1 5908,0 5925,1 5962,0 5992,1 6021,0 6051,1 6137,0 6178,1 6237,0 6238,1 6321,0 6335,1 6409,0 6428,1 6439,0 6504,1 6582,0 6678,1 6713,0 6750,1 6789,0 6876,1 6900,0 6936,1 6996,0 7076,1 7112,0 7162,1 7247,0 7290,1 7291,0 7313,1 7379,0 7457,1 7542,0 7578,1 7640,0 7700,1 7769,0 7788,1 7792,0 7805,1 7815,0 7838,1 7937,0 7944,1 7950,0 7973,1 8046,0 8107,1 8116,0 8126,1 8152,0 8155,1 8218,0 8313,1 8372,0 8428,1 8498,0 8524,1 8576,0 8586,1 8677,0 8716,1 8747,0 8750,1 8798,0 8881,1 8882,0 8930,1 8996,0 9076,1 9100,0 9123,1 9162,0 9237,1 9310,0 9407,1 9467,0 9566,1 9629,0 9679,1 9683,0 9765,1 9837,0 9868,1 9964,0 10048,1 10120,0 10202,1 10231,0 10253,1 10298,0 10357,1 10389,0 10432,1 10471,0 10512,1 10571,0 10627,1 10650,0 10675,1 10713,0 10798,1 10822,0 10873,1 10922,0 10986,1 11072,0 11103,1 11139,0 11199,1 11240,0 11245,1 11321,0 11414,1 11430,0 11525,1 11536,0 11604,1 11650,0 11654,1 11670,0 11712,1 11759,0 11819,1 11910,0 11961,1 11986,0 12084,1 12128,0 12148,1 12213,0 12306,1 12378,0 12404,1 12490,0 12567,1 12608,0 12686,1 12740,0 12750,1 12850,0 12927,1 12942,0 12980,1 12989,0 13044,1 13096,0 13135,1 13232,0 13290,1 13376,0 13385,1 13426,0 13519,1 13543,0 13586,1 13656,0 13751,1 13822,0 13857,1 13864,0 13932,1 13950,0 14019,1 14092,0 14102,1 14128,0 14196,1 14202,0 14203,1 14242,0 14322,1 14367,0 14441,1 14452,0 14487,1 14577,0 14635,1 14670,0 14713,1 14793,0 14833,1 14835,0 14881,1 14914,0 14991,1 15051,0 15088,1 15106,0 15160,1 15252,0 15277,1 15286,0 15335,1 15384,0 15422,1 15478,0 15479,1 15515,0 15550,1 15640,0 15685,1 15695,0 15785,1 15811,0 15910,1 15974,0 16023,1 16123,0 16205,1 16237,0 16312,1 16387,0 16476,1 16538,0 16632,1 16712,0 16746,1 16806,0 16813,1 16906,0 16937,1 16994,0 17047,1 17129,0 17155,1 17158,0 17219,1 17293,0 17367,1 17428,0 17515,1 17532,0 17614,1 17714,0 17781,1 17825,0 17898,1 17967,0 18020,1 18087,0 18152,1 18240,0 18266,1 18278,0 18306,1 18311,0 18364,1 18405,0 18422,1 18493,0 18526,1 18623,0 18650,1 18719,0 18802,1 18835,0 18848,1 18885,0 18886,1 18935,0 18963,1 19026,0 19049,1 19060,0 19075,1 19076,0 19143,1 19187,0 19244,1 19261,0 19351,1 19379,0 19451,1 19483,0 19557,1 19633,0 19698,1 19763,0 19767,1 19853,0 19880,1 19942,0 20032,1 20072,0 20141,1 20220,0 20276,1 20359,0 20401,1 20424,0 20518,1 20556,0 20574,1 20592,0 20600,1 20661,0 20700,1 20747,0 20786,1 20856,0 20953,1 21039,0 21120,1 21183,0 21209,1 21210,0 21247,1 21268,0 21335,1 21387,0 21458,1 21470,0 21540,1 21567,0 21633,1 21723,0 21759,1 21821,0 21884,1 21980,0 21995,1 22084,0 22121,1 22125,0 22164,1 22261,0 22360,1 22456,0 22512,1 22557,0 22627,1 22646,0 22737,1 22762,0 22792,1 22823,0 22857,1 22862,0 22917,1 23015,0 23043,1 23093,0 23150,1 23229,0 23302,1 23354,0 23438,1 23495,0 23521,1 23546,0 23593,1 23637,0 23715,1 23748,0 23780,1 23797,0 23825,1 23906,0 23955,1 23959,0 24027,1 24117,0 24155,1 24212,0 24242,1 24332,0 24411,1 24487,0 24566,1 24569,0 24625,1 24681,0 24746,1 24811,0 24903,1 24928,0 24960,1 25053,0 25119,1 25172,0 25208,1 25287,0 25369,1 25436,0 25516,1 25585,0 25622,1 25688,0 25710,1 25775,0 25833,1 25888,0 25910,1 25939,0 25988,1 26033,0 26099,1 26169,0 26241,1 26286,0 26295,1 26325,0 26385,1 26448,0 26547,1 26636,0 26682,1 26695,0 26708,1 26741,0 26832,1 26916,0 26994,1 27030,0 27104,1 27162,0 27227,1 27273,0 27351,1 27451,0 27485,1 27578,0 27589,1 27661,0 27705,1 27708,0 27792,1 27804,0 27850,1 27920,0 27984,1 28050,0 28136,1 28162,0 28217,1 28308,0 28395,1 28416,0 28469,1 28506,0 28587,1 28624,0 28625,1 28657,0 28755,1 28838,0 28886,1 28931,0 28966,1 28970,0 29035,1 29105,0 29186,1 29266,0 29321,1 29324,0 29342,1 29389,0 29413,1 29458,0 29539,1 29619,0 29659,1 29702,0 29739,1 29763,0 29782,1 29805,0 29823,1 29826,0 29832,1 29906,0 29994,1 30082,0 30084,1 30139,0 30187,1 30259,0 30310,1 30322,0 30374,1 30376,0 30447,1 30466,0 30500,1 30563,0 30630,1 30677,0 30730,1 30797,0 30885,1 30914,0 30990,1 30993,0 31068,1 31076,0 31138,1 31172,0 31190,1 31224,0 31290,1 31297,0 31354,1 31445,0 31534,1 31567,0 31577,1 31658,0 31709,1 31792,0 31837,1 31841,0 31857,1 31931,0 31945,1 32000,0 32024,1 32073,0 32133,1 32204,0 32304,1 32368,0 32423,1 32519,0 32616,1 32684,0 32689,1 32783,0 32829,1 32916,0 32954,1 33035,0 33051,1 33090,0 33183,1 33276,0 33291,1 33385,0 33482,1 33509,0 33528,1 33542,0 33553,1 33619,0 33689,1 33758,0 33761,1 33842,0 33896,1 33979,0 34058,1 34146,0 34199,1 34249,0 34336,1 34364,0 34464,1 34468,0 34516,1 34579,0 34604,1 34682,0 34782,1 34853,0 34887,1 34986,0 35003,1 35043,0 35112,1 35208,0 35282,1 35382,0 35446,1 35481,0 35527,1 35608,0 35705,1 35720,0 35809,1 35820,0 35904,1 35917,0 35954,1 35987,0 36087,1 36187,0 36231,1 36302,0 36394,1 36490,0 36513,1 36566,0 36627,1 36692,0 36703,1 36747,0 36762,1 36815,0 36912,1 36998,0 37088,1 37154,0 37235,1 37269,0 37336,1 37413,0 37489,1 37524,0 37552,1 37615,0 37685,1 37714,0 37731,1 37812,0 37852,1 37931,0 37990,1 37994,0 37996,1 38002,0 38066,1 38069,0 38094,1 38176,0 38243,1 38314,0 38410,1 38436,0 38516,1 38582,0 38612,1 38613,0 38646,1 38683,0 38693,1 38695,0 38732,1 38809,0 38860,1 38937,0 38988,1 39047,0 39062,1 39112,0 39164,1 39169,0 39216,1 39287,0 39354,1 39401,0 39457,1 39475,0 39519,1 39582,0 39585,1 39655,0 39699,1 39738,0 39801,1 39901,0 39945,1 39981,0 40053,1 40068,0 40085,1 40114,0 40149,1 40217,0 40242,1 40304,0 40368,1 40382,0 40415,1 40510,0 40544,1 40562,0 40610,1 40702,0 40735,1 40831,0 40881,1 40975,0 41005,1 41038,0 41065,1 41115,0 41200,1 41224,0 41286,1 41379,0 41428,1 41477,0 41512,1 41514,0 41590,1 41624,0 41714,1 41756,0 41838,1 41846,0 41877,1 41966,0 42014,1 42106,0 42137,1 42226,0 42294,1 42394,0 42440,1 42477,0 42550,1 42608,0 42653,1 42657,0 42726,1 42779,0 42810,1 42834,0 42841,1 42870,0 42929,1 42976,0 42984,1 43000,0 43088,1 43137,0 43237,1 43322,0 43386,1 43396,0 43492,1 43572,0 43640,1 43662,0 43667,1 43686,0 43719,1 43761,0 43786,1 43813,0 43817,1 43875,0 43905,1 43912,0 43921,1 43964,0 44011,1 44064,0 44087,1 44122,0 44219,1 44230,0 44315,1 44336,0 44406,1 44438,0 44519,1 44599,0 44631,1 44671,0 44732,1 44813,0 44863,1 44922,0 44937,1 45009,0 45010,1 45085,0 45159,1 45185,0 45219,1 45243,0 45340,1 45352,0 45428,1 45491,0 45562,1 45600,0 45644,1 45728,0 45795,1 45816,0 45875,1 45882,0 45939,1 45955,0 45998,1 46065,0 46121,1 46217,0 46288,1 46342,0 46380,1 46435,0 46494,1 46508,0 46534,1 46595,0 46694,1 46749,0 46836,1 46883,0 46939,1 47028,0 47050,1 47100,0 47101,1 47194,0 47273,1 47285,0 47334,1 47361,0 47416,1 47464,0 47470,1 47569,0 47634,1 47714,0 47807,1 47852,0 47930,1 47962,0 47990,1 48082,0 48098,1 48139,0 48169,1 48230,0 48267,1 48328,0 48389,1 48398,0 48431,1 48470,0 48563,1 48626,0 48694,1 48750,0 48819,1 48906,0 48997,1 49073,0 49099,1 49160,0 49212,1 49267,0 49366,1 49430,0 49519,1 49556,0 49615,1 49699,0 49777,1 49787,0 49879,1 49952,0 50042,1 50119,0 50131,1 50184,0 50203,1 50254,0 50338,1 50348,0 50407,1 50444,0 50515,1 50563,0 50660,1 50678,0 50734,1 50824,0 50874,1 50970,0 50980,1 51066,0 51084,1 51130,0 51164,1 end initlist a9 0,0 80,1 141,0 160,1 212,0 312,1 344,0 393,1 402,0 491,1 536,0 612,1 703,0 750,1 779,0 831,1 837,0 853,1 891,0 967,1 987,0 997,1 1084,0 1170,1 1196,0 1219,1 1232,0 1246,1 1312,0 1358,1 1414,0 1486,1 1526,0 1579,1 1625,0 1673,1 1755,0 1787,1 1815,0 1894,1 1918,0 1972,1 2019,0 2040,1 2124,0 2129,1 2147,0 2225,1 2266,0 2336,1 2374,0 2447,1 2463,0 2505,1 2589,0 2654,1 2664,0 2730,1 2795,0 2846,1 2917,0 2938,1 2971,0 3036,1 3050,0 3053,1 3116,0 3137,1 3215,0 3254,1 3324,0 3346,1 3387,0 3414,1 3460,0 3555,1 3625,0 3701,1 3727,0 3792,1 3890,0 3974,1 4047,0 4076,1 4103,0 4104,1 4123,0 4213,1 4217,0 4254,1 4331,0 4388,1 4457,0 4469,1 4492,0 4566,1 4638,0 4696,1 4718,0 4772,1 4804,0 4814,1 4880,0 4959,1 5000,0 5057,1 5114,0 5174,1 5203,0 5209,1 5243,0 5259,1 5273,0 5340,1 5420,0 5441,1 5469,0 5479,1 5507,0 5549,1 5624,0 5639,1 5699,0 5745,1 5790,0 5884,1 5907,0 5944,1 5988,0 6013,1 6026,0 6050,1 6080,0 6130,1 6184,0 6267,1 6292,0 6300,1 6343,0 6409,1 6422,0 6463,1 6477,0 6501,1 6578,0 6607,1 6691,0 6703,1 6715,0 6750,1 6799,0 6839,1 6936,0 7013,1 7068,0 7148,1 7216,0 7282,1 7381,0 7445,1 7518,0 7573,1 7672,0 7739,1 7757,0 7835,1 7847,0 7896,1 7906,0 7913,1 7992,0 8006,1 8033,0 8079,1 8105,0 8121,1 8185,0 8227,1 8309,0 8357,1 8421,0 8444,1 8456,0 8532,1 8607,0 8681,1 8703,0 8737,1 8795,0 8863,1 8962,0 9013,1 9082,0 9169,1 9231,0 9310,1 9354,0 9356,1 9366,0 9462,1 9509,0 9574,1 9600,0 9645,1 9689,0 9706,1 9717,0 9783,1 9850,0 9919,1 9933,0 10009,1 10056,0 10077,1 10080,0 10109,1 10126,0 10137,1 10205,0 10220,1 10242,0 10337,1 10428,0 10435,1 10493,0 10589,1 10652,0 10722,1 10768,0 10774,1 10814,0 10890,1 10893,0 10924,1 11001,0 11091,1 11109,0 11132,1 11172,0 11206,1 11245,0 11288,1 11357,0 11404,1 11442,0 11487,1 11523,0 11540,1 11624,0 11701,1 11772,0 11828,1 11835,0 11909,1 11990,0 12009,1 12098,0 12107,1 12149,0 12174,1 12183,0 12192,1 12281,0 12337,1 12389,0 12402,1 12419,0 12455,1 12509,0 12533,1 12590,0 12664,1 12682,0 12715,1 12770,0 12811,1 12893,0 12937,1 13018,0 13049,1 13142,0 13221,1 13261,0 13327,1 13363,0 13405,1 13450,0 13469,1 13512,0 13540,1 13581,0 13591,1 13656,0 13705,1 13803,0 13822,1 13856,0 13883,1 13936,0 13995,1 14047,0 14074,1 14144,0 14213,1 14293,0 14333,1 14352,0 14432,1 14527,0 14534,1 14551,0 14560,1 14654,0 14674,1 14749,0 14810,1 14856,0 14945,1 14987,0 15077,1 15163,0 15184,1 15251,0 15346,1 15415,0 15436,1 15486,0 15506,1 15539,0 15566,1 15627,0 15698,1 15719,0 15739,1 15784,0 15818,1 15884,0 15975,1 16006,0 16062,1 16143,0 16206,1 16233,0 16320,1 16321,0 16403,1 16468,0 16512,1 16527,0 16626,1 16676,0 16758,1 16797,0 16820,1 16885,0 16898,1 16918,0 16971,1 17028,0 17077,1 17088,0 17139,1 17239,0 17278,1 17346,0 17385,1 17429,0 17469,1 17508,0 17573,1 17580,0 17631,1 17637,0 17661,1 17682,0 17775,1 17777,0 17835,1 17915,0 17979,1 18076,0 18130,1 18203,0 18267,1 18348,0 18351,1 18406,0 18448,1 18497,0 18531,1 18599,0 18660,1 18722,0 18771,1 18816,0 18830,1 18880,0 18897,1 18962,0 18980,1 18998,0 19007,1 19015,0 19095,1 19172,0 19200,1 19213,0 19230,1 19246,0 19333,1 19340,0 19372,1 19405,0 19441,1 19513,0 19595,1 19669,0 19711,1 19769,0 19793,1 19846,0 19921,1 19999,0 20011,1 20037,0 20071,1 20153,0 20178,1 20182,0 20244,1 20277,0 20353,1 20387,0 20476,1 20547,0 20554,1 20640,0 20660,1 20670,0 20696,1 20727,0 20758,1 20832,0 20845,1 20929,0 20931,1 21006,0 21061,1 21080,0 21150,1 21237,0 21333,1 21340,0 21370,1 21435,0 21487,1 21515,0 21523,1 21557,0 21654,1 21695,0 21716,1 21798,0 21892,1 21961,0 21994,1 22014,0 22114,1 22168,0 22197,1 22257,0 22311,1 22402,0 22466,1 22488,0 22559,1 22591,0 22634,1 22638,0 22714,1 22747,0 22770,1 22816,0 22889,1 22897,0 22936,1 22948,0 22978,1 23041,0 23058,1 23093,0 23118,1 23138,0 23212,1 23305,0 23345,1 23365,0 23372,1 23379,0 23434,1 23476,0 23565,1 23585,0 23619,1 23684,0 23688,1 23756,0 23851,1 23949,0 23972,1 24052,0 24111,1 24178,0 24239,1 24313,0 24348,1 24355,0 24396,1 24469,0 24532,1 24547,0 24624,1 24665,0 24737,1 24817,0 24820,1 24851,0 24907,1 24943,0 25030,1 25062,0 25118,1 25176,0 25233,1 25306,0 25314,1 25372,0 25416,1 25422,0 25495,1 25539,0 25545,1 25596,0 25673,1 25701,0 25794,1 25795,0 25861,1 25932,0 25938,1 25954,0 25963,1 25992,0 26017,1 26113,0 26143,1 26199,0 26206,1 26229,0 26301,1 26392,0 26450,1 26543,0 26552,1 26591,0 26664,1 26730,0 26811,1 26826,0 26866,1 26874,0 26930,1 27008,0 27057,1 27149,0 27209,1 27263,0 27335,1 27396,0 27493,1 27520,0 27555,1 27568,0 27668,1 27764,0 27814,1 27832,0 27927,1 27982,0 28067,1 28111,0 28195,1 28216,0 28227,1 28244,0 28250,1 28275,0 28285,1 28291,0 28341,1 28398,0 28496,1 28560,0 28619,1 28663,0 28665,1 28698,0 28771,1 28862,0 28863,1 28864,0 28866,1 28906,0 28987,1 28990,0 29078,1 29093,0 29140,1 29198,0 29209,1 29220,0 29275,1 29324,0 29386,1 29389,0 29460,1 29485,0 29551,1 29651,0 29726,1 29792,0 29864,1 29877,0 29878,1 29889,0 29945,1 29969,0 30030,1 30084,0 30141,1 30162,0 30262,1 30316,0 30416,1 30493,0 30527,1 30533,0 30583,1 30637,0 30681,1 30751,0 30782,1 30783,0 30842,1 30941,0 30967,1 31064,0 31078,1 31144,0 31153,1 31194,0 31196,1 31250,0 31271,1 31360,0 31413,1 31425,0 31445,1 31461,0 31488,1 31501,0 31561,1 31653,0 31739,1 31753,0 31763,1 31767,0 31801,1 31811,0 31813,1 31897,0 31955,1 32004,0 32041,1 32087,0 32183,1 32224,0 32267,1 32293,0 32322,1 32416,0 32418,1 32440,0 32526,1 32620,0 32692,1 32716,0 32776,1 32798,0 32840,1 32870,0 32897,1 32937,0 32950,1 32953,0 32971,1 33038,0 33040,1 33099,0 33145,1 33150,0 33221,1 33250,0 33276,1 33372,0 33458,1 33522,0 33553,1 33642,0 33646,1 33670,0 33724,1 33740,0 33776,1 33803,0 33818,1 33883,0 33958,1 34051,0 34071,1 34168,0 34175,1 34230,0 34267,1 34325,0 34337,1 34420,0 34476,1 34496,0 34514,1 34580,0 34635,1 34730,0 34809,1 34882,0 34939,1 34973,0 34988,1 35003,0 35054,1 35099,0 35112,1 35129,0 35195,1 35270,0 35358,1 35380,0 35425,1 35482,0 35541,1 35628,0 35685,1 35686,0 35732,1 35781,0 35844,1 35921,0 35955,1 35991,0 36068,1 36167,0 36243,1 36276,0 36309,1 36363,0 36451,1 36541,0 36607,1 36666,0 36730,1 36824,0 36907,1 36935,0 36988,1 37068,0 37111,1 37121,0 37122,1 37161,0 37227,1 37308,0 37339,1 37387,0 37445,1 37490,0 37532,1 37625,0 37651,1 37664,0 37731,1 37799,0 37808,1 37848,0 37892,1 37967,0 37992,1 38051,0 38103,1 38134,0 38163,1 38207,0 38271,1 38289,0 38352,1 38399,0 38478,1 38497,0 38577,1 38626,0 38673,1 38682,0 38701,1 38798,0 38893,1 38973,0 39036,1 39068,0 39082,1 39158,0 39172,1 39254,0 39324,1 39412,0 39440,1 39478,0 39489,1 39518,0 39617,1 39687,0 39715,1 39747,0 39761,1 39834,0 39879,1 39940,0 40008,1 40079,0 40151,1 40182,0 40261,1 40339,0 40361,1 40371,0 40471,1 40472,0 40539,1 40545,0 40595,1 40626,0 40682,1 40723,0 40745,1 40756,0 40800,1 40892,0 40954,1 40960,0 40970,1 41064,0 41087,1 41175,0 41179,1 41258,0 41297,1 41327,0 41333,1 41415,0 41512,1 41569,0 41597,1 41686,0 41770,1 41816,0 41832,1 41906,0 41919,1 41938,0 41961,1 41974,0 42053,1 42110,0 42163,1 42222,0 42291,1 42324,0 42365,1 42379,0 42449,1 42529,0 42575,1 42640,0 42642,1 42695,0 42769,1 42866,0 42870,1 42890,0 42988,1 43088,0 43110,1 43173,0 43183,1 43193,0 43195,1 43238,0 43247,1 43346,0 43359,1 43431,0 43457,1 43494,0 43515,1 43596,0 43648,1 43714,0 43722,1 43820,0 43897,1 43962,0 43979,1 44021,0 44103,1 44190,0 44236,1 44264,0 44299,1 44391,0 44437,1 44478,0 44562,1 44626,0 44700,1 44723,0 44747,1 44789,0 44853,1 44868,0 44920,1 44938,0 45037,1 45078,0 45172,1 45209,0 45266,1 45306,0 45315,1 45348,0 45443,1 45504,0 45592,1 45630,0 45658,1 45741,0 45760,1 45764,0 45857,1 45876,0 45916,1 45935,0 46013,1 46105,0 46109,1 46181,0 46193,1 46206,0 46280,1 46315,0 46386,1 46440,0 46508,1 46589,0 46683,1 46687,0 46739,1 46750,0 46813,1 46903,0 46995,1 47084,0 47156,1 47250,0 47335,1 47336,0 47382,1 47467,0 47505,1 47537,0 47600,1 47679,0 47735,1 47742,0 47783,1 end initlist a10 0,0 30,1 40,0 121,1 142,0 209,1 236,0 268,1 349,0 368,1 413,0 503,1 578,0 652,1 667,0 761,1 809,0 855,1 918,0 1002,1 1097,0 1166,1 1219,0 1276,1 1327,0 1371,1 1415,0 1440,1 1518,0 1574,1 1660,0 1760,1 1803,0 1861,1 1881,0 1944,1 2041,0 2135,1 2197,0 2242,1 2318,0 2359,1 2398,0 2446,1 2541,0 2549,1 2606,0 2610,1 2709,0 2780,1 2789,0 2796,1 2876,0 2945,1 3001,0 3091,1 3094,0 3110,1 3168,0 3230,1 3322,0 3338,1 3340,0 3402,1 3416,0 3493,1 3523,0 3586,1 3640,0 3683,1 3718,0 3767,1 3849,0 3900,1 3973,0 4032,1 4080,0 4100,1 4120,0 4194,1 4262,0 4315,1 4375,0 4408,1 4504,0 4575,1 4652,0 4727,1 4761,0 4858,1 4878,0 4908,1 4917,0 4928,1 4964,0 4965,1 5009,0 5061,1 5114,0 5208,1 5232,0 5297,1 5317,0 5378,1 5440,0 5537,1 5590,0 5634,1 5662,0 5723,1 5822,0 5842,1 5908,0 5936,1 5983,0 6023,1 6095,0 6145,1 6211,0 6298,1 6362,0 6389,1 6428,0 6455,1 6553,0 6586,1 6665,0 6714,1 6756,0 6806,1 6823,0 6859,1 6937,0 6965,1 7028,0 7070,1 7121,0 7202,1 7271,0 7281,1 7318,0 7322,1 7392,0 7398,1 7400,0 7490,1 7547,0 7591,1 7648,0 7711,1 7739,0 7795,1 7865,0 7902,1 7955,0 8019,1 8114,0 8210,1 8253,0 8320,1 8390,0 8483,1 8558,0 8628,1 8667,0 8691,1 8716,0 8790,1 8877,0 8963,1 8983,0 9009,1 9089,0 9186,1 9283,0 9328,1 9352,0 9405,1 9426,0 9434,1 9520,0 9570,1 9584,0 9619,1 9701,0 9709,1 9746,0 9829,1 9847,0 9864,1 9892,0 9896,1 9902,0 9980,1 10074,0 10096,1 10113,0 10145,1 10175,0 10245,1 10313,0 10338,1 10358,0 10423,1 10433,0 10454,1 10531,0 10612,1 10627,0 10721,1 10820,0 10887,1 10893,0 10908,1 10962,0 10970,1 10994,0 11071,1 11085,0 11157,1 11201,0 11222,1 11281,0 11356,1 11435,0 11456,1 11502,0 11542,1 11575,0 11651,1 11746,0 11802,1 11807,0 11883,1 11918,0 11960,1 12023,0 12041,1 12110,0 12138,1 12223,0 12272,1 12277,0 12304,1 12308,0 12334,1 12424,0 12432,1 12514,0 12573,1 12602,0 12608,1 12626,0 12668,1 12686,0 12695,1 12726,0 12784,1 12859,0 12931,1 13001,0 13034,1 13116,0 13196,1 13204,0 13244,1 13333,0 13357,1 13397,0 13415,1 13469,0 13551,1 13561,0 13654,1 13674,0 13762,1 13861,0 13950,1 14007,0 14092,1 14121,0 14136,1 14149,0 14222,1 14242,0 14295,1 14345,0 14346,1 14398,0 14469,1 14545,0 14637,1 14644,0 14682,1 14701,0 14801,1 14868,0 14958,1 14971,0 15008,1 15088,0 15126,1 15214,0 15296,1 15375,0 15448,1 15495,0 15525,1 15555,0 15608,1 15667,0 15742,1 15807,0 15836,1 15846,0 15878,1 15939,0 16029,1 16095,0 16130,1 16177,0 16257,1 16293,0 16311,1 16399,0 16439,1 16481,0 16580,1 16640,0 16679,1 16739,0 16778,1 16861,0 16951,1 17034,0 17090,1 17178,0 17199,1 17263,0 17289,1 17297,0 17376,1 17472,0 17493,1 17510,0 17551,1 17556,0 17615,1 17653,0 17654,1 17671,0 17691,1 17761,0 17815,1 17817,0 17891,1 17956,0 18013,1 18028,0 18106,1 18163,0 18258,1 18310,0 18403,1 18423,0 18469,1 18543,0 18553,1 18586,0 18603,1 18607,0 18627,1 18705,0 18743,1 18825,0 18923,1 18975,0 19055,1 19059,0 19077,1 19092,0 19189,1 19262,0 19354,1 19440,0 19525,1 19529,0 19582,1 19662,0 19740,1 19811,0 19880,1 19944,0 19985,1 19997,0 20005,1 20097,0 20112,1 20133,0 20136,1 20189,0 20236,1 20276,0 20309,1 20336,0 20419,1 20434,0 20520,1 20580,0 20639,1 20658,0 20683,1 20756,0 20777,1 20834,0 20861,1 20875,0 20958,1 21057,0 21083,1 21109,0 21173,1 21190,0 21224,1 21267,0 21270,1 21282,0 21362,1 21442,0 21534,1 21632,0 21695,1 21775,0 21871,1 21875,0 21911,1 21917,0 21959,1 22007,0 22057,1 22097,0 22169,1 22175,0 22209,1 22283,0 22306,1 22405,0 22425,1 22514,0 22554,1 22636,0 22673,1 22712,0 22812,1 22886,0 22972,1 23056,0 23094,1 23109,0 23204,1 23246,0 23345,1 23361,0 23452,1 23480,0 23520,1 23615,0 23654,1 23663,0 23753,1 23846,0 23912,1 23966,0 24007,1 24014,0 24032,1 24132,0 24184,1 24224,0 24306,1 24405,0 24411,1 24420,0 24477,1 24549,0 24593,1 24670,0 24759,1 24816,0 24823,1 24852,0 24891,1 24896,0 24903,1 24928,0 24938,1 25032,0 25108,1 25144,0 25204,1 25259,0 25299,1 25342,0 25397,1 25490,0 25569,1 25616,0 25690,1 25700,0 25749,1 25799,0 25894,1 25946,0 25988,1 26077,0 26100,1 26200,0 26225,1 26236,0 26319,1 26320,0 26405,1 26459,0 26530,1 26624,0 26679,1 26741,0 26837,1 26838,0 26889,1 26903,0 26910,1 26938,0 26944,1 26965,0 27032,1 27040,0 27137,1 27166,0 27181,1 27240,0 27311,1 27322,0 27407,1 27424,0 27503,1 27598,0 27629,1 27637,0 27677,1 27681,0 27767,1 27773,0 27808,1 27855,0 27949,1 28013,0 28052,1 28124,0 28173,1 28221,0 28243,1 28306,0 28340,1 28367,0 28466,1 28506,0 28567,1 28616,0 28641,1 28728,0 28824,1 28874,0 28972,1 29070,0 29131,1 29219,0 29270,1 29301,0 29317,1 29330,0 29428,1 29479,0 29505,1 29534,0 29561,1 29634,0 29727,1 29799,0 29807,1 29877,0 29942,1 29944,0 29967,1 30011,0 30029,1 30092,0 30180,1 30183,0 30233,1 30308,0 30388,1 30435,0 30457,1 30496,0 30578,1 30605,0 30673,1 30698,0 30748,1 30775,0 30861,1 30920,0 30990,1 31004,0 31050,1 31149,0 31180,1 31258,0 31337,1 31377,0 31398,1 31489,0 31519,1 31618,0 31683,1 31739,0 31747,1 31826,0 31912,1 31918,0 31949,1 32013,0 32061,1 32090,0 32176,1 32252,0 32331,1 32350,0 32446,1 32465,0 32502,1 32594,0 32640,1 32694,0 32769,1 32804,0 32842,1 32901,0 32939,1 32987,0 33077,1 33147,0 33165,1 33229,0 33243,1 33334,0 33362,1 33409,0 33496,1 33504,0 33519,1 33603,0 33687,1 33688,0 33699,1 33763,0 33764,1 33861,0 33879,1 33885,0 33905,1 33942,0 34024,1 34109,0 34183,1 34266,0 34347,1 34370,0 34426,1 34526,0 34592,1 34680,0 34779,1 34827,0 34880,1 34965,0 34971,1 35065,0 35069,1 35129,0 35146,1 35197,0 35289,1 35340,0 35401,1 35467,0 35556,1 35614,0 35661,1 35713,0 35771,1 35838,0 35926,1 36013,0 36077,1 36132,0 36213,1 36263,0 36301,1 36375,0 36426,1 36453,0 36544,1 36629,0 36716,1 36806,0 36841,1 36851,0 36884,1 36969,0 36992,1 37065,0 37158,1 37164,0 37249,1 37349,0 37379,1 37474,0 37501,1 37568,0 37591,1 37682,0 37761,1 37769,0 37802,1 37862,0 37952,1 38044,0 38075,1 38088,0 38111,1 38158,0 38244,1 38259,0 38323,1 38325,0 38337,1 38424,0 38452,1 38495,0 38514,1 38519,0 38547,1 38627,0 38704,1 38710,0 38807,1 38892,0 38916,1 38963,0 38964,1 38976,0 38987,1 39060,0 39118,1 39180,0 39229,1 39328,0 39417,1 39464,0 39512,1 39546,0 39573,1 39646,0 39726,1 39732,0 39785,1 39826,0 39877,1 39969,0 40043,1 40101,0 40136,1 40139,0 40179,1 40240,0 40284,1 40295,0 40319,1 40378,0 40419,1 40455,0 40515,1 40528,0 40570,1 40616,0 40703,1 40743,0 40817,1 40858,0 40866,1 40934,0 41002,1 41027,0 41071,1 41108,0 41130,1 41221,0 41286,1 41331,0 41367,1 41369,0 41430,1 41529,0 41622,1 41712,0 41774,1 41869,0 41876,1 41886,0 41924,1 41932,0 41973,1 42047,0 42138,1 42203,0 42283,1 42325,0 42397,1 42402,0 42450,1 42538,0 42633,1 42637,0 42729,1 42750,0 42756,1 42828,0 42849,1 42876,0 42880,1 42951,0 43010,1 43091,0 43109,1 43130,0 43147,1 43183,0 43272,1 43335,0 43393,1 43468,0 43506,1 43540,0 43541,1 43628,0 43660,1 43687,0 43786,1 43830,0 43901,1 43989,0 44066,1 44114,0 44194,1 44211,0 44294,1 44324,0 44342,1 44380,0 44407,1 44458,0 44459,1 44556,0 44636,1 44719,0 44778,1 44796,0 44864,1 44937,0 44977,1 45069,0 45148,1 45175,0 45202,1 45231,0 45301,1 45325,0 45409,1 45461,0 45549,1 45620,0 45637,1 45665,0 45734,1 45740,0 45782,1 45851,0 45906,1 45925,0 45970,1 45986,0 46064,1 46084,0 46166,1 46167,0 46260,1 46271,0 46317,1 46390,0 46440,1 46484,0 46485,1 46578,0 46656,1 46710,0 46781,1 46881,0 46955,1 47008,0 47097,1 47131,0 47175,1 47209,0 47285,1 47352,0 47426,1 47494,0 47572,1 47596,0 47607,1 47693,0 47785,1 47857,0 47889,1 47938,0 47945,1 48022,0 48027,1 48109,0 48119,1 48128,0 48182,1 48237,0 48337,1 48371,0 48462,1 48502,0 48572,1 48670,0 48696,1 48743,0 48748,1 48848,0 48939,1 48946,0 49045,1 49097,0 49195,1 49230,0 49278,1 49287,0 49366,1 49417,0 49454,1 49508,0 49521,1 49602,0 49651,1 49674,0 49738,1 49758,0 49842,1 49909,0 50006,1 50083,0 50164,1 50172,0 50179,1 50225,0 50233,1 50312,0 50400,1 50452,0 50494,1 50504,0 50595,1 50667,0 50762,1 50767,0 50797,1 50838,0 50876,1 50973,0 51059,1 51104,0 51164,1 51210,0 51257,1 51304,0 51352,1 end initlist a11 0,0 57,1 61,0 121,1 218,0 280,1 281,0 328,1 340,0 384,1 447,0 449,1 478,0 555,1 583,0 636,1 734,0 737,1 818,0 899,1 910,0 998,1 1026,0 1058,1 1145,0 1201,1 1238,0 1251,1 1278,0 1335,1 1352,0 1418,1 1510,0 1529,1 1577,0 1661,1 1741,0 1832,1 1883,0 1904,1 2001,0 2002,1 2066,0 2117,1 2201,0 2217,1 2258,0 2272,1 2323,0 2383,1 2478,0 2564,1 2592,0 2638,1 2663,0 2670,1 2703,0 2717,1 2749,0 2765,1 2827,0 2907,1 3003,0 3029,1 3112,0 3203,1 3214,0 3270,1 3305,0 3310,1 3320,0 3347,1 3367,0 3383,1 3447,0 3453,1 3454,0 3478,1 3540,0 3563,1 3623,0 3629,1 3651,0 3739,1 3795,0 3841,1 3937,0 4027,1 4052,0 4135,1 4220,0 4270,1 4350,0 4415,1 4428,0 4440,1 4473,0 4479,1 4547,0 4549,1 4560,0 4596,1 4599,0 4668,1 4755,0 4784,1 4861,0 4917,1 4948,0 5035,1 5069,0 5075,1 5093,0 5116,1 5163,0 5223,1 5285,0 5367,1 5410,0 5492,1 5551,0 5562,1 5646,0 5704,1 5713,0 5788,1 5872,0 5884,1 5922,0 6000,1 6031,0 6111,1 6154,0 6247,1 6305,0 6333,1 6348,0 6407,1 6463,0 6547,1 6567,0 6577,1 6655,0 6702,1 6710,0 6731,1 6749,0 6831,1 6917,0 7003,1 7044,0 7073,1 7143,0 7233,1 7279,0 7343,1 7409,0 7465,1 7546,0 7620,1 7702,0 7713,1 7792,0 7793,1 7798,0 7897,1 7924,0 7942,1 8040,0 8105,1 8193,0 8237,1 8283,0 8301,1 8321,0 8402,1 8421,0 8521,1 8529,0 8581,1 8668,0 8671,1 8770,0 8839,1 8893,0 8979,1 9005,0 9102,1 9132,0 9217,1 9293,0 9328,1 9349,0 9393,1 9493,0 9528,1 9551,0 9568,1 9617,0 9659,1 9695,0 9748,1 9818,0 9850,1 9941,0 9999,1 10007,0 10093,1 10155,0 10229,1 10327,0 10335,1 10417,0 10492,1 10581,0 10592,1 10640,0 10669,1 10678,0 10717,1 10784,0 10823,1 10829,0 10929,1 10930,0 10995,1 11087,0 11157,1 11253,0 11255,1 11257,0 11349,1 11389,0 11459,1 11550,0 11581,1 11661,0 11704,1 11798,0 11851,1 11900,0 11903,1 11959,0 11989,1 12010,0 12092,1 12174,0 12251,1 12287,0 12315,1 12374,0 12438,1 12485,0 12517,1 12537,0 12543,1 12591,0 12647,1 12714,0 12774,1 12858,0 12902,1 12996,0 13053,1 13142,0 13182,1 13184,0 13235,1 13279,0 13283,1 13291,0 13347,1 13410,0 13474,1 13508,0 13557,1 13600,0 13691,1 13751,0 13832,1 13844,0 13886,1 13946,0 14044,1 14062,0 14143,1 14196,0 14215,1 14314,0 14339,1 14359,0 14375,1 14377,0 14420,1 14467,0 14548,1 14623,0 14716,1 14808,0 14835,1 14895,0 14972,1 15063,0 15157,1 15158,0 15199,1 15262,0 15298,1 15372,0 15447,1 15475,0 15552,1 15625,0 15702,1 15798,0 15866,1 15940,0 15978,1 16053,0 16079,1 16080,0 16131,1 16132,0 16231,1 16308,0 16380,1 16395,0 16410,1 16505,0 16539,1 16579,0 16607,1 16620,0 16713,1 16740,0 16782,1 16789,0 16846,1 16919,0 16922,1 16930,0 16960,1 16965,0 16996,1 17063,0 17100,1 17139,0 17219,1 17289,0 17337,1 17404,0 17463,1 17515,0 17538,1 17586,0 17632,1 17654,0 17724,1 17816,0 17839,1 17867,0 17967,1 18061,0 18080,1 18111,0 18129,1 18153,0 18216,1 18283,0 18299,1 18396,0 18470,1 18496,0 18553,1 18569,0 18646,1 18717,0 18721,1 18794,0 18874,1 18916,0 18995,1 19072,0 19086,1 19098,0 19195,1 19219,0 19317,1 19376,0 19399,1 19466,0 19559,1 19623,0 19686,1 19693,0 19722,1 19766,0 19850,1 19852,0 19889,1 19898,0 19997,1 20005,0 20087,1 20090,0 20144,1 20206,0 20295,1 20319,0 20394,1 20412,0 20457,1 20527,0 20601,1 20700,0 20795,1 20845,0 20882,1 20905,0 20978,1 21047,0 21126,1 21187,0 21277,1 21294,0 21315,1 21325,0 21406,1 21425,0 21499,1 21532,0 21582,1 21641,0 21696,1 21742,0 21766,1 21809,0 21878,1 21969,0 21999,1 22090,0 22107,1 22204,0 22260,1 22304,0 22377,1 22405,0 22469,1 22536,0 22618,1 22686,0 22710,1 22796,0 22844,1 22944,0 22960,1 23049,0 23077,1 23115,0 23136,1 23155,0 23253,1 23328,0 23427,1 23521,0 23581,1 23645,0 23688,1 23701,0 23759,1 23803,0 23838,1 23919,0 24011,1 24014,0 24017,1 24094,0 24154,1 24206,0 24218,1 24276,0 24365,1 24447,0 24499,1 24517,0 24554,1 24646,0 24661,1 24678,0 24702,1 24797,0 24808,1 24839,0 24857,1 24928,0 24982,1 25047,0 25110,1 25183,0 25262,1 25264,0 25270,1 25279,0 25334,1 25426,0 25518,1 25525,0 25599,1 25614,0 25697,1 25701,0 25728,1 25768,0 25783,1 25841,0 25848,1 25869,0 25935,1 25962,0 26048,1 26120,0 26211,1 26286,0 26310,1 26331,0 26406,1 26443,0 26484,1 26491,0 26590,1 26599,0 26632,1 26707,0 26765,1 26808,0 26850,1 26872,0 26916,1 26982,0 27050,1 27149,0 27241,1 27301,0 27400,1 27421,0 27485,1 27576,0 27610,1 27696,0 27725,1 27803,0 27841,1 27884,0 27902,1 27913,0 28006,1 28071,0 28129,1 28138,0 28219,1 28239,0 28338,1 28427,0 28437,1 28492,0 28505,1 28513,0 28607,1 28701,0 28732,1 28803,0 28805,1 28830,0 28885,1 28981,0 28992,1 29039,0 29109,1 29128,0 29141,1 29225,0 29250,1 29285,0 29332,1 29401,0 29490,1 29584,0 29663,1 29666,0 29735,1 29829,0 29872,1 29921,0 29975,1 30072,0 30141,1 30241,0 30257,1 30325,0 30364,1 30416,0 30490,1 30589,0 30625,1 30676,0 30765,1 30850,0 30919,1 30994,0 31053,1 31071,0 31118,1 31149,0 31186,1 31217,0 31290,1 31350,0 31426,1 31436,0 31513,1 31573,0 31617,1 31682,0 31748,1 31759,0 31842,1 31898,0 31951,1 31960,0 31983,1 31990,0 32075,1 32146,0 32187,1 32189,0 32279,1 32285,0 32357,1 32425,0 32444,1 32474,0 32511,1 32520,0 32557,1 32563,0 32650,1 32658,0 32720,1 32784,0 32853,1 32904,0 32953,1 32956,0 33014,1 33080,0 33166,1 33211,0 33267,1 33297,0 33332,1 33352,0 33424,1 33428,0 33430,1 33473,0 33479,1 33574,0 33663,1 33708,0 33778,1 33823,0 33825,1 33919,0 33975,1 33999,0 34006,1 34088,0 34119,1 34189,0 34199,1 34220,0 34309,1 34352,0 34446,1 34505,0 34597,1 34660,0 34689,1 34787,0 34806,1 34818,0 34843,1 34881,0 34889,1 34916,0 34986,1 35053,0 35095,1 35190,0 35278,1 35280,0 35319,1 35369,0 35468,1 35533,0 35545,1 35621,0 35643,1 35667,0 35706,1 35786,0 35811,1 35876,0 35930,1 35982,0 36023,1 36091,0 36175,1 36275,0 36292,1 36321,0 36394,1 36440,0 36453,1 36509,0 36531,1 36623,0 36691,1 36711,0 36775,1 36821,0 36849,1 36947,0 36998,1 37055,0 37065,1 37125,0 37143,1 37233,0 37281,1 37370,0 37371,1 37411,0 37444,1 37463,0 37496,1 37596,0 37684,1 37686,0 37724,1 37734,0 37774,1 37839,0 37894,1 37919,0 37979,1 37989,0 38045,1 38080,0 38099,1 38136,0 38235,1 38335,0 38417,1 38456,0 38545,1 38591,0 38617,1 38705,0 38711,1 38753,0 38759,1 38854,0 38884,1 38901,0 38996,1 39023,0 39053,1 39112,0 39165,1 39176,0 39196,1 39213,0 39248,1 39306,0 39380,1 39413,0 39442,1 39460,0 39463,1 39508,0 39585,1 39645,0 39661,1 39743,0 39764,1 39835,0 39901,1 39919,0 39953,1 40009,0 40018,1 40074,0 40151,1 40250,0 40346,1 40397,0 40462,1 40544,0 40621,1 40688,0 40767,1 40812,0 40824,1 40829,0 40858,1 40859,0 40913,1 40977,0 41047,1 41101,0 41184,1 41203,0 41283,1 41294,0 41370,1 41382,0 41450,1 41478,0 41496,1 41567,0 41578,1 41636,0 41710,1 41719,0 41808,1 41844,0 41878,1 41892,0 41945,1 42044,0 42098,1 42104,0 42151,1 42244,0 42299,1 42375,0 42475,1 42524,0 42544,1 42615,0 42647,1 42666,0 42679,1 42754,0 42788,1 42810,0 42853,1 42869,0 42954,1 42984,0 42997,1 43002,0 43061,1 43149,0 43194,1 43287,0 43348,1 43412,0 43418,1 43461,0 43502,1 43577,0 43583,1 43596,0 43641,1 43644,0 43686,1 43756,0 43855,1 43948,0 43950,1 43957,0 43997,1 44032,0 44087,1 44170,0 44234,1 44324,0 44343,1 44429,0 44466,1 44551,0 44592,1 44607,0 44632,1 44669,0 44753,1 44843,0 44873,1 44958,0 44988,1 45016,0 45105,1 45202,0 45301,1 45350,0 45397,1 45421,0 45432,1 45507,0 45583,1 45624,0 45703,1 45794,0 45887,1 45917,0 45970,1 46027,0 46029,1 46128,0 46162,1 46193,0 46284,1 46316,0 46337,1 46431,0 46489,1 46512,0 46575,1 46673,0 46703,1 46763,0 46818,1 46894,0 46899,1 46937,0 47006,1 47007,0 47045,1 47062,0 47141,1 47145,0 47229,1 47284,0 47319,1 47381,0 47416,1 47482,0 47530,1 47597,0 47637,1 47694,0 47756,1 47837,0 47932,1 48018,0 48096,1 48126,0 48185,1 48280,0 48371,1 48443,0 48506,1 48602,0 48620,1 48646,0 48651,1 48751,0 48761,1 48803,0 48865,1 48962,0 49042,1 49104,0 49189,1 49277,0 49344,1 49409,0 49443,1 49486,0 49578,1 49588,0 49603,1 49703,0 49803,1 49883,0 49974,1 50010,0 50060,1 50074,0 50136,1 50203,0 50220,1 50235,0 50246,1 50290,0 50320,1 50366,0 50395,1 50440,0 50495,1 end initlist a12 0,0 23,1 34,0 79,1 127,0 194,1 214,0 295,1 388,0 407,1 450,0 495,1 521,0 618,1 683,0 704,1 763,0 789,1 793,0 827,1 885,0 926,1 932,0 973,1 1028,0 1119,1 1166,0 1216,1 1271,0 1340,1 1394,0 1468,1 1564,0 1594,1 1627,0 1669,1 1761,0 1842,1 1942,0 2007,1 2024,0 2046,1 2119,0 2189,1 2254,0 2261,1 2278,0 2330,1 2356,0 2370,1 2443,0 2483,1 2491,0 2513,1 2563,0 2613,1 2616,0 2694,1 2779,0 2809,1 2830,0 2856,1 2917,0 3009,1 3104,0 3166,1 3253,0 3336,1 3364,0 3445,1 3490,0 3505,1 3601,0 3632,1 3667,0 3671,1 3718,0 3772,1 3811,0 3894,1 3933,0 3945,1 3994,0 4055,1 4109,0 4195,1 4258,0 4343,1 4415,0 4462,1 4492,0 4586,1 4599,0 4607,1 4705,0 4726,1 4765,0 4844,1 4852,0 4858,1 4958,0 5000,1 5054,0 5066,1 5129,0 5215,1 5220,0 5285,1 5370,0 5383,1 5413,0 5440,1 5472,0 5516,1 5556,0 5598,1 5695,0 5696,1 5764,0 5818,1 5824,0 5907,1 5974,0 6065,1 6069,0 6098,1 6194,0 6196,1 6280,0 6354,1 6390,0 6395,1 6446,0 6512,1 6533,0 6590,1 6639,0 6647,1 6702,0 6703,1 6792,0 6863,1 6940,0 6965,1 7054,0 7064,1 7090,0 7143,1 7184,0 7259,1 7320,0 7335,1 7366,0 7396,1 7443,0 7451,1 7519,0 7535,1 7623,0 7667,1 7703,0 7719,1 7755,0 7812,1 7907,0 7922,1 8000,0 8093,1 8155,0 8193,1 8196,0 8261,1 8347,0 8382,1 8424,0 8521,1 8592,0 8602,1 8615,0 8643,1 8728,0 8812,1 8886,0 8934,1 9003,0 9085,1 9102,0 9189,1 9222,0 9223,1 9294,0 9355,1 9388,0 9392,1 9483,0 9514,1 9542,0 9636,1 9723,0 9805,1 9875,0 9924,1 9958,0 9983,1 9992,0 10048,1 10067,0 10096,1 10153,0 10162,1 10226,0 10324,1 10402,0 10478,1 10503,0 10505,1 10507,0 10591,1 10632,0 10726,1 10736,0 10777,1 10853,0 10907,1 10965,0 10973,1 11064,0 11080,1 11127,0 11170,1 11231,0 11316,1 11348,0 11353,1 11393,0 11461,1 11553,0 11570,1 11592,0 11606,1 11653,0 11748,1 11811,0 11891,1 11991,0 11996,1 12000,0 12068,1 12161,0 12162,1 12232,0 12245,1 12312,0 12347,1 12432,0 12515,1 12561,0 12578,1 12661,0 12684,1 12687,0 12756,1 12787,0 12886,1 12928,0 13018,1 13045,0 13074,1 13097,0 13134,1 13182,0 13199,1 13287,0 13376,1 13438,0 13497,1 13514,0 13549,1 13599,0 13638,1 13685,0 13767,1 13769,0 13858,1 13936,0 14017,1 14065,0 14151,1 14188,0 14249,1 14273,0 14285,1 14353,0 14445,1 14485,0 14579,1 14596,0 14674,1 14717,0 14739,1 14748,0 14787,1 14847,0 14857,1 14916,0 14963,1 15023,0 15040,1 15091,0 15168,1 15233,0 15333,1 15387,0 15478,1 15570,0 15654,1 15670,0 15682,1 15732,0 15819,1 15834,0 15894,1 15991,0 16088,1 16117,0 16151,1 16240,0 16257,1 16351,0 16434,1 16510,0 16598,1 16603,0 16637,1 16688,0 16703,1 16781,0 16789,1 16848,0 16921,1 16955,0 16958,1 16969,0 17061,1 17110,0 17151,1 17195,0 17199,1 17221,0 17310,1 17393,0 17440,1 17524,0 17561,1 17589,0 17651,1 17652,0 17667,1 17674,0 17762,1 17842,0 17886,1 17954,0 18004,1 18047,0 18108,1 18139,0 18168,1 18237,0 18276,1 18333,0 18386,1 18459,0 18542,1 18597,0 18606,1 18665,0 18756,1 18820,0 18847,1 18863,0 18928,1 18987,0 18999,1 19048,0 19099,1 19161,0 19230,1 19298,0 19300,1 19372,0 19427,1 19429,0 19522,1 19622,0 19706,1 19732,0 19787,1 19879,0 19927,1 19981,0 20002,1 20022,0 20099,1 20191,0 20196,1 20286,0 20367,1 20442,0 20491,1 20583,0 20677,1 20766,0 20768,1 20803,0 20896,1 20916,0 20924,1 20968,0 21042,1 21077,0 21127,1 21179,0 21241,1 21257,0 21312,1 21412,0 21506,1 21543,0 21614,1 21704,0 21783,1 21880,0 21923,1 22013,0 22096,1 22193,0 22204,1 22208,0 22285,1 22293,0 22322,1 22410,0 22427,1 22456,0 22526,1 22606,0 22657,1 22681,0 22765,1 22823,0 22848,1 22867,0 22878,1 22889,0 22949,1 22964,0 22995,1 23004,0 23016,1 23114,0 23135,1 23150,0 23203,1 23285,0 23307,1 23369,0 23424,1 23439,0 23465,1 23496,0 23589,1 23650,0 23675,1 23683,0 23724,1 23759,0 23849,1 23893,0 23911,1 23954,0 23979,1 24055,0 24136,1 24178,0 24210,1 24229,0 24258,1 24353,0 24368,1 24448,0 24535,1 24582,0 24662,1 24740,0 24753,1 24793,0 24832,1 24842,0 24940,1 24987,0 25083,1 25125,0 25198,1 25295,0 25330,1 25351,0 25374,1 25437,0 25499,1 25581,0 25592,1 25648,0 25715,1 25769,0 25777,1 25847,0 25855,1 25890,0 25950,1 25965,0 26061,1 26099,0 26114,1 26179,0 26185,1 26258,0 26278,1 26279,0 26287,1 26371,0 26383,1 26388,0 26408,1 26433,0 26439,1 26458,0 26459,1 26490,0 26561,1 26619,0 26656,1 26725,0 26811,1 26824,0 26845,1 26890,0 26984,1 27030,0 27072,1 27168,0 27197,1 27224,0 27316,1 27374,0 27422,1 27448,0 27471,1 27541,0 27568,1 27581,0 27625,1 27662,0 27680,1 27740,0 27837,1 27933,0 27985,1 28025,0 28121,1 28151,0 28240,1 28263,0 28338,1 28416,0 28511,1 28514,0 28600,1 28664,0 28704,1 28778,0 28829,1 28900,0 28941,1 29030,0 29092,1 29109,0 29153,1 29251,0 29267,1 29345,0 29407,1 29480,0 29556,1 29598,0 29673,1 29742,0 29796,1 29806,0 29858,1 29932,0 29963,1 30015,0 30109,1 30173,0 30216,1 30261,0 30332,1 30398,0 30427,1 30486,0 30566,1 30570,0 30644,1 30672,0 30740,1 30792,0 30854,1 30917,0 30919,1 30968,0 31065,1 31101,0 31196,1 31219,0 31281,1 31316,0 31371,1 31398,0 31498,1 31598,0 31664,1 31677,0 31692,1 31766,0 31799,1 31883,0 31889,1 31985,0 32001,1 32090,0 32175,1 32213,0 32276,1 32327,0 32367,1 32430,0 32476,1 32510,0 32581,1 32634,0 32669,1 32699,0 32779,1 32859,0 32861,1 32929,0 32965,1 33003,0 33016,1 33097,0 33158,1 33166,0 33260,1 33282,0 33303,1 33305,0 33374,1 33421,0 33473,1 33540,0 33571,1 33622,0 33655,1 33665,0 33738,1 33767,0 33794,1 33842,0 33923,1 33981,0 34046,1 34055,0 34082,1 34130,0 34150,1 34182,0 34201,1 34257,0 34325,1 34346,0 34347,1 34420,0 34457,1 34506,0 34524,1 34550,0 34564,1 34576,0 34652,1 34742,0 34751,1 34829,0 34860,1 34915,0 34996,1 35064,0 35072,1 35087,0 35165,1 35193,0 35194,1 35281,0 35343,1 35390,0 35415,1 35426,0 35499,1 35568,0 35659,1 35732,0 35786,1 35822,0 35912,1 35971,0 36006,1 36079,0 36115,1 36129,0 36216,1 36292,0 36385,1 36391,0 36395,1 36399,0 36409,1 36505,0 36544,1 36642,0 36740,1 36764,0 36788,1 36834,0 36856,1 36874,0 36877,1 36896,0 36920,1 37002,0 37014,1 37029,0 37037,1 37042,0 37054,1 37146,0 37180,1 37222,0 37261,1 37316,0 37337,1 37362,0 37413,1 37450,0 37544,1 37619,0 37625,1 37724,0 37821,1 37853,0 37950,1 37975,0 38060,1 38083,0 38129,1 38152,0 38216,1 38291,0 38313,1 38345,0 38426,1 38512,0 38577,1 38581,0 38627,1 38645,0 38664,1 38667,0 38703,1 38784,0 38825,1 38904,0 38959,1 39025,0 39064,1 39140,0 39154,1 39228,0 39241,1 39264,0 39317,1 39404,0 39483,1 39563,0 39594,1 39641,0 39697,1 39749,0 39823,1 39882,0 39925,1 40002,0 40018,1 40052,0 40062,1 40143,0 40226,1 40229,0 40274,1 40350,0 40411,1 40436,0 40448,1 40500,0 40501,1 40508,0 40572,1 40601,0 40694,1 40711,0 40739,1 40751,0 40812,1 40858,0 40881,1 40898,0 40901,1 40958,0 40971,1 41024,0 41027,1 41124,0 41188,1 41223,0 41280,1 41380,0 41471,1 41533,0 41556,1 41591,0 41626,1 41702,0 41750,1 41762,0 41810,1 41829,0 41882,1 41979,0 42067,1 42151,0 42224,1 42313,0 42384,1 42441,0 42500,1 42592,0 42616,1 42655,0 42731,1 42732,0 42785,1 42832,0 42920,1 42970,0 43038,1 43039,0 43101,1 43120,0 43215,1 43249,0 43252,1 43253,0 43331,1 43350,0 43425,1 43524,0 43558,1 43562,0 43573,1 43644,0 43689,1 43730,0 43744,1 43750,0 43835,1 43858,0 43925,1 43961,0 43965,1 44043,0 44057,1 44077,0 44141,1 44228,0 44322,1 44345,0 44371,1 44440,0 44522,1 44550,0 44595,1 44614,0 44616,1 44657,0 44693,1 44748,0 44761,1 44822,0 44920,1 44962,0 45007,1 45087,0 45166,1 45216,0 45283,1 45352,0 45427,1 45510,0 45561,1 45648,0 45691,1 45777,0 45848,1 45896,0 45967,1 45971,0 46020,1 46042,0 46071,1 46119,0 46129,1 46164,0 46220,1 46292,0 46316,1 46373,0 46429,1 46507,0 46549,1 46555,0 46635,1 46689,0 46768,1 46860,0 46891,1 46894,0 46952,1 46995,0 47044,1 47128,0 47218,1 47228,0 47275,1 47351,0 47426,1 47491,0 47550,1 47564,0 47613,1 47639,0 47738,1 47778,0 47843,1 47874,0 47880,1 47930,0 47933,1 47973,0 48006,1 48023,0 48079,1 48150,0 48239,1 48242,0 48304,1 48340,0 48385,1 48402,0 48441,1 48471,0 48551,1 48583,0 48657,1 48686,0 48755,1 48834,0 48854,1 48900,0 48916,1 48959,0 49016,1 49019,0 49061,1 end initlist a13 0,0 36,1 100,0 126,1 198,0 203,1 272,0 329,1 397,0 457,1 473,0 512,1 586,0 677,1 748,0 760,1 783,0 841,1 881,0 950,1 1025,0 1039,1 1040,0 1058,1 1119,0 1167,1 1214,0 1264,1 1275,0 1286,1 1350,0 1384,1 1460,0 1550,1 1578,0 1611,1 1693,0 1750,1 1783,0 1842,1 1916,0 1976,1 1991,0 2011,1 2098,0 2143,1 2227,0 2265,1 2359,0 2424,1 2517,0 2540,1 2615,0 2640,1 2657,0 2694,1 2792,0 2866,1 2910,0 2927,1 3014,0 3040,1 3089,0 3177,1 3276,0 3375,1 3454,0 3527,1 3551,0 3642,1 3682,0 3738,1 3811,0 3882,1 3953,0 4020,1 4080,0 4120,1 4213,0 4280,1 4317,0 4331,1 4393,0 4399,1 4440,0 4488,1 4533,0 4585,1 4598,0 4658,1 4669,0 4676,1 4771,0 4820,1 4918,0 4924,1 4956,0 5018,1 5084,0 5113,1 5194,0 5218,1 5262,0 5264,1 5306,0 5374,1 5414,0 5469,1 5535,0 5543,1 5638,0 5683,1 5699,0 5777,1 5810,0 5898,1 5987,0 6016,1 6076,0 6081,1 6096,0 6192,1 6257,0 6291,1 6331,0 6393,1 6421,0 6451,1 6456,0 6514,1 6599,0 6615,1 6638,0 6644,1 6686,0 6738,1 6793,0 6888,1 6951,0 7034,1 7040,0 7126,1 7132,0 7163,1 7232,0 7262,1 7282,0 7319,1 7327,0 7333,1 7387,0 7456,1 7473,0 7569,1 7576,0 7627,1 7701,0 7712,1 7779,0 7819,1 7838,0 7922,1 7952,0 7964,1 7975,0 8065,1 8097,0 8128,1 8196,0 8197,1 8215,0 8269,1 8338,0 8393,1 8459,0 8523,1 8535,0 8577,1 8605,0 8652,1 8670,0 8710,1 8757,0 8801,1 8842,0 8879,1 8891,0 8925,1 9013,0 9060,1 9094,0 9144,1 9188,0 9213,1 9244,0 9337,1 9412,0 9442,1 9480,0 9553,1 9556,0 9655,1 9675,0 9744,1 9769,0 9780,1 9848,0 9939,1 10031,0 10055,1 10084,0 10085,1 10104,0 10194,1 10279,0 10326,1 10369,0 10430,1 10436,0 10440,1 10502,0 10548,1 10626,0 10722,1 10822,0 10904,1 10937,0 10968,1 11065,0 11120,1 11168,0 11240,1 11314,0 11330,1 11349,0 11353,1 11444,0 11474,1 11539,0 11575,1 11630,0 11692,1 11792,0 11805,1 11881,0 11976,1 12061,0 12101,1 12106,0 12183,1 12230,0 12290,1 12304,0 12331,1 12356,0 12442,1 12512,0 12541,1 12596,0 12601,1 12665,0 12729,1 12755,0 12757,1 12771,0 12834,1 12883,0 12978,1 13005,0 13071,1 13081,0 13121,1 13194,0 13293,1 13365,0 13380,1 13384,0 13387,1 13460,0 13514,1 13567,0 13591,1 13592,0 13637,1 13737,0 13779,1 13851,0 13903,1 13999,0 14024,1 14112,0 14178,1 14209,0 14214,1 14253,0 14303,1 14344,0 14347,1 14420,0 14432,1 14532,0 14571,1 14652,0 14690,1 14762,0 14770,1 14811,0 14833,1 14908,0 14911,1 14973,0 15017,1 15058,0 15095,1 15117,0 15139,1 15156,0 15235,1 15330,0 15383,1 15396,0 15462,1 15543,0 15557,1 15614,0 15682,1 15729,0 15746,1 15771,0 15803,1 15879,0 15917,1 16009,0 16071,1 16095,0 16098,1 16122,0 16130,1 16214,0 16243,1 16274,0 16275,1 16297,0 16347,1 16408,0 16482,1 16506,0 16594,1 16655,0 16678,1 16683,0 16766,1 16826,0 16907,1 16968,0 17006,1 17049,0 17115,1 17133,0 17172,1 17271,0 17328,1 17392,0 17428,1 17494,0 17547,1 17635,0 17663,1 17712,0 17795,1 17845,0 17846,1 17872,0 17878,1 17976,0 18059,1 18076,0 18121,1 18182,0 18272,1 18353,0 18385,1 18396,0 18430,1 18457,0 18531,1 18571,0 18629,1 18674,0 18702,1 18709,0 18772,1 18837,0 18933,1 18937,0 18964,1 19036,0 19124,1 19208,0 19290,1 19357,0 19388,1 19436,0 19528,1 19591,0 19648,1 19660,0 19674,1 19697,0 19701,1 19792,0 19877,1 19964,0 20042,1 20085,0 20146,1 20231,0 20241,1 20299,0 20335,1 20431,0 20512,1 20563,0 20614,1 20659,0 20723,1 20786,0 20831,1 20857,0 20898,1 20923,0 21018,1 21085,0 21106,1 21108,0 21157,1 21224,0 21283,1 21300,0 21398,1 21473,0 21513,1 21575,0 21579,1 21644,0 21740,1 21813,0 21912,1 21960,0 21997,1 22011,0 22100,1 22194,0 22239,1 22276,0 22318,1 22352,0 22445,1 22448,0 22463,1 22477,0 22534,1 22627,0 22653,1 22682,0 22765,1 22787,0 22842,1 22894,0 22955,1 22989,0 23081,1 23120,0 23147,1 23214,0 23265,1 23302,0 23305,1 23399,0 23486,1 23508,0 23581,1 23613,0 23684,1 23691,0 23705,1 23782,0 23818,1 23904,0 23928,1 23994,0 24094,1 24168,0 24192,1 24290,0 24339,1 24396,0 24398,1 24428,0 24478,1 24497,0 24539,1 24582,0 24592,1 24602,0 24691,1 24721,0 24737,1 24764,0 24790,1 24796,0 24838,1 24922,0 24929,1 24940,0 24989,1 25026,0 25077,1 25144,0 25180,1 25191,0 25232,1 25250,0 25324,1 25333,0 25404,1 25452,0 25484,1 25550,0 25597,1 25694,0 25787,1 25841,0 25883,1 25935,0 26009,1 26106,0 26111,1 26171,0 26187,1 26262,0 26348,1 26402,0 26444,1 26484,0 26560,1 26576,0 26634,1 26734,0 26807,1 26852,0 26867,1 26871,0 26955,1 27032,0 27096,1 27165,0 27224,1 27243,0 27272,1 27356,0 27358,1 27405,0 27413,1 27472,0 27566,1 27589,0 27591,1 27659,0 27698,1 27730,0 27782,1 27844,0 27854,1 27925,0 27976,1 28005,0 28062,1 28116,0 28168,1 28244,0 28290,1 28323,0 28368,1 28447,0 28536,1 28545,0 28560,1 28629,0 28643,1 28681,0 28746,1 28750,0 28782,1 28849,0 28905,1 28976,0 28988,1 29071,0 29161,1 29191,0 29203,1 29242,0 29243,1 29315,0 29409,1 29490,0 29555,1 29650,0 29680,1 29762,0 29781,1 29848,0 29915,1 29998,0 30037,1 30083,0 30096,1 30098,0 30129,1 30204,0 30242,1 30300,0 30338,1 30392,0 30449,1 30530,0 30539,1 30565,0 30634,1 30709,0 30743,1 30808,0 30896,1 30969,0 30975,1 31049,0 31131,1 31133,0 31226,1 31229,0 31287,1 31295,0 31305,1 31327,0 31393,1 31396,0 31460,1 31542,0 31638,1 31646,0 31678,1 31703,0 31774,1 31832,0 31837,1 31849,0 31901,1 31937,0 31975,1 31986,0 32023,1 32035,0 32076,1 32077,0 32096,1 32171,0 32192,1 32230,0 32238,1 32241,0 32298,1 32332,0 32370,1 32394,0 32410,1 32485,0 32568,1 32656,0 32723,1 32771,0 32860,1 32932,0 33020,1 33041,0 33067,1 33092,0 33191,1 33236,0 33297,1 33341,0 33348,1 33397,0 33417,1 33477,0 33561,1 33600,0 33685,1 33693,0 33739,1 33807,0 33862,1 33934,0 33969,1 33983,0 34058,1 34082,0 34152,1 34203,0 34275,1 34306,0 34376,1 34380,0 34416,1 34428,0 34502,1 34554,0 34628,1 34690,0 34708,1 34802,0 34839,1 34882,0 34962,1 35046,0 35083,1 35108,0 35152,1 35167,0 35172,1 35183,0 35195,1 35272,0 35338,1 35372,0 35383,1 35407,0 35420,1 35485,0 35584,1 35665,0 35749,1 35791,0 35866,1 35935,0 35950,1 36048,0 36145,1 36236,0 36247,1 36327,0 36373,1 36442,0 36529,1 36543,0 36577,1 36674,0 36685,1 36762,0 36765,1 36786,0 36833,1 36899,0 36960,1 37028,0 37112,1 37189,0 37271,1 37318,0 37418,1 37426,0 37512,1 37599,0 37664,1 37703,0 37746,1 37820,0 37849,1 37935,0 37977,1 37997,0 38061,1 38083,0 38137,1 38148,0 38209,1 38222,0 38311,1 38326,0 38329,1 38397,0 38408,1 38463,0 38555,1 38608,0 38688,1 38758,0 38797,1 38828,0 38890,1 38987,0 38998,1 39093,0 39188,1 39267,0 39310,1 39365,0 39449,1 39512,0 39576,1 39614,0 39615,1 39648,0 39734,1 39794,0 39821,1 39870,0 39897,1 39955,0 39992,1 40052,0 40100,1 40190,0 40201,1 40237,0 40250,1 40260,0 40281,1 40345,0 40402,1 40455,0 40498,1 40576,0 40673,1 40691,0 40696,1 40711,0 40737,1 40751,0 40763,1 40854,0 40944,1 40950,0 40957,1 41022,0 41110,1 41140,0 41210,1 41236,0 41238,1 41275,0 41367,1 41451,0 41494,1 41527,0 41572,1 41614,0 41618,1 41706,0 41786,1 41865,0 41895,1 41962,0 42027,1 42059,0 42157,1 42178,0 42182,1 42258,0 42347,1 42373,0 42394,1 42461,0 42501,1 42601,0 42659,1 42758,0 42815,1 42854,0 42898,1 42927,0 42993,1 43060,0 43099,1 43148,0 43184,1 43257,0 43261,1 43282,0 43297,1 43309,0 43375,1 43449,0 43549,1 43560,0 43583,1 43597,0 43678,1 43764,0 43853,1 43864,0 43942,1 43986,0 44007,1 44094,0 44108,1 44126,0 44180,1 44275,0 44292,1 44305,0 44381,1 44455,0 44481,1 44552,0 44557,1 44649,0 44707,1 44774,0 44842,1 44860,0 44913,1 44940,0 44958,1 45038,0 45039,1 45073,0 45075,1 45130,0 45169,1 45229,0 45263,1 45347,0 45438,1 45481,0 45577,1 45599,0 45675,1 45740,0 45742,1 45747,0 45818,1 45829,0 45836,1 45843,0 45917,1 45935,0 45960,1 45989,0 46056,1 46135,0 46227,1 46305,0 46379,1 46442,0 46464,1 46507,0 46526,1 46529,0 46567,1 46622,0 46639,1 46702,0 46758,1 46761,0 46844,1 46910,0 46933,1 47030,0 47104,1 47129,0 47185,1 47192,0 47280,1 47360,0 47366,1 47422,0 47510,1 47576,0 47610,1 47662,0 47694,1 47701,0 47774,1 47837,0 47886,1 47960,0 48035,1 48051,0 48068,1 48131,0 48138,1 48200,0 48206,1 48245,0 48300,1 48344,0 48398,1 48487,0 48497,1 48510,0 48555,1 end initlist a14 0,0 34,1 53,0 73,1 146,0 236,1 259,0 353,1 379,0 452,1 504,0 567,1 592,0 636,1 703,0 749,1 772,0 774,1 816,0 875,1 936,0 941,1 994,0 1077,1 1126,0 1213,1 1261,0 1317,1 1367,0 1415,1 1515,0 1585,1 1639,0 1736,1 1806,0 1850,1 1924,0 2014,1 2030,0 2091,1 2160,0 2177,1 2273,0 2274,1 2332,0 2374,1 2467,0 2491,1 2528,0 2543,1 2606,0 2688,1 2713,0 2795,1 2816,0 2892,1 2917,0 2950,1 3028,0 3099,1 3149,0 3240,1 3328,0 3362,1 3369,0 3376,1 3438,0 3516,1 3600,0 3652,1 3655,0 3747,1 3796,0 3877,1 3963,0 4063,1 4087,0 4093,1 4174,0 4272,1 4329,0 4397,1 4459,0 4557,1 4654,0 4690,1 4742,0 4820,1 4866,0 4950,1 4971,0 5051,1 5127,0 5217,1 5225,0 5321,1 5325,0 5335,1 5385,0 5450,1 5522,0 5566,1 5571,0 5578,1 5611,0 5653,1 5725,0 5771,1 5854,0 5947,1 5953,0 6033,1 6088,0 6126,1 6221,0 6247,1 6299,0 6382,1 6452,0 6469,1 6499,0 6521,1 6581,0 6607,1 6679,0 6759,1 6792,0 6876,1 6945,0 7020,1 7099,0 7113,1 7122,0 7203,1 7301,0 7305,1 7393,0 7421,1 7484,0 7553,1 7613,0 7661,1 7729,0 7793,1 7797,0 7881,1 7882,0 7973,1 8012,0 8104,1 8133,0 8186,1 8268,0 8352,1 8417,0 8479,1 8496,0 8551,1 8593,0 8654,1 8667,0 8671,1 8674,0 8721,1 8749,0 8757,1 8822,0 8838,1 8844,0 8928,1 9004,0 9027,1 9104,0 9133,1 9193,0 9218,1 9239,0 9317,1 9412,0 9496,1 9524,0 9554,1 9619,0 9627,1 9685,0 9761,1 9795,0 9811,1 9818,0 9907,1 9914,0 9993,1 10073,0 10122,1 10196,0 10222,1 10291,0 10351,1 10408,0 10477,1 10481,0 10578,1 10655,0 10667,1 10668,0 10749,1 10826,0 10907,1 10930,0 10992,1 11059,0 11076,1 11150,0 11159,1 11257,0 11278,1 11313,0 11385,1 11429,0 11459,1 11528,0 11549,1 11584,0 11607,1 11628,0 11701,1 11752,0 11758,1 11832,0 11888,1 11936,0 11942,1 12028,0 12065,1 12120,0 12214,1 12245,0 12342,1 12361,0 12443,1 12482,0 12562,1 12580,0 12614,1 12652,0 12734,1 12770,0 12868,1 12929,0 12987,1 13049,0 13057,1 13098,0 13159,1 13200,0 13299,1 13349,0 13358,1 13445,0 13509,1 13562,0 13633,1 13644,0 13659,1 13748,0 13804,1 13889,0 13926,1 14019,0 14049,1 14082,0 14147,1 14173,0 14203,1 14303,0 14326,1 14353,0 14407,1 14446,0 14528,1 14542,0 14594,1 14660,0 14692,1 14781,0 14841,1 14913,0 14936,1 14976,0 15050,1 15080,0 15134,1 15135,0 15172,1 15241,0 15254,1 15329,0 15428,1 15443,0 15499,1 15578,0 15662,1 15706,0 15739,1 15781,0 15875,1 15878,0 15957,1 16050,0 16091,1 16171,0 16188,1 16230,0 16295,1 16315,0 16399,1 16486,0 16585,1 16646,0 16697,1 16784,0 16859,1 16865,0 16907,1 17006,0 17036,1 17122,0 17167,1 17185,0 17262,1 17312,0 17404,1 17497,0 17560,1 17590,0 17597,1 17626,0 17715,1 17750,0 17819,1 17865,0 17900,1 17962,0 17999,1 18008,0 18057,1 18129,0 18177,1 18211,0 18255,1 18290,0 18298,1 18314,0 18380,1 18391,0 18456,1 18505,0 18579,1 18602,0 18635,1 18669,0 18718,1 18782,0 18866,1 18908,0 18909,1 18997,0 19084,1 19130,0 19224,1 19277,0 19327,1 19358,0 19387,1 19429,0 19477,1 19498,0 19577,1 19673,0 19681,1 19718,0 19741,1 19790,0 19852,1 19917,0 19923,1 20018,0 20090,1 20093,0 20136,1 20169,0 20211,1 20221,0 20292,1 20390,0 20462,1 20492,0 20530,1 20569,0 20669,1 20688,0 20784,1 20875,0 20965,1 20980,0 21020,1 21119,0 21148,1 21214,0 21240,1 21296,0 21321,1 21346,0 21413,1 21489,0 21579,1 21580,0 21646,1 21690,0 21773,1 21799,0 21877,1 21908,0 22002,1 22069,0 22118,1 22210,0 22309,1 22311,0 22405,1 22429,0 22487,1 22524,0 22542,1 22575,0 22613,1 22655,0 22747,1 22766,0 22797,1 22820,0 22877,1 22900,0 22921,1 22958,0 23027,1 23050,0 23147,1 23163,0 23190,1 23246,0 23278,1 23324,0 23414,1 23505,0 23508,1 23538,0 23595,1 23600,0 23644,1 23731,0 23805,1 23851,0 23938,1 23997,0 24060,1 24146,0 24243,1 24335,0 24336,1 24354,0 24355,1 24445,0 24477,1 24483,0 24514,1 24550,0 24558,1 24564,0 24587,1 24647,0 24689,1 24715,0 24754,1 24803,0 24897,1 24917,0 24970,1 24998,0 25068,1 25134,0 25187,1 25282,0 25359,1 25453,0 25535,1 25615,0 25652,1 25751,0 25802,1 25818,0 25837,1 25921,0 26011,1 26099,0 26131,1 26168,0 26235,1 26329,0 26428,1 26470,0 26570,1 26618,0 26695,1 26704,0 26752,1 26803,0 26828,1 26897,0 26994,1 26998,0 27046,1 27055,0 27155,1 27164,0 27209,1 27227,0 27257,1 27260,0 27353,1 27430,0 27521,1 27591,0 27670,1 27732,0 27825,1 27895,0 27966,1 28037,0 28084,1 28094,0 28194,1 28207,0 28213,1 28216,0 28236,1 28239,0 28245,1 28262,0 28336,1 28347,0 28357,1 28410,0 28455,1 28507,0 28556,1 28590,0 28686,1 28771,0 28821,1 28880,0 28929,1 28976,0 29072,1 29091,0 29189,1 29233,0 29314,1 29330,0 29383,1 29432,0 29470,1 29569,0 29615,1 29653,0 29714,1 29796,0 29874,1 29878,0 29886,1 29949,0 29966,1 30023,0 30070,1 30136,0 30202,1 30247,0 30286,1 30324,0 30335,1 30421,0 30432,1 30482,0 30514,1 30534,0 30544,1 30604,0 30685,1 30704,0 30754,1 30784,0 30785,1 30841,0 30908,1 30910,0 30953,1 30966,0 30984,1 31016,0 31040,1 31125,0 31198,1 31297,0 31362,1 31407,0 31468,1 31482,0 31528,1 31595,0 31673,1 31728,0 31735,1 31761,0 31827,1 31858,0 31952,1 32045,0 32125,1 32216,0 32304,1 32321,0 32391,1 32414,0 32453,1 32510,0 32553,1 32636,0 32717,1 32790,0 32797,1 32821,0 32865,1 32913,0 33012,1 33068,0 33167,1 33227,0 33262,1 33288,0 33371,1 33375,0 33437,1 33510,0 33567,1 33628,0 33684,1 33698,0 33748,1 33811,0 33901,1 33911,0 34007,1 34020,0 34079,1 34082,0 34130,1 34163,0 34204,1 34242,0 34265,1 34275,0 34340,1 34367,0 34400,1 34493,0 34535,1 34589,0 34621,1 34652,0 34714,1 34723,0 34810,1 34863,0 34951,1 35040,0 35133,1 35152,0 35189,1 35205,0 35302,1 35374,0 35421,1 35489,0 35512,1 35544,0 35581,1 35617,0 35682,1 35756,0 35765,1 35856,0 35954,1 35973,0 35993,1 36046,0 36139,1 36206,0 36277,1 36338,0 36392,1 36450,0 36489,1 36555,0 36642,1 36666,0 36674,1 36724,0 36793,1 36863,0 36944,1 36966,0 37013,1 37074,0 37144,1 37181,0 37238,1 37250,0 37271,1 37305,0 37367,1 37458,0 37486,1 37494,0 37568,1 37665,0 37730,1 37775,0 37846,1 37874,0 37930,1 38007,0 38010,1 38025,0 38049,1 38108,0 38158,1 38227,0 38297,1 38353,0 38447,1 38529,0 38613,1 38616,0 38656,1 38722,0 38753,1 38791,0 38825,1 38887,0 38985,1 38986,0 39054,1 39134,0 39232,1 39321,0 39359,1 39427,0 39507,1 39544,0 39549,1 39637,0 39659,1 39683,0 39703,1 39791,0 39879,1 39938,0 40003,1 40099,0 40100,1 40155,0 40186,1 40206,0 40273,1 40310,0 40391,1 40402,0 40500,1 40589,0 40618,1 40697,0 40729,1 40736,0 40813,1 40911,0 40991,1 41074,0 41125,1 41195,0 41246,1 41298,0 41314,1 41385,0 41431,1 41492,0 41526,1 41606,0 41644,1 41692,0 41726,1 41749,0 41826,1 41916,0 41985,1 42017,0 42090,1 42180,0 42228,1 42282,0 42316,1 42324,0 42423,1 42496,0 42552,1 42578,0 42661,1 42664,0 42721,1 42807,0 42829,1 42887,0 42916,1 42994,0 43088,1 43136,0 43147,1 43234,0 43257,1 43314,0 43357,1 43370,0 43396,1 43401,0 43433,1 43485,0 43534,1 43617,0 43673,1 43678,0 43704,1 43724,0 43810,1 43844,0 43870,1 43901,0 43999,1 44092,0 44107,1 44203,0 44259,1 44310,0 44348,1 44422,0 44519,1 44595,0 44635,1 44731,0 44738,1 44832,0 44841,1 44905,0 44922,1 45000,0 45040,1 45055,0 45116,1 45195,0 45275,1 45351,0 45429,1 45470,0 45482,1 45574,0 45614,1 45621,0 45645,1 45650,0 45733,1 45771,0 45868,1 45896,0 45985,1 46075,0 46101,1 46134,0 46200,1 46274,0 46276,1 46300,0 46394,1 46484,0 46516,1 46590,0 46600,1 46642,0 46677,1 46763,0 46820,1 46870,0 46965,1 46977,0 47055,1 47083,0 47132,1 47224,0 47292,1 47361,0 47405,1 47437,0 47516,1 47543,0 47546,1 47562,0 47614,1 47698,0 47770,1 47842,0 47921,1 48007,0 48072,1 48095,0 48194,1 48271,0 48326,1 48338,0 48401,1 48450,0 48515,1 48527,0 48568,1 48610,0 48612,1 48657,0 48726,1 48798,0 48827,1 48839,0 48876,1 48888,0 48925,1 49000,0 49015,1 49096,0 49134,1 49154,0 49201,1 49286,0 49351,1 49374,0 49433,1 49449,0 49479,1 49572,0 49661,1 49665,0 49708,1 49719,0 49783,1 49843,0 49922,1 49936,0 49965,1 50042,0 50122,1 50198,0 50292,1 50358,0 50377,1 50420,0 50423,1 50482,0 50507,1 50515,0 50561,1 50570,0 50589,1 50612,0 50673,1 50702,0 50802,1 50841,0 50889,1 50984,0 51039,1 51123,0 51192,1 51259,0 51345,1 51390,0 51457,1 51525,0 51557,1 end initlist a15 0,0 49,1 142,0 165,1 225,0 262,1 280,0 342,1 411,0 460,1 539,0 631,1 649,0 653,1 735,0 753,1 831,0 913,1 974,0 1008,1 1019,0 1069,1 1163,0 1261,1 1343,0 1359,1 1420,0 1509,1 1593,0 1681,1 1696,0 1697,1 1753,0 1764,1 1816,0 1913,1 1969,0 1991,1 2064,0 2114,1 2147,0 2186,1 2271,0 2371,1 2419,0 2506,1 2579,0 2610,1 2674,0 2754,1 2811,0 2830,1 2887,0 2964,1 3002,0 3094,1 3117,0 3136,1 3139,0 3183,1 3259,0 3315,1 3342,0 3422,1 3466,0 3514,1 3578,0 3591,1 3676,0 3774,1 3813,0 3900,1 3972,0 4063,1 4127,0 4215,1 4262,0 4333,1 4390,0 4471,1 4541,0 4579,1 4656,0 4659,1 4695,0 4757,1 4794,0 4859,1 4899,0 4942,1 4976,0 5043,1 5088,0 5166,1 5253,0 5314,1 5406,0 5492,1 5544,0 5583,1 5614,0 5681,1 5769,0 5808,1 5883,0 5946,1 6038,0 6039,1 6078,0 6146,1 6200,0 6225,1 6282,0 6325,1 6329,0 6348,1 6415,0 6482,1 6576,0 6667,1 6738,0 6834,1 6932,0 6935,1 6985,0 7021,1 7115,0 7143,1 7202,0 7271,1 7286,0 7381,1 7382,0 7398,1 7445,0 7525,1 7585,0 7647,1 7690,0 7698,1 7778,0 7868,1 7903,0 7926,1 7930,0 7961,1 7996,0 8013,1 8090,0 8177,1 8203,0 8276,1 8340,0 8388,1 8418,0 8456,1 8497,0 8544,1 8566,0 8639,1 8717,0 8813,1 8900,0 8957,1 8979,0 8984,1 9024,0 9115,1 9208,0 9209,1 9263,0 9363,1 9372,0 9381,1 9414,0 9455,1 9509,0 9587,1 9679,0 9763,1 9839,0 9869,1 9897,0 9913,1 9962,0 10022,1 10088,0 10165,1 10169,0 10184,1 10222,0 10252,1 10343,0 10428,1 10509,0 10523,1 10558,0 10610,1 10652,0 10672,1 10756,0 10770,1 10817,0 10871,1 10921,0 10937,1 10966,0 10983,1 11074,0 11132,1 11195,0 11234,1 11261,0 11273,1 11362,0 11449,1 11466,0 11552,1 11582,0 11584,1 11671,0 11682,1 11702,0 11798,1 11832,0 11860,1 11931,0 11945,1 11971,0 12020,1 12028,0 12083,1 12089,0 12147,1 12191,0 12192,1 12213,0 12255,1 12332,0 12382,1 12482,0 12484,1 12577,0 12633,1 12635,0 12658,1 12754,0 12755,1 12797,0 12895,1 12948,0 13022,1 13072,0 13111,1 13159,0 13252,1 13293,0 13369,1 13436,0 13512,1 13565,0 13650,1 13672,0 13710,1 13799,0 13863,1 13907,0 13976,1 14070,0 14141,1 14146,0 14206,1 14279,0 14303,1 14403,0 14468,1 14516,0 14612,1 14700,0 14793,1 14802,0 14879,1 14940,0 14957,1 14964,0 14985,1 15075,0 15112,1 15114,0 15127,1 15155,0 15244,1 15259,0 15350,1 15368,0 15369,1 15404,0 15499,1 15595,0 15626,1 15696,0 15712,1 15771,0 15834,1 15926,0 15977,1 16024,0 16096,1 16113,0 16173,1 16177,0 16196,1 16278,0 16316,1 16412,0 16460,1 16544,0 16610,1 16662,0 16700,1 16743,0 16801,1 16863,0 16932,1 16948,0 17040,1 17059,0 17110,1 17119,0 17156,1 17180,0 17196,1 17295,0 17391,1 17414,0 17432,1 17486,0 17505,1 17544,0 17604,1 17624,0 17718,1 17798,0 17839,1 17916,0 17929,1 17938,0 18021,1 18089,0 18159,1 18195,0 18294,1 18351,0 18413,1 18483,0 18497,1 18560,0 18650,1 18696,0 18759,1 18814,0 18912,1 18966,0 19001,1 19007,0 19068,1 19143,0 19234,1 19313,0 19386,1 19457,0 19467,1 19514,0 19569,1 19606,0 19645,1 19728,0 19796,1 19885,0 19978,1 20059,0 20146,1 20202,0 20263,1 20312,0 20340,1 20416,0 20424,1 20492,0 20536,1 20590,0 20620,1 20703,0 20751,1 20849,0 20920,1 21001,0 21033,1 21056,0 21144,1 21201,0 21228,1 21231,0 21236,1 21336,0 21355,1 21372,0 21383,1 21462,0 21551,1 21606,0 21647,1 21681,0 21715,1 21777,0 21820,1 21868,0 21895,1 21994,0 22024,1 22111,0 22197,1 22232,0 22248,1 22327,0 22387,1 22420,0 22498,1 22561,0 22642,1 22722,0 22734,1 22816,0 22858,1 22950,0 23001,1 23002,0 23092,1 23106,0 23206,1 23211,0 23294,1 23384,0 23443,1 23457,0 23529,1 23550,0 23566,1 23588,0 23627,1 23637,0 23643,1 23690,0 23723,1 23756,0 23831,1 23927,0 24027,1 24063,0 24113,1 24200,0 24224,1 24242,0 24325,1 24339,0 24390,1 24430,0 24507,1 24521,0 24542,1 24596,0 24601,1 24623,0 24689,1 24728,0 24739,1 24788,0 24810,1 24818,0 24907,1 24970,0 25057,1 25092,0 25162,1 25188,0 25224,1 25273,0 25341,1 25401,0 25404,1 25423,0 25514,1 25543,0 25608,1 25663,0 25742,1 25783,0 25788,1 25795,0 25861,1 25890,0 25898,1 25963,0 25984,1 26021,0 26075,1 26118,0 26215,1 26315,0 26360,1 26414,0 26434,1 26506,0 26604,1 26647,0 26716,1 26731,0 26753,1 26801,0 26836,1 26888,0 26902,1 26921,0 26982,1 26997,0 27041,1 27067,0 27117,1 27183,0 27256,1 27298,0 27348,1 27424,0 27516,1 27614,0 27679,1 27687,0 27735,1 27781,0 27823,1 27865,0 27934,1 27938,0 27973,1 27990,0 28047,1 28118,0 28188,1 28221,0 28299,1 28344,0 28431,1 28453,0 28464,1 28547,0 28573,1 28600,0 28635,1 28726,0 28768,1 28852,0 28900,1 28968,0 29007,1 29102,0 29135,1 29175,0 29202,1 29214,0 29236,1 29263,0 29288,1 29354,0 29431,1 29462,0 29546,1 29645,0 29733,1 29781,0 29802,1 29826,0 29846,1 29862,0 29898,1 29960,0 30040,1 30058,0 30133,1 30202,0 30253,1 30271,0 30275,1 30375,0 30403,1 30498,0 30521,1 30549,0 30648,1 30721,0 30731,1 30739,0 30835,1 30852,0 30946,1 31009,0 31049,1 31105,0 31202,1 31272,0 31298,1 31344,0 31348,1 31351,0 31366,1 31434,0 31483,1 31500,0 31595,1 31621,0 31669,1 31704,0 31708,1 31717,0 31816,1 31840,0 31926,1 32014,0 32112,1 32195,0 32211,1 32244,0 32344,1 32386,0 32409,1 32440,0 32462,1 32506,0 32519,1 32555,0 32630,1 32709,0 32729,1 32762,0 32810,1 32905,0 32986,1 33028,0 33073,1 33135,0 33167,1 33172,0 33198,1 33232,0 33295,1 33392,0 33487,1 33496,0 33511,1 33562,0 33634,1 33640,0 33682,1 33691,0 33700,1 33763,0 33818,1 33908,0 33954,1 33987,0 34056,1 34105,0 34190,1 34252,0 34272,1 34326,0 34363,1 34376,0 34411,1 34488,0 34496,1 34500,0 34588,1 34635,0 34675,1 34695,0 34767,1 34860,0 34933,1 35011,0 35091,1 35170,0 35258,1 35286,0 35287,1 35327,0 35390,1 35467,0 35494,1 35550,0 35598,1 35691,0 35704,1 35745,0 35837,1 35896,0 35899,1 35907,0 35975,1 36007,0 36038,1 36040,0 36092,1 36151,0 36200,1 36283,0 36318,1 36393,0 36458,1 36555,0 36652,1 36726,0 36749,1 36769,0 36799,1 36827,0 36860,1 36921,0 36986,1 36993,0 37009,1 37067,0 37089,1 37122,0 37136,1 37220,0 37312,1 37392,0 37475,1 37541,0 37554,1 37556,0 37596,1 37688,0 37783,1 37836,0 37886,1 37924,0 37974,1 37976,0 38015,1 38073,0 38086,1 38101,0 38185,1 38192,0 38245,1 38309,0 38326,1 38364,0 38448,1 38544,0 38560,1 38595,0 38677,1 38718,0 38747,1 38837,0 38916,1 39005,0 39052,1 39123,0 39152,1 39208,0 39225,1 39278,0 39364,1 39459,0 39544,1 39580,0 39642,1 39706,0 39739,1 39747,0 39761,1 39831,0 39915,1 40012,0 40097,1 40114,0 40214,1 40268,0 40306,1 40320,0 40416,1 40475,0 40527,1 40532,0 40576,1 40608,0 40626,1 40674,0 40766,1 40853,0 40918,1 40979,0 40994,1 41062,0 41105,1 41181,0 41196,1 41198,0 41240,1 41280,0 41329,1 41365,0 41385,1 41412,0 41420,1 41501,0 41558,1 41567,0 41569,1 41657,0 41756,1 41770,0 41841,1 41928,0 42025,1 42080,0 42081,1 42108,0 42161,1 42232,0 42313,1 42340,0 42369,1 42431,0 42514,1 42586,0 42630,1 42671,0 42691,1 42710,0 42785,1 42812,0 42904,1 42937,0 42967,1 42968,0 43026,1 43031,0 43041,1 43076,0 43102,1 43146,0 43230,1 43307,0 43356,1 43443,0 43490,1 43578,0 43626,1 43646,0 43658,1 43698,0 43790,1 43821,0 43866,1 43930,0 43942,1 44034,0 44064,1 44147,0 44198,1 44291,0 44381,1 44431,0 44482,1 44572,0 44668,1 44690,0 44700,1 44757,0 44779,1 44842,0 44886,1 44952,0 45025,1 45046,0 45146,1 45237,0 45284,1 45316,0 45391,1 45428,0 45489,1 45524,0 45528,1 45554,0 45619,1 45629,0 45696,1 45708,0 45764,1 45780,0 45811,1 45868,0 45924,1 45950,0 46041,1 46099,0 46160,1 46222,0 46256,1 46323,0 46340,1 46393,0 46488,1 46501,0 46520,1 46618,0 46715,1 46744,0 46753,1 46825,0 46894,1 46930,0 46973,1 46994,0 47051,1 47078,0 47161,1 47166,0 47230,1 47237,0 47293,1 47356,0 47406,1 47496,0 47584,1 47620,0 47713,1 47769,0 47791,1 47839,0 47857,1 47932,0 48025,1 48067,0 48116,1 48131,0 48207,1 48251,0 48331,1 48415,0 48503,1 48527,0 48583,1 48603,0 48669,1 48716,0 48777,1 48808,0 48907,1 48934,0 48966,1 49059,0 49124,1 49151,0 49155,1 49234,0 49254,1 49306,0 49312,1 49368,0 49420,1 49434,0 49495,1 49501,0 49532,1 49575,0 49660,1 49746,0 49763,1 49787,0 49876,1 49905,0 49964,1 50043,0 50108,1 50169,0 50260,1 50271,0 50347,1 50391,0 50466,1 50546,0 50569,1 50628,0 50668,1 50751,0 50793,1 end initlist b0 0,0 88,1 173,0 234,1 272,0 275,1 332,0 367,1 433,0 451,1 478,0 503,1 541,0 568,1 653,0 684,1 709,0 796,1 816,0 894,1 969,0 1048,1 1099,0 1128,1 1166,0 1172,1 1230,0 1278,1 1287,0 1295,1 1340,0 1380,1 1430,0 1504,1 1570,0 1627,1 1696,0 1710,1 1795,0 1796,1 1798,0 1858,1 1954,0 2044,1 2107,0 2181,1 2199,0 2282,1 2362,0 2434,1 2528,0 2601,1 2692,0 2721,1 2795,0 2868,1 2930,0 2975,1 3061,0 3140,1 3161,0 3235,1 3275,0 3304,1 3340,0 3353,1 3403,0 3430,1 3431,0 3453,1 3519,0 3591,1 3658,0 3752,1 3760,0 3799,1 3860,0 3907,1 3923,0 3987,1 4073,0 4126,1 4184,0 4192,1 4282,0 4330,1 4380,0 4395,1 4482,0 4513,1 4568,0 4642,1 4720,0 4781,1 4808,0 4877,1 4941,0 5010,1 5062,0 5162,1 5185,0 5269,1 5288,0 5365,1 5381,0 5416,1 5513,0 5550,1 5574,0 5612,1 5689,0 5759,1 5804,0 5902,1 5969,0 6059,1 6069,0 6077,1 6163,0 6194,1 6288,0 6351,1 6437,0 6446,1 6505,0 6555,1 6559,0 6609,1 6691,0 6763,1 6817,0 6910,1 6931,0 6973,1 7044,0 7138,1 7237,0 7287,1 7377,0 7436,1 7482,0 7582,1 7660,0 7756,1 7826,0 7871,1 7889,0 7975,1 7979,0 8009,1 8019,0 8046,1 8120,0 8166,1 8201,0 8257,1 8322,0 8349,1 8417,0 8513,1 8612,0 8652,1 8747,0 8771,1 8868,0 8923,1 8978,0 9046,1 9105,0 9180,1 9199,0 9247,1 9292,0 9373,1 9400,0 9435,1 9443,0 9486,1 9579,0 9674,1 9703,0 9710,1 9778,0 9785,1 9854,0 9863,1 9875,0 9918,1 9938,0 10021,1 10061,0 10108,1 10168,0 10184,1 10272,0 10285,1 10329,0 10397,1 10420,0 10433,1 10464,0 10563,1 10619,0 10658,1 10721,0 10770,1 10821,0 10831,1 10913,0 10945,1 10990,0 11053,1 11067,0 11142,1 11209,0 11286,1 11339,0 11351,1 11396,0 11402,1 11470,0 11507,1 11537,0 11552,1 11618,0 11657,1 11748,0 11806,1 11819,0 11881,1 11904,0 11958,1 11975,0 12030,1 12051,0 12055,1 12122,0 12191,1 12260,0 12277,1 12279,0 12371,1 12448,0 12511,1 12566,0 12576,1 12582,0 12668,1 12765,0 12857,1 12904,0 12993,1 12998,0 13018,1 13036,0 13107,1 13202,0 13238,1 13333,0 13429,1 13475,0 13518,1 13525,0 13579,1 13635,0 13719,1 13736,0 13798,1 13822,0 13894,1 13983,0 13992,1 13994,0 14012,1 14059,0 14074,1 14159,0 14225,1 14284,0 14380,1 14446,0 14448,1 14478,0 14509,1 14516,0 14608,1 14700,0 14795,1 14860,0 14911,1 14982,0 15021,1 15029,0 15036,1 15130,0 15206,1 15266,0 15272,1 15311,0 15323,1 15420,0 15489,1 15582,0 15667,1 15716,0 15792,1 15866,0 15951,1 16032,0 16064,1 16111,0 16115,1 16122,0 16203,1 16231,0 16325,1 16421,0 16443,1 16531,0 16590,1 16689,0 16772,1 16807,0 16904,1 16974,0 17015,1 17081,0 17113,1 17176,0 17238,1 17253,0 17275,1 17370,0 17436,1 17486,0 17509,1 17583,0 17669,1 17738,0 17747,1 17790,0 17834,1 17888,0 17969,1 18032,0 18052,1 18109,0 18201,1 18300,0 18393,1 18481,0 18559,1 18592,0 18668,1 18738,0 18806,1 18902,0 18912,1 18933,0 19005,1 19027,0 19090,1 19102,0 19154,1 19202,0 19218,1 19233,0 19248,1 19319,0 19397,1 19463,0 19466,1 19564,0 19568,1 19611,0 19678,1 19761,0 19833,1 19920,0 19977,1 20022,0 20094,1 20124,0 20210,1 20238,0 20245,1 20313,0 20340,1 20430,0 20504,1 20557,0 20605,1 20637,0 20648,1 20722,0 20749,1 20794,0 20872,1 20924,0 20973,1 21002,0 21081,1 21163,0 21262,1 21360,0 21416,1 21424,0 21504,1 21558,0 21596,1 21654,0 21747,1 21805,0 21811,1 21874,0 21966,1 21987,0 22019,1 22046,0 22123,1 22161,0 22250,1 22350,0 22383,1 22387,0 22417,1 22453,0 22495,1 22582,0 22590,1 22637,0 22727,1 22748,0 22821,1 22891,0 22954,1 22979,0 23056,1 23081,0 23167,1 23195,0 23198,1 23199,0 23284,1 23369,0 23460,1 23485,0 23532,1 23611,0 23639,1 23708,0 23803,1 23811,0 23849,1 23855,0 23861,1 23906,0 23971,1 24030,0 24055,1 24065,0 24124,1 24171,0 24183,1 24214,0 24307,1 24312,0 24356,1 24450,0 24467,1 24514,0 24598,1 24677,0 24737,1 24740,0 24826,1 24846,0 24894,1 24955,0 25053,1 25151,0 25242,1 25255,0 25295,1 25346,0 25402,1 25463,0 25552,1 25558,0 25644,1 25687,0 25713,1 25733,0 25751,1 25836,0 25860,1 25901,0 25989,1 26055,0 26155,1 26227,0 26283,1 26376,0 26420,1 26466,0 26538,1 26618,0 26678,1 26746,0 26836,1 26895,0 26954,1 27053,0 27085,1 27151,0 27217,1 27278,0 27350,1 27400,0 27460,1 27492,0 27565,1 27632,0 27694,1 27788,0 27830,1 27861,0 27911,1 27959,0 27969,1 28014,0 28070,1 28149,0 28161,1 28239,0 28303,1 28314,0 28332,1 28427,0 28435,1 28530,0 28623,1 28658,0 28713,1 28787,0 28817,1 28893,0 28981,1 29013,0 29062,1 29141,0 29153,1 29232,0 29329,1 29429,0 29523,1 29622,0 29663,1 29693,0 29700,1 29747,0 29838,1 29892,0 29935,1 29956,0 30017,1 30057,0 30142,1 30200,0 30293,1 30370,0 30410,1 30437,0 30481,1 30516,0 30610,1 30636,0 30720,1 30817,0 30871,1 30941,0 30990,1 31009,0 31096,1 31134,0 31217,1 31260,0 31317,1 31397,0 31447,1 31516,0 31542,1 31587,0 31624,1 31689,0 31753,1 31851,0 31864,1 31878,0 31894,1 31969,0 32049,1 32142,0 32183,1 32220,0 32232,1 32312,0 32323,1 32379,0 32394,1 32411,0 32480,1 32494,0 32574,1 32587,0 32644,1 32655,0 32726,1 32765,0 32785,1 32838,0 32895,1 32920,0 33003,1 33037,0 33041,1 33078,0 33123,1 33164,0 33166,1 33259,0 33286,1 33319,0 33395,1 33412,0 33489,1 33556,0 33642,1 33672,0 33707,1 33760,0 33835,1 33836,0 33868,1 33869,0 33956,1 33968,0 34050,1 34064,0 34118,1 34136,0 34143,1 34222,0 34242,1 34291,0 34356,1 34361,0 34454,1 34535,0 34546,1 34570,0 34594,1 34632,0 34674,1 34675,0 34772,1 34828,0 34924,1 34975,0 35008,1 35105,0 35132,1 35154,0 35158,1 35248,0 35264,1 35308,0 35318,1 35389,0 35402,1 35425,0 35448,1 35455,0 35487,1 35528,0 35555,1 35580,0 35628,1 35639,0 35676,1 35696,0 35740,1 35755,0 35849,1 35932,0 35937,1 35988,0 36017,1 36079,0 36148,1 36220,0 36253,1 36319,0 36372,1 36390,0 36480,1 36507,0 36576,1 36633,0 36725,1 36793,0 36868,1 36906,0 36988,1 37063,0 37078,1 37175,0 37237,1 37302,0 37316,1 37392,0 37490,1 37564,0 37637,1 37732,0 37784,1 37863,0 37912,1 38005,0 38070,1 38086,0 38110,1 38124,0 38150,1 38225,0 38238,1 38259,0 38342,1 38368,0 38420,1 38505,0 38560,1 38656,0 38747,1 38752,0 38827,1 38874,0 38972,1 39011,0 39016,1 39101,0 39174,1 39231,0 39285,1 39333,0 39375,1 39384,0 39469,1 39510,0 39542,1 39635,0 39717,1 39806,0 39834,1 39882,0 39917,1 39919,0 39933,1 39948,0 39951,1 40025,0 40122,1 40214,0 40233,1 40297,0 40381,1 40431,0 40501,1 40543,0 40588,1 40617,0 40653,1 40667,0 40697,1 40738,0 40742,1 40782,0 40787,1 40881,0 40882,1 40908,0 40987,1 41018,0 41031,1 41104,0 41155,1 41178,0 41189,1 41192,0 41290,1 41295,0 41311,1 41392,0 41404,1 41449,0 41455,1 41534,0 41563,1 41632,0 41708,1 41804,0 41850,1 41892,0 41974,1 42054,0 42108,1 42115,0 42171,1 42227,0 42237,1 42282,0 42298,1 42317,0 42408,1 42452,0 42498,1 42598,0 42680,1 42762,0 42806,1 42870,0 42879,1 42917,0 43008,1 43058,0 43153,1 43209,0 43271,1 43312,0 43391,1 43420,0 43424,1 43524,0 43623,1 43702,0 43759,1 43792,0 43884,1 43897,0 43939,1 43989,0 43994,1 44035,0 44129,1 44182,0 44242,1 44336,0 44360,1 44377,0 44411,1 44488,0 44587,1 44592,0 44616,1 44690,0 44720,1 44731,0 44829,1 44858,0 44943,1 44946,0 44976,1 45006,0 45059,1 45076,0 45079,1 45176,0 45230,1 45275,0 45360,1 45416,0 45515,1 45569,0 45594,1 45614,0 45615,1 45645,0 45694,1 45729,0 45813,1 45872,0 45965,1 45994,0 46012,1 46102,0 46113,1 46155,0 46236,1 46297,0 46301,1 46357,0 46423,1 46482,0 46562,1 46638,0 46701,1 46730,0 46752,1 46753,0 46779,1 46825,0 46858,1 46911,0 47009,1 47060,0 47074,1 47091,0 47105,1 47186,0 47267,1 47271,0 47344,1 47418,0 47472,1 47542,0 47591,1 47691,0 47753,1 47812,0 47832,1 47905,0 47956,1 47976,0 47998,1 48096,0 48111,1 48118,0 48193,1 48243,0 48307,1 48365,0 48380,1 48420,0 48477,1 48572,0 48597,1 48626,0 48648,1 48685,0 48722,1 48745,0 48839,1 48842,0 48862,1 48909,0 48917,1 48947,0 48986,1 48987,0 49037,1 49069,0 49088,1 49107,0 49173,1 49223,0 49289,1 49359,0 49441,1 49478,0 49536,1 49607,0 49637,1 49708,0 49789,1 49838,0 49847,1 49868,0 49880,1 49959,0 49992,1 50002,0 50081,1 50140,0 50238,1 50247,0 50335,1 50411,0 50427,1 50447,0 50501,1 50587,0 50644,1 50662,0 50741,1 50788,0 50840,1 50919,0 50969,1 51004,0 51012,1 51069,0 51124,1 end initlist b1 0,0 85,1 165,0 236,1 305,0 350,1 434,0 502,1 530,0 607,1 683,0 747,1 783,0 857,1 861,0 938,1 1003,0 1050,1 1078,0 1122,1 1187,0 1189,1 1214,0 1292,1 1351,0 1435,1 1518,0 1578,1 1631,0 1648,1 1741,0 1784,1 1869,0 1889,1 1952,0 2031,1 2109,0 2118,1 2196,0 2236,1 2240,0 2245,1 2310,0 2398,1 2432,0 2502,1 2559,0 2630,1 2679,0 2739,1 2832,0 2849,1 2903,0 2956,1 3046,0 3115,1 3170,0 3257,1 3306,0 3382,1 3422,0 3461,1 3509,0 3537,1 3607,0 3678,1 3751,0 3827,1 3902,0 3976,1 4024,0 4077,1 4115,0 4173,1 4187,0 4204,1 4284,0 4289,1 4322,0 4408,1 4475,0 4529,1 4538,0 4550,1 4648,0 4748,1 4776,0 4830,1 4918,0 4941,1 4951,0 4967,1 5030,0 5095,1 5107,0 5186,1 5201,0 5237,1 5301,0 5349,1 5448,0 5544,1 5559,0 5656,1 5677,0 5775,1 5864,0 5961,1 6031,0 6095,1 6144,0 6242,1 6335,0 6420,1 6497,0 6499,1 6566,0 6582,1 6662,0 6697,1 6730,0 6824,1 6828,0 6870,1 6913,0 6937,1 6952,0 6991,1 7000,0 7040,1 7124,0 7164,1 7181,0 7196,1 7271,0 7346,1 7386,0 7465,1 7503,0 7578,1 7585,0 7619,1 7647,0 7648,1 7740,0 7744,1 7824,0 7870,1 7960,0 8017,1 8020,0 8023,1 8086,0 8181,1 8244,0 8263,1 8349,0 8395,1 8414,0 8488,1 8583,0 8668,1 8751,0 8830,1 8904,0 8940,1 8989,0 9049,1 9064,0 9090,1 9139,0 9217,1 9291,0 9307,1 9392,0 9477,1 9541,0 9624,1 9696,0 9758,1 9812,0 9890,1 9982,0 10007,1 10043,0 10059,1 10133,0 10177,1 10252,0 10314,1 10411,0 10496,1 10538,0 10600,1 10630,0 10644,1 10732,0 10734,1 10771,0 10802,1 10805,0 10899,1 10989,0 10997,1 11015,0 11052,1 11118,0 11208,1 11233,0 11274,1 11369,0 11410,1 11469,0 11531,1 11557,0 11583,1 11668,0 11736,1 11797,0 11829,1 11838,0 11877,1 11878,0 11899,1 11992,0 11998,1 12003,0 12022,1 12063,0 12153,1 12175,0 12199,1 12238,0 12305,1 12384,0 12406,1 12498,0 12502,1 12503,0 12599,1 12672,0 12698,1 12798,0 12855,1 12859,0 12868,1 12954,0 12987,1 13050,0 13121,1 13128,0 13224,1 13235,0 13300,1 13366,0 13431,1 13450,0 13466,1 13468,0 13483,1 13498,0 13597,1 13667,0 13724,1 13770,0 13813,1 13843,0 13884,1 13890,0 13940,1 13961,0 13968,1 14068,0 14159,1 14161,0 14172,1 14211,0 14235,1 14241,0 14335,1 14423,0 14473,1 14562,0 14659,1 14739,0 14809,1 14904,0 14920,1 14966,0 15066,1 15071,0 15126,1 15151,0 15209,1 15287,0 15369,1 15445,0 15502,1 15542,0 15576,1 15606,0 15630,1 15711,0 15766,1 15855,0 15880,1 15914,0 15986,1 16027,0 16092,1 16175,0 16242,1 16282,0 16382,1 16451,0 16531,1 16548,0 16551,1 16640,0 16681,1 16770,0 16870,1 16949,0 16977,1 17074,0 17098,1 17125,0 17128,1 17154,0 17252,1 17294,0 17329,1 17346,0 17429,1 17481,0 17484,1 17535,0 17614,1 17655,0 17710,1 17766,0 17866,1 17888,0 17977,1 18037,0 18093,1 18175,0 18252,1 18346,0 18383,1 18439,0 18468,1 18521,0 18563,1 18589,0 18620,1 18660,0 18668,1 18741,0 18761,1 18846,0 18900,1 18997,0 19031,1 19102,0 19116,1 19129,0 19202,1 19256,0 19306,1 19369,0 19460,1 19526,0 19543,1 19598,0 19599,1 19601,0 19638,1 19731,0 19733,1 19831,0 19871,1 19933,0 19945,1 19994,0 20050,1 20116,0 20161,1 20231,0 20316,1 20366,0 20411,1 20460,0 20511,1 20577,0 20677,1 20711,0 20778,1 20795,0 20858,1 20946,0 21003,1 21071,0 21111,1 21134,0 21175,1 21249,0 21318,1 21404,0 21494,1 21536,0 21551,1 21561,0 21624,1 21685,0 21777,1 21854,0 21882,1 21962,0 22058,1 22078,0 22110,1 22120,0 22159,1 22236,0 22269,1 22276,0 22356,1 22378,0 22393,1 22455,0 22552,1 22576,0 22652,1 22723,0 22817,1 22827,0 22839,1 22887,0 22935,1 22936,0 22946,1 23004,0 23075,1 23148,0 23248,1 23318,0 23343,1 23358,0 23379,1 23446,0 23459,1 23463,0 23513,1 23584,0 23603,1 23611,0 23629,1 23686,0 23714,1 23792,0 23816,1 23833,0 23896,1 23902,0 23968,1 24068,0 24087,1 24151,0 24214,1 24275,0 24329,1 24345,0 24406,1 24479,0 24514,1 24599,0 24666,1 24688,0 24709,1 24794,0 24824,1 24904,0 24973,1 25046,0 25066,1 25071,0 25167,1 25184,0 25190,1 25232,0 25244,1 25323,0 25377,1 25452,0 25533,1 25571,0 25625,1 25677,0 25766,1 25794,0 25855,1 25875,0 25941,1 25975,0 26042,1 26129,0 26228,1 26309,0 26360,1 26424,0 26523,1 26541,0 26544,1 26612,0 26634,1 26650,0 26685,1 26719,0 26794,1 26838,0 26903,1 26969,0 27019,1 27067,0 27129,1 27181,0 27242,1 27249,0 27266,1 27357,0 27421,1 27485,0 27533,1 27625,0 27670,1 27728,0 27744,1 27791,0 27840,1 27884,0 27955,1 27988,0 28042,1 28044,0 28139,1 28233,0 28268,1 28328,0 28397,1 28466,0 28548,1 28593,0 28653,1 28685,0 28710,1 28741,0 28789,1 28797,0 28886,1 28985,0 28995,1 29037,0 29091,1 29092,0 29139,1 29150,0 29232,1 29233,0 29256,1 29328,0 29363,1 29366,0 29388,1 29464,0 29547,1 29573,0 29662,1 29723,0 29729,1 29741,0 29765,1 29811,0 29874,1 29906,0 29975,1 30019,0 30044,1 30118,0 30211,1 30232,0 30237,1 30290,0 30293,1 30317,0 30346,1 30384,0 30448,1 30460,0 30518,1 30618,0 30625,1 30715,0 30716,1 30779,0 30801,1 30847,0 30869,1 30870,0 30925,1 30944,0 31007,1 31008,0 31019,1 31038,0 31046,1 31073,0 31105,1 31139,0 31206,1 31276,0 31316,1 31394,0 31407,1 31507,0 31569,1 31647,0 31664,1 31743,0 31803,1 31838,0 31880,1 31965,0 31999,1 32025,0 32036,1 32052,0 32094,1 32142,0 32179,1 32269,0 32337,1 32414,0 32492,1 32549,0 32559,1 32605,0 32644,1 32743,0 32840,1 32917,0 32962,1 33062,0 33139,1 33166,0 33236,1 33285,0 33316,1 33353,0 33396,1 33429,0 33444,1 33501,0 33592,1 33638,0 33709,1 33804,0 33838,1 33926,0 33970,1 34030,0 34068,1 34073,0 34142,1 34232,0 34281,1 34282,0 34346,1 34366,0 34398,1 34428,0 34524,1 34551,0 34612,1 34656,0 34708,1 34745,0 34769,1 34826,0 34895,1 34982,0 35040,1 35078,0 35137,1 35234,0 35328,1 35385,0 35485,1 35542,0 35569,1 35637,0 35736,1 35830,0 35864,1 35880,0 35965,1 36025,0 36112,1 36175,0 36232,1 36242,0 36342,1 36396,0 36407,1 36448,0 36523,1 36616,0 36710,1 36733,0 36752,1 36793,0 36872,1 36943,0 36957,1 37008,0 37018,1 37057,0 37072,1 37166,0 37214,1 37276,0 37355,1 37424,0 37438,1 37484,0 37500,1 37526,0 37612,1 37618,0 37705,1 37714,0 37729,1 37770,0 37775,1 37799,0 37881,1 37910,0 37960,1 37983,0 38053,1 38132,0 38181,1 38258,0 38357,1 38448,0 38474,1 38539,0 38596,1 38633,0 38716,1 38727,0 38810,1 38879,0 38928,1 39005,0 39039,1 39119,0 39208,1 39270,0 39285,1 39338,0 39434,1 39442,0 39541,1 39615,0 39655,1 39710,0 39807,1 39891,0 39897,1 39971,0 40010,1 40085,0 40173,1 40216,0 40298,1 40339,0 40414,1 40507,0 40573,1 40615,0 40697,1 40717,0 40732,1 40789,0 40859,1 40886,0 40948,1 41042,0 41057,1 41081,0 41119,1 41202,0 41264,1 41359,0 41381,1 41423,0 41458,1 41558,0 41581,1 41626,0 41696,1 41790,0 41840,1 41903,0 41966,1 42014,0 42046,1 42092,0 42192,1 42263,0 42291,1 42389,0 42471,1 42486,0 42550,1 42641,0 42683,1 42746,0 42795,1 42827,0 42845,1 42903,0 42976,1 42991,0 43081,1 43160,0 43210,1 43287,0 43321,1 43415,0 43440,1 43474,0 43517,1 43595,0 43633,1 43680,0 43780,1 43877,0 43917,1 43949,0 43988,1 44026,0 44053,1 44117,0 44188,1 44193,0 44239,1 44243,0 44331,1 44371,0 44469,1 44546,0 44547,1 44635,0 44685,1 44720,0 44787,1 44839,0 44880,1 44969,0 45059,1 45089,0 45109,1 45141,0 45191,1 45273,0 45325,1 45390,0 45407,1 45462,0 45535,1 45632,0 45685,1 45711,0 45759,1 45775,0 45814,1 45909,0 45920,1 45940,0 45957,1 46051,0 46099,1 46174,0 46189,1 46246,0 46280,1 46343,0 46350,1 46385,0 46435,1 46478,0 46522,1 46532,0 46556,1 46584,0 46600,1 46632,0 46728,1 46753,0 46848,1 46889,0 46942,1 46964,0 47058,1 47094,0 47107,1 47169,0 47217,1 47289,0 47292,1 47388,0 47412,1 47473,0 47536,1 47591,0 47637,1 47684,0 47770,1 47844,0 47895,1 47925,0 48009,1 48095,0 48108,1 48138,0 48171,1 48270,0 48297,1 48394,0 48488,1 48549,0 48634,1 48653,0 48655,1 48725,0 48787,1 48805,0 48855,1 48896,0 48957,1 48996,0 49076,1 49080,0 49095,1 49159,0 49162,1 49244,0 49300,1 49400,0 49490,1 49530,0 49625,1 49629,0 49656,1 49730,0 49787,1 49814,0 49907,1 49980,0 49990,1 50058,0 50123,1 50170,0 50270,1 50290,0 50365,1 50399,0 50408,1 50443,0 50535,1 50572,0 50629,1 50686,0 50731,1 50764,0 50832,1 50883,0 50887,1 50979,0 51018,1 51024,0 51034,1 51077,0 51158,1 51245,0 51342,1 51382,0 51451,1 51521,0 51526,1 end initlist b2 0,0 19,1 119,0 218,1 253,0 273,1 313,0 377,1 425,0 499,1 525,0 565,1 577,0 654,1 661,0 691,1 734,0 771,1 779,0 875,1 911,0 978,1 1009,0 1025,1 1049,0 1050,1 1145,0 1241,1 1334,0 1410,1 1445,0 1459,1 1486,0 1508,1 1538,0 1589,1 1630,0 1702,1 1709,0 1718,1 1723,0 1823,1 1899,0 1926,1 2006,0 2045,1 2077,0 2080,1 2147,0 2235,1 2265,0 2314,1 2388,0 2487,1 2521,0 2523,1 2600,0 2665,1 2709,0 2779,1 2841,0 2887,1 2904,0 2995,1 3095,0 3174,1 3273,0 3371,1 3455,0 3494,1 3541,0 3546,1 3625,0 3667,1 3686,0 3687,1 3754,0 3805,1 3826,0 3827,1 3859,0 3947,1 3975,0 4039,1 4078,0 4163,1 4261,0 4307,1 4323,0 4355,1 4397,0 4442,1 4500,0 4510,1 4516,0 4589,1 4664,0 4750,1 4828,0 4867,1 4945,0 5015,1 5102,0 5171,1 5260,0 5327,1 5398,0 5419,1 5479,0 5575,1 5614,0 5692,1 5749,0 5836,1 5912,0 5969,1 6029,0 6040,1 6052,0 6140,1 6186,0 6212,1 6272,0 6292,1 6319,0 6415,1 6418,0 6479,1 6551,0 6598,1 6679,0 6749,1 6781,0 6871,1 6964,0 7030,1 7059,0 7146,1 7211,0 7272,1 7308,0 7314,1 7397,0 7412,1 7427,0 7477,1 7494,0 7544,1 7551,0 7623,1 7683,0 7768,1 7835,0 7930,1 7931,0 8010,1 8083,0 8145,1 8210,0 8264,1 8286,0 8350,1 8423,0 8487,1 8527,0 8563,1 8590,0 8610,1 8668,0 8679,1 8721,0 8764,1 8797,0 8866,1 8905,0 8924,1 9013,0 9047,1 9144,0 9197,1 9231,0 9309,1 9386,0 9430,1 9455,0 9532,1 9561,0 9660,1 9720,0 9740,1 9822,0 9866,1 9926,0 9990,1 10044,0 10050,1 10056,0 10155,1 10185,0 10203,1 10243,0 10331,1 10370,0 10461,1 10553,0 10571,1 10653,0 10726,1 10824,0 10840,1 10851,0 10867,1 10872,0 10970,1 11045,0 11101,1 11155,0 11240,1 11264,0 11273,1 11366,0 11411,1 11424,0 11511,1 11601,0 11698,1 11772,0 11814,1 11880,0 11909,1 12000,0 12051,1 12135,0 12227,1 12247,0 12304,1 12394,0 12429,1 12505,0 12602,1 12634,0 12670,1 12766,0 12798,1 12825,0 12912,1 12984,0 12995,1 13025,0 13084,1 13181,0 13227,1 13257,0 13302,1 13365,0 13369,1 13373,0 13442,1 13464,0 13543,1 13597,0 13646,1 13699,0 13746,1 13782,0 13783,1 13873,0 13934,1 13977,0 14016,1 14036,0 14080,1 14127,0 14206,1 14242,0 14248,1 14304,0 14358,1 14442,0 14450,1 14458,0 14488,1 14514,0 14562,1 14637,0 14658,1 14669,0 14720,1 14793,0 14848,1 14895,0 14897,1 14961,0 14996,1 14999,0 15041,1 15107,0 15127,1 15186,0 15200,1 15208,0 15296,1 15389,0 15405,1 15489,0 15566,1 15574,0 15644,1 15673,0 15683,1 15705,0 15754,1 15834,0 15897,1 15950,0 16006,1 16013,0 16094,1 16173,0 16200,1 16289,0 16328,1 16386,0 16426,1 16478,0 16482,1 16577,0 16618,1 16634,0 16727,1 16818,0 16866,1 16909,0 16972,1 17013,0 17032,1 17068,0 17125,1 17169,0 17242,1 17294,0 17354,1 17414,0 17446,1 17458,0 17461,1 17559,0 17608,1 17694,0 17745,1 17807,0 17860,1 17949,0 17987,1 18036,0 18083,1 18118,0 18179,1 18241,0 18260,1 18296,0 18355,1 18452,0 18478,1 18553,0 18624,1 18693,0 18720,1 18760,0 18859,1 18897,0 18907,1 18926,0 18998,1 19097,0 19118,1 19124,0 19128,1 19173,0 19258,1 19352,0 19385,1 19468,0 19542,1 19557,0 19614,1 19617,0 19655,1 19689,0 19753,1 19808,0 19817,1 19896,0 19898,1 19915,0 19987,1 20012,0 20035,1 20111,0 20206,1 20230,0 20275,1 20336,0 20366,1 20460,0 20554,1 20653,0 20669,1 20702,0 20764,1 20798,0 20876,1 20929,0 20997,1 21020,0 21068,1 21133,0 21147,1 21179,0 21214,1 21226,0 21270,1 21346,0 21377,1 21472,0 21515,1 21560,0 21623,1 21660,0 21694,1 21780,0 21854,1 21927,0 21945,1 21972,0 22052,1 22064,0 22110,1 22127,0 22130,1 22228,0 22254,1 22280,0 22360,1 22441,0 22479,1 22548,0 22599,1 22684,0 22694,1 22778,0 22844,1 22896,0 22937,1 22976,0 22992,1 23062,0 23083,1 23126,0 23184,1 23249,0 23251,1 23279,0 23359,1 23412,0 23502,1 23567,0 23595,1 23650,0 23706,1 23719,0 23728,1 23802,0 23821,1 23907,0 23908,1 23931,0 24008,1 24044,0 24113,1 24151,0 24220,1 24306,0 24389,1 24424,0 24520,1 24542,0 24597,1 24669,0 24695,1 24793,0 24871,1 24941,0 24949,1 24965,0 25027,1 25077,0 25138,1 25181,0 25207,1 25245,0 25323,1 25372,0 25391,1 25457,0 25489,1 25512,0 25542,1 25564,0 25589,1 25603,0 25614,1 25641,0 25649,1 25713,0 25741,1 25797,0 25858,1 25901,0 25956,1 26002,0 26011,1 26079,0 26101,1 26166,0 26250,1 26318,0 26341,1 26414,0 26504,1 26597,0 26650,1 26721,0 26769,1 26837,0 26857,1 26906,0 26936,1 26988,0 26989,1 27048,0 27128,1 27212,0 27310,1 27398,0 27492,1 27582,0 27591,1 27632,0 27696,1 27731,0 27751,1 27756,0 27811,1 27883,0 27933,1 28012,0 28029,1 28064,0 28112,1 28178,0 28208,1 28305,0 28389,1 28429,0 28458,1 28524,0 28620,1 28649,0 28683,1 28709,0 28758,1 28799,0 28803,1 28857,0 28939,1 28976,0 29000,1 29012,0 29050,1 29052,0 29143,1 29186,0 29218,1 29295,0 29321,1 29389,0 29468,1 29532,0 29546,1 29609,0 29681,1 29770,0 29792,1 29858,0 29914,1 29964,0 30049,1 30084,0 30128,1 30214,0 30225,1 30300,0 30323,1 30376,0 30397,1 30473,0 30517,1 30610,0 30699,1 30702,0 30779,1 30867,0 30890,1 30906,0 30970,1 31021,0 31088,1 31159,0 31223,1 31243,0 31245,1 31310,0 31374,1 31381,0 31470,1 31554,0 31612,1 31712,0 31760,1 31769,0 31822,1 31854,0 31891,1 31907,0 31987,1 32047,0 32120,1 32194,0 32205,1 32251,0 32318,1 32418,0 32455,1 32539,0 32630,1 32655,0 32741,1 32810,0 32900,1 32968,0 33050,1 33120,0 33214,1 33243,0 33294,1 33334,0 33424,1 33468,0 33472,1 33484,0 33506,1 33579,0 33580,1 33636,0 33714,1 33794,0 33834,1 33905,0 33969,1 34024,0 34084,1 34094,0 34191,1 34258,0 34349,1 34445,0 34533,1 34604,0 34614,1 34636,0 34647,1 34716,0 34721,1 34768,0 34850,1 34884,0 34940,1 34976,0 35052,1 35100,0 35144,1 35237,0 35304,1 35383,0 35390,1 35476,0 35511,1 35611,0 35634,1 35686,0 35747,1 35780,0 35821,1 35834,0 35911,1 35941,0 35981,1 36072,0 36164,1 36192,0 36216,1 36218,0 36286,1 36332,0 36411,1 36438,0 36441,1 36445,0 36516,1 36610,0 36612,1 36615,0 36669,1 36723,0 36745,1 36773,0 36785,1 36811,0 36825,1 36849,0 36891,1 36905,0 36994,1 37025,0 37106,1 37186,0 37242,1 37292,0 37387,1 37406,0 37461,1 37529,0 37595,1 37635,0 37730,1 37755,0 37837,1 37923,0 37953,1 38020,0 38075,1 38083,0 38127,1 38200,0 38263,1 38323,0 38344,1 38397,0 38405,1 38435,0 38484,1 38568,0 38655,1 38680,0 38761,1 38766,0 38780,1 38824,0 38864,1 38935,0 38940,1 39029,0 39126,1 39149,0 39238,1 39249,0 39328,1 39382,0 39383,1 39478,0 39512,1 39567,0 39625,1 39698,0 39769,1 39807,0 39864,1 39901,0 39932,1 40000,0 40096,1 40130,0 40192,1 40278,0 40334,1 40351,0 40369,1 40406,0 40491,1 40549,0 40638,1 40735,0 40743,1 40779,0 40844,1 40873,0 40933,1 40957,0 41017,1 41040,0 41117,1 41152,0 41229,1 41232,0 41302,1 41304,0 41326,1 41425,0 41451,1 41461,0 41555,1 41583,0 41682,1 41709,0 41782,1 41849,0 41927,1 41945,0 41970,1 42023,0 42112,1 42145,0 42182,1 42224,0 42251,1 42280,0 42286,1 42293,0 42346,1 42421,0 42453,1 42524,0 42598,1 42659,0 42727,1 42827,0 42834,1 42839,0 42878,1 42971,0 43053,1 43152,0 43241,1 43279,0 43370,1 43461,0 43500,1 43565,0 43653,1 43713,0 43775,1 43788,0 43865,1 43936,0 44036,1 44056,0 44139,1 44216,0 44310,1 44343,0 44427,1 44520,0 44595,1 44626,0 44643,1 44722,0 44772,1 44802,0 44809,1 44894,0 44896,1 44957,0 44980,1 45025,0 45117,1 45206,0 45303,1 45374,0 45429,1 45487,0 45579,1 45614,0 45683,1 45705,0 45803,1 45835,0 45844,1 45944,0 46004,1 46083,0 46157,1 46188,0 46216,1 46257,0 46345,1 46419,0 46470,1 46545,0 46606,1 46670,0 46740,1 46834,0 46861,1 46875,0 46943,1 47038,0 47104,1 47140,0 47238,1 47250,0 47325,1 47342,0 47428,1 47440,0 47539,1 47554,0 47562,1 47657,0 47674,1 47678,0 47764,1 47827,0 47894,1 47955,0 48035,1 48044,0 48105,1 48193,0 48264,1 48312,0 48328,1 48378,0 48388,1 48389,0 48444,1 48502,0 48538,1 48550,0 48587,1 48686,0 48692,1 48726,0 48728,1 48751,0 48806,1 48807,0 48820,1 48882,0 48900,1 48946,0 49000,1 49069,0 49131,1 49209,0 49291,1 49332,0 49339,1 49410,0 49450,1 49496,0 49570,1 49580,0 49645,1 49694,0 49747,1 49771,0 49783,1 49806,0 49807,1 49864,0 49879,1 49898,0 49953,1 50020,0 50106,1 50113,0 50150,1 50244,0 50310,1 50358,0 50364,1 50429,0 50469,1 50515,0 50523,1 50597,0 50694,1 50743,0 50779,1 50807,0 50845,1 end initlist b3 0,0 21,1 98,0 179,1 251,0 320,1 354,0 432,1 497,0 538,1 620,0 699,1 786,0 805,1 855,0 882,1 889,0 938,1 1007,0 1042,1 1083,0 1154,1 1223,0 1268,1 1314,0 1394,1 1457,0 1481,1 1524,0 1586,1 1618,0 1630,1 1658,0 1749,1 1811,0 1859,1 1930,0 1974,1 2027,0 2107,1 2137,0 2166,1 2182,0 2270,1 2331,0 2366,1 2402,0 2457,1 2514,0 2609,1 2691,0 2767,1 2856,0 2876,1 2916,0 3016,1 3041,0 3050,1 3144,0 3193,1 3246,0 3327,1 3345,0 3430,1 3526,0 3606,1 3693,0 3722,1 3767,0 3781,1 3813,0 3883,1 3979,0 4009,1 4077,0 4111,1 4194,0 4240,1 4270,0 4360,1 4364,0 4406,1 4502,0 4562,1 4570,0 4636,1 4679,0 4691,1 4770,0 4820,1 4882,0 4958,1 4983,0 5071,1 5153,0 5244,1 5314,0 5408,1 5427,0 5518,1 5593,0 5639,1 5653,0 5751,1 5845,0 5894,1 5913,0 5982,1 5986,0 6061,1 6127,0 6139,1 6203,0 6241,1 6296,0 6385,1 6415,0 6445,1 6456,0 6520,1 6616,0 6626,1 6726,0 6728,1 6771,0 6864,1 6888,0 6894,1 6991,0 7090,1 7131,0 7208,1 7230,0 7294,1 7374,0 7390,1 7467,0 7520,1 7609,0 7622,1 7642,0 7729,1 7738,0 7748,1 7793,0 7838,1 7900,0 7926,1 7977,0 8055,1 8104,0 8116,1 8150,0 8224,1 8270,0 8359,1 8367,0 8376,1 8466,0 8505,1 8527,0 8614,1 8685,0 8777,1 8848,0 8861,1 8864,0 8905,1 8957,0 9022,1 9066,0 9068,1 9126,0 9182,1 9256,0 9290,1 9301,0 9326,1 9381,0 9451,1 9511,0 9585,1 9643,0 9686,1 9754,0 9782,1 9863,0 9929,1 9965,0 9980,1 10035,0 10072,1 10163,0 10249,1 10313,0 10402,1 10411,0 10436,1 10452,0 10478,1 10496,0 10511,1 10547,0 10595,1 10637,0 10680,1 10703,0 10761,1 10766,0 10848,1 10933,0 11004,1 11028,0 11102,1 11194,0 11273,1 11351,0 11400,1 11434,0 11502,1 11560,0 11618,1 11700,0 11735,1 11801,0 11858,1 11881,0 11900,1 11969,0 12008,1 12030,0 12126,1 12185,0 12285,1 12310,0 12382,1 12384,0 12407,1 12469,0 12501,1 12601,0 12631,1 12664,0 12688,1 12748,0 12824,1 12922,0 12975,1 12986,0 13025,1 13115,0 13182,1 13277,0 13307,1 13334,0 13342,1 13409,0 13445,1 13536,0 13619,1 13625,0 13634,1 13646,0 13741,1 13785,0 13871,1 13908,0 13957,1 14020,0 14054,1 14067,0 14120,1 14130,0 14153,1 14183,0 14276,1 14340,0 14343,1 14414,0 14454,1 14532,0 14553,1 14604,0 14659,1 14689,0 14777,1 14817,0 14895,1 14913,0 14978,1 15031,0 15073,1 15111,0 15173,1 15207,0 15306,1 15384,0 15409,1 15509,0 15543,1 15615,0 15693,1 15791,0 15800,1 15820,0 15916,1 15929,0 15948,1 15989,0 16039,1 16131,0 16197,1 16225,0 16301,1 16319,0 16333,1 16381,0 16439,1 16531,0 16544,1 16570,0 16636,1 16653,0 16683,1 16700,0 16755,1 16818,0 16857,1 16918,0 16935,1 16955,0 17052,1 17066,0 17102,1 17187,0 17243,1 17332,0 17416,1 17504,0 17563,1 17636,0 17697,1 17797,0 17854,1 17904,0 17959,1 17977,0 18010,1 18102,0 18169,1 18269,0 18353,1 18414,0 18415,1 18428,0 18464,1 18536,0 18618,1 18641,0 18727,1 18732,0 18814,1 18849,0 18879,1 18940,0 18979,1 19026,0 19087,1 19149,0 19190,1 19221,0 19225,1 19323,0 19400,1 19425,0 19499,1 19561,0 19575,1 19624,0 19643,1 19714,0 19784,1 19876,0 19894,1 19969,0 20049,1 20112,0 20186,1 20262,0 20328,1 20338,0 20393,1 20438,0 20519,1 20523,0 20598,1 20609,0 20660,1 20753,0 20834,1 20890,0 20931,1 21014,0 21046,1 21076,0 21171,1 21235,0 21327,1 21350,0 21386,1 21462,0 21518,1 21602,0 21604,1 21662,0 21666,1 21675,0 21730,1 21800,0 21826,1 21912,0 21930,1 22001,0 22066,1 22086,0 22129,1 22207,0 22229,1 22287,0 22302,1 22308,0 22315,1 22377,0 22463,1 22465,0 22509,1 22589,0 22608,1 22631,0 22691,1 22720,0 22796,1 22837,0 22883,1 22890,0 22912,1 22952,0 23049,1 23102,0 23157,1 23238,0 23319,1 23326,0 23398,1 23479,0 23491,1 23540,0 23581,1 23589,0 23607,1 23662,0 23761,1 23811,0 23850,1 23862,0 23941,1 24038,0 24063,1 24091,0 24106,1 24197,0 24200,1 24239,0 24325,1 24352,0 24363,1 24451,0 24539,1 24556,0 24631,1 24719,0 24737,1 24804,0 24842,1 24873,0 24958,1 25027,0 25042,1 25105,0 25186,1 25217,0 25277,1 25281,0 25296,1 25382,0 25420,1 25487,0 25504,1 25520,0 25614,1 25705,0 25754,1 25844,0 25854,1 25930,0 26001,1 26036,0 26111,1 26115,0 26133,1 26153,0 26245,1 26323,0 26378,1 26454,0 26465,1 26564,0 26585,1 26643,0 26703,1 26751,0 26786,1 26881,0 26969,1 27016,0 27050,1 27110,0 27208,1 27280,0 27333,1 27361,0 27442,1 27481,0 27525,1 27575,0 27636,1 27703,0 27719,1 27729,0 27826,1 27859,0 27943,1 27992,0 28080,1 28128,0 28139,1 28146,0 28237,1 28274,0 28366,1 28408,0 28423,1 28458,0 28540,1 28597,0 28665,1 28741,0 28815,1 28816,0 28913,1 28939,0 29001,1 29050,0 29137,1 29151,0 29159,1 29226,0 29267,1 29323,0 29375,1 29462,0 29562,1 29642,0 29737,1 29753,0 29845,1 29859,0 29926,1 29977,0 29994,1 30008,0 30099,1 30174,0 30238,1 30338,0 30438,1 30469,0 30544,1 30585,0 30672,1 30752,0 30828,1 30849,0 30938,1 31005,0 31080,1 31173,0 31261,1 31339,0 31432,1 31483,0 31576,1 31665,0 31699,1 31722,0 31730,1 31818,0 31901,1 31997,0 32026,1 32088,0 32091,1 32171,0 32243,1 32252,0 32339,1 32359,0 32424,1 32425,0 32484,1 32577,0 32588,1 32680,0 32763,1 32767,0 32866,1 32874,0 32922,1 32979,0 33071,1 33095,0 33153,1 33199,0 33202,1 33230,0 33278,1 33291,0 33323,1 33386,0 33431,1 33508,0 33573,1 33656,0 33725,1 33742,0 33774,1 33806,0 33878,1 33908,0 33911,1 33990,0 34013,1 34022,0 34055,1 34153,0 34209,1 34302,0 34303,1 34306,0 34352,1 34448,0 34481,1 34510,0 34561,1 34640,0 34682,1 34759,0 34852,1 34940,0 35000,1 35041,0 35117,1 35176,0 35198,1 35210,0 35240,1 35317,0 35350,1 35413,0 35487,1 35526,0 35567,1 35611,0 35683,1 35737,0 35743,1 35821,0 35894,1 35920,0 36006,1 36104,0 36144,1 36174,0 36226,1 36294,0 36326,1 36393,0 36436,1 36476,0 36501,1 36553,0 36642,1 36670,0 36763,1 36815,0 36911,1 36932,0 37029,1 37061,0 37089,1 37131,0 37229,1 37277,0 37294,1 37302,0 37383,1 37421,0 37505,1 37557,0 37583,1 37653,0 37685,1 37741,0 37788,1 37852,0 37910,1 37959,0 37964,1 38037,0 38100,1 38183,0 38236,1 38295,0 38370,1 38403,0 38499,1 38565,0 38653,1 38658,0 38680,1 38684,0 38716,1 38793,0 38832,1 38858,0 38946,1 39024,0 39059,1 39151,0 39159,1 39177,0 39257,1 39301,0 39321,1 39335,0 39364,1 39410,0 39448,1 39531,0 39541,1 39590,0 39655,1 39727,0 39808,1 39870,0 39938,1 39947,0 39972,1 40010,0 40107,1 40112,0 40179,1 40197,0 40284,1 40379,0 40415,1 40501,0 40503,1 40538,0 40619,1 40671,0 40678,1 40730,0 40773,1 40790,0 40816,1 40841,0 40869,1 40951,0 41043,1 41117,0 41174,1 41188,0 41269,1 41345,0 41432,1 41506,0 41598,1 41669,0 41736,1 41794,0 41802,1 41843,0 41855,1 41887,0 41967,1 42003,0 42091,1 42116,0 42172,1 42182,0 42238,1 42298,0 42359,1 42377,0 42403,1 42424,0 42440,1 42496,0 42571,1 42609,0 42654,1 42744,0 42784,1 42793,0 42889,1 42956,0 42966,1 43053,0 43150,1 43217,0 43285,1 43314,0 43338,1 43361,0 43443,1 43524,0 43579,1 43636,0 43727,1 43785,0 43813,1 43899,0 43933,1 43993,0 44057,1 44108,0 44129,1 44160,0 44181,1 44253,0 44291,1 44387,0 44461,1 44519,0 44611,1 44694,0 44714,1 44800,0 44865,1 44868,0 44925,1 44956,0 45050,1 45077,0 45162,1 45245,0 45269,1 45275,0 45344,1 45432,0 45454,1 45472,0 45566,1 45651,0 45685,1 45720,0 45781,1 45827,0 45877,1 45935,0 45950,1 46023,0 46070,1 46083,0 46090,1 46126,0 46157,1 46216,0 46294,1 46313,0 46379,1 46413,0 46456,1 46531,0 46621,1 46622,0 46647,1 46722,0 46819,1 46918,0 46973,1 47057,0 47107,1 47158,0 47171,1 47259,0 47318,1 47338,0 47419,1 47439,0 47490,1 47511,0 47578,1 47602,0 47656,1 47676,0 47729,1 47747,0 47786,1 47816,0 47908,1 47929,0 48015,1 48115,0 48155,1 48233,0 48325,1 48393,0 48421,1 48515,0 48524,1 48550,0 48570,1 48604,0 48610,1 48685,0 48689,1 48728,0 48824,1 48883,0 48921,1 49001,0 49029,1 49054,0 49066,1 49096,0 49165,1 49191,0 49286,1 49291,0 49323,1 49359,0 49438,1 49498,0 49509,1 49607,0 49651,1 49751,0 49788,1 49831,0 49850,1 49925,0 49997,1 50073,0 50124,1 50192,0 50254,1 50291,0 50378,1 50457,0 50493,1 50535,0 50574,1 50636,0 50673,1 50686,0 50758,1 50763,0 50799,1 50871,0 50881,1 50895,0 50962,1 51032,0 51062,1 51073,0 51113,1 51192,0 51284,1 51288,0 51315,1 51387,0 51435,1 51532,0 51537,1 51611,0 51672,1 51695,0 51771,1 51801,0 51819,1 end initlist b4 0,0 73,1 139,0 228,1 282,0 362,1 395,0 429,1 446,0 542,1 624,0 702,1 760,0 817,1 853,0 915,1 943,0 1006,1 1087,0 1177,1 1255,0 1256,1 1346,0 1445,1 1459,0 1534,1 1580,0 1609,1 1647,0 1650,1 1701,0 1712,1 1798,0 1849,1 1926,0 1931,1 2023,0 2067,1 2129,0 2206,1 2274,0 2362,1 2366,0 2407,1 2507,0 2554,1 2556,0 2656,1 2682,0 2762,1 2846,0 2865,1 2875,0 2969,1 3060,0 3090,1 3172,0 3231,1 3254,0 3304,1 3336,0 3430,1 3486,0 3565,1 3569,0 3627,1 3673,0 3760,1 3801,0 3886,1 3893,0 3919,1 3953,0 4020,1 4056,0 4093,1 4169,0 4255,1 4270,0 4292,1 4366,0 4443,1 4524,0 4535,1 4575,0 4634,1 4682,0 4723,1 4763,0 4775,1 4805,0 4891,1 4946,0 5027,1 5083,0 5137,1 5202,0 5212,1 5243,0 5246,1 5257,0 5313,1 5391,0 5470,1 5476,0 5551,1 5596,0 5661,1 5684,0 5762,1 5834,0 5880,1 5887,0 5931,1 5985,0 6073,1 6115,0 6130,1 6224,0 6297,1 6344,0 6349,1 6406,0 6449,1 6457,0 6479,1 6491,0 6501,1 6592,0 6651,1 6688,0 6710,1 6759,0 6794,1 6859,0 6948,1 7015,0 7019,1 7029,0 7121,1 7166,0 7180,1 7249,0 7322,1 7394,0 7480,1 7490,0 7526,1 7586,0 7618,1 7658,0 7729,1 7747,0 7829,1 7861,0 7882,1 7908,0 7919,1 8007,0 8027,1 8069,0 8137,1 8143,0 8160,1 8208,0 8307,1 8329,0 8394,1 8469,0 8470,1 8508,0 8558,1 8581,0 8670,1 8745,0 8775,1 8806,0 8828,1 8921,0 9018,1 9025,0 9058,1 9148,0 9173,1 9184,0 9234,1 9251,0 9276,1 9328,0 9335,1 9359,0 9408,1 9432,0 9518,1 9587,0 9597,1 9628,0 9642,1 9666,0 9766,1 9819,0 9919,1 9970,0 9994,1 10078,0 10174,1 10187,0 10264,1 10354,0 10439,1 10536,0 10566,1 10600,0 10630,1 10686,0 10723,1 10765,0 10800,1 10807,0 10813,1 10835,0 10892,1 10912,0 10965,1 11023,0 11075,1 11098,0 11107,1 11138,0 11224,1 11277,0 11336,1 11384,0 11450,1 11463,0 11465,1 11467,0 11513,1 11580,0 11645,1 11654,0 11744,1 11756,0 11832,1 11878,0 11931,1 11951,0 12047,1 12144,0 12206,1 12299,0 12364,1 12453,0 12527,1 12613,0 12651,1 12693,0 12766,1 12839,0 12907,1 12950,0 12977,1 13031,0 13119,1 13133,0 13206,1 13244,0 13250,1 13317,0 13380,1 13459,0 13513,1 13556,0 13653,1 13731,0 13821,1 13911,0 13929,1 13933,0 14017,1 14109,0 14113,1 14139,0 14232,1 14282,0 14297,1 14397,0 14415,1 14490,0 14539,1 14633,0 14679,1 14758,0 14844,1 14864,0 14957,1 15003,0 15088,1 15114,0 15205,1 15277,0 15284,1 15371,0 15446,1 15499,0 15546,1 15616,0 15694,1 15786,0 15870,1 15953,0 16037,1 16043,0 16092,1 16131,0 16204,1 16218,0 16228,1 16260,0 16294,1 16375,0 16448,1 16511,0 16607,1 16686,0 16779,1 16834,0 16863,1 16908,0 16989,1 17069,0 17094,1 17178,0 17257,1 17304,0 17370,1 17427,0 17524,1 17611,0 17615,1 17683,0 17730,1 17830,0 17855,1 17930,0 17976,1 18053,0 18071,1 18142,0 18240,1 18323,0 18394,1 18480,0 18545,1 18559,0 18601,1 18646,0 18720,1 18772,0 18836,1 18872,0 18944,1 19007,0 19042,1 19064,0 19107,1 19203,0 19241,1 19288,0 19300,1 19380,0 19382,1 19455,0 19483,1 19517,0 19535,1 19599,0 19662,1 19744,0 19814,1 19826,0 19837,1 19918,0 19955,1 19956,0 20048,1 20101,0 20192,1 20213,0 20281,1 20342,0 20400,1 20415,0 20484,1 20510,0 20544,1 20565,0 20599,1 20600,0 20624,1 20672,0 20745,1 20821,0 20869,1 20906,0 21006,1 21075,0 21115,1 21200,0 21222,1 21307,0 21341,1 21376,0 21436,1 21533,0 21576,1 21634,0 21651,1 21749,0 21782,1 21869,0 21890,1 21959,0 21968,1 22016,0 22058,1 22131,0 22145,1 22157,0 22245,1 22292,0 22347,1 22390,0 22429,1 22473,0 22522,1 22554,0 22653,1 22659,0 22668,1 22672,0 22718,1 22775,0 22852,1 22864,0 22938,1 22954,0 22992,1 23036,0 23072,1 23164,0 23239,1 23259,0 23348,1 23414,0 23428,1 23429,0 23457,1 23466,0 23489,1 23560,0 23611,1 23622,0 23641,1 23677,0 23689,1 23749,0 23841,1 23868,0 23947,1 24031,0 24128,1 24219,0 24309,1 24370,0 24431,1 24476,0 24514,1 24543,0 24596,1 24694,0 24738,1 24762,0 24828,1 24882,0 24883,1 24909,0 24917,1 24938,0 24975,1 24992,0 24995,1 25092,0 25106,1 25183,0 25229,1 25315,0 25384,1 25392,0 25491,1 25567,0 25625,1 25675,0 25717,1 25777,0 25858,1 25927,0 25963,1 26031,0 26124,1 26205,0 26299,1 26303,0 26390,1 26421,0 26475,1 26479,0 26528,1 26604,0 26608,1 26652,0 26747,1 26762,0 26781,1 26842,0 26869,1 26904,0 26983,1 27059,0 27158,1 27245,0 27293,1 27384,0 27484,1 27507,0 27606,1 27656,0 27688,1 27764,0 27835,1 27886,0 27906,1 27943,0 27991,1 28034,0 28080,1 28091,0 28120,1 28126,0 28152,1 28230,0 28246,1 28312,0 28402,1 28453,0 28491,1 28561,0 28594,1 28618,0 28687,1 28744,0 28840,1 28887,0 28895,1 28947,0 29032,1 29048,0 29131,1 29228,0 29310,1 29388,0 29437,1 29488,0 29584,1 29590,0 29622,1 29662,0 29667,1 29677,0 29682,1 29687,0 29780,1 29871,0 29964,1 29992,0 30055,1 30126,0 30137,1 30153,0 30244,1 30297,0 30348,1 30368,0 30428,1 30461,0 30488,1 30583,0 30607,1 30660,0 30717,1 30763,0 30861,1 30916,0 31008,1 31065,0 31103,1 31187,0 31251,1 31327,0 31378,1 31400,0 31489,1 31549,0 31552,1 31617,0 31633,1 31702,0 31794,1 31822,0 31920,1 31954,0 31969,1 32040,0 32100,1 32148,0 32209,1 32275,0 32316,1 32359,0 32421,1 32461,0 32473,1 32530,0 32536,1 32544,0 32595,1 32680,0 32681,1 32735,0 32806,1 32900,0 32956,1 33026,0 33107,1 33118,0 33156,1 33256,0 33279,1 33370,0 33397,1 33460,0 33558,1 33599,0 33695,1 33714,0 33722,1 33820,0 33829,1 33848,0 33884,1 33904,0 33916,1 33952,0 34040,1 34088,0 34172,1 34178,0 34213,1 34281,0 34368,1 34372,0 34389,1 34455,0 34555,1 34643,0 34710,1 34760,0 34779,1 34814,0 34908,1 34909,0 34918,1 34944,0 34964,1 35059,0 35107,1 35125,0 35134,1 35193,0 35269,1 35308,0 35332,1 35425,0 35519,1 35591,0 35680,1 35714,0 35799,1 35883,0 35979,1 36075,0 36168,1 36268,0 36343,1 36397,0 36459,1 36552,0 36595,1 36648,0 36668,1 36682,0 36735,1 36787,0 36837,1 36912,0 36974,1 37000,0 37030,1 37077,0 37154,1 37188,0 37227,1 37287,0 37372,1 37379,0 37477,1 37546,0 37584,1 37586,0 37611,1 37670,0 37724,1 37772,0 37842,1 37927,0 37939,1 37975,0 38037,1 38095,0 38126,1 38152,0 38206,1 38281,0 38327,1 38394,0 38493,1 38498,0 38530,1 38616,0 38617,1 38683,0 38734,1 38750,0 38816,1 38879,0 38893,1 38946,0 38994,1 39011,0 39042,1 39122,0 39213,1 39303,0 39384,1 39467,0 39499,1 39524,0 39548,1 39573,0 39647,1 39713,0 39737,1 39741,0 39808,1 39824,0 39848,1 39916,0 39971,1 40032,0 40101,1 40180,0 40228,1 40240,0 40243,1 40316,0 40341,1 40371,0 40403,1 40418,0 40514,1 40550,0 40575,1 40619,0 40642,1 40692,0 40715,1 40727,0 40790,1 40874,0 40956,1 41006,0 41081,1 41158,0 41180,1 41247,0 41254,1 41338,0 41344,1 41419,0 41497,1 41581,0 41598,1 41605,0 41640,1 41686,0 41768,1 41794,0 41833,1 41873,0 41882,1 41941,0 41957,1 41966,0 41992,1 42014,0 42030,1 42086,0 42171,1 42201,0 42285,1 42331,0 42353,1 42388,0 42467,1 42534,0 42539,1 42549,0 42642,1 42683,0 42734,1 42753,0 42795,1 42827,0 42919,1 43008,0 43051,1 43132,0 43157,1 43202,0 43259,1 43319,0 43365,1 43369,0 43394,1 43490,0 43506,1 43538,0 43629,1 43635,0 43678,1 43717,0 43730,1 43793,0 43848,1 43881,0 43886,1 43971,0 44063,1 44088,0 44151,1 44208,0 44308,1 44334,0 44424,1 44468,0 44568,1 44571,0 44591,1 44643,0 44653,1 44691,0 44773,1 44857,0 44928,1 44955,0 44962,1 44971,0 45042,1 45059,0 45147,1 45215,0 45251,1 45273,0 45353,1 45412,0 45428,1 45492,0 45515,1 45594,0 45624,1 45669,0 45692,1 45766,0 45804,1 45813,0 45841,1 45914,0 45972,1 45974,0 45999,1 46069,0 46153,1 46201,0 46202,1 46258,0 46354,1 46405,0 46470,1 46558,0 46582,1 46598,0 46628,1 46707,0 46777,1 46788,0 46839,1 46887,0 46923,1 46931,0 46971,1 47015,0 47096,1 47188,0 47260,1 47263,0 47285,1 47321,0 47339,1 47399,0 47455,1 47507,0 47593,1 47609,0 47628,1 47677,0 47759,1 47812,0 47892,1 47968,0 48033,1 48054,0 48078,1 48106,0 48111,1 48114,0 48121,1 48126,0 48217,1 48235,0 48284,1 48380,0 48444,1 48476,0 48510,1 48602,0 48637,1 48721,0 48744,1 48746,0 48762,1 48848,0 48873,1 48908,0 48948,1 48972,0 49027,1 49085,0 49159,1 49204,0 49269,1 49351,0 49380,1 49449,0 49477,1 49497,0 49520,1 49608,0 49679,1 49760,0 49801,1 49822,0 49845,1 49909,0 49910,1 50000,0 50011,1 50104,0 50165,1 50249,0 50291,1 50371,0 50379,1 end initlist b5 0,0 54,1 103,0 192,1 292,0 390,1 454,0 479,1 547,0 556,1 565,0 645,1 648,0 690,1 786,0 807,1 899,0 987,1 1018,0 1076,1 1114,0 1147,1 1181,0 1278,1 1321,0 1381,1 1386,0 1434,1 1471,0 1538,1 1577,0 1652,1 1739,0 1794,1 1873,0 1877,1 1878,0 1901,1 1905,0 1967,1 2027,0 2068,1 2160,0 2197,1 2271,0 2342,1 2364,0 2422,1 2484,0 2574,1 2580,0 2635,1 2679,0 2705,1 2753,0 2798,1 2878,0 2883,1 2889,0 2891,1 2958,0 3040,1 3071,0 3129,1 3159,0 3229,1 3322,0 3374,1 3439,0 3445,1 3538,0 3579,1 3663,0 3760,1 3787,0 3827,1 3902,0 3935,1 3993,0 4082,1 4176,0 4266,1 4312,0 4409,1 4430,0 4525,1 4584,0 4604,1 4699,0 4794,1 4859,0 4908,1 4969,0 5003,1 5011,0 5013,1 5029,0 5069,1 5128,0 5212,1 5267,0 5280,1 5351,0 5372,1 5410,0 5455,1 5489,0 5539,1 5562,0 5643,1 5728,0 5797,1 5891,0 5976,1 6008,0 6022,1 6036,0 6047,1 6080,0 6148,1 6152,0 6174,1 6213,0 6298,1 6392,0 6475,1 6490,0 6584,1 6633,0 6718,1 6758,0 6809,1 6853,0 6889,1 6977,0 7038,1 7121,0 7172,1 7199,0 7279,1 7339,0 7353,1 7427,0 7436,1 7514,0 7532,1 7591,0 7689,1 7767,0 7790,1 7796,0 7826,1 7892,0 7969,1 8049,0 8082,1 8163,0 8170,1 8225,0 8283,1 8297,0 8387,1 8393,0 8487,1 8555,0 8613,1 8687,0 8738,1 8777,0 8838,1 8895,0 8962,1 8980,0 9036,1 9120,0 9201,1 9295,0 9325,1 9357,0 9403,1 9419,0 9505,1 9589,0 9651,1 9680,0 9729,1 9731,0 9799,1 9802,0 9902,1 9957,0 10004,1 10042,0 10074,1 10161,0 10224,1 10232,0 10275,1 10311,0 10342,1 10389,0 10420,1 10495,0 10569,1 10654,0 10739,1 10803,0 10811,1 10888,0 10955,1 10998,0 11053,1 11115,0 11155,1 11160,0 11220,1 11287,0 11381,1 11472,0 11483,1 11549,0 11594,1 11647,0 11698,1 11792,0 11878,1 11912,0 11913,1 11951,0 11977,1 12018,0 12051,1 12082,0 12125,1 12174,0 12252,1 12254,0 12307,1 12396,0 12494,1 12559,0 12654,1 12725,0 12740,1 12810,0 12822,1 12922,0 12956,1 13000,0 13021,1 13121,0 13147,1 13159,0 13166,1 13217,0 13282,1 13283,0 13341,1 13359,0 13414,1 13429,0 13461,1 13484,0 13486,1 13516,0 13591,1 13684,0 13777,1 13834,0 13907,1 13997,0 14067,1 14111,0 14183,1 14234,0 14284,1 14334,0 14406,1 14418,0 14508,1 14564,0 14610,1 14686,0 14765,1 14814,0 14818,1 14904,0 14985,1 15051,0 15060,1 15095,0 15151,1 15183,0 15273,1 15344,0 15393,1 15418,0 15478,1 15540,0 15618,1 15633,0 15721,1 15748,0 15763,1 15821,0 15849,1 15925,0 15975,1 15991,0 16003,1 16019,0 16080,1 16099,0 16171,1 16249,0 16255,1 16295,0 16301,1 16370,0 16413,1 16442,0 16542,1 16601,0 16626,1 16633,0 16712,1 16765,0 16842,1 16875,0 16961,1 17015,0 17094,1 17129,0 17134,1 17193,0 17251,1 17293,0 17390,1 17451,0 17510,1 17582,0 17656,1 17658,0 17704,1 17733,0 17764,1 17794,0 17837,1 17857,0 17864,1 17904,0 17920,1 17969,0 17999,1 18094,0 18143,1 18190,0 18253,1 18263,0 18303,1 18310,0 18407,1 18482,0 18537,1 18567,0 18587,1 18636,0 18687,1 18711,0 18770,1 18813,0 18868,1 18881,0 18889,1 18947,0 18949,1 19012,0 19056,1 19115,0 19178,1 19238,0 19256,1 19350,0 19375,1 19458,0 19550,1 19623,0 19701,1 19735,0 19804,1 19896,0 19977,1 20070,0 20103,1 20117,0 20159,1 20175,0 20274,1 20341,0 20406,1 20457,0 20499,1 20542,0 20619,1 20687,0 20764,1 20769,0 20802,1 20857,0 20916,1 20988,0 21064,1 21119,0 21167,1 21187,0 21191,1 21209,0 21235,1 21285,0 21381,1 21479,0 21526,1 21587,0 21679,1 21776,0 21845,1 21927,0 22026,1 22126,0 22185,1 22216,0 22233,1 22317,0 22337,1 22401,0 22453,1 22506,0 22590,1 22631,0 22675,1 22691,0 22693,1 22712,0 22745,1 22827,0 22922,1 22934,0 22954,1 23047,0 23138,1 23199,0 23215,1 23220,0 23290,1 23327,0 23389,1 23397,0 23487,1 23547,0 23634,1 23688,0 23780,1 23830,0 23920,1 23929,0 24011,1 24063,0 24132,1 24200,0 24262,1 24307,0 24393,1 24417,0 24511,1 24596,0 24694,1 24749,0 24773,1 24865,0 24866,1 24934,0 24958,1 25015,0 25058,1 25090,0 25112,1 25127,0 25171,1 25203,0 25273,1 25283,0 25322,1 25358,0 25359,1 25454,0 25551,1 25579,0 25672,1 25758,0 25805,1 25811,0 25881,1 25954,0 26018,1 26078,0 26173,1 26256,0 26277,1 26344,0 26407,1 26417,0 26461,1 26552,0 26585,1 26593,0 26655,1 26718,0 26741,1 26754,0 26763,1 26842,0 26930,1 27024,0 27082,1 27177,0 27256,1 27333,0 27367,1 27432,0 27456,1 27499,0 27550,1 27551,0 27612,1 27636,0 27681,1 27702,0 27713,1 27781,0 27860,1 27883,0 27964,1 28012,0 28040,1 28046,0 28110,1 28202,0 28301,1 28365,0 28409,1 28416,0 28438,1 28507,0 28547,1 28604,0 28609,1 28623,0 28710,1 28766,0 28834,1 28874,0 28955,1 29040,0 29051,1 29141,0 29196,1 29294,0 29314,1 29376,0 29401,1 29447,0 29468,1 29526,0 29612,1 29618,0 29712,1 29776,0 29786,1 29825,0 29829,1 29913,0 29970,1 30058,0 30059,1 30141,0 30240,1 30266,0 30282,1 30331,0 30422,1 30476,0 30506,1 30578,0 30672,1 30691,0 30774,1 30795,0 30876,1 30895,0 30961,1 30993,0 31084,1 31104,0 31176,1 31232,0 31329,1 31425,0 31476,1 31545,0 31637,1 31711,0 31810,1 31846,0 31925,1 31926,0 31927,1 31952,0 32012,1 32068,0 32080,1 32179,0 32264,1 32360,0 32393,1 32437,0 32447,1 32528,0 32533,1 32594,0 32620,1 32678,0 32747,1 32779,0 32831,1 32846,0 32901,1 32941,0 32994,1 32998,0 33034,1 33067,0 33145,1 33151,0 33216,1 33217,0 33257,1 33276,0 33356,1 33416,0 33459,1 33466,0 33500,1 33575,0 33660,1 33720,0 33812,1 33906,0 33953,1 34047,0 34052,1 34118,0 34171,1 34180,0 34222,1 34288,0 34316,1 34367,0 34430,1 34503,0 34583,1 34661,0 34754,1 34818,0 34897,1 34914,0 34995,1 35005,0 35064,1 35156,0 35244,1 35272,0 35345,1 35409,0 35481,1 35579,0 35678,1 35736,0 35819,1 35896,0 35944,1 36000,0 36009,1 36044,0 36071,1 36151,0 36156,1 36172,0 36190,1 36276,0 36321,1 36345,0 36444,1 36515,0 36541,1 36600,0 36682,1 36684,0 36685,1 36740,0 36780,1 36804,0 36848,1 36894,0 36914,1 36995,0 37017,1 37116,0 37187,1 37198,0 37286,1 37328,0 37329,1 37417,0 37501,1 37540,0 37547,1 37571,0 37632,1 37641,0 37715,1 37728,0 37782,1 37835,0 37934,1 37946,0 38002,1 38040,0 38098,1 38099,0 38194,1 38270,0 38334,1 38374,0 38404,1 38406,0 38431,1 38510,0 38541,1 38583,0 38587,1 38660,0 38748,1 38836,0 38891,1 38912,0 39005,1 39035,0 39082,1 39172,0 39200,1 39209,0 39306,1 39338,0 39340,1 39394,0 39434,1 39474,0 39529,1 39601,0 39611,1 39704,0 39721,1 39792,0 39812,1 39882,0 39955,1 39964,0 40034,1 40093,0 40169,1 40222,0 40275,1 40314,0 40355,1 40389,0 40390,1 40434,0 40523,1 40538,0 40606,1 40626,0 40705,1 40805,0 40901,1 40962,0 41032,1 41048,0 41081,1 41136,0 41223,1 41289,0 41383,1 41455,0 41495,1 41586,0 41606,1 41633,0 41683,1 41758,0 41800,1 41876,0 41904,1 41985,0 41988,1 41991,0 41998,1 42060,0 42114,1 42201,0 42206,1 42237,0 42270,1 42322,0 42352,1 42446,0 42519,1 42552,0 42594,1 42639,0 42678,1 42717,0 42736,1 42760,0 42837,1 42921,0 42938,1 42992,0 43049,1 43149,0 43224,1 43244,0 43292,1 43315,0 43366,1 43409,0 43414,1 43418,0 43474,1 43556,0 43654,1 43723,0 43820,1 43887,0 43975,1 44057,0 44087,1 44117,0 44187,1 44220,0 44303,1 44313,0 44364,1 44459,0 44510,1 44582,0 44656,1 44719,0 44735,1 44775,0 44816,1 44856,0 44865,1 44876,0 44890,1 44966,0 45049,1 45070,0 45082,1 45098,0 45124,1 45190,0 45220,1 45295,0 45376,1 45468,0 45490,1 45517,0 45531,1 45533,0 45573,1 45587,0 45621,1 45661,0 45757,1 45805,0 45813,1 45882,0 45903,1 45907,0 45978,1 45993,0 46078,1 46147,0 46203,1 46252,0 46290,1 46342,0 46400,1 46436,0 46499,1 46530,0 46596,1 46599,0 46665,1 46670,0 46687,1 46716,0 46800,1 46847,0 46895,1 46966,0 47054,1 47113,0 47183,1 47226,0 47241,1 47311,0 47356,1 47423,0 47447,1 47496,0 47508,1 47532,0 47605,1 47679,0 47763,1 47830,0 47856,1 47887,0 47894,1 47964,0 48032,1 48116,0 48138,1 48163,0 48214,1 48260,0 48350,1 48395,0 48406,1 48472,0 48508,1 48516,0 48544,1 48564,0 48625,1 48716,0 48782,1 48853,0 48882,1 48949,0 48990,1 49005,0 49017,1 49040,0 49104,1 49126,0 49146,1 49232,0 49315,1 49393,0 49486,1 49560,0 49608,1 49677,0 49690,1 49743,0 49774,1 49794,0 49836,1 49907,0 49931,1 49987,0 50011,1 50037,0 50042,1 50139,0 50234,1 50252,0 50257,1 50263,0 50286,1 50305,0 50355,1 50372,0 50383,1 50457,0 50542,1 50609,0 50693,1 50770,0 50863,1 end initlist b6 0,0 42,1 80,0 98,1 162,0 163,1 212,0 229,1 249,0 304,1 399,0 448,1 483,0 503,1 569,0 607,1 659,0 668,1 684,0 760,1 852,0 899,1 948,0 965,1 1008,0 1058,1 1115,0 1193,1 1261,0 1340,1 1430,0 1514,1 1555,0 1611,1 1688,0 1710,1 1722,0 1793,1 1835,0 1924,1 1961,0 1987,1 2014,0 2023,1 2041,0 2071,1 2154,0 2158,1 2252,0 2341,1 2351,0 2367,1 2439,0 2522,1 2578,0 2621,1 2626,0 2689,1 2713,0 2796,1 2862,0 2918,1 3000,0 3057,1 3092,0 3190,1 3192,0 3233,1 3238,0 3275,1 3327,0 3425,1 3466,0 3495,1 3537,0 3596,1 3683,0 3761,1 3846,0 3856,1 3948,0 4025,1 4041,0 4065,1 4143,0 4216,1 4279,0 4284,1 4307,0 4385,1 4435,0 4446,1 4457,0 4521,1 4571,0 4604,1 4672,0 4743,1 4780,0 4805,1 4817,0 4830,1 4860,0 4913,1 4940,0 4960,1 5048,0 5079,1 5125,0 5193,1 5281,0 5307,1 5346,0 5389,1 5473,0 5556,1 5573,0 5602,1 5614,0 5633,1 5712,0 5732,1 5779,0 5853,1 5915,0 5973,1 6045,0 6085,1 6157,0 6194,1 6294,0 6322,1 6417,0 6421,1 6422,0 6471,1 6496,0 6574,1 6647,0 6663,1 6709,0 6740,1 6834,0 6836,1 6926,0 7024,1 7074,0 7156,1 7230,0 7289,1 7377,0 7466,1 7538,0 7621,1 7655,0 7663,1 7747,0 7786,1 7814,0 7862,1 7887,0 7953,1 7954,0 7956,1 8055,0 8076,1 8111,0 8195,1 8251,0 8304,1 8334,0 8394,1 8400,0 8475,1 8541,0 8586,1 8633,0 8677,1 8742,0 8800,1 8893,0 8926,1 8988,0 9020,1 9040,0 9045,1 9090,0 9175,1 9201,0 9278,1 9335,0 9367,1 9408,0 9450,1 9469,0 9502,1 9544,0 9600,1 9660,0 9712,1 9715,0 9736,1 9807,0 9872,1 9919,0 9978,1 10038,0 10069,1 10146,0 10148,1 10188,0 10279,1 10369,0 10378,1 10462,0 10562,1 10563,0 10647,1 10696,0 10755,1 10779,0 10861,1 10941,0 11037,1 11048,0 11136,1 11157,0 11219,1 11267,0 11300,1 11371,0 11426,1 11451,0 11476,1 11477,0 11507,1 11597,0 11607,1 11670,0 11770,1 11857,0 11944,1 11993,0 12010,1 12041,0 12129,1 12141,0 12184,1 12253,0 12348,1 12407,0 12485,1 12488,0 12524,1 12582,0 12679,1 12719,0 12766,1 12830,0 12883,1 12978,0 12992,1 13061,0 13146,1 13231,0 13270,1 13287,0 13292,1 13357,0 13405,1 13484,0 13563,1 13588,0 13651,1 13689,0 13693,1 13734,0 13756,1 13849,0 13923,1 13924,0 13986,1 14032,0 14067,1 14077,0 14153,1 14176,0 14214,1 14232,0 14305,1 14331,0 14373,1 14470,0 14557,1 14564,0 14593,1 14632,0 14730,1 14794,0 14886,1 14968,0 15034,1 15057,0 15153,1 15205,0 15240,1 15335,0 15380,1 15473,0 15529,1 15591,0 15667,1 15698,0 15718,1 15758,0 15841,1 15876,0 15910,1 15956,0 16016,1 16017,0 16104,1 16131,0 16164,1 16165,0 16173,1 16232,0 16277,1 16300,0 16361,1 16443,0 16493,1 16516,0 16535,1 16603,0 16624,1 16647,0 16673,1 16711,0 16724,1 16732,0 16753,1 16766,0 16770,1 16784,0 16815,1 16854,0 16943,1 17020,0 17050,1 17125,0 17223,1 17239,0 17282,1 17370,0 17445,1 17468,0 17494,1 17589,0 17640,1 17738,0 17780,1 17783,0 17831,1 17913,0 17976,1 18066,0 18163,1 18213,0 18312,1 18361,0 18393,1 18443,0 18503,1 18583,0 18620,1 18687,0 18782,1 18788,0 18842,1 18930,0 18957,1 18963,0 19006,1 19088,0 19141,1 19206,0 19296,1 19386,0 19441,1 19530,0 19629,1 19641,0 19708,1 19752,0 19778,1 19812,0 19813,1 19892,0 19988,1 20063,0 20113,1 20140,0 20151,1 20179,0 20187,1 20276,0 20296,1 20342,0 20358,1 20430,0 20503,1 20566,0 20591,1 20621,0 20682,1 20740,0 20772,1 20800,0 20879,1 20913,0 20950,1 20968,0 21021,1 21023,0 21025,1 21073,0 21075,1 21130,0 21213,1 21249,0 21311,1 21326,0 21378,1 21477,0 21572,1 21658,0 21758,1 21776,0 21833,1 21839,0 21901,1 21926,0 21985,1 21997,0 22032,1 22046,0 22068,1 22158,0 22246,1 22263,0 22334,1 22415,0 22465,1 22473,0 22527,1 22544,0 22558,1 22580,0 22668,1 22729,0 22742,1 22784,0 22874,1 22902,0 22980,1 23021,0 23097,1 23108,0 23149,1 23182,0 23278,1 23366,0 23438,1 23451,0 23550,1 23624,0 23703,1 23757,0 23846,1 23856,0 23898,1 23934,0 24004,1 24099,0 24106,1 24170,0 24263,1 24351,0 24442,1 24466,0 24514,1 24522,0 24533,1 24547,0 24633,1 24679,0 24738,1 24795,0 24820,1 24841,0 24935,1 24969,0 25028,1 25118,0 25187,1 25210,0 25302,1 25321,0 25395,1 25451,0 25461,1 25480,0 25577,1 25611,0 25636,1 25656,0 25751,1 25795,0 25854,1 25868,0 25966,1 26010,0 26077,1 26081,0 26159,1 26188,0 26245,1 26269,0 26304,1 26372,0 26452,1 26529,0 26567,1 26634,0 26708,1 26782,0 26797,1 26876,0 26880,1 26960,0 27004,1 27010,0 27081,1 27097,0 27116,1 27134,0 27141,1 27212,0 27225,1 27253,0 27266,1 27357,0 27361,1 27394,0 27463,1 27550,0 27568,1 27606,0 27693,1 27763,0 27797,1 27860,0 27919,1 27987,0 28030,1 28086,0 28131,1 28173,0 28239,1 28257,0 28266,1 28354,0 28366,1 28421,0 28483,1 28510,0 28599,1 28647,0 28657,1 28690,0 28733,1 28751,0 28774,1 28840,0 28869,1 28903,0 28937,1 28948,0 29011,1 29057,0 29107,1 29182,0 29229,1 29286,0 29310,1 29335,0 29343,1 29436,0 29459,1 29520,0 29603,1 29681,0 29734,1 29763,0 29788,1 29877,0 29966,1 30038,0 30091,1 30164,0 30218,1 30316,0 30342,1 30381,0 30410,1 30439,0 30507,1 30559,0 30631,1 30731,0 30788,1 30873,0 30970,1 31002,0 31030,1 31042,0 31116,1 31124,0 31147,1 31204,0 31225,1 31279,0 31309,1 31383,0 31476,1 31575,0 31629,1 31661,0 31670,1 31697,0 31740,1 31789,0 31808,1 31822,0 31890,1 31966,0 32034,1 32057,0 32095,1 32123,0 32217,1 32230,0 32269,1 32317,0 32406,1 32466,0 32556,1 32622,0 32715,1 32735,0 32833,1 32918,0 32937,1 32968,0 32997,1 33077,0 33144,1 33237,0 33263,1 33280,0 33293,1 33328,0 33334,1 33424,0 33496,1 33576,0 33626,1 33630,0 33666,1 33677,0 33679,1 33738,0 33780,1 33850,0 33940,1 33963,0 34060,1 34066,0 34098,1 34114,0 34126,1 34219,0 34222,1 34290,0 34321,1 34324,0 34336,1 34427,0 34465,1 34550,0 34591,1 34685,0 34703,1 34708,0 34802,1 34807,0 34841,1 34876,0 34945,1 35002,0 35101,1 35142,0 35151,1 35163,0 35172,1 35265,0 35337,1 35416,0 35467,1 35526,0 35581,1 35606,0 35651,1 35658,0 35740,1 35750,0 35795,1 35814,0 35838,1 35850,0 35918,1 35956,0 35970,1 35984,0 36008,1 36066,0 36132,1 36204,0 36237,1 36248,0 36329,1 36419,0 36467,1 36543,0 36559,1 36647,0 36672,1 36680,0 36719,1 36783,0 36845,1 36882,0 36895,1 36969,0 36994,1 37068,0 37151,1 37154,0 37184,1 37280,0 37296,1 37302,0 37366,1 37380,0 37473,1 37513,0 37583,1 37652,0 37703,1 37794,0 37797,1 37871,0 37955,1 38035,0 38039,1 38069,0 38099,1 38184,0 38220,1 38283,0 38317,1 38357,0 38438,1 38534,0 38584,1 38617,0 38636,1 38691,0 38745,1 38815,0 38838,1 38908,0 39007,1 39086,0 39142,1 39153,0 39171,1 39209,0 39266,1 39312,0 39333,1 39414,0 39476,1 39497,0 39588,1 39607,0 39665,1 39716,0 39740,1 39744,0 39777,1 39786,0 39846,1 39889,0 39930,1 40030,0 40104,1 40189,0 40235,1 40287,0 40347,1 40366,0 40438,1 40475,0 40565,1 40593,0 40644,1 40738,0 40791,1 40888,0 40960,1 40974,0 41006,1 41059,0 41100,1 41179,0 41225,1 41276,0 41351,1 41379,0 41455,1 41507,0 41604,1 41689,0 41729,1 41805,0 41835,1 41854,0 41871,1 41941,0 42008,1 42026,0 42090,1 42161,0 42230,1 42247,0 42253,1 42265,0 42274,1 42337,0 42385,1 42410,0 42482,1 42517,0 42580,1 42599,0 42697,1 42743,0 42780,1 42875,0 42896,1 42933,0 43021,1 43023,0 43097,1 43178,0 43223,1 43244,0 43299,1 43389,0 43421,1 43495,0 43580,1 43636,0 43660,1 43756,0 43785,1 43797,0 43856,1 43955,0 43959,1 43965,0 44047,1 44124,0 44208,1 44231,0 44264,1 44357,0 44421,1 44468,0 44515,1 44526,0 44585,1 44587,0 44603,1 44636,0 44710,1 44810,0 44825,1 44921,0 44944,1 44945,0 45023,1 45066,0 45079,1 45106,0 45173,1 45193,0 45263,1 45345,0 45347,1 45380,0 45385,1 45477,0 45514,1 45574,0 45621,1 45625,0 45640,1 45658,0 45750,1 45774,0 45873,1 45929,0 45996,1 46012,0 46100,1 46138,0 46146,1 46238,0 46285,1 46300,0 46327,1 46365,0 46398,1 46444,0 46498,1 46545,0 46613,1 46658,0 46690,1 46703,0 46770,1 46843,0 46882,1 46937,0 46990,1 47055,0 47137,1 47214,0 47232,1 47315,0 47349,1 47387,0 47431,1 47518,0 47547,1 47610,0 47647,1 47654,0 47683,1 47778,0 47856,1 47866,0 47910,1 47973,0 47980,1 48033,0 48076,1 48079,0 48085,1 48124,0 48217,1 48226,0 48286,1 48340,0 48416,1 48424,0 48435,1 48514,0 48515,1 48519,0 48600,1 48672,0 48687,1 48704,0 48742,1 48787,0 48825,1 48919,0 48930,1 end initlist b7 0,0 79,1 109,0 154,1 184,0 230,1 262,0 307,1 386,0 455,1 465,0 509,1 542,0 578,1 615,0 690,1 742,0 767,1 863,0 918,1 1011,0 1038,1 1077,0 1086,1 1114,0 1212,1 1254,0 1259,1 1331,0 1420,1 1502,0 1522,1 1528,0 1601,1 1641,0 1730,1 1787,0 1885,1 1935,0 1963,1 1990,0 2074,1 2078,0 2178,1 2189,0 2200,1 2209,0 2227,1 2238,0 2336,1 2415,0 2444,1 2527,0 2615,1 2651,0 2666,1 2693,0 2769,1 2773,0 2833,1 2912,0 2926,1 2969,0 3021,1 3093,0 3172,1 3245,0 3321,1 3366,0 3390,1 3460,0 3510,1 3601,0 3677,1 3705,0 3781,1 3852,0 3911,1 3930,0 3974,1 4022,0 4106,1 4180,0 4211,1 4244,0 4288,1 4319,0 4389,1 4415,0 4490,1 4499,0 4553,1 4652,0 4668,1 4733,0 4785,1 4831,0 4871,1 4950,0 4993,1 5018,0 5117,1 5130,0 5225,1 5252,0 5278,1 5324,0 5392,1 5424,0 5476,1 5525,0 5604,1 5703,0 5744,1 5841,0 5938,1 6012,0 6019,1 6029,0 6058,1 6138,0 6147,1 6167,0 6192,1 6217,0 6262,1 6312,0 6351,1 6406,0 6487,1 6531,0 6611,1 6642,0 6688,1 6761,0 6773,1 6863,0 6959,1 7057,0 7118,1 7159,0 7161,1 7250,0 7320,1 7329,0 7423,1 7521,0 7575,1 7669,0 7741,1 7810,0 7831,1 7890,0 7897,1 7912,0 7938,1 8034,0 8133,1 8152,0 8155,1 8198,0 8239,1 8337,0 8435,1 8502,0 8527,1 8606,0 8648,1 8660,0 8671,1 8751,0 8794,1 8881,0 8979,1 9065,0 9088,1 9158,0 9244,1 9309,0 9331,1 9386,0 9435,1 9463,0 9523,1 9576,0 9602,1 9651,0 9677,1 9764,0 9770,1 9864,0 9940,1 10019,0 10063,1 10135,0 10196,1 10233,0 10258,1 10285,0 10316,1 10322,0 10330,1 10375,0 10381,1 10401,0 10457,1 10488,0 10507,1 10558,0 10649,1 10749,0 10840,1 10930,0 10956,1 11015,0 11071,1 11119,0 11163,1 11212,0 11221,1 11254,0 11312,1 11367,0 11374,1 11450,0 11523,1 11576,0 11612,1 11676,0 11682,1 11743,0 11792,1 11861,0 11947,1 12006,0 12068,1 12115,0 12147,1 12185,0 12250,1 12333,0 12389,1 12408,0 12458,1 12477,0 12485,1 12552,0 12621,1 12625,0 12711,1 12716,0 12748,1 12798,0 12818,1 12830,0 12927,1 13022,0 13115,1 13212,0 13214,1 13293,0 13341,1 13365,0 13447,1 13457,0 13480,1 13559,0 13597,1 13643,0 13695,1 13771,0 13791,1 13827,0 13841,1 13876,0 13967,1 14030,0 14119,1 14204,0 14252,1 14256,0 14293,1 14384,0 14453,1 14454,0 14548,1 14600,0 14636,1 14706,0 14768,1 14810,0 14879,1 14886,0 14938,1 14989,0 15038,1 15108,0 15208,1 15297,0 15299,1 15336,0 15354,1 15449,0 15511,1 15561,0 15578,1 15645,0 15703,1 15774,0 15865,1 15884,0 15912,1 15918,0 16012,1 16094,0 16114,1 16165,0 16233,1 16238,0 16241,1 16341,0 16441,1 16511,0 16580,1 16589,0 16635,1 16674,0 16752,1 16827,0 16912,1 16973,0 17027,1 17112,0 17124,1 17214,0 17241,1 17304,0 17345,1 17363,0 17448,1 17487,0 17536,1 17548,0 17560,1 17624,0 17719,1 17731,0 17740,1 17803,0 17805,1 17884,0 17953,1 18032,0 18080,1 18157,0 18205,1 18240,0 18284,1 18342,0 18350,1 18434,0 18460,1 18524,0 18573,1 18634,0 18715,1 18791,0 18880,1 18970,0 18989,1 19084,0 19151,1 19203,0 19260,1 19317,0 19416,1 19469,0 19554,1 19566,0 19607,1 19701,0 19716,1 19737,0 19791,1 19872,0 19951,1 20040,0 20073,1 20094,0 20099,1 20132,0 20192,1 20249,0 20253,1 20257,0 20353,1 20375,0 20407,1 20498,0 20512,1 20608,0 20648,1 20734,0 20755,1 20763,0 20818,1 20841,0 20848,1 20909,0 20980,1 20981,0 21034,1 21057,0 21060,1 21103,0 21199,1 21289,0 21293,1 21373,0 21375,1 21376,0 21429,1 21502,0 21524,1 21553,0 21652,1 21673,0 21754,1 21816,0 21909,1 21918,0 21965,1 21987,0 22059,1 22146,0 22236,1 22313,0 22404,1 22441,0 22483,1 22569,0 22579,1 22634,0 22653,1 22735,0 22793,1 22864,0 22938,1 23021,0 23042,1 23091,0 23113,1 23184,0 23275,1 23349,0 23358,1 23361,0 23371,1 23467,0 23528,1 23605,0 23695,1 23785,0 23873,1 23884,0 23942,1 24027,0 24047,1 24079,0 24085,1 24160,0 24213,1 24219,0 24295,1 24316,0 24372,1 24395,0 24409,1 24473,0 24510,1 24564,0 24636,1 24729,0 24827,1 24883,0 24960,1 25017,0 25059,1 25101,0 25189,1 25220,0 25311,1 25408,0 25500,1 25532,0 25619,1 25693,0 25729,1 25808,0 25906,1 25920,0 25925,1 25937,0 25983,1 26028,0 26099,1 26119,0 26192,1 26271,0 26272,1 26329,0 26419,1 26519,0 26555,1 26585,0 26674,1 26706,0 26707,1 26801,0 26889,1 26977,0 27008,1 27048,0 27069,1 27112,0 27185,1 27246,0 27279,1 27349,0 27375,1 27454,0 27507,1 27585,0 27638,1 27719,0 27793,1 27805,0 27817,1 27902,0 27937,1 28006,0 28034,1 28105,0 28193,1 28232,0 28261,1 28291,0 28320,1 28381,0 28391,1 28448,0 28477,1 28550,0 28634,1 28636,0 28656,1 28696,0 28728,1 28753,0 28821,1 28840,0 28886,1 28913,0 28927,1 28995,0 29048,1 29131,0 29218,1 29263,0 29324,1 29424,0 29484,1 29578,0 29637,1 29679,0 29766,1 29861,0 29900,1 29996,0 30016,1 30083,0 30128,1 30191,0 30289,1 30356,0 30358,1 30390,0 30467,1 30524,0 30564,1 30594,0 30672,1 30696,0 30789,1 30884,0 30931,1 31002,0 31045,1 31064,0 31131,1 31154,0 31187,1 31247,0 31278,1 31354,0 31388,1 31415,0 31512,1 31525,0 31600,1 31643,0 31670,1 31701,0 31728,1 31768,0 31796,1 31802,0 31822,1 31837,0 31862,1 31874,0 31919,1 31986,0 32019,1 32057,0 32111,1 32126,0 32155,1 32160,0 32245,1 32308,0 32319,1 32400,0 32444,1 32484,0 32532,1 32621,0 32698,1 32724,0 32824,1 32866,0 32911,1 32943,0 32993,1 33024,0 33071,1 33159,0 33235,1 33299,0 33387,1 33442,0 33483,1 33572,0 33670,1 33764,0 33848,1 33878,0 33961,1 34039,0 34057,1 34138,0 34208,1 34269,0 34272,1 34361,0 34396,1 34486,0 34574,1 34611,0 34660,1 34735,0 34797,1 34844,0 34892,1 34903,0 34999,1 35092,0 35100,1 35162,0 35228,1 35234,0 35245,1 35330,0 35401,1 35435,0 35474,1 35482,0 35498,1 35501,0 35503,1 35574,0 35623,1 35722,0 35735,1 35810,0 35849,1 35900,0 35947,1 35973,0 35985,1 36002,0 36088,1 36151,0 36170,1 36261,0 36360,1 36456,0 36475,1 36569,0 36643,1 36687,0 36786,1 36865,0 36912,1 37011,0 37044,1 37101,0 37109,1 37170,0 37234,1 37239,0 37317,1 37398,0 37425,1 37449,0 37515,1 37552,0 37589,1 37637,0 37699,1 37756,0 37825,1 37854,0 37938,1 37951,0 38002,1 38048,0 38110,1 38175,0 38252,1 38326,0 38397,1 38449,0 38532,1 38621,0 38644,1 38684,0 38725,1 38733,0 38747,1 38826,0 38896,1 38990,0 39005,1 39031,0 39088,1 39182,0 39196,1 39267,0 39367,1 39378,0 39469,1 39471,0 39529,1 39609,0 39681,1 39776,0 39804,1 39871,0 39897,1 39997,0 40039,1 40135,0 40225,1 40247,0 40277,1 40295,0 40298,1 40309,0 40318,1 40387,0 40409,1 40428,0 40450,1 40548,0 40575,1 40650,0 40706,1 40805,0 40809,1 40819,0 40882,1 40924,0 40968,1 41019,0 41101,1 41127,0 41156,1 41249,0 41301,1 41305,0 41379,1 41407,0 41442,1 41459,0 41503,1 41535,0 41613,1 41632,0 41699,1 41737,0 41816,1 41832,0 41841,1 41864,0 41883,1 41912,0 41936,1 42016,0 42027,1 42032,0 42077,1 42156,0 42247,1 42300,0 42332,1 42341,0 42403,1 42416,0 42500,1 42512,0 42574,1 42652,0 42660,1 42678,0 42689,1 42705,0 42737,1 42742,0 42818,1 42874,0 42928,1 42993,0 43012,1 43103,0 43136,1 43160,0 43182,1 43271,0 43349,1 43442,0 43461,1 43503,0 43543,1 43631,0 43704,1 43765,0 43824,1 43904,0 43946,1 43999,0 44067,1 44107,0 44150,1 44235,0 44302,1 44384,0 44453,1 44471,0 44521,1 44569,0 44659,1 44686,0 44696,1 44790,0 44847,1 44899,0 44968,1 45009,0 45048,1 45079,0 45087,1 45095,0 45158,1 45192,0 45288,1 45361,0 45414,1 45417,0 45458,1 45507,0 45556,1 45653,0 45704,1 45743,0 45837,1 45907,0 45995,1 46013,0 46030,1 46110,0 46125,1 46195,0 46275,1 46293,0 46294,1 46351,0 46429,1 46463,0 46523,1 46545,0 46625,1 46639,0 46675,1 46757,0 46845,1 46851,0 46916,1 46973,0 47034,1 47035,0 47054,1 47145,0 47200,1 47254,0 47270,1 47275,0 47370,1 47398,0 47471,1 47537,0 47588,1 47673,0 47701,1 47741,0 47834,1 47891,0 47917,1 47957,0 48016,1 48092,0 48130,1 48213,0 48274,1 48285,0 48354,1 48434,0 48532,1 48547,0 48606,1 48669,0 48754,1 48805,0 48903,1 48982,0 49067,1 49159,0 49195,1 49240,0 49284,1 49365,0 49459,1 49471,0 49571,1 49652,0 49712,1 49729,0 49760,1 49846,0 49850,1 49879,0 49948,1 50022,0 50076,1 50165,0 50240,1 50253,0 50300,1 50399,0 50452,1 50523,0 50619,1 50654,0 50692,1 50751,0 50830,1 50857,0 50885,1 50978,0 51058,1 51092,0 51180,1 51255,0 51258,1 51349,0 51432,1 51465,0 51535,1 51562,0 51590,1 51628,0 51684,1 end initlist b8 0,0 15,1 17,0 107,1 187,0 228,1 231,0 312,1 334,0 350,1 352,0 434,1 459,0 480,1 550,0 553,1 570,0 593,1 692,0 786,1 799,0 878,1 896,0 943,1 1031,0 1076,1 1101,0 1130,1 1177,0 1191,1 1197,0 1232,1 1291,0 1307,1 1384,0 1475,1 1501,0 1596,1 1695,0 1698,1 1700,0 1718,1 1816,0 1893,1 1973,0 2032,1 2106,0 2150,1 2224,0 2228,1 2328,0 2402,1 2448,0 2517,1 2582,0 2610,1 2630,0 2714,1 2805,0 2896,1 2984,0 3009,1 3056,0 3136,1 3138,0 3204,1 3277,0 3320,1 3341,0 3428,1 3446,0 3536,1 3556,0 3611,1 3670,0 3736,1 3744,0 3768,1 3804,0 3861,1 3958,0 3973,1 4003,0 4030,1 4093,0 4126,1 4188,0 4196,1 4248,0 4343,1 4422,0 4455,1 4547,0 4628,1 4659,0 4747,1 4753,0 4766,1 4798,0 4833,1 4842,0 4941,1 4956,0 5036,1 5112,0 5183,1 5193,0 5268,1 5300,0 5388,1 5464,0 5482,1 5565,0 5579,1 5580,0 5668,1 5766,0 5838,1 5839,0 5870,1 5889,0 5945,1 5976,0 6019,1 6023,0 6104,1 6201,0 6294,1 6343,0 6430,1 6522,0 6582,1 6601,0 6623,1 6702,0 6787,1 6885,0 6945,1 7012,0 7023,1 7112,0 7136,1 7174,0 7180,1 7269,0 7330,1 7426,0 7470,1 7471,0 7493,1 7547,0 7607,1 7685,0 7690,1 7788,0 7883,1 7937,0 8022,1 8092,0 8096,1 8154,0 8231,1 8325,0 8345,1 8381,0 8447,1 8501,0 8541,1 8622,0 8627,1 8635,0 8647,1 8741,0 8779,1 8852,0 8913,1 8923,0 8974,1 9010,0 9098,1 9144,0 9214,1 9314,0 9386,1 9436,0 9535,1 9564,0 9654,1 9721,0 9759,1 9772,0 9807,1 9808,0 9886,1 9895,0 9991,1 10048,0 10109,1 10190,0 10288,1 10329,0 10366,1 10446,0 10467,1 10557,0 10598,1 10661,0 10724,1 10728,0 10761,1 10853,0 10923,1 10950,0 10953,1 10961,0 10978,1 10982,0 11023,1 11036,0 11072,1 11131,0 11199,1 11237,0 11319,1 11371,0 11418,1 11469,0 11506,1 11551,0 11559,1 11590,0 11617,1 11668,0 11743,1 11842,0 11883,1 11901,0 11942,1 11984,0 12044,1 12142,0 12210,1 12307,0 12392,1 12489,0 12516,1 12539,0 12552,1 12602,0 12700,1 12740,0 12779,1 12874,0 12901,1 12950,0 13030,1 13081,0 13109,1 13118,0 13131,1 13194,0 13222,1 13289,0 13345,1 13430,0 13520,1 13599,0 13626,1 13697,0 13783,1 13846,0 13863,1 13891,0 13972,1 13984,0 14041,1 14140,0 14142,1 14156,0 14160,1 14221,0 14293,1 14319,0 14369,1 14423,0 14425,1 14466,0 14563,1 14598,0 14686,1 14736,0 14830,1 14844,0 14894,1 14978,0 14991,1 15041,0 15093,1 15151,0 15198,1 15274,0 15297,1 15349,0 15372,1 15437,0 15486,1 15577,0 15644,1 15681,0 15730,1 15759,0 15808,1 15820,0 15901,1 15941,0 15955,1 15991,0 16067,1 16094,0 16110,1 16183,0 16205,1 16265,0 16349,1 16402,0 16499,1 16586,0 16607,1 16637,0 16732,1 16792,0 16875,1 16926,0 16931,1 16946,0 16952,1 17027,0 17104,1 17198,0 17267,1 17303,0 17384,1 17481,0 17559,1 17609,0 17686,1 17696,0 17774,1 17861,0 17919,1 17955,0 18010,1 18074,0 18140,1 18186,0 18272,1 18285,0 18308,1 18351,0 18440,1 18445,0 18509,1 18545,0 18552,1 18647,0 18664,1 18695,0 18713,1 18777,0 18794,1 18797,0 18850,1 18897,0 18997,1 19049,0 19133,1 19205,0 19288,1 19318,0 19415,1 19478,0 19531,1 19546,0 19612,1 19653,0 19732,1 19807,0 19830,1 19929,0 19967,1 20040,0 20088,1 20180,0 20274,1 20332,0 20417,1 20472,0 20521,1 20618,0 20639,1 20697,0 20772,1 20861,0 20957,1 20997,0 21017,1 21116,0 21185,1 21229,0 21299,1 21333,0 21339,1 21349,0 21363,1 21386,0 21467,1 21506,0 21547,1 21629,0 21713,1 21805,0 21887,1 21905,0 21998,1 22059,0 22112,1 22198,0 22267,1 22284,0 22374,1 22434,0 22476,1 22545,0 22604,1 22681,0 22741,1 22779,0 22834,1 22932,0 22970,1 22993,0 23035,1 23116,0 23204,1 23292,0 23319,1 23342,0 23375,1 23443,0 23453,1 23455,0 23492,1 23518,0 23616,1 23661,0 23732,1 23802,0 23829,1 23915,0 23927,1 24014,0 24083,1 24084,0 24117,1 24208,0 24217,1 24279,0 24361,1 24407,0 24438,1 24533,0 24579,1 24596,0 24663,1 24671,0 24767,1 24773,0 24851,1 24908,0 24932,1 24985,0 25080,1 25167,0 25219,1 25297,0 25341,1 25363,0 25424,1 25493,0 25560,1 25583,0 25648,1 25731,0 25737,1 25837,0 25840,1 25928,0 26008,1 26034,0 26036,1 26052,0 26121,1 26189,0 26268,1 26323,0 26340,1 26428,0 26521,1 26524,0 26582,1 26616,0 26686,1 26762,0 26861,1 26899,0 26905,1 26931,0 26939,1 26979,0 26996,1 27036,0 27114,1 27118,0 27120,1 27146,0 27179,1 27241,0 27286,1 27296,0 27396,1 27404,0 27495,1 27498,0 27586,1 27609,0 27620,1 27712,0 27767,1 27828,0 27858,1 27900,0 27941,1 28027,0 28117,1 28197,0 28266,1 28279,0 28366,1 28382,0 28443,1 28447,0 28544,1 28634,0 28705,1 28707,0 28741,1 28782,0 28786,1 28811,0 28852,1 28949,0 29029,1 29097,0 29111,1 29179,0 29257,1 29261,0 29336,1 29355,0 29384,1 29450,0 29491,1 29537,0 29547,1 29599,0 29675,1 29762,0 29778,1 29848,0 29933,1 29939,0 29951,1 30016,0 30060,1 30142,0 30193,1 30208,0 30248,1 30297,0 30376,1 30393,0 30461,1 30481,0 30484,1 30489,0 30580,1 30645,0 30739,1 30788,0 30806,1 30825,0 30833,1 30876,0 30964,1 31013,0 31064,1 31079,0 31082,1 31152,0 31196,1 31271,0 31356,1 31374,0 31380,1 31405,0 31477,1 31506,0 31587,1 31610,0 31696,1 31778,0 31786,1 31789,0 31856,1 31857,0 31916,1 31995,0 32092,1 32167,0 32189,1 32253,0 32327,1 32343,0 32376,1 32427,0 32443,1 32535,0 32626,1 32705,0 32725,1 32765,0 32815,1 32855,0 32890,1 32946,0 32963,1 33041,0 33135,1 33151,0 33220,1 33296,0 33374,1 33451,0 33527,1 33611,0 33636,1 33710,0 33777,1 33853,0 33912,1 33936,0 34000,1 34047,0 34060,1 34137,0 34147,1 34188,0 34241,1 34265,0 34279,1 34372,0 34458,1 34544,0 34576,1 34614,0 34646,1 34694,0 34786,1 34825,0 34877,1 34969,0 35001,1 35067,0 35148,1 35248,0 35305,1 35388,0 35409,1 35431,0 35471,1 35552,0 35642,1 35691,0 35784,1 35803,0 35815,1 35825,0 35835,1 35881,0 35908,1 35974,0 35988,1 36003,0 36085,1 36119,0 36186,1 36223,0 36297,1 36338,0 36417,1 36506,0 36597,1 36678,0 36774,1 36823,0 36907,1 36954,0 36978,1 37052,0 37128,1 37192,0 37223,1 37317,0 37338,1 37392,0 37425,1 37439,0 37443,1 37446,0 37464,1 37500,0 37530,1 37589,0 37615,1 37643,0 37713,1 37770,0 37868,1 37885,0 37909,1 37936,0 37951,1 37969,0 38011,1 38083,0 38143,1 38185,0 38218,1 38293,0 38360,1 38377,0 38448,1 38457,0 38485,1 38537,0 38608,1 38707,0 38713,1 38786,0 38829,1 38899,0 38984,1 39064,0 39153,1 39241,0 39332,1 39418,0 39445,1 39543,0 39636,1 39643,0 39699,1 39721,0 39722,1 39813,0 39856,1 39882,0 39976,1 40041,0 40046,1 40055,0 40129,1 40148,0 40220,1 40274,0 40307,1 40405,0 40417,1 40509,0 40606,1 40607,0 40659,1 40697,0 40733,1 40808,0 40905,1 40997,0 41012,1 41037,0 41064,1 41119,0 41128,1 41228,0 41230,1 41297,0 41319,1 41411,0 41476,1 41530,0 41546,1 41619,0 41667,1 41750,0 41760,1 41766,0 41787,1 41857,0 41940,1 41993,0 42069,1 42081,0 42181,1 42198,0 42288,1 42320,0 42390,1 42480,0 42520,1 42557,0 42599,1 42692,0 42791,1 42866,0 42894,1 42990,0 43067,1 43165,0 43233,1 43246,0 43329,1 43358,0 43448,1 43466,0 43533,1 43582,0 43652,1 43681,0 43712,1 43729,0 43785,1 43824,0 43880,1 43912,0 43982,1 44060,0 44151,1 44160,0 44186,1 44253,0 44339,1 44427,0 44454,1 44503,0 44532,1 44536,0 44540,1 44548,0 44569,1 44592,0 44689,1 44699,0 44753,1 44802,0 44807,1 44810,0 44885,1 44915,0 44937,1 45004,0 45056,1 45098,0 45123,1 45219,0 45266,1 45339,0 45398,1 45494,0 45525,1 45613,0 45648,1 45688,0 45766,1 45805,0 45838,1 45924,0 45967,1 46017,0 46092,1 46107,0 46109,1 46185,0 46281,1 46282,0 46313,1 46360,0 46440,1 46520,0 46608,1 46643,0 46667,1 46745,0 46784,1 46803,0 46893,1 46949,0 47030,1 47087,0 47155,1 47171,0 47238,1 47265,0 47303,1 47317,0 47396,1 47437,0 47455,1 47469,0 47500,1 47507,0 47598,1 47664,0 47708,1 47785,0 47870,1 47909,0 47993,1 48044,0 48090,1 48113,0 48203,1 48217,0 48253,1 48285,0 48372,1 48441,0 48502,1 48519,0 48523,1 48620,0 48683,1 48690,0 48790,1 48890,0 48988,1 49043,0 49069,1 49156,0 49202,1 49272,0 49324,1 49408,0 49410,1 49440,0 49457,1 49522,0 49539,1 49559,0 49634,1 49717,0 49770,1 49820,0 49849,1 49937,0 49942,1 49949,0 50027,1 50040,0 50063,1 50129,0 50179,1 50260,0 50285,1 50383,0 50393,1 50410,0 50474,1 50526,0 50560,1 50562,0 50651,1 50745,0 50824,1 50924,0 50990,1 50998,0 51049,1 51093,0 51122,1 51196,0 51212,1 51233,0 51292,1 end initlist b9 0,0 29,1 31,0 37,1 77,0 138,1 221,0 237,1 278,0 374,1 420,0 513,1 571,0 599,1 617,0 661,1 706,0 787,1 802,0 882,1 943,0 969,1 1002,0 1086,1 1108,0 1185,1 1196,0 1290,1 1370,0 1454,1 1545,0 1629,1 1668,0 1687,1 1745,0 1827,1 1890,0 1949,1 2030,0 2090,1 2148,0 2237,1 2261,0 2291,1 2317,0 2370,1 2392,0 2459,1 2482,0 2517,1 2553,0 2587,1 2618,0 2684,1 2729,0 2766,1 2832,0 2838,1 2927,0 2930,1 2971,0 3057,1 3126,0 3220,1 3299,0 3302,1 3390,0 3451,1 3508,0 3599,1 3639,0 3644,1 3673,0 3755,1 3822,0 3877,1 3932,0 3988,1 4039,0 4103,1 4180,0 4253,1 4255,0 4343,1 4417,0 4481,1 4491,0 4590,1 4599,0 4699,1 4775,0 4833,1 4912,0 4920,1 4991,0 5047,1 5134,0 5193,1 5239,0 5302,1 5376,0 5411,1 5414,0 5497,1 5546,0 5642,1 5688,0 5730,1 5794,0 5813,1 5912,0 5918,1 5977,0 6002,1 6075,0 6161,1 6164,0 6233,1 6313,0 6399,1 6433,0 6451,1 6482,0 6538,1 6626,0 6707,1 6734,0 6746,1 6838,0 6855,1 6900,0 6953,1 7010,0 7018,1 7063,0 7140,1 7153,0 7209,1 7217,0 7286,1 7341,0 7431,1 7514,0 7587,1 7657,0 7667,1 7672,0 7714,1 7748,0 7750,1 7787,0 7816,1 7842,0 7860,1 7898,0 7980,1 7992,0 8082,1 8173,0 8190,1 8251,0 8301,1 8389,0 8486,1 8495,0 8570,1 8598,0 8635,1 8708,0 8780,1 8829,0 8918,1 8951,0 8977,1 9048,0 9052,1 9135,0 9157,1 9191,0 9192,1 9226,0 9321,1 9326,0 9396,1 9413,0 9485,1 9553,0 9556,1 9572,0 9670,1 9722,0 9807,1 9904,0 9969,1 10043,0 10078,1 10163,0 10199,1 10234,0 10310,1 10339,0 10351,1 10381,0 10436,1 10529,0 10549,1 10581,0 10638,1 10716,0 10741,1 10810,0 10862,1 10868,0 10926,1 10976,0 11052,1 11140,0 11154,1 11166,0 11187,1 11242,0 11255,1 11347,0 11409,1 11476,0 11491,1 11534,0 11577,1 11605,0 11672,1 11767,0 11774,1 11788,0 11812,1 11904,0 11933,1 11964,0 11971,1 12042,0 12044,1 12064,0 12075,1 12115,0 12158,1 12208,0 12209,1 12223,0 12232,1 12324,0 12384,1 12415,0 12470,1 12556,0 12580,1 12624,0 12692,1 12788,0 12805,1 12893,0 12912,1 12934,0 12992,1 13079,0 13140,1 13153,0 13221,1 13228,0 13257,1 13275,0 13331,1 13402,0 13424,1 13469,0 13542,1 13593,0 13641,1 13704,0 13790,1 13826,0 13832,1 13874,0 13926,1 14002,0 14077,1 14149,0 14226,1 14323,0 14384,1 14386,0 14478,1 14486,0 14534,1 14535,0 14615,1 14662,0 14698,1 14779,0 14870,1 14892,0 14971,1 14974,0 15009,1 15035,0 15094,1 15187,0 15226,1 15314,0 15360,1 15382,0 15429,1 15437,0 15450,1 15457,0 15532,1 15556,0 15618,1 15662,0 15693,1 15698,0 15772,1 15871,0 15873,1 15912,0 16005,1 16070,0 16134,1 16168,0 16210,1 16294,0 16295,1 16347,0 16434,1 16517,0 16589,1 16674,0 16727,1 16777,0 16794,1 16827,0 16869,1 16966,0 16987,1 17012,0 17054,1 17134,0 17146,1 17225,0 17257,1 17297,0 17343,1 17384,0 17460,1 17490,0 17515,1 17525,0 17595,1 17650,0 17665,1 17678,0 17745,1 17794,0 17891,1 17947,0 17967,1 18061,0 18140,1 18217,0 18250,1 18280,0 18289,1 18319,0 18419,1 18466,0 18527,1 18583,0 18658,1 18712,0 18768,1 18863,0 18934,1 18946,0 18995,1 19042,0 19046,1 19118,0 19130,1 19213,0 19262,1 19299,0 19318,1 19417,0 19458,1 19497,0 19596,1 19660,0 19682,1 19756,0 19835,1 19891,0 19895,1 19971,0 20006,1 20068,0 20092,1 20149,0 20205,1 20222,0 20305,1 20375,0 20436,1 20502,0 20543,1 20549,0 20585,1 20624,0 20637,1 20716,0 20803,1 20827,0 20854,1 20895,0 20992,1 20998,0 21021,1 21045,0 21066,1 21157,0 21174,1 21217,0 21310,1 21331,0 21411,1 21506,0 21518,1 21592,0 21639,1 21684,0 21712,1 21786,0 21794,1 21864,0 21930,1 21958,0 21962,1 21967,0 22020,1 22028,0 22034,1 22123,0 22155,1 22207,0 22251,1 22266,0 22321,1 22387,0 22467,1 22555,0 22609,1 22706,0 22765,1 22822,0 22849,1 22912,0 22928,1 22934,0 22997,1 23009,0 23080,1 23096,0 23139,1 23164,0 23210,1 23230,0 23269,1 23305,0 23307,1 23370,0 23382,1 23450,0 23533,1 23601,0 23615,1 23634,0 23698,1 23727,0 23800,1 23852,0 23952,1 23983,0 24074,1 24114,0 24185,1 24270,0 24295,1 24372,0 24455,1 24495,0 24564,1 24571,0 24583,1 24671,0 24769,1 24805,0 24904,1 24955,0 24957,1 25012,0 25080,1 25155,0 25237,1 25242,0 25301,1 25326,0 25421,1 25490,0 25579,1 25673,0 25767,1 25834,0 25922,1 25926,0 25988,1 26052,0 26072,1 26121,0 26143,1 26155,0 26205,1 26241,0 26293,1 26365,0 26460,1 26517,0 26537,1 26581,0 26612,1 26667,0 26743,1 26760,0 26847,1 26906,0 26927,1 27005,0 27013,1 27069,0 27152,1 27180,0 27235,1 27267,0 27317,1 27359,0 27454,1 27489,0 27497,1 27589,0 27684,1 27777,0 27830,1 27910,0 28010,1 28102,0 28110,1 28158,0 28216,1 28264,0 28298,1 28307,0 28393,1 28398,0 28408,1 28508,0 28594,1 28665,0 28744,1 28753,0 28832,1 28898,0 28965,1 29039,0 29090,1 29154,0 29244,1 29340,0 29379,1 29478,0 29542,1 29594,0 29603,1 29621,0 29697,1 29794,0 29850,1 29871,0 29930,1 29990,0 29995,1 30084,0 30143,1 30191,0 30206,1 30238,0 30266,1 30335,0 30417,1 30441,0 30485,1 30518,0 30550,1 30567,0 30664,1 30703,0 30725,1 30771,0 30819,1 30827,0 30878,1 30950,0 31040,1 31137,0 31149,1 31186,0 31229,1 31327,0 31372,1 31426,0 31492,1 31514,0 31576,1 31654,0 31718,1 31725,0 31790,1 31811,0 31862,1 31905,0 31956,1 31997,0 32055,1 32096,0 32148,1 32198,0 32244,1 32329,0 32422,1 32443,0 32446,1 32495,0 32510,1 32539,0 32639,1 32713,0 32738,1 32744,0 32827,1 32900,0 32962,1 33008,0 33064,1 33121,0 33216,1 33298,0 33344,1 33358,0 33429,1 33499,0 33548,1 33566,0 33624,1 33647,0 33723,1 33792,0 33866,1 33905,0 33915,1 33933,0 34015,1 34038,0 34125,1 34152,0 34186,1 34212,0 34256,1 34330,0 34412,1 34480,0 34517,1 34595,0 34681,1 34720,0 34729,1 34789,0 34807,1 34818,0 34896,1 34974,0 34992,1 35057,0 35124,1 35141,0 35150,1 35191,0 35287,1 35383,0 35476,1 35497,0 35596,1 35672,0 35703,1 35799,0 35885,1 35975,0 36064,1 36088,0 36180,1 36220,0 36221,1 36297,0 36307,1 36374,0 36458,1 36474,0 36539,1 36615,0 36681,1 36717,0 36795,1 36858,0 36863,1 36876,0 36950,1 36953,0 37017,1 37056,0 37085,1 37165,0 37256,1 37305,0 37368,1 37419,0 37442,1 37507,0 37595,1 37640,0 37667,1 37675,0 37738,1 37787,0 37839,1 37870,0 37932,1 37938,0 38011,1 38034,0 38118,1 38145,0 38212,1 38296,0 38335,1 38344,0 38416,1 38418,0 38508,1 38521,0 38587,1 38665,0 38712,1 38808,0 38838,1 38863,0 38875,1 38962,0 38983,1 39000,0 39014,1 39050,0 39087,1 39122,0 39180,1 39234,0 39300,1 39388,0 39414,1 39417,0 39486,1 39562,0 39589,1 39635,0 39698,1 39764,0 39856,1 39888,0 39919,1 39930,0 39967,1 40024,0 40068,1 40142,0 40204,1 40234,0 40314,1 40376,0 40435,1 40448,0 40542,1 40586,0 40597,1 40629,0 40688,1 40768,0 40814,1 40823,0 40853,1 40950,0 41014,1 41024,0 41115,1 41146,0 41239,1 41308,0 41355,1 41447,0 41467,1 41530,0 41601,1 41646,0 41713,1 41747,0 41765,1 41847,0 41936,1 41995,0 42003,1 42021,0 42095,1 42148,0 42211,1 42299,0 42320,1 42398,0 42474,1 42490,0 42531,1 42569,0 42600,1 42694,0 42740,1 42801,0 42859,1 42913,0 42993,1 43019,0 43059,1 43075,0 43088,1 43161,0 43217,1 43247,0 43260,1 43275,0 43359,1 43439,0 43475,1 43566,0 43661,1 43720,0 43771,1 43835,0 43868,1 43917,0 43925,1 43982,0 44031,1 44121,0 44165,1 44261,0 44346,1 44375,0 44447,1 44516,0 44551,1 44588,0 44680,1 44772,0 44850,1 44915,0 44983,1 45018,0 45109,1 45131,0 45146,1 45197,0 45203,1 45295,0 45379,1 45478,0 45503,1 45506,0 45588,1 45650,0 45694,1 45793,0 45865,1 45880,0 45902,1 45930,0 45999,1 46076,0 46082,1 46142,0 46149,1 46206,0 46281,1 46309,0 46385,1 46428,0 46481,1 46581,0 46613,1 46684,0 46784,1 46869,0 46947,1 46982,0 47060,1 47073,0 47162,1 47166,0 47260,1 47343,0 47404,1 47471,0 47483,1 47536,0 47544,1 47637,0 47718,1 47759,0 47792,1 47801,0 47874,1 47938,0 48016,1 48075,0 48087,1 48185,0 48198,1 48258,0 48313,1 48379,0 48472,1 48507,0 48567,1 48644,0 48738,1 48837,0 48839,1 48914,0 48988,1 49042,0 49133,1 49226,0 49298,1 49336,0 49425,1 49479,0 49539,1 49563,0 49641,1 49702,0 49740,1 49833,0 49865,1 49886,0 49948,1 49993,0 50036,1 50060,0 50079,1 50132,0 50205,1 50269,0 50275,1 50363,0 50404,1 50407,0 50409,1 50467,0 50493,1 50505,0 50550,1 50612,0 50619,1 50682,0 50707,1 50739,0 50746,1 50755,0 50776,1 50816,0 50821,1 50898,0 50907,1 end initlist b10 0,0 40,1 128,0 150,1 202,0 223,1 291,0 302,1 320,0 342,1 429,0 449,1 529,0 627,1 645,0 733,1 746,0 838,1 849,0 918,1 1014,0 1043,1 1050,0 1149,1 1221,0 1266,1 1315,0 1350,1 1374,0 1416,1 1460,0 1555,1 1579,0 1621,1 1667,0 1712,1 1718,0 1769,1 1788,0 1817,1 1838,0 1873,1 1903,0 1977,1 2061,0 2099,1 2177,0 2180,1 2246,0 2327,1 2374,0 2380,1 2420,0 2447,1 2481,0 2549,1 2610,0 2695,1 2793,0 2863,1 2938,0 3016,1 3071,0 3074,1 3081,0 3121,1 3155,0 3204,1 3278,0 3333,1 3372,0 3463,1 3533,0 3592,1 3633,0 3697,1 3726,0 3740,1 3838,0 3855,1 3912,0 3977,1 3980,0 4029,1 4053,0 4128,1 4204,0 4245,1 4330,0 4351,1 4365,0 4446,1 4536,0 4623,1 4675,0 4744,1 4755,0 4791,1 4863,0 4903,1 4923,0 4950,1 5011,0 5050,1 5145,0 5241,1 5318,0 5351,1 5410,0 5491,1 5517,0 5523,1 5620,0 5687,1 5714,0 5753,1 5829,0 5892,1 5956,0 6034,1 6093,0 6159,1 6249,0 6286,1 6352,0 6401,1 6406,0 6430,1 6483,0 6578,1 6607,0 6674,1 6772,0 6804,1 6833,0 6913,1 6947,0 7014,1 7041,0 7066,1 7086,0 7179,1 7206,0 7285,1 7323,0 7362,1 7435,0 7454,1 7487,0 7569,1 7604,0 7688,1 7782,0 7817,1 7857,0 7950,1 7999,0 8097,1 8130,0 8222,1 8276,0 8366,1 8392,0 8462,1 8510,0 8537,1 8557,0 8581,1 8645,0 8659,1 8739,0 8755,1 8797,0 8840,1 8872,0 8941,1 8977,0 9045,1 9132,0 9159,1 9259,0 9354,1 9376,0 9464,1 9465,0 9506,1 9564,0 9587,1 9634,0 9685,1 9719,0 9725,1 9753,0 9795,1 9821,0 9890,1 9923,0 9969,1 9980,0 10055,1 10155,0 10203,1 10301,0 10320,1 10415,0 10455,1 10511,0 10550,1 10624,0 10635,1 10651,0 10678,1 10772,0 10782,1 10794,0 10799,1 10891,0 10956,1 10971,0 11043,1 11085,0 11178,1 11272,0 11336,1 11400,0 11497,1 11559,0 11565,1 11658,0 11678,1 11724,0 11747,1 11844,0 11847,1 11883,0 11918,1 11980,0 12043,1 12060,0 12107,1 12134,0 12216,1 12291,0 12330,1 12342,0 12345,1 12380,0 12405,1 12412,0 12466,1 12489,0 12544,1 12576,0 12648,1 12680,0 12754,1 12824,0 12826,1 12892,0 12916,1 12969,0 13039,1 13090,0 13177,1 13208,0 13253,1 13330,0 13407,1 13485,0 13553,1 13572,0 13606,1 13696,0 13769,1 13808,0 13819,1 13909,0 13944,1 13955,0 14029,1 14069,0 14078,1 14118,0 14191,1 14277,0 14341,1 14376,0 14411,1 14422,0 14442,1 14470,0 14471,1 14509,0 14524,1 14561,0 14624,1 14697,0 14789,1 14799,0 14830,1 14926,0 14989,1 15034,0 15106,1 15140,0 15170,1 15260,0 15356,1 15443,0 15468,1 15502,0 15508,1 15605,0 15696,1 15740,0 15827,1 15855,0 15893,1 15913,0 15933,1 16026,0 16066,1 16119,0 16136,1 16176,0 16237,1 16302,0 16322,1 16364,0 16446,1 16461,0 16561,1 16572,0 16604,1 16613,0 16635,1 16681,0 16734,1 16825,0 16888,1 16943,0 16961,1 16979,0 17049,1 17092,0 17107,1 17147,0 17236,1 17255,0 17346,1 17431,0 17509,1 17570,0 17592,1 17649,0 17735,1 17833,0 17848,1 17943,0 17944,1 18008,0 18057,1 18062,0 18144,1 18161,0 18204,1 18219,0 18285,1 18363,0 18423,1 18441,0 18449,1 18484,0 18584,1 18654,0 18661,1 18749,0 18824,1 18869,0 18919,1 19010,0 19101,1 19199,0 19247,1 19279,0 19328,1 19381,0 19387,1 19419,0 19486,1 19577,0 19653,1 19747,0 19799,1 19864,0 19894,1 19911,0 19996,1 20079,0 20126,1 20217,0 20293,1 20308,0 20327,1 20369,0 20383,1 20417,0 20436,1 20496,0 20535,1 20633,0 20689,1 20753,0 20833,1 20894,0 20987,1 21025,0 21031,1 21110,0 21200,1 21286,0 21288,1 21307,0 21400,1 21453,0 21465,1 21514,0 21560,1 21629,0 21633,1 21709,0 21782,1 21786,0 21862,1 21870,0 21892,1 21968,0 21993,1 22052,0 22120,1 22133,0 22220,1 22277,0 22298,1 22311,0 22403,1 22422,0 22460,1 22477,0 22540,1 22559,0 22566,1 22587,0 22665,1 22759,0 22848,1 22872,0 22876,1 22960,0 23017,1 23104,0 23166,1 23259,0 23301,1 23338,0 23400,1 23438,0 23521,1 23537,0 23622,1 23657,0 23710,1 23741,0 23764,1 23778,0 23868,1 23898,0 23926,1 23978,0 24015,1 24016,0 24108,1 24168,0 24265,1 24285,0 24323,1 24344,0 24434,1 24499,0 24551,1 24566,0 24590,1 24661,0 24753,1 24824,0 24846,1 24914,0 25005,1 25067,0 25070,1 25118,0 25162,1 25218,0 25230,1 25291,0 25302,1 25398,0 25414,1 25438,0 25486,1 25577,0 25613,1 25677,0 25762,1 25805,0 25815,1 25867,0 25954,1 26043,0 26121,1 26208,0 26288,1 26355,0 26394,1 26492,0 26580,1 26621,0 26671,1 26737,0 26774,1 26842,0 26901,1 26970,0 27028,1 27080,0 27179,1 27216,0 27222,1 27312,0 27350,1 27376,0 27390,1 27427,0 27500,1 27558,0 27568,1 27627,0 27637,1 27673,0 27771,1 27830,0 27880,1 27913,0 27980,1 28036,0 28083,1 28123,0 28195,1 28200,0 28203,1 28260,0 28266,1 28321,0 28361,1 28392,0 28449,1 28495,0 28591,1 28637,0 28737,1 28789,0 28803,1 28829,0 28890,1 28985,0 29054,1 29059,0 29115,1 29142,0 29150,1 29217,0 29304,1 29401,0 29433,1 29470,0 29529,1 29625,0 29684,1 29729,0 29741,1 29800,0 29866,1 29919,0 29998,1 30029,0 30057,1 30116,0 30210,1 30291,0 30382,1 30457,0 30512,1 30551,0 30621,1 30632,0 30643,1 30656,0 30710,1 30805,0 30834,1 30856,0 30910,1 30954,0 30976,1 30985,0 31076,1 31157,0 31243,1 31318,0 31411,1 31454,0 31471,1 31507,0 31591,1 31614,0 31628,1 31706,0 31782,1 31787,0 31847,1 31916,0 32007,1 32009,0 32079,1 32099,0 32197,1 32246,0 32257,1 32294,0 32382,1 32406,0 32439,1 32528,0 32591,1 32650,0 32738,1 32756,0 32765,1 32788,0 32822,1 32841,0 32940,1 32951,0 33018,1 33027,0 33040,1 33062,0 33139,1 33166,0 33197,1 33279,0 33366,1 33381,0 33389,1 33457,0 33476,1 33496,0 33571,1 33631,0 33659,1 33722,0 33740,1 33781,0 33880,1 33974,0 34073,1 34166,0 34264,1 34310,0 34359,1 34397,0 34413,1 34430,0 34452,1 34525,0 34561,1 34654,0 34698,1 34753,0 34780,1 34788,0 34845,1 34874,0 34878,1 34940,0 35015,1 35113,0 35139,1 35177,0 35202,1 35239,0 35291,1 35312,0 35340,1 35377,0 35378,1 35460,0 35549,1 35611,0 35669,1 35703,0 35778,1 35793,0 35805,1 35857,0 35896,1 35946,0 35994,1 36015,0 36052,1 36071,0 36101,1 36109,0 36202,1 36261,0 36352,1 36355,0 36390,1 36485,0 36499,1 36596,0 36599,1 36658,0 36729,1 36766,0 36787,1 36832,0 36855,1 36907,0 36912,1 36989,0 37057,1 37122,0 37201,1 37277,0 37376,1 37455,0 37497,1 37546,0 37562,1 37580,0 37605,1 37666,0 37699,1 37701,0 37720,1 37761,0 37842,1 37871,0 37932,1 38016,0 38111,1 38179,0 38205,1 38254,0 38296,1 38341,0 38344,1 38425,0 38434,1 38482,0 38544,1 38602,0 38694,1 38730,0 38783,1 38834,0 38877,1 38887,0 38975,1 38979,0 39004,1 39046,0 39074,1 39095,0 39154,1 39244,0 39304,1 39359,0 39423,1 39454,0 39504,1 39546,0 39573,1 39599,0 39618,1 39644,0 39682,1 39747,0 39837,1 39927,0 39987,1 40059,0 40157,1 40208,0 40261,1 40279,0 40349,1 40418,0 40518,1 40573,0 40671,1 40716,0 40810,1 40842,0 40869,1 40959,0 41028,1 41042,0 41129,1 41221,0 41257,1 41298,0 41344,1 41402,0 41410,1 41495,0 41514,1 41612,0 41708,1 41739,0 41760,1 41800,0 41827,1 41921,0 41980,1 41992,0 41995,1 42071,0 42081,1 42093,0 42158,1 42217,0 42246,1 42284,0 42361,1 42378,0 42445,1 42501,0 42546,1 42624,0 42692,1 42711,0 42759,1 42790,0 42828,1 42919,0 42969,1 43028,0 43112,1 43167,0 43197,1 43291,0 43389,1 43412,0 43452,1 43465,0 43535,1 43619,0 43634,1 43709,0 43801,1 43883,0 43909,1 43910,0 43995,1 44031,0 44083,1 44113,0 44121,1 44186,0 44218,1 44259,0 44265,1 44361,0 44366,1 44416,0 44502,1 44560,0 44643,1 44646,0 44707,1 44709,0 44768,1 44833,0 44855,1 44947,0 44981,1 45069,0 45083,1 45121,0 45166,1 45208,0 45266,1 45291,0 45373,1 45466,0 45469,1 45476,0 45521,1 45614,0 45714,1 45776,0 45780,1 45806,0 45840,1 45892,0 45954,1 45969,0 45994,1 46010,0 46046,1 46129,0 46194,1 46280,0 46369,1 46414,0 46482,1 46498,0 46515,1 46548,0 46643,1 46668,0 46698,1 46716,0 46775,1 46856,0 46911,1 46938,0 47024,1 47101,0 47140,1 47237,0 47259,1 47314,0 47414,1 47505,0 47601,1 47614,0 47687,1 47727,0 47822,1 47901,0 47952,1 47975,0 47987,1 48057,0 48071,1 48149,0 48194,1 48267,0 48294,1 48380,0 48388,1 48463,0 48510,1 48572,0 48660,1 48741,0 48806,1 48845,0 48849,1 48892,0 48912,1 48965,0 48995,1 49055,0 49124,1 49143,0 49219,1 49315,0 49347,1 49377,0 49423,1 49445,0 49524,1 49603,0 49669,1 49766,0 49834,1 49839,0 49841,1 49890,0 49929,1 49955,0 50042,1 50050,0 50051,1 50103,0 50128,1 50200,0 50207,1 end initlist b11 0,0 9,1 48,0 52,1 66,0 115,1 193,0 255,1 346,0 421,1 450,0 498,1 564,0 659,1 731,0 753,1 852,0 952,1 987,0 993,1 995,0 1035,1 1052,0 1134,1 1189,0 1272,1 1348,0 1352,1 1441,0 1470,1 1494,0 1584,1 1664,0 1747,1 1754,0 1819,1 1870,0 1935,1 1977,0 2037,1 2047,0 2123,1 2173,0 2226,1 2258,0 2301,1 2326,0 2420,1 2444,0 2449,1 2535,0 2564,1 2577,0 2612,1 2644,0 2661,1 2706,0 2789,1 2853,0 2925,1 3007,0 3051,1 3057,0 3117,1 3145,0 3178,1 3198,0 3255,1 3277,0 3279,1 3302,0 3335,1 3375,0 3405,1 3444,0 3528,1 3583,0 3675,1 3722,0 3777,1 3813,0 3861,1 3871,0 3917,1 4000,0 4084,1 4154,0 4251,1 4329,0 4418,1 4463,0 4546,1 4635,0 4686,1 4692,0 4743,1 4775,0 4803,1 4824,0 4849,1 4924,0 4989,1 5038,0 5121,1 5199,0 5285,1 5304,0 5330,1 5397,0 5448,1 5539,0 5621,1 5717,0 5723,1 5725,0 5750,1 5835,0 5839,1 5939,0 6007,1 6097,0 6177,1 6228,0 6235,1 6270,0 6361,1 6379,0 6420,1 6424,0 6482,1 6545,0 6582,1 6667,0 6730,1 6783,0 6786,1 6787,0 6846,1 6889,0 6925,1 7024,0 7052,1 7110,0 7120,1 7212,0 7265,1 7353,0 7363,1 7365,0 7421,1 7502,0 7525,1 7579,0 7604,1 7699,0 7703,1 7726,0 7759,1 7853,0 7907,1 7951,0 8015,1 8079,0 8142,1 8220,0 8282,1 8344,0 8364,1 8429,0 8489,1 8537,0 8622,1 8687,0 8696,1 8714,0 8720,1 8778,0 8827,1 8903,0 8905,1 9001,0 9053,1 9111,0 9167,1 9255,0 9346,1 9348,0 9375,1 9386,0 9390,1 9437,0 9442,1 9538,0 9550,1 9646,0 9719,1 9743,0 9793,1 9839,0 9901,1 9981,0 9982,1 9986,0 10013,1 10015,0 10073,1 10125,0 10224,1 10258,0 10283,1 10334,0 10420,1 10422,0 10512,1 10548,0 10608,1 10658,0 10710,1 10753,0 10832,1 10900,0 10973,1 10974,0 10979,1 11040,0 11121,1 11183,0 11184,1 11263,0 11329,1 11417,0 11422,1 11522,0 11535,1 11550,0 11608,1 11612,0 11703,1 11783,0 11866,1 11960,0 12041,1 12128,0 12176,1 12249,0 12329,1 12429,0 12458,1 12546,0 12572,1 12623,0 12695,1 12750,0 12775,1 12821,0 12904,1 12915,0 13015,1 13017,0 13048,1 13054,0 13085,1 13103,0 13144,1 13226,0 13253,1 13257,0 13351,1 13355,0 13426,1 13432,0 13494,1 13506,0 13578,1 13591,0 13631,1 13674,0 13676,1 13698,0 13704,1 13775,0 13794,1 13847,0 13899,1 13969,0 14060,1 14106,0 14178,1 14246,0 14335,1 14416,0 14470,1 14506,0 14550,1 14603,0 14623,1 14684,0 14759,1 14816,0 14864,1 14924,0 14997,1 15042,0 15128,1 15139,0 15155,1 15245,0 15282,1 15330,0 15382,1 15391,0 15428,1 15498,0 15592,1 15670,0 15695,1 15729,0 15796,1 15843,0 15845,1 15924,0 15976,1 15990,0 16027,1 16040,0 16131,1 16144,0 16171,1 16266,0 16321,1 16373,0 16391,1 16477,0 16557,1 16636,0 16662,1 16689,0 16779,1 16821,0 16863,1 16921,0 16938,1 16977,0 17048,1 17075,0 17116,1 17191,0 17227,1 17261,0 17344,1 17382,0 17443,1 17491,0 17567,1 17639,0 17708,1 17788,0 17789,1 17834,0 17854,1 17877,0 17892,1 17930,0 18005,1 18087,0 18126,1 18210,0 18235,1 18311,0 18354,1 18452,0 18529,1 18603,0 18643,1 18682,0 18746,1 18815,0 18902,1 18917,0 18981,1 19079,0 19154,1 19165,0 19236,1 19311,0 19394,1 19417,0 19441,1 19482,0 19510,1 19519,0 19525,1 19619,0 19716,1 19727,0 19801,1 19814,0 19863,1 19951,0 19958,1 19984,0 20077,1 20173,0 20202,1 20231,0 20247,1 20294,0 20322,1 20335,0 20429,1 20431,0 20497,1 20541,0 20634,1 20714,0 20732,1 20783,0 20867,1 20919,0 21008,1 21083,0 21163,1 21250,0 21336,1 21351,0 21354,1 21388,0 21432,1 21521,0 21538,1 21546,0 21596,1 21666,0 21724,1 21811,0 21889,1 21951,0 22030,1 22050,0 22137,1 22154,0 22252,1 22316,0 22348,1 22399,0 22417,1 22510,0 22511,1 22565,0 22654,1 22674,0 22690,1 22708,0 22775,1 22824,0 22850,1 22913,0 22938,1 22992,0 23008,1 23098,0 23132,1 23137,0 23159,1 23178,0 23232,1 23236,0 23319,1 23409,0 23421,1 23446,0 23526,1 23546,0 23590,1 23648,0 23741,1 23746,0 23764,1 23767,0 23814,1 23815,0 23830,1 23831,0 23871,1 23969,0 24068,1 24104,0 24109,1 24126,0 24215,1 24275,0 24306,1 24402,0 24435,1 24466,0 24549,1 24622,0 24652,1 24685,0 24733,1 24782,0 24838,1 24916,0 24979,1 25003,0 25059,1 25107,0 25144,1 25210,0 25213,1 25248,0 25280,1 25291,0 25348,1 25406,0 25426,1 25474,0 25479,1 25486,0 25573,1 25630,0 25699,1 25743,0 25819,1 25873,0 25927,1 26011,0 26049,1 26077,0 26156,1 26208,0 26251,1 26302,0 26345,1 26407,0 26469,1 26541,0 26639,1 26646,0 26733,1 26745,0 26777,1 26792,0 26859,1 26874,0 26928,1 27022,0 27067,1 27119,0 27120,1 27122,0 27191,1 27268,0 27279,1 27281,0 27286,1 27347,0 27444,1 27502,0 27575,1 27639,0 27717,1 27784,0 27796,1 27881,0 27901,1 27996,0 28028,1 28096,0 28182,1 28266,0 28339,1 28346,0 28357,1 28444,0 28445,1 28519,0 28530,1 28573,0 28633,1 28720,0 28795,1 28862,0 28918,1 28992,0 29024,1 29060,0 29154,1 29234,0 29320,1 29328,0 29361,1 29414,0 29418,1 29429,0 29459,1 29513,0 29516,1 29593,0 29649,1 29732,0 29808,1 29900,0 29977,1 30017,0 30059,1 30150,0 30230,1 30287,0 30314,1 30359,0 30422,1 30515,0 30547,1 30642,0 30648,1 30695,0 30719,1 30812,0 30881,1 30944,0 30954,1 31050,0 31128,1 31187,0 31272,1 31327,0 31381,1 31429,0 31448,1 31534,0 31590,1 31609,0 31612,1 31688,0 31757,1 31847,0 31914,1 31960,0 31987,1 32001,0 32075,1 32121,0 32142,1 32177,0 32217,1 32249,0 32256,1 32321,0 32356,1 32365,0 32440,1 32460,0 32547,1 32613,0 32706,1 32770,0 32789,1 32862,0 32874,1 32922,0 33006,1 33060,0 33102,1 33146,0 33156,1 33246,0 33257,1 33321,0 33382,1 33455,0 33529,1 33544,0 33623,1 33713,0 33764,1 33860,0 33911,1 34007,0 34035,1 34089,0 34146,1 34241,0 34264,1 34357,0 34454,1 34545,0 34614,1 34681,0 34714,1 34726,0 34819,1 34901,0 34961,1 35057,0 35131,1 35220,0 35237,1 35285,0 35345,1 35405,0 35428,1 35459,0 35480,1 35564,0 35626,1 35667,0 35695,1 35754,0 35766,1 35828,0 35916,1 35970,0 36056,1 36074,0 36139,1 36205,0 36245,1 36297,0 36329,1 36355,0 36365,1 36394,0 36473,1 36565,0 36619,1 36630,0 36694,1 36723,0 36799,1 36800,0 36837,1 36838,0 36848,1 36849,0 36894,1 36991,0 37066,1 37151,0 37205,1 37235,0 37292,1 37348,0 37360,1 37448,0 37544,1 37570,0 37628,1 37715,0 37780,1 37871,0 37931,1 37999,0 38057,1 38086,0 38156,1 38223,0 38319,1 38356,0 38444,1 38448,0 38524,1 38605,0 38693,1 38790,0 38865,1 38936,0 38964,1 39043,0 39139,1 39209,0 39259,1 39295,0 39386,1 39413,0 39419,1 39420,0 39496,1 39571,0 39625,1 39656,0 39677,1 39768,0 39799,1 39837,0 39874,1 39935,0 39990,1 40071,0 40125,1 40212,0 40246,1 40283,0 40318,1 40380,0 40398,1 40474,0 40519,1 40592,0 40640,1 40700,0 40728,1 40758,0 40776,1 40849,0 40893,1 40908,0 40911,1 40930,0 41018,1 41113,0 41187,1 41255,0 41338,1 41371,0 41437,1 41460,0 41499,1 41530,0 41604,1 41704,0 41739,1 41770,0 41841,1 41937,0 41966,1 42063,0 42082,1 42128,0 42130,1 42154,0 42236,1 42266,0 42311,1 42345,0 42364,1 42391,0 42424,1 42523,0 42569,1 42643,0 42735,1 42789,0 42799,1 42868,0 42965,1 43050,0 43057,1 43063,0 43088,1 43148,0 43177,1 43273,0 43292,1 43353,0 43398,1 43443,0 43460,1 43535,0 43600,1 43619,0 43629,1 43649,0 43720,1 43780,0 43834,1 43862,0 43888,1 43930,0 44011,1 44061,0 44097,1 44138,0 44214,1 44285,0 44301,1 44325,0 44421,1 44477,0 44559,1 44564,0 44570,1 44633,0 44716,1 44735,0 44813,1 44910,0 45009,1 45043,0 45050,1 45097,0 45196,1 45269,0 45302,1 45328,0 45426,1 45439,0 45532,1 45535,0 45622,1 45692,0 45738,1 45792,0 45802,1 45856,0 45924,1 45942,0 45968,1 45969,0 46014,1 46106,0 46115,1 46150,0 46241,1 46316,0 46326,1 46414,0 46444,1 46533,0 46556,1 46651,0 46663,1 46737,0 46835,1 46911,0 46923,1 46943,0 46976,1 47002,0 47052,1 47103,0 47169,1 47222,0 47237,1 47282,0 47377,1 47408,0 47459,1 47534,0 47583,1 47589,0 47641,1 47677,0 47765,1 47820,0 47894,1 47988,0 48022,1 48058,0 48137,1 48184,0 48198,1 48262,0 48306,1 48348,0 48368,1 48412,0 48441,1 48491,0 48574,1 48659,0 48683,1 48737,0 48834,1 48836,0 48838,1 48846,0 48930,1 48997,0 49047,1 49121,0 49126,1 49213,0 49215,1 49239,0 49271,1 49319,0 49407,1 49486,0 49499,1 49571,0 49659,1 49731,0 49823,1 49830,0 49834,1 49841,0 49871,1 49931,0 49954,1 49975,0 49986,1 50048,0 50144,1 50194,0 50208,1 50210,0 50215,1 50305,0 50393,1 50442,0 50476,1 end initlist b12 0,0 97,1 137,0 186,1 251,0 302,1 384,0 451,1 453,0 506,1 526,0 528,1 563,0 581,1 584,0 669,1 679,0 777,1 795,0 827,1 831,0 838,1 907,0 960,1 1007,0 1048,1 1138,0 1145,1 1227,0 1307,1 1328,0 1362,1 1449,0 1505,1 1568,0 1572,1 1599,0 1669,1 1733,0 1765,1 1844,0 1912,1 1974,0 2033,1 2042,0 2088,1 2168,0 2177,1 2192,0 2242,1 2322,0 2333,1 2342,0 2442,1 2529,0 2602,1 2688,0 2764,1 2817,0 2892,1 2965,0 2966,1 3013,0 3060,1 3147,0 3184,1 3266,0 3293,1 3384,0 3449,1 3482,0 3570,1 3649,0 3729,1 3734,0 3834,1 3922,0 3943,1 3951,0 3995,1 4067,0 4073,1 4075,0 4119,1 4180,0 4244,1 4325,0 4381,1 4409,0 4486,1 4508,0 4590,1 4634,0 4704,1 4769,0 4818,1 4876,0 4900,1 4954,0 5016,1 5019,0 5068,1 5119,0 5125,1 5155,0 5232,1 5258,0 5265,1 5315,0 5408,1 5438,0 5538,1 5620,0 5658,1 5663,0 5756,1 5832,0 5879,1 5901,0 5912,1 5989,0 6023,1 6029,0 6110,1 6194,0 6261,1 6320,0 6334,1 6372,0 6447,1 6479,0 6500,1 6544,0 6587,1 6647,0 6703,1 6736,0 6753,1 6827,0 6884,1 6955,0 6978,1 7040,0 7104,1 7191,0 7228,1 7321,0 7401,1 7459,0 7542,1 7559,0 7640,1 7700,0 7751,1 7777,0 7814,1 7828,0 7901,1 7985,0 8071,1 8079,0 8175,1 8204,0 8242,1 8298,0 8379,1 8468,0 8484,1 8523,0 8551,1 8622,0 8719,1 8776,0 8866,1 8918,0 8951,1 9008,0 9038,1 9100,0 9109,1 9163,0 9227,1 9284,0 9342,1 9412,0 9470,1 9474,0 9484,1 9537,0 9558,1 9575,0 9616,1 9658,0 9715,1 9793,0 9813,1 9838,0 9926,1 9971,0 10027,1 10091,0 10101,1 10201,0 10285,1 10347,0 10394,1 10439,0 10520,1 10531,0 10591,1 10596,0 10605,1 10699,0 10792,1 10859,0 10861,1 10915,0 10983,1 11059,0 11073,1 11075,0 11085,1 11124,0 11150,1 11170,0 11174,1 11186,0 11227,1 11327,0 11418,1 11466,0 11520,1 11595,0 11694,1 11743,0 11778,1 11816,0 11880,1 11972,0 11998,1 12032,0 12125,1 12217,0 12266,1 12357,0 12362,1 12399,0 12419,1 12432,0 12444,1 12514,0 12533,1 12607,0 12644,1 12740,0 12751,1 12810,0 12829,1 12860,0 12907,1 12983,0 12985,1 13039,0 13135,1 13141,0 13183,1 13221,0 13261,1 13335,0 13337,1 13405,0 13434,1 13469,0 13561,1 13598,0 13678,1 13704,0 13786,1 13830,0 13870,1 13921,0 13930,1 14029,0 14062,1 14110,0 14198,1 14271,0 14280,1 14290,0 14361,1 14364,0 14458,1 14463,0 14493,1 14503,0 14603,1 14658,0 14678,1 14777,0 14859,1 14923,0 15013,1 15044,0 15143,1 15237,0 15250,1 15284,0 15334,1 15422,0 15446,1 15505,0 15559,1 15587,0 15604,1 15640,0 15673,1 15747,0 15799,1 15857,0 15873,1 15938,0 15960,1 16001,0 16005,1 16077,0 16148,1 16149,0 16172,1 16181,0 16274,1 16318,0 16342,1 16408,0 16441,1 16526,0 16553,1 16604,0 16675,1 16772,0 16816,1 16824,0 16840,1 16889,0 16942,1 17010,0 17032,1 17125,0 17188,1 17275,0 17362,1 17385,0 17400,1 17442,0 17457,1 17469,0 17518,1 17617,0 17642,1 17678,0 17774,1 17816,0 17906,1 17988,0 17991,1 18080,0 18086,1 18186,0 18213,1 18300,0 18328,1 18383,0 18478,1 18521,0 18580,1 18629,0 18652,1 18720,0 18724,1 18804,0 18892,1 18983,0 18995,1 19075,0 19076,1 19153,0 19176,1 19214,0 19264,1 19285,0 19369,1 19390,0 19436,1 19486,0 19506,1 19530,0 19616,1 19690,0 19790,1 19811,0 19818,1 19858,0 19910,1 19963,0 19981,1 20034,0 20118,1 20172,0 20220,1 20281,0 20319,1 20399,0 20417,1 20456,0 20517,1 20582,0 20650,1 20729,0 20810,1 20819,0 20838,1 20918,0 20975,1 21040,0 21077,1 21137,0 21163,1 21202,0 21245,1 21344,0 21391,1 21426,0 21461,1 21486,0 21579,1 21592,0 21618,1 21649,0 21688,1 21746,0 21811,1 21900,0 21984,1 22074,0 22155,1 22239,0 22284,1 22384,0 22408,1 22422,0 22491,1 22591,0 22688,1 22787,0 22851,1 22933,0 23032,1 23099,0 23164,1 23262,0 23332,1 23411,0 23495,1 23531,0 23589,1 23670,0 23705,1 23805,0 23864,1 23889,0 23951,1 23972,0 23993,1 24008,0 24012,1 24097,0 24173,1 24204,0 24288,1 24363,0 24424,1 24466,0 24559,1 24561,0 24607,1 24674,0 24733,1 24758,0 24846,1 24896,0 24926,1 24996,0 25029,1 25118,0 25134,1 25175,0 25272,1 25287,0 25350,1 25393,0 25485,1 25493,0 25507,1 25595,0 25691,1 25748,0 25807,1 25857,0 25917,1 25975,0 26029,1 26034,0 26087,1 26164,0 26171,1 26215,0 26250,1 26260,0 26292,1 26304,0 26323,1 26342,0 26432,1 26532,0 26606,1 26694,0 26703,1 26708,0 26709,1 26799,0 26807,1 26871,0 26942,1 26992,0 27003,1 27034,0 27050,1 27110,0 27162,1 27193,0 27221,1 27258,0 27355,1 27375,0 27388,1 27400,0 27434,1 27478,0 27558,1 27629,0 27665,1 27748,0 27782,1 27818,0 27903,1 27947,0 27963,1 28022,0 28097,1 28187,0 28267,1 28367,0 28372,1 28438,0 28450,1 28483,0 28494,1 28536,0 28573,1 28651,0 28691,1 28746,0 28771,1 28792,0 28835,1 28858,0 28935,1 28992,0 29024,1 29065,0 29145,1 29214,0 29308,1 29363,0 29416,1 29486,0 29516,1 29607,0 29652,1 29701,0 29801,1 29830,0 29918,1 30003,0 30027,1 30048,0 30084,1 30144,0 30239,1 30290,0 30308,1 30320,0 30407,1 30478,0 30524,1 30567,0 30667,1 30741,0 30788,1 30835,0 30888,1 30949,0 31048,1 31132,0 31156,1 31162,0 31208,1 31231,0 31307,1 31337,0 31432,1 31467,0 31522,1 31566,0 31663,1 31704,0 31734,1 31757,0 31825,1 31846,0 31859,1 31955,0 32019,1 32066,0 32166,1 32219,0 32289,1 32353,0 32413,1 32469,0 32523,1 32585,0 32636,1 32697,0 32748,1 32753,0 32808,1 32861,0 32954,1 33050,0 33131,1 33142,0 33233,1 33315,0 33372,1 33439,0 33456,1 33526,0 33622,1 33664,0 33732,1 33782,0 33803,1 33821,0 33883,1 33925,0 34022,1 34057,0 34138,1 34182,0 34242,1 34300,0 34392,1 34413,0 34501,1 34508,0 34543,1 34551,0 34608,1 34670,0 34744,1 34765,0 34799,1 34853,0 34868,1 34892,0 34894,1 34895,0 34993,1 35010,0 35069,1 35107,0 35134,1 35159,0 35230,1 35232,0 35313,1 35342,0 35396,1 35397,0 35429,1 35492,0 35564,1 35599,0 35667,1 35745,0 35822,1 35856,0 35920,1 36020,0 36075,1 36125,0 36155,1 36182,0 36282,1 36327,0 36346,1 36391,0 36451,1 36547,0 36634,1 36686,0 36709,1 36784,0 36879,1 36953,0 36963,1 37015,0 37087,1 37148,0 37244,1 37250,0 37332,1 37389,0 37431,1 37432,0 37446,1 37546,0 37574,1 37612,0 37658,1 37752,0 37821,1 37849,0 37917,1 38005,0 38011,1 38093,0 38156,1 38237,0 38276,1 38339,0 38412,1 38456,0 38462,1 38465,0 38542,1 38569,0 38595,1 38604,0 38628,1 38690,0 38747,1 38806,0 38889,1 38902,0 38960,1 39049,0 39077,1 39125,0 39167,1 39214,0 39275,1 39318,0 39347,1 39370,0 39404,1 39500,0 39547,1 39562,0 39565,1 39583,0 39682,1 39777,0 39846,1 39918,0 39954,1 39988,0 40048,1 40105,0 40197,1 40292,0 40318,1 40356,0 40443,1 40468,0 40510,1 40578,0 40647,1 40684,0 40752,1 40783,0 40871,1 40896,0 40989,1 41003,0 41023,1 41068,0 41091,1 41099,0 41148,1 41173,0 41269,1 41282,0 41338,1 41374,0 41468,1 41499,0 41586,1 41671,0 41673,1 41750,0 41822,1 41835,0 41918,1 42001,0 42032,1 42034,0 42065,1 42144,0 42176,1 42231,0 42311,1 42388,0 42432,1 42490,0 42545,1 42560,0 42659,1 42697,0 42763,1 42795,0 42830,1 42835,0 42903,1 42915,0 42935,1 42987,0 43084,1 43159,0 43231,1 43254,0 43312,1 43343,0 43363,1 43429,0 43470,1 43513,0 43561,1 43571,0 43641,1 43734,0 43744,1 43757,0 43834,1 43897,0 43911,1 43984,0 44044,1 44104,0 44148,1 44223,0 44270,1 44352,0 44406,1 44481,0 44571,1 44667,0 44694,1 44743,0 44812,1 44866,0 44926,1 44991,0 45059,1 45093,0 45129,1 45161,0 45218,1 45302,0 45316,1 45373,0 45432,1 45511,0 45604,1 45607,0 45656,1 45724,0 45733,1 45769,0 45774,1 45870,0 45951,1 45981,0 45985,1 46052,0 46068,1 46070,0 46083,1 46092,0 46101,1 46199,0 46200,1 46292,0 46363,1 46452,0 46535,1 46539,0 46558,1 46615,0 46702,1 46712,0 46762,1 46775,0 46861,1 46936,0 47019,1 47052,0 47087,1 47176,0 47188,1 47271,0 47355,1 47414,0 47441,1 47442,0 47496,1 47550,0 47636,1 47692,0 47713,1 47744,0 47796,1 47798,0 47829,1 47883,0 47964,1 48061,0 48107,1 48156,0 48236,1 48242,0 48265,1 48355,0 48397,1 48465,0 48544,1 48630,0 48719,1 48806,0 48813,1 48887,0 48976,1 49008,0 49025,1 49122,0 49148,1 49157,0 49161,1 49228,0 49314,1 49380,0 49422,1 49443,0 49537,1 49605,0 49648,1 49703,0 49707,1 49796,0 49812,1 49856,0 49904,1 49940,0 49969,1 49999,0 50091,1 50183,0 50224,1 50324,0 50417,1 50439,0 50475,1 50493,0 50496,1 50523,0 50541,1 50561,0 50661,1 50705,0 50792,1 50847,0 50903,1 end initlist b13 0,0 14,1 80,0 92,1 109,0 142,1 188,0 251,1 344,0 435,1 486,0 550,1 586,0 606,1 649,0 708,1 754,0 837,1 857,0 916,1 938,0 964,1 1024,0 1105,1 1175,0 1241,1 1306,0 1325,1 1406,0 1497,1 1578,0 1674,1 1695,0 1723,1 1757,0 1832,1 1902,0 1984,1 1985,0 2022,1 2035,0 2125,1 2149,0 2150,1 2250,0 2342,1 2423,0 2485,1 2551,0 2566,1 2632,0 2672,1 2764,0 2780,1 2810,0 2876,1 2881,0 2934,1 2954,0 2962,1 3033,0 3035,1 3092,0 3169,1 3187,0 3205,1 3233,0 3261,1 3351,0 3372,1 3418,0 3476,1 3509,0 3537,1 3548,0 3589,1 3650,0 3703,1 3790,0 3805,1 3882,0 3952,1 3981,0 4080,1 4143,0 4144,1 4212,0 4226,1 4249,0 4293,1 4336,0 4373,1 4449,0 4500,1 4511,0 4610,1 4642,0 4646,1 4676,0 4702,1 4757,0 4810,1 4864,0 4871,1 4961,0 5055,1 5150,0 5185,1 5202,0 5291,1 5294,0 5374,1 5422,0 5505,1 5542,0 5561,1 5620,0 5696,1 5793,0 5866,1 5897,0 5910,1 5971,0 6005,1 6075,0 6100,1 6118,0 6187,1 6274,0 6367,1 6456,0 6540,1 6572,0 6573,1 6666,0 6693,1 6766,0 6856,1 6916,0 6928,1 6945,0 6998,1 7079,0 7177,1 7238,0 7291,1 7304,0 7330,1 7332,0 7420,1 7505,0 7574,1 7639,0 7643,1 7677,0 7684,1 7719,0 7727,1 7799,0 7810,1 7858,0 7901,1 7951,0 8042,1 8106,0 8133,1 8150,0 8177,1 8253,0 8334,1 8423,0 8515,1 8547,0 8606,1 8615,0 8651,1 8659,0 8740,1 8818,0 8823,1 8835,0 8864,1 8919,0 8974,1 8999,0 9017,1 9082,0 9163,1 9189,0 9289,1 9345,0 9407,1 9490,0 9570,1 9660,0 9711,1 9752,0 9765,1 9826,0 9905,1 9981,0 10005,1 10060,0 10113,1 10190,0 10228,1 10315,0 10357,1 10431,0 10504,1 10595,0 10681,1 10700,0 10707,1 10729,0 10797,1 10851,0 10928,1 10944,0 11041,1 11058,0 11084,1 11175,0 11267,1 11292,0 11390,1 11418,0 11431,1 11448,0 11479,1 11555,0 11612,1 11690,0 11776,1 11797,0 11881,1 11922,0 11933,1 11941,0 11989,1 12041,0 12100,1 12176,0 12205,1 12247,0 12280,1 12365,0 12427,1 12440,0 12459,1 12525,0 12568,1 12635,0 12713,1 12726,0 12735,1 12738,0 12754,1 12783,0 12820,1 12834,0 12907,1 12955,0 13018,1 13100,0 13127,1 13148,0 13240,1 13298,0 13316,1 13415,0 13495,1 13536,0 13620,1 13700,0 13780,1 13860,0 13960,1 14005,0 14047,1 14050,0 14130,1 14208,0 14255,1 14328,0 14377,1 14409,0 14494,1 14568,0 14586,1 14669,0 14712,1 14775,0 14844,1 14915,0 15013,1 15036,0 15129,1 15194,0 15202,1 15296,0 15363,1 15426,0 15446,1 15528,0 15552,1 15580,0 15607,1 15678,0 15745,1 15833,0 15914,1 15996,0 16001,1 16100,0 16101,1 16142,0 16149,1 16175,0 16240,1 16256,0 16298,1 16386,0 16477,1 16516,0 16585,1 16591,0 16612,1 16636,0 16690,1 16704,0 16735,1 16809,0 16852,1 16925,0 16996,1 17063,0 17122,1 17124,0 17145,1 17205,0 17241,1 17325,0 17362,1 17388,0 17424,1 17500,0 17552,1 17590,0 17642,1 17644,0 17647,1 17673,0 17739,1 17740,0 17795,1 17827,0 17845,1 17931,0 17982,1 18012,0 18074,1 18158,0 18241,1 18256,0 18282,1 18364,0 18444,1 18535,0 18609,1 18624,0 18629,1 18666,0 18710,1 18770,0 18819,1 18907,0 18947,1 18955,0 18972,1 19043,0 19053,1 19054,0 19132,1 19214,0 19247,1 19337,0 19359,1 19369,0 19451,1 19460,0 19520,1 19575,0 19629,1 19647,0 19745,1 19763,0 19845,1 19918,0 19974,1 20056,0 20086,1 20104,0 20111,1 20198,0 20232,1 20310,0 20353,1 20354,0 20365,1 20369,0 20438,1 20479,0 20503,1 20581,0 20617,1 20624,0 20694,1 20752,0 20832,1 20850,0 20924,1 21001,0 21007,1 21012,0 21085,1 21171,0 21187,1 21232,0 21283,1 21314,0 21363,1 21432,0 21477,1 21571,0 21605,1 21607,0 21660,1 21758,0 21759,1 21838,0 21848,1 21932,0 21983,1 22009,0 22081,1 22087,0 22101,1 22198,0 22256,1 22327,0 22373,1 22442,0 22476,1 22505,0 22562,1 22578,0 22610,1 22670,0 22694,1 22763,0 22781,1 22832,0 22863,1 22887,0 22942,1 23030,0 23065,1 23080,0 23099,1 23140,0 23194,1 23256,0 23338,1 23427,0 23478,1 23518,0 23594,1 23664,0 23753,1 23804,0 23890,1 23942,0 24010,1 24086,0 24088,1 24101,0 24156,1 24225,0 24226,1 24232,0 24322,1 24331,0 24409,1 24480,0 24507,1 24556,0 24643,1 24664,0 24731,1 24819,0 24843,1 24874,0 24909,1 24965,0 24971,1 24997,0 25009,1 25030,0 25087,1 25174,0 25178,1 25242,0 25302,1 25385,0 25452,1 25521,0 25574,1 25626,0 25704,1 25722,0 25755,1 25811,0 25859,1 25883,0 25958,1 26001,0 26055,1 26090,0 26093,1 26143,0 26167,1 26190,0 26289,1 26339,0 26386,1 26407,0 26436,1 26459,0 26462,1 26552,0 26617,1 26618,0 26653,1 26681,0 26778,1 26849,0 26920,1 26974,0 26995,1 27050,0 27079,1 27179,0 27191,1 27195,0 27273,1 27283,0 27337,1 27358,0 27369,1 27433,0 27499,1 27595,0 27673,1 27706,0 27723,1 27789,0 27796,1 27846,0 27873,1 27901,0 27925,1 27969,0 28026,1 28044,0 28059,1 28146,0 28212,1 28235,0 28303,1 28367,0 28446,1 28458,0 28491,1 28544,0 28594,1 28667,0 28704,1 28753,0 28819,1 28916,0 28989,1 29078,0 29146,1 29178,0 29251,1 29283,0 29347,1 29413,0 29503,1 29505,0 29557,1 29563,0 29631,1 29655,0 29712,1 29723,0 29730,1 29736,0 29765,1 29849,0 29907,1 29950,0 29968,1 30015,0 30075,1 30088,0 30178,1 30183,0 30265,1 30316,0 30317,1 30363,0 30400,1 30443,0 30531,1 30565,0 30600,1 30679,0 30717,1 30791,0 30844,1 30867,0 30875,1 30964,0 30986,1 30991,0 31047,1 31111,0 31156,1 31248,0 31263,1 31347,0 31383,1 31409,0 31486,1 31534,0 31584,1 31614,0 31680,1 31709,0 31753,1 31818,0 31885,1 31909,0 31986,1 32030,0 32037,1 32122,0 32161,1 32215,0 32235,1 32306,0 32376,1 32392,0 32402,1 32422,0 32452,1 32522,0 32524,1 32613,0 32616,1 32646,0 32746,1 32798,0 32849,1 32905,0 32980,1 33026,0 33096,1 33150,0 33227,1 33274,0 33373,1 33446,0 33546,1 33618,0 33663,1 33682,0 33734,1 33793,0 33880,1 33958,0 34034,1 34126,0 34155,1 34159,0 34235,1 34286,0 34362,1 34368,0 34390,1 34469,0 34519,1 34589,0 34608,1 34640,0 34654,1 34741,0 34828,1 34918,0 34991,1 35029,0 35035,1 35038,0 35120,1 35172,0 35190,1 35264,0 35343,1 35362,0 35366,1 35405,0 35448,1 35513,0 35546,1 35583,0 35636,1 35682,0 35775,1 35808,0 35860,1 35944,0 35985,1 36020,0 36042,1 36073,0 36157,1 36227,0 36308,1 36340,0 36371,1 36432,0 36515,1 36537,0 36591,1 36655,0 36662,1 36689,0 36693,1 36713,0 36780,1 36849,0 36875,1 36903,0 36987,1 37014,0 37088,1 37137,0 37218,1 37255,0 37282,1 37343,0 37375,1 37425,0 37454,1 37482,0 37568,1 37619,0 37659,1 37665,0 37737,1 37836,0 37930,1 38003,0 38092,1 38119,0 38146,1 38231,0 38256,1 38337,0 38381,1 38412,0 38424,1 38517,0 38577,1 38667,0 38767,1 38866,0 38881,1 38895,0 38960,1 39027,0 39032,1 39048,0 39080,1 39096,0 39137,1 39173,0 39194,1 39253,0 39266,1 39296,0 39376,1 39438,0 39504,1 39534,0 39596,1 39618,0 39650,1 39740,0 39823,1 39889,0 39965,1 40038,0 40086,1 40166,0 40211,1 40288,0 40306,1 40333,0 40343,1 40364,0 40403,1 40468,0 40500,1 40554,0 40638,1 40694,0 40790,1 40812,0 40897,1 40992,0 40998,1 41047,0 41054,1 41083,0 41107,1 41172,0 41250,1 41271,0 41298,1 41335,0 41369,1 41436,0 41444,1 41489,0 41553,1 41584,0 41586,1 41589,0 41662,1 41732,0 41753,1 41802,0 41898,1 41989,0 42077,1 42174,0 42259,1 42354,0 42395,1 42470,0 42475,1 42515,0 42604,1 42617,0 42707,1 42750,0 42759,1 42779,0 42851,1 42885,0 42966,1 43057,0 43096,1 43161,0 43208,1 43268,0 43349,1 43385,0 43425,1 43512,0 43605,1 43673,0 43696,1 43707,0 43743,1 43774,0 43837,1 43905,0 43974,1 43989,0 44046,1 44143,0 44192,1 44204,0 44237,1 44295,0 44357,1 44431,0 44497,1 44528,0 44616,1 44671,0 44754,1 44844,0 44858,1 44912,0 44998,1 45080,0 45108,1 45147,0 45175,1 45225,0 45276,1 45296,0 45374,1 45399,0 45431,1 45457,0 45519,1 45552,0 45604,1 45646,0 45690,1 45752,0 45781,1 45839,0 45873,1 45875,0 45970,1 46024,0 46095,1 46136,0 46204,1 46216,0 46288,1 46306,0 46392,1 46453,0 46462,1 46536,0 46613,1 46645,0 46733,1 46817,0 46830,1 46866,0 46907,1 46957,0 47010,1 47020,0 47072,1 47151,0 47242,1 47304,0 47360,1 47364,0 47437,1 47450,0 47539,1 47600,0 47681,1 47778,0 47798,1 47816,0 47849,1 47884,0 47890,1 47952,0 48035,1 48052,0 48112,1 48207,0 48286,1 48322,0 48384,1 48452,0 48511,1 48601,0 48636,1 48667,0 48681,1 48758,0 48844,1 48853,0 48885,1 48893,0 48906,1 48997,0 49036,1 49099,0 49156,1 49175,0 49266,1 49327,0 49333,1 49336,0 49343,1 49350,0 49403,1 end initlist b14 0,0 89,1 117,0 144,1 164,0 169,1 223,0 235,1 322,0 382,1 385,0 436,1 492,0 520,1 605,0 667,1 730,0 793,1 853,0 931,1 992,0 1018,1 1110,0 1180,1 1253,0 1271,1 1350,0 1448,1 1510,0 1573,1 1597,0 1618,1 1648,0 1745,1 1824,0 1921,1 1970,0 1996,1 2078,0 2136,1 2186,0 2224,1 2307,0 2323,1 2371,0 2417,1 2434,0 2488,1 2547,0 2609,1 2650,0 2683,1 2691,0 2715,1 2742,0 2744,1 2793,0 2889,1 2951,0 2996,1 3086,0 3166,1 3252,0 3270,1 3318,0 3411,1 3480,0 3540,1 3585,0 3591,1 3644,0 3680,1 3737,0 3753,1 3802,0 3822,1 3831,0 3877,1 3913,0 3925,1 3928,0 4009,1 4077,0 4089,1 4099,0 4126,1 4180,0 4201,1 4224,0 4275,1 4315,0 4317,1 4365,0 4396,1 4406,0 4446,1 4467,0 4503,1 4588,0 4641,1 4697,0 4733,1 4748,0 4832,1 4901,0 5000,1 5025,0 5075,1 5146,0 5209,1 5263,0 5285,1 5312,0 5344,1 5439,0 5475,1 5512,0 5605,1 5626,0 5707,1 5710,0 5767,1 5864,0 5917,1 5952,0 5966,1 5972,0 6032,1 6107,0 6127,1 6184,0 6186,1 6203,0 6283,1 6361,0 6424,1 6490,0 6523,1 6589,0 6617,1 6621,0 6719,1 6760,0 6815,1 6862,0 6954,1 7035,0 7066,1 7144,0 7163,1 7177,0 7261,1 7311,0 7404,1 7446,0 7518,1 7547,0 7616,1 7677,0 7700,1 7714,0 7723,1 7803,0 7850,1 7890,0 7940,1 7964,0 8048,1 8116,0 8194,1 8281,0 8291,1 8386,0 8410,1 8425,0 8488,1 8519,0 8550,1 8565,0 8594,1 8633,0 8670,1 8756,0 8799,1 8860,0 8897,1 8924,0 8999,1 9019,0 9052,1 9107,0 9174,1 9271,0 9288,1 9336,0 9420,1 9444,0 9538,1 9601,0 9671,1 9754,0 9828,1 9919,0 9961,1 10015,0 10082,1 10085,0 10167,1 10260,0 10348,1 10408,0 10505,1 10576,0 10630,1 10689,0 10692,1 10784,0 10851,1 10858,0 10912,1 10913,0 11011,1 11078,0 11140,1 11209,0 11259,1 11277,0 11323,1 11344,0 11378,1 11380,0 11381,1 11408,0 11455,1 11525,0 11570,1 11663,0 11753,1 11766,0 11835,1 11906,0 11952,1 12018,0 12066,1 12157,0 12212,1 12278,0 12353,1 12430,0 12453,1 12534,0 12587,1 12638,0 12639,1 12665,0 12678,1 12775,0 12845,1 12937,0 13031,1 13051,0 13066,1 13127,0 13218,1 13269,0 13363,1 13463,0 13510,1 13546,0 13608,1 13679,0 13719,1 13758,0 13815,1 13825,0 13891,1 13932,0 13980,1 14035,0 14055,1 14150,0 14237,1 14306,0 14343,1 14417,0 14434,1 14490,0 14588,1 14651,0 14695,1 14722,0 14777,1 14873,0 14971,1 15065,0 15113,1 15164,0 15174,1 15183,0 15223,1 15320,0 15350,1 15426,0 15484,1 15581,0 15643,1 15650,0 15672,1 15706,0 15793,1 15834,0 15881,1 15901,0 15915,1 15990,0 16089,1 16130,0 16218,1 16270,0 16330,1 16399,0 16403,1 16455,0 16523,1 16585,0 16659,1 16722,0 16796,1 16884,0 16980,1 17028,0 17031,1 17122,0 17190,1 17214,0 17220,1 17313,0 17381,1 17425,0 17435,1 17470,0 17491,1 17508,0 17576,1 17604,0 17689,1 17769,0 17819,1 17890,0 17933,1 17988,0 18020,1 18112,0 18204,1 18239,0 18313,1 18410,0 18428,1 18447,0 18483,1 18563,0 18572,1 18596,0 18627,1 18635,0 18673,1 18716,0 18734,1 18762,0 18774,1 18855,0 18912,1 18946,0 18973,1 18983,0 19044,1 19131,0 19145,1 19170,0 19227,1 19252,0 19320,1 19387,0 19417,1 19466,0 19484,1 19522,0 19536,1 19610,0 19666,1 19699,0 19778,1 19793,0 19888,1 19928,0 19963,1 19995,0 20017,1 20115,0 20210,1 20304,0 20389,1 20472,0 20541,1 20596,0 20665,1 20670,0 20761,1 20765,0 20831,1 20858,0 20927,1 20971,0 21035,1 21091,0 21151,1 21166,0 21169,1 21196,0 21272,1 21332,0 21419,1 21450,0 21472,1 21500,0 21558,1 21560,0 21614,1 21629,0 21702,1 21707,0 21781,1 21871,0 21918,1 21936,0 21983,1 22040,0 22086,1 22088,0 22128,1 22179,0 22223,1 22301,0 22377,1 22464,0 22509,1 22608,0 22614,1 22669,0 22707,1 22781,0 22829,1 22857,0 22866,1 22947,0 23031,1 23036,0 23053,1 23075,0 23109,1 23199,0 23223,1 23248,0 23336,1 23408,0 23507,1 23584,0 23612,1 23673,0 23729,1 23779,0 23870,1 23917,0 23995,1 24079,0 24144,1 24169,0 24202,1 24223,0 24255,1 24261,0 24277,1 24291,0 24306,1 24332,0 24427,1 24518,0 24611,1 24659,0 24660,1 24760,0 24777,1 24829,0 24857,1 24912,0 24989,1 25075,0 25115,1 25186,0 25199,1 25279,0 25335,1 25346,0 25377,1 25406,0 25490,1 25569,0 25581,1 25606,0 25701,1 25776,0 25831,1 25898,0 25995,1 26083,0 26152,1 26216,0 26301,1 26349,0 26378,1 26439,0 26460,1 26557,0 26655,1 26725,0 26781,1 26784,0 26870,1 26895,0 26988,1 27034,0 27045,1 27123,0 27159,1 27259,0 27355,1 27423,0 27447,1 27532,0 27597,1 27693,0 27762,1 27768,0 27808,1 27854,0 27890,1 27933,0 27991,1 28055,0 28077,1 28151,0 28208,1 28223,0 28317,1 28395,0 28490,1 28563,0 28581,1 28650,0 28672,1 28755,0 28761,1 28834,0 28900,1 28918,0 29005,1 29060,0 29102,1 29181,0 29218,1 29268,0 29329,1 29358,0 29398,1 29464,0 29535,1 29552,0 29594,1 29618,0 29668,1 29687,0 29688,1 29712,0 29790,1 29804,0 29844,1 29911,0 29997,1 30049,0 30093,1 30185,0 30275,1 30297,0 30324,1 30379,0 30388,1 30436,0 30529,1 30616,0 30672,1 30747,0 30826,1 30849,0 30892,1 30978,0 31076,1 31086,0 31115,1 31143,0 31150,1 31166,0 31204,1 31226,0 31296,1 31391,0 31469,1 31517,0 31535,1 31585,0 31639,1 31696,0 31792,1 31810,0 31902,1 31937,0 31991,1 32009,0 32100,1 32180,0 32278,1 32335,0 32430,1 32446,0 32463,1 32473,0 32479,1 32572,0 32620,1 32664,0 32720,1 32738,0 32800,1 32881,0 32937,1 33033,0 33064,1 33151,0 33155,1 33206,0 33262,1 33265,0 33271,1 33368,0 33400,1 33429,0 33435,1 33468,0 33519,1 33526,0 33559,1 33654,0 33669,1 33700,0 33763,1 33765,0 33813,1 33885,0 33922,1 34009,0 34018,1 34070,0 34099,1 34195,0 34198,1 34244,0 34282,1 34283,0 34293,1 34357,0 34380,1 34420,0 34426,1 34492,0 34587,1 34621,0 34719,1 34813,0 34836,1 34854,0 34911,1 34983,0 35047,1 35098,0 35102,1 35164,0 35176,1 35236,0 35301,1 35302,0 35400,1 35450,0 35503,1 35576,0 35587,1 35599,0 35643,1 35724,0 35811,1 35855,0 35868,1 35941,0 35953,1 36017,0 36112,1 36147,0 36167,1 36258,0 36344,1 36420,0 36492,1 36576,0 36615,1 36678,0 36759,1 36774,0 36860,1 36916,0 37011,1 37083,0 37127,1 37163,0 37251,1 37259,0 37300,1 37368,0 37388,1 37391,0 37436,1 37469,0 37562,1 37616,0 37674,1 37737,0 37775,1 37803,0 37808,1 37822,0 37849,1 37888,0 37893,1 37962,0 38058,1 38059,0 38114,1 38119,0 38204,1 38300,0 38336,1 38399,0 38421,1 38425,0 38514,1 38571,0 38629,1 38653,0 38654,1 38675,0 38741,1 38776,0 38831,1 38883,0 38931,1 39005,0 39097,1 39158,0 39225,1 39255,0 39301,1 39372,0 39456,1 39466,0 39491,1 39576,0 39593,1 39627,0 39679,1 39769,0 39814,1 39914,0 39918,1 39961,0 40048,1 40121,0 40207,1 40230,0 40235,1 40276,0 40370,1 40410,0 40425,1 40524,0 40568,1 40633,0 40658,1 40667,0 40745,1 40794,0 40846,1 40921,0 40980,1 41036,0 41100,1 41185,0 41220,1 41294,0 41349,1 41384,0 41461,1 41507,0 41548,1 41640,0 41662,1 41730,0 41820,1 41830,0 41855,1 41942,0 41949,1 41973,0 42000,1 42095,0 42115,1 42139,0 42183,1 42231,0 42274,1 42369,0 42448,1 42542,0 42607,1 42611,0 42621,1 42657,0 42757,1 42764,0 42835,1 42929,0 42964,1 43044,0 43068,1 43095,0 43126,1 43202,0 43231,1 43328,0 43354,1 43422,0 43449,1 43495,0 43549,1 43607,0 43666,1 43710,0 43781,1 43819,0 43890,1 43935,0 44033,1 44055,0 44058,1 44143,0 44144,1 44234,0 44251,1 44327,0 44372,1 44443,0 44503,1 44513,0 44559,1 44630,0 44721,1 44793,0 44889,1 44971,0 45064,1 45143,0 45222,1 45246,0 45278,1 45362,0 45375,1 45418,0 45465,1 45472,0 45493,1 45529,0 45603,1 45687,0 45777,1 45853,0 45896,1 45912,0 45933,1 45989,0 46056,1 46099,0 46104,1 46137,0 46169,1 46216,0 46309,1 46395,0 46469,1 46556,0 46567,1 46640,0 46687,1 46730,0 46802,1 46828,0 46836,1 46877,0 46956,1 46990,0 47075,1 47100,0 47127,1 47140,0 47186,1 47228,0 47326,1 47372,0 47460,1 47547,0 47626,1 47688,0 47754,1 47816,0 47897,1 47902,0 47951,1 48023,0 48112,1 48212,0 48287,1 48295,0 48393,1 48450,0 48466,1 48470,0 48501,1 48530,0 48534,1 48600,0 48676,1 48772,0 48857,1 48919,0 48982,1 49076,0 49152,1 49156,0 49224,1 49257,0 49279,1 49318,0 49397,1 49408,0 49483,1 49568,0 49647,1 49715,0 49717,1 49750,0 49808,1 49847,0 49888,1 49958,0 50055,1 50074,0 50142,1 50198,0 50298,1 50380,0 50413,1 50431,0 50467,1 50558,0 50614,1 50711,0 50770,1 50792,0 50848,1 50919,0 50958,1 50993,0 51081,1 51091,0 51107,1 51130,0 51218,1 end initlist b15 0,0 14,1 44,0 105,1 133,0 147,1 211,0 231,1 250,0 316,1 338,0 398,1 447,0 538,1 611,0 616,1 622,0 655,1 681,0 762,1 778,0 842,1 846,0 907,1 938,0 1004,1 1088,0 1125,1 1183,0 1217,1 1271,0 1302,1 1391,0 1439,1 1518,0 1614,1 1704,0 1766,1 1820,0 1842,1 1889,0 1903,1 1943,0 2000,1 2045,0 2142,1 2216,0 2230,1 2305,0 2344,1 2404,0 2475,1 2481,0 2551,1 2624,0 2668,1 2670,0 2758,1 2851,0 2917,1 2970,0 3017,1 3096,0 3137,1 3185,0 3254,1 3341,0 3392,1 3470,0 3493,1 3526,0 3556,1 3605,0 3609,1 3637,0 3657,1 3682,0 3768,1 3820,0 3853,1 3898,0 3951,1 4003,0 4061,1 4103,0 4167,1 4190,0 4229,1 4303,0 4362,1 4428,0 4486,1 4554,0 4600,1 4695,0 4711,1 4717,0 4776,1 4872,0 4958,1 5034,0 5085,1 5126,0 5151,1 5233,0 5296,1 5353,0 5440,1 5457,0 5552,1 5589,0 5646,1 5742,0 5751,1 5809,0 5838,1 5894,0 5990,1 6001,0 6060,1 6121,0 6144,1 6193,0 6283,1 6341,0 6396,1 6492,0 6520,1 6616,0 6675,1 6686,0 6719,1 6767,0 6796,1 6873,0 6915,1 6989,0 7089,1 7141,0 7144,1 7202,0 7224,1 7315,0 7321,1 7378,0 7453,1 7510,0 7569,1 7657,0 7670,1 7753,0 7845,1 7870,0 7911,1 7994,0 8016,1 8039,0 8075,1 8149,0 8175,1 8216,0 8266,1 8309,0 8323,1 8411,0 8463,1 8479,0 8549,1 8566,0 8628,1 8707,0 8744,1 8824,0 8862,1 8898,0 8925,1 8930,0 8934,1 8957,0 9017,1 9082,0 9131,1 9216,0 9293,1 9377,0 9407,1 9499,0 9503,1 9554,0 9568,1 9578,0 9658,1 9663,0 9751,1 9821,0 9854,1 9948,0 9983,1 10052,0 10078,1 10138,0 10209,1 10221,0 10315,1 10387,0 10411,1 10483,0 10564,1 10581,0 10647,1 10679,0 10705,1 10728,0 10784,1 10822,0 10914,1 10957,0 10961,1 11047,0 11143,1 11208,0 11253,1 11352,0 11388,1 11402,0 11452,1 11513,0 11610,1 11614,0 11699,1 11745,0 11812,1 11852,0 11931,1 11955,0 12008,1 12085,0 12179,1 12244,0 12330,1 12364,0 12384,1 12454,0 12492,1 12516,0 12539,1 12582,0 12680,1 12687,0 12748,1 12756,0 12806,1 12835,0 12935,1 12991,0 13035,1 13062,0 13102,1 13114,0 13117,1 13167,0 13244,1 13303,0 13379,1 13409,0 13506,1 13559,0 13563,1 13624,0 13667,1 13709,0 13752,1 13839,0 13907,1 13969,0 14031,1 14042,0 14082,1 14133,0 14223,1 14229,0 14292,1 14373,0 14379,1 14428,0 14515,1 14569,0 14578,1 14658,0 14663,1 14717,0 14780,1 14864,0 14880,1 14902,0 14992,1 15008,0 15056,1 15057,0 15075,1 15098,0 15163,1 15198,0 15216,1 15253,0 15297,1 15307,0 15402,1 15464,0 15518,1 15571,0 15573,1 15575,0 15645,1 15662,0 15707,1 15747,0 15839,1 15895,0 15897,1 15975,0 15983,1 16045,0 16138,1 16154,0 16252,1 16349,0 16448,1 16537,0 16623,1 16626,0 16628,1 16699,0 16718,1 16765,0 16768,1 16841,0 16929,1 16982,0 17004,1 17084,0 17141,1 17185,0 17205,1 17223,0 17290,1 17306,0 17374,1 17470,0 17532,1 17594,0 17692,1 17760,0 17777,1 17825,0 17862,1 17884,0 17931,1 17968,0 18052,1 18127,0 18172,1 18203,0 18301,1 18346,0 18397,1 18464,0 18503,1 18525,0 18579,1 18610,0 18620,1 18700,0 18777,1 18785,0 18839,1 18877,0 18917,1 18945,0 18967,1 18975,0 19072,1 19127,0 19211,1 19256,0 19302,1 19347,0 19405,1 19477,0 19539,1 19610,0 19644,1 19714,0 19766,1 19830,0 19895,1 19899,0 19963,1 20055,0 20071,1 20091,0 20096,1 20178,0 20195,1 20213,0 20313,1 20383,0 20398,1 20435,0 20480,1 20485,0 20538,1 20631,0 20728,1 20800,0 20874,1 20928,0 20941,1 21017,0 21076,1 21099,0 21134,1 21224,0 21318,1 21341,0 21415,1 21513,0 21517,1 21571,0 21623,1 21640,0 21670,1 21768,0 21809,1 21831,0 21866,1 21878,0 21971,1 22041,0 22085,1 22161,0 22194,1 22213,0 22224,1 22304,0 22311,1 22373,0 22383,1 22401,0 22453,1 22480,0 22561,1 22587,0 22668,1 22743,0 22838,1 22849,0 22873,1 22895,0 22959,1 23010,0 23081,1 23100,0 23127,1 23149,0 23160,1 23240,0 23289,1 23291,0 23348,1 23360,0 23419,1 23451,0 23515,1 23583,0 23657,1 23752,0 23769,1 23845,0 23916,1 23975,0 24013,1 24099,0 24121,1 24130,0 24166,1 24184,0 24201,1 24278,0 24375,1 24400,0 24491,1 24528,0 24615,1 24630,0 24723,1 24777,0 24839,1 24845,0 24882,1 24893,0 24971,1 24997,0 25041,1 25129,0 25199,1 25245,0 25279,1 25285,0 25357,1 25393,0 25446,1 25498,0 25569,1 25665,0 25697,1 25769,0 25840,1 25940,0 25973,1 26024,0 26103,1 26187,0 26253,1 26304,0 26353,1 26368,0 26407,1 26472,0 26541,1 26572,0 26644,1 26683,0 26701,1 26709,0 26767,1 26829,0 26849,1 26852,0 26947,1 27017,0 27044,1 27091,0 27161,1 27228,0 27299,1 27374,0 27411,1 27459,0 27531,1 27580,0 27662,1 27692,0 27766,1 27837,0 27911,1 27988,0 28032,1 28073,0 28104,1 28169,0 28176,1 28186,0 28261,1 28318,0 28416,1 28490,0 28582,1 28680,0 28707,1 28776,0 28808,1 28846,0 28855,1 28935,0 28958,1 29005,0 29032,1 29081,0 29118,1 29205,0 29242,1 29298,0 29328,1 29383,0 29386,1 29429,0 29497,1 29565,0 29646,1 29695,0 29704,1 29795,0 29894,1 29897,0 29968,1 30007,0 30024,1 30118,0 30156,1 30239,0 30292,1 30366,0 30436,1 30497,0 30532,1 30632,0 30723,1 30795,0 30861,1 30910,0 30935,1 30940,0 30971,1 31051,0 31105,1 31139,0 31172,1 31229,0 31297,1 31396,0 31446,1 31461,0 31519,1 31530,0 31534,1 31586,0 31676,1 31767,0 31835,1 31870,0 31878,1 31926,0 31992,1 32006,0 32020,1 32076,0 32103,1 32172,0 32257,1 32315,0 32389,1 32410,0 32498,1 32543,0 32618,1 32622,0 32638,1 32703,0 32772,1 32835,0 32883,1 32885,0 32897,1 32921,0 32988,1 33073,0 33162,1 33256,0 33330,1 33347,0 33439,1 33522,0 33591,1 33666,0 33752,1 33787,0 33793,1 33864,0 33952,1 34037,0 34064,1 34111,0 34135,1 34140,0 34169,1 34190,0 34269,1 34351,0 34414,1 34426,0 34496,1 34514,0 34576,1 34611,0 34678,1 34697,0 34729,1 34766,0 34802,1 34863,0 34894,1 34974,0 34997,1 35082,0 35106,1 35202,0 35289,1 35338,0 35368,1 35383,0 35461,1 35466,0 35561,1 35588,0 35666,1 35692,0 35757,1 35815,0 35823,1 35857,0 35868,1 35939,0 35985,1 36075,0 36127,1 36146,0 36199,1 36261,0 36321,1 36414,0 36446,1 36467,0 36555,1 36565,0 36639,1 36697,0 36707,1 36807,0 36895,1 36965,0 37010,1 37089,0 37131,1 37229,0 37319,1 37363,0 37444,1 37490,0 37545,1 37564,0 37569,1 37602,0 37660,1 37756,0 37821,1 37894,0 37900,1 37923,0 37940,1 37985,0 37993,1 38017,0 38113,1 38124,0 38223,1 38318,0 38335,1 38357,0 38402,1 38429,0 38430,1 38521,0 38591,1 38617,0 38659,1 38747,0 38812,1 38856,0 38881,1 38915,0 39008,1 39048,0 39084,1 39132,0 39219,1 39231,0 39268,1 39361,0 39452,1 39460,0 39481,1 39495,0 39519,1 39577,0 39664,1 39674,0 39724,1 39751,0 39849,1 39949,0 40034,1 40113,0 40178,1 40243,0 40327,1 40403,0 40451,1 40471,0 40558,1 40568,0 40592,1 40596,0 40634,1 40666,0 40761,1 40828,0 40915,1 41002,0 41029,1 41058,0 41092,1 41115,0 41140,1 41198,0 41222,1 41317,0 41372,1 41466,0 41482,1 41508,0 41559,1 41604,0 41641,1 41644,0 41680,1 41720,0 41812,1 41864,0 41887,1 41907,0 41957,1 41983,0 42026,1 42087,0 42101,1 42106,0 42132,1 42213,0 42281,1 42378,0 42407,1 42429,0 42510,1 42573,0 42669,1 42757,0 42831,1 42920,0 42985,1 43021,0 43039,1 43060,0 43104,1 43136,0 43214,1 43217,0 43288,1 43384,0 43386,1 43415,0 43487,1 43568,0 43592,1 43627,0 43667,1 43680,0 43713,1 43768,0 43787,1 43843,0 43942,1 43984,0 44054,1 44057,0 44061,1 44126,0 44222,1 44319,0 44325,1 44365,0 44431,1 44432,0 44460,1 44474,0 44497,1 44568,0 44602,1 44626,0 44686,1 44717,0 44782,1 44818,0 44901,1 44934,0 44996,1 45025,0 45090,1 45188,0 45284,1 45358,0 45367,1 45412,0 45449,1 45508,0 45590,1 45690,0 45780,1 45867,0 45871,1 45879,0 45910,1 45957,0 45995,1 46062,0 46140,1 46228,0 46322,1 46417,0 46475,1 46532,0 46584,1 46637,0 46665,1 46734,0 46767,1 46816,0 46845,1 46870,0 46945,1 47025,0 47050,1 47073,0 47127,1 47141,0 47215,1 47301,0 47302,1 47375,0 47443,1 47454,0 47461,1 47555,0 47556,1 47626,0 47707,1 47754,0 47772,1 47784,0 47882,1 47946,0 48021,1 48044,0 48079,1 48097,0 48147,1 48199,0 48288,1 48323,0 48330,1 48410,0 48413,1 48463,0 48519,1 48542,0 48560,1 48651,0 48734,1 48758,0 48792,1 48820,0 48846,1 48875,0 48905,1 49004,0 49062,1 49122,0 49201,1 49247,0 49321,1 49406,0 49431,1 49475,0 49499,1 49577,0 49583,1 49661,0 49690,1 49695,0 49764,1 49809,0 49813,1 49905,0 49940,1 49942,0 50015,1 50033,0 50061,1 50089,0 50166,1 50212,0 50260,1 end initlist cin 0, 0 53, 1 end outvalues s0 1, s1 1, s2 1, s3 1, s4 1, s5 1, s6 1, s7 1, s8 1, s9 1, s10 1, s11 1, s12 1, s13 1, s14 1, s15 1, , cout 1, end netlist // PGgen (g0,p0,a0,b0) xor2(p0,a0,b0)#5 and2(g0,a0,b0)#5 end netlist // PGgen (g1,p1,a1,b1) xor2(p1,a1,b1)#5 and2(g1,a1,b1)#5 end netlist // PGgen (g2,p2,a2,b2) xor2(p2,a2,b2)#5 and2(g2,a2,b2)#5 end netlist // PGgen (g3,p3,a3,b3) xor2(p3,a3,b3)#5 and2(g3,a3,b3)#5 end netlist // PGgen (g4,p4,a4,b4) xor2(p4,a4,b4)#5 and2(g4,a4,b4)#5 end netlist // PGgen (g5,p5,a5,b5) xor2(p5,a5,b5)#5 and2(g5,a5,b5)#5 end netlist // PGgen (g6,p6,a6,b6) xor2(p6,a6,b6)#5 and2(g6,a6,b6)#5 end netlist // PGgen (g7,p7,a7,b7) xor2(p7,a7,b7)#5 and2(g7,a7,b7)#5 end netlist // PGgen (g8,p8,a8,b8) xor2(p8,a8,b8)#5 and2(g8,a8,b8)#5 end netlist // PGgen (g9,p9,a9,b9) xor2(p9,a9,b9)#5 and2(g9,a9,b9)#5 end netlist // PGgen (g10,p10,a10,b10) xor2(p10,a10,b10)#5 and2(g10,a10,b10)#5 end netlist // PGgen (g11,p11,a11,b11) xor2(p11,a11,b11)#5 and2(g11,a11,b11)#5 end netlist // PGgen (g12,p12,a12,b12) xor2(p12,a12,b12)#5 and2(g12,a12,b12)#5 end netlist // PGgen (g13,p13,a13,b13) xor2(p13,a13,b13)#5 and2(g13,a13,b13)#5 end netlist // PGgen (g14,p14,a14,b14) xor2(p14,a14,b14)#5 and2(g14,a14,b14)#5 end netlist // PGgen (g15,p15,a15,b15) xor2(p15,a15,b15)#5 and2(g15,a15,b15)#5 end netlist // Gcombine (g_0_cin, g0, cin, p0 ) and2(w0g_0_cin, p0, cin )#5 or2( g_0_cin, w0g_0_cin, g0 )#5 end netlist // PGcombine (g_1_0,p_1_0,g1,p1,g0,p0) and2( w0g_1_0, p1, g0 )#5 or2( g_1_0, w0g_1_0, g1 )#5 and2( p_1_0, p1, p0)#5 end netlist // PGcombine (g_2_1,p_2_1,g2,p2,g1,p1) and2( w0g_2_1, p2, g1 )#5 or2( g_2_1, w0g_2_1, g2 )#5 and2( p_2_1, p2, p1)#5 end netlist // PGcombine (g_3_2,p_3_2,g3,p3,g2,p2) and2( w0g_3_2, p3, g2 )#5 or2( g_3_2, w0g_3_2, g3 )#5 and2( p_3_2, p3, p2)#5 end netlist // PGcombine (g_4_3,p_4_3,g4,p4,g3,p3) and2( w0g_4_3, p4, g3 )#5 or2( g_4_3, w0g_4_3, g4 )#5 and2( p_4_3, p4, p3)#5 end netlist // PGcombine (g_5_4,p_5_4,g5,p5,g4,p4) and2( w0g_5_4, p5, g4 )#5 or2( g_5_4, w0g_5_4, g5 )#5 and2( p_5_4, p5, p4)#5 end netlist // PGcombine (g_6_5,p_6_5,g6,p6,g5,p5) and2( w0g_6_5, p6, g5 )#5 or2( g_6_5, w0g_6_5, g6 )#5 and2( p_6_5, p6, p5)#5 end netlist // PGcombine (g_7_6,p_7_6,g7,p7,g6,p6) and2( w0g_7_6, p7, g6 )#5 or2( g_7_6, w0g_7_6, g7 )#5 and2( p_7_6, p7, p6)#5 end netlist // PGcombine (g_8_7,p_8_7,g8,p8,g7,p7) and2( w0g_8_7, p8, g7 )#5 or2( g_8_7, w0g_8_7, g8 )#5 and2( p_8_7, p8, p7)#5 end netlist // PGcombine (g_9_8,p_9_8,g9,p9,g8,p8) and2( w0g_9_8, p9, g8 )#5 or2( g_9_8, w0g_9_8, g9 )#5 and2( p_9_8, p9, p8)#5 end netlist // PGcombine (g_10_9,p_10_9,g10,p10,g9,p9) and2( w0g_10_9, p10, g9 )#5 or2( g_10_9, w0g_10_9, g10 )#5 and2( p_10_9, p10, p9)#5 end netlist // PGcombine (g_11_10,p_11_10,g11,p11,g10,p10) and2( w0g_11_10, p11, g10 )#5 or2( g_11_10, w0g_11_10, g11 )#5 and2( p_11_10, p11, p10)#5 end netlist // PGcombine (g_12_11,p_12_11,g12,p12,g11,p11) and2( w0g_12_11, p12, g11 )#5 or2( g_12_11, w0g_12_11, g12 )#5 and2( p_12_11, p12, p11)#5 end netlist // PGcombine (g_13_12,p_13_12,g13,p13,g12,p12) and2( w0g_13_12, p13, g12 )#5 or2( g_13_12, w0g_13_12, g13 )#5 and2( p_13_12, p13, p12)#5 end netlist // PGcombine (g_14_13,p_14_13,g14,p14,g13,p13) and2( w0g_14_13, p14, g13 )#5 or2( g_14_13, w0g_14_13, g14 )#5 and2( p_14_13, p14, p13)#5 end netlist // PGcombine (g_15_14,p_15_14,g15,p15,g14,p14) and2( w0g_15_14, p15, g14 )#5 or2( g_15_14, w0g_15_14, g15 )#5 and2( p_15_14, p15, p14)#5 end netlist // Gcombine (g_1_cin, g_1_0, cin, p_1_0 ) and2(w0g_1_cin, p_1_0, cin )#5 or2( g_1_cin, w0g_1_cin, g_1_0 )#5 end netlist // Gcombine (g_2_cin, g_2_1, g_0_cin, p_2_1 ) and2(w0g_2_cin, p_2_1, g_0_cin )#5 or2( g_2_cin, w0g_2_cin, g_2_1 )#5 end netlist // PGcombine (g_3_0,p_3_0,g_3_2,p_3_2,g_1_0,p_1_0) and2( w0g_3_0, p_3_2, g_1_0 )#5 or2( g_3_0, w0g_3_0, g_3_2 )#5 and2( p_3_0, p_3_2, p_1_0)#5 end netlist // PGcombine (g_4_1,p_4_1,g_4_3,p_4_3,g_2_1,p_2_1) and2( w0g_4_1, p_4_3, g_2_1 )#5 or2( g_4_1, w0g_4_1, g_4_3 )#5 and2( p_4_1, p_4_3, p_2_1)#5 end netlist // PGcombine (g_5_2,p_5_2,g_5_4,p_5_4,g_3_2,p_3_2) and2( w0g_5_2, p_5_4, g_3_2 )#5 or2( g_5_2, w0g_5_2, g_5_4 )#5 and2( p_5_2, p_5_4, p_3_2)#5 end netlist // PGcombine (g_6_3,p_6_3,g_6_5,p_6_5,g_4_3,p_4_3) and2( w0g_6_3, p_6_5, g_4_3 )#5 or2( g_6_3, w0g_6_3, g_6_5 )#5 and2( p_6_3, p_6_5, p_4_3)#5 end netlist // PGcombine (g_7_4,p_7_4,g_7_6,p_7_6,g_5_4,p_5_4) and2( w0g_7_4, p_7_6, g_5_4 )#5 or2( g_7_4, w0g_7_4, g_7_6 )#5 and2( p_7_4, p_7_6, p_5_4)#5 end netlist // PGcombine (g_8_5,p_8_5,g_8_7,p_8_7,g_6_5,p_6_5) and2( w0g_8_5, p_8_7, g_6_5 )#5 or2( g_8_5, w0g_8_5, g_8_7 )#5 and2( p_8_5, p_8_7, p_6_5)#5 end netlist // PGcombine (g_9_6,p_9_6,g_9_8,p_9_8,g_7_6,p_7_6) and2( w0g_9_6, p_9_8, g_7_6 )#5 or2( g_9_6, w0g_9_6, g_9_8 )#5 and2( p_9_6, p_9_8, p_7_6)#5 end netlist // PGcombine (g_10_7,p_10_7,g_10_9,p_10_9,g_8_7,p_8_7) and2( w0g_10_7, p_10_9, g_8_7 )#5 or2( g_10_7, w0g_10_7, g_10_9 )#5 and2( p_10_7, p_10_9, p_8_7)#5 end netlist // PGcombine (g_11_8,p_11_8,g_11_10,p_11_10,g_9_8,p_9_8) and2( w0g_11_8, p_11_10, g_9_8 )#5 or2( g_11_8, w0g_11_8, g_11_10 )#5 and2( p_11_8, p_11_10, p_9_8)#5 end netlist // PGcombine (g_12_9,p_12_9,g_12_11,p_12_11,g_10_9,p_10_9) and2( w0g_12_9, p_12_11, g_10_9 )#5 or2( g_12_9, w0g_12_9, g_12_11 )#5 and2( p_12_9, p_12_11, p_10_9)#5 end netlist // PGcombine (g_13_10,p_13_10,g_13_12,p_13_12,g_11_10,p_11_10) and2( w0g_13_10, p_13_12, g_11_10 )#5 or2( g_13_10, w0g_13_10, g_13_12 )#5 and2( p_13_10, p_13_12, p_11_10)#5 end netlist // PGcombine (g_14_11,p_14_11,g_14_13,p_14_13,g_12_11,p_12_11) and2( w0g_14_11, p_14_13, g_12_11 )#5 or2( g_14_11, w0g_14_11, g_14_13 )#5 and2( p_14_11, p_14_13, p_12_11)#5 end netlist // PGcombine (g_15_12,p_15_12,g_15_14,p_15_14,g_13_12,p_13_12) and2( w0g_15_12, p_15_14, g_13_12 )#5 or2( g_15_12, w0g_15_12, g_15_14 )#5 and2( p_15_12, p_15_14, p_13_12)#5 end netlist // Gcombine (g_3_cin, g_3_0, cin, p_3_0 ) and2(w0g_3_cin, p_3_0, cin )#5 or2( g_3_cin, w0g_3_cin, g_3_0 )#5 end netlist // Gcombine (g_4_cin, g_4_1, g_0_cin, p_4_1 ) and2(w0g_4_cin, p_4_1, g_0_cin )#5 or2( g_4_cin, w0g_4_cin, g_4_1 )#5 end netlist // Gcombine (g_5_cin, g_5_2, g_1_cin, p_5_2 ) and2(w0g_5_cin, p_5_2, g_1_cin )#5 or2( g_5_cin, w0g_5_cin, g_5_2 )#5 end netlist // Gcombine (g_6_cin, g_6_3, g_2_cin, p_6_3 ) and2(w0g_6_cin, p_6_3, g_2_cin )#5 or2( g_6_cin, w0g_6_cin, g_6_3 )#5 end netlist // PGcombine (g_7_0,p_7_0,g_7_4,p_7_4,g_3_0,p_3_0) and2( w0g_7_0, p_7_4, g_3_0 )#5 or2( g_7_0, w0g_7_0, g_7_4 )#5 and2( p_7_0, p_7_4, p_3_0)#5 end netlist // PGcombine (g_8_1,p_8_1,g_8_5,p_8_5,g_4_1,p_4_1) and2( w0g_8_1, p_8_5, g_4_1 )#5 or2( g_8_1, w0g_8_1, g_8_5 )#5 and2( p_8_1, p_8_5, p_4_1)#5 end netlist // PGcombine (g_9_2,p_9_2,g_9_6,p_9_6,g_5_2,p_5_2) and2( w0g_9_2, p_9_6, g_5_2 )#5 or2( g_9_2, w0g_9_2, g_9_6 )#5 and2( p_9_2, p_9_6, p_5_2)#5 end netlist // PGcombine (g_10_3,p_10_3,g_10_7,p_10_7,g_6_3,p_6_3) and2( w0g_10_3, p_10_7, g_6_3 )#5 or2( g_10_3, w0g_10_3, g_10_7 )#5 and2( p_10_3, p_10_7, p_6_3)#5 end netlist // PGcombine (g_11_4,p_11_4,g_11_8,p_11_8,g_7_4,p_7_4) and2( w0g_11_4, p_11_8, g_7_4 )#5 or2( g_11_4, w0g_11_4, g_11_8 )#5 and2( p_11_4, p_11_8, p_7_4)#5 end netlist // PGcombine (g_12_5,p_12_5,g_12_9,p_12_9,g_8_5,p_8_5) and2( w0g_12_5, p_12_9, g_8_5 )#5 or2( g_12_5, w0g_12_5, g_12_9 )#5 and2( p_12_5, p_12_9, p_8_5)#5 end netlist // PGcombine (g_13_6,p_13_6,g_13_10,p_13_10,g_9_6,p_9_6) and2( w0g_13_6, p_13_10, g_9_6 )#5 or2( g_13_6, w0g_13_6, g_13_10 )#5 and2( p_13_6, p_13_10, p_9_6)#5 end netlist // PGcombine (g_14_7,p_14_7,g_14_11,p_14_11,g_10_7,p_10_7) and2( w0g_14_7, p_14_11, g_10_7 )#5 or2( g_14_7, w0g_14_7, g_14_11 )#5 and2( p_14_7, p_14_11, p_10_7)#5 end netlist // PGcombine (g_15_8,p_15_8,g_15_12,p_15_12,g_11_8,p_11_8) and2( w0g_15_8, p_15_12, g_11_8 )#5 or2( g_15_8, w0g_15_8, g_15_12 )#5 and2( p_15_8, p_15_12, p_11_8)#5 end netlist // Gcombine (g_7_cin, g_7_0, cin, p_7_0 ) and2(w0g_7_cin, p_7_0, cin )#5 or2( g_7_cin, w0g_7_cin, g_7_0 )#5 end netlist // Gcombine (g_8_cin, g_8_1, g_0_cin, p_8_1 ) and2(w0g_8_cin, p_8_1, g_0_cin )#5 or2( g_8_cin, w0g_8_cin, g_8_1 )#5 end netlist // Gcombine (g_9_cin, g_9_2, g_1_cin, p_9_2 ) and2(w0g_9_cin, p_9_2, g_1_cin )#5 or2( g_9_cin, w0g_9_cin, g_9_2 )#5 end netlist // Gcombine (g_10_cin, g_10_3, g_2_cin, p_10_3 ) and2(w0g_10_cin, p_10_3, g_2_cin )#5 or2( g_10_cin, w0g_10_cin, g_10_3 )#5 end netlist // Gcombine (g_11_cin, g_11_4, g_3_cin, p_11_4 ) and2(w0g_11_cin, p_11_4, g_3_cin )#5 or2( g_11_cin, w0g_11_cin, g_11_4 )#5 end netlist // Gcombine (g_12_cin, g_12_5, g_4_cin, p_12_5 ) and2(w0g_12_cin, p_12_5, g_4_cin )#5 or2( g_12_cin, w0g_12_cin, g_12_5 )#5 end netlist // Gcombine (g_13_cin, g_13_6, g_5_cin, p_13_6 ) and2(w0g_13_cin, p_13_6, g_5_cin )#5 or2( g_13_cin, w0g_13_cin, g_13_6 )#5 end netlist // Gcombine (g_14_cin, g_14_7, g_6_cin, p_14_7 ) and2(w0g_14_cin, p_14_7, g_6_cin )#5 or2( g_14_cin, w0g_14_cin, g_14_7 )#5 end netlist // PGcombine (g_15_0,p_15_0,g_15_8,p_15_8,g_7_0,p_7_0) and2( w0g_15_0, p_15_8, g_7_0 )#5 or2( g_15_0, w0g_15_0, g_15_8 )#5 and2( p_15_0, p_15_8, p_7_0)#5 end netlist // Gcombine (cout, g_15_0, cin, p_15_0 ) and2(w0cout, p_15_0, cin )#5 or2( cout, w0cout, g_15_0 )#5 end netlist xor2( s0, p0,cin )#5 xor2( s1, p1,g_0_cin )#5 xor2( s2, p2,g_1_cin )#5 xor2( s3, p3,g_2_cin )#5 xor2( s4, p4,g_3_cin )#5 xor2( s5, p5,g_4_cin )#5 xor2( s6, p6,g_5_cin )#5 xor2( s7, p7,g_6_cin )#5 xor2( s8, p8,g_7_cin )#5 xor2( s9, p9,g_8_cin )#5 xor2( s10, p10,g_9_cin )#5 xor2( s11, p11,g_10_cin )#5 xor2( s12, p12,g_11_cin )#5 xor2( s13, p13,g_12_cin )#5 xor2( s14, p14,g_13_cin )#5 xor2( s15, p15,g_14_cin )#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/adder16.net
// Lonestar Benchmark Suite for irregular applications that exhibit // amorphous data-parallelism. // // Center for Grid and Distributed Computing // The University of Texas at Austin // // Copyright (C) 2007, 2008, 2009 The University of Texas at Austin // // Licensed under the Eclipse Public License, Version 1.0 (the "License"); // you may not use this file except in compliance with the License. // You may obtain a copy of the License at // // http://www.eclipse.org/legal/epl-v10.html // // Unless required by applicable law or agreed to in writing, software // distributed under the License is distributed on an "AS IS" BASIS, // WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. // See the License for the specific language governing permissions and // limitations under the License. // // File: adder16.net finish=250 inputs cin, a0, a1, a2, a3, a4, a5, a6, a7, a8, a9, a10, a11, a12, a13, a14, a15, end inputs b0, b1, b2, b3, b4, b5, b6, b7, b8, b9, b10, b11, b12, b13, b14, b15, end outputs r15, s0, s1, s2, s3, s4, s5, s6, s7, s8, s9, s10, s11, s12, s13, s14, s15 end outvalues r15 1, s0 0, s1 0, s2 0, s3 0, s4 0, s5 0, s6 0, s7 0, s8 0, s9 0, s10 0, s11 0, s12 0, s13 0, s14 0, s15 0, end initlist cin 0,0 21,1 end initlist a0 0,1 end initlist a1 0,1 end initlist a2 0,1 end initlist a3 0,1 end initlist a4 0,1 end initlist a5 0,1 end initlist a6 0,1 end initlist a7 0,1 end initlist a8 0,1 end initlist a9 0,1 end initlist a10 0,1 end initlist a11 0,1 end initlist a12 0,1 end initlist a13 0,1 end initlist a14 0,1 end initlist a15 0,1 end initlist b0 0,0 end initlist b1 0,0 end initlist b2 0,0 end initlist b3 0,0 end initlist b4 0,0 end initlist b5 0,0 end initlist b6 0,0 end initlist b7 0,0 end initlist b8 0,0 end initlist b9 0,0 end initlist b10 0,0 end initlist b11 0,0 end initlist b12 0,0 end initlist b13 0,0 end initlist b14 0,0 end initlist b15 0,0 end netlist inv(a0n,a0)#4 inv(b0n,b0)#4 inv(cinn,cin)#4 and2(a0nb0n,a0n,b0n)#2 and2(a0nb0,a0n,b0)#2 and2(a0b0n,a0,b0n)#2 and2(a0b0,a0,b0)#3 and2(a0b0cin,a0b0,cin)#2 and2(a0nb0ncin,a0nb0n,cin)#2 and2(a0nb0cinn,a0nb0,cinn)#2 and2(a0b0ncinn,a0b0n,cinn)#2 and2(b0cin,b0,cin)#2 and2(a0cin,cin,a0)#2 or2(s0w42,a0b0ncinn,a0nb0cinn)#3 or2(s0w71,a0b0cin, a0nb0ncin)#3 or2(s0,s0w42,s0w71)#3 or2(s0w35, b0cin, a0cin)#3 or2(r0,s0w35,a0b0)#5 end netlist inv(a1n,a1)#4 inv(b1n,b1)#4 inv(r0n,r0)#4 and2(a1nb1n,a1n,b1n)#2 and2(a1nb1,a1n,b1)#2 and2(a1b1n,a1,b1n)#2 and2(a1b1,a1,b1)#3 and2(a1b1r0,a1b1,r0)#2 and2(a1nb1nr0,a1nb1n,r0)#2 and2(a1nb1r0n,a1nb1,r0n)#2 and2(a1b1nr0n,a1b1n,r0n)#2 and2(b1r0,b1,r0)#2 and2(a1r0,r0,a1)#2 or2(s1w42,a1b1nr0n,a1nb1r0n)#3 or2(s1w71,a1b1r0, a1nb1nr0)#3 or2(s1,s1w42,s1w71)#3 or2(s1w35, b1r0, a1r0)#3 or2(r1,s1w35,a1b1)#5 end netlist inv(a2n,a2)#4 inv(b2n,b2)#4 inv(r1n,r1)#4 and2(a2nb2n,a2n,b2n)#2 and2(a2nb2,a2n,b2)#2 and2(a2b2n,a2,b2n)#2 and2(a2b2,a2,b2)#3 and2(a2b2r1,a2b2,r1)#2 and2(a2nb2nr1,a2nb2n,r1)#2 and2(a2nb2r1n,a2nb2,r1n)#2 and2(a2b2nr1n,a2b2n,r1n)#2 and2(b2r1,b2,r1)#2 and2(a2r1,r1,a2)#2 or2(s2w42,a2b2nr1n,a2nb2r1n)#3 or2(s2w71,a2b2r1, a2nb2nr1)#3 or2(s2,s2w42,s2w71)#3 or2(s2w35, b2r1, a2r1)#3 or2(r2,s2w35,a2b2)#5 end netlist inv(a3n,a3)#4 inv(b3n,b3)#4 inv(r2n,r2)#4 and2(a3nb3n,a3n,b3n)#2 and2(a3nb3,a3n,b3)#2 and2(a3b3n,a3,b3n)#2 and2(a3b3,a3,b3)#3 and2(a3b3r2,a3b3,r2)#2 and2(a3nb3nr2,a3nb3n,r2)#2 and2(a3nb3r2n,a3nb3,r2n)#2 and2(a3b3nr2n,a3b3n,r2n)#2 and2(b3r2,b3,r2)#2 and2(a3r2,r2,a3)#2 or2(s3w42,a3b3nr2n,a3nb3r2n)#3 or2(s3w71,a3b3r2, a3nb3nr2)#3 or2(s3,s3w42,s3w71)#3 or2(s3w35, b3r2, a3r2)#3 or2(r3,s3w35,a3b3)#5 end netlist inv(a4n,a4)#4 inv(b4n,b4)#4 inv(r3n,r3)#4 and2(a4nb4n,a4n,b4n)#2 and2(a4nb4,a4n,b4)#2 and2(a4b4n,a4,b4n)#2 and2(a4b4,a4,b4)#3 and2(a4b4r3,a4b4,r3)#2 and2(a4nb4nr3,a4nb4n,r3)#2 and2(a4nb4r3n,a4nb4,r3n)#2 and2(a4b4nr3n,a4b4n,r3n)#2 and2(b4r3,b4,r3)#2 and2(a4r3,r3,a4)#2 or2(s4w42,a4b4nr3n,a4nb4r3n)#3 or2(s4w71,a4b4r3, a4nb4nr3)#3 or2(s4,s4w42,s4w71)#3 or2(s4w35, b4r3, a4r3)#3 or2(r4,s4w35,a4b4)#5 end netlist inv(a5n,a5)#4 inv(b5n,b5)#4 inv(r4n,r4)#4 and2(a5nb5n,a5n,b5n)#2 and2(a5nb5,a5n,b5)#2 and2(a5b5n,a5,b5n)#2 and2(a5b5,a5,b5)#3 and2(a5b5r4,a5b5,r4)#2 and2(a5nb5nr4,a5nb5n,r4)#2 and2(a5nb5r4n,a5nb5,r4n)#2 and2(a5b5nr4n,a5b5n,r4n)#2 and2(b5r4,b5,r4)#2 and2(a5r4,r4,a5)#2 or2(s5w42,a5b5nr4n,a5nb5r4n)#3 or2(s5w71,a5b5r4, a5nb5nr4)#3 or2(s5,s5w42,s5w71)#3 or2(s5w35, b5r4, a5r4)#3 or2(r5,s5w35,a5b5)#5 end netlist inv(a6n,a6)#4 inv(b6n,b6)#4 inv(r5n,r5)#4 and2(a6nb6n,a6n,b6n)#2 and2(a6nb6,a6n,b6)#2 and2(a6b6n,a6,b6n)#2 and2(a6b6,a6,b6)#3 and2(a6b6r5,a6b6,r5)#2 and2(a6nb6nr5,a6nb6n,r5)#2 and2(a6nb6r5n,a6nb6,r5n)#2 and2(a6b6nr5n,a6b6n,r5n)#2 and2(b6r5,b6,r5)#2 and2(a6r5,r5,a6)#2 or2(s6w42,a6b6nr5n,a6nb6r5n)#3 or2(s6w71,a6b6r5, a6nb6nr5)#3 or2(s6,s6w42,s6w71)#3 or2(s6w35, b6r5, a6r5)#3 or2(r6,s6w35,a6b6)#5 end netlist inv(a7n,a7)#4 inv(b7n,b7)#4 inv(r6n,r6)#4 and2(a7nb7n,a7n,b7n)#2 and2(a7nb7,a7n,b7)#2 and2(a7b7n,a7,b7n)#2 and2(a7b7,a7,b7)#3 and2(a7b7r6,a7b7,r6)#2 and2(a7nb7nr6,a7nb7n,r6)#2 and2(a7nb7r6n,a7nb7,r6n)#2 and2(a7b7nr6n,a7b7n,r6n)#2 and2(b7r6,b7,r6)#2 and2(a7r6,r6,a7)#2 or2(s7w42,a7b7nr6n,a7nb7r6n)#3 or2(s7w71,a7b7r6, a7nb7nr6)#3 or2(s7,s7w42,s7w71)#3 or2(s7w35, b7r6, a7r6)#3 or2(r7,s7w35,a7b7)#5 end netlist inv(a8n,a8)#4 inv(b8n,b8)#4 inv(r7n,r7)#4 and2(a8nb8n,a8n,b8n)#2 and2(a8nb8,a8n,b8)#2 and2(a8b8n,a8,b8n)#2 and2(a8b8,a8,b8)#3 and2(a8b8r7,a8b8,r7)#2 and2(a8nb8nr7,a8nb8n,r7)#2 and2(a8nb8r7n,a8nb8,r7n)#2 and2(a8b8nr7n,a8b8n,r7n)#2 and2(b8r7,b8,r7)#2 and2(a8r7,r7,a8)#2 or2(s8w42,a8b8nr7n,a8nb8r7n)#3 or2(s8w71,a8b8r7, a8nb8nr7)#3 or2(s8,s8w42,s8w71)#3 or2(s8w35, b8r7, a8r7)#3 or2(r8,s8w35,a8b8)#5 end netlist inv(a9n,a9)#4 inv(b9n,b9)#4 inv(r8n,r8)#4 and2(a9nb9n,a9n,b9n)#2 and2(a9nb9,a9n,b9)#2 and2(a9b9n,a9,b9n)#2 and2(a9b9,a9,b9)#3 and2(a9b9r8,a9b9,r8)#2 and2(a9nb9nr8,a9nb9n,r8)#2 and2(a9nb9r8n,a9nb9,r8n)#2 and2(a9b9nr8n,a9b9n,r8n)#2 and2(b9r8,b9,r8)#2 and2(a9r8,r8,a9)#2 or2(s9w42,a9b9nr8n,a9nb9r8n)#3 or2(s9w71,a9b9r8, a9nb9nr8)#3 or2(s9,s9w42,s9w71)#3 or2(s9w35, b9r8, a9r8)#3 or2(r9,s9w35,a9b9)#5 end netlist inv(a10n,a10)#4 inv(b10n,b10)#4 inv(r9n,r9)#4 and2(a10nb10n,a10n,b10n)#2 and2(a10nb10,a10n,b10)#2 and2(a10b10n,a10,b10n)#2 and2(a10b10,a10,b10)#3 and2(a10b10r9,a10b10,r9)#2 and2(a10nb10nr9,a10nb10n,r9)#2 and2(a10nb10r9n,a10nb10,r9n)#2 and2(a10b10nr9n,a10b10n,r9n)#2 and2(b10r9,b10,r9)#2 and2(a10r9,r9,a10)#2 or2(s10w42,a10b10nr9n,a10nb10r9n)#3 or2(s10w71,a10b10r9, a10nb10nr9)#3 or2(s10,s10w42,s10w71)#3 or2(s10w35, b10r9, a10r9)#3 or2(r10,s10w35,a10b10)#5 end netlist inv(a11n,a11)#4 inv(b11n,b11)#4 inv(r10n,r10)#4 and2(a11nb11n,a11n,b11n)#2 and2(a11nb11,a11n,b11)#2 and2(a11b11n,a11,b11n)#2 and2(a11b11,a11,b11)#3 and2(a11b11r10,a11b11,r10)#2 and2(a11nb11nr10,a11nb11n,r10)#2 and2(a11nb11r10n,a11nb11,r10n)#2 and2(a11b11nr10n,a11b11n,r10n)#2 and2(b11r10,b11,r10)#2 and2(a11r10,r10,a11)#2 or2(s11w42,a11b11nr10n,a11nb11r10n)#3 or2(s11w71,a11b11r10, a11nb11nr10)#3 or2(s11,s11w42,s11w71)#3 or2(s11w35, b11r10, a11r10)#3 or2(r11,s11w35,a11b11)#5 end netlist inv(a12n,a12)#4 inv(b12n,b12)#4 inv(r11n,r11)#4 and2(a12nb12n,a12n,b12n)#2 and2(a12nb12,a12n,b12)#2 and2(a12b12n,a12,b12n)#2 and2(a12b12,a12,b12)#3 and2(a12b12r11,a12b12,r11)#2 and2(a12nb12nr11,a12nb12n,r11)#2 and2(a12nb12r11n,a12nb12,r11n)#2 and2(a12b12nr11n,a12b12n,r11n)#2 and2(b12r11,b12,r11)#2 and2(a12r11,r11,a12)#2 or2(s12w42,a12b12nr11n,a12nb12r11n)#3 or2(s12w71,a12b12r11, a12nb12nr11)#3 or2(s12,s12w42,s12w71)#3 or2(s12w35, b12r11, a12r11)#3 or2(r12,s12w35,a12b12)#5 end netlist inv(a13n,a13)#4 inv(b13n,b13)#4 inv(r12n,r12)#4 and2(a13nb13n,a13n,b13n)#2 and2(a13nb13,a13n,b13)#2 and2(a13b13n,a13,b13n)#2 and2(a13b13,a13,b13)#3 and2(a13b13r12,a13b13,r12)#2 and2(a13nb13nr12,a13nb13n,r12)#2 and2(a13nb13r12n,a13nb13,r12n)#2 and2(a13b13nr12n,a13b13n,r12n)#2 and2(b13r12,b13,r12)#2 and2(a13r12,r12,a13)#2 or2(s13w42,a13b13nr12n,a13nb13r12n)#3 or2(s13w71,a13b13r12, a13nb13nr12)#3 or2(s13,s13w42,s13w71)#3 or2(s13w35, b13r12, a13r12)#3 or2(r13,s13w35,a13b13)#5 end netlist inv(a14n,a14)#4 inv(b14n,b14)#4 inv(r13n,r13)#4 and2(a14nb14n,a14n,b14n)#2 and2(a14nb14,a14n,b14)#2 and2(a14b14n,a14,b14n)#2 and2(a14b14,a14,b14)#3 and2(a14b14r13,a14b14,r13)#2 and2(a14nb14nr13,a14nb14n,r13)#2 and2(a14nb14r13n,a14nb14,r13n)#2 and2(a14b14nr13n,a14b14n,r13n)#2 and2(b14r13,b14,r13)#2 and2(a14r13,r13,a14)#2 or2(s14w42,a14b14nr13n,a14nb14r13n)#3 or2(s14w71,a14b14r13, a14nb14nr13)#3 or2(s14,s14w42,s14w71)#3 or2(s14w35, b14r13, a14r13)#3 or2(r14,s14w35,a14b14)#5 end netlist inv(a15n,a15)#4 inv(b15n,b15)#4 inv(r14n,r14)#4 and2(a15nb15n,a15n,b15n)#2 and2(a15nb15,a15n,b15)#2 and2(a15b15n,a15,b15n)#2 and2(a15b15,a15,b15)#3 and2(a15b15r14,a15b15,r14)#2 and2(a15nb15nr14,a15nb15n,r14)#2 and2(a15nb15r14n,a15nb15,r14n)#2 and2(a15b15nr14n,a15b15n,r14n)#2 and2(b15r14,b15,r14)#2 and2(a15r14,r14,a15)#2 or2(s15w42,a15b15nr14n,a15nb15r14n)#3 or2(s15w71,a15b15r14, a15nb15nr14)#3 or2(s15,s15w42,s15w71)#3 or2(s15w35, b15r14, a15r14)#3 or2(r15,s15w35,a15b15)#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/multTree12bit.net
finish 100000 inputs a0, a1, a2, a3, a4, a5, a6, a7, a8, a9, a10, a11, b0, b1, b2, b3, b4, b5, b6, b7, b8, b9, b10, b11, GND end outputs m0, m1, m2, m3, m4, m5, m6, m7, m8, m9, m10, m11, m12, m13, m14, m15, m16, m17, m18, m19, m20, m21, m22, m23, end outvalues m0 1, m1 0, m2 0, m3 0, m4 0, m5 0, m6 0, m7 0, m8 0, m9 0, m10 0, m11 0, m12 0, m13 1, m14 1, m15 1, m16 1, m17 1, m18 1, m19 1, m20 1, m21 1, m22 1, m23 1, end initlist GND 0 0 end initlist a0 0,0 19,1 end initlist a1 0,0 76,1 end initlist a2 0,0 48,1 end initlist a3 0,0 89,1 end initlist a4 0,0 24,1 end initlist a5 0,0 30,1 end initlist a6 0,0 77,1 end initlist a7 0,0 72,1 end initlist a8 0,0 93,1 end initlist a9 0,0 80,1 end initlist a10 0,0 3,1 end initlist a11 0,0 92,1 end initlist b0 0,0 42,1 end initlist b1 0,0 53,1 end initlist b2 0,0 72,1 end initlist b3 0,0 63,1 end initlist b4 0,0 39,1 end initlist b5 0,0 42,1 end initlist b6 0,0 45,1 end initlist b7 0,0 88,1 end initlist b8 0,0 95,1 end initlist b9 0,0 61,1 end initlist b10 0,0 64,1 end initlist b11 0,0 11,1 end netlist // mux2x1 Bth0.0( PP_0_0, GND, a0, b0 ) inv(b0_n.Bth0.0, b0 )#5 and2(w0.Bth0.0, b0_n.Bth0.0, GND )#5 and2(w1.Bth0.0, b0, a0 )#5 or2(PP_0_0, w0.Bth0.0, w1.Bth0.0 )#5 // end mux2x1 Bth0.0 end netlist // mux2x1 Bth0.1( PP_0_1, GND, a1, b0 ) inv(b0_n.Bth0.1, b0 )#5 and2(w0.Bth0.1, b0_n.Bth0.1, GND )#5 and2(w1.Bth0.1, b0, a1 )#5 or2(PP_0_1, w0.Bth0.1, w1.Bth0.1 )#5 // end mux2x1 Bth0.1 end netlist // mux2x1 Bth0.2( PP_0_2, GND, a2, b0 ) inv(b0_n.Bth0.2, b0 )#5 and2(w0.Bth0.2, b0_n.Bth0.2, GND )#5 and2(w1.Bth0.2, b0, a2 )#5 or2(PP_0_2, w0.Bth0.2, w1.Bth0.2 )#5 // end mux2x1 Bth0.2 end netlist // mux2x1 Bth0.3( PP_0_3, GND, a3, b0 ) inv(b0_n.Bth0.3, b0 )#5 and2(w0.Bth0.3, b0_n.Bth0.3, GND )#5 and2(w1.Bth0.3, b0, a3 )#5 or2(PP_0_3, w0.Bth0.3, w1.Bth0.3 )#5 // end mux2x1 Bth0.3 end netlist // mux2x1 Bth0.4( PP_0_4, GND, a4, b0 ) inv(b0_n.Bth0.4, b0 )#5 and2(w0.Bth0.4, b0_n.Bth0.4, GND )#5 and2(w1.Bth0.4, b0, a4 )#5 or2(PP_0_4, w0.Bth0.4, w1.Bth0.4 )#5 // end mux2x1 Bth0.4 end netlist // mux2x1 Bth0.5( PP_0_5, GND, a5, b0 ) inv(b0_n.Bth0.5, b0 )#5 and2(w0.Bth0.5, b0_n.Bth0.5, GND )#5 and2(w1.Bth0.5, b0, a5 )#5 or2(PP_0_5, w0.Bth0.5, w1.Bth0.5 )#5 // end mux2x1 Bth0.5 end netlist // mux2x1 Bth0.6( PP_0_6, GND, a6, b0 ) inv(b0_n.Bth0.6, b0 )#5 and2(w0.Bth0.6, b0_n.Bth0.6, GND )#5 and2(w1.Bth0.6, b0, a6 )#5 or2(PP_0_6, w0.Bth0.6, w1.Bth0.6 )#5 // end mux2x1 Bth0.6 end netlist // mux2x1 Bth0.7( PP_0_7, GND, a7, b0 ) inv(b0_n.Bth0.7, b0 )#5 and2(w0.Bth0.7, b0_n.Bth0.7, GND )#5 and2(w1.Bth0.7, b0, a7 )#5 or2(PP_0_7, w0.Bth0.7, w1.Bth0.7 )#5 // end mux2x1 Bth0.7 end netlist // mux2x1 Bth0.8( PP_0_8, GND, a8, b0 ) inv(b0_n.Bth0.8, b0 )#5 and2(w0.Bth0.8, b0_n.Bth0.8, GND )#5 and2(w1.Bth0.8, b0, a8 )#5 or2(PP_0_8, w0.Bth0.8, w1.Bth0.8 )#5 // end mux2x1 Bth0.8 end netlist // mux2x1 Bth0.9( PP_0_9, GND, a9, b0 ) inv(b0_n.Bth0.9, b0 )#5 and2(w0.Bth0.9, b0_n.Bth0.9, GND )#5 and2(w1.Bth0.9, b0, a9 )#5 or2(PP_0_9, w0.Bth0.9, w1.Bth0.9 )#5 // end mux2x1 Bth0.9 end netlist // mux2x1 Bth0.10( PP_0_10, GND, a10, b0 ) inv(b0_n.Bth0.10, b0 )#5 and2(w0.Bth0.10, b0_n.Bth0.10, GND )#5 and2(w1.Bth0.10, b0, a10 )#5 or2(PP_0_10, w0.Bth0.10, w1.Bth0.10 )#5 // end mux2x1 Bth0.10 end netlist // mux2x1 Bth0.11( PP_0_11, GND, a11, b0 ) inv(b0_n.Bth0.11, b0 )#5 and2(w0.Bth0.11, b0_n.Bth0.11, GND )#5 and2(w1.Bth0.11, b0, a11 )#5 or2(PP_0_11, w0.Bth0.11, w1.Bth0.11 )#5 // end mux2x1 Bth0.11 end netlist // mux2x1 Bth0.12( PP_0_12, GND, GND, b0 ) inv(b0_n.Bth0.12, b0 )#5 and2(w0.Bth0.12, b0_n.Bth0.12, GND )#5 and2(w1.Bth0.12, b0, GND )#5 or2(PP_0_12, w0.Bth0.12, w1.Bth0.12 )#5 // end mux2x1 Bth0.12 end netlist // mux2x1 Bth0.13( PP_0_13, GND, GND, b0 ) inv(b0_n.Bth0.13, b0 )#5 and2(w0.Bth0.13, b0_n.Bth0.13, GND )#5 and2(w1.Bth0.13, b0, GND )#5 or2(PP_0_13, w0.Bth0.13, w1.Bth0.13 )#5 // end mux2x1 Bth0.13 end netlist // mux2x1 Bth0.14( PP_0_14, GND, GND, b0 ) inv(b0_n.Bth0.14, b0 )#5 and2(w0.Bth0.14, b0_n.Bth0.14, GND )#5 and2(w1.Bth0.14, b0, GND )#5 or2(PP_0_14, w0.Bth0.14, w1.Bth0.14 )#5 // end mux2x1 Bth0.14 end netlist // mux2x1 Bth0.15( PP_0_15, GND, GND, b0 ) inv(b0_n.Bth0.15, b0 )#5 and2(w0.Bth0.15, b0_n.Bth0.15, GND )#5 and2(w1.Bth0.15, b0, GND )#5 or2(PP_0_15, w0.Bth0.15, w1.Bth0.15 )#5 // end mux2x1 Bth0.15 end netlist // mux2x1 Bth0.16( PP_0_16, GND, GND, b0 ) inv(b0_n.Bth0.16, b0 )#5 and2(w0.Bth0.16, b0_n.Bth0.16, GND )#5 and2(w1.Bth0.16, b0, GND )#5 or2(PP_0_16, w0.Bth0.16, w1.Bth0.16 )#5 // end mux2x1 Bth0.16 end netlist // mux2x1 Bth0.17( PP_0_17, GND, GND, b0 ) inv(b0_n.Bth0.17, b0 )#5 and2(w0.Bth0.17, b0_n.Bth0.17, GND )#5 and2(w1.Bth0.17, b0, GND )#5 or2(PP_0_17, w0.Bth0.17, w1.Bth0.17 )#5 // end mux2x1 Bth0.17 end netlist // mux2x1 Bth0.18( PP_0_18, GND, GND, b0 ) inv(b0_n.Bth0.18, b0 )#5 and2(w0.Bth0.18, b0_n.Bth0.18, GND )#5 and2(w1.Bth0.18, b0, GND )#5 or2(PP_0_18, w0.Bth0.18, w1.Bth0.18 )#5 // end mux2x1 Bth0.18 end netlist // mux2x1 Bth0.19( PP_0_19, GND, GND, b0 ) inv(b0_n.Bth0.19, b0 )#5 and2(w0.Bth0.19, b0_n.Bth0.19, GND )#5 and2(w1.Bth0.19, b0, GND )#5 or2(PP_0_19, w0.Bth0.19, w1.Bth0.19 )#5 // end mux2x1 Bth0.19 end netlist // mux2x1 Bth0.20( PP_0_20, GND, GND, b0 ) inv(b0_n.Bth0.20, b0 )#5 and2(w0.Bth0.20, b0_n.Bth0.20, GND )#5 and2(w1.Bth0.20, b0, GND )#5 or2(PP_0_20, w0.Bth0.20, w1.Bth0.20 )#5 // end mux2x1 Bth0.20 end netlist // mux2x1 Bth0.21( PP_0_21, GND, GND, b0 ) inv(b0_n.Bth0.21, b0 )#5 and2(w0.Bth0.21, b0_n.Bth0.21, GND )#5 and2(w1.Bth0.21, b0, GND )#5 or2(PP_0_21, w0.Bth0.21, w1.Bth0.21 )#5 // end mux2x1 Bth0.21 end netlist // mux2x1 Bth0.22( PP_0_22, GND, GND, b0 ) inv(b0_n.Bth0.22, b0 )#5 and2(w0.Bth0.22, b0_n.Bth0.22, GND )#5 and2(w1.Bth0.22, b0, GND )#5 or2(PP_0_22, w0.Bth0.22, w1.Bth0.22 )#5 // end mux2x1 Bth0.22 end netlist // mux2x1 Bth0.23( PP_0_23, GND, GND, b0 ) inv(b0_n.Bth0.23, b0 )#5 and2(w0.Bth0.23, b0_n.Bth0.23, GND )#5 and2(w1.Bth0.23, b0, GND )#5 or2(PP_0_23, w0.Bth0.23, w1.Bth0.23 )#5 // end mux2x1 Bth0.23 end netlist // mux2x1 Bth1.0( PP_1_0, GND, GND, b1 ) inv(b1_n.Bth1.0, b1 )#5 and2(w0.Bth1.0, b1_n.Bth1.0, GND )#5 and2(w1.Bth1.0, b1, GND )#5 or2(PP_1_0, w0.Bth1.0, w1.Bth1.0 )#5 // end mux2x1 Bth1.0 end netlist // mux2x1 Bth1.1( PP_1_1, GND, a0, b1 ) inv(b1_n.Bth1.1, b1 )#5 and2(w0.Bth1.1, b1_n.Bth1.1, GND )#5 and2(w1.Bth1.1, b1, a0 )#5 or2(PP_1_1, w0.Bth1.1, w1.Bth1.1 )#5 // end mux2x1 Bth1.1 end netlist // mux2x1 Bth1.2( PP_1_2, GND, a1, b1 ) inv(b1_n.Bth1.2, b1 )#5 and2(w0.Bth1.2, b1_n.Bth1.2, GND )#5 and2(w1.Bth1.2, b1, a1 )#5 or2(PP_1_2, w0.Bth1.2, w1.Bth1.2 )#5 // end mux2x1 Bth1.2 end netlist // mux2x1 Bth1.3( PP_1_3, GND, a2, b1 ) inv(b1_n.Bth1.3, b1 )#5 and2(w0.Bth1.3, b1_n.Bth1.3, GND )#5 and2(w1.Bth1.3, b1, a2 )#5 or2(PP_1_3, w0.Bth1.3, w1.Bth1.3 )#5 // end mux2x1 Bth1.3 end netlist // mux2x1 Bth1.4( PP_1_4, GND, a3, b1 ) inv(b1_n.Bth1.4, b1 )#5 and2(w0.Bth1.4, b1_n.Bth1.4, GND )#5 and2(w1.Bth1.4, b1, a3 )#5 or2(PP_1_4, w0.Bth1.4, w1.Bth1.4 )#5 // end mux2x1 Bth1.4 end netlist // mux2x1 Bth1.5( PP_1_5, GND, a4, b1 ) inv(b1_n.Bth1.5, b1 )#5 and2(w0.Bth1.5, b1_n.Bth1.5, GND )#5 and2(w1.Bth1.5, b1, a4 )#5 or2(PP_1_5, w0.Bth1.5, w1.Bth1.5 )#5 // end mux2x1 Bth1.5 end netlist // mux2x1 Bth1.6( PP_1_6, GND, a5, b1 ) inv(b1_n.Bth1.6, b1 )#5 and2(w0.Bth1.6, b1_n.Bth1.6, GND )#5 and2(w1.Bth1.6, b1, a5 )#5 or2(PP_1_6, w0.Bth1.6, w1.Bth1.6 )#5 // end mux2x1 Bth1.6 end netlist // mux2x1 Bth1.7( PP_1_7, GND, a6, b1 ) inv(b1_n.Bth1.7, b1 )#5 and2(w0.Bth1.7, b1_n.Bth1.7, GND )#5 and2(w1.Bth1.7, b1, a6 )#5 or2(PP_1_7, w0.Bth1.7, w1.Bth1.7 )#5 // end mux2x1 Bth1.7 end netlist // mux2x1 Bth1.8( PP_1_8, GND, a7, b1 ) inv(b1_n.Bth1.8, b1 )#5 and2(w0.Bth1.8, b1_n.Bth1.8, GND )#5 and2(w1.Bth1.8, b1, a7 )#5 or2(PP_1_8, w0.Bth1.8, w1.Bth1.8 )#5 // end mux2x1 Bth1.8 end netlist // mux2x1 Bth1.9( PP_1_9, GND, a8, b1 ) inv(b1_n.Bth1.9, b1 )#5 and2(w0.Bth1.9, b1_n.Bth1.9, GND )#5 and2(w1.Bth1.9, b1, a8 )#5 or2(PP_1_9, w0.Bth1.9, w1.Bth1.9 )#5 // end mux2x1 Bth1.9 end netlist // mux2x1 Bth1.10( PP_1_10, GND, a9, b1 ) inv(b1_n.Bth1.10, b1 )#5 and2(w0.Bth1.10, b1_n.Bth1.10, GND )#5 and2(w1.Bth1.10, b1, a9 )#5 or2(PP_1_10, w0.Bth1.10, w1.Bth1.10 )#5 // end mux2x1 Bth1.10 end netlist // mux2x1 Bth1.11( PP_1_11, GND, a10, b1 ) inv(b1_n.Bth1.11, b1 )#5 and2(w0.Bth1.11, b1_n.Bth1.11, GND )#5 and2(w1.Bth1.11, b1, a10 )#5 or2(PP_1_11, w0.Bth1.11, w1.Bth1.11 )#5 // end mux2x1 Bth1.11 end netlist // mux2x1 Bth1.12( PP_1_12, GND, a11, b1 ) inv(b1_n.Bth1.12, b1 )#5 and2(w0.Bth1.12, b1_n.Bth1.12, GND )#5 and2(w1.Bth1.12, b1, a11 )#5 or2(PP_1_12, w0.Bth1.12, w1.Bth1.12 )#5 // end mux2x1 Bth1.12 end netlist // mux2x1 Bth1.13( PP_1_13, GND, GND, b1 ) inv(b1_n.Bth1.13, b1 )#5 and2(w0.Bth1.13, b1_n.Bth1.13, GND )#5 and2(w1.Bth1.13, b1, GND )#5 or2(PP_1_13, w0.Bth1.13, w1.Bth1.13 )#5 // end mux2x1 Bth1.13 end netlist // mux2x1 Bth1.14( PP_1_14, GND, GND, b1 ) inv(b1_n.Bth1.14, b1 )#5 and2(w0.Bth1.14, b1_n.Bth1.14, GND )#5 and2(w1.Bth1.14, b1, GND )#5 or2(PP_1_14, w0.Bth1.14, w1.Bth1.14 )#5 // end mux2x1 Bth1.14 end netlist // mux2x1 Bth1.15( PP_1_15, GND, GND, b1 ) inv(b1_n.Bth1.15, b1 )#5 and2(w0.Bth1.15, b1_n.Bth1.15, GND )#5 and2(w1.Bth1.15, b1, GND )#5 or2(PP_1_15, w0.Bth1.15, w1.Bth1.15 )#5 // end mux2x1 Bth1.15 end netlist // mux2x1 Bth1.16( PP_1_16, GND, GND, b1 ) inv(b1_n.Bth1.16, b1 )#5 and2(w0.Bth1.16, b1_n.Bth1.16, GND )#5 and2(w1.Bth1.16, b1, GND )#5 or2(PP_1_16, w0.Bth1.16, w1.Bth1.16 )#5 // end mux2x1 Bth1.16 end netlist // mux2x1 Bth1.17( PP_1_17, GND, GND, b1 ) inv(b1_n.Bth1.17, b1 )#5 and2(w0.Bth1.17, b1_n.Bth1.17, GND )#5 and2(w1.Bth1.17, b1, GND )#5 or2(PP_1_17, w0.Bth1.17, w1.Bth1.17 )#5 // end mux2x1 Bth1.17 end netlist // mux2x1 Bth1.18( PP_1_18, GND, GND, b1 ) inv(b1_n.Bth1.18, b1 )#5 and2(w0.Bth1.18, b1_n.Bth1.18, GND )#5 and2(w1.Bth1.18, b1, GND )#5 or2(PP_1_18, w0.Bth1.18, w1.Bth1.18 )#5 // end mux2x1 Bth1.18 end netlist // mux2x1 Bth1.19( PP_1_19, GND, GND, b1 ) inv(b1_n.Bth1.19, b1 )#5 and2(w0.Bth1.19, b1_n.Bth1.19, GND )#5 and2(w1.Bth1.19, b1, GND )#5 or2(PP_1_19, w0.Bth1.19, w1.Bth1.19 )#5 // end mux2x1 Bth1.19 end netlist // mux2x1 Bth1.20( PP_1_20, GND, GND, b1 ) inv(b1_n.Bth1.20, b1 )#5 and2(w0.Bth1.20, b1_n.Bth1.20, GND )#5 and2(w1.Bth1.20, b1, GND )#5 or2(PP_1_20, w0.Bth1.20, w1.Bth1.20 )#5 // end mux2x1 Bth1.20 end netlist // mux2x1 Bth1.21( PP_1_21, GND, GND, b1 ) inv(b1_n.Bth1.21, b1 )#5 and2(w0.Bth1.21, b1_n.Bth1.21, GND )#5 and2(w1.Bth1.21, b1, GND )#5 or2(PP_1_21, w0.Bth1.21, w1.Bth1.21 )#5 // end mux2x1 Bth1.21 end netlist // mux2x1 Bth1.22( PP_1_22, GND, GND, b1 ) inv(b1_n.Bth1.22, b1 )#5 and2(w0.Bth1.22, b1_n.Bth1.22, GND )#5 and2(w1.Bth1.22, b1, GND )#5 or2(PP_1_22, w0.Bth1.22, w1.Bth1.22 )#5 // end mux2x1 Bth1.22 end netlist // mux2x1 Bth1.23( PP_1_23, GND, GND, b1 ) inv(b1_n.Bth1.23, b1 )#5 and2(w0.Bth1.23, b1_n.Bth1.23, GND )#5 and2(w1.Bth1.23, b1, GND )#5 or2(PP_1_23, w0.Bth1.23, w1.Bth1.23 )#5 // end mux2x1 Bth1.23 end netlist // mux2x1 Bth2.0( PP_2_0, GND, GND, b2 ) inv(b2_n.Bth2.0, b2 )#5 and2(w0.Bth2.0, b2_n.Bth2.0, GND )#5 and2(w1.Bth2.0, b2, GND )#5 or2(PP_2_0, w0.Bth2.0, w1.Bth2.0 )#5 // end mux2x1 Bth2.0 end netlist // mux2x1 Bth2.1( PP_2_1, GND, GND, b2 ) inv(b2_n.Bth2.1, b2 )#5 and2(w0.Bth2.1, b2_n.Bth2.1, GND )#5 and2(w1.Bth2.1, b2, GND )#5 or2(PP_2_1, w0.Bth2.1, w1.Bth2.1 )#5 // end mux2x1 Bth2.1 end netlist // mux2x1 Bth2.2( PP_2_2, GND, a0, b2 ) inv(b2_n.Bth2.2, b2 )#5 and2(w0.Bth2.2, b2_n.Bth2.2, GND )#5 and2(w1.Bth2.2, b2, a0 )#5 or2(PP_2_2, w0.Bth2.2, w1.Bth2.2 )#5 // end mux2x1 Bth2.2 end netlist // mux2x1 Bth2.3( PP_2_3, GND, a1, b2 ) inv(b2_n.Bth2.3, b2 )#5 and2(w0.Bth2.3, b2_n.Bth2.3, GND )#5 and2(w1.Bth2.3, b2, a1 )#5 or2(PP_2_3, w0.Bth2.3, w1.Bth2.3 )#5 // end mux2x1 Bth2.3 end netlist // mux2x1 Bth2.4( PP_2_4, GND, a2, b2 ) inv(b2_n.Bth2.4, b2 )#5 and2(w0.Bth2.4, b2_n.Bth2.4, GND )#5 and2(w1.Bth2.4, b2, a2 )#5 or2(PP_2_4, w0.Bth2.4, w1.Bth2.4 )#5 // end mux2x1 Bth2.4 end netlist // mux2x1 Bth2.5( PP_2_5, GND, a3, b2 ) inv(b2_n.Bth2.5, b2 )#5 and2(w0.Bth2.5, b2_n.Bth2.5, GND )#5 and2(w1.Bth2.5, b2, a3 )#5 or2(PP_2_5, w0.Bth2.5, w1.Bth2.5 )#5 // end mux2x1 Bth2.5 end netlist // mux2x1 Bth2.6( PP_2_6, GND, a4, b2 ) inv(b2_n.Bth2.6, b2 )#5 and2(w0.Bth2.6, b2_n.Bth2.6, GND )#5 and2(w1.Bth2.6, b2, a4 )#5 or2(PP_2_6, w0.Bth2.6, w1.Bth2.6 )#5 // end mux2x1 Bth2.6 end netlist // mux2x1 Bth2.7( PP_2_7, GND, a5, b2 ) inv(b2_n.Bth2.7, b2 )#5 and2(w0.Bth2.7, b2_n.Bth2.7, GND )#5 and2(w1.Bth2.7, b2, a5 )#5 or2(PP_2_7, w0.Bth2.7, w1.Bth2.7 )#5 // end mux2x1 Bth2.7 end netlist // mux2x1 Bth2.8( PP_2_8, GND, a6, b2 ) inv(b2_n.Bth2.8, b2 )#5 and2(w0.Bth2.8, b2_n.Bth2.8, GND )#5 and2(w1.Bth2.8, b2, a6 )#5 or2(PP_2_8, w0.Bth2.8, w1.Bth2.8 )#5 // end mux2x1 Bth2.8 end netlist // mux2x1 Bth2.9( PP_2_9, GND, a7, b2 ) inv(b2_n.Bth2.9, b2 )#5 and2(w0.Bth2.9, b2_n.Bth2.9, GND )#5 and2(w1.Bth2.9, b2, a7 )#5 or2(PP_2_9, w0.Bth2.9, w1.Bth2.9 )#5 // end mux2x1 Bth2.9 end netlist // mux2x1 Bth2.10( PP_2_10, GND, a8, b2 ) inv(b2_n.Bth2.10, b2 )#5 and2(w0.Bth2.10, b2_n.Bth2.10, GND )#5 and2(w1.Bth2.10, b2, a8 )#5 or2(PP_2_10, w0.Bth2.10, w1.Bth2.10 )#5 // end mux2x1 Bth2.10 end netlist // mux2x1 Bth2.11( PP_2_11, GND, a9, b2 ) inv(b2_n.Bth2.11, b2 )#5 and2(w0.Bth2.11, b2_n.Bth2.11, GND )#5 and2(w1.Bth2.11, b2, a9 )#5 or2(PP_2_11, w0.Bth2.11, w1.Bth2.11 )#5 // end mux2x1 Bth2.11 end netlist // mux2x1 Bth2.12( PP_2_12, GND, a10, b2 ) inv(b2_n.Bth2.12, b2 )#5 and2(w0.Bth2.12, b2_n.Bth2.12, GND )#5 and2(w1.Bth2.12, b2, a10 )#5 or2(PP_2_12, w0.Bth2.12, w1.Bth2.12 )#5 // end mux2x1 Bth2.12 end netlist // mux2x1 Bth2.13( PP_2_13, GND, a11, b2 ) inv(b2_n.Bth2.13, b2 )#5 and2(w0.Bth2.13, b2_n.Bth2.13, GND )#5 and2(w1.Bth2.13, b2, a11 )#5 or2(PP_2_13, w0.Bth2.13, w1.Bth2.13 )#5 // end mux2x1 Bth2.13 end netlist // mux2x1 Bth2.14( PP_2_14, GND, GND, b2 ) inv(b2_n.Bth2.14, b2 )#5 and2(w0.Bth2.14, b2_n.Bth2.14, GND )#5 and2(w1.Bth2.14, b2, GND )#5 or2(PP_2_14, w0.Bth2.14, w1.Bth2.14 )#5 // end mux2x1 Bth2.14 end netlist // mux2x1 Bth2.15( PP_2_15, GND, GND, b2 ) inv(b2_n.Bth2.15, b2 )#5 and2(w0.Bth2.15, b2_n.Bth2.15, GND )#5 and2(w1.Bth2.15, b2, GND )#5 or2(PP_2_15, w0.Bth2.15, w1.Bth2.15 )#5 // end mux2x1 Bth2.15 end netlist // mux2x1 Bth2.16( PP_2_16, GND, GND, b2 ) inv(b2_n.Bth2.16, b2 )#5 and2(w0.Bth2.16, b2_n.Bth2.16, GND )#5 and2(w1.Bth2.16, b2, GND )#5 or2(PP_2_16, w0.Bth2.16, w1.Bth2.16 )#5 // end mux2x1 Bth2.16 end netlist // mux2x1 Bth2.17( PP_2_17, GND, GND, b2 ) inv(b2_n.Bth2.17, b2 )#5 and2(w0.Bth2.17, b2_n.Bth2.17, GND )#5 and2(w1.Bth2.17, b2, GND )#5 or2(PP_2_17, w0.Bth2.17, w1.Bth2.17 )#5 // end mux2x1 Bth2.17 end netlist // mux2x1 Bth2.18( PP_2_18, GND, GND, b2 ) inv(b2_n.Bth2.18, b2 )#5 and2(w0.Bth2.18, b2_n.Bth2.18, GND )#5 and2(w1.Bth2.18, b2, GND )#5 or2(PP_2_18, w0.Bth2.18, w1.Bth2.18 )#5 // end mux2x1 Bth2.18 end netlist // mux2x1 Bth2.19( PP_2_19, GND, GND, b2 ) inv(b2_n.Bth2.19, b2 )#5 and2(w0.Bth2.19, b2_n.Bth2.19, GND )#5 and2(w1.Bth2.19, b2, GND )#5 or2(PP_2_19, w0.Bth2.19, w1.Bth2.19 )#5 // end mux2x1 Bth2.19 end netlist // mux2x1 Bth2.20( PP_2_20, GND, GND, b2 ) inv(b2_n.Bth2.20, b2 )#5 and2(w0.Bth2.20, b2_n.Bth2.20, GND )#5 and2(w1.Bth2.20, b2, GND )#5 or2(PP_2_20, w0.Bth2.20, w1.Bth2.20 )#5 // end mux2x1 Bth2.20 end netlist // mux2x1 Bth2.21( PP_2_21, GND, GND, b2 ) inv(b2_n.Bth2.21, b2 )#5 and2(w0.Bth2.21, b2_n.Bth2.21, GND )#5 and2(w1.Bth2.21, b2, GND )#5 or2(PP_2_21, w0.Bth2.21, w1.Bth2.21 )#5 // end mux2x1 Bth2.21 end netlist // mux2x1 Bth2.22( PP_2_22, GND, GND, b2 ) inv(b2_n.Bth2.22, b2 )#5 and2(w0.Bth2.22, b2_n.Bth2.22, GND )#5 and2(w1.Bth2.22, b2, GND )#5 or2(PP_2_22, w0.Bth2.22, w1.Bth2.22 )#5 // end mux2x1 Bth2.22 end netlist // mux2x1 Bth2.23( PP_2_23, GND, GND, b2 ) inv(b2_n.Bth2.23, b2 )#5 and2(w0.Bth2.23, b2_n.Bth2.23, GND )#5 and2(w1.Bth2.23, b2, GND )#5 or2(PP_2_23, w0.Bth2.23, w1.Bth2.23 )#5 // end mux2x1 Bth2.23 end netlist // mux2x1 Bth3.0( PP_3_0, GND, GND, b3 ) inv(b3_n.Bth3.0, b3 )#5 and2(w0.Bth3.0, b3_n.Bth3.0, GND )#5 and2(w1.Bth3.0, b3, GND )#5 or2(PP_3_0, w0.Bth3.0, w1.Bth3.0 )#5 // end mux2x1 Bth3.0 end netlist // mux2x1 Bth3.1( PP_3_1, GND, GND, b3 ) inv(b3_n.Bth3.1, b3 )#5 and2(w0.Bth3.1, b3_n.Bth3.1, GND )#5 and2(w1.Bth3.1, b3, GND )#5 or2(PP_3_1, w0.Bth3.1, w1.Bth3.1 )#5 // end mux2x1 Bth3.1 end netlist // mux2x1 Bth3.2( PP_3_2, GND, GND, b3 ) inv(b3_n.Bth3.2, b3 )#5 and2(w0.Bth3.2, b3_n.Bth3.2, GND )#5 and2(w1.Bth3.2, b3, GND )#5 or2(PP_3_2, w0.Bth3.2, w1.Bth3.2 )#5 // end mux2x1 Bth3.2 end netlist // mux2x1 Bth3.3( PP_3_3, GND, a0, b3 ) inv(b3_n.Bth3.3, b3 )#5 and2(w0.Bth3.3, b3_n.Bth3.3, GND )#5 and2(w1.Bth3.3, b3, a0 )#5 or2(PP_3_3, w0.Bth3.3, w1.Bth3.3 )#5 // end mux2x1 Bth3.3 end netlist // mux2x1 Bth3.4( PP_3_4, GND, a1, b3 ) inv(b3_n.Bth3.4, b3 )#5 and2(w0.Bth3.4, b3_n.Bth3.4, GND )#5 and2(w1.Bth3.4, b3, a1 )#5 or2(PP_3_4, w0.Bth3.4, w1.Bth3.4 )#5 // end mux2x1 Bth3.4 end netlist // mux2x1 Bth3.5( PP_3_5, GND, a2, b3 ) inv(b3_n.Bth3.5, b3 )#5 and2(w0.Bth3.5, b3_n.Bth3.5, GND )#5 and2(w1.Bth3.5, b3, a2 )#5 or2(PP_3_5, w0.Bth3.5, w1.Bth3.5 )#5 // end mux2x1 Bth3.5 end netlist // mux2x1 Bth3.6( PP_3_6, GND, a3, b3 ) inv(b3_n.Bth3.6, b3 )#5 and2(w0.Bth3.6, b3_n.Bth3.6, GND )#5 and2(w1.Bth3.6, b3, a3 )#5 or2(PP_3_6, w0.Bth3.6, w1.Bth3.6 )#5 // end mux2x1 Bth3.6 end netlist // mux2x1 Bth3.7( PP_3_7, GND, a4, b3 ) inv(b3_n.Bth3.7, b3 )#5 and2(w0.Bth3.7, b3_n.Bth3.7, GND )#5 and2(w1.Bth3.7, b3, a4 )#5 or2(PP_3_7, w0.Bth3.7, w1.Bth3.7 )#5 // end mux2x1 Bth3.7 end netlist // mux2x1 Bth3.8( PP_3_8, GND, a5, b3 ) inv(b3_n.Bth3.8, b3 )#5 and2(w0.Bth3.8, b3_n.Bth3.8, GND )#5 and2(w1.Bth3.8, b3, a5 )#5 or2(PP_3_8, w0.Bth3.8, w1.Bth3.8 )#5 // end mux2x1 Bth3.8 end netlist // mux2x1 Bth3.9( PP_3_9, GND, a6, b3 ) inv(b3_n.Bth3.9, b3 )#5 and2(w0.Bth3.9, b3_n.Bth3.9, GND )#5 and2(w1.Bth3.9, b3, a6 )#5 or2(PP_3_9, w0.Bth3.9, w1.Bth3.9 )#5 // end mux2x1 Bth3.9 end netlist // mux2x1 Bth3.10( PP_3_10, GND, a7, b3 ) inv(b3_n.Bth3.10, b3 )#5 and2(w0.Bth3.10, b3_n.Bth3.10, GND )#5 and2(w1.Bth3.10, b3, a7 )#5 or2(PP_3_10, w0.Bth3.10, w1.Bth3.10 )#5 // end mux2x1 Bth3.10 end netlist // mux2x1 Bth3.11( PP_3_11, GND, a8, b3 ) inv(b3_n.Bth3.11, b3 )#5 and2(w0.Bth3.11, b3_n.Bth3.11, GND )#5 and2(w1.Bth3.11, b3, a8 )#5 or2(PP_3_11, w0.Bth3.11, w1.Bth3.11 )#5 // end mux2x1 Bth3.11 end netlist // mux2x1 Bth3.12( PP_3_12, GND, a9, b3 ) inv(b3_n.Bth3.12, b3 )#5 and2(w0.Bth3.12, b3_n.Bth3.12, GND )#5 and2(w1.Bth3.12, b3, a9 )#5 or2(PP_3_12, w0.Bth3.12, w1.Bth3.12 )#5 // end mux2x1 Bth3.12 end netlist // mux2x1 Bth3.13( PP_3_13, GND, a10, b3 ) inv(b3_n.Bth3.13, b3 )#5 and2(w0.Bth3.13, b3_n.Bth3.13, GND )#5 and2(w1.Bth3.13, b3, a10 )#5 or2(PP_3_13, w0.Bth3.13, w1.Bth3.13 )#5 // end mux2x1 Bth3.13 end netlist // mux2x1 Bth3.14( PP_3_14, GND, a11, b3 ) inv(b3_n.Bth3.14, b3 )#5 and2(w0.Bth3.14, b3_n.Bth3.14, GND )#5 and2(w1.Bth3.14, b3, a11 )#5 or2(PP_3_14, w0.Bth3.14, w1.Bth3.14 )#5 // end mux2x1 Bth3.14 end netlist // mux2x1 Bth3.15( PP_3_15, GND, GND, b3 ) inv(b3_n.Bth3.15, b3 )#5 and2(w0.Bth3.15, b3_n.Bth3.15, GND )#5 and2(w1.Bth3.15, b3, GND )#5 or2(PP_3_15, w0.Bth3.15, w1.Bth3.15 )#5 // end mux2x1 Bth3.15 end netlist // mux2x1 Bth3.16( PP_3_16, GND, GND, b3 ) inv(b3_n.Bth3.16, b3 )#5 and2(w0.Bth3.16, b3_n.Bth3.16, GND )#5 and2(w1.Bth3.16, b3, GND )#5 or2(PP_3_16, w0.Bth3.16, w1.Bth3.16 )#5 // end mux2x1 Bth3.16 end netlist // mux2x1 Bth3.17( PP_3_17, GND, GND, b3 ) inv(b3_n.Bth3.17, b3 )#5 and2(w0.Bth3.17, b3_n.Bth3.17, GND )#5 and2(w1.Bth3.17, b3, GND )#5 or2(PP_3_17, w0.Bth3.17, w1.Bth3.17 )#5 // end mux2x1 Bth3.17 end netlist // mux2x1 Bth3.18( PP_3_18, GND, GND, b3 ) inv(b3_n.Bth3.18, b3 )#5 and2(w0.Bth3.18, b3_n.Bth3.18, GND )#5 and2(w1.Bth3.18, b3, GND )#5 or2(PP_3_18, w0.Bth3.18, w1.Bth3.18 )#5 // end mux2x1 Bth3.18 end netlist // mux2x1 Bth3.19( PP_3_19, GND, GND, b3 ) inv(b3_n.Bth3.19, b3 )#5 and2(w0.Bth3.19, b3_n.Bth3.19, GND )#5 and2(w1.Bth3.19, b3, GND )#5 or2(PP_3_19, w0.Bth3.19, w1.Bth3.19 )#5 // end mux2x1 Bth3.19 end netlist // mux2x1 Bth3.20( PP_3_20, GND, GND, b3 ) inv(b3_n.Bth3.20, b3 )#5 and2(w0.Bth3.20, b3_n.Bth3.20, GND )#5 and2(w1.Bth3.20, b3, GND )#5 or2(PP_3_20, w0.Bth3.20, w1.Bth3.20 )#5 // end mux2x1 Bth3.20 end netlist // mux2x1 Bth3.21( PP_3_21, GND, GND, b3 ) inv(b3_n.Bth3.21, b3 )#5 and2(w0.Bth3.21, b3_n.Bth3.21, GND )#5 and2(w1.Bth3.21, b3, GND )#5 or2(PP_3_21, w0.Bth3.21, w1.Bth3.21 )#5 // end mux2x1 Bth3.21 end netlist // mux2x1 Bth3.22( PP_3_22, GND, GND, b3 ) inv(b3_n.Bth3.22, b3 )#5 and2(w0.Bth3.22, b3_n.Bth3.22, GND )#5 and2(w1.Bth3.22, b3, GND )#5 or2(PP_3_22, w0.Bth3.22, w1.Bth3.22 )#5 // end mux2x1 Bth3.22 end netlist // mux2x1 Bth3.23( PP_3_23, GND, GND, b3 ) inv(b3_n.Bth3.23, b3 )#5 and2(w0.Bth3.23, b3_n.Bth3.23, GND )#5 and2(w1.Bth3.23, b3, GND )#5 or2(PP_3_23, w0.Bth3.23, w1.Bth3.23 )#5 // end mux2x1 Bth3.23 end netlist // mux2x1 Bth4.0( PP_4_0, GND, GND, b4 ) inv(b4_n.Bth4.0, b4 )#5 and2(w0.Bth4.0, b4_n.Bth4.0, GND )#5 and2(w1.Bth4.0, b4, GND )#5 or2(PP_4_0, w0.Bth4.0, w1.Bth4.0 )#5 // end mux2x1 Bth4.0 end netlist // mux2x1 Bth4.1( PP_4_1, GND, GND, b4 ) inv(b4_n.Bth4.1, b4 )#5 and2(w0.Bth4.1, b4_n.Bth4.1, GND )#5 and2(w1.Bth4.1, b4, GND )#5 or2(PP_4_1, w0.Bth4.1, w1.Bth4.1 )#5 // end mux2x1 Bth4.1 end netlist // mux2x1 Bth4.2( PP_4_2, GND, GND, b4 ) inv(b4_n.Bth4.2, b4 )#5 and2(w0.Bth4.2, b4_n.Bth4.2, GND )#5 and2(w1.Bth4.2, b4, GND )#5 or2(PP_4_2, w0.Bth4.2, w1.Bth4.2 )#5 // end mux2x1 Bth4.2 end netlist // mux2x1 Bth4.3( PP_4_3, GND, GND, b4 ) inv(b4_n.Bth4.3, b4 )#5 and2(w0.Bth4.3, b4_n.Bth4.3, GND )#5 and2(w1.Bth4.3, b4, GND )#5 or2(PP_4_3, w0.Bth4.3, w1.Bth4.3 )#5 // end mux2x1 Bth4.3 end netlist // mux2x1 Bth4.4( PP_4_4, GND, a0, b4 ) inv(b4_n.Bth4.4, b4 )#5 and2(w0.Bth4.4, b4_n.Bth4.4, GND )#5 and2(w1.Bth4.4, b4, a0 )#5 or2(PP_4_4, w0.Bth4.4, w1.Bth4.4 )#5 // end mux2x1 Bth4.4 end netlist // mux2x1 Bth4.5( PP_4_5, GND, a1, b4 ) inv(b4_n.Bth4.5, b4 )#5 and2(w0.Bth4.5, b4_n.Bth4.5, GND )#5 and2(w1.Bth4.5, b4, a1 )#5 or2(PP_4_5, w0.Bth4.5, w1.Bth4.5 )#5 // end mux2x1 Bth4.5 end netlist // mux2x1 Bth4.6( PP_4_6, GND, a2, b4 ) inv(b4_n.Bth4.6, b4 )#5 and2(w0.Bth4.6, b4_n.Bth4.6, GND )#5 and2(w1.Bth4.6, b4, a2 )#5 or2(PP_4_6, w0.Bth4.6, w1.Bth4.6 )#5 // end mux2x1 Bth4.6 end netlist // mux2x1 Bth4.7( PP_4_7, GND, a3, b4 ) inv(b4_n.Bth4.7, b4 )#5 and2(w0.Bth4.7, b4_n.Bth4.7, GND )#5 and2(w1.Bth4.7, b4, a3 )#5 or2(PP_4_7, w0.Bth4.7, w1.Bth4.7 )#5 // end mux2x1 Bth4.7 end netlist // mux2x1 Bth4.8( PP_4_8, GND, a4, b4 ) inv(b4_n.Bth4.8, b4 )#5 and2(w0.Bth4.8, b4_n.Bth4.8, GND )#5 and2(w1.Bth4.8, b4, a4 )#5 or2(PP_4_8, w0.Bth4.8, w1.Bth4.8 )#5 // end mux2x1 Bth4.8 end netlist // mux2x1 Bth4.9( PP_4_9, GND, a5, b4 ) inv(b4_n.Bth4.9, b4 )#5 and2(w0.Bth4.9, b4_n.Bth4.9, GND )#5 and2(w1.Bth4.9, b4, a5 )#5 or2(PP_4_9, w0.Bth4.9, w1.Bth4.9 )#5 // end mux2x1 Bth4.9 end netlist // mux2x1 Bth4.10( PP_4_10, GND, a6, b4 ) inv(b4_n.Bth4.10, b4 )#5 and2(w0.Bth4.10, b4_n.Bth4.10, GND )#5 and2(w1.Bth4.10, b4, a6 )#5 or2(PP_4_10, w0.Bth4.10, w1.Bth4.10 )#5 // end mux2x1 Bth4.10 end netlist // mux2x1 Bth4.11( PP_4_11, GND, a7, b4 ) inv(b4_n.Bth4.11, b4 )#5 and2(w0.Bth4.11, b4_n.Bth4.11, GND )#5 and2(w1.Bth4.11, b4, a7 )#5 or2(PP_4_11, w0.Bth4.11, w1.Bth4.11 )#5 // end mux2x1 Bth4.11 end netlist // mux2x1 Bth4.12( PP_4_12, GND, a8, b4 ) inv(b4_n.Bth4.12, b4 )#5 and2(w0.Bth4.12, b4_n.Bth4.12, GND )#5 and2(w1.Bth4.12, b4, a8 )#5 or2(PP_4_12, w0.Bth4.12, w1.Bth4.12 )#5 // end mux2x1 Bth4.12 end netlist // mux2x1 Bth4.13( PP_4_13, GND, a9, b4 ) inv(b4_n.Bth4.13, b4 )#5 and2(w0.Bth4.13, b4_n.Bth4.13, GND )#5 and2(w1.Bth4.13, b4, a9 )#5 or2(PP_4_13, w0.Bth4.13, w1.Bth4.13 )#5 // end mux2x1 Bth4.13 end netlist // mux2x1 Bth4.14( PP_4_14, GND, a10, b4 ) inv(b4_n.Bth4.14, b4 )#5 and2(w0.Bth4.14, b4_n.Bth4.14, GND )#5 and2(w1.Bth4.14, b4, a10 )#5 or2(PP_4_14, w0.Bth4.14, w1.Bth4.14 )#5 // end mux2x1 Bth4.14 end netlist // mux2x1 Bth4.15( PP_4_15, GND, a11, b4 ) inv(b4_n.Bth4.15, b4 )#5 and2(w0.Bth4.15, b4_n.Bth4.15, GND )#5 and2(w1.Bth4.15, b4, a11 )#5 or2(PP_4_15, w0.Bth4.15, w1.Bth4.15 )#5 // end mux2x1 Bth4.15 end netlist // mux2x1 Bth4.16( PP_4_16, GND, GND, b4 ) inv(b4_n.Bth4.16, b4 )#5 and2(w0.Bth4.16, b4_n.Bth4.16, GND )#5 and2(w1.Bth4.16, b4, GND )#5 or2(PP_4_16, w0.Bth4.16, w1.Bth4.16 )#5 // end mux2x1 Bth4.16 end netlist // mux2x1 Bth4.17( PP_4_17, GND, GND, b4 ) inv(b4_n.Bth4.17, b4 )#5 and2(w0.Bth4.17, b4_n.Bth4.17, GND )#5 and2(w1.Bth4.17, b4, GND )#5 or2(PP_4_17, w0.Bth4.17, w1.Bth4.17 )#5 // end mux2x1 Bth4.17 end netlist // mux2x1 Bth4.18( PP_4_18, GND, GND, b4 ) inv(b4_n.Bth4.18, b4 )#5 and2(w0.Bth4.18, b4_n.Bth4.18, GND )#5 and2(w1.Bth4.18, b4, GND )#5 or2(PP_4_18, w0.Bth4.18, w1.Bth4.18 )#5 // end mux2x1 Bth4.18 end netlist // mux2x1 Bth4.19( PP_4_19, GND, GND, b4 ) inv(b4_n.Bth4.19, b4 )#5 and2(w0.Bth4.19, b4_n.Bth4.19, GND )#5 and2(w1.Bth4.19, b4, GND )#5 or2(PP_4_19, w0.Bth4.19, w1.Bth4.19 )#5 // end mux2x1 Bth4.19 end netlist // mux2x1 Bth4.20( PP_4_20, GND, GND, b4 ) inv(b4_n.Bth4.20, b4 )#5 and2(w0.Bth4.20, b4_n.Bth4.20, GND )#5 and2(w1.Bth4.20, b4, GND )#5 or2(PP_4_20, w0.Bth4.20, w1.Bth4.20 )#5 // end mux2x1 Bth4.20 end netlist // mux2x1 Bth4.21( PP_4_21, GND, GND, b4 ) inv(b4_n.Bth4.21, b4 )#5 and2(w0.Bth4.21, b4_n.Bth4.21, GND )#5 and2(w1.Bth4.21, b4, GND )#5 or2(PP_4_21, w0.Bth4.21, w1.Bth4.21 )#5 // end mux2x1 Bth4.21 end netlist // mux2x1 Bth4.22( PP_4_22, GND, GND, b4 ) inv(b4_n.Bth4.22, b4 )#5 and2(w0.Bth4.22, b4_n.Bth4.22, GND )#5 and2(w1.Bth4.22, b4, GND )#5 or2(PP_4_22, w0.Bth4.22, w1.Bth4.22 )#5 // end mux2x1 Bth4.22 end netlist // mux2x1 Bth4.23( PP_4_23, GND, GND, b4 ) inv(b4_n.Bth4.23, b4 )#5 and2(w0.Bth4.23, b4_n.Bth4.23, GND )#5 and2(w1.Bth4.23, b4, GND )#5 or2(PP_4_23, w0.Bth4.23, w1.Bth4.23 )#5 // end mux2x1 Bth4.23 end netlist // mux2x1 Bth5.0( PP_5_0, GND, GND, b5 ) inv(b5_n.Bth5.0, b5 )#5 and2(w0.Bth5.0, b5_n.Bth5.0, GND )#5 and2(w1.Bth5.0, b5, GND )#5 or2(PP_5_0, w0.Bth5.0, w1.Bth5.0 )#5 // end mux2x1 Bth5.0 end netlist // mux2x1 Bth5.1( PP_5_1, GND, GND, b5 ) inv(b5_n.Bth5.1, b5 )#5 and2(w0.Bth5.1, b5_n.Bth5.1, GND )#5 and2(w1.Bth5.1, b5, GND )#5 or2(PP_5_1, w0.Bth5.1, w1.Bth5.1 )#5 // end mux2x1 Bth5.1 end netlist // mux2x1 Bth5.2( PP_5_2, GND, GND, b5 ) inv(b5_n.Bth5.2, b5 )#5 and2(w0.Bth5.2, b5_n.Bth5.2, GND )#5 and2(w1.Bth5.2, b5, GND )#5 or2(PP_5_2, w0.Bth5.2, w1.Bth5.2 )#5 // end mux2x1 Bth5.2 end netlist // mux2x1 Bth5.3( PP_5_3, GND, GND, b5 ) inv(b5_n.Bth5.3, b5 )#5 and2(w0.Bth5.3, b5_n.Bth5.3, GND )#5 and2(w1.Bth5.3, b5, GND )#5 or2(PP_5_3, w0.Bth5.3, w1.Bth5.3 )#5 // end mux2x1 Bth5.3 end netlist // mux2x1 Bth5.4( PP_5_4, GND, GND, b5 ) inv(b5_n.Bth5.4, b5 )#5 and2(w0.Bth5.4, b5_n.Bth5.4, GND )#5 and2(w1.Bth5.4, b5, GND )#5 or2(PP_5_4, w0.Bth5.4, w1.Bth5.4 )#5 // end mux2x1 Bth5.4 end netlist // mux2x1 Bth5.5( PP_5_5, GND, a0, b5 ) inv(b5_n.Bth5.5, b5 )#5 and2(w0.Bth5.5, b5_n.Bth5.5, GND )#5 and2(w1.Bth5.5, b5, a0 )#5 or2(PP_5_5, w0.Bth5.5, w1.Bth5.5 )#5 // end mux2x1 Bth5.5 end netlist // mux2x1 Bth5.6( PP_5_6, GND, a1, b5 ) inv(b5_n.Bth5.6, b5 )#5 and2(w0.Bth5.6, b5_n.Bth5.6, GND )#5 and2(w1.Bth5.6, b5, a1 )#5 or2(PP_5_6, w0.Bth5.6, w1.Bth5.6 )#5 // end mux2x1 Bth5.6 end netlist // mux2x1 Bth5.7( PP_5_7, GND, a2, b5 ) inv(b5_n.Bth5.7, b5 )#5 and2(w0.Bth5.7, b5_n.Bth5.7, GND )#5 and2(w1.Bth5.7, b5, a2 )#5 or2(PP_5_7, w0.Bth5.7, w1.Bth5.7 )#5 // end mux2x1 Bth5.7 end netlist // mux2x1 Bth5.8( PP_5_8, GND, a3, b5 ) inv(b5_n.Bth5.8, b5 )#5 and2(w0.Bth5.8, b5_n.Bth5.8, GND )#5 and2(w1.Bth5.8, b5, a3 )#5 or2(PP_5_8, w0.Bth5.8, w1.Bth5.8 )#5 // end mux2x1 Bth5.8 end netlist // mux2x1 Bth5.9( PP_5_9, GND, a4, b5 ) inv(b5_n.Bth5.9, b5 )#5 and2(w0.Bth5.9, b5_n.Bth5.9, GND )#5 and2(w1.Bth5.9, b5, a4 )#5 or2(PP_5_9, w0.Bth5.9, w1.Bth5.9 )#5 // end mux2x1 Bth5.9 end netlist // mux2x1 Bth5.10( PP_5_10, GND, a5, b5 ) inv(b5_n.Bth5.10, b5 )#5 and2(w0.Bth5.10, b5_n.Bth5.10, GND )#5 and2(w1.Bth5.10, b5, a5 )#5 or2(PP_5_10, w0.Bth5.10, w1.Bth5.10 )#5 // end mux2x1 Bth5.10 end netlist // mux2x1 Bth5.11( PP_5_11, GND, a6, b5 ) inv(b5_n.Bth5.11, b5 )#5 and2(w0.Bth5.11, b5_n.Bth5.11, GND )#5 and2(w1.Bth5.11, b5, a6 )#5 or2(PP_5_11, w0.Bth5.11, w1.Bth5.11 )#5 // end mux2x1 Bth5.11 end netlist // mux2x1 Bth5.12( PP_5_12, GND, a7, b5 ) inv(b5_n.Bth5.12, b5 )#5 and2(w0.Bth5.12, b5_n.Bth5.12, GND )#5 and2(w1.Bth5.12, b5, a7 )#5 or2(PP_5_12, w0.Bth5.12, w1.Bth5.12 )#5 // end mux2x1 Bth5.12 end netlist // mux2x1 Bth5.13( PP_5_13, GND, a8, b5 ) inv(b5_n.Bth5.13, b5 )#5 and2(w0.Bth5.13, b5_n.Bth5.13, GND )#5 and2(w1.Bth5.13, b5, a8 )#5 or2(PP_5_13, w0.Bth5.13, w1.Bth5.13 )#5 // end mux2x1 Bth5.13 end netlist // mux2x1 Bth5.14( PP_5_14, GND, a9, b5 ) inv(b5_n.Bth5.14, b5 )#5 and2(w0.Bth5.14, b5_n.Bth5.14, GND )#5 and2(w1.Bth5.14, b5, a9 )#5 or2(PP_5_14, w0.Bth5.14, w1.Bth5.14 )#5 // end mux2x1 Bth5.14 end netlist // mux2x1 Bth5.15( PP_5_15, GND, a10, b5 ) inv(b5_n.Bth5.15, b5 )#5 and2(w0.Bth5.15, b5_n.Bth5.15, GND )#5 and2(w1.Bth5.15, b5, a10 )#5 or2(PP_5_15, w0.Bth5.15, w1.Bth5.15 )#5 // end mux2x1 Bth5.15 end netlist // mux2x1 Bth5.16( PP_5_16, GND, a11, b5 ) inv(b5_n.Bth5.16, b5 )#5 and2(w0.Bth5.16, b5_n.Bth5.16, GND )#5 and2(w1.Bth5.16, b5, a11 )#5 or2(PP_5_16, w0.Bth5.16, w1.Bth5.16 )#5 // end mux2x1 Bth5.16 end netlist // mux2x1 Bth5.17( PP_5_17, GND, GND, b5 ) inv(b5_n.Bth5.17, b5 )#5 and2(w0.Bth5.17, b5_n.Bth5.17, GND )#5 and2(w1.Bth5.17, b5, GND )#5 or2(PP_5_17, w0.Bth5.17, w1.Bth5.17 )#5 // end mux2x1 Bth5.17 end netlist // mux2x1 Bth5.18( PP_5_18, GND, GND, b5 ) inv(b5_n.Bth5.18, b5 )#5 and2(w0.Bth5.18, b5_n.Bth5.18, GND )#5 and2(w1.Bth5.18, b5, GND )#5 or2(PP_5_18, w0.Bth5.18, w1.Bth5.18 )#5 // end mux2x1 Bth5.18 end netlist // mux2x1 Bth5.19( PP_5_19, GND, GND, b5 ) inv(b5_n.Bth5.19, b5 )#5 and2(w0.Bth5.19, b5_n.Bth5.19, GND )#5 and2(w1.Bth5.19, b5, GND )#5 or2(PP_5_19, w0.Bth5.19, w1.Bth5.19 )#5 // end mux2x1 Bth5.19 end netlist // mux2x1 Bth5.20( PP_5_20, GND, GND, b5 ) inv(b5_n.Bth5.20, b5 )#5 and2(w0.Bth5.20, b5_n.Bth5.20, GND )#5 and2(w1.Bth5.20, b5, GND )#5 or2(PP_5_20, w0.Bth5.20, w1.Bth5.20 )#5 // end mux2x1 Bth5.20 end netlist // mux2x1 Bth5.21( PP_5_21, GND, GND, b5 ) inv(b5_n.Bth5.21, b5 )#5 and2(w0.Bth5.21, b5_n.Bth5.21, GND )#5 and2(w1.Bth5.21, b5, GND )#5 or2(PP_5_21, w0.Bth5.21, w1.Bth5.21 )#5 // end mux2x1 Bth5.21 end netlist // mux2x1 Bth5.22( PP_5_22, GND, GND, b5 ) inv(b5_n.Bth5.22, b5 )#5 and2(w0.Bth5.22, b5_n.Bth5.22, GND )#5 and2(w1.Bth5.22, b5, GND )#5 or2(PP_5_22, w0.Bth5.22, w1.Bth5.22 )#5 // end mux2x1 Bth5.22 end netlist // mux2x1 Bth5.23( PP_5_23, GND, GND, b5 ) inv(b5_n.Bth5.23, b5 )#5 and2(w0.Bth5.23, b5_n.Bth5.23, GND )#5 and2(w1.Bth5.23, b5, GND )#5 or2(PP_5_23, w0.Bth5.23, w1.Bth5.23 )#5 // end mux2x1 Bth5.23 end netlist // mux2x1 Bth6.0( PP_6_0, GND, GND, b6 ) inv(b6_n.Bth6.0, b6 )#5 and2(w0.Bth6.0, b6_n.Bth6.0, GND )#5 and2(w1.Bth6.0, b6, GND )#5 or2(PP_6_0, w0.Bth6.0, w1.Bth6.0 )#5 // end mux2x1 Bth6.0 end netlist // mux2x1 Bth6.1( PP_6_1, GND, GND, b6 ) inv(b6_n.Bth6.1, b6 )#5 and2(w0.Bth6.1, b6_n.Bth6.1, GND )#5 and2(w1.Bth6.1, b6, GND )#5 or2(PP_6_1, w0.Bth6.1, w1.Bth6.1 )#5 // end mux2x1 Bth6.1 end netlist // mux2x1 Bth6.2( PP_6_2, GND, GND, b6 ) inv(b6_n.Bth6.2, b6 )#5 and2(w0.Bth6.2, b6_n.Bth6.2, GND )#5 and2(w1.Bth6.2, b6, GND )#5 or2(PP_6_2, w0.Bth6.2, w1.Bth6.2 )#5 // end mux2x1 Bth6.2 end netlist // mux2x1 Bth6.3( PP_6_3, GND, GND, b6 ) inv(b6_n.Bth6.3, b6 )#5 and2(w0.Bth6.3, b6_n.Bth6.3, GND )#5 and2(w1.Bth6.3, b6, GND )#5 or2(PP_6_3, w0.Bth6.3, w1.Bth6.3 )#5 // end mux2x1 Bth6.3 end netlist // mux2x1 Bth6.4( PP_6_4, GND, GND, b6 ) inv(b6_n.Bth6.4, b6 )#5 and2(w0.Bth6.4, b6_n.Bth6.4, GND )#5 and2(w1.Bth6.4, b6, GND )#5 or2(PP_6_4, w0.Bth6.4, w1.Bth6.4 )#5 // end mux2x1 Bth6.4 end netlist // mux2x1 Bth6.5( PP_6_5, GND, GND, b6 ) inv(b6_n.Bth6.5, b6 )#5 and2(w0.Bth6.5, b6_n.Bth6.5, GND )#5 and2(w1.Bth6.5, b6, GND )#5 or2(PP_6_5, w0.Bth6.5, w1.Bth6.5 )#5 // end mux2x1 Bth6.5 end netlist // mux2x1 Bth6.6( PP_6_6, GND, a0, b6 ) inv(b6_n.Bth6.6, b6 )#5 and2(w0.Bth6.6, b6_n.Bth6.6, GND )#5 and2(w1.Bth6.6, b6, a0 )#5 or2(PP_6_6, w0.Bth6.6, w1.Bth6.6 )#5 // end mux2x1 Bth6.6 end netlist // mux2x1 Bth6.7( PP_6_7, GND, a1, b6 ) inv(b6_n.Bth6.7, b6 )#5 and2(w0.Bth6.7, b6_n.Bth6.7, GND )#5 and2(w1.Bth6.7, b6, a1 )#5 or2(PP_6_7, w0.Bth6.7, w1.Bth6.7 )#5 // end mux2x1 Bth6.7 end netlist // mux2x1 Bth6.8( PP_6_8, GND, a2, b6 ) inv(b6_n.Bth6.8, b6 )#5 and2(w0.Bth6.8, b6_n.Bth6.8, GND )#5 and2(w1.Bth6.8, b6, a2 )#5 or2(PP_6_8, w0.Bth6.8, w1.Bth6.8 )#5 // end mux2x1 Bth6.8 end netlist // mux2x1 Bth6.9( PP_6_9, GND, a3, b6 ) inv(b6_n.Bth6.9, b6 )#5 and2(w0.Bth6.9, b6_n.Bth6.9, GND )#5 and2(w1.Bth6.9, b6, a3 )#5 or2(PP_6_9, w0.Bth6.9, w1.Bth6.9 )#5 // end mux2x1 Bth6.9 end netlist // mux2x1 Bth6.10( PP_6_10, GND, a4, b6 ) inv(b6_n.Bth6.10, b6 )#5 and2(w0.Bth6.10, b6_n.Bth6.10, GND )#5 and2(w1.Bth6.10, b6, a4 )#5 or2(PP_6_10, w0.Bth6.10, w1.Bth6.10 )#5 // end mux2x1 Bth6.10 end netlist // mux2x1 Bth6.11( PP_6_11, GND, a5, b6 ) inv(b6_n.Bth6.11, b6 )#5 and2(w0.Bth6.11, b6_n.Bth6.11, GND )#5 and2(w1.Bth6.11, b6, a5 )#5 or2(PP_6_11, w0.Bth6.11, w1.Bth6.11 )#5 // end mux2x1 Bth6.11 end netlist // mux2x1 Bth6.12( PP_6_12, GND, a6, b6 ) inv(b6_n.Bth6.12, b6 )#5 and2(w0.Bth6.12, b6_n.Bth6.12, GND )#5 and2(w1.Bth6.12, b6, a6 )#5 or2(PP_6_12, w0.Bth6.12, w1.Bth6.12 )#5 // end mux2x1 Bth6.12 end netlist // mux2x1 Bth6.13( PP_6_13, GND, a7, b6 ) inv(b6_n.Bth6.13, b6 )#5 and2(w0.Bth6.13, b6_n.Bth6.13, GND )#5 and2(w1.Bth6.13, b6, a7 )#5 or2(PP_6_13, w0.Bth6.13, w1.Bth6.13 )#5 // end mux2x1 Bth6.13 end netlist // mux2x1 Bth6.14( PP_6_14, GND, a8, b6 ) inv(b6_n.Bth6.14, b6 )#5 and2(w0.Bth6.14, b6_n.Bth6.14, GND )#5 and2(w1.Bth6.14, b6, a8 )#5 or2(PP_6_14, w0.Bth6.14, w1.Bth6.14 )#5 // end mux2x1 Bth6.14 end netlist // mux2x1 Bth6.15( PP_6_15, GND, a9, b6 ) inv(b6_n.Bth6.15, b6 )#5 and2(w0.Bth6.15, b6_n.Bth6.15, GND )#5 and2(w1.Bth6.15, b6, a9 )#5 or2(PP_6_15, w0.Bth6.15, w1.Bth6.15 )#5 // end mux2x1 Bth6.15 end netlist // mux2x1 Bth6.16( PP_6_16, GND, a10, b6 ) inv(b6_n.Bth6.16, b6 )#5 and2(w0.Bth6.16, b6_n.Bth6.16, GND )#5 and2(w1.Bth6.16, b6, a10 )#5 or2(PP_6_16, w0.Bth6.16, w1.Bth6.16 )#5 // end mux2x1 Bth6.16 end netlist // mux2x1 Bth6.17( PP_6_17, GND, a11, b6 ) inv(b6_n.Bth6.17, b6 )#5 and2(w0.Bth6.17, b6_n.Bth6.17, GND )#5 and2(w1.Bth6.17, b6, a11 )#5 or2(PP_6_17, w0.Bth6.17, w1.Bth6.17 )#5 // end mux2x1 Bth6.17 end netlist // mux2x1 Bth6.18( PP_6_18, GND, GND, b6 ) inv(b6_n.Bth6.18, b6 )#5 and2(w0.Bth6.18, b6_n.Bth6.18, GND )#5 and2(w1.Bth6.18, b6, GND )#5 or2(PP_6_18, w0.Bth6.18, w1.Bth6.18 )#5 // end mux2x1 Bth6.18 end netlist // mux2x1 Bth6.19( PP_6_19, GND, GND, b6 ) inv(b6_n.Bth6.19, b6 )#5 and2(w0.Bth6.19, b6_n.Bth6.19, GND )#5 and2(w1.Bth6.19, b6, GND )#5 or2(PP_6_19, w0.Bth6.19, w1.Bth6.19 )#5 // end mux2x1 Bth6.19 end netlist // mux2x1 Bth6.20( PP_6_20, GND, GND, b6 ) inv(b6_n.Bth6.20, b6 )#5 and2(w0.Bth6.20, b6_n.Bth6.20, GND )#5 and2(w1.Bth6.20, b6, GND )#5 or2(PP_6_20, w0.Bth6.20, w1.Bth6.20 )#5 // end mux2x1 Bth6.20 end netlist // mux2x1 Bth6.21( PP_6_21, GND, GND, b6 ) inv(b6_n.Bth6.21, b6 )#5 and2(w0.Bth6.21, b6_n.Bth6.21, GND )#5 and2(w1.Bth6.21, b6, GND )#5 or2(PP_6_21, w0.Bth6.21, w1.Bth6.21 )#5 // end mux2x1 Bth6.21 end netlist // mux2x1 Bth6.22( PP_6_22, GND, GND, b6 ) inv(b6_n.Bth6.22, b6 )#5 and2(w0.Bth6.22, b6_n.Bth6.22, GND )#5 and2(w1.Bth6.22, b6, GND )#5 or2(PP_6_22, w0.Bth6.22, w1.Bth6.22 )#5 // end mux2x1 Bth6.22 end netlist // mux2x1 Bth6.23( PP_6_23, GND, GND, b6 ) inv(b6_n.Bth6.23, b6 )#5 and2(w0.Bth6.23, b6_n.Bth6.23, GND )#5 and2(w1.Bth6.23, b6, GND )#5 or2(PP_6_23, w0.Bth6.23, w1.Bth6.23 )#5 // end mux2x1 Bth6.23 end netlist // mux2x1 Bth7.0( PP_7_0, GND, GND, b7 ) inv(b7_n.Bth7.0, b7 )#5 and2(w0.Bth7.0, b7_n.Bth7.0, GND )#5 and2(w1.Bth7.0, b7, GND )#5 or2(PP_7_0, w0.Bth7.0, w1.Bth7.0 )#5 // end mux2x1 Bth7.0 end netlist // mux2x1 Bth7.1( PP_7_1, GND, GND, b7 ) inv(b7_n.Bth7.1, b7 )#5 and2(w0.Bth7.1, b7_n.Bth7.1, GND )#5 and2(w1.Bth7.1, b7, GND )#5 or2(PP_7_1, w0.Bth7.1, w1.Bth7.1 )#5 // end mux2x1 Bth7.1 end netlist // mux2x1 Bth7.2( PP_7_2, GND, GND, b7 ) inv(b7_n.Bth7.2, b7 )#5 and2(w0.Bth7.2, b7_n.Bth7.2, GND )#5 and2(w1.Bth7.2, b7, GND )#5 or2(PP_7_2, w0.Bth7.2, w1.Bth7.2 )#5 // end mux2x1 Bth7.2 end netlist // mux2x1 Bth7.3( PP_7_3, GND, GND, b7 ) inv(b7_n.Bth7.3, b7 )#5 and2(w0.Bth7.3, b7_n.Bth7.3, GND )#5 and2(w1.Bth7.3, b7, GND )#5 or2(PP_7_3, w0.Bth7.3, w1.Bth7.3 )#5 // end mux2x1 Bth7.3 end netlist // mux2x1 Bth7.4( PP_7_4, GND, GND, b7 ) inv(b7_n.Bth7.4, b7 )#5 and2(w0.Bth7.4, b7_n.Bth7.4, GND )#5 and2(w1.Bth7.4, b7, GND )#5 or2(PP_7_4, w0.Bth7.4, w1.Bth7.4 )#5 // end mux2x1 Bth7.4 end netlist // mux2x1 Bth7.5( PP_7_5, GND, GND, b7 ) inv(b7_n.Bth7.5, b7 )#5 and2(w0.Bth7.5, b7_n.Bth7.5, GND )#5 and2(w1.Bth7.5, b7, GND )#5 or2(PP_7_5, w0.Bth7.5, w1.Bth7.5 )#5 // end mux2x1 Bth7.5 end netlist // mux2x1 Bth7.6( PP_7_6, GND, GND, b7 ) inv(b7_n.Bth7.6, b7 )#5 and2(w0.Bth7.6, b7_n.Bth7.6, GND )#5 and2(w1.Bth7.6, b7, GND )#5 or2(PP_7_6, w0.Bth7.6, w1.Bth7.6 )#5 // end mux2x1 Bth7.6 end netlist // mux2x1 Bth7.7( PP_7_7, GND, a0, b7 ) inv(b7_n.Bth7.7, b7 )#5 and2(w0.Bth7.7, b7_n.Bth7.7, GND )#5 and2(w1.Bth7.7, b7, a0 )#5 or2(PP_7_7, w0.Bth7.7, w1.Bth7.7 )#5 // end mux2x1 Bth7.7 end netlist // mux2x1 Bth7.8( PP_7_8, GND, a1, b7 ) inv(b7_n.Bth7.8, b7 )#5 and2(w0.Bth7.8, b7_n.Bth7.8, GND )#5 and2(w1.Bth7.8, b7, a1 )#5 or2(PP_7_8, w0.Bth7.8, w1.Bth7.8 )#5 // end mux2x1 Bth7.8 end netlist // mux2x1 Bth7.9( PP_7_9, GND, a2, b7 ) inv(b7_n.Bth7.9, b7 )#5 and2(w0.Bth7.9, b7_n.Bth7.9, GND )#5 and2(w1.Bth7.9, b7, a2 )#5 or2(PP_7_9, w0.Bth7.9, w1.Bth7.9 )#5 // end mux2x1 Bth7.9 end netlist // mux2x1 Bth7.10( PP_7_10, GND, a3, b7 ) inv(b7_n.Bth7.10, b7 )#5 and2(w0.Bth7.10, b7_n.Bth7.10, GND )#5 and2(w1.Bth7.10, b7, a3 )#5 or2(PP_7_10, w0.Bth7.10, w1.Bth7.10 )#5 // end mux2x1 Bth7.10 end netlist // mux2x1 Bth7.11( PP_7_11, GND, a4, b7 ) inv(b7_n.Bth7.11, b7 )#5 and2(w0.Bth7.11, b7_n.Bth7.11, GND )#5 and2(w1.Bth7.11, b7, a4 )#5 or2(PP_7_11, w0.Bth7.11, w1.Bth7.11 )#5 // end mux2x1 Bth7.11 end netlist // mux2x1 Bth7.12( PP_7_12, GND, a5, b7 ) inv(b7_n.Bth7.12, b7 )#5 and2(w0.Bth7.12, b7_n.Bth7.12, GND )#5 and2(w1.Bth7.12, b7, a5 )#5 or2(PP_7_12, w0.Bth7.12, w1.Bth7.12 )#5 // end mux2x1 Bth7.12 end netlist // mux2x1 Bth7.13( PP_7_13, GND, a6, b7 ) inv(b7_n.Bth7.13, b7 )#5 and2(w0.Bth7.13, b7_n.Bth7.13, GND )#5 and2(w1.Bth7.13, b7, a6 )#5 or2(PP_7_13, w0.Bth7.13, w1.Bth7.13 )#5 // end mux2x1 Bth7.13 end netlist // mux2x1 Bth7.14( PP_7_14, GND, a7, b7 ) inv(b7_n.Bth7.14, b7 )#5 and2(w0.Bth7.14, b7_n.Bth7.14, GND )#5 and2(w1.Bth7.14, b7, a7 )#5 or2(PP_7_14, w0.Bth7.14, w1.Bth7.14 )#5 // end mux2x1 Bth7.14 end netlist // mux2x1 Bth7.15( PP_7_15, GND, a8, b7 ) inv(b7_n.Bth7.15, b7 )#5 and2(w0.Bth7.15, b7_n.Bth7.15, GND )#5 and2(w1.Bth7.15, b7, a8 )#5 or2(PP_7_15, w0.Bth7.15, w1.Bth7.15 )#5 // end mux2x1 Bth7.15 end netlist // mux2x1 Bth7.16( PP_7_16, GND, a9, b7 ) inv(b7_n.Bth7.16, b7 )#5 and2(w0.Bth7.16, b7_n.Bth7.16, GND )#5 and2(w1.Bth7.16, b7, a9 )#5 or2(PP_7_16, w0.Bth7.16, w1.Bth7.16 )#5 // end mux2x1 Bth7.16 end netlist // mux2x1 Bth7.17( PP_7_17, GND, a10, b7 ) inv(b7_n.Bth7.17, b7 )#5 and2(w0.Bth7.17, b7_n.Bth7.17, GND )#5 and2(w1.Bth7.17, b7, a10 )#5 or2(PP_7_17, w0.Bth7.17, w1.Bth7.17 )#5 // end mux2x1 Bth7.17 end netlist // mux2x1 Bth7.18( PP_7_18, GND, a11, b7 ) inv(b7_n.Bth7.18, b7 )#5 and2(w0.Bth7.18, b7_n.Bth7.18, GND )#5 and2(w1.Bth7.18, b7, a11 )#5 or2(PP_7_18, w0.Bth7.18, w1.Bth7.18 )#5 // end mux2x1 Bth7.18 end netlist // mux2x1 Bth7.19( PP_7_19, GND, GND, b7 ) inv(b7_n.Bth7.19, b7 )#5 and2(w0.Bth7.19, b7_n.Bth7.19, GND )#5 and2(w1.Bth7.19, b7, GND )#5 or2(PP_7_19, w0.Bth7.19, w1.Bth7.19 )#5 // end mux2x1 Bth7.19 end netlist // mux2x1 Bth7.20( PP_7_20, GND, GND, b7 ) inv(b7_n.Bth7.20, b7 )#5 and2(w0.Bth7.20, b7_n.Bth7.20, GND )#5 and2(w1.Bth7.20, b7, GND )#5 or2(PP_7_20, w0.Bth7.20, w1.Bth7.20 )#5 // end mux2x1 Bth7.20 end netlist // mux2x1 Bth7.21( PP_7_21, GND, GND, b7 ) inv(b7_n.Bth7.21, b7 )#5 and2(w0.Bth7.21, b7_n.Bth7.21, GND )#5 and2(w1.Bth7.21, b7, GND )#5 or2(PP_7_21, w0.Bth7.21, w1.Bth7.21 )#5 // end mux2x1 Bth7.21 end netlist // mux2x1 Bth7.22( PP_7_22, GND, GND, b7 ) inv(b7_n.Bth7.22, b7 )#5 and2(w0.Bth7.22, b7_n.Bth7.22, GND )#5 and2(w1.Bth7.22, b7, GND )#5 or2(PP_7_22, w0.Bth7.22, w1.Bth7.22 )#5 // end mux2x1 Bth7.22 end netlist // mux2x1 Bth7.23( PP_7_23, GND, GND, b7 ) inv(b7_n.Bth7.23, b7 )#5 and2(w0.Bth7.23, b7_n.Bth7.23, GND )#5 and2(w1.Bth7.23, b7, GND )#5 or2(PP_7_23, w0.Bth7.23, w1.Bth7.23 )#5 // end mux2x1 Bth7.23 end netlist // mux2x1 Bth8.0( PP_8_0, GND, GND, b8 ) inv(b8_n.Bth8.0, b8 )#5 and2(w0.Bth8.0, b8_n.Bth8.0, GND )#5 and2(w1.Bth8.0, b8, GND )#5 or2(PP_8_0, w0.Bth8.0, w1.Bth8.0 )#5 // end mux2x1 Bth8.0 end netlist // mux2x1 Bth8.1( PP_8_1, GND, GND, b8 ) inv(b8_n.Bth8.1, b8 )#5 and2(w0.Bth8.1, b8_n.Bth8.1, GND )#5 and2(w1.Bth8.1, b8, GND )#5 or2(PP_8_1, w0.Bth8.1, w1.Bth8.1 )#5 // end mux2x1 Bth8.1 end netlist // mux2x1 Bth8.2( PP_8_2, GND, GND, b8 ) inv(b8_n.Bth8.2, b8 )#5 and2(w0.Bth8.2, b8_n.Bth8.2, GND )#5 and2(w1.Bth8.2, b8, GND )#5 or2(PP_8_2, w0.Bth8.2, w1.Bth8.2 )#5 // end mux2x1 Bth8.2 end netlist // mux2x1 Bth8.3( PP_8_3, GND, GND, b8 ) inv(b8_n.Bth8.3, b8 )#5 and2(w0.Bth8.3, b8_n.Bth8.3, GND )#5 and2(w1.Bth8.3, b8, GND )#5 or2(PP_8_3, w0.Bth8.3, w1.Bth8.3 )#5 // end mux2x1 Bth8.3 end netlist // mux2x1 Bth8.4( PP_8_4, GND, GND, b8 ) inv(b8_n.Bth8.4, b8 )#5 and2(w0.Bth8.4, b8_n.Bth8.4, GND )#5 and2(w1.Bth8.4, b8, GND )#5 or2(PP_8_4, w0.Bth8.4, w1.Bth8.4 )#5 // end mux2x1 Bth8.4 end netlist // mux2x1 Bth8.5( PP_8_5, GND, GND, b8 ) inv(b8_n.Bth8.5, b8 )#5 and2(w0.Bth8.5, b8_n.Bth8.5, GND )#5 and2(w1.Bth8.5, b8, GND )#5 or2(PP_8_5, w0.Bth8.5, w1.Bth8.5 )#5 // end mux2x1 Bth8.5 end netlist // mux2x1 Bth8.6( PP_8_6, GND, GND, b8 ) inv(b8_n.Bth8.6, b8 )#5 and2(w0.Bth8.6, b8_n.Bth8.6, GND )#5 and2(w1.Bth8.6, b8, GND )#5 or2(PP_8_6, w0.Bth8.6, w1.Bth8.6 )#5 // end mux2x1 Bth8.6 end netlist // mux2x1 Bth8.7( PP_8_7, GND, GND, b8 ) inv(b8_n.Bth8.7, b8 )#5 and2(w0.Bth8.7, b8_n.Bth8.7, GND )#5 and2(w1.Bth8.7, b8, GND )#5 or2(PP_8_7, w0.Bth8.7, w1.Bth8.7 )#5 // end mux2x1 Bth8.7 end netlist // mux2x1 Bth8.8( PP_8_8, GND, a0, b8 ) inv(b8_n.Bth8.8, b8 )#5 and2(w0.Bth8.8, b8_n.Bth8.8, GND )#5 and2(w1.Bth8.8, b8, a0 )#5 or2(PP_8_8, w0.Bth8.8, w1.Bth8.8 )#5 // end mux2x1 Bth8.8 end netlist // mux2x1 Bth8.9( PP_8_9, GND, a1, b8 ) inv(b8_n.Bth8.9, b8 )#5 and2(w0.Bth8.9, b8_n.Bth8.9, GND )#5 and2(w1.Bth8.9, b8, a1 )#5 or2(PP_8_9, w0.Bth8.9, w1.Bth8.9 )#5 // end mux2x1 Bth8.9 end netlist // mux2x1 Bth8.10( PP_8_10, GND, a2, b8 ) inv(b8_n.Bth8.10, b8 )#5 and2(w0.Bth8.10, b8_n.Bth8.10, GND )#5 and2(w1.Bth8.10, b8, a2 )#5 or2(PP_8_10, w0.Bth8.10, w1.Bth8.10 )#5 // end mux2x1 Bth8.10 end netlist // mux2x1 Bth8.11( PP_8_11, GND, a3, b8 ) inv(b8_n.Bth8.11, b8 )#5 and2(w0.Bth8.11, b8_n.Bth8.11, GND )#5 and2(w1.Bth8.11, b8, a3 )#5 or2(PP_8_11, w0.Bth8.11, w1.Bth8.11 )#5 // end mux2x1 Bth8.11 end netlist // mux2x1 Bth8.12( PP_8_12, GND, a4, b8 ) inv(b8_n.Bth8.12, b8 )#5 and2(w0.Bth8.12, b8_n.Bth8.12, GND )#5 and2(w1.Bth8.12, b8, a4 )#5 or2(PP_8_12, w0.Bth8.12, w1.Bth8.12 )#5 // end mux2x1 Bth8.12 end netlist // mux2x1 Bth8.13( PP_8_13, GND, a5, b8 ) inv(b8_n.Bth8.13, b8 )#5 and2(w0.Bth8.13, b8_n.Bth8.13, GND )#5 and2(w1.Bth8.13, b8, a5 )#5 or2(PP_8_13, w0.Bth8.13, w1.Bth8.13 )#5 // end mux2x1 Bth8.13 end netlist // mux2x1 Bth8.14( PP_8_14, GND, a6, b8 ) inv(b8_n.Bth8.14, b8 )#5 and2(w0.Bth8.14, b8_n.Bth8.14, GND )#5 and2(w1.Bth8.14, b8, a6 )#5 or2(PP_8_14, w0.Bth8.14, w1.Bth8.14 )#5 // end mux2x1 Bth8.14 end netlist // mux2x1 Bth8.15( PP_8_15, GND, a7, b8 ) inv(b8_n.Bth8.15, b8 )#5 and2(w0.Bth8.15, b8_n.Bth8.15, GND )#5 and2(w1.Bth8.15, b8, a7 )#5 or2(PP_8_15, w0.Bth8.15, w1.Bth8.15 )#5 // end mux2x1 Bth8.15 end netlist // mux2x1 Bth8.16( PP_8_16, GND, a8, b8 ) inv(b8_n.Bth8.16, b8 )#5 and2(w0.Bth8.16, b8_n.Bth8.16, GND )#5 and2(w1.Bth8.16, b8, a8 )#5 or2(PP_8_16, w0.Bth8.16, w1.Bth8.16 )#5 // end mux2x1 Bth8.16 end netlist // mux2x1 Bth8.17( PP_8_17, GND, a9, b8 ) inv(b8_n.Bth8.17, b8 )#5 and2(w0.Bth8.17, b8_n.Bth8.17, GND )#5 and2(w1.Bth8.17, b8, a9 )#5 or2(PP_8_17, w0.Bth8.17, w1.Bth8.17 )#5 // end mux2x1 Bth8.17 end netlist // mux2x1 Bth8.18( PP_8_18, GND, a10, b8 ) inv(b8_n.Bth8.18, b8 )#5 and2(w0.Bth8.18, b8_n.Bth8.18, GND )#5 and2(w1.Bth8.18, b8, a10 )#5 or2(PP_8_18, w0.Bth8.18, w1.Bth8.18 )#5 // end mux2x1 Bth8.18 end netlist // mux2x1 Bth8.19( PP_8_19, GND, a11, b8 ) inv(b8_n.Bth8.19, b8 )#5 and2(w0.Bth8.19, b8_n.Bth8.19, GND )#5 and2(w1.Bth8.19, b8, a11 )#5 or2(PP_8_19, w0.Bth8.19, w1.Bth8.19 )#5 // end mux2x1 Bth8.19 end netlist // mux2x1 Bth8.20( PP_8_20, GND, GND, b8 ) inv(b8_n.Bth8.20, b8 )#5 and2(w0.Bth8.20, b8_n.Bth8.20, GND )#5 and2(w1.Bth8.20, b8, GND )#5 or2(PP_8_20, w0.Bth8.20, w1.Bth8.20 )#5 // end mux2x1 Bth8.20 end netlist // mux2x1 Bth8.21( PP_8_21, GND, GND, b8 ) inv(b8_n.Bth8.21, b8 )#5 and2(w0.Bth8.21, b8_n.Bth8.21, GND )#5 and2(w1.Bth8.21, b8, GND )#5 or2(PP_8_21, w0.Bth8.21, w1.Bth8.21 )#5 // end mux2x1 Bth8.21 end netlist // mux2x1 Bth8.22( PP_8_22, GND, GND, b8 ) inv(b8_n.Bth8.22, b8 )#5 and2(w0.Bth8.22, b8_n.Bth8.22, GND )#5 and2(w1.Bth8.22, b8, GND )#5 or2(PP_8_22, w0.Bth8.22, w1.Bth8.22 )#5 // end mux2x1 Bth8.22 end netlist // mux2x1 Bth8.23( PP_8_23, GND, GND, b8 ) inv(b8_n.Bth8.23, b8 )#5 and2(w0.Bth8.23, b8_n.Bth8.23, GND )#5 and2(w1.Bth8.23, b8, GND )#5 or2(PP_8_23, w0.Bth8.23, w1.Bth8.23 )#5 // end mux2x1 Bth8.23 end netlist // mux2x1 Bth9.0( PP_9_0, GND, GND, b9 ) inv(b9_n.Bth9.0, b9 )#5 and2(w0.Bth9.0, b9_n.Bth9.0, GND )#5 and2(w1.Bth9.0, b9, GND )#5 or2(PP_9_0, w0.Bth9.0, w1.Bth9.0 )#5 // end mux2x1 Bth9.0 end netlist // mux2x1 Bth9.1( PP_9_1, GND, GND, b9 ) inv(b9_n.Bth9.1, b9 )#5 and2(w0.Bth9.1, b9_n.Bth9.1, GND )#5 and2(w1.Bth9.1, b9, GND )#5 or2(PP_9_1, w0.Bth9.1, w1.Bth9.1 )#5 // end mux2x1 Bth9.1 end netlist // mux2x1 Bth9.2( PP_9_2, GND, GND, b9 ) inv(b9_n.Bth9.2, b9 )#5 and2(w0.Bth9.2, b9_n.Bth9.2, GND )#5 and2(w1.Bth9.2, b9, GND )#5 or2(PP_9_2, w0.Bth9.2, w1.Bth9.2 )#5 // end mux2x1 Bth9.2 end netlist // mux2x1 Bth9.3( PP_9_3, GND, GND, b9 ) inv(b9_n.Bth9.3, b9 )#5 and2(w0.Bth9.3, b9_n.Bth9.3, GND )#5 and2(w1.Bth9.3, b9, GND )#5 or2(PP_9_3, w0.Bth9.3, w1.Bth9.3 )#5 // end mux2x1 Bth9.3 end netlist // mux2x1 Bth9.4( PP_9_4, GND, GND, b9 ) inv(b9_n.Bth9.4, b9 )#5 and2(w0.Bth9.4, b9_n.Bth9.4, GND )#5 and2(w1.Bth9.4, b9, GND )#5 or2(PP_9_4, w0.Bth9.4, w1.Bth9.4 )#5 // end mux2x1 Bth9.4 end netlist // mux2x1 Bth9.5( PP_9_5, GND, GND, b9 ) inv(b9_n.Bth9.5, b9 )#5 and2(w0.Bth9.5, b9_n.Bth9.5, GND )#5 and2(w1.Bth9.5, b9, GND )#5 or2(PP_9_5, w0.Bth9.5, w1.Bth9.5 )#5 // end mux2x1 Bth9.5 end netlist // mux2x1 Bth9.6( PP_9_6, GND, GND, b9 ) inv(b9_n.Bth9.6, b9 )#5 and2(w0.Bth9.6, b9_n.Bth9.6, GND )#5 and2(w1.Bth9.6, b9, GND )#5 or2(PP_9_6, w0.Bth9.6, w1.Bth9.6 )#5 // end mux2x1 Bth9.6 end netlist // mux2x1 Bth9.7( PP_9_7, GND, GND, b9 ) inv(b9_n.Bth9.7, b9 )#5 and2(w0.Bth9.7, b9_n.Bth9.7, GND )#5 and2(w1.Bth9.7, b9, GND )#5 or2(PP_9_7, w0.Bth9.7, w1.Bth9.7 )#5 // end mux2x1 Bth9.7 end netlist // mux2x1 Bth9.8( PP_9_8, GND, GND, b9 ) inv(b9_n.Bth9.8, b9 )#5 and2(w0.Bth9.8, b9_n.Bth9.8, GND )#5 and2(w1.Bth9.8, b9, GND )#5 or2(PP_9_8, w0.Bth9.8, w1.Bth9.8 )#5 // end mux2x1 Bth9.8 end netlist // mux2x1 Bth9.9( PP_9_9, GND, a0, b9 ) inv(b9_n.Bth9.9, b9 )#5 and2(w0.Bth9.9, b9_n.Bth9.9, GND )#5 and2(w1.Bth9.9, b9, a0 )#5 or2(PP_9_9, w0.Bth9.9, w1.Bth9.9 )#5 // end mux2x1 Bth9.9 end netlist // mux2x1 Bth9.10( PP_9_10, GND, a1, b9 ) inv(b9_n.Bth9.10, b9 )#5 and2(w0.Bth9.10, b9_n.Bth9.10, GND )#5 and2(w1.Bth9.10, b9, a1 )#5 or2(PP_9_10, w0.Bth9.10, w1.Bth9.10 )#5 // end mux2x1 Bth9.10 end netlist // mux2x1 Bth9.11( PP_9_11, GND, a2, b9 ) inv(b9_n.Bth9.11, b9 )#5 and2(w0.Bth9.11, b9_n.Bth9.11, GND )#5 and2(w1.Bth9.11, b9, a2 )#5 or2(PP_9_11, w0.Bth9.11, w1.Bth9.11 )#5 // end mux2x1 Bth9.11 end netlist // mux2x1 Bth9.12( PP_9_12, GND, a3, b9 ) inv(b9_n.Bth9.12, b9 )#5 and2(w0.Bth9.12, b9_n.Bth9.12, GND )#5 and2(w1.Bth9.12, b9, a3 )#5 or2(PP_9_12, w0.Bth9.12, w1.Bth9.12 )#5 // end mux2x1 Bth9.12 end netlist // mux2x1 Bth9.13( PP_9_13, GND, a4, b9 ) inv(b9_n.Bth9.13, b9 )#5 and2(w0.Bth9.13, b9_n.Bth9.13, GND )#5 and2(w1.Bth9.13, b9, a4 )#5 or2(PP_9_13, w0.Bth9.13, w1.Bth9.13 )#5 // end mux2x1 Bth9.13 end netlist // mux2x1 Bth9.14( PP_9_14, GND, a5, b9 ) inv(b9_n.Bth9.14, b9 )#5 and2(w0.Bth9.14, b9_n.Bth9.14, GND )#5 and2(w1.Bth9.14, b9, a5 )#5 or2(PP_9_14, w0.Bth9.14, w1.Bth9.14 )#5 // end mux2x1 Bth9.14 end netlist // mux2x1 Bth9.15( PP_9_15, GND, a6, b9 ) inv(b9_n.Bth9.15, b9 )#5 and2(w0.Bth9.15, b9_n.Bth9.15, GND )#5 and2(w1.Bth9.15, b9, a6 )#5 or2(PP_9_15, w0.Bth9.15, w1.Bth9.15 )#5 // end mux2x1 Bth9.15 end netlist // mux2x1 Bth9.16( PP_9_16, GND, a7, b9 ) inv(b9_n.Bth9.16, b9 )#5 and2(w0.Bth9.16, b9_n.Bth9.16, GND )#5 and2(w1.Bth9.16, b9, a7 )#5 or2(PP_9_16, w0.Bth9.16, w1.Bth9.16 )#5 // end mux2x1 Bth9.16 end netlist // mux2x1 Bth9.17( PP_9_17, GND, a8, b9 ) inv(b9_n.Bth9.17, b9 )#5 and2(w0.Bth9.17, b9_n.Bth9.17, GND )#5 and2(w1.Bth9.17, b9, a8 )#5 or2(PP_9_17, w0.Bth9.17, w1.Bth9.17 )#5 // end mux2x1 Bth9.17 end netlist // mux2x1 Bth9.18( PP_9_18, GND, a9, b9 ) inv(b9_n.Bth9.18, b9 )#5 and2(w0.Bth9.18, b9_n.Bth9.18, GND )#5 and2(w1.Bth9.18, b9, a9 )#5 or2(PP_9_18, w0.Bth9.18, w1.Bth9.18 )#5 // end mux2x1 Bth9.18 end netlist // mux2x1 Bth9.19( PP_9_19, GND, a10, b9 ) inv(b9_n.Bth9.19, b9 )#5 and2(w0.Bth9.19, b9_n.Bth9.19, GND )#5 and2(w1.Bth9.19, b9, a10 )#5 or2(PP_9_19, w0.Bth9.19, w1.Bth9.19 )#5 // end mux2x1 Bth9.19 end netlist // mux2x1 Bth9.20( PP_9_20, GND, a11, b9 ) inv(b9_n.Bth9.20, b9 )#5 and2(w0.Bth9.20, b9_n.Bth9.20, GND )#5 and2(w1.Bth9.20, b9, a11 )#5 or2(PP_9_20, w0.Bth9.20, w1.Bth9.20 )#5 // end mux2x1 Bth9.20 end netlist // mux2x1 Bth9.21( PP_9_21, GND, GND, b9 ) inv(b9_n.Bth9.21, b9 )#5 and2(w0.Bth9.21, b9_n.Bth9.21, GND )#5 and2(w1.Bth9.21, b9, GND )#5 or2(PP_9_21, w0.Bth9.21, w1.Bth9.21 )#5 // end mux2x1 Bth9.21 end netlist // mux2x1 Bth9.22( PP_9_22, GND, GND, b9 ) inv(b9_n.Bth9.22, b9 )#5 and2(w0.Bth9.22, b9_n.Bth9.22, GND )#5 and2(w1.Bth9.22, b9, GND )#5 or2(PP_9_22, w0.Bth9.22, w1.Bth9.22 )#5 // end mux2x1 Bth9.22 end netlist // mux2x1 Bth9.23( PP_9_23, GND, GND, b9 ) inv(b9_n.Bth9.23, b9 )#5 and2(w0.Bth9.23, b9_n.Bth9.23, GND )#5 and2(w1.Bth9.23, b9, GND )#5 or2(PP_9_23, w0.Bth9.23, w1.Bth9.23 )#5 // end mux2x1 Bth9.23 end netlist // mux2x1 Bth10.0( PP_10_0, GND, GND, b10 ) inv(b10_n.Bth10.0, b10 )#5 and2(w0.Bth10.0, b10_n.Bth10.0, GND )#5 and2(w1.Bth10.0, b10, GND )#5 or2(PP_10_0, w0.Bth10.0, w1.Bth10.0 )#5 // end mux2x1 Bth10.0 end netlist // mux2x1 Bth10.1( PP_10_1, GND, GND, b10 ) inv(b10_n.Bth10.1, b10 )#5 and2(w0.Bth10.1, b10_n.Bth10.1, GND )#5 and2(w1.Bth10.1, b10, GND )#5 or2(PP_10_1, w0.Bth10.1, w1.Bth10.1 )#5 // end mux2x1 Bth10.1 end netlist // mux2x1 Bth10.2( PP_10_2, GND, GND, b10 ) inv(b10_n.Bth10.2, b10 )#5 and2(w0.Bth10.2, b10_n.Bth10.2, GND )#5 and2(w1.Bth10.2, b10, GND )#5 or2(PP_10_2, w0.Bth10.2, w1.Bth10.2 )#5 // end mux2x1 Bth10.2 end netlist // mux2x1 Bth10.3( PP_10_3, GND, GND, b10 ) inv(b10_n.Bth10.3, b10 )#5 and2(w0.Bth10.3, b10_n.Bth10.3, GND )#5 and2(w1.Bth10.3, b10, GND )#5 or2(PP_10_3, w0.Bth10.3, w1.Bth10.3 )#5 // end mux2x1 Bth10.3 end netlist // mux2x1 Bth10.4( PP_10_4, GND, GND, b10 ) inv(b10_n.Bth10.4, b10 )#5 and2(w0.Bth10.4, b10_n.Bth10.4, GND )#5 and2(w1.Bth10.4, b10, GND )#5 or2(PP_10_4, w0.Bth10.4, w1.Bth10.4 )#5 // end mux2x1 Bth10.4 end netlist // mux2x1 Bth10.5( PP_10_5, GND, GND, b10 ) inv(b10_n.Bth10.5, b10 )#5 and2(w0.Bth10.5, b10_n.Bth10.5, GND )#5 and2(w1.Bth10.5, b10, GND )#5 or2(PP_10_5, w0.Bth10.5, w1.Bth10.5 )#5 // end mux2x1 Bth10.5 end netlist // mux2x1 Bth10.6( PP_10_6, GND, GND, b10 ) inv(b10_n.Bth10.6, b10 )#5 and2(w0.Bth10.6, b10_n.Bth10.6, GND )#5 and2(w1.Bth10.6, b10, GND )#5 or2(PP_10_6, w0.Bth10.6, w1.Bth10.6 )#5 // end mux2x1 Bth10.6 end netlist // mux2x1 Bth10.7( PP_10_7, GND, GND, b10 ) inv(b10_n.Bth10.7, b10 )#5 and2(w0.Bth10.7, b10_n.Bth10.7, GND )#5 and2(w1.Bth10.7, b10, GND )#5 or2(PP_10_7, w0.Bth10.7, w1.Bth10.7 )#5 // end mux2x1 Bth10.7 end netlist // mux2x1 Bth10.8( PP_10_8, GND, GND, b10 ) inv(b10_n.Bth10.8, b10 )#5 and2(w0.Bth10.8, b10_n.Bth10.8, GND )#5 and2(w1.Bth10.8, b10, GND )#5 or2(PP_10_8, w0.Bth10.8, w1.Bth10.8 )#5 // end mux2x1 Bth10.8 end netlist // mux2x1 Bth10.9( PP_10_9, GND, GND, b10 ) inv(b10_n.Bth10.9, b10 )#5 and2(w0.Bth10.9, b10_n.Bth10.9, GND )#5 and2(w1.Bth10.9, b10, GND )#5 or2(PP_10_9, w0.Bth10.9, w1.Bth10.9 )#5 // end mux2x1 Bth10.9 end netlist // mux2x1 Bth10.10( PP_10_10, GND, a0, b10 ) inv(b10_n.Bth10.10, b10 )#5 and2(w0.Bth10.10, b10_n.Bth10.10, GND )#5 and2(w1.Bth10.10, b10, a0 )#5 or2(PP_10_10, w0.Bth10.10, w1.Bth10.10 )#5 // end mux2x1 Bth10.10 end netlist // mux2x1 Bth10.11( PP_10_11, GND, a1, b10 ) inv(b10_n.Bth10.11, b10 )#5 and2(w0.Bth10.11, b10_n.Bth10.11, GND )#5 and2(w1.Bth10.11, b10, a1 )#5 or2(PP_10_11, w0.Bth10.11, w1.Bth10.11 )#5 // end mux2x1 Bth10.11 end netlist // mux2x1 Bth10.12( PP_10_12, GND, a2, b10 ) inv(b10_n.Bth10.12, b10 )#5 and2(w0.Bth10.12, b10_n.Bth10.12, GND )#5 and2(w1.Bth10.12, b10, a2 )#5 or2(PP_10_12, w0.Bth10.12, w1.Bth10.12 )#5 // end mux2x1 Bth10.12 end netlist // mux2x1 Bth10.13( PP_10_13, GND, a3, b10 ) inv(b10_n.Bth10.13, b10 )#5 and2(w0.Bth10.13, b10_n.Bth10.13, GND )#5 and2(w1.Bth10.13, b10, a3 )#5 or2(PP_10_13, w0.Bth10.13, w1.Bth10.13 )#5 // end mux2x1 Bth10.13 end netlist // mux2x1 Bth10.14( PP_10_14, GND, a4, b10 ) inv(b10_n.Bth10.14, b10 )#5 and2(w0.Bth10.14, b10_n.Bth10.14, GND )#5 and2(w1.Bth10.14, b10, a4 )#5 or2(PP_10_14, w0.Bth10.14, w1.Bth10.14 )#5 // end mux2x1 Bth10.14 end netlist // mux2x1 Bth10.15( PP_10_15, GND, a5, b10 ) inv(b10_n.Bth10.15, b10 )#5 and2(w0.Bth10.15, b10_n.Bth10.15, GND )#5 and2(w1.Bth10.15, b10, a5 )#5 or2(PP_10_15, w0.Bth10.15, w1.Bth10.15 )#5 // end mux2x1 Bth10.15 end netlist // mux2x1 Bth10.16( PP_10_16, GND, a6, b10 ) inv(b10_n.Bth10.16, b10 )#5 and2(w0.Bth10.16, b10_n.Bth10.16, GND )#5 and2(w1.Bth10.16, b10, a6 )#5 or2(PP_10_16, w0.Bth10.16, w1.Bth10.16 )#5 // end mux2x1 Bth10.16 end netlist // mux2x1 Bth10.17( PP_10_17, GND, a7, b10 ) inv(b10_n.Bth10.17, b10 )#5 and2(w0.Bth10.17, b10_n.Bth10.17, GND )#5 and2(w1.Bth10.17, b10, a7 )#5 or2(PP_10_17, w0.Bth10.17, w1.Bth10.17 )#5 // end mux2x1 Bth10.17 end netlist // mux2x1 Bth10.18( PP_10_18, GND, a8, b10 ) inv(b10_n.Bth10.18, b10 )#5 and2(w0.Bth10.18, b10_n.Bth10.18, GND )#5 and2(w1.Bth10.18, b10, a8 )#5 or2(PP_10_18, w0.Bth10.18, w1.Bth10.18 )#5 // end mux2x1 Bth10.18 end netlist // mux2x1 Bth10.19( PP_10_19, GND, a9, b10 ) inv(b10_n.Bth10.19, b10 )#5 and2(w0.Bth10.19, b10_n.Bth10.19, GND )#5 and2(w1.Bth10.19, b10, a9 )#5 or2(PP_10_19, w0.Bth10.19, w1.Bth10.19 )#5 // end mux2x1 Bth10.19 end netlist // mux2x1 Bth10.20( PP_10_20, GND, a10, b10 ) inv(b10_n.Bth10.20, b10 )#5 and2(w0.Bth10.20, b10_n.Bth10.20, GND )#5 and2(w1.Bth10.20, b10, a10 )#5 or2(PP_10_20, w0.Bth10.20, w1.Bth10.20 )#5 // end mux2x1 Bth10.20 end netlist // mux2x1 Bth10.21( PP_10_21, GND, a11, b10 ) inv(b10_n.Bth10.21, b10 )#5 and2(w0.Bth10.21, b10_n.Bth10.21, GND )#5 and2(w1.Bth10.21, b10, a11 )#5 or2(PP_10_21, w0.Bth10.21, w1.Bth10.21 )#5 // end mux2x1 Bth10.21 end netlist // mux2x1 Bth10.22( PP_10_22, GND, GND, b10 ) inv(b10_n.Bth10.22, b10 )#5 and2(w0.Bth10.22, b10_n.Bth10.22, GND )#5 and2(w1.Bth10.22, b10, GND )#5 or2(PP_10_22, w0.Bth10.22, w1.Bth10.22 )#5 // end mux2x1 Bth10.22 end netlist // mux2x1 Bth10.23( PP_10_23, GND, GND, b10 ) inv(b10_n.Bth10.23, b10 )#5 and2(w0.Bth10.23, b10_n.Bth10.23, GND )#5 and2(w1.Bth10.23, b10, GND )#5 or2(PP_10_23, w0.Bth10.23, w1.Bth10.23 )#5 // end mux2x1 Bth10.23 end netlist // mux2x1 Bth11.0( PP_11_0, GND, GND, b11 ) inv(b11_n.Bth11.0, b11 )#5 and2(w0.Bth11.0, b11_n.Bth11.0, GND )#5 and2(w1.Bth11.0, b11, GND )#5 or2(PP_11_0, w0.Bth11.0, w1.Bth11.0 )#5 // end mux2x1 Bth11.0 end netlist // mux2x1 Bth11.1( PP_11_1, GND, GND, b11 ) inv(b11_n.Bth11.1, b11 )#5 and2(w0.Bth11.1, b11_n.Bth11.1, GND )#5 and2(w1.Bth11.1, b11, GND )#5 or2(PP_11_1, w0.Bth11.1, w1.Bth11.1 )#5 // end mux2x1 Bth11.1 end netlist // mux2x1 Bth11.2( PP_11_2, GND, GND, b11 ) inv(b11_n.Bth11.2, b11 )#5 and2(w0.Bth11.2, b11_n.Bth11.2, GND )#5 and2(w1.Bth11.2, b11, GND )#5 or2(PP_11_2, w0.Bth11.2, w1.Bth11.2 )#5 // end mux2x1 Bth11.2 end netlist // mux2x1 Bth11.3( PP_11_3, GND, GND, b11 ) inv(b11_n.Bth11.3, b11 )#5 and2(w0.Bth11.3, b11_n.Bth11.3, GND )#5 and2(w1.Bth11.3, b11, GND )#5 or2(PP_11_3, w0.Bth11.3, w1.Bth11.3 )#5 // end mux2x1 Bth11.3 end netlist // mux2x1 Bth11.4( PP_11_4, GND, GND, b11 ) inv(b11_n.Bth11.4, b11 )#5 and2(w0.Bth11.4, b11_n.Bth11.4, GND )#5 and2(w1.Bth11.4, b11, GND )#5 or2(PP_11_4, w0.Bth11.4, w1.Bth11.4 )#5 // end mux2x1 Bth11.4 end netlist // mux2x1 Bth11.5( PP_11_5, GND, GND, b11 ) inv(b11_n.Bth11.5, b11 )#5 and2(w0.Bth11.5, b11_n.Bth11.5, GND )#5 and2(w1.Bth11.5, b11, GND )#5 or2(PP_11_5, w0.Bth11.5, w1.Bth11.5 )#5 // end mux2x1 Bth11.5 end netlist // mux2x1 Bth11.6( PP_11_6, GND, GND, b11 ) inv(b11_n.Bth11.6, b11 )#5 and2(w0.Bth11.6, b11_n.Bth11.6, GND )#5 and2(w1.Bth11.6, b11, GND )#5 or2(PP_11_6, w0.Bth11.6, w1.Bth11.6 )#5 // end mux2x1 Bth11.6 end netlist // mux2x1 Bth11.7( PP_11_7, GND, GND, b11 ) inv(b11_n.Bth11.7, b11 )#5 and2(w0.Bth11.7, b11_n.Bth11.7, GND )#5 and2(w1.Bth11.7, b11, GND )#5 or2(PP_11_7, w0.Bth11.7, w1.Bth11.7 )#5 // end mux2x1 Bth11.7 end netlist // mux2x1 Bth11.8( PP_11_8, GND, GND, b11 ) inv(b11_n.Bth11.8, b11 )#5 and2(w0.Bth11.8, b11_n.Bth11.8, GND )#5 and2(w1.Bth11.8, b11, GND )#5 or2(PP_11_8, w0.Bth11.8, w1.Bth11.8 )#5 // end mux2x1 Bth11.8 end netlist // mux2x1 Bth11.9( PP_11_9, GND, GND, b11 ) inv(b11_n.Bth11.9, b11 )#5 and2(w0.Bth11.9, b11_n.Bth11.9, GND )#5 and2(w1.Bth11.9, b11, GND )#5 or2(PP_11_9, w0.Bth11.9, w1.Bth11.9 )#5 // end mux2x1 Bth11.9 end netlist // mux2x1 Bth11.10( PP_11_10, GND, GND, b11 ) inv(b11_n.Bth11.10, b11 )#5 and2(w0.Bth11.10, b11_n.Bth11.10, GND )#5 and2(w1.Bth11.10, b11, GND )#5 or2(PP_11_10, w0.Bth11.10, w1.Bth11.10 )#5 // end mux2x1 Bth11.10 end netlist // mux2x1 Bth11.11( PP_11_11, GND, a0, b11 ) inv(b11_n.Bth11.11, b11 )#5 and2(w0.Bth11.11, b11_n.Bth11.11, GND )#5 and2(w1.Bth11.11, b11, a0 )#5 or2(PP_11_11, w0.Bth11.11, w1.Bth11.11 )#5 // end mux2x1 Bth11.11 end netlist // mux2x1 Bth11.12( PP_11_12, GND, a1, b11 ) inv(b11_n.Bth11.12, b11 )#5 and2(w0.Bth11.12, b11_n.Bth11.12, GND )#5 and2(w1.Bth11.12, b11, a1 )#5 or2(PP_11_12, w0.Bth11.12, w1.Bth11.12 )#5 // end mux2x1 Bth11.12 end netlist // mux2x1 Bth11.13( PP_11_13, GND, a2, b11 ) inv(b11_n.Bth11.13, b11 )#5 and2(w0.Bth11.13, b11_n.Bth11.13, GND )#5 and2(w1.Bth11.13, b11, a2 )#5 or2(PP_11_13, w0.Bth11.13, w1.Bth11.13 )#5 // end mux2x1 Bth11.13 end netlist // mux2x1 Bth11.14( PP_11_14, GND, a3, b11 ) inv(b11_n.Bth11.14, b11 )#5 and2(w0.Bth11.14, b11_n.Bth11.14, GND )#5 and2(w1.Bth11.14, b11, a3 )#5 or2(PP_11_14, w0.Bth11.14, w1.Bth11.14 )#5 // end mux2x1 Bth11.14 end netlist // mux2x1 Bth11.15( PP_11_15, GND, a4, b11 ) inv(b11_n.Bth11.15, b11 )#5 and2(w0.Bth11.15, b11_n.Bth11.15, GND )#5 and2(w1.Bth11.15, b11, a4 )#5 or2(PP_11_15, w0.Bth11.15, w1.Bth11.15 )#5 // end mux2x1 Bth11.15 end netlist // mux2x1 Bth11.16( PP_11_16, GND, a5, b11 ) inv(b11_n.Bth11.16, b11 )#5 and2(w0.Bth11.16, b11_n.Bth11.16, GND )#5 and2(w1.Bth11.16, b11, a5 )#5 or2(PP_11_16, w0.Bth11.16, w1.Bth11.16 )#5 // end mux2x1 Bth11.16 end netlist // mux2x1 Bth11.17( PP_11_17, GND, a6, b11 ) inv(b11_n.Bth11.17, b11 )#5 and2(w0.Bth11.17, b11_n.Bth11.17, GND )#5 and2(w1.Bth11.17, b11, a6 )#5 or2(PP_11_17, w0.Bth11.17, w1.Bth11.17 )#5 // end mux2x1 Bth11.17 end netlist // mux2x1 Bth11.18( PP_11_18, GND, a7, b11 ) inv(b11_n.Bth11.18, b11 )#5 and2(w0.Bth11.18, b11_n.Bth11.18, GND )#5 and2(w1.Bth11.18, b11, a7 )#5 or2(PP_11_18, w0.Bth11.18, w1.Bth11.18 )#5 // end mux2x1 Bth11.18 end netlist // mux2x1 Bth11.19( PP_11_19, GND, a8, b11 ) inv(b11_n.Bth11.19, b11 )#5 and2(w0.Bth11.19, b11_n.Bth11.19, GND )#5 and2(w1.Bth11.19, b11, a8 )#5 or2(PP_11_19, w0.Bth11.19, w1.Bth11.19 )#5 // end mux2x1 Bth11.19 end netlist // mux2x1 Bth11.20( PP_11_20, GND, a9, b11 ) inv(b11_n.Bth11.20, b11 )#5 and2(w0.Bth11.20, b11_n.Bth11.20, GND )#5 and2(w1.Bth11.20, b11, a9 )#5 or2(PP_11_20, w0.Bth11.20, w1.Bth11.20 )#5 // end mux2x1 Bth11.20 end netlist // mux2x1 Bth11.21( PP_11_21, GND, a10, b11 ) inv(b11_n.Bth11.21, b11 )#5 and2(w0.Bth11.21, b11_n.Bth11.21, GND )#5 and2(w1.Bth11.21, b11, a10 )#5 or2(PP_11_21, w0.Bth11.21, w1.Bth11.21 )#5 // end mux2x1 Bth11.21 end netlist // mux2x1 Bth11.22( PP_11_22, GND, a11, b11 ) inv(b11_n.Bth11.22, b11 )#5 and2(w0.Bth11.22, b11_n.Bth11.22, GND )#5 and2(w1.Bth11.22, b11, a11 )#5 or2(PP_11_22, w0.Bth11.22, w1.Bth11.22 )#5 // end mux2x1 Bth11.22 end netlist // mux2x1 Bth11.23( PP_11_23, GND, GND, b11 ) inv(b11_n.Bth11.23, b11 )#5 and2(w0.Bth11.23, b11_n.Bth11.23, GND )#5 and2(w1.Bth11.23, b11, GND )#5 or2(PP_11_23, w0.Bth11.23, w1.Bth11.23 )#5 // end mux2x1 Bth11.23 end // instantiating csa4x2Vec at lvl 0 netlist // csa4x2 (csa4x2_0_lvl0.0, s0_lvl0_0,t0_lvl0_0,cout_csa4x2_0_lvl0.0,PP_0_0,PP_1_0,PP_2_0,PP_3_0,GND) ; // adder1bit Adder0.csa4x2_0_lvl0.0( sintcsa4x2_0_lvl0.0, cout_csa4x2_0_lvl0.0, PP_0_0, PP_1_0, PP_2_0) // sum xor2( w0.Adder0.csa4x2_0_lvl0.0, PP_0_0, PP_1_0 )#5 xor2( sintcsa4x2_0_lvl0.0, w0.Adder0.csa4x2_0_lvl0.0, PP_2_0 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.0, PP_0_0, PP_1_0 )#5 and2( w2.Adder0.csa4x2_0_lvl0.0, w0.Adder0.csa4x2_0_lvl0.0, PP_2_0 )#5 or2( cout_csa4x2_0_lvl0.0, w1.Adder0.csa4x2_0_lvl0.0, w2.Adder0.csa4x2_0_lvl0.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.0( s0_lvl0_0, t0_lvl0_0, sintcsa4x2_0_lvl0.0, PP_3_0, GND) // sum xor2( w0.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, PP_3_0 )#5 xor2( s0_lvl0_0, w0.Adder1.csa4x2_0_lvl0.0, GND )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, PP_3_0 )#5 and2( w2.Adder1.csa4x2_0_lvl0.0, w0.Adder1.csa4x2_0_lvl0.0, GND )#5 or2( t0_lvl0_0, w1.Adder1.csa4x2_0_lvl0.0, w2.Adder1.csa4x2_0_lvl0.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.1, s0_lvl0_1,t0_lvl0_1,cout_csa4x2_0_lvl0.1,PP_0_1,PP_1_1,PP_2_1,PP_3_1,cout_csa4x2_0_lvl0.0) ; // adder1bit Adder0.csa4x2_0_lvl0.1( sintcsa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.1, PP_0_1, PP_1_1, PP_2_1) // sum xor2( w0.Adder0.csa4x2_0_lvl0.1, PP_0_1, PP_1_1 )#5 xor2( sintcsa4x2_0_lvl0.1, w0.Adder0.csa4x2_0_lvl0.1, PP_2_1 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.1, PP_0_1, PP_1_1 )#5 and2( w2.Adder0.csa4x2_0_lvl0.1, w0.Adder0.csa4x2_0_lvl0.1, PP_2_1 )#5 or2( cout_csa4x2_0_lvl0.1, w1.Adder0.csa4x2_0_lvl0.1, w2.Adder0.csa4x2_0_lvl0.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.1( s0_lvl0_1, t0_lvl0_1, sintcsa4x2_0_lvl0.1, PP_3_1, cout_csa4x2_0_lvl0.0) // sum xor2( w0.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, PP_3_1 )#5 xor2( s0_lvl0_1, w0.Adder1.csa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, PP_3_1 )#5 and2( w2.Adder1.csa4x2_0_lvl0.1, w0.Adder1.csa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0 )#5 or2( t0_lvl0_1, w1.Adder1.csa4x2_0_lvl0.1, w2.Adder1.csa4x2_0_lvl0.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.2, s0_lvl0_2,t0_lvl0_2,cout_csa4x2_0_lvl0.2,PP_0_2,PP_1_2,PP_2_2,PP_3_2,cout_csa4x2_0_lvl0.1) ; // adder1bit Adder0.csa4x2_0_lvl0.2( sintcsa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.2, PP_0_2, PP_1_2, PP_2_2) // sum xor2( w0.Adder0.csa4x2_0_lvl0.2, PP_0_2, PP_1_2 )#5 xor2( sintcsa4x2_0_lvl0.2, w0.Adder0.csa4x2_0_lvl0.2, PP_2_2 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.2, PP_0_2, PP_1_2 )#5 and2( w2.Adder0.csa4x2_0_lvl0.2, w0.Adder0.csa4x2_0_lvl0.2, PP_2_2 )#5 or2( cout_csa4x2_0_lvl0.2, w1.Adder0.csa4x2_0_lvl0.2, w2.Adder0.csa4x2_0_lvl0.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.2( s0_lvl0_2, t0_lvl0_2, sintcsa4x2_0_lvl0.2, PP_3_2, cout_csa4x2_0_lvl0.1) // sum xor2( w0.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, PP_3_2 )#5 xor2( s0_lvl0_2, w0.Adder1.csa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, PP_3_2 )#5 and2( w2.Adder1.csa4x2_0_lvl0.2, w0.Adder1.csa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1 )#5 or2( t0_lvl0_2, w1.Adder1.csa4x2_0_lvl0.2, w2.Adder1.csa4x2_0_lvl0.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.3, s0_lvl0_3,t0_lvl0_3,cout_csa4x2_0_lvl0.3,PP_0_3,PP_1_3,PP_2_3,PP_3_3,cout_csa4x2_0_lvl0.2) ; // adder1bit Adder0.csa4x2_0_lvl0.3( sintcsa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.3, PP_0_3, PP_1_3, PP_2_3) // sum xor2( w0.Adder0.csa4x2_0_lvl0.3, PP_0_3, PP_1_3 )#5 xor2( sintcsa4x2_0_lvl0.3, w0.Adder0.csa4x2_0_lvl0.3, PP_2_3 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.3, PP_0_3, PP_1_3 )#5 and2( w2.Adder0.csa4x2_0_lvl0.3, w0.Adder0.csa4x2_0_lvl0.3, PP_2_3 )#5 or2( cout_csa4x2_0_lvl0.3, w1.Adder0.csa4x2_0_lvl0.3, w2.Adder0.csa4x2_0_lvl0.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.3( s0_lvl0_3, t0_lvl0_3, sintcsa4x2_0_lvl0.3, PP_3_3, cout_csa4x2_0_lvl0.2) // sum xor2( w0.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, PP_3_3 )#5 xor2( s0_lvl0_3, w0.Adder1.csa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, PP_3_3 )#5 and2( w2.Adder1.csa4x2_0_lvl0.3, w0.Adder1.csa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2 )#5 or2( t0_lvl0_3, w1.Adder1.csa4x2_0_lvl0.3, w2.Adder1.csa4x2_0_lvl0.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.4, s0_lvl0_4,t0_lvl0_4,cout_csa4x2_0_lvl0.4,PP_0_4,PP_1_4,PP_2_4,PP_3_4,cout_csa4x2_0_lvl0.3) ; // adder1bit Adder0.csa4x2_0_lvl0.4( sintcsa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.4, PP_0_4, PP_1_4, PP_2_4) // sum xor2( w0.Adder0.csa4x2_0_lvl0.4, PP_0_4, PP_1_4 )#5 xor2( sintcsa4x2_0_lvl0.4, w0.Adder0.csa4x2_0_lvl0.4, PP_2_4 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.4, PP_0_4, PP_1_4 )#5 and2( w2.Adder0.csa4x2_0_lvl0.4, w0.Adder0.csa4x2_0_lvl0.4, PP_2_4 )#5 or2( cout_csa4x2_0_lvl0.4, w1.Adder0.csa4x2_0_lvl0.4, w2.Adder0.csa4x2_0_lvl0.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.4( s0_lvl0_4, t0_lvl0_4, sintcsa4x2_0_lvl0.4, PP_3_4, cout_csa4x2_0_lvl0.3) // sum xor2( w0.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, PP_3_4 )#5 xor2( s0_lvl0_4, w0.Adder1.csa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, PP_3_4 )#5 and2( w2.Adder1.csa4x2_0_lvl0.4, w0.Adder1.csa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3 )#5 or2( t0_lvl0_4, w1.Adder1.csa4x2_0_lvl0.4, w2.Adder1.csa4x2_0_lvl0.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.5, s0_lvl0_5,t0_lvl0_5,cout_csa4x2_0_lvl0.5,PP_0_5,PP_1_5,PP_2_5,PP_3_5,cout_csa4x2_0_lvl0.4) ; // adder1bit Adder0.csa4x2_0_lvl0.5( sintcsa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.5, PP_0_5, PP_1_5, PP_2_5) // sum xor2( w0.Adder0.csa4x2_0_lvl0.5, PP_0_5, PP_1_5 )#5 xor2( sintcsa4x2_0_lvl0.5, w0.Adder0.csa4x2_0_lvl0.5, PP_2_5 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.5, PP_0_5, PP_1_5 )#5 and2( w2.Adder0.csa4x2_0_lvl0.5, w0.Adder0.csa4x2_0_lvl0.5, PP_2_5 )#5 or2( cout_csa4x2_0_lvl0.5, w1.Adder0.csa4x2_0_lvl0.5, w2.Adder0.csa4x2_0_lvl0.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.5( s0_lvl0_5, t0_lvl0_5, sintcsa4x2_0_lvl0.5, PP_3_5, cout_csa4x2_0_lvl0.4) // sum xor2( w0.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, PP_3_5 )#5 xor2( s0_lvl0_5, w0.Adder1.csa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, PP_3_5 )#5 and2( w2.Adder1.csa4x2_0_lvl0.5, w0.Adder1.csa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4 )#5 or2( t0_lvl0_5, w1.Adder1.csa4x2_0_lvl0.5, w2.Adder1.csa4x2_0_lvl0.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.6, s0_lvl0_6,t0_lvl0_6,cout_csa4x2_0_lvl0.6,PP_0_6,PP_1_6,PP_2_6,PP_3_6,cout_csa4x2_0_lvl0.5) ; // adder1bit Adder0.csa4x2_0_lvl0.6( sintcsa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.6, PP_0_6, PP_1_6, PP_2_6) // sum xor2( w0.Adder0.csa4x2_0_lvl0.6, PP_0_6, PP_1_6 )#5 xor2( sintcsa4x2_0_lvl0.6, w0.Adder0.csa4x2_0_lvl0.6, PP_2_6 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.6, PP_0_6, PP_1_6 )#5 and2( w2.Adder0.csa4x2_0_lvl0.6, w0.Adder0.csa4x2_0_lvl0.6, PP_2_6 )#5 or2( cout_csa4x2_0_lvl0.6, w1.Adder0.csa4x2_0_lvl0.6, w2.Adder0.csa4x2_0_lvl0.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.6( s0_lvl0_6, t0_lvl0_6, sintcsa4x2_0_lvl0.6, PP_3_6, cout_csa4x2_0_lvl0.5) // sum xor2( w0.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, PP_3_6 )#5 xor2( s0_lvl0_6, w0.Adder1.csa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, PP_3_6 )#5 and2( w2.Adder1.csa4x2_0_lvl0.6, w0.Adder1.csa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5 )#5 or2( t0_lvl0_6, w1.Adder1.csa4x2_0_lvl0.6, w2.Adder1.csa4x2_0_lvl0.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.7, s0_lvl0_7,t0_lvl0_7,cout_csa4x2_0_lvl0.7,PP_0_7,PP_1_7,PP_2_7,PP_3_7,cout_csa4x2_0_lvl0.6) ; // adder1bit Adder0.csa4x2_0_lvl0.7( sintcsa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.7, PP_0_7, PP_1_7, PP_2_7) // sum xor2( w0.Adder0.csa4x2_0_lvl0.7, PP_0_7, PP_1_7 )#5 xor2( sintcsa4x2_0_lvl0.7, w0.Adder0.csa4x2_0_lvl0.7, PP_2_7 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.7, PP_0_7, PP_1_7 )#5 and2( w2.Adder0.csa4x2_0_lvl0.7, w0.Adder0.csa4x2_0_lvl0.7, PP_2_7 )#5 or2( cout_csa4x2_0_lvl0.7, w1.Adder0.csa4x2_0_lvl0.7, w2.Adder0.csa4x2_0_lvl0.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.7( s0_lvl0_7, t0_lvl0_7, sintcsa4x2_0_lvl0.7, PP_3_7, cout_csa4x2_0_lvl0.6) // sum xor2( w0.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, PP_3_7 )#5 xor2( s0_lvl0_7, w0.Adder1.csa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, PP_3_7 )#5 and2( w2.Adder1.csa4x2_0_lvl0.7, w0.Adder1.csa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6 )#5 or2( t0_lvl0_7, w1.Adder1.csa4x2_0_lvl0.7, w2.Adder1.csa4x2_0_lvl0.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.8, s0_lvl0_8,t0_lvl0_8,cout_csa4x2_0_lvl0.8,PP_0_8,PP_1_8,PP_2_8,PP_3_8,cout_csa4x2_0_lvl0.7) ; // adder1bit Adder0.csa4x2_0_lvl0.8( sintcsa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.8, PP_0_8, PP_1_8, PP_2_8) // sum xor2( w0.Adder0.csa4x2_0_lvl0.8, PP_0_8, PP_1_8 )#5 xor2( sintcsa4x2_0_lvl0.8, w0.Adder0.csa4x2_0_lvl0.8, PP_2_8 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.8, PP_0_8, PP_1_8 )#5 and2( w2.Adder0.csa4x2_0_lvl0.8, w0.Adder0.csa4x2_0_lvl0.8, PP_2_8 )#5 or2( cout_csa4x2_0_lvl0.8, w1.Adder0.csa4x2_0_lvl0.8, w2.Adder0.csa4x2_0_lvl0.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.8( s0_lvl0_8, t0_lvl0_8, sintcsa4x2_0_lvl0.8, PP_3_8, cout_csa4x2_0_lvl0.7) // sum xor2( w0.Adder1.csa4x2_0_lvl0.8, sintcsa4x2_0_lvl0.8, PP_3_8 )#5 xor2( s0_lvl0_8, w0.Adder1.csa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.7 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.8, sintcsa4x2_0_lvl0.8, PP_3_8 )#5 and2( w2.Adder1.csa4x2_0_lvl0.8, w0.Adder1.csa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.7 )#5 or2( t0_lvl0_8, w1.Adder1.csa4x2_0_lvl0.8, w2.Adder1.csa4x2_0_lvl0.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.9, s0_lvl0_9,t0_lvl0_9,cout_csa4x2_0_lvl0.9,PP_0_9,PP_1_9,PP_2_9,PP_3_9,cout_csa4x2_0_lvl0.8) ; // adder1bit Adder0.csa4x2_0_lvl0.9( sintcsa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.9, PP_0_9, PP_1_9, PP_2_9) // sum xor2( w0.Adder0.csa4x2_0_lvl0.9, PP_0_9, PP_1_9 )#5 xor2( sintcsa4x2_0_lvl0.9, w0.Adder0.csa4x2_0_lvl0.9, PP_2_9 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.9, PP_0_9, PP_1_9 )#5 and2( w2.Adder0.csa4x2_0_lvl0.9, w0.Adder0.csa4x2_0_lvl0.9, PP_2_9 )#5 or2( cout_csa4x2_0_lvl0.9, w1.Adder0.csa4x2_0_lvl0.9, w2.Adder0.csa4x2_0_lvl0.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.9( s0_lvl0_9, t0_lvl0_9, sintcsa4x2_0_lvl0.9, PP_3_9, cout_csa4x2_0_lvl0.8) // sum xor2( w0.Adder1.csa4x2_0_lvl0.9, sintcsa4x2_0_lvl0.9, PP_3_9 )#5 xor2( s0_lvl0_9, w0.Adder1.csa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.8 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.9, sintcsa4x2_0_lvl0.9, PP_3_9 )#5 and2( w2.Adder1.csa4x2_0_lvl0.9, w0.Adder1.csa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.8 )#5 or2( t0_lvl0_9, w1.Adder1.csa4x2_0_lvl0.9, w2.Adder1.csa4x2_0_lvl0.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.10, s0_lvl0_10,t0_lvl0_10,cout_csa4x2_0_lvl0.10,PP_0_10,PP_1_10,PP_2_10,PP_3_10,cout_csa4x2_0_lvl0.9) ; // adder1bit Adder0.csa4x2_0_lvl0.10( sintcsa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.10, PP_0_10, PP_1_10, PP_2_10) // sum xor2( w0.Adder0.csa4x2_0_lvl0.10, PP_0_10, PP_1_10 )#5 xor2( sintcsa4x2_0_lvl0.10, w0.Adder0.csa4x2_0_lvl0.10, PP_2_10 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.10, PP_0_10, PP_1_10 )#5 and2( w2.Adder0.csa4x2_0_lvl0.10, w0.Adder0.csa4x2_0_lvl0.10, PP_2_10 )#5 or2( cout_csa4x2_0_lvl0.10, w1.Adder0.csa4x2_0_lvl0.10, w2.Adder0.csa4x2_0_lvl0.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.10( s0_lvl0_10, t0_lvl0_10, sintcsa4x2_0_lvl0.10, PP_3_10, cout_csa4x2_0_lvl0.9) // sum xor2( w0.Adder1.csa4x2_0_lvl0.10, sintcsa4x2_0_lvl0.10, PP_3_10 )#5 xor2( s0_lvl0_10, w0.Adder1.csa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.9 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.10, sintcsa4x2_0_lvl0.10, PP_3_10 )#5 and2( w2.Adder1.csa4x2_0_lvl0.10, w0.Adder1.csa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.9 )#5 or2( t0_lvl0_10, w1.Adder1.csa4x2_0_lvl0.10, w2.Adder1.csa4x2_0_lvl0.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.11, s0_lvl0_11,t0_lvl0_11,cout_csa4x2_0_lvl0.11,PP_0_11,PP_1_11,PP_2_11,PP_3_11,cout_csa4x2_0_lvl0.10) ; // adder1bit Adder0.csa4x2_0_lvl0.11( sintcsa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.11, PP_0_11, PP_1_11, PP_2_11) // sum xor2( w0.Adder0.csa4x2_0_lvl0.11, PP_0_11, PP_1_11 )#5 xor2( sintcsa4x2_0_lvl0.11, w0.Adder0.csa4x2_0_lvl0.11, PP_2_11 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.11, PP_0_11, PP_1_11 )#5 and2( w2.Adder0.csa4x2_0_lvl0.11, w0.Adder0.csa4x2_0_lvl0.11, PP_2_11 )#5 or2( cout_csa4x2_0_lvl0.11, w1.Adder0.csa4x2_0_lvl0.11, w2.Adder0.csa4x2_0_lvl0.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.11( s0_lvl0_11, t0_lvl0_11, sintcsa4x2_0_lvl0.11, PP_3_11, cout_csa4x2_0_lvl0.10) // sum xor2( w0.Adder1.csa4x2_0_lvl0.11, sintcsa4x2_0_lvl0.11, PP_3_11 )#5 xor2( s0_lvl0_11, w0.Adder1.csa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.10 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.11, sintcsa4x2_0_lvl0.11, PP_3_11 )#5 and2( w2.Adder1.csa4x2_0_lvl0.11, w0.Adder1.csa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.10 )#5 or2( t0_lvl0_11, w1.Adder1.csa4x2_0_lvl0.11, w2.Adder1.csa4x2_0_lvl0.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.12, s0_lvl0_12,t0_lvl0_12,cout_csa4x2_0_lvl0.12,PP_0_12,PP_1_12,PP_2_12,PP_3_12,cout_csa4x2_0_lvl0.11) ; // adder1bit Adder0.csa4x2_0_lvl0.12( sintcsa4x2_0_lvl0.12, cout_csa4x2_0_lvl0.12, PP_0_12, PP_1_12, PP_2_12) // sum xor2( w0.Adder0.csa4x2_0_lvl0.12, PP_0_12, PP_1_12 )#5 xor2( sintcsa4x2_0_lvl0.12, w0.Adder0.csa4x2_0_lvl0.12, PP_2_12 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.12, PP_0_12, PP_1_12 )#5 and2( w2.Adder0.csa4x2_0_lvl0.12, w0.Adder0.csa4x2_0_lvl0.12, PP_2_12 )#5 or2( cout_csa4x2_0_lvl0.12, w1.Adder0.csa4x2_0_lvl0.12, w2.Adder0.csa4x2_0_lvl0.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.12( s0_lvl0_12, t0_lvl0_12, sintcsa4x2_0_lvl0.12, PP_3_12, cout_csa4x2_0_lvl0.11) // sum xor2( w0.Adder1.csa4x2_0_lvl0.12, sintcsa4x2_0_lvl0.12, PP_3_12 )#5 xor2( s0_lvl0_12, w0.Adder1.csa4x2_0_lvl0.12, cout_csa4x2_0_lvl0.11 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.12, sintcsa4x2_0_lvl0.12, PP_3_12 )#5 and2( w2.Adder1.csa4x2_0_lvl0.12, w0.Adder1.csa4x2_0_lvl0.12, cout_csa4x2_0_lvl0.11 )#5 or2( t0_lvl0_12, w1.Adder1.csa4x2_0_lvl0.12, w2.Adder1.csa4x2_0_lvl0.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.13, s0_lvl0_13,t0_lvl0_13,cout_csa4x2_0_lvl0.13,PP_0_13,PP_1_13,PP_2_13,PP_3_13,cout_csa4x2_0_lvl0.12) ; // adder1bit Adder0.csa4x2_0_lvl0.13( sintcsa4x2_0_lvl0.13, cout_csa4x2_0_lvl0.13, PP_0_13, PP_1_13, PP_2_13) // sum xor2( w0.Adder0.csa4x2_0_lvl0.13, PP_0_13, PP_1_13 )#5 xor2( sintcsa4x2_0_lvl0.13, w0.Adder0.csa4x2_0_lvl0.13, PP_2_13 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.13, PP_0_13, PP_1_13 )#5 and2( w2.Adder0.csa4x2_0_lvl0.13, w0.Adder0.csa4x2_0_lvl0.13, PP_2_13 )#5 or2( cout_csa4x2_0_lvl0.13, w1.Adder0.csa4x2_0_lvl0.13, w2.Adder0.csa4x2_0_lvl0.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.13( s0_lvl0_13, t0_lvl0_13, sintcsa4x2_0_lvl0.13, PP_3_13, cout_csa4x2_0_lvl0.12) // sum xor2( w0.Adder1.csa4x2_0_lvl0.13, sintcsa4x2_0_lvl0.13, PP_3_13 )#5 xor2( s0_lvl0_13, w0.Adder1.csa4x2_0_lvl0.13, cout_csa4x2_0_lvl0.12 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.13, sintcsa4x2_0_lvl0.13, PP_3_13 )#5 and2( w2.Adder1.csa4x2_0_lvl0.13, w0.Adder1.csa4x2_0_lvl0.13, cout_csa4x2_0_lvl0.12 )#5 or2( t0_lvl0_13, w1.Adder1.csa4x2_0_lvl0.13, w2.Adder1.csa4x2_0_lvl0.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.14, s0_lvl0_14,t0_lvl0_14,cout_csa4x2_0_lvl0.14,PP_0_14,PP_1_14,PP_2_14,PP_3_14,cout_csa4x2_0_lvl0.13) ; // adder1bit Adder0.csa4x2_0_lvl0.14( sintcsa4x2_0_lvl0.14, cout_csa4x2_0_lvl0.14, PP_0_14, PP_1_14, PP_2_14) // sum xor2( w0.Adder0.csa4x2_0_lvl0.14, PP_0_14, PP_1_14 )#5 xor2( sintcsa4x2_0_lvl0.14, w0.Adder0.csa4x2_0_lvl0.14, PP_2_14 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.14, PP_0_14, PP_1_14 )#5 and2( w2.Adder0.csa4x2_0_lvl0.14, w0.Adder0.csa4x2_0_lvl0.14, PP_2_14 )#5 or2( cout_csa4x2_0_lvl0.14, w1.Adder0.csa4x2_0_lvl0.14, w2.Adder0.csa4x2_0_lvl0.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.14( s0_lvl0_14, t0_lvl0_14, sintcsa4x2_0_lvl0.14, PP_3_14, cout_csa4x2_0_lvl0.13) // sum xor2( w0.Adder1.csa4x2_0_lvl0.14, sintcsa4x2_0_lvl0.14, PP_3_14 )#5 xor2( s0_lvl0_14, w0.Adder1.csa4x2_0_lvl0.14, cout_csa4x2_0_lvl0.13 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.14, sintcsa4x2_0_lvl0.14, PP_3_14 )#5 and2( w2.Adder1.csa4x2_0_lvl0.14, w0.Adder1.csa4x2_0_lvl0.14, cout_csa4x2_0_lvl0.13 )#5 or2( t0_lvl0_14, w1.Adder1.csa4x2_0_lvl0.14, w2.Adder1.csa4x2_0_lvl0.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.15, s0_lvl0_15,t0_lvl0_15,cout_csa4x2_0_lvl0.15,PP_0_15,PP_1_15,PP_2_15,PP_3_15,cout_csa4x2_0_lvl0.14) ; // adder1bit Adder0.csa4x2_0_lvl0.15( sintcsa4x2_0_lvl0.15, cout_csa4x2_0_lvl0.15, PP_0_15, PP_1_15, PP_2_15) // sum xor2( w0.Adder0.csa4x2_0_lvl0.15, PP_0_15, PP_1_15 )#5 xor2( sintcsa4x2_0_lvl0.15, w0.Adder0.csa4x2_0_lvl0.15, PP_2_15 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.15, PP_0_15, PP_1_15 )#5 and2( w2.Adder0.csa4x2_0_lvl0.15, w0.Adder0.csa4x2_0_lvl0.15, PP_2_15 )#5 or2( cout_csa4x2_0_lvl0.15, w1.Adder0.csa4x2_0_lvl0.15, w2.Adder0.csa4x2_0_lvl0.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.15( s0_lvl0_15, t0_lvl0_15, sintcsa4x2_0_lvl0.15, PP_3_15, cout_csa4x2_0_lvl0.14) // sum xor2( w0.Adder1.csa4x2_0_lvl0.15, sintcsa4x2_0_lvl0.15, PP_3_15 )#5 xor2( s0_lvl0_15, w0.Adder1.csa4x2_0_lvl0.15, cout_csa4x2_0_lvl0.14 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.15, sintcsa4x2_0_lvl0.15, PP_3_15 )#5 and2( w2.Adder1.csa4x2_0_lvl0.15, w0.Adder1.csa4x2_0_lvl0.15, cout_csa4x2_0_lvl0.14 )#5 or2( t0_lvl0_15, w1.Adder1.csa4x2_0_lvl0.15, w2.Adder1.csa4x2_0_lvl0.15 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.16, s0_lvl0_16,t0_lvl0_16,cout_csa4x2_0_lvl0.16,PP_0_16,PP_1_16,PP_2_16,PP_3_16,cout_csa4x2_0_lvl0.15) ; // adder1bit Adder0.csa4x2_0_lvl0.16( sintcsa4x2_0_lvl0.16, cout_csa4x2_0_lvl0.16, PP_0_16, PP_1_16, PP_2_16) // sum xor2( w0.Adder0.csa4x2_0_lvl0.16, PP_0_16, PP_1_16 )#5 xor2( sintcsa4x2_0_lvl0.16, w0.Adder0.csa4x2_0_lvl0.16, PP_2_16 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.16, PP_0_16, PP_1_16 )#5 and2( w2.Adder0.csa4x2_0_lvl0.16, w0.Adder0.csa4x2_0_lvl0.16, PP_2_16 )#5 or2( cout_csa4x2_0_lvl0.16, w1.Adder0.csa4x2_0_lvl0.16, w2.Adder0.csa4x2_0_lvl0.16 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.16( s0_lvl0_16, t0_lvl0_16, sintcsa4x2_0_lvl0.16, PP_3_16, cout_csa4x2_0_lvl0.15) // sum xor2( w0.Adder1.csa4x2_0_lvl0.16, sintcsa4x2_0_lvl0.16, PP_3_16 )#5 xor2( s0_lvl0_16, w0.Adder1.csa4x2_0_lvl0.16, cout_csa4x2_0_lvl0.15 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.16, sintcsa4x2_0_lvl0.16, PP_3_16 )#5 and2( w2.Adder1.csa4x2_0_lvl0.16, w0.Adder1.csa4x2_0_lvl0.16, cout_csa4x2_0_lvl0.15 )#5 or2( t0_lvl0_16, w1.Adder1.csa4x2_0_lvl0.16, w2.Adder1.csa4x2_0_lvl0.16 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.17, s0_lvl0_17,t0_lvl0_17,cout_csa4x2_0_lvl0.17,PP_0_17,PP_1_17,PP_2_17,PP_3_17,cout_csa4x2_0_lvl0.16) ; // adder1bit Adder0.csa4x2_0_lvl0.17( sintcsa4x2_0_lvl0.17, cout_csa4x2_0_lvl0.17, PP_0_17, PP_1_17, PP_2_17) // sum xor2( w0.Adder0.csa4x2_0_lvl0.17, PP_0_17, PP_1_17 )#5 xor2( sintcsa4x2_0_lvl0.17, w0.Adder0.csa4x2_0_lvl0.17, PP_2_17 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.17, PP_0_17, PP_1_17 )#5 and2( w2.Adder0.csa4x2_0_lvl0.17, w0.Adder0.csa4x2_0_lvl0.17, PP_2_17 )#5 or2( cout_csa4x2_0_lvl0.17, w1.Adder0.csa4x2_0_lvl0.17, w2.Adder0.csa4x2_0_lvl0.17 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.17( s0_lvl0_17, t0_lvl0_17, sintcsa4x2_0_lvl0.17, PP_3_17, cout_csa4x2_0_lvl0.16) // sum xor2( w0.Adder1.csa4x2_0_lvl0.17, sintcsa4x2_0_lvl0.17, PP_3_17 )#5 xor2( s0_lvl0_17, w0.Adder1.csa4x2_0_lvl0.17, cout_csa4x2_0_lvl0.16 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.17, sintcsa4x2_0_lvl0.17, PP_3_17 )#5 and2( w2.Adder1.csa4x2_0_lvl0.17, w0.Adder1.csa4x2_0_lvl0.17, cout_csa4x2_0_lvl0.16 )#5 or2( t0_lvl0_17, w1.Adder1.csa4x2_0_lvl0.17, w2.Adder1.csa4x2_0_lvl0.17 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.18, s0_lvl0_18,t0_lvl0_18,cout_csa4x2_0_lvl0.18,PP_0_18,PP_1_18,PP_2_18,PP_3_18,cout_csa4x2_0_lvl0.17) ; // adder1bit Adder0.csa4x2_0_lvl0.18( sintcsa4x2_0_lvl0.18, cout_csa4x2_0_lvl0.18, PP_0_18, PP_1_18, PP_2_18) // sum xor2( w0.Adder0.csa4x2_0_lvl0.18, PP_0_18, PP_1_18 )#5 xor2( sintcsa4x2_0_lvl0.18, w0.Adder0.csa4x2_0_lvl0.18, PP_2_18 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.18, PP_0_18, PP_1_18 )#5 and2( w2.Adder0.csa4x2_0_lvl0.18, w0.Adder0.csa4x2_0_lvl0.18, PP_2_18 )#5 or2( cout_csa4x2_0_lvl0.18, w1.Adder0.csa4x2_0_lvl0.18, w2.Adder0.csa4x2_0_lvl0.18 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.18( s0_lvl0_18, t0_lvl0_18, sintcsa4x2_0_lvl0.18, PP_3_18, cout_csa4x2_0_lvl0.17) // sum xor2( w0.Adder1.csa4x2_0_lvl0.18, sintcsa4x2_0_lvl0.18, PP_3_18 )#5 xor2( s0_lvl0_18, w0.Adder1.csa4x2_0_lvl0.18, cout_csa4x2_0_lvl0.17 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.18, sintcsa4x2_0_lvl0.18, PP_3_18 )#5 and2( w2.Adder1.csa4x2_0_lvl0.18, w0.Adder1.csa4x2_0_lvl0.18, cout_csa4x2_0_lvl0.17 )#5 or2( t0_lvl0_18, w1.Adder1.csa4x2_0_lvl0.18, w2.Adder1.csa4x2_0_lvl0.18 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.19, s0_lvl0_19,t0_lvl0_19,cout_csa4x2_0_lvl0.19,PP_0_19,PP_1_19,PP_2_19,PP_3_19,cout_csa4x2_0_lvl0.18) ; // adder1bit Adder0.csa4x2_0_lvl0.19( sintcsa4x2_0_lvl0.19, cout_csa4x2_0_lvl0.19, PP_0_19, PP_1_19, PP_2_19) // sum xor2( w0.Adder0.csa4x2_0_lvl0.19, PP_0_19, PP_1_19 )#5 xor2( sintcsa4x2_0_lvl0.19, w0.Adder0.csa4x2_0_lvl0.19, PP_2_19 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.19, PP_0_19, PP_1_19 )#5 and2( w2.Adder0.csa4x2_0_lvl0.19, w0.Adder0.csa4x2_0_lvl0.19, PP_2_19 )#5 or2( cout_csa4x2_0_lvl0.19, w1.Adder0.csa4x2_0_lvl0.19, w2.Adder0.csa4x2_0_lvl0.19 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.19( s0_lvl0_19, t0_lvl0_19, sintcsa4x2_0_lvl0.19, PP_3_19, cout_csa4x2_0_lvl0.18) // sum xor2( w0.Adder1.csa4x2_0_lvl0.19, sintcsa4x2_0_lvl0.19, PP_3_19 )#5 xor2( s0_lvl0_19, w0.Adder1.csa4x2_0_lvl0.19, cout_csa4x2_0_lvl0.18 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.19, sintcsa4x2_0_lvl0.19, PP_3_19 )#5 and2( w2.Adder1.csa4x2_0_lvl0.19, w0.Adder1.csa4x2_0_lvl0.19, cout_csa4x2_0_lvl0.18 )#5 or2( t0_lvl0_19, w1.Adder1.csa4x2_0_lvl0.19, w2.Adder1.csa4x2_0_lvl0.19 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.20, s0_lvl0_20,t0_lvl0_20,cout_csa4x2_0_lvl0.20,PP_0_20,PP_1_20,PP_2_20,PP_3_20,cout_csa4x2_0_lvl0.19) ; // adder1bit Adder0.csa4x2_0_lvl0.20( sintcsa4x2_0_lvl0.20, cout_csa4x2_0_lvl0.20, PP_0_20, PP_1_20, PP_2_20) // sum xor2( w0.Adder0.csa4x2_0_lvl0.20, PP_0_20, PP_1_20 )#5 xor2( sintcsa4x2_0_lvl0.20, w0.Adder0.csa4x2_0_lvl0.20, PP_2_20 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.20, PP_0_20, PP_1_20 )#5 and2( w2.Adder0.csa4x2_0_lvl0.20, w0.Adder0.csa4x2_0_lvl0.20, PP_2_20 )#5 or2( cout_csa4x2_0_lvl0.20, w1.Adder0.csa4x2_0_lvl0.20, w2.Adder0.csa4x2_0_lvl0.20 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.20( s0_lvl0_20, t0_lvl0_20, sintcsa4x2_0_lvl0.20, PP_3_20, cout_csa4x2_0_lvl0.19) // sum xor2( w0.Adder1.csa4x2_0_lvl0.20, sintcsa4x2_0_lvl0.20, PP_3_20 )#5 xor2( s0_lvl0_20, w0.Adder1.csa4x2_0_lvl0.20, cout_csa4x2_0_lvl0.19 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.20, sintcsa4x2_0_lvl0.20, PP_3_20 )#5 and2( w2.Adder1.csa4x2_0_lvl0.20, w0.Adder1.csa4x2_0_lvl0.20, cout_csa4x2_0_lvl0.19 )#5 or2( t0_lvl0_20, w1.Adder1.csa4x2_0_lvl0.20, w2.Adder1.csa4x2_0_lvl0.20 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.21, s0_lvl0_21,t0_lvl0_21,cout_csa4x2_0_lvl0.21,PP_0_21,PP_1_21,PP_2_21,PP_3_21,cout_csa4x2_0_lvl0.20) ; // adder1bit Adder0.csa4x2_0_lvl0.21( sintcsa4x2_0_lvl0.21, cout_csa4x2_0_lvl0.21, PP_0_21, PP_1_21, PP_2_21) // sum xor2( w0.Adder0.csa4x2_0_lvl0.21, PP_0_21, PP_1_21 )#5 xor2( sintcsa4x2_0_lvl0.21, w0.Adder0.csa4x2_0_lvl0.21, PP_2_21 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.21, PP_0_21, PP_1_21 )#5 and2( w2.Adder0.csa4x2_0_lvl0.21, w0.Adder0.csa4x2_0_lvl0.21, PP_2_21 )#5 or2( cout_csa4x2_0_lvl0.21, w1.Adder0.csa4x2_0_lvl0.21, w2.Adder0.csa4x2_0_lvl0.21 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.21( s0_lvl0_21, t0_lvl0_21, sintcsa4x2_0_lvl0.21, PP_3_21, cout_csa4x2_0_lvl0.20) // sum xor2( w0.Adder1.csa4x2_0_lvl0.21, sintcsa4x2_0_lvl0.21, PP_3_21 )#5 xor2( s0_lvl0_21, w0.Adder1.csa4x2_0_lvl0.21, cout_csa4x2_0_lvl0.20 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.21, sintcsa4x2_0_lvl0.21, PP_3_21 )#5 and2( w2.Adder1.csa4x2_0_lvl0.21, w0.Adder1.csa4x2_0_lvl0.21, cout_csa4x2_0_lvl0.20 )#5 or2( t0_lvl0_21, w1.Adder1.csa4x2_0_lvl0.21, w2.Adder1.csa4x2_0_lvl0.21 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.22, s0_lvl0_22,t0_lvl0_22,cout_csa4x2_0_lvl0.22,PP_0_22,PP_1_22,PP_2_22,PP_3_22,cout_csa4x2_0_lvl0.21) ; // adder1bit Adder0.csa4x2_0_lvl0.22( sintcsa4x2_0_lvl0.22, cout_csa4x2_0_lvl0.22, PP_0_22, PP_1_22, PP_2_22) // sum xor2( w0.Adder0.csa4x2_0_lvl0.22, PP_0_22, PP_1_22 )#5 xor2( sintcsa4x2_0_lvl0.22, w0.Adder0.csa4x2_0_lvl0.22, PP_2_22 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.22, PP_0_22, PP_1_22 )#5 and2( w2.Adder0.csa4x2_0_lvl0.22, w0.Adder0.csa4x2_0_lvl0.22, PP_2_22 )#5 or2( cout_csa4x2_0_lvl0.22, w1.Adder0.csa4x2_0_lvl0.22, w2.Adder0.csa4x2_0_lvl0.22 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.22( s0_lvl0_22, t0_lvl0_22, sintcsa4x2_0_lvl0.22, PP_3_22, cout_csa4x2_0_lvl0.21) // sum xor2( w0.Adder1.csa4x2_0_lvl0.22, sintcsa4x2_0_lvl0.22, PP_3_22 )#5 xor2( s0_lvl0_22, w0.Adder1.csa4x2_0_lvl0.22, cout_csa4x2_0_lvl0.21 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.22, sintcsa4x2_0_lvl0.22, PP_3_22 )#5 and2( w2.Adder1.csa4x2_0_lvl0.22, w0.Adder1.csa4x2_0_lvl0.22, cout_csa4x2_0_lvl0.21 )#5 or2( t0_lvl0_22, w1.Adder1.csa4x2_0_lvl0.22, w2.Adder1.csa4x2_0_lvl0.22 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.23, s0_lvl0_23,t0_lvl0_23,cout_csa4x2_0_lvl0.23,PP_0_23,PP_1_23,PP_2_23,PP_3_23,cout_csa4x2_0_lvl0.22) ; // adder1bit Adder0.csa4x2_0_lvl0.23( sintcsa4x2_0_lvl0.23, cout_csa4x2_0_lvl0.23, PP_0_23, PP_1_23, PP_2_23) // sum xor2( w0.Adder0.csa4x2_0_lvl0.23, PP_0_23, PP_1_23 )#5 xor2( sintcsa4x2_0_lvl0.23, w0.Adder0.csa4x2_0_lvl0.23, PP_2_23 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.23, PP_0_23, PP_1_23 )#5 and2( w2.Adder0.csa4x2_0_lvl0.23, w0.Adder0.csa4x2_0_lvl0.23, PP_2_23 )#5 or2( cout_csa4x2_0_lvl0.23, w1.Adder0.csa4x2_0_lvl0.23, w2.Adder0.csa4x2_0_lvl0.23 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.23( s0_lvl0_23, t0_lvl0_23, sintcsa4x2_0_lvl0.23, PP_3_23, cout_csa4x2_0_lvl0.22) // sum xor2( w0.Adder1.csa4x2_0_lvl0.23, sintcsa4x2_0_lvl0.23, PP_3_23 )#5 xor2( s0_lvl0_23, w0.Adder1.csa4x2_0_lvl0.23, cout_csa4x2_0_lvl0.22 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.23, sintcsa4x2_0_lvl0.23, PP_3_23 )#5 and2( w2.Adder1.csa4x2_0_lvl0.23, w0.Adder1.csa4x2_0_lvl0.23, cout_csa4x2_0_lvl0.22 )#5 or2( t0_lvl0_23, w1.Adder1.csa4x2_0_lvl0.23, w2.Adder1.csa4x2_0_lvl0.23 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.0, s4_lvl0_0,t4_lvl0_0,cout_csa4x2_4_lvl0.0,PP_4_0,PP_5_0,PP_6_0,PP_7_0,GND) ; // adder1bit Adder0.csa4x2_4_lvl0.0( sintcsa4x2_4_lvl0.0, cout_csa4x2_4_lvl0.0, PP_4_0, PP_5_0, PP_6_0) // sum xor2( w0.Adder0.csa4x2_4_lvl0.0, PP_4_0, PP_5_0 )#5 xor2( sintcsa4x2_4_lvl0.0, w0.Adder0.csa4x2_4_lvl0.0, PP_6_0 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.0, PP_4_0, PP_5_0 )#5 and2( w2.Adder0.csa4x2_4_lvl0.0, w0.Adder0.csa4x2_4_lvl0.0, PP_6_0 )#5 or2( cout_csa4x2_4_lvl0.0, w1.Adder0.csa4x2_4_lvl0.0, w2.Adder0.csa4x2_4_lvl0.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.0( s4_lvl0_0, t4_lvl0_0, sintcsa4x2_4_lvl0.0, PP_7_0, GND) // sum xor2( w0.Adder1.csa4x2_4_lvl0.0, sintcsa4x2_4_lvl0.0, PP_7_0 )#5 xor2( s4_lvl0_0, w0.Adder1.csa4x2_4_lvl0.0, GND )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.0, sintcsa4x2_4_lvl0.0, PP_7_0 )#5 and2( w2.Adder1.csa4x2_4_lvl0.0, w0.Adder1.csa4x2_4_lvl0.0, GND )#5 or2( t4_lvl0_0, w1.Adder1.csa4x2_4_lvl0.0, w2.Adder1.csa4x2_4_lvl0.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.1, s4_lvl0_1,t4_lvl0_1,cout_csa4x2_4_lvl0.1,PP_4_1,PP_5_1,PP_6_1,PP_7_1,cout_csa4x2_4_lvl0.0) ; // adder1bit Adder0.csa4x2_4_lvl0.1( sintcsa4x2_4_lvl0.1, cout_csa4x2_4_lvl0.1, PP_4_1, PP_5_1, PP_6_1) // sum xor2( w0.Adder0.csa4x2_4_lvl0.1, PP_4_1, PP_5_1 )#5 xor2( sintcsa4x2_4_lvl0.1, w0.Adder0.csa4x2_4_lvl0.1, PP_6_1 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.1, PP_4_1, PP_5_1 )#5 and2( w2.Adder0.csa4x2_4_lvl0.1, w0.Adder0.csa4x2_4_lvl0.1, PP_6_1 )#5 or2( cout_csa4x2_4_lvl0.1, w1.Adder0.csa4x2_4_lvl0.1, w2.Adder0.csa4x2_4_lvl0.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.1( s4_lvl0_1, t4_lvl0_1, sintcsa4x2_4_lvl0.1, PP_7_1, cout_csa4x2_4_lvl0.0) // sum xor2( w0.Adder1.csa4x2_4_lvl0.1, sintcsa4x2_4_lvl0.1, PP_7_1 )#5 xor2( s4_lvl0_1, w0.Adder1.csa4x2_4_lvl0.1, cout_csa4x2_4_lvl0.0 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.1, sintcsa4x2_4_lvl0.1, PP_7_1 )#5 and2( w2.Adder1.csa4x2_4_lvl0.1, w0.Adder1.csa4x2_4_lvl0.1, cout_csa4x2_4_lvl0.0 )#5 or2( t4_lvl0_1, w1.Adder1.csa4x2_4_lvl0.1, w2.Adder1.csa4x2_4_lvl0.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.2, s4_lvl0_2,t4_lvl0_2,cout_csa4x2_4_lvl0.2,PP_4_2,PP_5_2,PP_6_2,PP_7_2,cout_csa4x2_4_lvl0.1) ; // adder1bit Adder0.csa4x2_4_lvl0.2( sintcsa4x2_4_lvl0.2, cout_csa4x2_4_lvl0.2, PP_4_2, PP_5_2, PP_6_2) // sum xor2( w0.Adder0.csa4x2_4_lvl0.2, PP_4_2, PP_5_2 )#5 xor2( sintcsa4x2_4_lvl0.2, w0.Adder0.csa4x2_4_lvl0.2, PP_6_2 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.2, PP_4_2, PP_5_2 )#5 and2( w2.Adder0.csa4x2_4_lvl0.2, w0.Adder0.csa4x2_4_lvl0.2, PP_6_2 )#5 or2( cout_csa4x2_4_lvl0.2, w1.Adder0.csa4x2_4_lvl0.2, w2.Adder0.csa4x2_4_lvl0.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.2( s4_lvl0_2, t4_lvl0_2, sintcsa4x2_4_lvl0.2, PP_7_2, cout_csa4x2_4_lvl0.1) // sum xor2( w0.Adder1.csa4x2_4_lvl0.2, sintcsa4x2_4_lvl0.2, PP_7_2 )#5 xor2( s4_lvl0_2, w0.Adder1.csa4x2_4_lvl0.2, cout_csa4x2_4_lvl0.1 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.2, sintcsa4x2_4_lvl0.2, PP_7_2 )#5 and2( w2.Adder1.csa4x2_4_lvl0.2, w0.Adder1.csa4x2_4_lvl0.2, cout_csa4x2_4_lvl0.1 )#5 or2( t4_lvl0_2, w1.Adder1.csa4x2_4_lvl0.2, w2.Adder1.csa4x2_4_lvl0.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.3, s4_lvl0_3,t4_lvl0_3,cout_csa4x2_4_lvl0.3,PP_4_3,PP_5_3,PP_6_3,PP_7_3,cout_csa4x2_4_lvl0.2) ; // adder1bit Adder0.csa4x2_4_lvl0.3( sintcsa4x2_4_lvl0.3, cout_csa4x2_4_lvl0.3, PP_4_3, PP_5_3, PP_6_3) // sum xor2( w0.Adder0.csa4x2_4_lvl0.3, PP_4_3, PP_5_3 )#5 xor2( sintcsa4x2_4_lvl0.3, w0.Adder0.csa4x2_4_lvl0.3, PP_6_3 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.3, PP_4_3, PP_5_3 )#5 and2( w2.Adder0.csa4x2_4_lvl0.3, w0.Adder0.csa4x2_4_lvl0.3, PP_6_3 )#5 or2( cout_csa4x2_4_lvl0.3, w1.Adder0.csa4x2_4_lvl0.3, w2.Adder0.csa4x2_4_lvl0.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.3( s4_lvl0_3, t4_lvl0_3, sintcsa4x2_4_lvl0.3, PP_7_3, cout_csa4x2_4_lvl0.2) // sum xor2( w0.Adder1.csa4x2_4_lvl0.3, sintcsa4x2_4_lvl0.3, PP_7_3 )#5 xor2( s4_lvl0_3, w0.Adder1.csa4x2_4_lvl0.3, cout_csa4x2_4_lvl0.2 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.3, sintcsa4x2_4_lvl0.3, PP_7_3 )#5 and2( w2.Adder1.csa4x2_4_lvl0.3, w0.Adder1.csa4x2_4_lvl0.3, cout_csa4x2_4_lvl0.2 )#5 or2( t4_lvl0_3, w1.Adder1.csa4x2_4_lvl0.3, w2.Adder1.csa4x2_4_lvl0.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.4, s4_lvl0_4,t4_lvl0_4,cout_csa4x2_4_lvl0.4,PP_4_4,PP_5_4,PP_6_4,PP_7_4,cout_csa4x2_4_lvl0.3) ; // adder1bit Adder0.csa4x2_4_lvl0.4( sintcsa4x2_4_lvl0.4, cout_csa4x2_4_lvl0.4, PP_4_4, PP_5_4, PP_6_4) // sum xor2( w0.Adder0.csa4x2_4_lvl0.4, PP_4_4, PP_5_4 )#5 xor2( sintcsa4x2_4_lvl0.4, w0.Adder0.csa4x2_4_lvl0.4, PP_6_4 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.4, PP_4_4, PP_5_4 )#5 and2( w2.Adder0.csa4x2_4_lvl0.4, w0.Adder0.csa4x2_4_lvl0.4, PP_6_4 )#5 or2( cout_csa4x2_4_lvl0.4, w1.Adder0.csa4x2_4_lvl0.4, w2.Adder0.csa4x2_4_lvl0.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.4( s4_lvl0_4, t4_lvl0_4, sintcsa4x2_4_lvl0.4, PP_7_4, cout_csa4x2_4_lvl0.3) // sum xor2( w0.Adder1.csa4x2_4_lvl0.4, sintcsa4x2_4_lvl0.4, PP_7_4 )#5 xor2( s4_lvl0_4, w0.Adder1.csa4x2_4_lvl0.4, cout_csa4x2_4_lvl0.3 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.4, sintcsa4x2_4_lvl0.4, PP_7_4 )#5 and2( w2.Adder1.csa4x2_4_lvl0.4, w0.Adder1.csa4x2_4_lvl0.4, cout_csa4x2_4_lvl0.3 )#5 or2( t4_lvl0_4, w1.Adder1.csa4x2_4_lvl0.4, w2.Adder1.csa4x2_4_lvl0.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.5, s4_lvl0_5,t4_lvl0_5,cout_csa4x2_4_lvl0.5,PP_4_5,PP_5_5,PP_6_5,PP_7_5,cout_csa4x2_4_lvl0.4) ; // adder1bit Adder0.csa4x2_4_lvl0.5( sintcsa4x2_4_lvl0.5, cout_csa4x2_4_lvl0.5, PP_4_5, PP_5_5, PP_6_5) // sum xor2( w0.Adder0.csa4x2_4_lvl0.5, PP_4_5, PP_5_5 )#5 xor2( sintcsa4x2_4_lvl0.5, w0.Adder0.csa4x2_4_lvl0.5, PP_6_5 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.5, PP_4_5, PP_5_5 )#5 and2( w2.Adder0.csa4x2_4_lvl0.5, w0.Adder0.csa4x2_4_lvl0.5, PP_6_5 )#5 or2( cout_csa4x2_4_lvl0.5, w1.Adder0.csa4x2_4_lvl0.5, w2.Adder0.csa4x2_4_lvl0.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.5( s4_lvl0_5, t4_lvl0_5, sintcsa4x2_4_lvl0.5, PP_7_5, cout_csa4x2_4_lvl0.4) // sum xor2( w0.Adder1.csa4x2_4_lvl0.5, sintcsa4x2_4_lvl0.5, PP_7_5 )#5 xor2( s4_lvl0_5, w0.Adder1.csa4x2_4_lvl0.5, cout_csa4x2_4_lvl0.4 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.5, sintcsa4x2_4_lvl0.5, PP_7_5 )#5 and2( w2.Adder1.csa4x2_4_lvl0.5, w0.Adder1.csa4x2_4_lvl0.5, cout_csa4x2_4_lvl0.4 )#5 or2( t4_lvl0_5, w1.Adder1.csa4x2_4_lvl0.5, w2.Adder1.csa4x2_4_lvl0.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.6, s4_lvl0_6,t4_lvl0_6,cout_csa4x2_4_lvl0.6,PP_4_6,PP_5_6,PP_6_6,PP_7_6,cout_csa4x2_4_lvl0.5) ; // adder1bit Adder0.csa4x2_4_lvl0.6( sintcsa4x2_4_lvl0.6, cout_csa4x2_4_lvl0.6, PP_4_6, PP_5_6, PP_6_6) // sum xor2( w0.Adder0.csa4x2_4_lvl0.6, PP_4_6, PP_5_6 )#5 xor2( sintcsa4x2_4_lvl0.6, w0.Adder0.csa4x2_4_lvl0.6, PP_6_6 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.6, PP_4_6, PP_5_6 )#5 and2( w2.Adder0.csa4x2_4_lvl0.6, w0.Adder0.csa4x2_4_lvl0.6, PP_6_6 )#5 or2( cout_csa4x2_4_lvl0.6, w1.Adder0.csa4x2_4_lvl0.6, w2.Adder0.csa4x2_4_lvl0.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.6( s4_lvl0_6, t4_lvl0_6, sintcsa4x2_4_lvl0.6, PP_7_6, cout_csa4x2_4_lvl0.5) // sum xor2( w0.Adder1.csa4x2_4_lvl0.6, sintcsa4x2_4_lvl0.6, PP_7_6 )#5 xor2( s4_lvl0_6, w0.Adder1.csa4x2_4_lvl0.6, cout_csa4x2_4_lvl0.5 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.6, sintcsa4x2_4_lvl0.6, PP_7_6 )#5 and2( w2.Adder1.csa4x2_4_lvl0.6, w0.Adder1.csa4x2_4_lvl0.6, cout_csa4x2_4_lvl0.5 )#5 or2( t4_lvl0_6, w1.Adder1.csa4x2_4_lvl0.6, w2.Adder1.csa4x2_4_lvl0.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.7, s4_lvl0_7,t4_lvl0_7,cout_csa4x2_4_lvl0.7,PP_4_7,PP_5_7,PP_6_7,PP_7_7,cout_csa4x2_4_lvl0.6) ; // adder1bit Adder0.csa4x2_4_lvl0.7( sintcsa4x2_4_lvl0.7, cout_csa4x2_4_lvl0.7, PP_4_7, PP_5_7, PP_6_7) // sum xor2( w0.Adder0.csa4x2_4_lvl0.7, PP_4_7, PP_5_7 )#5 xor2( sintcsa4x2_4_lvl0.7, w0.Adder0.csa4x2_4_lvl0.7, PP_6_7 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.7, PP_4_7, PP_5_7 )#5 and2( w2.Adder0.csa4x2_4_lvl0.7, w0.Adder0.csa4x2_4_lvl0.7, PP_6_7 )#5 or2( cout_csa4x2_4_lvl0.7, w1.Adder0.csa4x2_4_lvl0.7, w2.Adder0.csa4x2_4_lvl0.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.7( s4_lvl0_7, t4_lvl0_7, sintcsa4x2_4_lvl0.7, PP_7_7, cout_csa4x2_4_lvl0.6) // sum xor2( w0.Adder1.csa4x2_4_lvl0.7, sintcsa4x2_4_lvl0.7, PP_7_7 )#5 xor2( s4_lvl0_7, w0.Adder1.csa4x2_4_lvl0.7, cout_csa4x2_4_lvl0.6 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.7, sintcsa4x2_4_lvl0.7, PP_7_7 )#5 and2( w2.Adder1.csa4x2_4_lvl0.7, w0.Adder1.csa4x2_4_lvl0.7, cout_csa4x2_4_lvl0.6 )#5 or2( t4_lvl0_7, w1.Adder1.csa4x2_4_lvl0.7, w2.Adder1.csa4x2_4_lvl0.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.8, s4_lvl0_8,t4_lvl0_8,cout_csa4x2_4_lvl0.8,PP_4_8,PP_5_8,PP_6_8,PP_7_8,cout_csa4x2_4_lvl0.7) ; // adder1bit Adder0.csa4x2_4_lvl0.8( sintcsa4x2_4_lvl0.8, cout_csa4x2_4_lvl0.8, PP_4_8, PP_5_8, PP_6_8) // sum xor2( w0.Adder0.csa4x2_4_lvl0.8, PP_4_8, PP_5_8 )#5 xor2( sintcsa4x2_4_lvl0.8, w0.Adder0.csa4x2_4_lvl0.8, PP_6_8 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.8, PP_4_8, PP_5_8 )#5 and2( w2.Adder0.csa4x2_4_lvl0.8, w0.Adder0.csa4x2_4_lvl0.8, PP_6_8 )#5 or2( cout_csa4x2_4_lvl0.8, w1.Adder0.csa4x2_4_lvl0.8, w2.Adder0.csa4x2_4_lvl0.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.8( s4_lvl0_8, t4_lvl0_8, sintcsa4x2_4_lvl0.8, PP_7_8, cout_csa4x2_4_lvl0.7) // sum xor2( w0.Adder1.csa4x2_4_lvl0.8, sintcsa4x2_4_lvl0.8, PP_7_8 )#5 xor2( s4_lvl0_8, w0.Adder1.csa4x2_4_lvl0.8, cout_csa4x2_4_lvl0.7 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.8, sintcsa4x2_4_lvl0.8, PP_7_8 )#5 and2( w2.Adder1.csa4x2_4_lvl0.8, w0.Adder1.csa4x2_4_lvl0.8, cout_csa4x2_4_lvl0.7 )#5 or2( t4_lvl0_8, w1.Adder1.csa4x2_4_lvl0.8, w2.Adder1.csa4x2_4_lvl0.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.9, s4_lvl0_9,t4_lvl0_9,cout_csa4x2_4_lvl0.9,PP_4_9,PP_5_9,PP_6_9,PP_7_9,cout_csa4x2_4_lvl0.8) ; // adder1bit Adder0.csa4x2_4_lvl0.9( sintcsa4x2_4_lvl0.9, cout_csa4x2_4_lvl0.9, PP_4_9, PP_5_9, PP_6_9) // sum xor2( w0.Adder0.csa4x2_4_lvl0.9, PP_4_9, PP_5_9 )#5 xor2( sintcsa4x2_4_lvl0.9, w0.Adder0.csa4x2_4_lvl0.9, PP_6_9 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.9, PP_4_9, PP_5_9 )#5 and2( w2.Adder0.csa4x2_4_lvl0.9, w0.Adder0.csa4x2_4_lvl0.9, PP_6_9 )#5 or2( cout_csa4x2_4_lvl0.9, w1.Adder0.csa4x2_4_lvl0.9, w2.Adder0.csa4x2_4_lvl0.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.9( s4_lvl0_9, t4_lvl0_9, sintcsa4x2_4_lvl0.9, PP_7_9, cout_csa4x2_4_lvl0.8) // sum xor2( w0.Adder1.csa4x2_4_lvl0.9, sintcsa4x2_4_lvl0.9, PP_7_9 )#5 xor2( s4_lvl0_9, w0.Adder1.csa4x2_4_lvl0.9, cout_csa4x2_4_lvl0.8 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.9, sintcsa4x2_4_lvl0.9, PP_7_9 )#5 and2( w2.Adder1.csa4x2_4_lvl0.9, w0.Adder1.csa4x2_4_lvl0.9, cout_csa4x2_4_lvl0.8 )#5 or2( t4_lvl0_9, w1.Adder1.csa4x2_4_lvl0.9, w2.Adder1.csa4x2_4_lvl0.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.10, s4_lvl0_10,t4_lvl0_10,cout_csa4x2_4_lvl0.10,PP_4_10,PP_5_10,PP_6_10,PP_7_10,cout_csa4x2_4_lvl0.9) ; // adder1bit Adder0.csa4x2_4_lvl0.10( sintcsa4x2_4_lvl0.10, cout_csa4x2_4_lvl0.10, PP_4_10, PP_5_10, PP_6_10) // sum xor2( w0.Adder0.csa4x2_4_lvl0.10, PP_4_10, PP_5_10 )#5 xor2( sintcsa4x2_4_lvl0.10, w0.Adder0.csa4x2_4_lvl0.10, PP_6_10 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.10, PP_4_10, PP_5_10 )#5 and2( w2.Adder0.csa4x2_4_lvl0.10, w0.Adder0.csa4x2_4_lvl0.10, PP_6_10 )#5 or2( cout_csa4x2_4_lvl0.10, w1.Adder0.csa4x2_4_lvl0.10, w2.Adder0.csa4x2_4_lvl0.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.10( s4_lvl0_10, t4_lvl0_10, sintcsa4x2_4_lvl0.10, PP_7_10, cout_csa4x2_4_lvl0.9) // sum xor2( w0.Adder1.csa4x2_4_lvl0.10, sintcsa4x2_4_lvl0.10, PP_7_10 )#5 xor2( s4_lvl0_10, w0.Adder1.csa4x2_4_lvl0.10, cout_csa4x2_4_lvl0.9 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.10, sintcsa4x2_4_lvl0.10, PP_7_10 )#5 and2( w2.Adder1.csa4x2_4_lvl0.10, w0.Adder1.csa4x2_4_lvl0.10, cout_csa4x2_4_lvl0.9 )#5 or2( t4_lvl0_10, w1.Adder1.csa4x2_4_lvl0.10, w2.Adder1.csa4x2_4_lvl0.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.11, s4_lvl0_11,t4_lvl0_11,cout_csa4x2_4_lvl0.11,PP_4_11,PP_5_11,PP_6_11,PP_7_11,cout_csa4x2_4_lvl0.10) ; // adder1bit Adder0.csa4x2_4_lvl0.11( sintcsa4x2_4_lvl0.11, cout_csa4x2_4_lvl0.11, PP_4_11, PP_5_11, PP_6_11) // sum xor2( w0.Adder0.csa4x2_4_lvl0.11, PP_4_11, PP_5_11 )#5 xor2( sintcsa4x2_4_lvl0.11, w0.Adder0.csa4x2_4_lvl0.11, PP_6_11 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.11, PP_4_11, PP_5_11 )#5 and2( w2.Adder0.csa4x2_4_lvl0.11, w0.Adder0.csa4x2_4_lvl0.11, PP_6_11 )#5 or2( cout_csa4x2_4_lvl0.11, w1.Adder0.csa4x2_4_lvl0.11, w2.Adder0.csa4x2_4_lvl0.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.11( s4_lvl0_11, t4_lvl0_11, sintcsa4x2_4_lvl0.11, PP_7_11, cout_csa4x2_4_lvl0.10) // sum xor2( w0.Adder1.csa4x2_4_lvl0.11, sintcsa4x2_4_lvl0.11, PP_7_11 )#5 xor2( s4_lvl0_11, w0.Adder1.csa4x2_4_lvl0.11, cout_csa4x2_4_lvl0.10 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.11, sintcsa4x2_4_lvl0.11, PP_7_11 )#5 and2( w2.Adder1.csa4x2_4_lvl0.11, w0.Adder1.csa4x2_4_lvl0.11, cout_csa4x2_4_lvl0.10 )#5 or2( t4_lvl0_11, w1.Adder1.csa4x2_4_lvl0.11, w2.Adder1.csa4x2_4_lvl0.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.12, s4_lvl0_12,t4_lvl0_12,cout_csa4x2_4_lvl0.12,PP_4_12,PP_5_12,PP_6_12,PP_7_12,cout_csa4x2_4_lvl0.11) ; // adder1bit Adder0.csa4x2_4_lvl0.12( sintcsa4x2_4_lvl0.12, cout_csa4x2_4_lvl0.12, PP_4_12, PP_5_12, PP_6_12) // sum xor2( w0.Adder0.csa4x2_4_lvl0.12, PP_4_12, PP_5_12 )#5 xor2( sintcsa4x2_4_lvl0.12, w0.Adder0.csa4x2_4_lvl0.12, PP_6_12 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.12, PP_4_12, PP_5_12 )#5 and2( w2.Adder0.csa4x2_4_lvl0.12, w0.Adder0.csa4x2_4_lvl0.12, PP_6_12 )#5 or2( cout_csa4x2_4_lvl0.12, w1.Adder0.csa4x2_4_lvl0.12, w2.Adder0.csa4x2_4_lvl0.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.12( s4_lvl0_12, t4_lvl0_12, sintcsa4x2_4_lvl0.12, PP_7_12, cout_csa4x2_4_lvl0.11) // sum xor2( w0.Adder1.csa4x2_4_lvl0.12, sintcsa4x2_4_lvl0.12, PP_7_12 )#5 xor2( s4_lvl0_12, w0.Adder1.csa4x2_4_lvl0.12, cout_csa4x2_4_lvl0.11 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.12, sintcsa4x2_4_lvl0.12, PP_7_12 )#5 and2( w2.Adder1.csa4x2_4_lvl0.12, w0.Adder1.csa4x2_4_lvl0.12, cout_csa4x2_4_lvl0.11 )#5 or2( t4_lvl0_12, w1.Adder1.csa4x2_4_lvl0.12, w2.Adder1.csa4x2_4_lvl0.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.13, s4_lvl0_13,t4_lvl0_13,cout_csa4x2_4_lvl0.13,PP_4_13,PP_5_13,PP_6_13,PP_7_13,cout_csa4x2_4_lvl0.12) ; // adder1bit Adder0.csa4x2_4_lvl0.13( sintcsa4x2_4_lvl0.13, cout_csa4x2_4_lvl0.13, PP_4_13, PP_5_13, PP_6_13) // sum xor2( w0.Adder0.csa4x2_4_lvl0.13, PP_4_13, PP_5_13 )#5 xor2( sintcsa4x2_4_lvl0.13, w0.Adder0.csa4x2_4_lvl0.13, PP_6_13 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.13, PP_4_13, PP_5_13 )#5 and2( w2.Adder0.csa4x2_4_lvl0.13, w0.Adder0.csa4x2_4_lvl0.13, PP_6_13 )#5 or2( cout_csa4x2_4_lvl0.13, w1.Adder0.csa4x2_4_lvl0.13, w2.Adder0.csa4x2_4_lvl0.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.13( s4_lvl0_13, t4_lvl0_13, sintcsa4x2_4_lvl0.13, PP_7_13, cout_csa4x2_4_lvl0.12) // sum xor2( w0.Adder1.csa4x2_4_lvl0.13, sintcsa4x2_4_lvl0.13, PP_7_13 )#5 xor2( s4_lvl0_13, w0.Adder1.csa4x2_4_lvl0.13, cout_csa4x2_4_lvl0.12 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.13, sintcsa4x2_4_lvl0.13, PP_7_13 )#5 and2( w2.Adder1.csa4x2_4_lvl0.13, w0.Adder1.csa4x2_4_lvl0.13, cout_csa4x2_4_lvl0.12 )#5 or2( t4_lvl0_13, w1.Adder1.csa4x2_4_lvl0.13, w2.Adder1.csa4x2_4_lvl0.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.14, s4_lvl0_14,t4_lvl0_14,cout_csa4x2_4_lvl0.14,PP_4_14,PP_5_14,PP_6_14,PP_7_14,cout_csa4x2_4_lvl0.13) ; // adder1bit Adder0.csa4x2_4_lvl0.14( sintcsa4x2_4_lvl0.14, cout_csa4x2_4_lvl0.14, PP_4_14, PP_5_14, PP_6_14) // sum xor2( w0.Adder0.csa4x2_4_lvl0.14, PP_4_14, PP_5_14 )#5 xor2( sintcsa4x2_4_lvl0.14, w0.Adder0.csa4x2_4_lvl0.14, PP_6_14 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.14, PP_4_14, PP_5_14 )#5 and2( w2.Adder0.csa4x2_4_lvl0.14, w0.Adder0.csa4x2_4_lvl0.14, PP_6_14 )#5 or2( cout_csa4x2_4_lvl0.14, w1.Adder0.csa4x2_4_lvl0.14, w2.Adder0.csa4x2_4_lvl0.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.14( s4_lvl0_14, t4_lvl0_14, sintcsa4x2_4_lvl0.14, PP_7_14, cout_csa4x2_4_lvl0.13) // sum xor2( w0.Adder1.csa4x2_4_lvl0.14, sintcsa4x2_4_lvl0.14, PP_7_14 )#5 xor2( s4_lvl0_14, w0.Adder1.csa4x2_4_lvl0.14, cout_csa4x2_4_lvl0.13 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.14, sintcsa4x2_4_lvl0.14, PP_7_14 )#5 and2( w2.Adder1.csa4x2_4_lvl0.14, w0.Adder1.csa4x2_4_lvl0.14, cout_csa4x2_4_lvl0.13 )#5 or2( t4_lvl0_14, w1.Adder1.csa4x2_4_lvl0.14, w2.Adder1.csa4x2_4_lvl0.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.15, s4_lvl0_15,t4_lvl0_15,cout_csa4x2_4_lvl0.15,PP_4_15,PP_5_15,PP_6_15,PP_7_15,cout_csa4x2_4_lvl0.14) ; // adder1bit Adder0.csa4x2_4_lvl0.15( sintcsa4x2_4_lvl0.15, cout_csa4x2_4_lvl0.15, PP_4_15, PP_5_15, PP_6_15) // sum xor2( w0.Adder0.csa4x2_4_lvl0.15, PP_4_15, PP_5_15 )#5 xor2( sintcsa4x2_4_lvl0.15, w0.Adder0.csa4x2_4_lvl0.15, PP_6_15 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.15, PP_4_15, PP_5_15 )#5 and2( w2.Adder0.csa4x2_4_lvl0.15, w0.Adder0.csa4x2_4_lvl0.15, PP_6_15 )#5 or2( cout_csa4x2_4_lvl0.15, w1.Adder0.csa4x2_4_lvl0.15, w2.Adder0.csa4x2_4_lvl0.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.15( s4_lvl0_15, t4_lvl0_15, sintcsa4x2_4_lvl0.15, PP_7_15, cout_csa4x2_4_lvl0.14) // sum xor2( w0.Adder1.csa4x2_4_lvl0.15, sintcsa4x2_4_lvl0.15, PP_7_15 )#5 xor2( s4_lvl0_15, w0.Adder1.csa4x2_4_lvl0.15, cout_csa4x2_4_lvl0.14 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.15, sintcsa4x2_4_lvl0.15, PP_7_15 )#5 and2( w2.Adder1.csa4x2_4_lvl0.15, w0.Adder1.csa4x2_4_lvl0.15, cout_csa4x2_4_lvl0.14 )#5 or2( t4_lvl0_15, w1.Adder1.csa4x2_4_lvl0.15, w2.Adder1.csa4x2_4_lvl0.15 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.16, s4_lvl0_16,t4_lvl0_16,cout_csa4x2_4_lvl0.16,PP_4_16,PP_5_16,PP_6_16,PP_7_16,cout_csa4x2_4_lvl0.15) ; // adder1bit Adder0.csa4x2_4_lvl0.16( sintcsa4x2_4_lvl0.16, cout_csa4x2_4_lvl0.16, PP_4_16, PP_5_16, PP_6_16) // sum xor2( w0.Adder0.csa4x2_4_lvl0.16, PP_4_16, PP_5_16 )#5 xor2( sintcsa4x2_4_lvl0.16, w0.Adder0.csa4x2_4_lvl0.16, PP_6_16 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.16, PP_4_16, PP_5_16 )#5 and2( w2.Adder0.csa4x2_4_lvl0.16, w0.Adder0.csa4x2_4_lvl0.16, PP_6_16 )#5 or2( cout_csa4x2_4_lvl0.16, w1.Adder0.csa4x2_4_lvl0.16, w2.Adder0.csa4x2_4_lvl0.16 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.16( s4_lvl0_16, t4_lvl0_16, sintcsa4x2_4_lvl0.16, PP_7_16, cout_csa4x2_4_lvl0.15) // sum xor2( w0.Adder1.csa4x2_4_lvl0.16, sintcsa4x2_4_lvl0.16, PP_7_16 )#5 xor2( s4_lvl0_16, w0.Adder1.csa4x2_4_lvl0.16, cout_csa4x2_4_lvl0.15 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.16, sintcsa4x2_4_lvl0.16, PP_7_16 )#5 and2( w2.Adder1.csa4x2_4_lvl0.16, w0.Adder1.csa4x2_4_lvl0.16, cout_csa4x2_4_lvl0.15 )#5 or2( t4_lvl0_16, w1.Adder1.csa4x2_4_lvl0.16, w2.Adder1.csa4x2_4_lvl0.16 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.17, s4_lvl0_17,t4_lvl0_17,cout_csa4x2_4_lvl0.17,PP_4_17,PP_5_17,PP_6_17,PP_7_17,cout_csa4x2_4_lvl0.16) ; // adder1bit Adder0.csa4x2_4_lvl0.17( sintcsa4x2_4_lvl0.17, cout_csa4x2_4_lvl0.17, PP_4_17, PP_5_17, PP_6_17) // sum xor2( w0.Adder0.csa4x2_4_lvl0.17, PP_4_17, PP_5_17 )#5 xor2( sintcsa4x2_4_lvl0.17, w0.Adder0.csa4x2_4_lvl0.17, PP_6_17 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.17, PP_4_17, PP_5_17 )#5 and2( w2.Adder0.csa4x2_4_lvl0.17, w0.Adder0.csa4x2_4_lvl0.17, PP_6_17 )#5 or2( cout_csa4x2_4_lvl0.17, w1.Adder0.csa4x2_4_lvl0.17, w2.Adder0.csa4x2_4_lvl0.17 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.17( s4_lvl0_17, t4_lvl0_17, sintcsa4x2_4_lvl0.17, PP_7_17, cout_csa4x2_4_lvl0.16) // sum xor2( w0.Adder1.csa4x2_4_lvl0.17, sintcsa4x2_4_lvl0.17, PP_7_17 )#5 xor2( s4_lvl0_17, w0.Adder1.csa4x2_4_lvl0.17, cout_csa4x2_4_lvl0.16 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.17, sintcsa4x2_4_lvl0.17, PP_7_17 )#5 and2( w2.Adder1.csa4x2_4_lvl0.17, w0.Adder1.csa4x2_4_lvl0.17, cout_csa4x2_4_lvl0.16 )#5 or2( t4_lvl0_17, w1.Adder1.csa4x2_4_lvl0.17, w2.Adder1.csa4x2_4_lvl0.17 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.18, s4_lvl0_18,t4_lvl0_18,cout_csa4x2_4_lvl0.18,PP_4_18,PP_5_18,PP_6_18,PP_7_18,cout_csa4x2_4_lvl0.17) ; // adder1bit Adder0.csa4x2_4_lvl0.18( sintcsa4x2_4_lvl0.18, cout_csa4x2_4_lvl0.18, PP_4_18, PP_5_18, PP_6_18) // sum xor2( w0.Adder0.csa4x2_4_lvl0.18, PP_4_18, PP_5_18 )#5 xor2( sintcsa4x2_4_lvl0.18, w0.Adder0.csa4x2_4_lvl0.18, PP_6_18 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.18, PP_4_18, PP_5_18 )#5 and2( w2.Adder0.csa4x2_4_lvl0.18, w0.Adder0.csa4x2_4_lvl0.18, PP_6_18 )#5 or2( cout_csa4x2_4_lvl0.18, w1.Adder0.csa4x2_4_lvl0.18, w2.Adder0.csa4x2_4_lvl0.18 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.18( s4_lvl0_18, t4_lvl0_18, sintcsa4x2_4_lvl0.18, PP_7_18, cout_csa4x2_4_lvl0.17) // sum xor2( w0.Adder1.csa4x2_4_lvl0.18, sintcsa4x2_4_lvl0.18, PP_7_18 )#5 xor2( s4_lvl0_18, w0.Adder1.csa4x2_4_lvl0.18, cout_csa4x2_4_lvl0.17 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.18, sintcsa4x2_4_lvl0.18, PP_7_18 )#5 and2( w2.Adder1.csa4x2_4_lvl0.18, w0.Adder1.csa4x2_4_lvl0.18, cout_csa4x2_4_lvl0.17 )#5 or2( t4_lvl0_18, w1.Adder1.csa4x2_4_lvl0.18, w2.Adder1.csa4x2_4_lvl0.18 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.19, s4_lvl0_19,t4_lvl0_19,cout_csa4x2_4_lvl0.19,PP_4_19,PP_5_19,PP_6_19,PP_7_19,cout_csa4x2_4_lvl0.18) ; // adder1bit Adder0.csa4x2_4_lvl0.19( sintcsa4x2_4_lvl0.19, cout_csa4x2_4_lvl0.19, PP_4_19, PP_5_19, PP_6_19) // sum xor2( w0.Adder0.csa4x2_4_lvl0.19, PP_4_19, PP_5_19 )#5 xor2( sintcsa4x2_4_lvl0.19, w0.Adder0.csa4x2_4_lvl0.19, PP_6_19 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.19, PP_4_19, PP_5_19 )#5 and2( w2.Adder0.csa4x2_4_lvl0.19, w0.Adder0.csa4x2_4_lvl0.19, PP_6_19 )#5 or2( cout_csa4x2_4_lvl0.19, w1.Adder0.csa4x2_4_lvl0.19, w2.Adder0.csa4x2_4_lvl0.19 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.19( s4_lvl0_19, t4_lvl0_19, sintcsa4x2_4_lvl0.19, PP_7_19, cout_csa4x2_4_lvl0.18) // sum xor2( w0.Adder1.csa4x2_4_lvl0.19, sintcsa4x2_4_lvl0.19, PP_7_19 )#5 xor2( s4_lvl0_19, w0.Adder1.csa4x2_4_lvl0.19, cout_csa4x2_4_lvl0.18 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.19, sintcsa4x2_4_lvl0.19, PP_7_19 )#5 and2( w2.Adder1.csa4x2_4_lvl0.19, w0.Adder1.csa4x2_4_lvl0.19, cout_csa4x2_4_lvl0.18 )#5 or2( t4_lvl0_19, w1.Adder1.csa4x2_4_lvl0.19, w2.Adder1.csa4x2_4_lvl0.19 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.20, s4_lvl0_20,t4_lvl0_20,cout_csa4x2_4_lvl0.20,PP_4_20,PP_5_20,PP_6_20,PP_7_20,cout_csa4x2_4_lvl0.19) ; // adder1bit Adder0.csa4x2_4_lvl0.20( sintcsa4x2_4_lvl0.20, cout_csa4x2_4_lvl0.20, PP_4_20, PP_5_20, PP_6_20) // sum xor2( w0.Adder0.csa4x2_4_lvl0.20, PP_4_20, PP_5_20 )#5 xor2( sintcsa4x2_4_lvl0.20, w0.Adder0.csa4x2_4_lvl0.20, PP_6_20 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.20, PP_4_20, PP_5_20 )#5 and2( w2.Adder0.csa4x2_4_lvl0.20, w0.Adder0.csa4x2_4_lvl0.20, PP_6_20 )#5 or2( cout_csa4x2_4_lvl0.20, w1.Adder0.csa4x2_4_lvl0.20, w2.Adder0.csa4x2_4_lvl0.20 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.20( s4_lvl0_20, t4_lvl0_20, sintcsa4x2_4_lvl0.20, PP_7_20, cout_csa4x2_4_lvl0.19) // sum xor2( w0.Adder1.csa4x2_4_lvl0.20, sintcsa4x2_4_lvl0.20, PP_7_20 )#5 xor2( s4_lvl0_20, w0.Adder1.csa4x2_4_lvl0.20, cout_csa4x2_4_lvl0.19 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.20, sintcsa4x2_4_lvl0.20, PP_7_20 )#5 and2( w2.Adder1.csa4x2_4_lvl0.20, w0.Adder1.csa4x2_4_lvl0.20, cout_csa4x2_4_lvl0.19 )#5 or2( t4_lvl0_20, w1.Adder1.csa4x2_4_lvl0.20, w2.Adder1.csa4x2_4_lvl0.20 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.21, s4_lvl0_21,t4_lvl0_21,cout_csa4x2_4_lvl0.21,PP_4_21,PP_5_21,PP_6_21,PP_7_21,cout_csa4x2_4_lvl0.20) ; // adder1bit Adder0.csa4x2_4_lvl0.21( sintcsa4x2_4_lvl0.21, cout_csa4x2_4_lvl0.21, PP_4_21, PP_5_21, PP_6_21) // sum xor2( w0.Adder0.csa4x2_4_lvl0.21, PP_4_21, PP_5_21 )#5 xor2( sintcsa4x2_4_lvl0.21, w0.Adder0.csa4x2_4_lvl0.21, PP_6_21 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.21, PP_4_21, PP_5_21 )#5 and2( w2.Adder0.csa4x2_4_lvl0.21, w0.Adder0.csa4x2_4_lvl0.21, PP_6_21 )#5 or2( cout_csa4x2_4_lvl0.21, w1.Adder0.csa4x2_4_lvl0.21, w2.Adder0.csa4x2_4_lvl0.21 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.21( s4_lvl0_21, t4_lvl0_21, sintcsa4x2_4_lvl0.21, PP_7_21, cout_csa4x2_4_lvl0.20) // sum xor2( w0.Adder1.csa4x2_4_lvl0.21, sintcsa4x2_4_lvl0.21, PP_7_21 )#5 xor2( s4_lvl0_21, w0.Adder1.csa4x2_4_lvl0.21, cout_csa4x2_4_lvl0.20 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.21, sintcsa4x2_4_lvl0.21, PP_7_21 )#5 and2( w2.Adder1.csa4x2_4_lvl0.21, w0.Adder1.csa4x2_4_lvl0.21, cout_csa4x2_4_lvl0.20 )#5 or2( t4_lvl0_21, w1.Adder1.csa4x2_4_lvl0.21, w2.Adder1.csa4x2_4_lvl0.21 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.22, s4_lvl0_22,t4_lvl0_22,cout_csa4x2_4_lvl0.22,PP_4_22,PP_5_22,PP_6_22,PP_7_22,cout_csa4x2_4_lvl0.21) ; // adder1bit Adder0.csa4x2_4_lvl0.22( sintcsa4x2_4_lvl0.22, cout_csa4x2_4_lvl0.22, PP_4_22, PP_5_22, PP_6_22) // sum xor2( w0.Adder0.csa4x2_4_lvl0.22, PP_4_22, PP_5_22 )#5 xor2( sintcsa4x2_4_lvl0.22, w0.Adder0.csa4x2_4_lvl0.22, PP_6_22 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.22, PP_4_22, PP_5_22 )#5 and2( w2.Adder0.csa4x2_4_lvl0.22, w0.Adder0.csa4x2_4_lvl0.22, PP_6_22 )#5 or2( cout_csa4x2_4_lvl0.22, w1.Adder0.csa4x2_4_lvl0.22, w2.Adder0.csa4x2_4_lvl0.22 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.22( s4_lvl0_22, t4_lvl0_22, sintcsa4x2_4_lvl0.22, PP_7_22, cout_csa4x2_4_lvl0.21) // sum xor2( w0.Adder1.csa4x2_4_lvl0.22, sintcsa4x2_4_lvl0.22, PP_7_22 )#5 xor2( s4_lvl0_22, w0.Adder1.csa4x2_4_lvl0.22, cout_csa4x2_4_lvl0.21 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.22, sintcsa4x2_4_lvl0.22, PP_7_22 )#5 and2( w2.Adder1.csa4x2_4_lvl0.22, w0.Adder1.csa4x2_4_lvl0.22, cout_csa4x2_4_lvl0.21 )#5 or2( t4_lvl0_22, w1.Adder1.csa4x2_4_lvl0.22, w2.Adder1.csa4x2_4_lvl0.22 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.23, s4_lvl0_23,t4_lvl0_23,cout_csa4x2_4_lvl0.23,PP_4_23,PP_5_23,PP_6_23,PP_7_23,cout_csa4x2_4_lvl0.22) ; // adder1bit Adder0.csa4x2_4_lvl0.23( sintcsa4x2_4_lvl0.23, cout_csa4x2_4_lvl0.23, PP_4_23, PP_5_23, PP_6_23) // sum xor2( w0.Adder0.csa4x2_4_lvl0.23, PP_4_23, PP_5_23 )#5 xor2( sintcsa4x2_4_lvl0.23, w0.Adder0.csa4x2_4_lvl0.23, PP_6_23 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.23, PP_4_23, PP_5_23 )#5 and2( w2.Adder0.csa4x2_4_lvl0.23, w0.Adder0.csa4x2_4_lvl0.23, PP_6_23 )#5 or2( cout_csa4x2_4_lvl0.23, w1.Adder0.csa4x2_4_lvl0.23, w2.Adder0.csa4x2_4_lvl0.23 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.23( s4_lvl0_23, t4_lvl0_23, sintcsa4x2_4_lvl0.23, PP_7_23, cout_csa4x2_4_lvl0.22) // sum xor2( w0.Adder1.csa4x2_4_lvl0.23, sintcsa4x2_4_lvl0.23, PP_7_23 )#5 xor2( s4_lvl0_23, w0.Adder1.csa4x2_4_lvl0.23, cout_csa4x2_4_lvl0.22 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.23, sintcsa4x2_4_lvl0.23, PP_7_23 )#5 and2( w2.Adder1.csa4x2_4_lvl0.23, w0.Adder1.csa4x2_4_lvl0.23, cout_csa4x2_4_lvl0.22 )#5 or2( t4_lvl0_23, w1.Adder1.csa4x2_4_lvl0.23, w2.Adder1.csa4x2_4_lvl0.23 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.0, s8_lvl0_0,t8_lvl0_0,cout_csa4x2_8_lvl0.0,PP_8_0,PP_9_0,PP_10_0,PP_11_0,GND) ; // adder1bit Adder0.csa4x2_8_lvl0.0( sintcsa4x2_8_lvl0.0, cout_csa4x2_8_lvl0.0, PP_8_0, PP_9_0, PP_10_0) // sum xor2( w0.Adder0.csa4x2_8_lvl0.0, PP_8_0, PP_9_0 )#5 xor2( sintcsa4x2_8_lvl0.0, w0.Adder0.csa4x2_8_lvl0.0, PP_10_0 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.0, PP_8_0, PP_9_0 )#5 and2( w2.Adder0.csa4x2_8_lvl0.0, w0.Adder0.csa4x2_8_lvl0.0, PP_10_0 )#5 or2( cout_csa4x2_8_lvl0.0, w1.Adder0.csa4x2_8_lvl0.0, w2.Adder0.csa4x2_8_lvl0.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.0( s8_lvl0_0, t8_lvl0_0, sintcsa4x2_8_lvl0.0, PP_11_0, GND) // sum xor2( w0.Adder1.csa4x2_8_lvl0.0, sintcsa4x2_8_lvl0.0, PP_11_0 )#5 xor2( s8_lvl0_0, w0.Adder1.csa4x2_8_lvl0.0, GND )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.0, sintcsa4x2_8_lvl0.0, PP_11_0 )#5 and2( w2.Adder1.csa4x2_8_lvl0.0, w0.Adder1.csa4x2_8_lvl0.0, GND )#5 or2( t8_lvl0_0, w1.Adder1.csa4x2_8_lvl0.0, w2.Adder1.csa4x2_8_lvl0.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.1, s8_lvl0_1,t8_lvl0_1,cout_csa4x2_8_lvl0.1,PP_8_1,PP_9_1,PP_10_1,PP_11_1,cout_csa4x2_8_lvl0.0) ; // adder1bit Adder0.csa4x2_8_lvl0.1( sintcsa4x2_8_lvl0.1, cout_csa4x2_8_lvl0.1, PP_8_1, PP_9_1, PP_10_1) // sum xor2( w0.Adder0.csa4x2_8_lvl0.1, PP_8_1, PP_9_1 )#5 xor2( sintcsa4x2_8_lvl0.1, w0.Adder0.csa4x2_8_lvl0.1, PP_10_1 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.1, PP_8_1, PP_9_1 )#5 and2( w2.Adder0.csa4x2_8_lvl0.1, w0.Adder0.csa4x2_8_lvl0.1, PP_10_1 )#5 or2( cout_csa4x2_8_lvl0.1, w1.Adder0.csa4x2_8_lvl0.1, w2.Adder0.csa4x2_8_lvl0.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.1( s8_lvl0_1, t8_lvl0_1, sintcsa4x2_8_lvl0.1, PP_11_1, cout_csa4x2_8_lvl0.0) // sum xor2( w0.Adder1.csa4x2_8_lvl0.1, sintcsa4x2_8_lvl0.1, PP_11_1 )#5 xor2( s8_lvl0_1, w0.Adder1.csa4x2_8_lvl0.1, cout_csa4x2_8_lvl0.0 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.1, sintcsa4x2_8_lvl0.1, PP_11_1 )#5 and2( w2.Adder1.csa4x2_8_lvl0.1, w0.Adder1.csa4x2_8_lvl0.1, cout_csa4x2_8_lvl0.0 )#5 or2( t8_lvl0_1, w1.Adder1.csa4x2_8_lvl0.1, w2.Adder1.csa4x2_8_lvl0.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.2, s8_lvl0_2,t8_lvl0_2,cout_csa4x2_8_lvl0.2,PP_8_2,PP_9_2,PP_10_2,PP_11_2,cout_csa4x2_8_lvl0.1) ; // adder1bit Adder0.csa4x2_8_lvl0.2( sintcsa4x2_8_lvl0.2, cout_csa4x2_8_lvl0.2, PP_8_2, PP_9_2, PP_10_2) // sum xor2( w0.Adder0.csa4x2_8_lvl0.2, PP_8_2, PP_9_2 )#5 xor2( sintcsa4x2_8_lvl0.2, w0.Adder0.csa4x2_8_lvl0.2, PP_10_2 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.2, PP_8_2, PP_9_2 )#5 and2( w2.Adder0.csa4x2_8_lvl0.2, w0.Adder0.csa4x2_8_lvl0.2, PP_10_2 )#5 or2( cout_csa4x2_8_lvl0.2, w1.Adder0.csa4x2_8_lvl0.2, w2.Adder0.csa4x2_8_lvl0.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.2( s8_lvl0_2, t8_lvl0_2, sintcsa4x2_8_lvl0.2, PP_11_2, cout_csa4x2_8_lvl0.1) // sum xor2( w0.Adder1.csa4x2_8_lvl0.2, sintcsa4x2_8_lvl0.2, PP_11_2 )#5 xor2( s8_lvl0_2, w0.Adder1.csa4x2_8_lvl0.2, cout_csa4x2_8_lvl0.1 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.2, sintcsa4x2_8_lvl0.2, PP_11_2 )#5 and2( w2.Adder1.csa4x2_8_lvl0.2, w0.Adder1.csa4x2_8_lvl0.2, cout_csa4x2_8_lvl0.1 )#5 or2( t8_lvl0_2, w1.Adder1.csa4x2_8_lvl0.2, w2.Adder1.csa4x2_8_lvl0.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.3, s8_lvl0_3,t8_lvl0_3,cout_csa4x2_8_lvl0.3,PP_8_3,PP_9_3,PP_10_3,PP_11_3,cout_csa4x2_8_lvl0.2) ; // adder1bit Adder0.csa4x2_8_lvl0.3( sintcsa4x2_8_lvl0.3, cout_csa4x2_8_lvl0.3, PP_8_3, PP_9_3, PP_10_3) // sum xor2( w0.Adder0.csa4x2_8_lvl0.3, PP_8_3, PP_9_3 )#5 xor2( sintcsa4x2_8_lvl0.3, w0.Adder0.csa4x2_8_lvl0.3, PP_10_3 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.3, PP_8_3, PP_9_3 )#5 and2( w2.Adder0.csa4x2_8_lvl0.3, w0.Adder0.csa4x2_8_lvl0.3, PP_10_3 )#5 or2( cout_csa4x2_8_lvl0.3, w1.Adder0.csa4x2_8_lvl0.3, w2.Adder0.csa4x2_8_lvl0.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.3( s8_lvl0_3, t8_lvl0_3, sintcsa4x2_8_lvl0.3, PP_11_3, cout_csa4x2_8_lvl0.2) // sum xor2( w0.Adder1.csa4x2_8_lvl0.3, sintcsa4x2_8_lvl0.3, PP_11_3 )#5 xor2( s8_lvl0_3, w0.Adder1.csa4x2_8_lvl0.3, cout_csa4x2_8_lvl0.2 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.3, sintcsa4x2_8_lvl0.3, PP_11_3 )#5 and2( w2.Adder1.csa4x2_8_lvl0.3, w0.Adder1.csa4x2_8_lvl0.3, cout_csa4x2_8_lvl0.2 )#5 or2( t8_lvl0_3, w1.Adder1.csa4x2_8_lvl0.3, w2.Adder1.csa4x2_8_lvl0.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.4, s8_lvl0_4,t8_lvl0_4,cout_csa4x2_8_lvl0.4,PP_8_4,PP_9_4,PP_10_4,PP_11_4,cout_csa4x2_8_lvl0.3) ; // adder1bit Adder0.csa4x2_8_lvl0.4( sintcsa4x2_8_lvl0.4, cout_csa4x2_8_lvl0.4, PP_8_4, PP_9_4, PP_10_4) // sum xor2( w0.Adder0.csa4x2_8_lvl0.4, PP_8_4, PP_9_4 )#5 xor2( sintcsa4x2_8_lvl0.4, w0.Adder0.csa4x2_8_lvl0.4, PP_10_4 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.4, PP_8_4, PP_9_4 )#5 and2( w2.Adder0.csa4x2_8_lvl0.4, w0.Adder0.csa4x2_8_lvl0.4, PP_10_4 )#5 or2( cout_csa4x2_8_lvl0.4, w1.Adder0.csa4x2_8_lvl0.4, w2.Adder0.csa4x2_8_lvl0.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.4( s8_lvl0_4, t8_lvl0_4, sintcsa4x2_8_lvl0.4, PP_11_4, cout_csa4x2_8_lvl0.3) // sum xor2( w0.Adder1.csa4x2_8_lvl0.4, sintcsa4x2_8_lvl0.4, PP_11_4 )#5 xor2( s8_lvl0_4, w0.Adder1.csa4x2_8_lvl0.4, cout_csa4x2_8_lvl0.3 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.4, sintcsa4x2_8_lvl0.4, PP_11_4 )#5 and2( w2.Adder1.csa4x2_8_lvl0.4, w0.Adder1.csa4x2_8_lvl0.4, cout_csa4x2_8_lvl0.3 )#5 or2( t8_lvl0_4, w1.Adder1.csa4x2_8_lvl0.4, w2.Adder1.csa4x2_8_lvl0.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.5, s8_lvl0_5,t8_lvl0_5,cout_csa4x2_8_lvl0.5,PP_8_5,PP_9_5,PP_10_5,PP_11_5,cout_csa4x2_8_lvl0.4) ; // adder1bit Adder0.csa4x2_8_lvl0.5( sintcsa4x2_8_lvl0.5, cout_csa4x2_8_lvl0.5, PP_8_5, PP_9_5, PP_10_5) // sum xor2( w0.Adder0.csa4x2_8_lvl0.5, PP_8_5, PP_9_5 )#5 xor2( sintcsa4x2_8_lvl0.5, w0.Adder0.csa4x2_8_lvl0.5, PP_10_5 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.5, PP_8_5, PP_9_5 )#5 and2( w2.Adder0.csa4x2_8_lvl0.5, w0.Adder0.csa4x2_8_lvl0.5, PP_10_5 )#5 or2( cout_csa4x2_8_lvl0.5, w1.Adder0.csa4x2_8_lvl0.5, w2.Adder0.csa4x2_8_lvl0.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.5( s8_lvl0_5, t8_lvl0_5, sintcsa4x2_8_lvl0.5, PP_11_5, cout_csa4x2_8_lvl0.4) // sum xor2( w0.Adder1.csa4x2_8_lvl0.5, sintcsa4x2_8_lvl0.5, PP_11_5 )#5 xor2( s8_lvl0_5, w0.Adder1.csa4x2_8_lvl0.5, cout_csa4x2_8_lvl0.4 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.5, sintcsa4x2_8_lvl0.5, PP_11_5 )#5 and2( w2.Adder1.csa4x2_8_lvl0.5, w0.Adder1.csa4x2_8_lvl0.5, cout_csa4x2_8_lvl0.4 )#5 or2( t8_lvl0_5, w1.Adder1.csa4x2_8_lvl0.5, w2.Adder1.csa4x2_8_lvl0.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.6, s8_lvl0_6,t8_lvl0_6,cout_csa4x2_8_lvl0.6,PP_8_6,PP_9_6,PP_10_6,PP_11_6,cout_csa4x2_8_lvl0.5) ; // adder1bit Adder0.csa4x2_8_lvl0.6( sintcsa4x2_8_lvl0.6, cout_csa4x2_8_lvl0.6, PP_8_6, PP_9_6, PP_10_6) // sum xor2( w0.Adder0.csa4x2_8_lvl0.6, PP_8_6, PP_9_6 )#5 xor2( sintcsa4x2_8_lvl0.6, w0.Adder0.csa4x2_8_lvl0.6, PP_10_6 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.6, PP_8_6, PP_9_6 )#5 and2( w2.Adder0.csa4x2_8_lvl0.6, w0.Adder0.csa4x2_8_lvl0.6, PP_10_6 )#5 or2( cout_csa4x2_8_lvl0.6, w1.Adder0.csa4x2_8_lvl0.6, w2.Adder0.csa4x2_8_lvl0.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.6( s8_lvl0_6, t8_lvl0_6, sintcsa4x2_8_lvl0.6, PP_11_6, cout_csa4x2_8_lvl0.5) // sum xor2( w0.Adder1.csa4x2_8_lvl0.6, sintcsa4x2_8_lvl0.6, PP_11_6 )#5 xor2( s8_lvl0_6, w0.Adder1.csa4x2_8_lvl0.6, cout_csa4x2_8_lvl0.5 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.6, sintcsa4x2_8_lvl0.6, PP_11_6 )#5 and2( w2.Adder1.csa4x2_8_lvl0.6, w0.Adder1.csa4x2_8_lvl0.6, cout_csa4x2_8_lvl0.5 )#5 or2( t8_lvl0_6, w1.Adder1.csa4x2_8_lvl0.6, w2.Adder1.csa4x2_8_lvl0.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.7, s8_lvl0_7,t8_lvl0_7,cout_csa4x2_8_lvl0.7,PP_8_7,PP_9_7,PP_10_7,PP_11_7,cout_csa4x2_8_lvl0.6) ; // adder1bit Adder0.csa4x2_8_lvl0.7( sintcsa4x2_8_lvl0.7, cout_csa4x2_8_lvl0.7, PP_8_7, PP_9_7, PP_10_7) // sum xor2( w0.Adder0.csa4x2_8_lvl0.7, PP_8_7, PP_9_7 )#5 xor2( sintcsa4x2_8_lvl0.7, w0.Adder0.csa4x2_8_lvl0.7, PP_10_7 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.7, PP_8_7, PP_9_7 )#5 and2( w2.Adder0.csa4x2_8_lvl0.7, w0.Adder0.csa4x2_8_lvl0.7, PP_10_7 )#5 or2( cout_csa4x2_8_lvl0.7, w1.Adder0.csa4x2_8_lvl0.7, w2.Adder0.csa4x2_8_lvl0.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.7( s8_lvl0_7, t8_lvl0_7, sintcsa4x2_8_lvl0.7, PP_11_7, cout_csa4x2_8_lvl0.6) // sum xor2( w0.Adder1.csa4x2_8_lvl0.7, sintcsa4x2_8_lvl0.7, PP_11_7 )#5 xor2( s8_lvl0_7, w0.Adder1.csa4x2_8_lvl0.7, cout_csa4x2_8_lvl0.6 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.7, sintcsa4x2_8_lvl0.7, PP_11_7 )#5 and2( w2.Adder1.csa4x2_8_lvl0.7, w0.Adder1.csa4x2_8_lvl0.7, cout_csa4x2_8_lvl0.6 )#5 or2( t8_lvl0_7, w1.Adder1.csa4x2_8_lvl0.7, w2.Adder1.csa4x2_8_lvl0.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.8, s8_lvl0_8,t8_lvl0_8,cout_csa4x2_8_lvl0.8,PP_8_8,PP_9_8,PP_10_8,PP_11_8,cout_csa4x2_8_lvl0.7) ; // adder1bit Adder0.csa4x2_8_lvl0.8( sintcsa4x2_8_lvl0.8, cout_csa4x2_8_lvl0.8, PP_8_8, PP_9_8, PP_10_8) // sum xor2( w0.Adder0.csa4x2_8_lvl0.8, PP_8_8, PP_9_8 )#5 xor2( sintcsa4x2_8_lvl0.8, w0.Adder0.csa4x2_8_lvl0.8, PP_10_8 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.8, PP_8_8, PP_9_8 )#5 and2( w2.Adder0.csa4x2_8_lvl0.8, w0.Adder0.csa4x2_8_lvl0.8, PP_10_8 )#5 or2( cout_csa4x2_8_lvl0.8, w1.Adder0.csa4x2_8_lvl0.8, w2.Adder0.csa4x2_8_lvl0.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.8( s8_lvl0_8, t8_lvl0_8, sintcsa4x2_8_lvl0.8, PP_11_8, cout_csa4x2_8_lvl0.7) // sum xor2( w0.Adder1.csa4x2_8_lvl0.8, sintcsa4x2_8_lvl0.8, PP_11_8 )#5 xor2( s8_lvl0_8, w0.Adder1.csa4x2_8_lvl0.8, cout_csa4x2_8_lvl0.7 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.8, sintcsa4x2_8_lvl0.8, PP_11_8 )#5 and2( w2.Adder1.csa4x2_8_lvl0.8, w0.Adder1.csa4x2_8_lvl0.8, cout_csa4x2_8_lvl0.7 )#5 or2( t8_lvl0_8, w1.Adder1.csa4x2_8_lvl0.8, w2.Adder1.csa4x2_8_lvl0.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.9, s8_lvl0_9,t8_lvl0_9,cout_csa4x2_8_lvl0.9,PP_8_9,PP_9_9,PP_10_9,PP_11_9,cout_csa4x2_8_lvl0.8) ; // adder1bit Adder0.csa4x2_8_lvl0.9( sintcsa4x2_8_lvl0.9, cout_csa4x2_8_lvl0.9, PP_8_9, PP_9_9, PP_10_9) // sum xor2( w0.Adder0.csa4x2_8_lvl0.9, PP_8_9, PP_9_9 )#5 xor2( sintcsa4x2_8_lvl0.9, w0.Adder0.csa4x2_8_lvl0.9, PP_10_9 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.9, PP_8_9, PP_9_9 )#5 and2( w2.Adder0.csa4x2_8_lvl0.9, w0.Adder0.csa4x2_8_lvl0.9, PP_10_9 )#5 or2( cout_csa4x2_8_lvl0.9, w1.Adder0.csa4x2_8_lvl0.9, w2.Adder0.csa4x2_8_lvl0.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.9( s8_lvl0_9, t8_lvl0_9, sintcsa4x2_8_lvl0.9, PP_11_9, cout_csa4x2_8_lvl0.8) // sum xor2( w0.Adder1.csa4x2_8_lvl0.9, sintcsa4x2_8_lvl0.9, PP_11_9 )#5 xor2( s8_lvl0_9, w0.Adder1.csa4x2_8_lvl0.9, cout_csa4x2_8_lvl0.8 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.9, sintcsa4x2_8_lvl0.9, PP_11_9 )#5 and2( w2.Adder1.csa4x2_8_lvl0.9, w0.Adder1.csa4x2_8_lvl0.9, cout_csa4x2_8_lvl0.8 )#5 or2( t8_lvl0_9, w1.Adder1.csa4x2_8_lvl0.9, w2.Adder1.csa4x2_8_lvl0.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.10, s8_lvl0_10,t8_lvl0_10,cout_csa4x2_8_lvl0.10,PP_8_10,PP_9_10,PP_10_10,PP_11_10,cout_csa4x2_8_lvl0.9) ; // adder1bit Adder0.csa4x2_8_lvl0.10( sintcsa4x2_8_lvl0.10, cout_csa4x2_8_lvl0.10, PP_8_10, PP_9_10, PP_10_10) // sum xor2( w0.Adder0.csa4x2_8_lvl0.10, PP_8_10, PP_9_10 )#5 xor2( sintcsa4x2_8_lvl0.10, w0.Adder0.csa4x2_8_lvl0.10, PP_10_10 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.10, PP_8_10, PP_9_10 )#5 and2( w2.Adder0.csa4x2_8_lvl0.10, w0.Adder0.csa4x2_8_lvl0.10, PP_10_10 )#5 or2( cout_csa4x2_8_lvl0.10, w1.Adder0.csa4x2_8_lvl0.10, w2.Adder0.csa4x2_8_lvl0.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.10( s8_lvl0_10, t8_lvl0_10, sintcsa4x2_8_lvl0.10, PP_11_10, cout_csa4x2_8_lvl0.9) // sum xor2( w0.Adder1.csa4x2_8_lvl0.10, sintcsa4x2_8_lvl0.10, PP_11_10 )#5 xor2( s8_lvl0_10, w0.Adder1.csa4x2_8_lvl0.10, cout_csa4x2_8_lvl0.9 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.10, sintcsa4x2_8_lvl0.10, PP_11_10 )#5 and2( w2.Adder1.csa4x2_8_lvl0.10, w0.Adder1.csa4x2_8_lvl0.10, cout_csa4x2_8_lvl0.9 )#5 or2( t8_lvl0_10, w1.Adder1.csa4x2_8_lvl0.10, w2.Adder1.csa4x2_8_lvl0.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.11, s8_lvl0_11,t8_lvl0_11,cout_csa4x2_8_lvl0.11,PP_8_11,PP_9_11,PP_10_11,PP_11_11,cout_csa4x2_8_lvl0.10) ; // adder1bit Adder0.csa4x2_8_lvl0.11( sintcsa4x2_8_lvl0.11, cout_csa4x2_8_lvl0.11, PP_8_11, PP_9_11, PP_10_11) // sum xor2( w0.Adder0.csa4x2_8_lvl0.11, PP_8_11, PP_9_11 )#5 xor2( sintcsa4x2_8_lvl0.11, w0.Adder0.csa4x2_8_lvl0.11, PP_10_11 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.11, PP_8_11, PP_9_11 )#5 and2( w2.Adder0.csa4x2_8_lvl0.11, w0.Adder0.csa4x2_8_lvl0.11, PP_10_11 )#5 or2( cout_csa4x2_8_lvl0.11, w1.Adder0.csa4x2_8_lvl0.11, w2.Adder0.csa4x2_8_lvl0.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.11( s8_lvl0_11, t8_lvl0_11, sintcsa4x2_8_lvl0.11, PP_11_11, cout_csa4x2_8_lvl0.10) // sum xor2( w0.Adder1.csa4x2_8_lvl0.11, sintcsa4x2_8_lvl0.11, PP_11_11 )#5 xor2( s8_lvl0_11, w0.Adder1.csa4x2_8_lvl0.11, cout_csa4x2_8_lvl0.10 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.11, sintcsa4x2_8_lvl0.11, PP_11_11 )#5 and2( w2.Adder1.csa4x2_8_lvl0.11, w0.Adder1.csa4x2_8_lvl0.11, cout_csa4x2_8_lvl0.10 )#5 or2( t8_lvl0_11, w1.Adder1.csa4x2_8_lvl0.11, w2.Adder1.csa4x2_8_lvl0.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.12, s8_lvl0_12,t8_lvl0_12,cout_csa4x2_8_lvl0.12,PP_8_12,PP_9_12,PP_10_12,PP_11_12,cout_csa4x2_8_lvl0.11) ; // adder1bit Adder0.csa4x2_8_lvl0.12( sintcsa4x2_8_lvl0.12, cout_csa4x2_8_lvl0.12, PP_8_12, PP_9_12, PP_10_12) // sum xor2( w0.Adder0.csa4x2_8_lvl0.12, PP_8_12, PP_9_12 )#5 xor2( sintcsa4x2_8_lvl0.12, w0.Adder0.csa4x2_8_lvl0.12, PP_10_12 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.12, PP_8_12, PP_9_12 )#5 and2( w2.Adder0.csa4x2_8_lvl0.12, w0.Adder0.csa4x2_8_lvl0.12, PP_10_12 )#5 or2( cout_csa4x2_8_lvl0.12, w1.Adder0.csa4x2_8_lvl0.12, w2.Adder0.csa4x2_8_lvl0.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.12( s8_lvl0_12, t8_lvl0_12, sintcsa4x2_8_lvl0.12, PP_11_12, cout_csa4x2_8_lvl0.11) // sum xor2( w0.Adder1.csa4x2_8_lvl0.12, sintcsa4x2_8_lvl0.12, PP_11_12 )#5 xor2( s8_lvl0_12, w0.Adder1.csa4x2_8_lvl0.12, cout_csa4x2_8_lvl0.11 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.12, sintcsa4x2_8_lvl0.12, PP_11_12 )#5 and2( w2.Adder1.csa4x2_8_lvl0.12, w0.Adder1.csa4x2_8_lvl0.12, cout_csa4x2_8_lvl0.11 )#5 or2( t8_lvl0_12, w1.Adder1.csa4x2_8_lvl0.12, w2.Adder1.csa4x2_8_lvl0.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.13, s8_lvl0_13,t8_lvl0_13,cout_csa4x2_8_lvl0.13,PP_8_13,PP_9_13,PP_10_13,PP_11_13,cout_csa4x2_8_lvl0.12) ; // adder1bit Adder0.csa4x2_8_lvl0.13( sintcsa4x2_8_lvl0.13, cout_csa4x2_8_lvl0.13, PP_8_13, PP_9_13, PP_10_13) // sum xor2( w0.Adder0.csa4x2_8_lvl0.13, PP_8_13, PP_9_13 )#5 xor2( sintcsa4x2_8_lvl0.13, w0.Adder0.csa4x2_8_lvl0.13, PP_10_13 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.13, PP_8_13, PP_9_13 )#5 and2( w2.Adder0.csa4x2_8_lvl0.13, w0.Adder0.csa4x2_8_lvl0.13, PP_10_13 )#5 or2( cout_csa4x2_8_lvl0.13, w1.Adder0.csa4x2_8_lvl0.13, w2.Adder0.csa4x2_8_lvl0.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.13( s8_lvl0_13, t8_lvl0_13, sintcsa4x2_8_lvl0.13, PP_11_13, cout_csa4x2_8_lvl0.12) // sum xor2( w0.Adder1.csa4x2_8_lvl0.13, sintcsa4x2_8_lvl0.13, PP_11_13 )#5 xor2( s8_lvl0_13, w0.Adder1.csa4x2_8_lvl0.13, cout_csa4x2_8_lvl0.12 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.13, sintcsa4x2_8_lvl0.13, PP_11_13 )#5 and2( w2.Adder1.csa4x2_8_lvl0.13, w0.Adder1.csa4x2_8_lvl0.13, cout_csa4x2_8_lvl0.12 )#5 or2( t8_lvl0_13, w1.Adder1.csa4x2_8_lvl0.13, w2.Adder1.csa4x2_8_lvl0.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.14, s8_lvl0_14,t8_lvl0_14,cout_csa4x2_8_lvl0.14,PP_8_14,PP_9_14,PP_10_14,PP_11_14,cout_csa4x2_8_lvl0.13) ; // adder1bit Adder0.csa4x2_8_lvl0.14( sintcsa4x2_8_lvl0.14, cout_csa4x2_8_lvl0.14, PP_8_14, PP_9_14, PP_10_14) // sum xor2( w0.Adder0.csa4x2_8_lvl0.14, PP_8_14, PP_9_14 )#5 xor2( sintcsa4x2_8_lvl0.14, w0.Adder0.csa4x2_8_lvl0.14, PP_10_14 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.14, PP_8_14, PP_9_14 )#5 and2( w2.Adder0.csa4x2_8_lvl0.14, w0.Adder0.csa4x2_8_lvl0.14, PP_10_14 )#5 or2( cout_csa4x2_8_lvl0.14, w1.Adder0.csa4x2_8_lvl0.14, w2.Adder0.csa4x2_8_lvl0.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.14( s8_lvl0_14, t8_lvl0_14, sintcsa4x2_8_lvl0.14, PP_11_14, cout_csa4x2_8_lvl0.13) // sum xor2( w0.Adder1.csa4x2_8_lvl0.14, sintcsa4x2_8_lvl0.14, PP_11_14 )#5 xor2( s8_lvl0_14, w0.Adder1.csa4x2_8_lvl0.14, cout_csa4x2_8_lvl0.13 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.14, sintcsa4x2_8_lvl0.14, PP_11_14 )#5 and2( w2.Adder1.csa4x2_8_lvl0.14, w0.Adder1.csa4x2_8_lvl0.14, cout_csa4x2_8_lvl0.13 )#5 or2( t8_lvl0_14, w1.Adder1.csa4x2_8_lvl0.14, w2.Adder1.csa4x2_8_lvl0.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.15, s8_lvl0_15,t8_lvl0_15,cout_csa4x2_8_lvl0.15,PP_8_15,PP_9_15,PP_10_15,PP_11_15,cout_csa4x2_8_lvl0.14) ; // adder1bit Adder0.csa4x2_8_lvl0.15( sintcsa4x2_8_lvl0.15, cout_csa4x2_8_lvl0.15, PP_8_15, PP_9_15, PP_10_15) // sum xor2( w0.Adder0.csa4x2_8_lvl0.15, PP_8_15, PP_9_15 )#5 xor2( sintcsa4x2_8_lvl0.15, w0.Adder0.csa4x2_8_lvl0.15, PP_10_15 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.15, PP_8_15, PP_9_15 )#5 and2( w2.Adder0.csa4x2_8_lvl0.15, w0.Adder0.csa4x2_8_lvl0.15, PP_10_15 )#5 or2( cout_csa4x2_8_lvl0.15, w1.Adder0.csa4x2_8_lvl0.15, w2.Adder0.csa4x2_8_lvl0.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.15( s8_lvl0_15, t8_lvl0_15, sintcsa4x2_8_lvl0.15, PP_11_15, cout_csa4x2_8_lvl0.14) // sum xor2( w0.Adder1.csa4x2_8_lvl0.15, sintcsa4x2_8_lvl0.15, PP_11_15 )#5 xor2( s8_lvl0_15, w0.Adder1.csa4x2_8_lvl0.15, cout_csa4x2_8_lvl0.14 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.15, sintcsa4x2_8_lvl0.15, PP_11_15 )#5 and2( w2.Adder1.csa4x2_8_lvl0.15, w0.Adder1.csa4x2_8_lvl0.15, cout_csa4x2_8_lvl0.14 )#5 or2( t8_lvl0_15, w1.Adder1.csa4x2_8_lvl0.15, w2.Adder1.csa4x2_8_lvl0.15 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.16, s8_lvl0_16,t8_lvl0_16,cout_csa4x2_8_lvl0.16,PP_8_16,PP_9_16,PP_10_16,PP_11_16,cout_csa4x2_8_lvl0.15) ; // adder1bit Adder0.csa4x2_8_lvl0.16( sintcsa4x2_8_lvl0.16, cout_csa4x2_8_lvl0.16, PP_8_16, PP_9_16, PP_10_16) // sum xor2( w0.Adder0.csa4x2_8_lvl0.16, PP_8_16, PP_9_16 )#5 xor2( sintcsa4x2_8_lvl0.16, w0.Adder0.csa4x2_8_lvl0.16, PP_10_16 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.16, PP_8_16, PP_9_16 )#5 and2( w2.Adder0.csa4x2_8_lvl0.16, w0.Adder0.csa4x2_8_lvl0.16, PP_10_16 )#5 or2( cout_csa4x2_8_lvl0.16, w1.Adder0.csa4x2_8_lvl0.16, w2.Adder0.csa4x2_8_lvl0.16 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.16( s8_lvl0_16, t8_lvl0_16, sintcsa4x2_8_lvl0.16, PP_11_16, cout_csa4x2_8_lvl0.15) // sum xor2( w0.Adder1.csa4x2_8_lvl0.16, sintcsa4x2_8_lvl0.16, PP_11_16 )#5 xor2( s8_lvl0_16, w0.Adder1.csa4x2_8_lvl0.16, cout_csa4x2_8_lvl0.15 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.16, sintcsa4x2_8_lvl0.16, PP_11_16 )#5 and2( w2.Adder1.csa4x2_8_lvl0.16, w0.Adder1.csa4x2_8_lvl0.16, cout_csa4x2_8_lvl0.15 )#5 or2( t8_lvl0_16, w1.Adder1.csa4x2_8_lvl0.16, w2.Adder1.csa4x2_8_lvl0.16 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.17, s8_lvl0_17,t8_lvl0_17,cout_csa4x2_8_lvl0.17,PP_8_17,PP_9_17,PP_10_17,PP_11_17,cout_csa4x2_8_lvl0.16) ; // adder1bit Adder0.csa4x2_8_lvl0.17( sintcsa4x2_8_lvl0.17, cout_csa4x2_8_lvl0.17, PP_8_17, PP_9_17, PP_10_17) // sum xor2( w0.Adder0.csa4x2_8_lvl0.17, PP_8_17, PP_9_17 )#5 xor2( sintcsa4x2_8_lvl0.17, w0.Adder0.csa4x2_8_lvl0.17, PP_10_17 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.17, PP_8_17, PP_9_17 )#5 and2( w2.Adder0.csa4x2_8_lvl0.17, w0.Adder0.csa4x2_8_lvl0.17, PP_10_17 )#5 or2( cout_csa4x2_8_lvl0.17, w1.Adder0.csa4x2_8_lvl0.17, w2.Adder0.csa4x2_8_lvl0.17 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.17( s8_lvl0_17, t8_lvl0_17, sintcsa4x2_8_lvl0.17, PP_11_17, cout_csa4x2_8_lvl0.16) // sum xor2( w0.Adder1.csa4x2_8_lvl0.17, sintcsa4x2_8_lvl0.17, PP_11_17 )#5 xor2( s8_lvl0_17, w0.Adder1.csa4x2_8_lvl0.17, cout_csa4x2_8_lvl0.16 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.17, sintcsa4x2_8_lvl0.17, PP_11_17 )#5 and2( w2.Adder1.csa4x2_8_lvl0.17, w0.Adder1.csa4x2_8_lvl0.17, cout_csa4x2_8_lvl0.16 )#5 or2( t8_lvl0_17, w1.Adder1.csa4x2_8_lvl0.17, w2.Adder1.csa4x2_8_lvl0.17 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.18, s8_lvl0_18,t8_lvl0_18,cout_csa4x2_8_lvl0.18,PP_8_18,PP_9_18,PP_10_18,PP_11_18,cout_csa4x2_8_lvl0.17) ; // adder1bit Adder0.csa4x2_8_lvl0.18( sintcsa4x2_8_lvl0.18, cout_csa4x2_8_lvl0.18, PP_8_18, PP_9_18, PP_10_18) // sum xor2( w0.Adder0.csa4x2_8_lvl0.18, PP_8_18, PP_9_18 )#5 xor2( sintcsa4x2_8_lvl0.18, w0.Adder0.csa4x2_8_lvl0.18, PP_10_18 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.18, PP_8_18, PP_9_18 )#5 and2( w2.Adder0.csa4x2_8_lvl0.18, w0.Adder0.csa4x2_8_lvl0.18, PP_10_18 )#5 or2( cout_csa4x2_8_lvl0.18, w1.Adder0.csa4x2_8_lvl0.18, w2.Adder0.csa4x2_8_lvl0.18 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.18( s8_lvl0_18, t8_lvl0_18, sintcsa4x2_8_lvl0.18, PP_11_18, cout_csa4x2_8_lvl0.17) // sum xor2( w0.Adder1.csa4x2_8_lvl0.18, sintcsa4x2_8_lvl0.18, PP_11_18 )#5 xor2( s8_lvl0_18, w0.Adder1.csa4x2_8_lvl0.18, cout_csa4x2_8_lvl0.17 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.18, sintcsa4x2_8_lvl0.18, PP_11_18 )#5 and2( w2.Adder1.csa4x2_8_lvl0.18, w0.Adder1.csa4x2_8_lvl0.18, cout_csa4x2_8_lvl0.17 )#5 or2( t8_lvl0_18, w1.Adder1.csa4x2_8_lvl0.18, w2.Adder1.csa4x2_8_lvl0.18 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.19, s8_lvl0_19,t8_lvl0_19,cout_csa4x2_8_lvl0.19,PP_8_19,PP_9_19,PP_10_19,PP_11_19,cout_csa4x2_8_lvl0.18) ; // adder1bit Adder0.csa4x2_8_lvl0.19( sintcsa4x2_8_lvl0.19, cout_csa4x2_8_lvl0.19, PP_8_19, PP_9_19, PP_10_19) // sum xor2( w0.Adder0.csa4x2_8_lvl0.19, PP_8_19, PP_9_19 )#5 xor2( sintcsa4x2_8_lvl0.19, w0.Adder0.csa4x2_8_lvl0.19, PP_10_19 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.19, PP_8_19, PP_9_19 )#5 and2( w2.Adder0.csa4x2_8_lvl0.19, w0.Adder0.csa4x2_8_lvl0.19, PP_10_19 )#5 or2( cout_csa4x2_8_lvl0.19, w1.Adder0.csa4x2_8_lvl0.19, w2.Adder0.csa4x2_8_lvl0.19 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.19( s8_lvl0_19, t8_lvl0_19, sintcsa4x2_8_lvl0.19, PP_11_19, cout_csa4x2_8_lvl0.18) // sum xor2( w0.Adder1.csa4x2_8_lvl0.19, sintcsa4x2_8_lvl0.19, PP_11_19 )#5 xor2( s8_lvl0_19, w0.Adder1.csa4x2_8_lvl0.19, cout_csa4x2_8_lvl0.18 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.19, sintcsa4x2_8_lvl0.19, PP_11_19 )#5 and2( w2.Adder1.csa4x2_8_lvl0.19, w0.Adder1.csa4x2_8_lvl0.19, cout_csa4x2_8_lvl0.18 )#5 or2( t8_lvl0_19, w1.Adder1.csa4x2_8_lvl0.19, w2.Adder1.csa4x2_8_lvl0.19 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.20, s8_lvl0_20,t8_lvl0_20,cout_csa4x2_8_lvl0.20,PP_8_20,PP_9_20,PP_10_20,PP_11_20,cout_csa4x2_8_lvl0.19) ; // adder1bit Adder0.csa4x2_8_lvl0.20( sintcsa4x2_8_lvl0.20, cout_csa4x2_8_lvl0.20, PP_8_20, PP_9_20, PP_10_20) // sum xor2( w0.Adder0.csa4x2_8_lvl0.20, PP_8_20, PP_9_20 )#5 xor2( sintcsa4x2_8_lvl0.20, w0.Adder0.csa4x2_8_lvl0.20, PP_10_20 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.20, PP_8_20, PP_9_20 )#5 and2( w2.Adder0.csa4x2_8_lvl0.20, w0.Adder0.csa4x2_8_lvl0.20, PP_10_20 )#5 or2( cout_csa4x2_8_lvl0.20, w1.Adder0.csa4x2_8_lvl0.20, w2.Adder0.csa4x2_8_lvl0.20 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.20( s8_lvl0_20, t8_lvl0_20, sintcsa4x2_8_lvl0.20, PP_11_20, cout_csa4x2_8_lvl0.19) // sum xor2( w0.Adder1.csa4x2_8_lvl0.20, sintcsa4x2_8_lvl0.20, PP_11_20 )#5 xor2( s8_lvl0_20, w0.Adder1.csa4x2_8_lvl0.20, cout_csa4x2_8_lvl0.19 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.20, sintcsa4x2_8_lvl0.20, PP_11_20 )#5 and2( w2.Adder1.csa4x2_8_lvl0.20, w0.Adder1.csa4x2_8_lvl0.20, cout_csa4x2_8_lvl0.19 )#5 or2( t8_lvl0_20, w1.Adder1.csa4x2_8_lvl0.20, w2.Adder1.csa4x2_8_lvl0.20 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.21, s8_lvl0_21,t8_lvl0_21,cout_csa4x2_8_lvl0.21,PP_8_21,PP_9_21,PP_10_21,PP_11_21,cout_csa4x2_8_lvl0.20) ; // adder1bit Adder0.csa4x2_8_lvl0.21( sintcsa4x2_8_lvl0.21, cout_csa4x2_8_lvl0.21, PP_8_21, PP_9_21, PP_10_21) // sum xor2( w0.Adder0.csa4x2_8_lvl0.21, PP_8_21, PP_9_21 )#5 xor2( sintcsa4x2_8_lvl0.21, w0.Adder0.csa4x2_8_lvl0.21, PP_10_21 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.21, PP_8_21, PP_9_21 )#5 and2( w2.Adder0.csa4x2_8_lvl0.21, w0.Adder0.csa4x2_8_lvl0.21, PP_10_21 )#5 or2( cout_csa4x2_8_lvl0.21, w1.Adder0.csa4x2_8_lvl0.21, w2.Adder0.csa4x2_8_lvl0.21 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.21( s8_lvl0_21, t8_lvl0_21, sintcsa4x2_8_lvl0.21, PP_11_21, cout_csa4x2_8_lvl0.20) // sum xor2( w0.Adder1.csa4x2_8_lvl0.21, sintcsa4x2_8_lvl0.21, PP_11_21 )#5 xor2( s8_lvl0_21, w0.Adder1.csa4x2_8_lvl0.21, cout_csa4x2_8_lvl0.20 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.21, sintcsa4x2_8_lvl0.21, PP_11_21 )#5 and2( w2.Adder1.csa4x2_8_lvl0.21, w0.Adder1.csa4x2_8_lvl0.21, cout_csa4x2_8_lvl0.20 )#5 or2( t8_lvl0_21, w1.Adder1.csa4x2_8_lvl0.21, w2.Adder1.csa4x2_8_lvl0.21 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.22, s8_lvl0_22,t8_lvl0_22,cout_csa4x2_8_lvl0.22,PP_8_22,PP_9_22,PP_10_22,PP_11_22,cout_csa4x2_8_lvl0.21) ; // adder1bit Adder0.csa4x2_8_lvl0.22( sintcsa4x2_8_lvl0.22, cout_csa4x2_8_lvl0.22, PP_8_22, PP_9_22, PP_10_22) // sum xor2( w0.Adder0.csa4x2_8_lvl0.22, PP_8_22, PP_9_22 )#5 xor2( sintcsa4x2_8_lvl0.22, w0.Adder0.csa4x2_8_lvl0.22, PP_10_22 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.22, PP_8_22, PP_9_22 )#5 and2( w2.Adder0.csa4x2_8_lvl0.22, w0.Adder0.csa4x2_8_lvl0.22, PP_10_22 )#5 or2( cout_csa4x2_8_lvl0.22, w1.Adder0.csa4x2_8_lvl0.22, w2.Adder0.csa4x2_8_lvl0.22 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.22( s8_lvl0_22, t8_lvl0_22, sintcsa4x2_8_lvl0.22, PP_11_22, cout_csa4x2_8_lvl0.21) // sum xor2( w0.Adder1.csa4x2_8_lvl0.22, sintcsa4x2_8_lvl0.22, PP_11_22 )#5 xor2( s8_lvl0_22, w0.Adder1.csa4x2_8_lvl0.22, cout_csa4x2_8_lvl0.21 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.22, sintcsa4x2_8_lvl0.22, PP_11_22 )#5 and2( w2.Adder1.csa4x2_8_lvl0.22, w0.Adder1.csa4x2_8_lvl0.22, cout_csa4x2_8_lvl0.21 )#5 or2( t8_lvl0_22, w1.Adder1.csa4x2_8_lvl0.22, w2.Adder1.csa4x2_8_lvl0.22 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_8_lvl0.23, s8_lvl0_23,t8_lvl0_23,cout_csa4x2_8_lvl0.23,PP_8_23,PP_9_23,PP_10_23,PP_11_23,cout_csa4x2_8_lvl0.22) ; // adder1bit Adder0.csa4x2_8_lvl0.23( sintcsa4x2_8_lvl0.23, cout_csa4x2_8_lvl0.23, PP_8_23, PP_9_23, PP_10_23) // sum xor2( w0.Adder0.csa4x2_8_lvl0.23, PP_8_23, PP_9_23 )#5 xor2( sintcsa4x2_8_lvl0.23, w0.Adder0.csa4x2_8_lvl0.23, PP_10_23 )#5 //cout and2( w1.Adder0.csa4x2_8_lvl0.23, PP_8_23, PP_9_23 )#5 and2( w2.Adder0.csa4x2_8_lvl0.23, w0.Adder0.csa4x2_8_lvl0.23, PP_10_23 )#5 or2( cout_csa4x2_8_lvl0.23, w1.Adder0.csa4x2_8_lvl0.23, w2.Adder0.csa4x2_8_lvl0.23 )#5 // end adder1bit // adder1bit Adder1.csa4x2_8_lvl0.23( s8_lvl0_23, t8_lvl0_23, sintcsa4x2_8_lvl0.23, PP_11_23, cout_csa4x2_8_lvl0.22) // sum xor2( w0.Adder1.csa4x2_8_lvl0.23, sintcsa4x2_8_lvl0.23, PP_11_23 )#5 xor2( s8_lvl0_23, w0.Adder1.csa4x2_8_lvl0.23, cout_csa4x2_8_lvl0.22 )#5 //cout and2( w1.Adder1.csa4x2_8_lvl0.23, sintcsa4x2_8_lvl0.23, PP_11_23 )#5 and2( w2.Adder1.csa4x2_8_lvl0.23, w0.Adder1.csa4x2_8_lvl0.23, cout_csa4x2_8_lvl0.22 )#5 or2( t8_lvl0_23, w1.Adder1.csa4x2_8_lvl0.23, w2.Adder1.csa4x2_8_lvl0.23 )#5 // end adder1bit // end csa4x2 end // instantiating csa4x2Vec at lvl 1 netlist // csa4x2 (csa4x2_0_lvl1.0, s0_lvl1_0,t0_lvl1_0,cout_csa4x2_0_lvl1.0,s0_lvl0_0,GND,s4_lvl0_0,GND,GND) ; // adder1bit Adder0.csa4x2_0_lvl1.0( sintcsa4x2_0_lvl1.0, cout_csa4x2_0_lvl1.0, s0_lvl0_0, GND, s4_lvl0_0) // sum xor2( w0.Adder0.csa4x2_0_lvl1.0, s0_lvl0_0, GND )#5 xor2( sintcsa4x2_0_lvl1.0, w0.Adder0.csa4x2_0_lvl1.0, s4_lvl0_0 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.0, s0_lvl0_0, GND )#5 and2( w2.Adder0.csa4x2_0_lvl1.0, w0.Adder0.csa4x2_0_lvl1.0, s4_lvl0_0 )#5 or2( cout_csa4x2_0_lvl1.0, w1.Adder0.csa4x2_0_lvl1.0, w2.Adder0.csa4x2_0_lvl1.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.0( s0_lvl1_0, t0_lvl1_0, sintcsa4x2_0_lvl1.0, GND, GND) // sum xor2( w0.Adder1.csa4x2_0_lvl1.0, sintcsa4x2_0_lvl1.0, GND )#5 xor2( s0_lvl1_0, w0.Adder1.csa4x2_0_lvl1.0, GND )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.0, sintcsa4x2_0_lvl1.0, GND )#5 and2( w2.Adder1.csa4x2_0_lvl1.0, w0.Adder1.csa4x2_0_lvl1.0, GND )#5 or2( t0_lvl1_0, w1.Adder1.csa4x2_0_lvl1.0, w2.Adder1.csa4x2_0_lvl1.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.1, s0_lvl1_1,t0_lvl1_1,cout_csa4x2_0_lvl1.1,s0_lvl0_1,t0_lvl0_0,s4_lvl0_1,t4_lvl0_0,cout_csa4x2_0_lvl1.0) ; // adder1bit Adder0.csa4x2_0_lvl1.1( sintcsa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.1, s0_lvl0_1, t0_lvl0_0, s4_lvl0_1) // sum xor2( w0.Adder0.csa4x2_0_lvl1.1, s0_lvl0_1, t0_lvl0_0 )#5 xor2( sintcsa4x2_0_lvl1.1, w0.Adder0.csa4x2_0_lvl1.1, s4_lvl0_1 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.1, s0_lvl0_1, t0_lvl0_0 )#5 and2( w2.Adder0.csa4x2_0_lvl1.1, w0.Adder0.csa4x2_0_lvl1.1, s4_lvl0_1 )#5 or2( cout_csa4x2_0_lvl1.1, w1.Adder0.csa4x2_0_lvl1.1, w2.Adder0.csa4x2_0_lvl1.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.1( s0_lvl1_1, t0_lvl1_1, sintcsa4x2_0_lvl1.1, t4_lvl0_0, cout_csa4x2_0_lvl1.0) // sum xor2( w0.Adder1.csa4x2_0_lvl1.1, sintcsa4x2_0_lvl1.1, t4_lvl0_0 )#5 xor2( s0_lvl1_1, w0.Adder1.csa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.0 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.1, sintcsa4x2_0_lvl1.1, t4_lvl0_0 )#5 and2( w2.Adder1.csa4x2_0_lvl1.1, w0.Adder1.csa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.0 )#5 or2( t0_lvl1_1, w1.Adder1.csa4x2_0_lvl1.1, w2.Adder1.csa4x2_0_lvl1.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.2, s0_lvl1_2,t0_lvl1_2,cout_csa4x2_0_lvl1.2,s0_lvl0_2,t0_lvl0_1,s4_lvl0_2,t4_lvl0_1,cout_csa4x2_0_lvl1.1) ; // adder1bit Adder0.csa4x2_0_lvl1.2( sintcsa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.2, s0_lvl0_2, t0_lvl0_1, s4_lvl0_2) // sum xor2( w0.Adder0.csa4x2_0_lvl1.2, s0_lvl0_2, t0_lvl0_1 )#5 xor2( sintcsa4x2_0_lvl1.2, w0.Adder0.csa4x2_0_lvl1.2, s4_lvl0_2 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.2, s0_lvl0_2, t0_lvl0_1 )#5 and2( w2.Adder0.csa4x2_0_lvl1.2, w0.Adder0.csa4x2_0_lvl1.2, s4_lvl0_2 )#5 or2( cout_csa4x2_0_lvl1.2, w1.Adder0.csa4x2_0_lvl1.2, w2.Adder0.csa4x2_0_lvl1.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.2( s0_lvl1_2, t0_lvl1_2, sintcsa4x2_0_lvl1.2, t4_lvl0_1, cout_csa4x2_0_lvl1.1) // sum xor2( w0.Adder1.csa4x2_0_lvl1.2, sintcsa4x2_0_lvl1.2, t4_lvl0_1 )#5 xor2( s0_lvl1_2, w0.Adder1.csa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.1 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.2, sintcsa4x2_0_lvl1.2, t4_lvl0_1 )#5 and2( w2.Adder1.csa4x2_0_lvl1.2, w0.Adder1.csa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.1 )#5 or2( t0_lvl1_2, w1.Adder1.csa4x2_0_lvl1.2, w2.Adder1.csa4x2_0_lvl1.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.3, s0_lvl1_3,t0_lvl1_3,cout_csa4x2_0_lvl1.3,s0_lvl0_3,t0_lvl0_2,s4_lvl0_3,t4_lvl0_2,cout_csa4x2_0_lvl1.2) ; // adder1bit Adder0.csa4x2_0_lvl1.3( sintcsa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.3, s0_lvl0_3, t0_lvl0_2, s4_lvl0_3) // sum xor2( w0.Adder0.csa4x2_0_lvl1.3, s0_lvl0_3, t0_lvl0_2 )#5 xor2( sintcsa4x2_0_lvl1.3, w0.Adder0.csa4x2_0_lvl1.3, s4_lvl0_3 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.3, s0_lvl0_3, t0_lvl0_2 )#5 and2( w2.Adder0.csa4x2_0_lvl1.3, w0.Adder0.csa4x2_0_lvl1.3, s4_lvl0_3 )#5 or2( cout_csa4x2_0_lvl1.3, w1.Adder0.csa4x2_0_lvl1.3, w2.Adder0.csa4x2_0_lvl1.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.3( s0_lvl1_3, t0_lvl1_3, sintcsa4x2_0_lvl1.3, t4_lvl0_2, cout_csa4x2_0_lvl1.2) // sum xor2( w0.Adder1.csa4x2_0_lvl1.3, sintcsa4x2_0_lvl1.3, t4_lvl0_2 )#5 xor2( s0_lvl1_3, w0.Adder1.csa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.2 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.3, sintcsa4x2_0_lvl1.3, t4_lvl0_2 )#5 and2( w2.Adder1.csa4x2_0_lvl1.3, w0.Adder1.csa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.2 )#5 or2( t0_lvl1_3, w1.Adder1.csa4x2_0_lvl1.3, w2.Adder1.csa4x2_0_lvl1.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.4, s0_lvl1_4,t0_lvl1_4,cout_csa4x2_0_lvl1.4,s0_lvl0_4,t0_lvl0_3,s4_lvl0_4,t4_lvl0_3,cout_csa4x2_0_lvl1.3) ; // adder1bit Adder0.csa4x2_0_lvl1.4( sintcsa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.4, s0_lvl0_4, t0_lvl0_3, s4_lvl0_4) // sum xor2( w0.Adder0.csa4x2_0_lvl1.4, s0_lvl0_4, t0_lvl0_3 )#5 xor2( sintcsa4x2_0_lvl1.4, w0.Adder0.csa4x2_0_lvl1.4, s4_lvl0_4 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.4, s0_lvl0_4, t0_lvl0_3 )#5 and2( w2.Adder0.csa4x2_0_lvl1.4, w0.Adder0.csa4x2_0_lvl1.4, s4_lvl0_4 )#5 or2( cout_csa4x2_0_lvl1.4, w1.Adder0.csa4x2_0_lvl1.4, w2.Adder0.csa4x2_0_lvl1.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.4( s0_lvl1_4, t0_lvl1_4, sintcsa4x2_0_lvl1.4, t4_lvl0_3, cout_csa4x2_0_lvl1.3) // sum xor2( w0.Adder1.csa4x2_0_lvl1.4, sintcsa4x2_0_lvl1.4, t4_lvl0_3 )#5 xor2( s0_lvl1_4, w0.Adder1.csa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.3 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.4, sintcsa4x2_0_lvl1.4, t4_lvl0_3 )#5 and2( w2.Adder1.csa4x2_0_lvl1.4, w0.Adder1.csa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.3 )#5 or2( t0_lvl1_4, w1.Adder1.csa4x2_0_lvl1.4, w2.Adder1.csa4x2_0_lvl1.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.5, s0_lvl1_5,t0_lvl1_5,cout_csa4x2_0_lvl1.5,s0_lvl0_5,t0_lvl0_4,s4_lvl0_5,t4_lvl0_4,cout_csa4x2_0_lvl1.4) ; // adder1bit Adder0.csa4x2_0_lvl1.5( sintcsa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.5, s0_lvl0_5, t0_lvl0_4, s4_lvl0_5) // sum xor2( w0.Adder0.csa4x2_0_lvl1.5, s0_lvl0_5, t0_lvl0_4 )#5 xor2( sintcsa4x2_0_lvl1.5, w0.Adder0.csa4x2_0_lvl1.5, s4_lvl0_5 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.5, s0_lvl0_5, t0_lvl0_4 )#5 and2( w2.Adder0.csa4x2_0_lvl1.5, w0.Adder0.csa4x2_0_lvl1.5, s4_lvl0_5 )#5 or2( cout_csa4x2_0_lvl1.5, w1.Adder0.csa4x2_0_lvl1.5, w2.Adder0.csa4x2_0_lvl1.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.5( s0_lvl1_5, t0_lvl1_5, sintcsa4x2_0_lvl1.5, t4_lvl0_4, cout_csa4x2_0_lvl1.4) // sum xor2( w0.Adder1.csa4x2_0_lvl1.5, sintcsa4x2_0_lvl1.5, t4_lvl0_4 )#5 xor2( s0_lvl1_5, w0.Adder1.csa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.4 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.5, sintcsa4x2_0_lvl1.5, t4_lvl0_4 )#5 and2( w2.Adder1.csa4x2_0_lvl1.5, w0.Adder1.csa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.4 )#5 or2( t0_lvl1_5, w1.Adder1.csa4x2_0_lvl1.5, w2.Adder1.csa4x2_0_lvl1.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.6, s0_lvl1_6,t0_lvl1_6,cout_csa4x2_0_lvl1.6,s0_lvl0_6,t0_lvl0_5,s4_lvl0_6,t4_lvl0_5,cout_csa4x2_0_lvl1.5) ; // adder1bit Adder0.csa4x2_0_lvl1.6( sintcsa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.6, s0_lvl0_6, t0_lvl0_5, s4_lvl0_6) // sum xor2( w0.Adder0.csa4x2_0_lvl1.6, s0_lvl0_6, t0_lvl0_5 )#5 xor2( sintcsa4x2_0_lvl1.6, w0.Adder0.csa4x2_0_lvl1.6, s4_lvl0_6 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.6, s0_lvl0_6, t0_lvl0_5 )#5 and2( w2.Adder0.csa4x2_0_lvl1.6, w0.Adder0.csa4x2_0_lvl1.6, s4_lvl0_6 )#5 or2( cout_csa4x2_0_lvl1.6, w1.Adder0.csa4x2_0_lvl1.6, w2.Adder0.csa4x2_0_lvl1.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.6( s0_lvl1_6, t0_lvl1_6, sintcsa4x2_0_lvl1.6, t4_lvl0_5, cout_csa4x2_0_lvl1.5) // sum xor2( w0.Adder1.csa4x2_0_lvl1.6, sintcsa4x2_0_lvl1.6, t4_lvl0_5 )#5 xor2( s0_lvl1_6, w0.Adder1.csa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.5 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.6, sintcsa4x2_0_lvl1.6, t4_lvl0_5 )#5 and2( w2.Adder1.csa4x2_0_lvl1.6, w0.Adder1.csa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.5 )#5 or2( t0_lvl1_6, w1.Adder1.csa4x2_0_lvl1.6, w2.Adder1.csa4x2_0_lvl1.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.7, s0_lvl1_7,t0_lvl1_7,cout_csa4x2_0_lvl1.7,s0_lvl0_7,t0_lvl0_6,s4_lvl0_7,t4_lvl0_6,cout_csa4x2_0_lvl1.6) ; // adder1bit Adder0.csa4x2_0_lvl1.7( sintcsa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.7, s0_lvl0_7, t0_lvl0_6, s4_lvl0_7) // sum xor2( w0.Adder0.csa4x2_0_lvl1.7, s0_lvl0_7, t0_lvl0_6 )#5 xor2( sintcsa4x2_0_lvl1.7, w0.Adder0.csa4x2_0_lvl1.7, s4_lvl0_7 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.7, s0_lvl0_7, t0_lvl0_6 )#5 and2( w2.Adder0.csa4x2_0_lvl1.7, w0.Adder0.csa4x2_0_lvl1.7, s4_lvl0_7 )#5 or2( cout_csa4x2_0_lvl1.7, w1.Adder0.csa4x2_0_lvl1.7, w2.Adder0.csa4x2_0_lvl1.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.7( s0_lvl1_7, t0_lvl1_7, sintcsa4x2_0_lvl1.7, t4_lvl0_6, cout_csa4x2_0_lvl1.6) // sum xor2( w0.Adder1.csa4x2_0_lvl1.7, sintcsa4x2_0_lvl1.7, t4_lvl0_6 )#5 xor2( s0_lvl1_7, w0.Adder1.csa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.6 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.7, sintcsa4x2_0_lvl1.7, t4_lvl0_6 )#5 and2( w2.Adder1.csa4x2_0_lvl1.7, w0.Adder1.csa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.6 )#5 or2( t0_lvl1_7, w1.Adder1.csa4x2_0_lvl1.7, w2.Adder1.csa4x2_0_lvl1.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.8, s0_lvl1_8,t0_lvl1_8,cout_csa4x2_0_lvl1.8,s0_lvl0_8,t0_lvl0_7,s4_lvl0_8,t4_lvl0_7,cout_csa4x2_0_lvl1.7) ; // adder1bit Adder0.csa4x2_0_lvl1.8( sintcsa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.8, s0_lvl0_8, t0_lvl0_7, s4_lvl0_8) // sum xor2( w0.Adder0.csa4x2_0_lvl1.8, s0_lvl0_8, t0_lvl0_7 )#5 xor2( sintcsa4x2_0_lvl1.8, w0.Adder0.csa4x2_0_lvl1.8, s4_lvl0_8 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.8, s0_lvl0_8, t0_lvl0_7 )#5 and2( w2.Adder0.csa4x2_0_lvl1.8, w0.Adder0.csa4x2_0_lvl1.8, s4_lvl0_8 )#5 or2( cout_csa4x2_0_lvl1.8, w1.Adder0.csa4x2_0_lvl1.8, w2.Adder0.csa4x2_0_lvl1.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.8( s0_lvl1_8, t0_lvl1_8, sintcsa4x2_0_lvl1.8, t4_lvl0_7, cout_csa4x2_0_lvl1.7) // sum xor2( w0.Adder1.csa4x2_0_lvl1.8, sintcsa4x2_0_lvl1.8, t4_lvl0_7 )#5 xor2( s0_lvl1_8, w0.Adder1.csa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.7 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.8, sintcsa4x2_0_lvl1.8, t4_lvl0_7 )#5 and2( w2.Adder1.csa4x2_0_lvl1.8, w0.Adder1.csa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.7 )#5 or2( t0_lvl1_8, w1.Adder1.csa4x2_0_lvl1.8, w2.Adder1.csa4x2_0_lvl1.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.9, s0_lvl1_9,t0_lvl1_9,cout_csa4x2_0_lvl1.9,s0_lvl0_9,t0_lvl0_8,s4_lvl0_9,t4_lvl0_8,cout_csa4x2_0_lvl1.8) ; // adder1bit Adder0.csa4x2_0_lvl1.9( sintcsa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.9, s0_lvl0_9, t0_lvl0_8, s4_lvl0_9) // sum xor2( w0.Adder0.csa4x2_0_lvl1.9, s0_lvl0_9, t0_lvl0_8 )#5 xor2( sintcsa4x2_0_lvl1.9, w0.Adder0.csa4x2_0_lvl1.9, s4_lvl0_9 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.9, s0_lvl0_9, t0_lvl0_8 )#5 and2( w2.Adder0.csa4x2_0_lvl1.9, w0.Adder0.csa4x2_0_lvl1.9, s4_lvl0_9 )#5 or2( cout_csa4x2_0_lvl1.9, w1.Adder0.csa4x2_0_lvl1.9, w2.Adder0.csa4x2_0_lvl1.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.9( s0_lvl1_9, t0_lvl1_9, sintcsa4x2_0_lvl1.9, t4_lvl0_8, cout_csa4x2_0_lvl1.8) // sum xor2( w0.Adder1.csa4x2_0_lvl1.9, sintcsa4x2_0_lvl1.9, t4_lvl0_8 )#5 xor2( s0_lvl1_9, w0.Adder1.csa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.8 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.9, sintcsa4x2_0_lvl1.9, t4_lvl0_8 )#5 and2( w2.Adder1.csa4x2_0_lvl1.9, w0.Adder1.csa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.8 )#5 or2( t0_lvl1_9, w1.Adder1.csa4x2_0_lvl1.9, w2.Adder1.csa4x2_0_lvl1.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.10, s0_lvl1_10,t0_lvl1_10,cout_csa4x2_0_lvl1.10,s0_lvl0_10,t0_lvl0_9,s4_lvl0_10,t4_lvl0_9,cout_csa4x2_0_lvl1.9) ; // adder1bit Adder0.csa4x2_0_lvl1.10( sintcsa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.10, s0_lvl0_10, t0_lvl0_9, s4_lvl0_10) // sum xor2( w0.Adder0.csa4x2_0_lvl1.10, s0_lvl0_10, t0_lvl0_9 )#5 xor2( sintcsa4x2_0_lvl1.10, w0.Adder0.csa4x2_0_lvl1.10, s4_lvl0_10 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.10, s0_lvl0_10, t0_lvl0_9 )#5 and2( w2.Adder0.csa4x2_0_lvl1.10, w0.Adder0.csa4x2_0_lvl1.10, s4_lvl0_10 )#5 or2( cout_csa4x2_0_lvl1.10, w1.Adder0.csa4x2_0_lvl1.10, w2.Adder0.csa4x2_0_lvl1.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.10( s0_lvl1_10, t0_lvl1_10, sintcsa4x2_0_lvl1.10, t4_lvl0_9, cout_csa4x2_0_lvl1.9) // sum xor2( w0.Adder1.csa4x2_0_lvl1.10, sintcsa4x2_0_lvl1.10, t4_lvl0_9 )#5 xor2( s0_lvl1_10, w0.Adder1.csa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.9 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.10, sintcsa4x2_0_lvl1.10, t4_lvl0_9 )#5 and2( w2.Adder1.csa4x2_0_lvl1.10, w0.Adder1.csa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.9 )#5 or2( t0_lvl1_10, w1.Adder1.csa4x2_0_lvl1.10, w2.Adder1.csa4x2_0_lvl1.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.11, s0_lvl1_11,t0_lvl1_11,cout_csa4x2_0_lvl1.11,s0_lvl0_11,t0_lvl0_10,s4_lvl0_11,t4_lvl0_10,cout_csa4x2_0_lvl1.10) ; // adder1bit Adder0.csa4x2_0_lvl1.11( sintcsa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.11, s0_lvl0_11, t0_lvl0_10, s4_lvl0_11) // sum xor2( w0.Adder0.csa4x2_0_lvl1.11, s0_lvl0_11, t0_lvl0_10 )#5 xor2( sintcsa4x2_0_lvl1.11, w0.Adder0.csa4x2_0_lvl1.11, s4_lvl0_11 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.11, s0_lvl0_11, t0_lvl0_10 )#5 and2( w2.Adder0.csa4x2_0_lvl1.11, w0.Adder0.csa4x2_0_lvl1.11, s4_lvl0_11 )#5 or2( cout_csa4x2_0_lvl1.11, w1.Adder0.csa4x2_0_lvl1.11, w2.Adder0.csa4x2_0_lvl1.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.11( s0_lvl1_11, t0_lvl1_11, sintcsa4x2_0_lvl1.11, t4_lvl0_10, cout_csa4x2_0_lvl1.10) // sum xor2( w0.Adder1.csa4x2_0_lvl1.11, sintcsa4x2_0_lvl1.11, t4_lvl0_10 )#5 xor2( s0_lvl1_11, w0.Adder1.csa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.10 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.11, sintcsa4x2_0_lvl1.11, t4_lvl0_10 )#5 and2( w2.Adder1.csa4x2_0_lvl1.11, w0.Adder1.csa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.10 )#5 or2( t0_lvl1_11, w1.Adder1.csa4x2_0_lvl1.11, w2.Adder1.csa4x2_0_lvl1.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.12, s0_lvl1_12,t0_lvl1_12,cout_csa4x2_0_lvl1.12,s0_lvl0_12,t0_lvl0_11,s4_lvl0_12,t4_lvl0_11,cout_csa4x2_0_lvl1.11) ; // adder1bit Adder0.csa4x2_0_lvl1.12( sintcsa4x2_0_lvl1.12, cout_csa4x2_0_lvl1.12, s0_lvl0_12, t0_lvl0_11, s4_lvl0_12) // sum xor2( w0.Adder0.csa4x2_0_lvl1.12, s0_lvl0_12, t0_lvl0_11 )#5 xor2( sintcsa4x2_0_lvl1.12, w0.Adder0.csa4x2_0_lvl1.12, s4_lvl0_12 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.12, s0_lvl0_12, t0_lvl0_11 )#5 and2( w2.Adder0.csa4x2_0_lvl1.12, w0.Adder0.csa4x2_0_lvl1.12, s4_lvl0_12 )#5 or2( cout_csa4x2_0_lvl1.12, w1.Adder0.csa4x2_0_lvl1.12, w2.Adder0.csa4x2_0_lvl1.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.12( s0_lvl1_12, t0_lvl1_12, sintcsa4x2_0_lvl1.12, t4_lvl0_11, cout_csa4x2_0_lvl1.11) // sum xor2( w0.Adder1.csa4x2_0_lvl1.12, sintcsa4x2_0_lvl1.12, t4_lvl0_11 )#5 xor2( s0_lvl1_12, w0.Adder1.csa4x2_0_lvl1.12, cout_csa4x2_0_lvl1.11 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.12, sintcsa4x2_0_lvl1.12, t4_lvl0_11 )#5 and2( w2.Adder1.csa4x2_0_lvl1.12, w0.Adder1.csa4x2_0_lvl1.12, cout_csa4x2_0_lvl1.11 )#5 or2( t0_lvl1_12, w1.Adder1.csa4x2_0_lvl1.12, w2.Adder1.csa4x2_0_lvl1.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.13, s0_lvl1_13,t0_lvl1_13,cout_csa4x2_0_lvl1.13,s0_lvl0_13,t0_lvl0_12,s4_lvl0_13,t4_lvl0_12,cout_csa4x2_0_lvl1.12) ; // adder1bit Adder0.csa4x2_0_lvl1.13( sintcsa4x2_0_lvl1.13, cout_csa4x2_0_lvl1.13, s0_lvl0_13, t0_lvl0_12, s4_lvl0_13) // sum xor2( w0.Adder0.csa4x2_0_lvl1.13, s0_lvl0_13, t0_lvl0_12 )#5 xor2( sintcsa4x2_0_lvl1.13, w0.Adder0.csa4x2_0_lvl1.13, s4_lvl0_13 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.13, s0_lvl0_13, t0_lvl0_12 )#5 and2( w2.Adder0.csa4x2_0_lvl1.13, w0.Adder0.csa4x2_0_lvl1.13, s4_lvl0_13 )#5 or2( cout_csa4x2_0_lvl1.13, w1.Adder0.csa4x2_0_lvl1.13, w2.Adder0.csa4x2_0_lvl1.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.13( s0_lvl1_13, t0_lvl1_13, sintcsa4x2_0_lvl1.13, t4_lvl0_12, cout_csa4x2_0_lvl1.12) // sum xor2( w0.Adder1.csa4x2_0_lvl1.13, sintcsa4x2_0_lvl1.13, t4_lvl0_12 )#5 xor2( s0_lvl1_13, w0.Adder1.csa4x2_0_lvl1.13, cout_csa4x2_0_lvl1.12 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.13, sintcsa4x2_0_lvl1.13, t4_lvl0_12 )#5 and2( w2.Adder1.csa4x2_0_lvl1.13, w0.Adder1.csa4x2_0_lvl1.13, cout_csa4x2_0_lvl1.12 )#5 or2( t0_lvl1_13, w1.Adder1.csa4x2_0_lvl1.13, w2.Adder1.csa4x2_0_lvl1.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.14, s0_lvl1_14,t0_lvl1_14,cout_csa4x2_0_lvl1.14,s0_lvl0_14,t0_lvl0_13,s4_lvl0_14,t4_lvl0_13,cout_csa4x2_0_lvl1.13) ; // adder1bit Adder0.csa4x2_0_lvl1.14( sintcsa4x2_0_lvl1.14, cout_csa4x2_0_lvl1.14, s0_lvl0_14, t0_lvl0_13, s4_lvl0_14) // sum xor2( w0.Adder0.csa4x2_0_lvl1.14, s0_lvl0_14, t0_lvl0_13 )#5 xor2( sintcsa4x2_0_lvl1.14, w0.Adder0.csa4x2_0_lvl1.14, s4_lvl0_14 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.14, s0_lvl0_14, t0_lvl0_13 )#5 and2( w2.Adder0.csa4x2_0_lvl1.14, w0.Adder0.csa4x2_0_lvl1.14, s4_lvl0_14 )#5 or2( cout_csa4x2_0_lvl1.14, w1.Adder0.csa4x2_0_lvl1.14, w2.Adder0.csa4x2_0_lvl1.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.14( s0_lvl1_14, t0_lvl1_14, sintcsa4x2_0_lvl1.14, t4_lvl0_13, cout_csa4x2_0_lvl1.13) // sum xor2( w0.Adder1.csa4x2_0_lvl1.14, sintcsa4x2_0_lvl1.14, t4_lvl0_13 )#5 xor2( s0_lvl1_14, w0.Adder1.csa4x2_0_lvl1.14, cout_csa4x2_0_lvl1.13 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.14, sintcsa4x2_0_lvl1.14, t4_lvl0_13 )#5 and2( w2.Adder1.csa4x2_0_lvl1.14, w0.Adder1.csa4x2_0_lvl1.14, cout_csa4x2_0_lvl1.13 )#5 or2( t0_lvl1_14, w1.Adder1.csa4x2_0_lvl1.14, w2.Adder1.csa4x2_0_lvl1.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.15, s0_lvl1_15,t0_lvl1_15,cout_csa4x2_0_lvl1.15,s0_lvl0_15,t0_lvl0_14,s4_lvl0_15,t4_lvl0_14,cout_csa4x2_0_lvl1.14) ; // adder1bit Adder0.csa4x2_0_lvl1.15( sintcsa4x2_0_lvl1.15, cout_csa4x2_0_lvl1.15, s0_lvl0_15, t0_lvl0_14, s4_lvl0_15) // sum xor2( w0.Adder0.csa4x2_0_lvl1.15, s0_lvl0_15, t0_lvl0_14 )#5 xor2( sintcsa4x2_0_lvl1.15, w0.Adder0.csa4x2_0_lvl1.15, s4_lvl0_15 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.15, s0_lvl0_15, t0_lvl0_14 )#5 and2( w2.Adder0.csa4x2_0_lvl1.15, w0.Adder0.csa4x2_0_lvl1.15, s4_lvl0_15 )#5 or2( cout_csa4x2_0_lvl1.15, w1.Adder0.csa4x2_0_lvl1.15, w2.Adder0.csa4x2_0_lvl1.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.15( s0_lvl1_15, t0_lvl1_15, sintcsa4x2_0_lvl1.15, t4_lvl0_14, cout_csa4x2_0_lvl1.14) // sum xor2( w0.Adder1.csa4x2_0_lvl1.15, sintcsa4x2_0_lvl1.15, t4_lvl0_14 )#5 xor2( s0_lvl1_15, w0.Adder1.csa4x2_0_lvl1.15, cout_csa4x2_0_lvl1.14 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.15, sintcsa4x2_0_lvl1.15, t4_lvl0_14 )#5 and2( w2.Adder1.csa4x2_0_lvl1.15, w0.Adder1.csa4x2_0_lvl1.15, cout_csa4x2_0_lvl1.14 )#5 or2( t0_lvl1_15, w1.Adder1.csa4x2_0_lvl1.15, w2.Adder1.csa4x2_0_lvl1.15 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.16, s0_lvl1_16,t0_lvl1_16,cout_csa4x2_0_lvl1.16,s0_lvl0_16,t0_lvl0_15,s4_lvl0_16,t4_lvl0_15,cout_csa4x2_0_lvl1.15) ; // adder1bit Adder0.csa4x2_0_lvl1.16( sintcsa4x2_0_lvl1.16, cout_csa4x2_0_lvl1.16, s0_lvl0_16, t0_lvl0_15, s4_lvl0_16) // sum xor2( w0.Adder0.csa4x2_0_lvl1.16, s0_lvl0_16, t0_lvl0_15 )#5 xor2( sintcsa4x2_0_lvl1.16, w0.Adder0.csa4x2_0_lvl1.16, s4_lvl0_16 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.16, s0_lvl0_16, t0_lvl0_15 )#5 and2( w2.Adder0.csa4x2_0_lvl1.16, w0.Adder0.csa4x2_0_lvl1.16, s4_lvl0_16 )#5 or2( cout_csa4x2_0_lvl1.16, w1.Adder0.csa4x2_0_lvl1.16, w2.Adder0.csa4x2_0_lvl1.16 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.16( s0_lvl1_16, t0_lvl1_16, sintcsa4x2_0_lvl1.16, t4_lvl0_15, cout_csa4x2_0_lvl1.15) // sum xor2( w0.Adder1.csa4x2_0_lvl1.16, sintcsa4x2_0_lvl1.16, t4_lvl0_15 )#5 xor2( s0_lvl1_16, w0.Adder1.csa4x2_0_lvl1.16, cout_csa4x2_0_lvl1.15 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.16, sintcsa4x2_0_lvl1.16, t4_lvl0_15 )#5 and2( w2.Adder1.csa4x2_0_lvl1.16, w0.Adder1.csa4x2_0_lvl1.16, cout_csa4x2_0_lvl1.15 )#5 or2( t0_lvl1_16, w1.Adder1.csa4x2_0_lvl1.16, w2.Adder1.csa4x2_0_lvl1.16 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.17, s0_lvl1_17,t0_lvl1_17,cout_csa4x2_0_lvl1.17,s0_lvl0_17,t0_lvl0_16,s4_lvl0_17,t4_lvl0_16,cout_csa4x2_0_lvl1.16) ; // adder1bit Adder0.csa4x2_0_lvl1.17( sintcsa4x2_0_lvl1.17, cout_csa4x2_0_lvl1.17, s0_lvl0_17, t0_lvl0_16, s4_lvl0_17) // sum xor2( w0.Adder0.csa4x2_0_lvl1.17, s0_lvl0_17, t0_lvl0_16 )#5 xor2( sintcsa4x2_0_lvl1.17, w0.Adder0.csa4x2_0_lvl1.17, s4_lvl0_17 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.17, s0_lvl0_17, t0_lvl0_16 )#5 and2( w2.Adder0.csa4x2_0_lvl1.17, w0.Adder0.csa4x2_0_lvl1.17, s4_lvl0_17 )#5 or2( cout_csa4x2_0_lvl1.17, w1.Adder0.csa4x2_0_lvl1.17, w2.Adder0.csa4x2_0_lvl1.17 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.17( s0_lvl1_17, t0_lvl1_17, sintcsa4x2_0_lvl1.17, t4_lvl0_16, cout_csa4x2_0_lvl1.16) // sum xor2( w0.Adder1.csa4x2_0_lvl1.17, sintcsa4x2_0_lvl1.17, t4_lvl0_16 )#5 xor2( s0_lvl1_17, w0.Adder1.csa4x2_0_lvl1.17, cout_csa4x2_0_lvl1.16 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.17, sintcsa4x2_0_lvl1.17, t4_lvl0_16 )#5 and2( w2.Adder1.csa4x2_0_lvl1.17, w0.Adder1.csa4x2_0_lvl1.17, cout_csa4x2_0_lvl1.16 )#5 or2( t0_lvl1_17, w1.Adder1.csa4x2_0_lvl1.17, w2.Adder1.csa4x2_0_lvl1.17 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.18, s0_lvl1_18,t0_lvl1_18,cout_csa4x2_0_lvl1.18,s0_lvl0_18,t0_lvl0_17,s4_lvl0_18,t4_lvl0_17,cout_csa4x2_0_lvl1.17) ; // adder1bit Adder0.csa4x2_0_lvl1.18( sintcsa4x2_0_lvl1.18, cout_csa4x2_0_lvl1.18, s0_lvl0_18, t0_lvl0_17, s4_lvl0_18) // sum xor2( w0.Adder0.csa4x2_0_lvl1.18, s0_lvl0_18, t0_lvl0_17 )#5 xor2( sintcsa4x2_0_lvl1.18, w0.Adder0.csa4x2_0_lvl1.18, s4_lvl0_18 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.18, s0_lvl0_18, t0_lvl0_17 )#5 and2( w2.Adder0.csa4x2_0_lvl1.18, w0.Adder0.csa4x2_0_lvl1.18, s4_lvl0_18 )#5 or2( cout_csa4x2_0_lvl1.18, w1.Adder0.csa4x2_0_lvl1.18, w2.Adder0.csa4x2_0_lvl1.18 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.18( s0_lvl1_18, t0_lvl1_18, sintcsa4x2_0_lvl1.18, t4_lvl0_17, cout_csa4x2_0_lvl1.17) // sum xor2( w0.Adder1.csa4x2_0_lvl1.18, sintcsa4x2_0_lvl1.18, t4_lvl0_17 )#5 xor2( s0_lvl1_18, w0.Adder1.csa4x2_0_lvl1.18, cout_csa4x2_0_lvl1.17 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.18, sintcsa4x2_0_lvl1.18, t4_lvl0_17 )#5 and2( w2.Adder1.csa4x2_0_lvl1.18, w0.Adder1.csa4x2_0_lvl1.18, cout_csa4x2_0_lvl1.17 )#5 or2( t0_lvl1_18, w1.Adder1.csa4x2_0_lvl1.18, w2.Adder1.csa4x2_0_lvl1.18 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.19, s0_lvl1_19,t0_lvl1_19,cout_csa4x2_0_lvl1.19,s0_lvl0_19,t0_lvl0_18,s4_lvl0_19,t4_lvl0_18,cout_csa4x2_0_lvl1.18) ; // adder1bit Adder0.csa4x2_0_lvl1.19( sintcsa4x2_0_lvl1.19, cout_csa4x2_0_lvl1.19, s0_lvl0_19, t0_lvl0_18, s4_lvl0_19) // sum xor2( w0.Adder0.csa4x2_0_lvl1.19, s0_lvl0_19, t0_lvl0_18 )#5 xor2( sintcsa4x2_0_lvl1.19, w0.Adder0.csa4x2_0_lvl1.19, s4_lvl0_19 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.19, s0_lvl0_19, t0_lvl0_18 )#5 and2( w2.Adder0.csa4x2_0_lvl1.19, w0.Adder0.csa4x2_0_lvl1.19, s4_lvl0_19 )#5 or2( cout_csa4x2_0_lvl1.19, w1.Adder0.csa4x2_0_lvl1.19, w2.Adder0.csa4x2_0_lvl1.19 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.19( s0_lvl1_19, t0_lvl1_19, sintcsa4x2_0_lvl1.19, t4_lvl0_18, cout_csa4x2_0_lvl1.18) // sum xor2( w0.Adder1.csa4x2_0_lvl1.19, sintcsa4x2_0_lvl1.19, t4_lvl0_18 )#5 xor2( s0_lvl1_19, w0.Adder1.csa4x2_0_lvl1.19, cout_csa4x2_0_lvl1.18 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.19, sintcsa4x2_0_lvl1.19, t4_lvl0_18 )#5 and2( w2.Adder1.csa4x2_0_lvl1.19, w0.Adder1.csa4x2_0_lvl1.19, cout_csa4x2_0_lvl1.18 )#5 or2( t0_lvl1_19, w1.Adder1.csa4x2_0_lvl1.19, w2.Adder1.csa4x2_0_lvl1.19 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.20, s0_lvl1_20,t0_lvl1_20,cout_csa4x2_0_lvl1.20,s0_lvl0_20,t0_lvl0_19,s4_lvl0_20,t4_lvl0_19,cout_csa4x2_0_lvl1.19) ; // adder1bit Adder0.csa4x2_0_lvl1.20( sintcsa4x2_0_lvl1.20, cout_csa4x2_0_lvl1.20, s0_lvl0_20, t0_lvl0_19, s4_lvl0_20) // sum xor2( w0.Adder0.csa4x2_0_lvl1.20, s0_lvl0_20, t0_lvl0_19 )#5 xor2( sintcsa4x2_0_lvl1.20, w0.Adder0.csa4x2_0_lvl1.20, s4_lvl0_20 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.20, s0_lvl0_20, t0_lvl0_19 )#5 and2( w2.Adder0.csa4x2_0_lvl1.20, w0.Adder0.csa4x2_0_lvl1.20, s4_lvl0_20 )#5 or2( cout_csa4x2_0_lvl1.20, w1.Adder0.csa4x2_0_lvl1.20, w2.Adder0.csa4x2_0_lvl1.20 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.20( s0_lvl1_20, t0_lvl1_20, sintcsa4x2_0_lvl1.20, t4_lvl0_19, cout_csa4x2_0_lvl1.19) // sum xor2( w0.Adder1.csa4x2_0_lvl1.20, sintcsa4x2_0_lvl1.20, t4_lvl0_19 )#5 xor2( s0_lvl1_20, w0.Adder1.csa4x2_0_lvl1.20, cout_csa4x2_0_lvl1.19 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.20, sintcsa4x2_0_lvl1.20, t4_lvl0_19 )#5 and2( w2.Adder1.csa4x2_0_lvl1.20, w0.Adder1.csa4x2_0_lvl1.20, cout_csa4x2_0_lvl1.19 )#5 or2( t0_lvl1_20, w1.Adder1.csa4x2_0_lvl1.20, w2.Adder1.csa4x2_0_lvl1.20 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.21, s0_lvl1_21,t0_lvl1_21,cout_csa4x2_0_lvl1.21,s0_lvl0_21,t0_lvl0_20,s4_lvl0_21,t4_lvl0_20,cout_csa4x2_0_lvl1.20) ; // adder1bit Adder0.csa4x2_0_lvl1.21( sintcsa4x2_0_lvl1.21, cout_csa4x2_0_lvl1.21, s0_lvl0_21, t0_lvl0_20, s4_lvl0_21) // sum xor2( w0.Adder0.csa4x2_0_lvl1.21, s0_lvl0_21, t0_lvl0_20 )#5 xor2( sintcsa4x2_0_lvl1.21, w0.Adder0.csa4x2_0_lvl1.21, s4_lvl0_21 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.21, s0_lvl0_21, t0_lvl0_20 )#5 and2( w2.Adder0.csa4x2_0_lvl1.21, w0.Adder0.csa4x2_0_lvl1.21, s4_lvl0_21 )#5 or2( cout_csa4x2_0_lvl1.21, w1.Adder0.csa4x2_0_lvl1.21, w2.Adder0.csa4x2_0_lvl1.21 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.21( s0_lvl1_21, t0_lvl1_21, sintcsa4x2_0_lvl1.21, t4_lvl0_20, cout_csa4x2_0_lvl1.20) // sum xor2( w0.Adder1.csa4x2_0_lvl1.21, sintcsa4x2_0_lvl1.21, t4_lvl0_20 )#5 xor2( s0_lvl1_21, w0.Adder1.csa4x2_0_lvl1.21, cout_csa4x2_0_lvl1.20 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.21, sintcsa4x2_0_lvl1.21, t4_lvl0_20 )#5 and2( w2.Adder1.csa4x2_0_lvl1.21, w0.Adder1.csa4x2_0_lvl1.21, cout_csa4x2_0_lvl1.20 )#5 or2( t0_lvl1_21, w1.Adder1.csa4x2_0_lvl1.21, w2.Adder1.csa4x2_0_lvl1.21 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.22, s0_lvl1_22,t0_lvl1_22,cout_csa4x2_0_lvl1.22,s0_lvl0_22,t0_lvl0_21,s4_lvl0_22,t4_lvl0_21,cout_csa4x2_0_lvl1.21) ; // adder1bit Adder0.csa4x2_0_lvl1.22( sintcsa4x2_0_lvl1.22, cout_csa4x2_0_lvl1.22, s0_lvl0_22, t0_lvl0_21, s4_lvl0_22) // sum xor2( w0.Adder0.csa4x2_0_lvl1.22, s0_lvl0_22, t0_lvl0_21 )#5 xor2( sintcsa4x2_0_lvl1.22, w0.Adder0.csa4x2_0_lvl1.22, s4_lvl0_22 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.22, s0_lvl0_22, t0_lvl0_21 )#5 and2( w2.Adder0.csa4x2_0_lvl1.22, w0.Adder0.csa4x2_0_lvl1.22, s4_lvl0_22 )#5 or2( cout_csa4x2_0_lvl1.22, w1.Adder0.csa4x2_0_lvl1.22, w2.Adder0.csa4x2_0_lvl1.22 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.22( s0_lvl1_22, t0_lvl1_22, sintcsa4x2_0_lvl1.22, t4_lvl0_21, cout_csa4x2_0_lvl1.21) // sum xor2( w0.Adder1.csa4x2_0_lvl1.22, sintcsa4x2_0_lvl1.22, t4_lvl0_21 )#5 xor2( s0_lvl1_22, w0.Adder1.csa4x2_0_lvl1.22, cout_csa4x2_0_lvl1.21 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.22, sintcsa4x2_0_lvl1.22, t4_lvl0_21 )#5 and2( w2.Adder1.csa4x2_0_lvl1.22, w0.Adder1.csa4x2_0_lvl1.22, cout_csa4x2_0_lvl1.21 )#5 or2( t0_lvl1_22, w1.Adder1.csa4x2_0_lvl1.22, w2.Adder1.csa4x2_0_lvl1.22 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.23, s0_lvl1_23,t0_lvl1_23,cout_csa4x2_0_lvl1.23,s0_lvl0_23,t0_lvl0_22,s4_lvl0_23,t4_lvl0_22,cout_csa4x2_0_lvl1.22) ; // adder1bit Adder0.csa4x2_0_lvl1.23( sintcsa4x2_0_lvl1.23, cout_csa4x2_0_lvl1.23, s0_lvl0_23, t0_lvl0_22, s4_lvl0_23) // sum xor2( w0.Adder0.csa4x2_0_lvl1.23, s0_lvl0_23, t0_lvl0_22 )#5 xor2( sintcsa4x2_0_lvl1.23, w0.Adder0.csa4x2_0_lvl1.23, s4_lvl0_23 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.23, s0_lvl0_23, t0_lvl0_22 )#5 and2( w2.Adder0.csa4x2_0_lvl1.23, w0.Adder0.csa4x2_0_lvl1.23, s4_lvl0_23 )#5 or2( cout_csa4x2_0_lvl1.23, w1.Adder0.csa4x2_0_lvl1.23, w2.Adder0.csa4x2_0_lvl1.23 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.23( s0_lvl1_23, t0_lvl1_23, sintcsa4x2_0_lvl1.23, t4_lvl0_22, cout_csa4x2_0_lvl1.22) // sum xor2( w0.Adder1.csa4x2_0_lvl1.23, sintcsa4x2_0_lvl1.23, t4_lvl0_22 )#5 xor2( s0_lvl1_23, w0.Adder1.csa4x2_0_lvl1.23, cout_csa4x2_0_lvl1.22 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.23, sintcsa4x2_0_lvl1.23, t4_lvl0_22 )#5 and2( w2.Adder1.csa4x2_0_lvl1.23, w0.Adder1.csa4x2_0_lvl1.23, cout_csa4x2_0_lvl1.22 )#5 or2( t0_lvl1_23, w1.Adder1.csa4x2_0_lvl1.23, w2.Adder1.csa4x2_0_lvl1.23 )#5 // end adder1bit // end csa4x2 end // instantiating csa4x2Vec at lvl 2 netlist // csa4x2 (csa4x2_0_lvl2.0, s0_lvl2_0,t0_lvl2_0,cout_csa4x2_0_lvl2.0,s8_lvl0_0,GND,s0_lvl1_0,GND,GND) ; // adder1bit Adder0.csa4x2_0_lvl2.0( sintcsa4x2_0_lvl2.0, cout_csa4x2_0_lvl2.0, s8_lvl0_0, GND, s0_lvl1_0) // sum xor2( w0.Adder0.csa4x2_0_lvl2.0, s8_lvl0_0, GND )#5 xor2( sintcsa4x2_0_lvl2.0, w0.Adder0.csa4x2_0_lvl2.0, s0_lvl1_0 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.0, s8_lvl0_0, GND )#5 and2( w2.Adder0.csa4x2_0_lvl2.0, w0.Adder0.csa4x2_0_lvl2.0, s0_lvl1_0 )#5 or2( cout_csa4x2_0_lvl2.0, w1.Adder0.csa4x2_0_lvl2.0, w2.Adder0.csa4x2_0_lvl2.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.0( s0_lvl2_0, t0_lvl2_0, sintcsa4x2_0_lvl2.0, GND, GND) // sum xor2( w0.Adder1.csa4x2_0_lvl2.0, sintcsa4x2_0_lvl2.0, GND )#5 xor2( s0_lvl2_0, w0.Adder1.csa4x2_0_lvl2.0, GND )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.0, sintcsa4x2_0_lvl2.0, GND )#5 and2( w2.Adder1.csa4x2_0_lvl2.0, w0.Adder1.csa4x2_0_lvl2.0, GND )#5 or2( t0_lvl2_0, w1.Adder1.csa4x2_0_lvl2.0, w2.Adder1.csa4x2_0_lvl2.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.1, s0_lvl2_1,t0_lvl2_1,cout_csa4x2_0_lvl2.1,s8_lvl0_1,t8_lvl0_0,s0_lvl1_1,t0_lvl1_0,cout_csa4x2_0_lvl2.0) ; // adder1bit Adder0.csa4x2_0_lvl2.1( sintcsa4x2_0_lvl2.1, cout_csa4x2_0_lvl2.1, s8_lvl0_1, t8_lvl0_0, s0_lvl1_1) // sum xor2( w0.Adder0.csa4x2_0_lvl2.1, s8_lvl0_1, t8_lvl0_0 )#5 xor2( sintcsa4x2_0_lvl2.1, w0.Adder0.csa4x2_0_lvl2.1, s0_lvl1_1 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.1, s8_lvl0_1, t8_lvl0_0 )#5 and2( w2.Adder0.csa4x2_0_lvl2.1, w0.Adder0.csa4x2_0_lvl2.1, s0_lvl1_1 )#5 or2( cout_csa4x2_0_lvl2.1, w1.Adder0.csa4x2_0_lvl2.1, w2.Adder0.csa4x2_0_lvl2.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.1( s0_lvl2_1, t0_lvl2_1, sintcsa4x2_0_lvl2.1, t0_lvl1_0, cout_csa4x2_0_lvl2.0) // sum xor2( w0.Adder1.csa4x2_0_lvl2.1, sintcsa4x2_0_lvl2.1, t0_lvl1_0 )#5 xor2( s0_lvl2_1, w0.Adder1.csa4x2_0_lvl2.1, cout_csa4x2_0_lvl2.0 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.1, sintcsa4x2_0_lvl2.1, t0_lvl1_0 )#5 and2( w2.Adder1.csa4x2_0_lvl2.1, w0.Adder1.csa4x2_0_lvl2.1, cout_csa4x2_0_lvl2.0 )#5 or2( t0_lvl2_1, w1.Adder1.csa4x2_0_lvl2.1, w2.Adder1.csa4x2_0_lvl2.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.2, s0_lvl2_2,t0_lvl2_2,cout_csa4x2_0_lvl2.2,s8_lvl0_2,t8_lvl0_1,s0_lvl1_2,t0_lvl1_1,cout_csa4x2_0_lvl2.1) ; // adder1bit Adder0.csa4x2_0_lvl2.2( sintcsa4x2_0_lvl2.2, cout_csa4x2_0_lvl2.2, s8_lvl0_2, t8_lvl0_1, s0_lvl1_2) // sum xor2( w0.Adder0.csa4x2_0_lvl2.2, s8_lvl0_2, t8_lvl0_1 )#5 xor2( sintcsa4x2_0_lvl2.2, w0.Adder0.csa4x2_0_lvl2.2, s0_lvl1_2 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.2, s8_lvl0_2, t8_lvl0_1 )#5 and2( w2.Adder0.csa4x2_0_lvl2.2, w0.Adder0.csa4x2_0_lvl2.2, s0_lvl1_2 )#5 or2( cout_csa4x2_0_lvl2.2, w1.Adder0.csa4x2_0_lvl2.2, w2.Adder0.csa4x2_0_lvl2.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.2( s0_lvl2_2, t0_lvl2_2, sintcsa4x2_0_lvl2.2, t0_lvl1_1, cout_csa4x2_0_lvl2.1) // sum xor2( w0.Adder1.csa4x2_0_lvl2.2, sintcsa4x2_0_lvl2.2, t0_lvl1_1 )#5 xor2( s0_lvl2_2, w0.Adder1.csa4x2_0_lvl2.2, cout_csa4x2_0_lvl2.1 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.2, sintcsa4x2_0_lvl2.2, t0_lvl1_1 )#5 and2( w2.Adder1.csa4x2_0_lvl2.2, w0.Adder1.csa4x2_0_lvl2.2, cout_csa4x2_0_lvl2.1 )#5 or2( t0_lvl2_2, w1.Adder1.csa4x2_0_lvl2.2, w2.Adder1.csa4x2_0_lvl2.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.3, s0_lvl2_3,t0_lvl2_3,cout_csa4x2_0_lvl2.3,s8_lvl0_3,t8_lvl0_2,s0_lvl1_3,t0_lvl1_2,cout_csa4x2_0_lvl2.2) ; // adder1bit Adder0.csa4x2_0_lvl2.3( sintcsa4x2_0_lvl2.3, cout_csa4x2_0_lvl2.3, s8_lvl0_3, t8_lvl0_2, s0_lvl1_3) // sum xor2( w0.Adder0.csa4x2_0_lvl2.3, s8_lvl0_3, t8_lvl0_2 )#5 xor2( sintcsa4x2_0_lvl2.3, w0.Adder0.csa4x2_0_lvl2.3, s0_lvl1_3 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.3, s8_lvl0_3, t8_lvl0_2 )#5 and2( w2.Adder0.csa4x2_0_lvl2.3, w0.Adder0.csa4x2_0_lvl2.3, s0_lvl1_3 )#5 or2( cout_csa4x2_0_lvl2.3, w1.Adder0.csa4x2_0_lvl2.3, w2.Adder0.csa4x2_0_lvl2.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.3( s0_lvl2_3, t0_lvl2_3, sintcsa4x2_0_lvl2.3, t0_lvl1_2, cout_csa4x2_0_lvl2.2) // sum xor2( w0.Adder1.csa4x2_0_lvl2.3, sintcsa4x2_0_lvl2.3, t0_lvl1_2 )#5 xor2( s0_lvl2_3, w0.Adder1.csa4x2_0_lvl2.3, cout_csa4x2_0_lvl2.2 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.3, sintcsa4x2_0_lvl2.3, t0_lvl1_2 )#5 and2( w2.Adder1.csa4x2_0_lvl2.3, w0.Adder1.csa4x2_0_lvl2.3, cout_csa4x2_0_lvl2.2 )#5 or2( t0_lvl2_3, w1.Adder1.csa4x2_0_lvl2.3, w2.Adder1.csa4x2_0_lvl2.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.4, s0_lvl2_4,t0_lvl2_4,cout_csa4x2_0_lvl2.4,s8_lvl0_4,t8_lvl0_3,s0_lvl1_4,t0_lvl1_3,cout_csa4x2_0_lvl2.3) ; // adder1bit Adder0.csa4x2_0_lvl2.4( sintcsa4x2_0_lvl2.4, cout_csa4x2_0_lvl2.4, s8_lvl0_4, t8_lvl0_3, s0_lvl1_4) // sum xor2( w0.Adder0.csa4x2_0_lvl2.4, s8_lvl0_4, t8_lvl0_3 )#5 xor2( sintcsa4x2_0_lvl2.4, w0.Adder0.csa4x2_0_lvl2.4, s0_lvl1_4 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.4, s8_lvl0_4, t8_lvl0_3 )#5 and2( w2.Adder0.csa4x2_0_lvl2.4, w0.Adder0.csa4x2_0_lvl2.4, s0_lvl1_4 )#5 or2( cout_csa4x2_0_lvl2.4, w1.Adder0.csa4x2_0_lvl2.4, w2.Adder0.csa4x2_0_lvl2.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.4( s0_lvl2_4, t0_lvl2_4, sintcsa4x2_0_lvl2.4, t0_lvl1_3, cout_csa4x2_0_lvl2.3) // sum xor2( w0.Adder1.csa4x2_0_lvl2.4, sintcsa4x2_0_lvl2.4, t0_lvl1_3 )#5 xor2( s0_lvl2_4, w0.Adder1.csa4x2_0_lvl2.4, cout_csa4x2_0_lvl2.3 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.4, sintcsa4x2_0_lvl2.4, t0_lvl1_3 )#5 and2( w2.Adder1.csa4x2_0_lvl2.4, w0.Adder1.csa4x2_0_lvl2.4, cout_csa4x2_0_lvl2.3 )#5 or2( t0_lvl2_4, w1.Adder1.csa4x2_0_lvl2.4, w2.Adder1.csa4x2_0_lvl2.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.5, s0_lvl2_5,t0_lvl2_5,cout_csa4x2_0_lvl2.5,s8_lvl0_5,t8_lvl0_4,s0_lvl1_5,t0_lvl1_4,cout_csa4x2_0_lvl2.4) ; // adder1bit Adder0.csa4x2_0_lvl2.5( sintcsa4x2_0_lvl2.5, cout_csa4x2_0_lvl2.5, s8_lvl0_5, t8_lvl0_4, s0_lvl1_5) // sum xor2( w0.Adder0.csa4x2_0_lvl2.5, s8_lvl0_5, t8_lvl0_4 )#5 xor2( sintcsa4x2_0_lvl2.5, w0.Adder0.csa4x2_0_lvl2.5, s0_lvl1_5 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.5, s8_lvl0_5, t8_lvl0_4 )#5 and2( w2.Adder0.csa4x2_0_lvl2.5, w0.Adder0.csa4x2_0_lvl2.5, s0_lvl1_5 )#5 or2( cout_csa4x2_0_lvl2.5, w1.Adder0.csa4x2_0_lvl2.5, w2.Adder0.csa4x2_0_lvl2.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.5( s0_lvl2_5, t0_lvl2_5, sintcsa4x2_0_lvl2.5, t0_lvl1_4, cout_csa4x2_0_lvl2.4) // sum xor2( w0.Adder1.csa4x2_0_lvl2.5, sintcsa4x2_0_lvl2.5, t0_lvl1_4 )#5 xor2( s0_lvl2_5, w0.Adder1.csa4x2_0_lvl2.5, cout_csa4x2_0_lvl2.4 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.5, sintcsa4x2_0_lvl2.5, t0_lvl1_4 )#5 and2( w2.Adder1.csa4x2_0_lvl2.5, w0.Adder1.csa4x2_0_lvl2.5, cout_csa4x2_0_lvl2.4 )#5 or2( t0_lvl2_5, w1.Adder1.csa4x2_0_lvl2.5, w2.Adder1.csa4x2_0_lvl2.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.6, s0_lvl2_6,t0_lvl2_6,cout_csa4x2_0_lvl2.6,s8_lvl0_6,t8_lvl0_5,s0_lvl1_6,t0_lvl1_5,cout_csa4x2_0_lvl2.5) ; // adder1bit Adder0.csa4x2_0_lvl2.6( sintcsa4x2_0_lvl2.6, cout_csa4x2_0_lvl2.6, s8_lvl0_6, t8_lvl0_5, s0_lvl1_6) // sum xor2( w0.Adder0.csa4x2_0_lvl2.6, s8_lvl0_6, t8_lvl0_5 )#5 xor2( sintcsa4x2_0_lvl2.6, w0.Adder0.csa4x2_0_lvl2.6, s0_lvl1_6 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.6, s8_lvl0_6, t8_lvl0_5 )#5 and2( w2.Adder0.csa4x2_0_lvl2.6, w0.Adder0.csa4x2_0_lvl2.6, s0_lvl1_6 )#5 or2( cout_csa4x2_0_lvl2.6, w1.Adder0.csa4x2_0_lvl2.6, w2.Adder0.csa4x2_0_lvl2.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.6( s0_lvl2_6, t0_lvl2_6, sintcsa4x2_0_lvl2.6, t0_lvl1_5, cout_csa4x2_0_lvl2.5) // sum xor2( w0.Adder1.csa4x2_0_lvl2.6, sintcsa4x2_0_lvl2.6, t0_lvl1_5 )#5 xor2( s0_lvl2_6, w0.Adder1.csa4x2_0_lvl2.6, cout_csa4x2_0_lvl2.5 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.6, sintcsa4x2_0_lvl2.6, t0_lvl1_5 )#5 and2( w2.Adder1.csa4x2_0_lvl2.6, w0.Adder1.csa4x2_0_lvl2.6, cout_csa4x2_0_lvl2.5 )#5 or2( t0_lvl2_6, w1.Adder1.csa4x2_0_lvl2.6, w2.Adder1.csa4x2_0_lvl2.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.7, s0_lvl2_7,t0_lvl2_7,cout_csa4x2_0_lvl2.7,s8_lvl0_7,t8_lvl0_6,s0_lvl1_7,t0_lvl1_6,cout_csa4x2_0_lvl2.6) ; // adder1bit Adder0.csa4x2_0_lvl2.7( sintcsa4x2_0_lvl2.7, cout_csa4x2_0_lvl2.7, s8_lvl0_7, t8_lvl0_6, s0_lvl1_7) // sum xor2( w0.Adder0.csa4x2_0_lvl2.7, s8_lvl0_7, t8_lvl0_6 )#5 xor2( sintcsa4x2_0_lvl2.7, w0.Adder0.csa4x2_0_lvl2.7, s0_lvl1_7 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.7, s8_lvl0_7, t8_lvl0_6 )#5 and2( w2.Adder0.csa4x2_0_lvl2.7, w0.Adder0.csa4x2_0_lvl2.7, s0_lvl1_7 )#5 or2( cout_csa4x2_0_lvl2.7, w1.Adder0.csa4x2_0_lvl2.7, w2.Adder0.csa4x2_0_lvl2.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.7( s0_lvl2_7, t0_lvl2_7, sintcsa4x2_0_lvl2.7, t0_lvl1_6, cout_csa4x2_0_lvl2.6) // sum xor2( w0.Adder1.csa4x2_0_lvl2.7, sintcsa4x2_0_lvl2.7, t0_lvl1_6 )#5 xor2( s0_lvl2_7, w0.Adder1.csa4x2_0_lvl2.7, cout_csa4x2_0_lvl2.6 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.7, sintcsa4x2_0_lvl2.7, t0_lvl1_6 )#5 and2( w2.Adder1.csa4x2_0_lvl2.7, w0.Adder1.csa4x2_0_lvl2.7, cout_csa4x2_0_lvl2.6 )#5 or2( t0_lvl2_7, w1.Adder1.csa4x2_0_lvl2.7, w2.Adder1.csa4x2_0_lvl2.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.8, s0_lvl2_8,t0_lvl2_8,cout_csa4x2_0_lvl2.8,s8_lvl0_8,t8_lvl0_7,s0_lvl1_8,t0_lvl1_7,cout_csa4x2_0_lvl2.7) ; // adder1bit Adder0.csa4x2_0_lvl2.8( sintcsa4x2_0_lvl2.8, cout_csa4x2_0_lvl2.8, s8_lvl0_8, t8_lvl0_7, s0_lvl1_8) // sum xor2( w0.Adder0.csa4x2_0_lvl2.8, s8_lvl0_8, t8_lvl0_7 )#5 xor2( sintcsa4x2_0_lvl2.8, w0.Adder0.csa4x2_0_lvl2.8, s0_lvl1_8 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.8, s8_lvl0_8, t8_lvl0_7 )#5 and2( w2.Adder0.csa4x2_0_lvl2.8, w0.Adder0.csa4x2_0_lvl2.8, s0_lvl1_8 )#5 or2( cout_csa4x2_0_lvl2.8, w1.Adder0.csa4x2_0_lvl2.8, w2.Adder0.csa4x2_0_lvl2.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.8( s0_lvl2_8, t0_lvl2_8, sintcsa4x2_0_lvl2.8, t0_lvl1_7, cout_csa4x2_0_lvl2.7) // sum xor2( w0.Adder1.csa4x2_0_lvl2.8, sintcsa4x2_0_lvl2.8, t0_lvl1_7 )#5 xor2( s0_lvl2_8, w0.Adder1.csa4x2_0_lvl2.8, cout_csa4x2_0_lvl2.7 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.8, sintcsa4x2_0_lvl2.8, t0_lvl1_7 )#5 and2( w2.Adder1.csa4x2_0_lvl2.8, w0.Adder1.csa4x2_0_lvl2.8, cout_csa4x2_0_lvl2.7 )#5 or2( t0_lvl2_8, w1.Adder1.csa4x2_0_lvl2.8, w2.Adder1.csa4x2_0_lvl2.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.9, s0_lvl2_9,t0_lvl2_9,cout_csa4x2_0_lvl2.9,s8_lvl0_9,t8_lvl0_8,s0_lvl1_9,t0_lvl1_8,cout_csa4x2_0_lvl2.8) ; // adder1bit Adder0.csa4x2_0_lvl2.9( sintcsa4x2_0_lvl2.9, cout_csa4x2_0_lvl2.9, s8_lvl0_9, t8_lvl0_8, s0_lvl1_9) // sum xor2( w0.Adder0.csa4x2_0_lvl2.9, s8_lvl0_9, t8_lvl0_8 )#5 xor2( sintcsa4x2_0_lvl2.9, w0.Adder0.csa4x2_0_lvl2.9, s0_lvl1_9 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.9, s8_lvl0_9, t8_lvl0_8 )#5 and2( w2.Adder0.csa4x2_0_lvl2.9, w0.Adder0.csa4x2_0_lvl2.9, s0_lvl1_9 )#5 or2( cout_csa4x2_0_lvl2.9, w1.Adder0.csa4x2_0_lvl2.9, w2.Adder0.csa4x2_0_lvl2.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.9( s0_lvl2_9, t0_lvl2_9, sintcsa4x2_0_lvl2.9, t0_lvl1_8, cout_csa4x2_0_lvl2.8) // sum xor2( w0.Adder1.csa4x2_0_lvl2.9, sintcsa4x2_0_lvl2.9, t0_lvl1_8 )#5 xor2( s0_lvl2_9, w0.Adder1.csa4x2_0_lvl2.9, cout_csa4x2_0_lvl2.8 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.9, sintcsa4x2_0_lvl2.9, t0_lvl1_8 )#5 and2( w2.Adder1.csa4x2_0_lvl2.9, w0.Adder1.csa4x2_0_lvl2.9, cout_csa4x2_0_lvl2.8 )#5 or2( t0_lvl2_9, w1.Adder1.csa4x2_0_lvl2.9, w2.Adder1.csa4x2_0_lvl2.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.10, s0_lvl2_10,t0_lvl2_10,cout_csa4x2_0_lvl2.10,s8_lvl0_10,t8_lvl0_9,s0_lvl1_10,t0_lvl1_9,cout_csa4x2_0_lvl2.9) ; // adder1bit Adder0.csa4x2_0_lvl2.10( sintcsa4x2_0_lvl2.10, cout_csa4x2_0_lvl2.10, s8_lvl0_10, t8_lvl0_9, s0_lvl1_10) // sum xor2( w0.Adder0.csa4x2_0_lvl2.10, s8_lvl0_10, t8_lvl0_9 )#5 xor2( sintcsa4x2_0_lvl2.10, w0.Adder0.csa4x2_0_lvl2.10, s0_lvl1_10 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.10, s8_lvl0_10, t8_lvl0_9 )#5 and2( w2.Adder0.csa4x2_0_lvl2.10, w0.Adder0.csa4x2_0_lvl2.10, s0_lvl1_10 )#5 or2( cout_csa4x2_0_lvl2.10, w1.Adder0.csa4x2_0_lvl2.10, w2.Adder0.csa4x2_0_lvl2.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.10( s0_lvl2_10, t0_lvl2_10, sintcsa4x2_0_lvl2.10, t0_lvl1_9, cout_csa4x2_0_lvl2.9) // sum xor2( w0.Adder1.csa4x2_0_lvl2.10, sintcsa4x2_0_lvl2.10, t0_lvl1_9 )#5 xor2( s0_lvl2_10, w0.Adder1.csa4x2_0_lvl2.10, cout_csa4x2_0_lvl2.9 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.10, sintcsa4x2_0_lvl2.10, t0_lvl1_9 )#5 and2( w2.Adder1.csa4x2_0_lvl2.10, w0.Adder1.csa4x2_0_lvl2.10, cout_csa4x2_0_lvl2.9 )#5 or2( t0_lvl2_10, w1.Adder1.csa4x2_0_lvl2.10, w2.Adder1.csa4x2_0_lvl2.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.11, s0_lvl2_11,t0_lvl2_11,cout_csa4x2_0_lvl2.11,s8_lvl0_11,t8_lvl0_10,s0_lvl1_11,t0_lvl1_10,cout_csa4x2_0_lvl2.10) ; // adder1bit Adder0.csa4x2_0_lvl2.11( sintcsa4x2_0_lvl2.11, cout_csa4x2_0_lvl2.11, s8_lvl0_11, t8_lvl0_10, s0_lvl1_11) // sum xor2( w0.Adder0.csa4x2_0_lvl2.11, s8_lvl0_11, t8_lvl0_10 )#5 xor2( sintcsa4x2_0_lvl2.11, w0.Adder0.csa4x2_0_lvl2.11, s0_lvl1_11 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.11, s8_lvl0_11, t8_lvl0_10 )#5 and2( w2.Adder0.csa4x2_0_lvl2.11, w0.Adder0.csa4x2_0_lvl2.11, s0_lvl1_11 )#5 or2( cout_csa4x2_0_lvl2.11, w1.Adder0.csa4x2_0_lvl2.11, w2.Adder0.csa4x2_0_lvl2.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.11( s0_lvl2_11, t0_lvl2_11, sintcsa4x2_0_lvl2.11, t0_lvl1_10, cout_csa4x2_0_lvl2.10) // sum xor2( w0.Adder1.csa4x2_0_lvl2.11, sintcsa4x2_0_lvl2.11, t0_lvl1_10 )#5 xor2( s0_lvl2_11, w0.Adder1.csa4x2_0_lvl2.11, cout_csa4x2_0_lvl2.10 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.11, sintcsa4x2_0_lvl2.11, t0_lvl1_10 )#5 and2( w2.Adder1.csa4x2_0_lvl2.11, w0.Adder1.csa4x2_0_lvl2.11, cout_csa4x2_0_lvl2.10 )#5 or2( t0_lvl2_11, w1.Adder1.csa4x2_0_lvl2.11, w2.Adder1.csa4x2_0_lvl2.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.12, s0_lvl2_12,t0_lvl2_12,cout_csa4x2_0_lvl2.12,s8_lvl0_12,t8_lvl0_11,s0_lvl1_12,t0_lvl1_11,cout_csa4x2_0_lvl2.11) ; // adder1bit Adder0.csa4x2_0_lvl2.12( sintcsa4x2_0_lvl2.12, cout_csa4x2_0_lvl2.12, s8_lvl0_12, t8_lvl0_11, s0_lvl1_12) // sum xor2( w0.Adder0.csa4x2_0_lvl2.12, s8_lvl0_12, t8_lvl0_11 )#5 xor2( sintcsa4x2_0_lvl2.12, w0.Adder0.csa4x2_0_lvl2.12, s0_lvl1_12 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.12, s8_lvl0_12, t8_lvl0_11 )#5 and2( w2.Adder0.csa4x2_0_lvl2.12, w0.Adder0.csa4x2_0_lvl2.12, s0_lvl1_12 )#5 or2( cout_csa4x2_0_lvl2.12, w1.Adder0.csa4x2_0_lvl2.12, w2.Adder0.csa4x2_0_lvl2.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.12( s0_lvl2_12, t0_lvl2_12, sintcsa4x2_0_lvl2.12, t0_lvl1_11, cout_csa4x2_0_lvl2.11) // sum xor2( w0.Adder1.csa4x2_0_lvl2.12, sintcsa4x2_0_lvl2.12, t0_lvl1_11 )#5 xor2( s0_lvl2_12, w0.Adder1.csa4x2_0_lvl2.12, cout_csa4x2_0_lvl2.11 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.12, sintcsa4x2_0_lvl2.12, t0_lvl1_11 )#5 and2( w2.Adder1.csa4x2_0_lvl2.12, w0.Adder1.csa4x2_0_lvl2.12, cout_csa4x2_0_lvl2.11 )#5 or2( t0_lvl2_12, w1.Adder1.csa4x2_0_lvl2.12, w2.Adder1.csa4x2_0_lvl2.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.13, s0_lvl2_13,t0_lvl2_13,cout_csa4x2_0_lvl2.13,s8_lvl0_13,t8_lvl0_12,s0_lvl1_13,t0_lvl1_12,cout_csa4x2_0_lvl2.12) ; // adder1bit Adder0.csa4x2_0_lvl2.13( sintcsa4x2_0_lvl2.13, cout_csa4x2_0_lvl2.13, s8_lvl0_13, t8_lvl0_12, s0_lvl1_13) // sum xor2( w0.Adder0.csa4x2_0_lvl2.13, s8_lvl0_13, t8_lvl0_12 )#5 xor2( sintcsa4x2_0_lvl2.13, w0.Adder0.csa4x2_0_lvl2.13, s0_lvl1_13 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.13, s8_lvl0_13, t8_lvl0_12 )#5 and2( w2.Adder0.csa4x2_0_lvl2.13, w0.Adder0.csa4x2_0_lvl2.13, s0_lvl1_13 )#5 or2( cout_csa4x2_0_lvl2.13, w1.Adder0.csa4x2_0_lvl2.13, w2.Adder0.csa4x2_0_lvl2.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.13( s0_lvl2_13, t0_lvl2_13, sintcsa4x2_0_lvl2.13, t0_lvl1_12, cout_csa4x2_0_lvl2.12) // sum xor2( w0.Adder1.csa4x2_0_lvl2.13, sintcsa4x2_0_lvl2.13, t0_lvl1_12 )#5 xor2( s0_lvl2_13, w0.Adder1.csa4x2_0_lvl2.13, cout_csa4x2_0_lvl2.12 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.13, sintcsa4x2_0_lvl2.13, t0_lvl1_12 )#5 and2( w2.Adder1.csa4x2_0_lvl2.13, w0.Adder1.csa4x2_0_lvl2.13, cout_csa4x2_0_lvl2.12 )#5 or2( t0_lvl2_13, w1.Adder1.csa4x2_0_lvl2.13, w2.Adder1.csa4x2_0_lvl2.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.14, s0_lvl2_14,t0_lvl2_14,cout_csa4x2_0_lvl2.14,s8_lvl0_14,t8_lvl0_13,s0_lvl1_14,t0_lvl1_13,cout_csa4x2_0_lvl2.13) ; // adder1bit Adder0.csa4x2_0_lvl2.14( sintcsa4x2_0_lvl2.14, cout_csa4x2_0_lvl2.14, s8_lvl0_14, t8_lvl0_13, s0_lvl1_14) // sum xor2( w0.Adder0.csa4x2_0_lvl2.14, s8_lvl0_14, t8_lvl0_13 )#5 xor2( sintcsa4x2_0_lvl2.14, w0.Adder0.csa4x2_0_lvl2.14, s0_lvl1_14 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.14, s8_lvl0_14, t8_lvl0_13 )#5 and2( w2.Adder0.csa4x2_0_lvl2.14, w0.Adder0.csa4x2_0_lvl2.14, s0_lvl1_14 )#5 or2( cout_csa4x2_0_lvl2.14, w1.Adder0.csa4x2_0_lvl2.14, w2.Adder0.csa4x2_0_lvl2.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.14( s0_lvl2_14, t0_lvl2_14, sintcsa4x2_0_lvl2.14, t0_lvl1_13, cout_csa4x2_0_lvl2.13) // sum xor2( w0.Adder1.csa4x2_0_lvl2.14, sintcsa4x2_0_lvl2.14, t0_lvl1_13 )#5 xor2( s0_lvl2_14, w0.Adder1.csa4x2_0_lvl2.14, cout_csa4x2_0_lvl2.13 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.14, sintcsa4x2_0_lvl2.14, t0_lvl1_13 )#5 and2( w2.Adder1.csa4x2_0_lvl2.14, w0.Adder1.csa4x2_0_lvl2.14, cout_csa4x2_0_lvl2.13 )#5 or2( t0_lvl2_14, w1.Adder1.csa4x2_0_lvl2.14, w2.Adder1.csa4x2_0_lvl2.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.15, s0_lvl2_15,t0_lvl2_15,cout_csa4x2_0_lvl2.15,s8_lvl0_15,t8_lvl0_14,s0_lvl1_15,t0_lvl1_14,cout_csa4x2_0_lvl2.14) ; // adder1bit Adder0.csa4x2_0_lvl2.15( sintcsa4x2_0_lvl2.15, cout_csa4x2_0_lvl2.15, s8_lvl0_15, t8_lvl0_14, s0_lvl1_15) // sum xor2( w0.Adder0.csa4x2_0_lvl2.15, s8_lvl0_15, t8_lvl0_14 )#5 xor2( sintcsa4x2_0_lvl2.15, w0.Adder0.csa4x2_0_lvl2.15, s0_lvl1_15 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.15, s8_lvl0_15, t8_lvl0_14 )#5 and2( w2.Adder0.csa4x2_0_lvl2.15, w0.Adder0.csa4x2_0_lvl2.15, s0_lvl1_15 )#5 or2( cout_csa4x2_0_lvl2.15, w1.Adder0.csa4x2_0_lvl2.15, w2.Adder0.csa4x2_0_lvl2.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.15( s0_lvl2_15, t0_lvl2_15, sintcsa4x2_0_lvl2.15, t0_lvl1_14, cout_csa4x2_0_lvl2.14) // sum xor2( w0.Adder1.csa4x2_0_lvl2.15, sintcsa4x2_0_lvl2.15, t0_lvl1_14 )#5 xor2( s0_lvl2_15, w0.Adder1.csa4x2_0_lvl2.15, cout_csa4x2_0_lvl2.14 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.15, sintcsa4x2_0_lvl2.15, t0_lvl1_14 )#5 and2( w2.Adder1.csa4x2_0_lvl2.15, w0.Adder1.csa4x2_0_lvl2.15, cout_csa4x2_0_lvl2.14 )#5 or2( t0_lvl2_15, w1.Adder1.csa4x2_0_lvl2.15, w2.Adder1.csa4x2_0_lvl2.15 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.16, s0_lvl2_16,t0_lvl2_16,cout_csa4x2_0_lvl2.16,s8_lvl0_16,t8_lvl0_15,s0_lvl1_16,t0_lvl1_15,cout_csa4x2_0_lvl2.15) ; // adder1bit Adder0.csa4x2_0_lvl2.16( sintcsa4x2_0_lvl2.16, cout_csa4x2_0_lvl2.16, s8_lvl0_16, t8_lvl0_15, s0_lvl1_16) // sum xor2( w0.Adder0.csa4x2_0_lvl2.16, s8_lvl0_16, t8_lvl0_15 )#5 xor2( sintcsa4x2_0_lvl2.16, w0.Adder0.csa4x2_0_lvl2.16, s0_lvl1_16 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.16, s8_lvl0_16, t8_lvl0_15 )#5 and2( w2.Adder0.csa4x2_0_lvl2.16, w0.Adder0.csa4x2_0_lvl2.16, s0_lvl1_16 )#5 or2( cout_csa4x2_0_lvl2.16, w1.Adder0.csa4x2_0_lvl2.16, w2.Adder0.csa4x2_0_lvl2.16 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.16( s0_lvl2_16, t0_lvl2_16, sintcsa4x2_0_lvl2.16, t0_lvl1_15, cout_csa4x2_0_lvl2.15) // sum xor2( w0.Adder1.csa4x2_0_lvl2.16, sintcsa4x2_0_lvl2.16, t0_lvl1_15 )#5 xor2( s0_lvl2_16, w0.Adder1.csa4x2_0_lvl2.16, cout_csa4x2_0_lvl2.15 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.16, sintcsa4x2_0_lvl2.16, t0_lvl1_15 )#5 and2( w2.Adder1.csa4x2_0_lvl2.16, w0.Adder1.csa4x2_0_lvl2.16, cout_csa4x2_0_lvl2.15 )#5 or2( t0_lvl2_16, w1.Adder1.csa4x2_0_lvl2.16, w2.Adder1.csa4x2_0_lvl2.16 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.17, s0_lvl2_17,t0_lvl2_17,cout_csa4x2_0_lvl2.17,s8_lvl0_17,t8_lvl0_16,s0_lvl1_17,t0_lvl1_16,cout_csa4x2_0_lvl2.16) ; // adder1bit Adder0.csa4x2_0_lvl2.17( sintcsa4x2_0_lvl2.17, cout_csa4x2_0_lvl2.17, s8_lvl0_17, t8_lvl0_16, s0_lvl1_17) // sum xor2( w0.Adder0.csa4x2_0_lvl2.17, s8_lvl0_17, t8_lvl0_16 )#5 xor2( sintcsa4x2_0_lvl2.17, w0.Adder0.csa4x2_0_lvl2.17, s0_lvl1_17 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.17, s8_lvl0_17, t8_lvl0_16 )#5 and2( w2.Adder0.csa4x2_0_lvl2.17, w0.Adder0.csa4x2_0_lvl2.17, s0_lvl1_17 )#5 or2( cout_csa4x2_0_lvl2.17, w1.Adder0.csa4x2_0_lvl2.17, w2.Adder0.csa4x2_0_lvl2.17 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.17( s0_lvl2_17, t0_lvl2_17, sintcsa4x2_0_lvl2.17, t0_lvl1_16, cout_csa4x2_0_lvl2.16) // sum xor2( w0.Adder1.csa4x2_0_lvl2.17, sintcsa4x2_0_lvl2.17, t0_lvl1_16 )#5 xor2( s0_lvl2_17, w0.Adder1.csa4x2_0_lvl2.17, cout_csa4x2_0_lvl2.16 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.17, sintcsa4x2_0_lvl2.17, t0_lvl1_16 )#5 and2( w2.Adder1.csa4x2_0_lvl2.17, w0.Adder1.csa4x2_0_lvl2.17, cout_csa4x2_0_lvl2.16 )#5 or2( t0_lvl2_17, w1.Adder1.csa4x2_0_lvl2.17, w2.Adder1.csa4x2_0_lvl2.17 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.18, s0_lvl2_18,t0_lvl2_18,cout_csa4x2_0_lvl2.18,s8_lvl0_18,t8_lvl0_17,s0_lvl1_18,t0_lvl1_17,cout_csa4x2_0_lvl2.17) ; // adder1bit Adder0.csa4x2_0_lvl2.18( sintcsa4x2_0_lvl2.18, cout_csa4x2_0_lvl2.18, s8_lvl0_18, t8_lvl0_17, s0_lvl1_18) // sum xor2( w0.Adder0.csa4x2_0_lvl2.18, s8_lvl0_18, t8_lvl0_17 )#5 xor2( sintcsa4x2_0_lvl2.18, w0.Adder0.csa4x2_0_lvl2.18, s0_lvl1_18 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.18, s8_lvl0_18, t8_lvl0_17 )#5 and2( w2.Adder0.csa4x2_0_lvl2.18, w0.Adder0.csa4x2_0_lvl2.18, s0_lvl1_18 )#5 or2( cout_csa4x2_0_lvl2.18, w1.Adder0.csa4x2_0_lvl2.18, w2.Adder0.csa4x2_0_lvl2.18 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.18( s0_lvl2_18, t0_lvl2_18, sintcsa4x2_0_lvl2.18, t0_lvl1_17, cout_csa4x2_0_lvl2.17) // sum xor2( w0.Adder1.csa4x2_0_lvl2.18, sintcsa4x2_0_lvl2.18, t0_lvl1_17 )#5 xor2( s0_lvl2_18, w0.Adder1.csa4x2_0_lvl2.18, cout_csa4x2_0_lvl2.17 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.18, sintcsa4x2_0_lvl2.18, t0_lvl1_17 )#5 and2( w2.Adder1.csa4x2_0_lvl2.18, w0.Adder1.csa4x2_0_lvl2.18, cout_csa4x2_0_lvl2.17 )#5 or2( t0_lvl2_18, w1.Adder1.csa4x2_0_lvl2.18, w2.Adder1.csa4x2_0_lvl2.18 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.19, s0_lvl2_19,t0_lvl2_19,cout_csa4x2_0_lvl2.19,s8_lvl0_19,t8_lvl0_18,s0_lvl1_19,t0_lvl1_18,cout_csa4x2_0_lvl2.18) ; // adder1bit Adder0.csa4x2_0_lvl2.19( sintcsa4x2_0_lvl2.19, cout_csa4x2_0_lvl2.19, s8_lvl0_19, t8_lvl0_18, s0_lvl1_19) // sum xor2( w0.Adder0.csa4x2_0_lvl2.19, s8_lvl0_19, t8_lvl0_18 )#5 xor2( sintcsa4x2_0_lvl2.19, w0.Adder0.csa4x2_0_lvl2.19, s0_lvl1_19 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.19, s8_lvl0_19, t8_lvl0_18 )#5 and2( w2.Adder0.csa4x2_0_lvl2.19, w0.Adder0.csa4x2_0_lvl2.19, s0_lvl1_19 )#5 or2( cout_csa4x2_0_lvl2.19, w1.Adder0.csa4x2_0_lvl2.19, w2.Adder0.csa4x2_0_lvl2.19 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.19( s0_lvl2_19, t0_lvl2_19, sintcsa4x2_0_lvl2.19, t0_lvl1_18, cout_csa4x2_0_lvl2.18) // sum xor2( w0.Adder1.csa4x2_0_lvl2.19, sintcsa4x2_0_lvl2.19, t0_lvl1_18 )#5 xor2( s0_lvl2_19, w0.Adder1.csa4x2_0_lvl2.19, cout_csa4x2_0_lvl2.18 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.19, sintcsa4x2_0_lvl2.19, t0_lvl1_18 )#5 and2( w2.Adder1.csa4x2_0_lvl2.19, w0.Adder1.csa4x2_0_lvl2.19, cout_csa4x2_0_lvl2.18 )#5 or2( t0_lvl2_19, w1.Adder1.csa4x2_0_lvl2.19, w2.Adder1.csa4x2_0_lvl2.19 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.20, s0_lvl2_20,t0_lvl2_20,cout_csa4x2_0_lvl2.20,s8_lvl0_20,t8_lvl0_19,s0_lvl1_20,t0_lvl1_19,cout_csa4x2_0_lvl2.19) ; // adder1bit Adder0.csa4x2_0_lvl2.20( sintcsa4x2_0_lvl2.20, cout_csa4x2_0_lvl2.20, s8_lvl0_20, t8_lvl0_19, s0_lvl1_20) // sum xor2( w0.Adder0.csa4x2_0_lvl2.20, s8_lvl0_20, t8_lvl0_19 )#5 xor2( sintcsa4x2_0_lvl2.20, w0.Adder0.csa4x2_0_lvl2.20, s0_lvl1_20 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.20, s8_lvl0_20, t8_lvl0_19 )#5 and2( w2.Adder0.csa4x2_0_lvl2.20, w0.Adder0.csa4x2_0_lvl2.20, s0_lvl1_20 )#5 or2( cout_csa4x2_0_lvl2.20, w1.Adder0.csa4x2_0_lvl2.20, w2.Adder0.csa4x2_0_lvl2.20 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.20( s0_lvl2_20, t0_lvl2_20, sintcsa4x2_0_lvl2.20, t0_lvl1_19, cout_csa4x2_0_lvl2.19) // sum xor2( w0.Adder1.csa4x2_0_lvl2.20, sintcsa4x2_0_lvl2.20, t0_lvl1_19 )#5 xor2( s0_lvl2_20, w0.Adder1.csa4x2_0_lvl2.20, cout_csa4x2_0_lvl2.19 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.20, sintcsa4x2_0_lvl2.20, t0_lvl1_19 )#5 and2( w2.Adder1.csa4x2_0_lvl2.20, w0.Adder1.csa4x2_0_lvl2.20, cout_csa4x2_0_lvl2.19 )#5 or2( t0_lvl2_20, w1.Adder1.csa4x2_0_lvl2.20, w2.Adder1.csa4x2_0_lvl2.20 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.21, s0_lvl2_21,t0_lvl2_21,cout_csa4x2_0_lvl2.21,s8_lvl0_21,t8_lvl0_20,s0_lvl1_21,t0_lvl1_20,cout_csa4x2_0_lvl2.20) ; // adder1bit Adder0.csa4x2_0_lvl2.21( sintcsa4x2_0_lvl2.21, cout_csa4x2_0_lvl2.21, s8_lvl0_21, t8_lvl0_20, s0_lvl1_21) // sum xor2( w0.Adder0.csa4x2_0_lvl2.21, s8_lvl0_21, t8_lvl0_20 )#5 xor2( sintcsa4x2_0_lvl2.21, w0.Adder0.csa4x2_0_lvl2.21, s0_lvl1_21 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.21, s8_lvl0_21, t8_lvl0_20 )#5 and2( w2.Adder0.csa4x2_0_lvl2.21, w0.Adder0.csa4x2_0_lvl2.21, s0_lvl1_21 )#5 or2( cout_csa4x2_0_lvl2.21, w1.Adder0.csa4x2_0_lvl2.21, w2.Adder0.csa4x2_0_lvl2.21 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.21( s0_lvl2_21, t0_lvl2_21, sintcsa4x2_0_lvl2.21, t0_lvl1_20, cout_csa4x2_0_lvl2.20) // sum xor2( w0.Adder1.csa4x2_0_lvl2.21, sintcsa4x2_0_lvl2.21, t0_lvl1_20 )#5 xor2( s0_lvl2_21, w0.Adder1.csa4x2_0_lvl2.21, cout_csa4x2_0_lvl2.20 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.21, sintcsa4x2_0_lvl2.21, t0_lvl1_20 )#5 and2( w2.Adder1.csa4x2_0_lvl2.21, w0.Adder1.csa4x2_0_lvl2.21, cout_csa4x2_0_lvl2.20 )#5 or2( t0_lvl2_21, w1.Adder1.csa4x2_0_lvl2.21, w2.Adder1.csa4x2_0_lvl2.21 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.22, s0_lvl2_22,t0_lvl2_22,cout_csa4x2_0_lvl2.22,s8_lvl0_22,t8_lvl0_21,s0_lvl1_22,t0_lvl1_21,cout_csa4x2_0_lvl2.21) ; // adder1bit Adder0.csa4x2_0_lvl2.22( sintcsa4x2_0_lvl2.22, cout_csa4x2_0_lvl2.22, s8_lvl0_22, t8_lvl0_21, s0_lvl1_22) // sum xor2( w0.Adder0.csa4x2_0_lvl2.22, s8_lvl0_22, t8_lvl0_21 )#5 xor2( sintcsa4x2_0_lvl2.22, w0.Adder0.csa4x2_0_lvl2.22, s0_lvl1_22 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.22, s8_lvl0_22, t8_lvl0_21 )#5 and2( w2.Adder0.csa4x2_0_lvl2.22, w0.Adder0.csa4x2_0_lvl2.22, s0_lvl1_22 )#5 or2( cout_csa4x2_0_lvl2.22, w1.Adder0.csa4x2_0_lvl2.22, w2.Adder0.csa4x2_0_lvl2.22 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.22( s0_lvl2_22, t0_lvl2_22, sintcsa4x2_0_lvl2.22, t0_lvl1_21, cout_csa4x2_0_lvl2.21) // sum xor2( w0.Adder1.csa4x2_0_lvl2.22, sintcsa4x2_0_lvl2.22, t0_lvl1_21 )#5 xor2( s0_lvl2_22, w0.Adder1.csa4x2_0_lvl2.22, cout_csa4x2_0_lvl2.21 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.22, sintcsa4x2_0_lvl2.22, t0_lvl1_21 )#5 and2( w2.Adder1.csa4x2_0_lvl2.22, w0.Adder1.csa4x2_0_lvl2.22, cout_csa4x2_0_lvl2.21 )#5 or2( t0_lvl2_22, w1.Adder1.csa4x2_0_lvl2.22, w2.Adder1.csa4x2_0_lvl2.22 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.23, s0_lvl2_23,t0_lvl2_23,cout_csa4x2_0_lvl2.23,s8_lvl0_23,t8_lvl0_22,s0_lvl1_23,t0_lvl1_22,cout_csa4x2_0_lvl2.22) ; // adder1bit Adder0.csa4x2_0_lvl2.23( sintcsa4x2_0_lvl2.23, cout_csa4x2_0_lvl2.23, s8_lvl0_23, t8_lvl0_22, s0_lvl1_23) // sum xor2( w0.Adder0.csa4x2_0_lvl2.23, s8_lvl0_23, t8_lvl0_22 )#5 xor2( sintcsa4x2_0_lvl2.23, w0.Adder0.csa4x2_0_lvl2.23, s0_lvl1_23 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.23, s8_lvl0_23, t8_lvl0_22 )#5 and2( w2.Adder0.csa4x2_0_lvl2.23, w0.Adder0.csa4x2_0_lvl2.23, s0_lvl1_23 )#5 or2( cout_csa4x2_0_lvl2.23, w1.Adder0.csa4x2_0_lvl2.23, w2.Adder0.csa4x2_0_lvl2.23 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.23( s0_lvl2_23, t0_lvl2_23, sintcsa4x2_0_lvl2.23, t0_lvl1_22, cout_csa4x2_0_lvl2.22) // sum xor2( w0.Adder1.csa4x2_0_lvl2.23, sintcsa4x2_0_lvl2.23, t0_lvl1_22 )#5 xor2( s0_lvl2_23, w0.Adder1.csa4x2_0_lvl2.23, cout_csa4x2_0_lvl2.22 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.23, sintcsa4x2_0_lvl2.23, t0_lvl1_22 )#5 and2( w2.Adder1.csa4x2_0_lvl2.23, w0.Adder1.csa4x2_0_lvl2.23, cout_csa4x2_0_lvl2.22 )#5 or2( t0_lvl2_23, w1.Adder1.csa4x2_0_lvl2.23, w2.Adder1.csa4x2_0_lvl2.23 )#5 // end adder1bit // end csa4x2 end // genKoggeStoneVec(2*numBits, outVec, "cout", currRow->[0], currRow->[1], 'GND' ); netlist // PGgen (g0,p0,s0_lvl2_0,GND) xor2(p0,s0_lvl2_0,GND)#5 and2(g0,s0_lvl2_0,GND)#5 end netlist // PGgen (g1,p1,s0_lvl2_1,t0_lvl2_0) xor2(p1,s0_lvl2_1,t0_lvl2_0)#5 and2(g1,s0_lvl2_1,t0_lvl2_0)#5 end netlist // PGgen (g2,p2,s0_lvl2_2,t0_lvl2_1) xor2(p2,s0_lvl2_2,t0_lvl2_1)#5 and2(g2,s0_lvl2_2,t0_lvl2_1)#5 end netlist // PGgen (g3,p3,s0_lvl2_3,t0_lvl2_2) xor2(p3,s0_lvl2_3,t0_lvl2_2)#5 and2(g3,s0_lvl2_3,t0_lvl2_2)#5 end netlist // PGgen (g4,p4,s0_lvl2_4,t0_lvl2_3) xor2(p4,s0_lvl2_4,t0_lvl2_3)#5 and2(g4,s0_lvl2_4,t0_lvl2_3)#5 end netlist // PGgen (g5,p5,s0_lvl2_5,t0_lvl2_4) xor2(p5,s0_lvl2_5,t0_lvl2_4)#5 and2(g5,s0_lvl2_5,t0_lvl2_4)#5 end netlist // PGgen (g6,p6,s0_lvl2_6,t0_lvl2_5) xor2(p6,s0_lvl2_6,t0_lvl2_5)#5 and2(g6,s0_lvl2_6,t0_lvl2_5)#5 end netlist // PGgen (g7,p7,s0_lvl2_7,t0_lvl2_6) xor2(p7,s0_lvl2_7,t0_lvl2_6)#5 and2(g7,s0_lvl2_7,t0_lvl2_6)#5 end netlist // PGgen (g8,p8,s0_lvl2_8,t0_lvl2_7) xor2(p8,s0_lvl2_8,t0_lvl2_7)#5 and2(g8,s0_lvl2_8,t0_lvl2_7)#5 end netlist // PGgen (g9,p9,s0_lvl2_9,t0_lvl2_8) xor2(p9,s0_lvl2_9,t0_lvl2_8)#5 and2(g9,s0_lvl2_9,t0_lvl2_8)#5 end netlist // PGgen (g10,p10,s0_lvl2_10,t0_lvl2_9) xor2(p10,s0_lvl2_10,t0_lvl2_9)#5 and2(g10,s0_lvl2_10,t0_lvl2_9)#5 end netlist // PGgen (g11,p11,s0_lvl2_11,t0_lvl2_10) xor2(p11,s0_lvl2_11,t0_lvl2_10)#5 and2(g11,s0_lvl2_11,t0_lvl2_10)#5 end netlist // PGgen (g12,p12,s0_lvl2_12,t0_lvl2_11) xor2(p12,s0_lvl2_12,t0_lvl2_11)#5 and2(g12,s0_lvl2_12,t0_lvl2_11)#5 end netlist // PGgen (g13,p13,s0_lvl2_13,t0_lvl2_12) xor2(p13,s0_lvl2_13,t0_lvl2_12)#5 and2(g13,s0_lvl2_13,t0_lvl2_12)#5 end netlist // PGgen (g14,p14,s0_lvl2_14,t0_lvl2_13) xor2(p14,s0_lvl2_14,t0_lvl2_13)#5 and2(g14,s0_lvl2_14,t0_lvl2_13)#5 end netlist // PGgen (g15,p15,s0_lvl2_15,t0_lvl2_14) xor2(p15,s0_lvl2_15,t0_lvl2_14)#5 and2(g15,s0_lvl2_15,t0_lvl2_14)#5 end netlist // PGgen (g16,p16,s0_lvl2_16,t0_lvl2_15) xor2(p16,s0_lvl2_16,t0_lvl2_15)#5 and2(g16,s0_lvl2_16,t0_lvl2_15)#5 end netlist // PGgen (g17,p17,s0_lvl2_17,t0_lvl2_16) xor2(p17,s0_lvl2_17,t0_lvl2_16)#5 and2(g17,s0_lvl2_17,t0_lvl2_16)#5 end netlist // PGgen (g18,p18,s0_lvl2_18,t0_lvl2_17) xor2(p18,s0_lvl2_18,t0_lvl2_17)#5 and2(g18,s0_lvl2_18,t0_lvl2_17)#5 end netlist // PGgen (g19,p19,s0_lvl2_19,t0_lvl2_18) xor2(p19,s0_lvl2_19,t0_lvl2_18)#5 and2(g19,s0_lvl2_19,t0_lvl2_18)#5 end netlist // PGgen (g20,p20,s0_lvl2_20,t0_lvl2_19) xor2(p20,s0_lvl2_20,t0_lvl2_19)#5 and2(g20,s0_lvl2_20,t0_lvl2_19)#5 end netlist // PGgen (g21,p21,s0_lvl2_21,t0_lvl2_20) xor2(p21,s0_lvl2_21,t0_lvl2_20)#5 and2(g21,s0_lvl2_21,t0_lvl2_20)#5 end netlist // PGgen (g22,p22,s0_lvl2_22,t0_lvl2_21) xor2(p22,s0_lvl2_22,t0_lvl2_21)#5 and2(g22,s0_lvl2_22,t0_lvl2_21)#5 end netlist // PGgen (g23,p23,s0_lvl2_23,t0_lvl2_22) xor2(p23,s0_lvl2_23,t0_lvl2_22)#5 and2(g23,s0_lvl2_23,t0_lvl2_22)#5 end netlist // Gcombine (g_0_GND, g0, GND, p0 ) and2(w0g_0_GND, p0, GND )#5 or2( g_0_GND, w0g_0_GND, g0 )#5 end netlist // PGcombine (g_1_0,p_1_0,g1,p1,g0,p0) and2( w0g_1_0, p1, g0 )#5 or2( g_1_0, w0g_1_0, g1 )#5 and2( p_1_0, p1, p0)#5 end netlist // PGcombine (g_2_1,p_2_1,g2,p2,g1,p1) and2( w0g_2_1, p2, g1 )#5 or2( g_2_1, w0g_2_1, g2 )#5 and2( p_2_1, p2, p1)#5 end netlist // PGcombine (g_3_2,p_3_2,g3,p3,g2,p2) and2( w0g_3_2, p3, g2 )#5 or2( g_3_2, w0g_3_2, g3 )#5 and2( p_3_2, p3, p2)#5 end netlist // PGcombine (g_4_3,p_4_3,g4,p4,g3,p3) and2( w0g_4_3, p4, g3 )#5 or2( g_4_3, w0g_4_3, g4 )#5 and2( p_4_3, p4, p3)#5 end netlist // PGcombine (g_5_4,p_5_4,g5,p5,g4,p4) and2( w0g_5_4, p5, g4 )#5 or2( g_5_4, w0g_5_4, g5 )#5 and2( p_5_4, p5, p4)#5 end netlist // PGcombine (g_6_5,p_6_5,g6,p6,g5,p5) and2( w0g_6_5, p6, g5 )#5 or2( g_6_5, w0g_6_5, g6 )#5 and2( p_6_5, p6, p5)#5 end netlist // PGcombine (g_7_6,p_7_6,g7,p7,g6,p6) and2( w0g_7_6, p7, g6 )#5 or2( g_7_6, w0g_7_6, g7 )#5 and2( p_7_6, p7, p6)#5 end netlist // PGcombine (g_8_7,p_8_7,g8,p8,g7,p7) and2( w0g_8_7, p8, g7 )#5 or2( g_8_7, w0g_8_7, g8 )#5 and2( p_8_7, p8, p7)#5 end netlist // PGcombine (g_9_8,p_9_8,g9,p9,g8,p8) and2( w0g_9_8, p9, g8 )#5 or2( g_9_8, w0g_9_8, g9 )#5 and2( p_9_8, p9, p8)#5 end netlist // PGcombine (g_10_9,p_10_9,g10,p10,g9,p9) and2( w0g_10_9, p10, g9 )#5 or2( g_10_9, w0g_10_9, g10 )#5 and2( p_10_9, p10, p9)#5 end netlist // PGcombine (g_11_10,p_11_10,g11,p11,g10,p10) and2( w0g_11_10, p11, g10 )#5 or2( g_11_10, w0g_11_10, g11 )#5 and2( p_11_10, p11, p10)#5 end netlist // PGcombine (g_12_11,p_12_11,g12,p12,g11,p11) and2( w0g_12_11, p12, g11 )#5 or2( g_12_11, w0g_12_11, g12 )#5 and2( p_12_11, p12, p11)#5 end netlist // PGcombine (g_13_12,p_13_12,g13,p13,g12,p12) and2( w0g_13_12, p13, g12 )#5 or2( g_13_12, w0g_13_12, g13 )#5 and2( p_13_12, p13, p12)#5 end netlist // PGcombine (g_14_13,p_14_13,g14,p14,g13,p13) and2( w0g_14_13, p14, g13 )#5 or2( g_14_13, w0g_14_13, g14 )#5 and2( p_14_13, p14, p13)#5 end netlist // PGcombine (g_15_14,p_15_14,g15,p15,g14,p14) and2( w0g_15_14, p15, g14 )#5 or2( g_15_14, w0g_15_14, g15 )#5 and2( p_15_14, p15, p14)#5 end netlist // PGcombine (g_16_15,p_16_15,g16,p16,g15,p15) and2( w0g_16_15, p16, g15 )#5 or2( g_16_15, w0g_16_15, g16 )#5 and2( p_16_15, p16, p15)#5 end netlist // PGcombine (g_17_16,p_17_16,g17,p17,g16,p16) and2( w0g_17_16, p17, g16 )#5 or2( g_17_16, w0g_17_16, g17 )#5 and2( p_17_16, p17, p16)#5 end netlist // PGcombine (g_18_17,p_18_17,g18,p18,g17,p17) and2( w0g_18_17, p18, g17 )#5 or2( g_18_17, w0g_18_17, g18 )#5 and2( p_18_17, p18, p17)#5 end netlist // PGcombine (g_19_18,p_19_18,g19,p19,g18,p18) and2( w0g_19_18, p19, g18 )#5 or2( g_19_18, w0g_19_18, g19 )#5 and2( p_19_18, p19, p18)#5 end netlist // PGcombine (g_20_19,p_20_19,g20,p20,g19,p19) and2( w0g_20_19, p20, g19 )#5 or2( g_20_19, w0g_20_19, g20 )#5 and2( p_20_19, p20, p19)#5 end netlist // PGcombine (g_21_20,p_21_20,g21,p21,g20,p20) and2( w0g_21_20, p21, g20 )#5 or2( g_21_20, w0g_21_20, g21 )#5 and2( p_21_20, p21, p20)#5 end netlist // PGcombine (g_22_21,p_22_21,g22,p22,g21,p21) and2( w0g_22_21, p22, g21 )#5 or2( g_22_21, w0g_22_21, g22 )#5 and2( p_22_21, p22, p21)#5 end netlist // PGcombine (g_23_22,p_23_22,g23,p23,g22,p22) and2( w0g_23_22, p23, g22 )#5 or2( g_23_22, w0g_23_22, g23 )#5 and2( p_23_22, p23, p22)#5 end netlist // Gcombine (g_1_GND, g_1_0, GND, p_1_0 ) and2(w0g_1_GND, p_1_0, GND )#5 or2( g_1_GND, w0g_1_GND, g_1_0 )#5 end netlist // Gcombine (g_2_GND, g_2_1, g_0_GND, p_2_1 ) and2(w0g_2_GND, p_2_1, g_0_GND )#5 or2( g_2_GND, w0g_2_GND, g_2_1 )#5 end netlist // PGcombine (g_3_0,p_3_0,g_3_2,p_3_2,g_1_0,p_1_0) and2( w0g_3_0, p_3_2, g_1_0 )#5 or2( g_3_0, w0g_3_0, g_3_2 )#5 and2( p_3_0, p_3_2, p_1_0)#5 end netlist // PGcombine (g_4_1,p_4_1,g_4_3,p_4_3,g_2_1,p_2_1) and2( w0g_4_1, p_4_3, g_2_1 )#5 or2( g_4_1, w0g_4_1, g_4_3 )#5 and2( p_4_1, p_4_3, p_2_1)#5 end netlist // PGcombine (g_5_2,p_5_2,g_5_4,p_5_4,g_3_2,p_3_2) and2( w0g_5_2, p_5_4, g_3_2 )#5 or2( g_5_2, w0g_5_2, g_5_4 )#5 and2( p_5_2, p_5_4, p_3_2)#5 end netlist // PGcombine (g_6_3,p_6_3,g_6_5,p_6_5,g_4_3,p_4_3) and2( w0g_6_3, p_6_5, g_4_3 )#5 or2( g_6_3, w0g_6_3, g_6_5 )#5 and2( p_6_3, p_6_5, p_4_3)#5 end netlist // PGcombine (g_7_4,p_7_4,g_7_6,p_7_6,g_5_4,p_5_4) and2( w0g_7_4, p_7_6, g_5_4 )#5 or2( g_7_4, w0g_7_4, g_7_6 )#5 and2( p_7_4, p_7_6, p_5_4)#5 end netlist // PGcombine (g_8_5,p_8_5,g_8_7,p_8_7,g_6_5,p_6_5) and2( w0g_8_5, p_8_7, g_6_5 )#5 or2( g_8_5, w0g_8_5, g_8_7 )#5 and2( p_8_5, p_8_7, p_6_5)#5 end netlist // PGcombine (g_9_6,p_9_6,g_9_8,p_9_8,g_7_6,p_7_6) and2( w0g_9_6, p_9_8, g_7_6 )#5 or2( g_9_6, w0g_9_6, g_9_8 )#5 and2( p_9_6, p_9_8, p_7_6)#5 end netlist // PGcombine (g_10_7,p_10_7,g_10_9,p_10_9,g_8_7,p_8_7) and2( w0g_10_7, p_10_9, g_8_7 )#5 or2( g_10_7, w0g_10_7, g_10_9 )#5 and2( p_10_7, p_10_9, p_8_7)#5 end netlist // PGcombine (g_11_8,p_11_8,g_11_10,p_11_10,g_9_8,p_9_8) and2( w0g_11_8, p_11_10, g_9_8 )#5 or2( g_11_8, w0g_11_8, g_11_10 )#5 and2( p_11_8, p_11_10, p_9_8)#5 end netlist // PGcombine (g_12_9,p_12_9,g_12_11,p_12_11,g_10_9,p_10_9) and2( w0g_12_9, p_12_11, g_10_9 )#5 or2( g_12_9, w0g_12_9, g_12_11 )#5 and2( p_12_9, p_12_11, p_10_9)#5 end netlist // PGcombine (g_13_10,p_13_10,g_13_12,p_13_12,g_11_10,p_11_10) and2( w0g_13_10, p_13_12, g_11_10 )#5 or2( g_13_10, w0g_13_10, g_13_12 )#5 and2( p_13_10, p_13_12, p_11_10)#5 end netlist // PGcombine (g_14_11,p_14_11,g_14_13,p_14_13,g_12_11,p_12_11) and2( w0g_14_11, p_14_13, g_12_11 )#5 or2( g_14_11, w0g_14_11, g_14_13 )#5 and2( p_14_11, p_14_13, p_12_11)#5 end netlist // PGcombine (g_15_12,p_15_12,g_15_14,p_15_14,g_13_12,p_13_12) and2( w0g_15_12, p_15_14, g_13_12 )#5 or2( g_15_12, w0g_15_12, g_15_14 )#5 and2( p_15_12, p_15_14, p_13_12)#5 end netlist // PGcombine (g_16_13,p_16_13,g_16_15,p_16_15,g_14_13,p_14_13) and2( w0g_16_13, p_16_15, g_14_13 )#5 or2( g_16_13, w0g_16_13, g_16_15 )#5 and2( p_16_13, p_16_15, p_14_13)#5 end netlist // PGcombine (g_17_14,p_17_14,g_17_16,p_17_16,g_15_14,p_15_14) and2( w0g_17_14, p_17_16, g_15_14 )#5 or2( g_17_14, w0g_17_14, g_17_16 )#5 and2( p_17_14, p_17_16, p_15_14)#5 end netlist // PGcombine (g_18_15,p_18_15,g_18_17,p_18_17,g_16_15,p_16_15) and2( w0g_18_15, p_18_17, g_16_15 )#5 or2( g_18_15, w0g_18_15, g_18_17 )#5 and2( p_18_15, p_18_17, p_16_15)#5 end netlist // PGcombine (g_19_16,p_19_16,g_19_18,p_19_18,g_17_16,p_17_16) and2( w0g_19_16, p_19_18, g_17_16 )#5 or2( g_19_16, w0g_19_16, g_19_18 )#5 and2( p_19_16, p_19_18, p_17_16)#5 end netlist // PGcombine (g_20_17,p_20_17,g_20_19,p_20_19,g_18_17,p_18_17) and2( w0g_20_17, p_20_19, g_18_17 )#5 or2( g_20_17, w0g_20_17, g_20_19 )#5 and2( p_20_17, p_20_19, p_18_17)#5 end netlist // PGcombine (g_21_18,p_21_18,g_21_20,p_21_20,g_19_18,p_19_18) and2( w0g_21_18, p_21_20, g_19_18 )#5 or2( g_21_18, w0g_21_18, g_21_20 )#5 and2( p_21_18, p_21_20, p_19_18)#5 end netlist // PGcombine (g_22_19,p_22_19,g_22_21,p_22_21,g_20_19,p_20_19) and2( w0g_22_19, p_22_21, g_20_19 )#5 or2( g_22_19, w0g_22_19, g_22_21 )#5 and2( p_22_19, p_22_21, p_20_19)#5 end netlist // PGcombine (g_23_20,p_23_20,g_23_22,p_23_22,g_21_20,p_21_20) and2( w0g_23_20, p_23_22, g_21_20 )#5 or2( g_23_20, w0g_23_20, g_23_22 )#5 and2( p_23_20, p_23_22, p_21_20)#5 end netlist // Gcombine (g_3_GND, g_3_0, GND, p_3_0 ) and2(w0g_3_GND, p_3_0, GND )#5 or2( g_3_GND, w0g_3_GND, g_3_0 )#5 end netlist // Gcombine (g_4_GND, g_4_1, g_0_GND, p_4_1 ) and2(w0g_4_GND, p_4_1, g_0_GND )#5 or2( g_4_GND, w0g_4_GND, g_4_1 )#5 end netlist // Gcombine (g_5_GND, g_5_2, g_1_GND, p_5_2 ) and2(w0g_5_GND, p_5_2, g_1_GND )#5 or2( g_5_GND, w0g_5_GND, g_5_2 )#5 end netlist // Gcombine (g_6_GND, g_6_3, g_2_GND, p_6_3 ) and2(w0g_6_GND, p_6_3, g_2_GND )#5 or2( g_6_GND, w0g_6_GND, g_6_3 )#5 end netlist // PGcombine (g_7_0,p_7_0,g_7_4,p_7_4,g_3_0,p_3_0) and2( w0g_7_0, p_7_4, g_3_0 )#5 or2( g_7_0, w0g_7_0, g_7_4 )#5 and2( p_7_0, p_7_4, p_3_0)#5 end netlist // PGcombine (g_8_1,p_8_1,g_8_5,p_8_5,g_4_1,p_4_1) and2( w0g_8_1, p_8_5, g_4_1 )#5 or2( g_8_1, w0g_8_1, g_8_5 )#5 and2( p_8_1, p_8_5, p_4_1)#5 end netlist // PGcombine (g_9_2,p_9_2,g_9_6,p_9_6,g_5_2,p_5_2) and2( w0g_9_2, p_9_6, g_5_2 )#5 or2( g_9_2, w0g_9_2, g_9_6 )#5 and2( p_9_2, p_9_6, p_5_2)#5 end netlist // PGcombine (g_10_3,p_10_3,g_10_7,p_10_7,g_6_3,p_6_3) and2( w0g_10_3, p_10_7, g_6_3 )#5 or2( g_10_3, w0g_10_3, g_10_7 )#5 and2( p_10_3, p_10_7, p_6_3)#5 end netlist // PGcombine (g_11_4,p_11_4,g_11_8,p_11_8,g_7_4,p_7_4) and2( w0g_11_4, p_11_8, g_7_4 )#5 or2( g_11_4, w0g_11_4, g_11_8 )#5 and2( p_11_4, p_11_8, p_7_4)#5 end netlist // PGcombine (g_12_5,p_12_5,g_12_9,p_12_9,g_8_5,p_8_5) and2( w0g_12_5, p_12_9, g_8_5 )#5 or2( g_12_5, w0g_12_5, g_12_9 )#5 and2( p_12_5, p_12_9, p_8_5)#5 end netlist // PGcombine (g_13_6,p_13_6,g_13_10,p_13_10,g_9_6,p_9_6) and2( w0g_13_6, p_13_10, g_9_6 )#5 or2( g_13_6, w0g_13_6, g_13_10 )#5 and2( p_13_6, p_13_10, p_9_6)#5 end netlist // PGcombine (g_14_7,p_14_7,g_14_11,p_14_11,g_10_7,p_10_7) and2( w0g_14_7, p_14_11, g_10_7 )#5 or2( g_14_7, w0g_14_7, g_14_11 )#5 and2( p_14_7, p_14_11, p_10_7)#5 end netlist // PGcombine (g_15_8,p_15_8,g_15_12,p_15_12,g_11_8,p_11_8) and2( w0g_15_8, p_15_12, g_11_8 )#5 or2( g_15_8, w0g_15_8, g_15_12 )#5 and2( p_15_8, p_15_12, p_11_8)#5 end netlist // PGcombine (g_16_9,p_16_9,g_16_13,p_16_13,g_12_9,p_12_9) and2( w0g_16_9, p_16_13, g_12_9 )#5 or2( g_16_9, w0g_16_9, g_16_13 )#5 and2( p_16_9, p_16_13, p_12_9)#5 end netlist // PGcombine (g_17_10,p_17_10,g_17_14,p_17_14,g_13_10,p_13_10) and2( w0g_17_10, p_17_14, g_13_10 )#5 or2( g_17_10, w0g_17_10, g_17_14 )#5 and2( p_17_10, p_17_14, p_13_10)#5 end netlist // PGcombine (g_18_11,p_18_11,g_18_15,p_18_15,g_14_11,p_14_11) and2( w0g_18_11, p_18_15, g_14_11 )#5 or2( g_18_11, w0g_18_11, g_18_15 )#5 and2( p_18_11, p_18_15, p_14_11)#5 end netlist // PGcombine (g_19_12,p_19_12,g_19_16,p_19_16,g_15_12,p_15_12) and2( w0g_19_12, p_19_16, g_15_12 )#5 or2( g_19_12, w0g_19_12, g_19_16 )#5 and2( p_19_12, p_19_16, p_15_12)#5 end netlist // PGcombine (g_20_13,p_20_13,g_20_17,p_20_17,g_16_13,p_16_13) and2( w0g_20_13, p_20_17, g_16_13 )#5 or2( g_20_13, w0g_20_13, g_20_17 )#5 and2( p_20_13, p_20_17, p_16_13)#5 end netlist // PGcombine (g_21_14,p_21_14,g_21_18,p_21_18,g_17_14,p_17_14) and2( w0g_21_14, p_21_18, g_17_14 )#5 or2( g_21_14, w0g_21_14, g_21_18 )#5 and2( p_21_14, p_21_18, p_17_14)#5 end netlist // PGcombine (g_22_15,p_22_15,g_22_19,p_22_19,g_18_15,p_18_15) and2( w0g_22_15, p_22_19, g_18_15 )#5 or2( g_22_15, w0g_22_15, g_22_19 )#5 and2( p_22_15, p_22_19, p_18_15)#5 end netlist // PGcombine (g_23_16,p_23_16,g_23_20,p_23_20,g_19_16,p_19_16) and2( w0g_23_16, p_23_20, g_19_16 )#5 or2( g_23_16, w0g_23_16, g_23_20 )#5 and2( p_23_16, p_23_20, p_19_16)#5 end netlist // Gcombine (g_7_GND, g_7_0, GND, p_7_0 ) and2(w0g_7_GND, p_7_0, GND )#5 or2( g_7_GND, w0g_7_GND, g_7_0 )#5 end netlist // Gcombine (g_8_GND, g_8_1, g_0_GND, p_8_1 ) and2(w0g_8_GND, p_8_1, g_0_GND )#5 or2( g_8_GND, w0g_8_GND, g_8_1 )#5 end netlist // Gcombine (g_9_GND, g_9_2, g_1_GND, p_9_2 ) and2(w0g_9_GND, p_9_2, g_1_GND )#5 or2( g_9_GND, w0g_9_GND, g_9_2 )#5 end netlist // Gcombine (g_10_GND, g_10_3, g_2_GND, p_10_3 ) and2(w0g_10_GND, p_10_3, g_2_GND )#5 or2( g_10_GND, w0g_10_GND, g_10_3 )#5 end netlist // Gcombine (g_11_GND, g_11_4, g_3_GND, p_11_4 ) and2(w0g_11_GND, p_11_4, g_3_GND )#5 or2( g_11_GND, w0g_11_GND, g_11_4 )#5 end netlist // Gcombine (g_12_GND, g_12_5, g_4_GND, p_12_5 ) and2(w0g_12_GND, p_12_5, g_4_GND )#5 or2( g_12_GND, w0g_12_GND, g_12_5 )#5 end netlist // Gcombine (g_13_GND, g_13_6, g_5_GND, p_13_6 ) and2(w0g_13_GND, p_13_6, g_5_GND )#5 or2( g_13_GND, w0g_13_GND, g_13_6 )#5 end netlist // Gcombine (g_14_GND, g_14_7, g_6_GND, p_14_7 ) and2(w0g_14_GND, p_14_7, g_6_GND )#5 or2( g_14_GND, w0g_14_GND, g_14_7 )#5 end netlist // PGcombine (g_15_0,p_15_0,g_15_8,p_15_8,g_7_0,p_7_0) and2( w0g_15_0, p_15_8, g_7_0 )#5 or2( g_15_0, w0g_15_0, g_15_8 )#5 and2( p_15_0, p_15_8, p_7_0)#5 end netlist // PGcombine (g_16_1,p_16_1,g_16_9,p_16_9,g_8_1,p_8_1) and2( w0g_16_1, p_16_9, g_8_1 )#5 or2( g_16_1, w0g_16_1, g_16_9 )#5 and2( p_16_1, p_16_9, p_8_1)#5 end netlist // PGcombine (g_17_2,p_17_2,g_17_10,p_17_10,g_9_2,p_9_2) and2( w0g_17_2, p_17_10, g_9_2 )#5 or2( g_17_2, w0g_17_2, g_17_10 )#5 and2( p_17_2, p_17_10, p_9_2)#5 end netlist // PGcombine (g_18_3,p_18_3,g_18_11,p_18_11,g_10_3,p_10_3) and2( w0g_18_3, p_18_11, g_10_3 )#5 or2( g_18_3, w0g_18_3, g_18_11 )#5 and2( p_18_3, p_18_11, p_10_3)#5 end netlist // PGcombine (g_19_4,p_19_4,g_19_12,p_19_12,g_11_4,p_11_4) and2( w0g_19_4, p_19_12, g_11_4 )#5 or2( g_19_4, w0g_19_4, g_19_12 )#5 and2( p_19_4, p_19_12, p_11_4)#5 end netlist // PGcombine (g_20_5,p_20_5,g_20_13,p_20_13,g_12_5,p_12_5) and2( w0g_20_5, p_20_13, g_12_5 )#5 or2( g_20_5, w0g_20_5, g_20_13 )#5 and2( p_20_5, p_20_13, p_12_5)#5 end netlist // PGcombine (g_21_6,p_21_6,g_21_14,p_21_14,g_13_6,p_13_6) and2( w0g_21_6, p_21_14, g_13_6 )#5 or2( g_21_6, w0g_21_6, g_21_14 )#5 and2( p_21_6, p_21_14, p_13_6)#5 end netlist // PGcombine (g_22_7,p_22_7,g_22_15,p_22_15,g_14_7,p_14_7) and2( w0g_22_7, p_22_15, g_14_7 )#5 or2( g_22_7, w0g_22_7, g_22_15 )#5 and2( p_22_7, p_22_15, p_14_7)#5 end netlist // PGcombine (g_23_8,p_23_8,g_23_16,p_23_16,g_15_8,p_15_8) and2( w0g_23_8, p_23_16, g_15_8 )#5 or2( g_23_8, w0g_23_8, g_23_16 )#5 and2( p_23_8, p_23_16, p_15_8)#5 end netlist // Gcombine (g_15_GND, g_15_0, GND, p_15_0 ) and2(w0g_15_GND, p_15_0, GND )#5 or2( g_15_GND, w0g_15_GND, g_15_0 )#5 end netlist // Gcombine (g_16_GND, g_16_1, g_0_GND, p_16_1 ) and2(w0g_16_GND, p_16_1, g_0_GND )#5 or2( g_16_GND, w0g_16_GND, g_16_1 )#5 end netlist // Gcombine (g_17_GND, g_17_2, g_1_GND, p_17_2 ) and2(w0g_17_GND, p_17_2, g_1_GND )#5 or2( g_17_GND, w0g_17_GND, g_17_2 )#5 end netlist // Gcombine (g_18_GND, g_18_3, g_2_GND, p_18_3 ) and2(w0g_18_GND, p_18_3, g_2_GND )#5 or2( g_18_GND, w0g_18_GND, g_18_3 )#5 end netlist // Gcombine (g_19_GND, g_19_4, g_3_GND, p_19_4 ) and2(w0g_19_GND, p_19_4, g_3_GND )#5 or2( g_19_GND, w0g_19_GND, g_19_4 )#5 end netlist // Gcombine (g_20_GND, g_20_5, g_4_GND, p_20_5 ) and2(w0g_20_GND, p_20_5, g_4_GND )#5 or2( g_20_GND, w0g_20_GND, g_20_5 )#5 end netlist // Gcombine (g_21_GND, g_21_6, g_5_GND, p_21_6 ) and2(w0g_21_GND, p_21_6, g_5_GND )#5 or2( g_21_GND, w0g_21_GND, g_21_6 )#5 end netlist // Gcombine (g_22_GND, g_22_7, g_6_GND, p_22_7 ) and2(w0g_22_GND, p_22_7, g_6_GND )#5 or2( g_22_GND, w0g_22_GND, g_22_7 )#5 end netlist // Gcombine (cout, g_23_8, g_7_GND, p_23_8 ) and2(w0cout, p_23_8, g_7_GND )#5 or2( cout, w0cout, g_23_8 )#5 end netlist xor2( m0, p0,GND )#5 xor2( m1, p1,g_0_GND )#5 xor2( m2, p2,g_1_GND )#5 xor2( m3, p3,g_2_GND )#5 xor2( m4, p4,g_3_GND )#5 xor2( m5, p5,g_4_GND )#5 xor2( m6, p6,g_5_GND )#5 xor2( m7, p7,g_6_GND )#5 xor2( m8, p8,g_7_GND )#5 xor2( m9, p9,g_8_GND )#5 xor2( m10, p10,g_9_GND )#5 xor2( m11, p11,g_10_GND )#5 xor2( m12, p12,g_11_GND )#5 xor2( m13, p13,g_12_GND )#5 xor2( m14, p14,g_13_GND )#5 xor2( m15, p15,g_14_GND )#5 xor2( m16, p16,g_15_GND )#5 xor2( m17, p17,g_16_GND )#5 xor2( m18, p18,g_17_GND )#5 xor2( m19, p19,g_18_GND )#5 xor2( m20, p20,g_19_GND )#5 xor2( m21, p21,g_20_GND )#5 xor2( m22, p22,g_21_GND )#5 xor2( m23, p23,g_22_GND )#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/multTree6bit.net
// Lonestar Benchmark Suite for irregular applications that exhibit // amorphous data-parallelism. // // Center for Grid and Distributed Computing // The University of Texas at Austin // // Copyright (C) 2007, 2008, 2009 The University of Texas at Austin // // Licensed under the Eclipse Public License, Version 1.0 (the "License"); // you may not use this file except in compliance with the License. // You may obtain a copy of the License at // // http://www.eclipse.org/legal/epl-v10.html // // Unless required by applicable law or agreed to in writing, software // distributed under the License is distributed on an "AS IS" BASIS, // WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. // See the License for the specific language governing permissions and // limitations under the License. // // File: multTree6bit.net finish 100000 inputs a0, a1, a2, a3, a4, a5, b0, b1, b2, b3, b4, b5, GND end outputs m0, m1, m2, m3, m4, m5, m6, m7, m8, m9, m10, m11, end outvalues m0 1, m1 0, m2 0, m3 0, m4 0, m5 0, m6 0, m7 1, m8 1, m9 1, m10 1, m11 1, end initlist GND 0 0 end initlist a0 0,0 97,1 end initlist a1 0,0 49,1 end initlist a2 0,0 42,1 end initlist a3 0,0 37,1 end initlist a4 0,0 19,1 end initlist a5 0,0 11,1 end initlist b0 0,0 10,1 end initlist b1 0,0 36,1 end initlist b2 0,0 99,1 end initlist b3 0,0 98,1 end initlist b4 0,0 58,1 end initlist b5 0,0 6,1 end netlist // mux2x1 Bth0.0( PP_0_0, GND, a0, b0 ) inv(b0_n.Bth0.0, b0 )#5 and2(w0.Bth0.0, b0_n.Bth0.0, GND )#5 and2(w1.Bth0.0, b0, a0 )#5 or2(PP_0_0, w0.Bth0.0, w1.Bth0.0 )#5 // end mux2x1 Bth0.0 end netlist // mux2x1 Bth0.1( PP_0_1, GND, a1, b0 ) inv(b0_n.Bth0.1, b0 )#5 and2(w0.Bth0.1, b0_n.Bth0.1, GND )#5 and2(w1.Bth0.1, b0, a1 )#5 or2(PP_0_1, w0.Bth0.1, w1.Bth0.1 )#5 // end mux2x1 Bth0.1 end netlist // mux2x1 Bth0.2( PP_0_2, GND, a2, b0 ) inv(b0_n.Bth0.2, b0 )#5 and2(w0.Bth0.2, b0_n.Bth0.2, GND )#5 and2(w1.Bth0.2, b0, a2 )#5 or2(PP_0_2, w0.Bth0.2, w1.Bth0.2 )#5 // end mux2x1 Bth0.2 end netlist // mux2x1 Bth0.3( PP_0_3, GND, a3, b0 ) inv(b0_n.Bth0.3, b0 )#5 and2(w0.Bth0.3, b0_n.Bth0.3, GND )#5 and2(w1.Bth0.3, b0, a3 )#5 or2(PP_0_3, w0.Bth0.3, w1.Bth0.3 )#5 // end mux2x1 Bth0.3 end netlist // mux2x1 Bth0.4( PP_0_4, GND, a4, b0 ) inv(b0_n.Bth0.4, b0 )#5 and2(w0.Bth0.4, b0_n.Bth0.4, GND )#5 and2(w1.Bth0.4, b0, a4 )#5 or2(PP_0_4, w0.Bth0.4, w1.Bth0.4 )#5 // end mux2x1 Bth0.4 end netlist // mux2x1 Bth0.5( PP_0_5, GND, a5, b0 ) inv(b0_n.Bth0.5, b0 )#5 and2(w0.Bth0.5, b0_n.Bth0.5, GND )#5 and2(w1.Bth0.5, b0, a5 )#5 or2(PP_0_5, w0.Bth0.5, w1.Bth0.5 )#5 // end mux2x1 Bth0.5 end netlist // mux2x1 Bth0.6( PP_0_6, GND, GND, b0 ) inv(b0_n.Bth0.6, b0 )#5 and2(w0.Bth0.6, b0_n.Bth0.6, GND )#5 and2(w1.Bth0.6, b0, GND )#5 or2(PP_0_6, w0.Bth0.6, w1.Bth0.6 )#5 // end mux2x1 Bth0.6 end netlist // mux2x1 Bth0.7( PP_0_7, GND, GND, b0 ) inv(b0_n.Bth0.7, b0 )#5 and2(w0.Bth0.7, b0_n.Bth0.7, GND )#5 and2(w1.Bth0.7, b0, GND )#5 or2(PP_0_7, w0.Bth0.7, w1.Bth0.7 )#5 // end mux2x1 Bth0.7 end netlist // mux2x1 Bth0.8( PP_0_8, GND, GND, b0 ) inv(b0_n.Bth0.8, b0 )#5 and2(w0.Bth0.8, b0_n.Bth0.8, GND )#5 and2(w1.Bth0.8, b0, GND )#5 or2(PP_0_8, w0.Bth0.8, w1.Bth0.8 )#5 // end mux2x1 Bth0.8 end netlist // mux2x1 Bth0.9( PP_0_9, GND, GND, b0 ) inv(b0_n.Bth0.9, b0 )#5 and2(w0.Bth0.9, b0_n.Bth0.9, GND )#5 and2(w1.Bth0.9, b0, GND )#5 or2(PP_0_9, w0.Bth0.9, w1.Bth0.9 )#5 // end mux2x1 Bth0.9 end netlist // mux2x1 Bth0.10( PP_0_10, GND, GND, b0 ) inv(b0_n.Bth0.10, b0 )#5 and2(w0.Bth0.10, b0_n.Bth0.10, GND )#5 and2(w1.Bth0.10, b0, GND )#5 or2(PP_0_10, w0.Bth0.10, w1.Bth0.10 )#5 // end mux2x1 Bth0.10 end netlist // mux2x1 Bth0.11( PP_0_11, GND, GND, b0 ) inv(b0_n.Bth0.11, b0 )#5 and2(w0.Bth0.11, b0_n.Bth0.11, GND )#5 and2(w1.Bth0.11, b0, GND )#5 or2(PP_0_11, w0.Bth0.11, w1.Bth0.11 )#5 // end mux2x1 Bth0.11 end netlist // mux2x1 Bth1.0( PP_1_0, GND, GND, b1 ) inv(b1_n.Bth1.0, b1 )#5 and2(w0.Bth1.0, b1_n.Bth1.0, GND )#5 and2(w1.Bth1.0, b1, GND )#5 or2(PP_1_0, w0.Bth1.0, w1.Bth1.0 )#5 // end mux2x1 Bth1.0 end netlist // mux2x1 Bth1.1( PP_1_1, GND, a0, b1 ) inv(b1_n.Bth1.1, b1 )#5 and2(w0.Bth1.1, b1_n.Bth1.1, GND )#5 and2(w1.Bth1.1, b1, a0 )#5 or2(PP_1_1, w0.Bth1.1, w1.Bth1.1 )#5 // end mux2x1 Bth1.1 end netlist // mux2x1 Bth1.2( PP_1_2, GND, a1, b1 ) inv(b1_n.Bth1.2, b1 )#5 and2(w0.Bth1.2, b1_n.Bth1.2, GND )#5 and2(w1.Bth1.2, b1, a1 )#5 or2(PP_1_2, w0.Bth1.2, w1.Bth1.2 )#5 // end mux2x1 Bth1.2 end netlist // mux2x1 Bth1.3( PP_1_3, GND, a2, b1 ) inv(b1_n.Bth1.3, b1 )#5 and2(w0.Bth1.3, b1_n.Bth1.3, GND )#5 and2(w1.Bth1.3, b1, a2 )#5 or2(PP_1_3, w0.Bth1.3, w1.Bth1.3 )#5 // end mux2x1 Bth1.3 end netlist // mux2x1 Bth1.4( PP_1_4, GND, a3, b1 ) inv(b1_n.Bth1.4, b1 )#5 and2(w0.Bth1.4, b1_n.Bth1.4, GND )#5 and2(w1.Bth1.4, b1, a3 )#5 or2(PP_1_4, w0.Bth1.4, w1.Bth1.4 )#5 // end mux2x1 Bth1.4 end netlist // mux2x1 Bth1.5( PP_1_5, GND, a4, b1 ) inv(b1_n.Bth1.5, b1 )#5 and2(w0.Bth1.5, b1_n.Bth1.5, GND )#5 and2(w1.Bth1.5, b1, a4 )#5 or2(PP_1_5, w0.Bth1.5, w1.Bth1.5 )#5 // end mux2x1 Bth1.5 end netlist // mux2x1 Bth1.6( PP_1_6, GND, a5, b1 ) inv(b1_n.Bth1.6, b1 )#5 and2(w0.Bth1.6, b1_n.Bth1.6, GND )#5 and2(w1.Bth1.6, b1, a5 )#5 or2(PP_1_6, w0.Bth1.6, w1.Bth1.6 )#5 // end mux2x1 Bth1.6 end netlist // mux2x1 Bth1.7( PP_1_7, GND, GND, b1 ) inv(b1_n.Bth1.7, b1 )#5 and2(w0.Bth1.7, b1_n.Bth1.7, GND )#5 and2(w1.Bth1.7, b1, GND )#5 or2(PP_1_7, w0.Bth1.7, w1.Bth1.7 )#5 // end mux2x1 Bth1.7 end netlist // mux2x1 Bth1.8( PP_1_8, GND, GND, b1 ) inv(b1_n.Bth1.8, b1 )#5 and2(w0.Bth1.8, b1_n.Bth1.8, GND )#5 and2(w1.Bth1.8, b1, GND )#5 or2(PP_1_8, w0.Bth1.8, w1.Bth1.8 )#5 // end mux2x1 Bth1.8 end netlist // mux2x1 Bth1.9( PP_1_9, GND, GND, b1 ) inv(b1_n.Bth1.9, b1 )#5 and2(w0.Bth1.9, b1_n.Bth1.9, GND )#5 and2(w1.Bth1.9, b1, GND )#5 or2(PP_1_9, w0.Bth1.9, w1.Bth1.9 )#5 // end mux2x1 Bth1.9 end netlist // mux2x1 Bth1.10( PP_1_10, GND, GND, b1 ) inv(b1_n.Bth1.10, b1 )#5 and2(w0.Bth1.10, b1_n.Bth1.10, GND )#5 and2(w1.Bth1.10, b1, GND )#5 or2(PP_1_10, w0.Bth1.10, w1.Bth1.10 )#5 // end mux2x1 Bth1.10 end netlist // mux2x1 Bth1.11( PP_1_11, GND, GND, b1 ) inv(b1_n.Bth1.11, b1 )#5 and2(w0.Bth1.11, b1_n.Bth1.11, GND )#5 and2(w1.Bth1.11, b1, GND )#5 or2(PP_1_11, w0.Bth1.11, w1.Bth1.11 )#5 // end mux2x1 Bth1.11 end netlist // mux2x1 Bth2.0( PP_2_0, GND, GND, b2 ) inv(b2_n.Bth2.0, b2 )#5 and2(w0.Bth2.0, b2_n.Bth2.0, GND )#5 and2(w1.Bth2.0, b2, GND )#5 or2(PP_2_0, w0.Bth2.0, w1.Bth2.0 )#5 // end mux2x1 Bth2.0 end netlist // mux2x1 Bth2.1( PP_2_1, GND, GND, b2 ) inv(b2_n.Bth2.1, b2 )#5 and2(w0.Bth2.1, b2_n.Bth2.1, GND )#5 and2(w1.Bth2.1, b2, GND )#5 or2(PP_2_1, w0.Bth2.1, w1.Bth2.1 )#5 // end mux2x1 Bth2.1 end netlist // mux2x1 Bth2.2( PP_2_2, GND, a0, b2 ) inv(b2_n.Bth2.2, b2 )#5 and2(w0.Bth2.2, b2_n.Bth2.2, GND )#5 and2(w1.Bth2.2, b2, a0 )#5 or2(PP_2_2, w0.Bth2.2, w1.Bth2.2 )#5 // end mux2x1 Bth2.2 end netlist // mux2x1 Bth2.3( PP_2_3, GND, a1, b2 ) inv(b2_n.Bth2.3, b2 )#5 and2(w0.Bth2.3, b2_n.Bth2.3, GND )#5 and2(w1.Bth2.3, b2, a1 )#5 or2(PP_2_3, w0.Bth2.3, w1.Bth2.3 )#5 // end mux2x1 Bth2.3 end netlist // mux2x1 Bth2.4( PP_2_4, GND, a2, b2 ) inv(b2_n.Bth2.4, b2 )#5 and2(w0.Bth2.4, b2_n.Bth2.4, GND )#5 and2(w1.Bth2.4, b2, a2 )#5 or2(PP_2_4, w0.Bth2.4, w1.Bth2.4 )#5 // end mux2x1 Bth2.4 end netlist // mux2x1 Bth2.5( PP_2_5, GND, a3, b2 ) inv(b2_n.Bth2.5, b2 )#5 and2(w0.Bth2.5, b2_n.Bth2.5, GND )#5 and2(w1.Bth2.5, b2, a3 )#5 or2(PP_2_5, w0.Bth2.5, w1.Bth2.5 )#5 // end mux2x1 Bth2.5 end netlist // mux2x1 Bth2.6( PP_2_6, GND, a4, b2 ) inv(b2_n.Bth2.6, b2 )#5 and2(w0.Bth2.6, b2_n.Bth2.6, GND )#5 and2(w1.Bth2.6, b2, a4 )#5 or2(PP_2_6, w0.Bth2.6, w1.Bth2.6 )#5 // end mux2x1 Bth2.6 end netlist // mux2x1 Bth2.7( PP_2_7, GND, a5, b2 ) inv(b2_n.Bth2.7, b2 )#5 and2(w0.Bth2.7, b2_n.Bth2.7, GND )#5 and2(w1.Bth2.7, b2, a5 )#5 or2(PP_2_7, w0.Bth2.7, w1.Bth2.7 )#5 // end mux2x1 Bth2.7 end netlist // mux2x1 Bth2.8( PP_2_8, GND, GND, b2 ) inv(b2_n.Bth2.8, b2 )#5 and2(w0.Bth2.8, b2_n.Bth2.8, GND )#5 and2(w1.Bth2.8, b2, GND )#5 or2(PP_2_8, w0.Bth2.8, w1.Bth2.8 )#5 // end mux2x1 Bth2.8 end netlist // mux2x1 Bth2.9( PP_2_9, GND, GND, b2 ) inv(b2_n.Bth2.9, b2 )#5 and2(w0.Bth2.9, b2_n.Bth2.9, GND )#5 and2(w1.Bth2.9, b2, GND )#5 or2(PP_2_9, w0.Bth2.9, w1.Bth2.9 )#5 // end mux2x1 Bth2.9 end netlist // mux2x1 Bth2.10( PP_2_10, GND, GND, b2 ) inv(b2_n.Bth2.10, b2 )#5 and2(w0.Bth2.10, b2_n.Bth2.10, GND )#5 and2(w1.Bth2.10, b2, GND )#5 or2(PP_2_10, w0.Bth2.10, w1.Bth2.10 )#5 // end mux2x1 Bth2.10 end netlist // mux2x1 Bth2.11( PP_2_11, GND, GND, b2 ) inv(b2_n.Bth2.11, b2 )#5 and2(w0.Bth2.11, b2_n.Bth2.11, GND )#5 and2(w1.Bth2.11, b2, GND )#5 or2(PP_2_11, w0.Bth2.11, w1.Bth2.11 )#5 // end mux2x1 Bth2.11 end netlist // mux2x1 Bth3.0( PP_3_0, GND, GND, b3 ) inv(b3_n.Bth3.0, b3 )#5 and2(w0.Bth3.0, b3_n.Bth3.0, GND )#5 and2(w1.Bth3.0, b3, GND )#5 or2(PP_3_0, w0.Bth3.0, w1.Bth3.0 )#5 // end mux2x1 Bth3.0 end netlist // mux2x1 Bth3.1( PP_3_1, GND, GND, b3 ) inv(b3_n.Bth3.1, b3 )#5 and2(w0.Bth3.1, b3_n.Bth3.1, GND )#5 and2(w1.Bth3.1, b3, GND )#5 or2(PP_3_1, w0.Bth3.1, w1.Bth3.1 )#5 // end mux2x1 Bth3.1 end netlist // mux2x1 Bth3.2( PP_3_2, GND, GND, b3 ) inv(b3_n.Bth3.2, b3 )#5 and2(w0.Bth3.2, b3_n.Bth3.2, GND )#5 and2(w1.Bth3.2, b3, GND )#5 or2(PP_3_2, w0.Bth3.2, w1.Bth3.2 )#5 // end mux2x1 Bth3.2 end netlist // mux2x1 Bth3.3( PP_3_3, GND, a0, b3 ) inv(b3_n.Bth3.3, b3 )#5 and2(w0.Bth3.3, b3_n.Bth3.3, GND )#5 and2(w1.Bth3.3, b3, a0 )#5 or2(PP_3_3, w0.Bth3.3, w1.Bth3.3 )#5 // end mux2x1 Bth3.3 end netlist // mux2x1 Bth3.4( PP_3_4, GND, a1, b3 ) inv(b3_n.Bth3.4, b3 )#5 and2(w0.Bth3.4, b3_n.Bth3.4, GND )#5 and2(w1.Bth3.4, b3, a1 )#5 or2(PP_3_4, w0.Bth3.4, w1.Bth3.4 )#5 // end mux2x1 Bth3.4 end netlist // mux2x1 Bth3.5( PP_3_5, GND, a2, b3 ) inv(b3_n.Bth3.5, b3 )#5 and2(w0.Bth3.5, b3_n.Bth3.5, GND )#5 and2(w1.Bth3.5, b3, a2 )#5 or2(PP_3_5, w0.Bth3.5, w1.Bth3.5 )#5 // end mux2x1 Bth3.5 end netlist // mux2x1 Bth3.6( PP_3_6, GND, a3, b3 ) inv(b3_n.Bth3.6, b3 )#5 and2(w0.Bth3.6, b3_n.Bth3.6, GND )#5 and2(w1.Bth3.6, b3, a3 )#5 or2(PP_3_6, w0.Bth3.6, w1.Bth3.6 )#5 // end mux2x1 Bth3.6 end netlist // mux2x1 Bth3.7( PP_3_7, GND, a4, b3 ) inv(b3_n.Bth3.7, b3 )#5 and2(w0.Bth3.7, b3_n.Bth3.7, GND )#5 and2(w1.Bth3.7, b3, a4 )#5 or2(PP_3_7, w0.Bth3.7, w1.Bth3.7 )#5 // end mux2x1 Bth3.7 end netlist // mux2x1 Bth3.8( PP_3_8, GND, a5, b3 ) inv(b3_n.Bth3.8, b3 )#5 and2(w0.Bth3.8, b3_n.Bth3.8, GND )#5 and2(w1.Bth3.8, b3, a5 )#5 or2(PP_3_8, w0.Bth3.8, w1.Bth3.8 )#5 // end mux2x1 Bth3.8 end netlist // mux2x1 Bth3.9( PP_3_9, GND, GND, b3 ) inv(b3_n.Bth3.9, b3 )#5 and2(w0.Bth3.9, b3_n.Bth3.9, GND )#5 and2(w1.Bth3.9, b3, GND )#5 or2(PP_3_9, w0.Bth3.9, w1.Bth3.9 )#5 // end mux2x1 Bth3.9 end netlist // mux2x1 Bth3.10( PP_3_10, GND, GND, b3 ) inv(b3_n.Bth3.10, b3 )#5 and2(w0.Bth3.10, b3_n.Bth3.10, GND )#5 and2(w1.Bth3.10, b3, GND )#5 or2(PP_3_10, w0.Bth3.10, w1.Bth3.10 )#5 // end mux2x1 Bth3.10 end netlist // mux2x1 Bth3.11( PP_3_11, GND, GND, b3 ) inv(b3_n.Bth3.11, b3 )#5 and2(w0.Bth3.11, b3_n.Bth3.11, GND )#5 and2(w1.Bth3.11, b3, GND )#5 or2(PP_3_11, w0.Bth3.11, w1.Bth3.11 )#5 // end mux2x1 Bth3.11 end netlist // mux2x1 Bth4.0( PP_4_0, GND, GND, b4 ) inv(b4_n.Bth4.0, b4 )#5 and2(w0.Bth4.0, b4_n.Bth4.0, GND )#5 and2(w1.Bth4.0, b4, GND )#5 or2(PP_4_0, w0.Bth4.0, w1.Bth4.0 )#5 // end mux2x1 Bth4.0 end netlist // mux2x1 Bth4.1( PP_4_1, GND, GND, b4 ) inv(b4_n.Bth4.1, b4 )#5 and2(w0.Bth4.1, b4_n.Bth4.1, GND )#5 and2(w1.Bth4.1, b4, GND )#5 or2(PP_4_1, w0.Bth4.1, w1.Bth4.1 )#5 // end mux2x1 Bth4.1 end netlist // mux2x1 Bth4.2( PP_4_2, GND, GND, b4 ) inv(b4_n.Bth4.2, b4 )#5 and2(w0.Bth4.2, b4_n.Bth4.2, GND )#5 and2(w1.Bth4.2, b4, GND )#5 or2(PP_4_2, w0.Bth4.2, w1.Bth4.2 )#5 // end mux2x1 Bth4.2 end netlist // mux2x1 Bth4.3( PP_4_3, GND, GND, b4 ) inv(b4_n.Bth4.3, b4 )#5 and2(w0.Bth4.3, b4_n.Bth4.3, GND )#5 and2(w1.Bth4.3, b4, GND )#5 or2(PP_4_3, w0.Bth4.3, w1.Bth4.3 )#5 // end mux2x1 Bth4.3 end netlist // mux2x1 Bth4.4( PP_4_4, GND, a0, b4 ) inv(b4_n.Bth4.4, b4 )#5 and2(w0.Bth4.4, b4_n.Bth4.4, GND )#5 and2(w1.Bth4.4, b4, a0 )#5 or2(PP_4_4, w0.Bth4.4, w1.Bth4.4 )#5 // end mux2x1 Bth4.4 end netlist // mux2x1 Bth4.5( PP_4_5, GND, a1, b4 ) inv(b4_n.Bth4.5, b4 )#5 and2(w0.Bth4.5, b4_n.Bth4.5, GND )#5 and2(w1.Bth4.5, b4, a1 )#5 or2(PP_4_5, w0.Bth4.5, w1.Bth4.5 )#5 // end mux2x1 Bth4.5 end netlist // mux2x1 Bth4.6( PP_4_6, GND, a2, b4 ) inv(b4_n.Bth4.6, b4 )#5 and2(w0.Bth4.6, b4_n.Bth4.6, GND )#5 and2(w1.Bth4.6, b4, a2 )#5 or2(PP_4_6, w0.Bth4.6, w1.Bth4.6 )#5 // end mux2x1 Bth4.6 end netlist // mux2x1 Bth4.7( PP_4_7, GND, a3, b4 ) inv(b4_n.Bth4.7, b4 )#5 and2(w0.Bth4.7, b4_n.Bth4.7, GND )#5 and2(w1.Bth4.7, b4, a3 )#5 or2(PP_4_7, w0.Bth4.7, w1.Bth4.7 )#5 // end mux2x1 Bth4.7 end netlist // mux2x1 Bth4.8( PP_4_8, GND, a4, b4 ) inv(b4_n.Bth4.8, b4 )#5 and2(w0.Bth4.8, b4_n.Bth4.8, GND )#5 and2(w1.Bth4.8, b4, a4 )#5 or2(PP_4_8, w0.Bth4.8, w1.Bth4.8 )#5 // end mux2x1 Bth4.8 end netlist // mux2x1 Bth4.9( PP_4_9, GND, a5, b4 ) inv(b4_n.Bth4.9, b4 )#5 and2(w0.Bth4.9, b4_n.Bth4.9, GND )#5 and2(w1.Bth4.9, b4, a5 )#5 or2(PP_4_9, w0.Bth4.9, w1.Bth4.9 )#5 // end mux2x1 Bth4.9 end netlist // mux2x1 Bth4.10( PP_4_10, GND, GND, b4 ) inv(b4_n.Bth4.10, b4 )#5 and2(w0.Bth4.10, b4_n.Bth4.10, GND )#5 and2(w1.Bth4.10, b4, GND )#5 or2(PP_4_10, w0.Bth4.10, w1.Bth4.10 )#5 // end mux2x1 Bth4.10 end netlist // mux2x1 Bth4.11( PP_4_11, GND, GND, b4 ) inv(b4_n.Bth4.11, b4 )#5 and2(w0.Bth4.11, b4_n.Bth4.11, GND )#5 and2(w1.Bth4.11, b4, GND )#5 or2(PP_4_11, w0.Bth4.11, w1.Bth4.11 )#5 // end mux2x1 Bth4.11 end netlist // mux2x1 Bth5.0( PP_5_0, GND, GND, b5 ) inv(b5_n.Bth5.0, b5 )#5 and2(w0.Bth5.0, b5_n.Bth5.0, GND )#5 and2(w1.Bth5.0, b5, GND )#5 or2(PP_5_0, w0.Bth5.0, w1.Bth5.0 )#5 // end mux2x1 Bth5.0 end netlist // mux2x1 Bth5.1( PP_5_1, GND, GND, b5 ) inv(b5_n.Bth5.1, b5 )#5 and2(w0.Bth5.1, b5_n.Bth5.1, GND )#5 and2(w1.Bth5.1, b5, GND )#5 or2(PP_5_1, w0.Bth5.1, w1.Bth5.1 )#5 // end mux2x1 Bth5.1 end netlist // mux2x1 Bth5.2( PP_5_2, GND, GND, b5 ) inv(b5_n.Bth5.2, b5 )#5 and2(w0.Bth5.2, b5_n.Bth5.2, GND )#5 and2(w1.Bth5.2, b5, GND )#5 or2(PP_5_2, w0.Bth5.2, w1.Bth5.2 )#5 // end mux2x1 Bth5.2 end netlist // mux2x1 Bth5.3( PP_5_3, GND, GND, b5 ) inv(b5_n.Bth5.3, b5 )#5 and2(w0.Bth5.3, b5_n.Bth5.3, GND )#5 and2(w1.Bth5.3, b5, GND )#5 or2(PP_5_3, w0.Bth5.3, w1.Bth5.3 )#5 // end mux2x1 Bth5.3 end netlist // mux2x1 Bth5.4( PP_5_4, GND, GND, b5 ) inv(b5_n.Bth5.4, b5 )#5 and2(w0.Bth5.4, b5_n.Bth5.4, GND )#5 and2(w1.Bth5.4, b5, GND )#5 or2(PP_5_4, w0.Bth5.4, w1.Bth5.4 )#5 // end mux2x1 Bth5.4 end netlist // mux2x1 Bth5.5( PP_5_5, GND, a0, b5 ) inv(b5_n.Bth5.5, b5 )#5 and2(w0.Bth5.5, b5_n.Bth5.5, GND )#5 and2(w1.Bth5.5, b5, a0 )#5 or2(PP_5_5, w0.Bth5.5, w1.Bth5.5 )#5 // end mux2x1 Bth5.5 end netlist // mux2x1 Bth5.6( PP_5_6, GND, a1, b5 ) inv(b5_n.Bth5.6, b5 )#5 and2(w0.Bth5.6, b5_n.Bth5.6, GND )#5 and2(w1.Bth5.6, b5, a1 )#5 or2(PP_5_6, w0.Bth5.6, w1.Bth5.6 )#5 // end mux2x1 Bth5.6 end netlist // mux2x1 Bth5.7( PP_5_7, GND, a2, b5 ) inv(b5_n.Bth5.7, b5 )#5 and2(w0.Bth5.7, b5_n.Bth5.7, GND )#5 and2(w1.Bth5.7, b5, a2 )#5 or2(PP_5_7, w0.Bth5.7, w1.Bth5.7 )#5 // end mux2x1 Bth5.7 end netlist // mux2x1 Bth5.8( PP_5_8, GND, a3, b5 ) inv(b5_n.Bth5.8, b5 )#5 and2(w0.Bth5.8, b5_n.Bth5.8, GND )#5 and2(w1.Bth5.8, b5, a3 )#5 or2(PP_5_8, w0.Bth5.8, w1.Bth5.8 )#5 // end mux2x1 Bth5.8 end netlist // mux2x1 Bth5.9( PP_5_9, GND, a4, b5 ) inv(b5_n.Bth5.9, b5 )#5 and2(w0.Bth5.9, b5_n.Bth5.9, GND )#5 and2(w1.Bth5.9, b5, a4 )#5 or2(PP_5_9, w0.Bth5.9, w1.Bth5.9 )#5 // end mux2x1 Bth5.9 end netlist // mux2x1 Bth5.10( PP_5_10, GND, a5, b5 ) inv(b5_n.Bth5.10, b5 )#5 and2(w0.Bth5.10, b5_n.Bth5.10, GND )#5 and2(w1.Bth5.10, b5, a5 )#5 or2(PP_5_10, w0.Bth5.10, w1.Bth5.10 )#5 // end mux2x1 Bth5.10 end netlist // mux2x1 Bth5.11( PP_5_11, GND, GND, b5 ) inv(b5_n.Bth5.11, b5 )#5 and2(w0.Bth5.11, b5_n.Bth5.11, GND )#5 and2(w1.Bth5.11, b5, GND )#5 or2(PP_5_11, w0.Bth5.11, w1.Bth5.11 )#5 // end mux2x1 Bth5.11 end // instantiating csa4x2Vec at lvl 0 netlist // csa4x2 (csa4x2_0_lvl0.0, s0_lvl0_0,t0_lvl0_0,cout_csa4x2_0_lvl0.0,PP_0_0,PP_1_0,PP_2_0,PP_3_0,GND) ; // adder1bit Adder0.csa4x2_0_lvl0.0( sintcsa4x2_0_lvl0.0, cout_csa4x2_0_lvl0.0, PP_0_0, PP_1_0, PP_2_0) // sum xor2( w0.Adder0.csa4x2_0_lvl0.0, PP_0_0, PP_1_0 )#5 xor2( sintcsa4x2_0_lvl0.0, w0.Adder0.csa4x2_0_lvl0.0, PP_2_0 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.0, PP_0_0, PP_1_0 )#5 and2( w2.Adder0.csa4x2_0_lvl0.0, w0.Adder0.csa4x2_0_lvl0.0, PP_2_0 )#5 or2( cout_csa4x2_0_lvl0.0, w1.Adder0.csa4x2_0_lvl0.0, w2.Adder0.csa4x2_0_lvl0.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.0( s0_lvl0_0, t0_lvl0_0, sintcsa4x2_0_lvl0.0, PP_3_0, GND) // sum xor2( w0.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, PP_3_0 )#5 xor2( s0_lvl0_0, w0.Adder1.csa4x2_0_lvl0.0, GND )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, PP_3_0 )#5 and2( w2.Adder1.csa4x2_0_lvl0.0, w0.Adder1.csa4x2_0_lvl0.0, GND )#5 or2( t0_lvl0_0, w1.Adder1.csa4x2_0_lvl0.0, w2.Adder1.csa4x2_0_lvl0.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.1, s0_lvl0_1,t0_lvl0_1,cout_csa4x2_0_lvl0.1,PP_0_1,PP_1_1,PP_2_1,PP_3_1,cout_csa4x2_0_lvl0.0) ; // adder1bit Adder0.csa4x2_0_lvl0.1( sintcsa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.1, PP_0_1, PP_1_1, PP_2_1) // sum xor2( w0.Adder0.csa4x2_0_lvl0.1, PP_0_1, PP_1_1 )#5 xor2( sintcsa4x2_0_lvl0.1, w0.Adder0.csa4x2_0_lvl0.1, PP_2_1 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.1, PP_0_1, PP_1_1 )#5 and2( w2.Adder0.csa4x2_0_lvl0.1, w0.Adder0.csa4x2_0_lvl0.1, PP_2_1 )#5 or2( cout_csa4x2_0_lvl0.1, w1.Adder0.csa4x2_0_lvl0.1, w2.Adder0.csa4x2_0_lvl0.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.1( s0_lvl0_1, t0_lvl0_1, sintcsa4x2_0_lvl0.1, PP_3_1, cout_csa4x2_0_lvl0.0) // sum xor2( w0.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, PP_3_1 )#5 xor2( s0_lvl0_1, w0.Adder1.csa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, PP_3_1 )#5 and2( w2.Adder1.csa4x2_0_lvl0.1, w0.Adder1.csa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0 )#5 or2( t0_lvl0_1, w1.Adder1.csa4x2_0_lvl0.1, w2.Adder1.csa4x2_0_lvl0.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.2, s0_lvl0_2,t0_lvl0_2,cout_csa4x2_0_lvl0.2,PP_0_2,PP_1_2,PP_2_2,PP_3_2,cout_csa4x2_0_lvl0.1) ; // adder1bit Adder0.csa4x2_0_lvl0.2( sintcsa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.2, PP_0_2, PP_1_2, PP_2_2) // sum xor2( w0.Adder0.csa4x2_0_lvl0.2, PP_0_2, PP_1_2 )#5 xor2( sintcsa4x2_0_lvl0.2, w0.Adder0.csa4x2_0_lvl0.2, PP_2_2 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.2, PP_0_2, PP_1_2 )#5 and2( w2.Adder0.csa4x2_0_lvl0.2, w0.Adder0.csa4x2_0_lvl0.2, PP_2_2 )#5 or2( cout_csa4x2_0_lvl0.2, w1.Adder0.csa4x2_0_lvl0.2, w2.Adder0.csa4x2_0_lvl0.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.2( s0_lvl0_2, t0_lvl0_2, sintcsa4x2_0_lvl0.2, PP_3_2, cout_csa4x2_0_lvl0.1) // sum xor2( w0.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, PP_3_2 )#5 xor2( s0_lvl0_2, w0.Adder1.csa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, PP_3_2 )#5 and2( w2.Adder1.csa4x2_0_lvl0.2, w0.Adder1.csa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1 )#5 or2( t0_lvl0_2, w1.Adder1.csa4x2_0_lvl0.2, w2.Adder1.csa4x2_0_lvl0.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.3, s0_lvl0_3,t0_lvl0_3,cout_csa4x2_0_lvl0.3,PP_0_3,PP_1_3,PP_2_3,PP_3_3,cout_csa4x2_0_lvl0.2) ; // adder1bit Adder0.csa4x2_0_lvl0.3( sintcsa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.3, PP_0_3, PP_1_3, PP_2_3) // sum xor2( w0.Adder0.csa4x2_0_lvl0.3, PP_0_3, PP_1_3 )#5 xor2( sintcsa4x2_0_lvl0.3, w0.Adder0.csa4x2_0_lvl0.3, PP_2_3 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.3, PP_0_3, PP_1_3 )#5 and2( w2.Adder0.csa4x2_0_lvl0.3, w0.Adder0.csa4x2_0_lvl0.3, PP_2_3 )#5 or2( cout_csa4x2_0_lvl0.3, w1.Adder0.csa4x2_0_lvl0.3, w2.Adder0.csa4x2_0_lvl0.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.3( s0_lvl0_3, t0_lvl0_3, sintcsa4x2_0_lvl0.3, PP_3_3, cout_csa4x2_0_lvl0.2) // sum xor2( w0.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, PP_3_3 )#5 xor2( s0_lvl0_3, w0.Adder1.csa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, PP_3_3 )#5 and2( w2.Adder1.csa4x2_0_lvl0.3, w0.Adder1.csa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2 )#5 or2( t0_lvl0_3, w1.Adder1.csa4x2_0_lvl0.3, w2.Adder1.csa4x2_0_lvl0.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.4, s0_lvl0_4,t0_lvl0_4,cout_csa4x2_0_lvl0.4,PP_0_4,PP_1_4,PP_2_4,PP_3_4,cout_csa4x2_0_lvl0.3) ; // adder1bit Adder0.csa4x2_0_lvl0.4( sintcsa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.4, PP_0_4, PP_1_4, PP_2_4) // sum xor2( w0.Adder0.csa4x2_0_lvl0.4, PP_0_4, PP_1_4 )#5 xor2( sintcsa4x2_0_lvl0.4, w0.Adder0.csa4x2_0_lvl0.4, PP_2_4 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.4, PP_0_4, PP_1_4 )#5 and2( w2.Adder0.csa4x2_0_lvl0.4, w0.Adder0.csa4x2_0_lvl0.4, PP_2_4 )#5 or2( cout_csa4x2_0_lvl0.4, w1.Adder0.csa4x2_0_lvl0.4, w2.Adder0.csa4x2_0_lvl0.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.4( s0_lvl0_4, t0_lvl0_4, sintcsa4x2_0_lvl0.4, PP_3_4, cout_csa4x2_0_lvl0.3) // sum xor2( w0.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, PP_3_4 )#5 xor2( s0_lvl0_4, w0.Adder1.csa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, PP_3_4 )#5 and2( w2.Adder1.csa4x2_0_lvl0.4, w0.Adder1.csa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3 )#5 or2( t0_lvl0_4, w1.Adder1.csa4x2_0_lvl0.4, w2.Adder1.csa4x2_0_lvl0.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.5, s0_lvl0_5,t0_lvl0_5,cout_csa4x2_0_lvl0.5,PP_0_5,PP_1_5,PP_2_5,PP_3_5,cout_csa4x2_0_lvl0.4) ; // adder1bit Adder0.csa4x2_0_lvl0.5( sintcsa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.5, PP_0_5, PP_1_5, PP_2_5) // sum xor2( w0.Adder0.csa4x2_0_lvl0.5, PP_0_5, PP_1_5 )#5 xor2( sintcsa4x2_0_lvl0.5, w0.Adder0.csa4x2_0_lvl0.5, PP_2_5 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.5, PP_0_5, PP_1_5 )#5 and2( w2.Adder0.csa4x2_0_lvl0.5, w0.Adder0.csa4x2_0_lvl0.5, PP_2_5 )#5 or2( cout_csa4x2_0_lvl0.5, w1.Adder0.csa4x2_0_lvl0.5, w2.Adder0.csa4x2_0_lvl0.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.5( s0_lvl0_5, t0_lvl0_5, sintcsa4x2_0_lvl0.5, PP_3_5, cout_csa4x2_0_lvl0.4) // sum xor2( w0.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, PP_3_5 )#5 xor2( s0_lvl0_5, w0.Adder1.csa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, PP_3_5 )#5 and2( w2.Adder1.csa4x2_0_lvl0.5, w0.Adder1.csa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4 )#5 or2( t0_lvl0_5, w1.Adder1.csa4x2_0_lvl0.5, w2.Adder1.csa4x2_0_lvl0.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.6, s0_lvl0_6,t0_lvl0_6,cout_csa4x2_0_lvl0.6,PP_0_6,PP_1_6,PP_2_6,PP_3_6,cout_csa4x2_0_lvl0.5) ; // adder1bit Adder0.csa4x2_0_lvl0.6( sintcsa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.6, PP_0_6, PP_1_6, PP_2_6) // sum xor2( w0.Adder0.csa4x2_0_lvl0.6, PP_0_6, PP_1_6 )#5 xor2( sintcsa4x2_0_lvl0.6, w0.Adder0.csa4x2_0_lvl0.6, PP_2_6 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.6, PP_0_6, PP_1_6 )#5 and2( w2.Adder0.csa4x2_0_lvl0.6, w0.Adder0.csa4x2_0_lvl0.6, PP_2_6 )#5 or2( cout_csa4x2_0_lvl0.6, w1.Adder0.csa4x2_0_lvl0.6, w2.Adder0.csa4x2_0_lvl0.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.6( s0_lvl0_6, t0_lvl0_6, sintcsa4x2_0_lvl0.6, PP_3_6, cout_csa4x2_0_lvl0.5) // sum xor2( w0.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, PP_3_6 )#5 xor2( s0_lvl0_6, w0.Adder1.csa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, PP_3_6 )#5 and2( w2.Adder1.csa4x2_0_lvl0.6, w0.Adder1.csa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5 )#5 or2( t0_lvl0_6, w1.Adder1.csa4x2_0_lvl0.6, w2.Adder1.csa4x2_0_lvl0.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.7, s0_lvl0_7,t0_lvl0_7,cout_csa4x2_0_lvl0.7,PP_0_7,PP_1_7,PP_2_7,PP_3_7,cout_csa4x2_0_lvl0.6) ; // adder1bit Adder0.csa4x2_0_lvl0.7( sintcsa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.7, PP_0_7, PP_1_7, PP_2_7) // sum xor2( w0.Adder0.csa4x2_0_lvl0.7, PP_0_7, PP_1_7 )#5 xor2( sintcsa4x2_0_lvl0.7, w0.Adder0.csa4x2_0_lvl0.7, PP_2_7 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.7, PP_0_7, PP_1_7 )#5 and2( w2.Adder0.csa4x2_0_lvl0.7, w0.Adder0.csa4x2_0_lvl0.7, PP_2_7 )#5 or2( cout_csa4x2_0_lvl0.7, w1.Adder0.csa4x2_0_lvl0.7, w2.Adder0.csa4x2_0_lvl0.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.7( s0_lvl0_7, t0_lvl0_7, sintcsa4x2_0_lvl0.7, PP_3_7, cout_csa4x2_0_lvl0.6) // sum xor2( w0.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, PP_3_7 )#5 xor2( s0_lvl0_7, w0.Adder1.csa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, PP_3_7 )#5 and2( w2.Adder1.csa4x2_0_lvl0.7, w0.Adder1.csa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6 )#5 or2( t0_lvl0_7, w1.Adder1.csa4x2_0_lvl0.7, w2.Adder1.csa4x2_0_lvl0.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.8, s0_lvl0_8,t0_lvl0_8,cout_csa4x2_0_lvl0.8,PP_0_8,PP_1_8,PP_2_8,PP_3_8,cout_csa4x2_0_lvl0.7) ; // adder1bit Adder0.csa4x2_0_lvl0.8( sintcsa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.8, PP_0_8, PP_1_8, PP_2_8) // sum xor2( w0.Adder0.csa4x2_0_lvl0.8, PP_0_8, PP_1_8 )#5 xor2( sintcsa4x2_0_lvl0.8, w0.Adder0.csa4x2_0_lvl0.8, PP_2_8 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.8, PP_0_8, PP_1_8 )#5 and2( w2.Adder0.csa4x2_0_lvl0.8, w0.Adder0.csa4x2_0_lvl0.8, PP_2_8 )#5 or2( cout_csa4x2_0_lvl0.8, w1.Adder0.csa4x2_0_lvl0.8, w2.Adder0.csa4x2_0_lvl0.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.8( s0_lvl0_8, t0_lvl0_8, sintcsa4x2_0_lvl0.8, PP_3_8, cout_csa4x2_0_lvl0.7) // sum xor2( w0.Adder1.csa4x2_0_lvl0.8, sintcsa4x2_0_lvl0.8, PP_3_8 )#5 xor2( s0_lvl0_8, w0.Adder1.csa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.7 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.8, sintcsa4x2_0_lvl0.8, PP_3_8 )#5 and2( w2.Adder1.csa4x2_0_lvl0.8, w0.Adder1.csa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.7 )#5 or2( t0_lvl0_8, w1.Adder1.csa4x2_0_lvl0.8, w2.Adder1.csa4x2_0_lvl0.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.9, s0_lvl0_9,t0_lvl0_9,cout_csa4x2_0_lvl0.9,PP_0_9,PP_1_9,PP_2_9,PP_3_9,cout_csa4x2_0_lvl0.8) ; // adder1bit Adder0.csa4x2_0_lvl0.9( sintcsa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.9, PP_0_9, PP_1_9, PP_2_9) // sum xor2( w0.Adder0.csa4x2_0_lvl0.9, PP_0_9, PP_1_9 )#5 xor2( sintcsa4x2_0_lvl0.9, w0.Adder0.csa4x2_0_lvl0.9, PP_2_9 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.9, PP_0_9, PP_1_9 )#5 and2( w2.Adder0.csa4x2_0_lvl0.9, w0.Adder0.csa4x2_0_lvl0.9, PP_2_9 )#5 or2( cout_csa4x2_0_lvl0.9, w1.Adder0.csa4x2_0_lvl0.9, w2.Adder0.csa4x2_0_lvl0.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.9( s0_lvl0_9, t0_lvl0_9, sintcsa4x2_0_lvl0.9, PP_3_9, cout_csa4x2_0_lvl0.8) // sum xor2( w0.Adder1.csa4x2_0_lvl0.9, sintcsa4x2_0_lvl0.9, PP_3_9 )#5 xor2( s0_lvl0_9, w0.Adder1.csa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.8 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.9, sintcsa4x2_0_lvl0.9, PP_3_9 )#5 and2( w2.Adder1.csa4x2_0_lvl0.9, w0.Adder1.csa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.8 )#5 or2( t0_lvl0_9, w1.Adder1.csa4x2_0_lvl0.9, w2.Adder1.csa4x2_0_lvl0.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.10, s0_lvl0_10,t0_lvl0_10,cout_csa4x2_0_lvl0.10,PP_0_10,PP_1_10,PP_2_10,PP_3_10,cout_csa4x2_0_lvl0.9) ; // adder1bit Adder0.csa4x2_0_lvl0.10( sintcsa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.10, PP_0_10, PP_1_10, PP_2_10) // sum xor2( w0.Adder0.csa4x2_0_lvl0.10, PP_0_10, PP_1_10 )#5 xor2( sintcsa4x2_0_lvl0.10, w0.Adder0.csa4x2_0_lvl0.10, PP_2_10 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.10, PP_0_10, PP_1_10 )#5 and2( w2.Adder0.csa4x2_0_lvl0.10, w0.Adder0.csa4x2_0_lvl0.10, PP_2_10 )#5 or2( cout_csa4x2_0_lvl0.10, w1.Adder0.csa4x2_0_lvl0.10, w2.Adder0.csa4x2_0_lvl0.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.10( s0_lvl0_10, t0_lvl0_10, sintcsa4x2_0_lvl0.10, PP_3_10, cout_csa4x2_0_lvl0.9) // sum xor2( w0.Adder1.csa4x2_0_lvl0.10, sintcsa4x2_0_lvl0.10, PP_3_10 )#5 xor2( s0_lvl0_10, w0.Adder1.csa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.9 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.10, sintcsa4x2_0_lvl0.10, PP_3_10 )#5 and2( w2.Adder1.csa4x2_0_lvl0.10, w0.Adder1.csa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.9 )#5 or2( t0_lvl0_10, w1.Adder1.csa4x2_0_lvl0.10, w2.Adder1.csa4x2_0_lvl0.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.11, s0_lvl0_11,t0_lvl0_11,cout_csa4x2_0_lvl0.11,PP_0_11,PP_1_11,PP_2_11,PP_3_11,cout_csa4x2_0_lvl0.10) ; // adder1bit Adder0.csa4x2_0_lvl0.11( sintcsa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.11, PP_0_11, PP_1_11, PP_2_11) // sum xor2( w0.Adder0.csa4x2_0_lvl0.11, PP_0_11, PP_1_11 )#5 xor2( sintcsa4x2_0_lvl0.11, w0.Adder0.csa4x2_0_lvl0.11, PP_2_11 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.11, PP_0_11, PP_1_11 )#5 and2( w2.Adder0.csa4x2_0_lvl0.11, w0.Adder0.csa4x2_0_lvl0.11, PP_2_11 )#5 or2( cout_csa4x2_0_lvl0.11, w1.Adder0.csa4x2_0_lvl0.11, w2.Adder0.csa4x2_0_lvl0.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.11( s0_lvl0_11, t0_lvl0_11, sintcsa4x2_0_lvl0.11, PP_3_11, cout_csa4x2_0_lvl0.10) // sum xor2( w0.Adder1.csa4x2_0_lvl0.11, sintcsa4x2_0_lvl0.11, PP_3_11 )#5 xor2( s0_lvl0_11, w0.Adder1.csa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.10 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.11, sintcsa4x2_0_lvl0.11, PP_3_11 )#5 and2( w2.Adder1.csa4x2_0_lvl0.11, w0.Adder1.csa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.10 )#5 or2( t0_lvl0_11, w1.Adder1.csa4x2_0_lvl0.11, w2.Adder1.csa4x2_0_lvl0.11 )#5 // end adder1bit // end csa4x2 end // instantiating csa4x2Vec at lvl 1 netlist // csa4x2 (csa4x2_0_lvl1.0, s0_lvl1_0,t0_lvl1_0,cout_csa4x2_0_lvl1.0,PP_4_0,PP_5_0,s0_lvl0_0,GND,GND) ; // adder1bit Adder0.csa4x2_0_lvl1.0( sintcsa4x2_0_lvl1.0, cout_csa4x2_0_lvl1.0, PP_4_0, PP_5_0, s0_lvl0_0) // sum xor2( w0.Adder0.csa4x2_0_lvl1.0, PP_4_0, PP_5_0 )#5 xor2( sintcsa4x2_0_lvl1.0, w0.Adder0.csa4x2_0_lvl1.0, s0_lvl0_0 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.0, PP_4_0, PP_5_0 )#5 and2( w2.Adder0.csa4x2_0_lvl1.0, w0.Adder0.csa4x2_0_lvl1.0, s0_lvl0_0 )#5 or2( cout_csa4x2_0_lvl1.0, w1.Adder0.csa4x2_0_lvl1.0, w2.Adder0.csa4x2_0_lvl1.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.0( s0_lvl1_0, t0_lvl1_0, sintcsa4x2_0_lvl1.0, GND, GND) // sum xor2( w0.Adder1.csa4x2_0_lvl1.0, sintcsa4x2_0_lvl1.0, GND )#5 xor2( s0_lvl1_0, w0.Adder1.csa4x2_0_lvl1.0, GND )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.0, sintcsa4x2_0_lvl1.0, GND )#5 and2( w2.Adder1.csa4x2_0_lvl1.0, w0.Adder1.csa4x2_0_lvl1.0, GND )#5 or2( t0_lvl1_0, w1.Adder1.csa4x2_0_lvl1.0, w2.Adder1.csa4x2_0_lvl1.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.1, s0_lvl1_1,t0_lvl1_1,cout_csa4x2_0_lvl1.1,PP_4_1,PP_5_1,s0_lvl0_1,t0_lvl0_0,cout_csa4x2_0_lvl1.0) ; // adder1bit Adder0.csa4x2_0_lvl1.1( sintcsa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.1, PP_4_1, PP_5_1, s0_lvl0_1) // sum xor2( w0.Adder0.csa4x2_0_lvl1.1, PP_4_1, PP_5_1 )#5 xor2( sintcsa4x2_0_lvl1.1, w0.Adder0.csa4x2_0_lvl1.1, s0_lvl0_1 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.1, PP_4_1, PP_5_1 )#5 and2( w2.Adder0.csa4x2_0_lvl1.1, w0.Adder0.csa4x2_0_lvl1.1, s0_lvl0_1 )#5 or2( cout_csa4x2_0_lvl1.1, w1.Adder0.csa4x2_0_lvl1.1, w2.Adder0.csa4x2_0_lvl1.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.1( s0_lvl1_1, t0_lvl1_1, sintcsa4x2_0_lvl1.1, t0_lvl0_0, cout_csa4x2_0_lvl1.0) // sum xor2( w0.Adder1.csa4x2_0_lvl1.1, sintcsa4x2_0_lvl1.1, t0_lvl0_0 )#5 xor2( s0_lvl1_1, w0.Adder1.csa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.0 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.1, sintcsa4x2_0_lvl1.1, t0_lvl0_0 )#5 and2( w2.Adder1.csa4x2_0_lvl1.1, w0.Adder1.csa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.0 )#5 or2( t0_lvl1_1, w1.Adder1.csa4x2_0_lvl1.1, w2.Adder1.csa4x2_0_lvl1.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.2, s0_lvl1_2,t0_lvl1_2,cout_csa4x2_0_lvl1.2,PP_4_2,PP_5_2,s0_lvl0_2,t0_lvl0_1,cout_csa4x2_0_lvl1.1) ; // adder1bit Adder0.csa4x2_0_lvl1.2( sintcsa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.2, PP_4_2, PP_5_2, s0_lvl0_2) // sum xor2( w0.Adder0.csa4x2_0_lvl1.2, PP_4_2, PP_5_2 )#5 xor2( sintcsa4x2_0_lvl1.2, w0.Adder0.csa4x2_0_lvl1.2, s0_lvl0_2 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.2, PP_4_2, PP_5_2 )#5 and2( w2.Adder0.csa4x2_0_lvl1.2, w0.Adder0.csa4x2_0_lvl1.2, s0_lvl0_2 )#5 or2( cout_csa4x2_0_lvl1.2, w1.Adder0.csa4x2_0_lvl1.2, w2.Adder0.csa4x2_0_lvl1.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.2( s0_lvl1_2, t0_lvl1_2, sintcsa4x2_0_lvl1.2, t0_lvl0_1, cout_csa4x2_0_lvl1.1) // sum xor2( w0.Adder1.csa4x2_0_lvl1.2, sintcsa4x2_0_lvl1.2, t0_lvl0_1 )#5 xor2( s0_lvl1_2, w0.Adder1.csa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.1 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.2, sintcsa4x2_0_lvl1.2, t0_lvl0_1 )#5 and2( w2.Adder1.csa4x2_0_lvl1.2, w0.Adder1.csa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.1 )#5 or2( t0_lvl1_2, w1.Adder1.csa4x2_0_lvl1.2, w2.Adder1.csa4x2_0_lvl1.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.3, s0_lvl1_3,t0_lvl1_3,cout_csa4x2_0_lvl1.3,PP_4_3,PP_5_3,s0_lvl0_3,t0_lvl0_2,cout_csa4x2_0_lvl1.2) ; // adder1bit Adder0.csa4x2_0_lvl1.3( sintcsa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.3, PP_4_3, PP_5_3, s0_lvl0_3) // sum xor2( w0.Adder0.csa4x2_0_lvl1.3, PP_4_3, PP_5_3 )#5 xor2( sintcsa4x2_0_lvl1.3, w0.Adder0.csa4x2_0_lvl1.3, s0_lvl0_3 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.3, PP_4_3, PP_5_3 )#5 and2( w2.Adder0.csa4x2_0_lvl1.3, w0.Adder0.csa4x2_0_lvl1.3, s0_lvl0_3 )#5 or2( cout_csa4x2_0_lvl1.3, w1.Adder0.csa4x2_0_lvl1.3, w2.Adder0.csa4x2_0_lvl1.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.3( s0_lvl1_3, t0_lvl1_3, sintcsa4x2_0_lvl1.3, t0_lvl0_2, cout_csa4x2_0_lvl1.2) // sum xor2( w0.Adder1.csa4x2_0_lvl1.3, sintcsa4x2_0_lvl1.3, t0_lvl0_2 )#5 xor2( s0_lvl1_3, w0.Adder1.csa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.2 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.3, sintcsa4x2_0_lvl1.3, t0_lvl0_2 )#5 and2( w2.Adder1.csa4x2_0_lvl1.3, w0.Adder1.csa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.2 )#5 or2( t0_lvl1_3, w1.Adder1.csa4x2_0_lvl1.3, w2.Adder1.csa4x2_0_lvl1.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.4, s0_lvl1_4,t0_lvl1_4,cout_csa4x2_0_lvl1.4,PP_4_4,PP_5_4,s0_lvl0_4,t0_lvl0_3,cout_csa4x2_0_lvl1.3) ; // adder1bit Adder0.csa4x2_0_lvl1.4( sintcsa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.4, PP_4_4, PP_5_4, s0_lvl0_4) // sum xor2( w0.Adder0.csa4x2_0_lvl1.4, PP_4_4, PP_5_4 )#5 xor2( sintcsa4x2_0_lvl1.4, w0.Adder0.csa4x2_0_lvl1.4, s0_lvl0_4 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.4, PP_4_4, PP_5_4 )#5 and2( w2.Adder0.csa4x2_0_lvl1.4, w0.Adder0.csa4x2_0_lvl1.4, s0_lvl0_4 )#5 or2( cout_csa4x2_0_lvl1.4, w1.Adder0.csa4x2_0_lvl1.4, w2.Adder0.csa4x2_0_lvl1.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.4( s0_lvl1_4, t0_lvl1_4, sintcsa4x2_0_lvl1.4, t0_lvl0_3, cout_csa4x2_0_lvl1.3) // sum xor2( w0.Adder1.csa4x2_0_lvl1.4, sintcsa4x2_0_lvl1.4, t0_lvl0_3 )#5 xor2( s0_lvl1_4, w0.Adder1.csa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.3 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.4, sintcsa4x2_0_lvl1.4, t0_lvl0_3 )#5 and2( w2.Adder1.csa4x2_0_lvl1.4, w0.Adder1.csa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.3 )#5 or2( t0_lvl1_4, w1.Adder1.csa4x2_0_lvl1.4, w2.Adder1.csa4x2_0_lvl1.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.5, s0_lvl1_5,t0_lvl1_5,cout_csa4x2_0_lvl1.5,PP_4_5,PP_5_5,s0_lvl0_5,t0_lvl0_4,cout_csa4x2_0_lvl1.4) ; // adder1bit Adder0.csa4x2_0_lvl1.5( sintcsa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.5, PP_4_5, PP_5_5, s0_lvl0_5) // sum xor2( w0.Adder0.csa4x2_0_lvl1.5, PP_4_5, PP_5_5 )#5 xor2( sintcsa4x2_0_lvl1.5, w0.Adder0.csa4x2_0_lvl1.5, s0_lvl0_5 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.5, PP_4_5, PP_5_5 )#5 and2( w2.Adder0.csa4x2_0_lvl1.5, w0.Adder0.csa4x2_0_lvl1.5, s0_lvl0_5 )#5 or2( cout_csa4x2_0_lvl1.5, w1.Adder0.csa4x2_0_lvl1.5, w2.Adder0.csa4x2_0_lvl1.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.5( s0_lvl1_5, t0_lvl1_5, sintcsa4x2_0_lvl1.5, t0_lvl0_4, cout_csa4x2_0_lvl1.4) // sum xor2( w0.Adder1.csa4x2_0_lvl1.5, sintcsa4x2_0_lvl1.5, t0_lvl0_4 )#5 xor2( s0_lvl1_5, w0.Adder1.csa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.4 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.5, sintcsa4x2_0_lvl1.5, t0_lvl0_4 )#5 and2( w2.Adder1.csa4x2_0_lvl1.5, w0.Adder1.csa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.4 )#5 or2( t0_lvl1_5, w1.Adder1.csa4x2_0_lvl1.5, w2.Adder1.csa4x2_0_lvl1.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.6, s0_lvl1_6,t0_lvl1_6,cout_csa4x2_0_lvl1.6,PP_4_6,PP_5_6,s0_lvl0_6,t0_lvl0_5,cout_csa4x2_0_lvl1.5) ; // adder1bit Adder0.csa4x2_0_lvl1.6( sintcsa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.6, PP_4_6, PP_5_6, s0_lvl0_6) // sum xor2( w0.Adder0.csa4x2_0_lvl1.6, PP_4_6, PP_5_6 )#5 xor2( sintcsa4x2_0_lvl1.6, w0.Adder0.csa4x2_0_lvl1.6, s0_lvl0_6 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.6, PP_4_6, PP_5_6 )#5 and2( w2.Adder0.csa4x2_0_lvl1.6, w0.Adder0.csa4x2_0_lvl1.6, s0_lvl0_6 )#5 or2( cout_csa4x2_0_lvl1.6, w1.Adder0.csa4x2_0_lvl1.6, w2.Adder0.csa4x2_0_lvl1.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.6( s0_lvl1_6, t0_lvl1_6, sintcsa4x2_0_lvl1.6, t0_lvl0_5, cout_csa4x2_0_lvl1.5) // sum xor2( w0.Adder1.csa4x2_0_lvl1.6, sintcsa4x2_0_lvl1.6, t0_lvl0_5 )#5 xor2( s0_lvl1_6, w0.Adder1.csa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.5 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.6, sintcsa4x2_0_lvl1.6, t0_lvl0_5 )#5 and2( w2.Adder1.csa4x2_0_lvl1.6, w0.Adder1.csa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.5 )#5 or2( t0_lvl1_6, w1.Adder1.csa4x2_0_lvl1.6, w2.Adder1.csa4x2_0_lvl1.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.7, s0_lvl1_7,t0_lvl1_7,cout_csa4x2_0_lvl1.7,PP_4_7,PP_5_7,s0_lvl0_7,t0_lvl0_6,cout_csa4x2_0_lvl1.6) ; // adder1bit Adder0.csa4x2_0_lvl1.7( sintcsa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.7, PP_4_7, PP_5_7, s0_lvl0_7) // sum xor2( w0.Adder0.csa4x2_0_lvl1.7, PP_4_7, PP_5_7 )#5 xor2( sintcsa4x2_0_lvl1.7, w0.Adder0.csa4x2_0_lvl1.7, s0_lvl0_7 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.7, PP_4_7, PP_5_7 )#5 and2( w2.Adder0.csa4x2_0_lvl1.7, w0.Adder0.csa4x2_0_lvl1.7, s0_lvl0_7 )#5 or2( cout_csa4x2_0_lvl1.7, w1.Adder0.csa4x2_0_lvl1.7, w2.Adder0.csa4x2_0_lvl1.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.7( s0_lvl1_7, t0_lvl1_7, sintcsa4x2_0_lvl1.7, t0_lvl0_6, cout_csa4x2_0_lvl1.6) // sum xor2( w0.Adder1.csa4x2_0_lvl1.7, sintcsa4x2_0_lvl1.7, t0_lvl0_6 )#5 xor2( s0_lvl1_7, w0.Adder1.csa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.6 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.7, sintcsa4x2_0_lvl1.7, t0_lvl0_6 )#5 and2( w2.Adder1.csa4x2_0_lvl1.7, w0.Adder1.csa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.6 )#5 or2( t0_lvl1_7, w1.Adder1.csa4x2_0_lvl1.7, w2.Adder1.csa4x2_0_lvl1.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.8, s0_lvl1_8,t0_lvl1_8,cout_csa4x2_0_lvl1.8,PP_4_8,PP_5_8,s0_lvl0_8,t0_lvl0_7,cout_csa4x2_0_lvl1.7) ; // adder1bit Adder0.csa4x2_0_lvl1.8( sintcsa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.8, PP_4_8, PP_5_8, s0_lvl0_8) // sum xor2( w0.Adder0.csa4x2_0_lvl1.8, PP_4_8, PP_5_8 )#5 xor2( sintcsa4x2_0_lvl1.8, w0.Adder0.csa4x2_0_lvl1.8, s0_lvl0_8 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.8, PP_4_8, PP_5_8 )#5 and2( w2.Adder0.csa4x2_0_lvl1.8, w0.Adder0.csa4x2_0_lvl1.8, s0_lvl0_8 )#5 or2( cout_csa4x2_0_lvl1.8, w1.Adder0.csa4x2_0_lvl1.8, w2.Adder0.csa4x2_0_lvl1.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.8( s0_lvl1_8, t0_lvl1_8, sintcsa4x2_0_lvl1.8, t0_lvl0_7, cout_csa4x2_0_lvl1.7) // sum xor2( w0.Adder1.csa4x2_0_lvl1.8, sintcsa4x2_0_lvl1.8, t0_lvl0_7 )#5 xor2( s0_lvl1_8, w0.Adder1.csa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.7 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.8, sintcsa4x2_0_lvl1.8, t0_lvl0_7 )#5 and2( w2.Adder1.csa4x2_0_lvl1.8, w0.Adder1.csa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.7 )#5 or2( t0_lvl1_8, w1.Adder1.csa4x2_0_lvl1.8, w2.Adder1.csa4x2_0_lvl1.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.9, s0_lvl1_9,t0_lvl1_9,cout_csa4x2_0_lvl1.9,PP_4_9,PP_5_9,s0_lvl0_9,t0_lvl0_8,cout_csa4x2_0_lvl1.8) ; // adder1bit Adder0.csa4x2_0_lvl1.9( sintcsa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.9, PP_4_9, PP_5_9, s0_lvl0_9) // sum xor2( w0.Adder0.csa4x2_0_lvl1.9, PP_4_9, PP_5_9 )#5 xor2( sintcsa4x2_0_lvl1.9, w0.Adder0.csa4x2_0_lvl1.9, s0_lvl0_9 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.9, PP_4_9, PP_5_9 )#5 and2( w2.Adder0.csa4x2_0_lvl1.9, w0.Adder0.csa4x2_0_lvl1.9, s0_lvl0_9 )#5 or2( cout_csa4x2_0_lvl1.9, w1.Adder0.csa4x2_0_lvl1.9, w2.Adder0.csa4x2_0_lvl1.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.9( s0_lvl1_9, t0_lvl1_9, sintcsa4x2_0_lvl1.9, t0_lvl0_8, cout_csa4x2_0_lvl1.8) // sum xor2( w0.Adder1.csa4x2_0_lvl1.9, sintcsa4x2_0_lvl1.9, t0_lvl0_8 )#5 xor2( s0_lvl1_9, w0.Adder1.csa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.8 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.9, sintcsa4x2_0_lvl1.9, t0_lvl0_8 )#5 and2( w2.Adder1.csa4x2_0_lvl1.9, w0.Adder1.csa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.8 )#5 or2( t0_lvl1_9, w1.Adder1.csa4x2_0_lvl1.9, w2.Adder1.csa4x2_0_lvl1.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.10, s0_lvl1_10,t0_lvl1_10,cout_csa4x2_0_lvl1.10,PP_4_10,PP_5_10,s0_lvl0_10,t0_lvl0_9,cout_csa4x2_0_lvl1.9) ; // adder1bit Adder0.csa4x2_0_lvl1.10( sintcsa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.10, PP_4_10, PP_5_10, s0_lvl0_10) // sum xor2( w0.Adder0.csa4x2_0_lvl1.10, PP_4_10, PP_5_10 )#5 xor2( sintcsa4x2_0_lvl1.10, w0.Adder0.csa4x2_0_lvl1.10, s0_lvl0_10 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.10, PP_4_10, PP_5_10 )#5 and2( w2.Adder0.csa4x2_0_lvl1.10, w0.Adder0.csa4x2_0_lvl1.10, s0_lvl0_10 )#5 or2( cout_csa4x2_0_lvl1.10, w1.Adder0.csa4x2_0_lvl1.10, w2.Adder0.csa4x2_0_lvl1.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.10( s0_lvl1_10, t0_lvl1_10, sintcsa4x2_0_lvl1.10, t0_lvl0_9, cout_csa4x2_0_lvl1.9) // sum xor2( w0.Adder1.csa4x2_0_lvl1.10, sintcsa4x2_0_lvl1.10, t0_lvl0_9 )#5 xor2( s0_lvl1_10, w0.Adder1.csa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.9 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.10, sintcsa4x2_0_lvl1.10, t0_lvl0_9 )#5 and2( w2.Adder1.csa4x2_0_lvl1.10, w0.Adder1.csa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.9 )#5 or2( t0_lvl1_10, w1.Adder1.csa4x2_0_lvl1.10, w2.Adder1.csa4x2_0_lvl1.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.11, s0_lvl1_11,t0_lvl1_11,cout_csa4x2_0_lvl1.11,PP_4_11,PP_5_11,s0_lvl0_11,t0_lvl0_10,cout_csa4x2_0_lvl1.10) ; // adder1bit Adder0.csa4x2_0_lvl1.11( sintcsa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.11, PP_4_11, PP_5_11, s0_lvl0_11) // sum xor2( w0.Adder0.csa4x2_0_lvl1.11, PP_4_11, PP_5_11 )#5 xor2( sintcsa4x2_0_lvl1.11, w0.Adder0.csa4x2_0_lvl1.11, s0_lvl0_11 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.11, PP_4_11, PP_5_11 )#5 and2( w2.Adder0.csa4x2_0_lvl1.11, w0.Adder0.csa4x2_0_lvl1.11, s0_lvl0_11 )#5 or2( cout_csa4x2_0_lvl1.11, w1.Adder0.csa4x2_0_lvl1.11, w2.Adder0.csa4x2_0_lvl1.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.11( s0_lvl1_11, t0_lvl1_11, sintcsa4x2_0_lvl1.11, t0_lvl0_10, cout_csa4x2_0_lvl1.10) // sum xor2( w0.Adder1.csa4x2_0_lvl1.11, sintcsa4x2_0_lvl1.11, t0_lvl0_10 )#5 xor2( s0_lvl1_11, w0.Adder1.csa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.10 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.11, sintcsa4x2_0_lvl1.11, t0_lvl0_10 )#5 and2( w2.Adder1.csa4x2_0_lvl1.11, w0.Adder1.csa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.10 )#5 or2( t0_lvl1_11, w1.Adder1.csa4x2_0_lvl1.11, w2.Adder1.csa4x2_0_lvl1.11 )#5 // end adder1bit // end csa4x2 end // genKoggeStoneVec(2*numBits, outVec, "cout", currRow->[0], currRow->[1], 'GND' ); netlist // PGgen (g0,p0,s0_lvl1_0,GND) xor2(p0,s0_lvl1_0,GND)#5 and2(g0,s0_lvl1_0,GND)#5 end netlist // PGgen (g1,p1,s0_lvl1_1,t0_lvl1_0) xor2(p1,s0_lvl1_1,t0_lvl1_0)#5 and2(g1,s0_lvl1_1,t0_lvl1_0)#5 end netlist // PGgen (g2,p2,s0_lvl1_2,t0_lvl1_1) xor2(p2,s0_lvl1_2,t0_lvl1_1)#5 and2(g2,s0_lvl1_2,t0_lvl1_1)#5 end netlist // PGgen (g3,p3,s0_lvl1_3,t0_lvl1_2) xor2(p3,s0_lvl1_3,t0_lvl1_2)#5 and2(g3,s0_lvl1_3,t0_lvl1_2)#5 end netlist // PGgen (g4,p4,s0_lvl1_4,t0_lvl1_3) xor2(p4,s0_lvl1_4,t0_lvl1_3)#5 and2(g4,s0_lvl1_4,t0_lvl1_3)#5 end netlist // PGgen (g5,p5,s0_lvl1_5,t0_lvl1_4) xor2(p5,s0_lvl1_5,t0_lvl1_4)#5 and2(g5,s0_lvl1_5,t0_lvl1_4)#5 end netlist // PGgen (g6,p6,s0_lvl1_6,t0_lvl1_5) xor2(p6,s0_lvl1_6,t0_lvl1_5)#5 and2(g6,s0_lvl1_6,t0_lvl1_5)#5 end netlist // PGgen (g7,p7,s0_lvl1_7,t0_lvl1_6) xor2(p7,s0_lvl1_7,t0_lvl1_6)#5 and2(g7,s0_lvl1_7,t0_lvl1_6)#5 end netlist // PGgen (g8,p8,s0_lvl1_8,t0_lvl1_7) xor2(p8,s0_lvl1_8,t0_lvl1_7)#5 and2(g8,s0_lvl1_8,t0_lvl1_7)#5 end netlist // PGgen (g9,p9,s0_lvl1_9,t0_lvl1_8) xor2(p9,s0_lvl1_9,t0_lvl1_8)#5 and2(g9,s0_lvl1_9,t0_lvl1_8)#5 end netlist // PGgen (g10,p10,s0_lvl1_10,t0_lvl1_9) xor2(p10,s0_lvl1_10,t0_lvl1_9)#5 and2(g10,s0_lvl1_10,t0_lvl1_9)#5 end netlist // PGgen (g11,p11,s0_lvl1_11,t0_lvl1_10) xor2(p11,s0_lvl1_11,t0_lvl1_10)#5 and2(g11,s0_lvl1_11,t0_lvl1_10)#5 end netlist // Gcombine (g_0_GND, g0, GND, p0 ) and2(w0g_0_GND, p0, GND )#5 or2( g_0_GND, w0g_0_GND, g0 )#5 end netlist // PGcombine (g_1_0,p_1_0,g1,p1,g0,p0) and2( w0g_1_0, p1, g0 )#5 or2( g_1_0, w0g_1_0, g1 )#5 and2( p_1_0, p1, p0)#5 end netlist // PGcombine (g_2_1,p_2_1,g2,p2,g1,p1) and2( w0g_2_1, p2, g1 )#5 or2( g_2_1, w0g_2_1, g2 )#5 and2( p_2_1, p2, p1)#5 end netlist // PGcombine (g_3_2,p_3_2,g3,p3,g2,p2) and2( w0g_3_2, p3, g2 )#5 or2( g_3_2, w0g_3_2, g3 )#5 and2( p_3_2, p3, p2)#5 end netlist // PGcombine (g_4_3,p_4_3,g4,p4,g3,p3) and2( w0g_4_3, p4, g3 )#5 or2( g_4_3, w0g_4_3, g4 )#5 and2( p_4_3, p4, p3)#5 end netlist // PGcombine (g_5_4,p_5_4,g5,p5,g4,p4) and2( w0g_5_4, p5, g4 )#5 or2( g_5_4, w0g_5_4, g5 )#5 and2( p_5_4, p5, p4)#5 end netlist // PGcombine (g_6_5,p_6_5,g6,p6,g5,p5) and2( w0g_6_5, p6, g5 )#5 or2( g_6_5, w0g_6_5, g6 )#5 and2( p_6_5, p6, p5)#5 end netlist // PGcombine (g_7_6,p_7_6,g7,p7,g6,p6) and2( w0g_7_6, p7, g6 )#5 or2( g_7_6, w0g_7_6, g7 )#5 and2( p_7_6, p7, p6)#5 end netlist // PGcombine (g_8_7,p_8_7,g8,p8,g7,p7) and2( w0g_8_7, p8, g7 )#5 or2( g_8_7, w0g_8_7, g8 )#5 and2( p_8_7, p8, p7)#5 end netlist // PGcombine (g_9_8,p_9_8,g9,p9,g8,p8) and2( w0g_9_8, p9, g8 )#5 or2( g_9_8, w0g_9_8, g9 )#5 and2( p_9_8, p9, p8)#5 end netlist // PGcombine (g_10_9,p_10_9,g10,p10,g9,p9) and2( w0g_10_9, p10, g9 )#5 or2( g_10_9, w0g_10_9, g10 )#5 and2( p_10_9, p10, p9)#5 end netlist // PGcombine (g_11_10,p_11_10,g11,p11,g10,p10) and2( w0g_11_10, p11, g10 )#5 or2( g_11_10, w0g_11_10, g11 )#5 and2( p_11_10, p11, p10)#5 end netlist // Gcombine (g_1_GND, g_1_0, GND, p_1_0 ) and2(w0g_1_GND, p_1_0, GND )#5 or2( g_1_GND, w0g_1_GND, g_1_0 )#5 end netlist // Gcombine (g_2_GND, g_2_1, g_0_GND, p_2_1 ) and2(w0g_2_GND, p_2_1, g_0_GND )#5 or2( g_2_GND, w0g_2_GND, g_2_1 )#5 end netlist // PGcombine (g_3_0,p_3_0,g_3_2,p_3_2,g_1_0,p_1_0) and2( w0g_3_0, p_3_2, g_1_0 )#5 or2( g_3_0, w0g_3_0, g_3_2 )#5 and2( p_3_0, p_3_2, p_1_0)#5 end netlist // PGcombine (g_4_1,p_4_1,g_4_3,p_4_3,g_2_1,p_2_1) and2( w0g_4_1, p_4_3, g_2_1 )#5 or2( g_4_1, w0g_4_1, g_4_3 )#5 and2( p_4_1, p_4_3, p_2_1)#5 end netlist // PGcombine (g_5_2,p_5_2,g_5_4,p_5_4,g_3_2,p_3_2) and2( w0g_5_2, p_5_4, g_3_2 )#5 or2( g_5_2, w0g_5_2, g_5_4 )#5 and2( p_5_2, p_5_4, p_3_2)#5 end netlist // PGcombine (g_6_3,p_6_3,g_6_5,p_6_5,g_4_3,p_4_3) and2( w0g_6_3, p_6_5, g_4_3 )#5 or2( g_6_3, w0g_6_3, g_6_5 )#5 and2( p_6_3, p_6_5, p_4_3)#5 end netlist // PGcombine (g_7_4,p_7_4,g_7_6,p_7_6,g_5_4,p_5_4) and2( w0g_7_4, p_7_6, g_5_4 )#5 or2( g_7_4, w0g_7_4, g_7_6 )#5 and2( p_7_4, p_7_6, p_5_4)#5 end netlist // PGcombine (g_8_5,p_8_5,g_8_7,p_8_7,g_6_5,p_6_5) and2( w0g_8_5, p_8_7, g_6_5 )#5 or2( g_8_5, w0g_8_5, g_8_7 )#5 and2( p_8_5, p_8_7, p_6_5)#5 end netlist // PGcombine (g_9_6,p_9_6,g_9_8,p_9_8,g_7_6,p_7_6) and2( w0g_9_6, p_9_8, g_7_6 )#5 or2( g_9_6, w0g_9_6, g_9_8 )#5 and2( p_9_6, p_9_8, p_7_6)#5 end netlist // PGcombine (g_10_7,p_10_7,g_10_9,p_10_9,g_8_7,p_8_7) and2( w0g_10_7, p_10_9, g_8_7 )#5 or2( g_10_7, w0g_10_7, g_10_9 )#5 and2( p_10_7, p_10_9, p_8_7)#5 end netlist // PGcombine (g_11_8,p_11_8,g_11_10,p_11_10,g_9_8,p_9_8) and2( w0g_11_8, p_11_10, g_9_8 )#5 or2( g_11_8, w0g_11_8, g_11_10 )#5 and2( p_11_8, p_11_10, p_9_8)#5 end netlist // Gcombine (g_3_GND, g_3_0, GND, p_3_0 ) and2(w0g_3_GND, p_3_0, GND )#5 or2( g_3_GND, w0g_3_GND, g_3_0 )#5 end netlist // Gcombine (g_4_GND, g_4_1, g_0_GND, p_4_1 ) and2(w0g_4_GND, p_4_1, g_0_GND )#5 or2( g_4_GND, w0g_4_GND, g_4_1 )#5 end netlist // Gcombine (g_5_GND, g_5_2, g_1_GND, p_5_2 ) and2(w0g_5_GND, p_5_2, g_1_GND )#5 or2( g_5_GND, w0g_5_GND, g_5_2 )#5 end netlist // Gcombine (g_6_GND, g_6_3, g_2_GND, p_6_3 ) and2(w0g_6_GND, p_6_3, g_2_GND )#5 or2( g_6_GND, w0g_6_GND, g_6_3 )#5 end netlist // PGcombine (g_7_0,p_7_0,g_7_4,p_7_4,g_3_0,p_3_0) and2( w0g_7_0, p_7_4, g_3_0 )#5 or2( g_7_0, w0g_7_0, g_7_4 )#5 and2( p_7_0, p_7_4, p_3_0)#5 end netlist // PGcombine (g_8_1,p_8_1,g_8_5,p_8_5,g_4_1,p_4_1) and2( w0g_8_1, p_8_5, g_4_1 )#5 or2( g_8_1, w0g_8_1, g_8_5 )#5 and2( p_8_1, p_8_5, p_4_1)#5 end netlist // PGcombine (g_9_2,p_9_2,g_9_6,p_9_6,g_5_2,p_5_2) and2( w0g_9_2, p_9_6, g_5_2 )#5 or2( g_9_2, w0g_9_2, g_9_6 )#5 and2( p_9_2, p_9_6, p_5_2)#5 end netlist // PGcombine (g_10_3,p_10_3,g_10_7,p_10_7,g_6_3,p_6_3) and2( w0g_10_3, p_10_7, g_6_3 )#5 or2( g_10_3, w0g_10_3, g_10_7 )#5 and2( p_10_3, p_10_7, p_6_3)#5 end netlist // PGcombine (g_11_4,p_11_4,g_11_8,p_11_8,g_7_4,p_7_4) and2( w0g_11_4, p_11_8, g_7_4 )#5 or2( g_11_4, w0g_11_4, g_11_8 )#5 and2( p_11_4, p_11_8, p_7_4)#5 end netlist // Gcombine (g_7_GND, g_7_0, GND, p_7_0 ) and2(w0g_7_GND, p_7_0, GND )#5 or2( g_7_GND, w0g_7_GND, g_7_0 )#5 end netlist // Gcombine (g_8_GND, g_8_1, g_0_GND, p_8_1 ) and2(w0g_8_GND, p_8_1, g_0_GND )#5 or2( g_8_GND, w0g_8_GND, g_8_1 )#5 end netlist // Gcombine (g_9_GND, g_9_2, g_1_GND, p_9_2 ) and2(w0g_9_GND, p_9_2, g_1_GND )#5 or2( g_9_GND, w0g_9_GND, g_9_2 )#5 end netlist // Gcombine (g_10_GND, g_10_3, g_2_GND, p_10_3 ) and2(w0g_10_GND, p_10_3, g_2_GND )#5 or2( g_10_GND, w0g_10_GND, g_10_3 )#5 end netlist // Gcombine (cout, g_11_4, g_3_GND, p_11_4 ) and2(w0cout, p_11_4, g_3_GND )#5 or2( cout, w0cout, g_11_4 )#5 end netlist xor2( m0, p0,GND )#5 xor2( m1, p1,g_0_GND )#5 xor2( m2, p2,g_1_GND )#5 xor2( m3, p3,g_2_GND )#5 xor2( m4, p4,g_3_GND )#5 xor2( m5, p5,g_4_GND )#5 xor2( m6, p6,g_5_GND )#5 xor2( m7, p7,g_6_GND )#5 xor2( m8, p8,g_7_GND )#5 xor2( m9, p9,g_8_GND )#5 xor2( m10, p10,g_9_GND )#5 xor2( m11, p11,g_10_GND )#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/koggeStone64bit.net
finish 100000 inputs cin, a0, a1, a2, a3, a4, a5, a6, a7, a8, a9, a10, a11, a12, a13, a14, a15, a16, a17, a18, a19, a20, a21, a22, a23, a24, a25, a26, a27, a28, a29, a30, a31, a32, a33, a34, a35, a36, a37, a38, a39, a40, a41, a42, a43, a44, a45, a46, a47, a48, a49, a50, a51, a52, a53, a54, a55, a56, a57, a58, a59, a60, a61, a62, a63, b0, b1, b2, b3, b4, b5, b6, b7, b8, b9, b10, b11, b12, b13, b14, b15, b16, b17, b18, b19, b20, b21, b22, b23, b24, b25, b26, b27, b28, b29, b30, b31, b32, b33, b34, b35, b36, b37, b38, b39, b40, b41, b42, b43, b44, b45, b46, b47, b48, b49, b50, b51, b52, b53, b54, b55, b56, b57, b58, b59, b60, b61, b62, b63 end outputs cout, s0, s1, s2, s3, s4, s5, s6, s7, s8, s9, s10, s11, s12, s13, s14, s15, s16, s17, s18, s19, s20, s21, s22, s23, s24, s25, s26, s27, s28, s29, s30, s31, s32, s33, s34, s35, s36, s37, s38, s39, s40, s41, s42, s43, s44, s45, s46, s47, s48, s49, s50, s51, s52, s53, s54, s55, s56, s57, s58, s59, s60, s61, s62, s63 end initlist a0 0,0 26,1 74,0 156,1 224,0 234,1 318,0 406,1 505,0 605,1 616,0 680,1 739,0 809,1 898,0 992,1 1067,0 1133,1 1184,0 1239,1 1283,0 1325,1 1372,0 1394,1 1395,0 1474,1 1556,0 1586,1 1594,0 1641,1 1697,0 1782,1 1849,0 1936,1 1994,0 2085,1 2171,0 2192,1 2218,0 2317,1 2410,0 2496,1 2564,0 2648,1 2740,0 2801,1 2855,0 2954,1 2977,0 3000,1 3053,0 3067,1 3163,0 3165,1 3173,0 3264,1 3274,0 3301,1 3380,0 3421,1 3451,0 3523,1 3600,0 3689,1 3696,0 3704,1 3791,0 3871,1 3971,0 4006,1 4018,0 4081,1 4131,0 4188,1 4223,0 4227,1 4319,0 4386,1 4420,0 4456,1 4470,0 4563,1 4574,0 4576,1 4605,0 4694,1 4703,0 4783,1 4789,0 4800,1 4879,0 4918,1 5012,0 5077,1 5105,0 5192,1 5257,0 5322,1 5329,0 5392,1 5479,0 5512,1 5577,0 5635,1 5669,0 5679,1 5718,0 5749,1 5789,0 5815,1 5842,0 5929,1 5980,0 6057,1 6066,0 6121,1 6216,0 6288,1 6354,0 6390,1 6441,0 6489,1 6552,0 6562,1 6568,0 6574,1 6598,0 6643,1 6673,0 6700,1 6781,0 6814,1 6914,0 6995,1 7028,0 7104,1 7173,0 7216,1 7287,0 7385,1 7484,0 7553,1 7639,0 7731,1 7741,0 7814,1 7819,0 7887,1 7895,0 7963,1 8012,0 8020,1 8023,0 8117,1 8143,0 8167,1 8181,0 8228,1 8261,0 8296,1 8348,0 8398,1 8470,0 8487,1 8556,0 8595,1 8619,0 8701,1 8724,0 8726,1 8728,0 8821,1 8894,0 8989,1 8993,0 9089,1 9176,0 9204,1 9291,0 9357,1 9367,0 9450,1 9462,0 9560,1 9588,0 9612,1 9704,0 9717,1 9750,0 9848,1 9851,0 9863,1 9895,0 9941,1 9988,0 10001,1 10032,0 10110,1 10139,0 10160,1 10225,0 10300,1 10309,0 10339,1 10431,0 10451,1 10464,0 10482,1 10520,0 10606,1 10638,0 10713,1 10789,0 10867,1 10901,0 11001,1 11023,0 11121,1 11171,0 11271,1 11294,0 11295,1 11335,0 11376,1 11401,0 11483,1 11503,0 11565,1 11609,0 11669,1 11764,0 11817,1 11882,0 11953,1 11993,0 12008,1 12019,0 12065,1 12096,0 12191,1 12255,0 12348,1 12385,0 12429,1 12465,0 12480,1 12507,0 12589,1 12687,0 12706,1 12774,0 12834,1 12930,0 12985,1 13034,0 13055,1 13082,0 13136,1 13213,0 13304,1 13321,0 13343,1 13433,0 13470,1 13544,0 13584,1 13671,0 13725,1 13752,0 13850,1 13876,0 13926,1 13930,0 13938,1 14001,0 14083,1 14129,0 14174,1 14246,0 14287,1 14363,0 14439,1 14476,0 14511,1 14589,0 14619,1 14638,0 14695,1 14768,0 14852,1 14897,0 14994,1 15022,0 15045,1 15055,0 15087,1 15130,0 15213,1 15224,0 15274,1 15374,0 15462,1 15492,0 15527,1 15587,0 15642,1 15677,0 15722,1 15779,0 15850,1 15863,0 15870,1 15903,0 15986,1 16068,0 16151,1 16242,0 16279,1 16362,0 16393,1 16411,0 16415,1 16458,0 16556,1 16628,0 16717,1 16803,0 16860,1 16880,0 16978,1 17032,0 17078,1 17093,0 17134,1 17192,0 17285,1 17319,0 17406,1 17465,0 17487,1 17533,0 17584,1 17666,0 17694,1 17768,0 17867,1 17870,0 17948,1 17953,0 18035,1 18051,0 18080,1 18108,0 18165,1 18246,0 18274,1 18352,0 18384,1 18411,0 18473,1 18563,0 18586,1 18608,0 18669,1 18698,0 18747,1 18836,0 18934,1 18935,0 19032,1 19039,0 19129,1 19176,0 19257,1 19340,0 19427,1 19472,0 19519,1 19613,0 19649,1 19749,0 19824,1 19828,0 19880,1 19935,0 20014,1 20044,0 20046,1 20110,0 20172,1 20235,0 20300,1 20396,0 20404,1 20453,0 20522,1 20585,0 20677,1 20731,0 20749,1 20836,0 20868,1 20870,0 20931,1 20962,0 20969,1 21069,0 21086,1 21156,0 21169,1 21249,0 21261,1 21357,0 21387,1 21447,0 21538,1 21566,0 21575,1 21626,0 21640,1 21708,0 21773,1 21806,0 21899,1 21990,0 22078,1 22102,0 22166,1 22253,0 22335,1 22407,0 22462,1 22550,0 22610,1 22691,0 22782,1 22882,0 22913,1 22988,0 23028,1 23071,0 23116,1 23152,0 23157,1 23158,0 23170,1 23173,0 23264,1 23280,0 23354,1 23444,0 23462,1 23562,0 23653,1 23714,0 23805,1 23886,0 23969,1 23981,0 24058,1 24095,0 24170,1 24172,0 24272,1 24366,0 24401,1 24460,0 24551,1 24574,0 24609,1 24611,0 24708,1 24733,0 24760,1 24791,0 24828,1 24853,0 24932,1 25022,0 25091,1 25109,0 25110,1 25140,0 25174,1 25260,0 25353,1 25435,0 25473,1 25474,0 25573,1 25604,0 25685,1 25721,0 25727,1 25775,0 25844,1 25893,0 25912,1 25974,0 26070,1 26154,0 26162,1 26252,0 26271,1 26284,0 26345,1 26385,0 26435,1 26437,0 26507,1 26514,0 26544,1 26561,0 26572,1 26593,0 26632,1 26662,0 26740,1 26798,0 26823,1 26895,0 26958,1 26978,0 27014,1 27059,0 27150,1 27223,0 27288,1 27310,0 27318,1 27388,0 27425,1 27504,0 27589,1 27641,0 27720,1 27722,0 27739,1 27832,0 27899,1 27991,0 28082,1 28094,0 28120,1 28187,0 28214,1 28258,0 28342,1 28400,0 28421,1 28466,0 28513,1 28612,0 28658,1 28726,0 28757,1 28768,0 28828,1 28890,0 28895,1 28908,0 29003,1 29029,0 29099,1 29117,0 29201,1 29255,0 29331,1 29355,0 29453,1 29540,0 29613,1 29702,0 29745,1 29790,0 29814,1 29856,0 29932,1 30008,0 30101,1 30189,0 30268,1 30309,0 30362,1 30410,0 30437,1 30477,0 30545,1 30599,0 30642,1 30643,0 30720,1 30785,0 30843,1 30900,0 30904,1 30984,0 31055,1 31142,0 31163,1 31245,0 31309,1 31347,0 31410,1 31505,0 31550,1 31625,0 31639,1 31655,0 31660,1 31740,0 31834,1 31922,0 31988,1 32085,0 32094,1 32154,0 32203,1 32248,0 32284,1 32329,0 32425,1 32434,0 32508,1 32525,0 32605,1 32657,0 32750,1 32824,0 32833,1 32842,0 32881,1 32936,0 33015,1 33104,0 33112,1 33128,0 33139,1 33175,0 33198,1 33203,0 33284,1 33376,0 33400,1 33446,0 33486,1 33586,0 33609,1 33661,0 33671,1 33689,0 33716,1 33741,0 33824,1 33900,0 33941,1 33998,0 34077,1 34141,0 34170,1 34219,0 34258,1 34265,0 34339,1 34344,0 34356,1 34422,0 34508,1 34528,0 34539,1 34616,0 34684,1 34730,0 34743,1 34780,0 34853,1 34890,0 34935,1 34957,0 35037,1 35087,0 35137,1 35182,0 35236,1 35253,0 35338,1 35392,0 35398,1 35424,0 35519,1 35584,0 35671,1 35681,0 35726,1 35750,0 35773,1 35824,0 35889,1 35976,0 36013,1 36021,0 36107,1 36119,0 36142,1 36172,0 36225,1 36270,0 36369,1 36372,0 36429,1 36476,0 36514,1 36520,0 36585,1 36671,0 36766,1 36842,0 36926,1 36992,0 37022,1 37032,0 37100,1 37117,0 37195,1 37284,0 37336,1 37346,0 37399,1 37441,0 37492,1 37510,0 37586,1 37646,0 37702,1 37793,0 37807,1 37881,0 37908,1 37998,0 38077,1 38097,0 38195,1 38244,0 38281,1 38336,0 38365,1 38420,0 38466,1 38498,0 38552,1 38611,0 38646,1 38736,0 38811,1 38822,0 38884,1 38900,0 38911,1 38946,0 39010,1 39014,0 39016,1 39099,0 39131,1 39220,0 39295,1 39350,0 39388,1 39445,0 39485,1 39516,0 39556,1 39647,0 39698,1 39761,0 39828,1 39875,0 39910,1 40004,0 40008,1 40080,0 40121,1 40191,0 40237,1 40317,0 40387,1 40398,0 40453,1 40502,0 40508,1 40543,0 40572,1 40654,0 40681,1 40699,0 40751,1 40814,0 40891,1 40914,0 40919,1 40996,0 41001,1 41083,0 41096,1 41116,0 41150,1 41151,0 41201,1 41228,0 41272,1 41277,0 41329,1 41347,0 41393,1 41443,0 41464,1 41483,0 41553,1 41615,0 41715,1 41815,0 41877,1 41884,0 41960,1 42015,0 42111,1 42198,0 42218,1 42263,0 42338,1 42401,0 42403,1 42486,0 42542,1 42614,0 42693,1 42704,0 42787,1 42850,0 42933,1 43018,0 43077,1 43148,0 43231,1 43267,0 43359,1 43446,0 43540,1 43595,0 43642,1 43662,0 43702,1 43721,0 43789,1 43834,0 43887,1 43939,0 44017,1 44052,0 44098,1 44194,0 44244,1 44333,0 44418,1 44449,0 44531,1 44576,0 44612,1 44658,0 44755,1 44841,0 44929,1 44984,0 45080,1 45122,0 45132,1 45181,0 45186,1 45282,0 45376,1 45459,0 45535,1 45568,0 45615,1 45699,0 45792,1 45816,0 45851,1 45880,0 45884,1 45885,0 45959,1 46058,0 46146,1 46192,0 46281,1 46290,0 46330,1 46376,0 46421,1 46515,0 46598,1 46695,0 46727,1 46816,0 46913,1 46921,0 46954,1 47037,0 47104,1 47115,0 47207,1 47277,0 47348,1 47388,0 47441,1 47479,0 47517,1 47539,0 47544,1 47603,0 47690,1 47765,0 47818,1 47860,0 47873,1 47892,0 47963,1 48049,0 48145,1 48188,0 48204,1 48300,0 48367,1 48466,0 48513,1 48581,0 48601,1 48630,0 48713,1 48714,0 48805,1 48832,0 48850,1 48891,0 48984,1 49019,0 49061,1 49098,0 49158,1 49258,0 49346,1 49428,0 49488,1 49503,0 49533,1 49556,0 49619,1 49654,0 49718,1 49749,0 49790,1 49833,0 49897,1 49978,0 49986,1 50049,0 50071,1 50073,0 50158,1 50223,0 50244,1 50333,0 50395,1 50456,0 50556,1 50602,0 50644,1 50686,0 50726,1 50769,0 50810,1 50909,0 50965,1 51023,0 51098,1 51195,0 51205,1 51223,0 51291,1 51376,0 51447,1 51507,0 51543,1 51580,0 51677,1 51734,0 51808,1 51863,0 51961,1 52018,0 52115,1 end initlist a1 0,0 58,1 80,0 101,1 110,0 170,1 255,0 346,1 355,0 405,1 473,0 501,1 535,0 555,1 638,0 726,1 747,0 786,1 815,0 880,1 944,0 978,1 1038,0 1084,1 1117,0 1161,1 1254,0 1291,1 1314,0 1373,1 1406,0 1481,1 1494,0 1502,1 1506,0 1580,1 1614,0 1636,1 1709,0 1762,1 1793,0 1859,1 1949,0 1977,1 2017,0 2021,1 2094,0 2135,1 2137,0 2187,1 2189,0 2205,1 2218,0 2276,1 2289,0 2349,1 2370,0 2451,1 2544,0 2575,1 2622,0 2669,1 2736,0 2758,1 2857,0 2863,1 2915,0 2946,1 3021,0 3089,1 3123,0 3172,1 3269,0 3297,1 3324,0 3325,1 3402,0 3404,1 3437,0 3477,1 3512,0 3565,1 3645,0 3651,1 3712,0 3786,1 3854,0 3936,1 3989,0 4019,1 4101,0 4185,1 4199,0 4243,1 4303,0 4329,1 4356,0 4420,1 4498,0 4517,1 4545,0 4569,1 4613,0 4614,1 4665,0 4695,1 4764,0 4803,1 4876,0 4918,1 4951,0 5009,1 5014,0 5053,1 5139,0 5218,1 5313,0 5397,1 5409,0 5437,1 5532,0 5570,1 5573,0 5648,1 5730,0 5758,1 5793,0 5840,1 5894,0 5993,1 6074,0 6124,1 6223,0 6282,1 6375,0 6422,1 6476,0 6489,1 6530,0 6612,1 6657,0 6742,1 6836,0 6916,1 6958,0 7044,1 7099,0 7143,1 7189,0 7205,1 7277,0 7337,1 7396,0 7405,1 7451,0 7511,1 7523,0 7562,1 7642,0 7671,1 7727,0 7736,1 7782,0 7878,1 7900,0 7932,1 7958,0 8010,1 8057,0 8123,1 8207,0 8295,1 8312,0 8401,1 8474,0 8533,1 8590,0 8607,1 8659,0 8744,1 8832,0 8921,1 8977,0 8985,1 9038,0 9064,1 9128,0 9206,1 9246,0 9263,1 9331,0 9428,1 9460,0 9471,1 9505,0 9554,1 9650,0 9740,1 9786,0 9848,1 9904,0 9995,1 10071,0 10075,1 10085,0 10130,1 10206,0 10261,1 10356,0 10374,1 10376,0 10473,1 10551,0 10612,1 10702,0 10775,1 10796,0 10868,1 10948,0 10951,1 11010,0 11056,1 11091,0 11114,1 11181,0 11252,1 11271,0 11310,1 11311,0 11387,1 11434,0 11495,1 11512,0 11595,1 11667,0 11760,1 11838,0 11866,1 11926,0 11985,1 12036,0 12132,1 12224,0 12300,1 12301,0 12310,1 12322,0 12367,1 12461,0 12543,1 12556,0 12612,1 12673,0 12706,1 12773,0 12817,1 12882,0 12968,1 12982,0 13003,1 13026,0 13124,1 13149,0 13217,1 13251,0 13318,1 13410,0 13473,1 13489,0 13517,1 13591,0 13688,1 13691,0 13696,1 13782,0 13820,1 13868,0 13960,1 14011,0 14109,1 14141,0 14220,1 14308,0 14369,1 14453,0 14542,1 14595,0 14645,1 14685,0 14755,1 14793,0 14819,1 14878,0 14973,1 14974,0 15014,1 15069,0 15124,1 15138,0 15185,1 15191,0 15279,1 15362,0 15393,1 15400,0 15493,1 15504,0 15598,1 15601,0 15644,1 15714,0 15719,1 15808,0 15866,1 15948,0 16021,1 16037,0 16086,1 16130,0 16145,1 16229,0 16312,1 16397,0 16480,1 16518,0 16585,1 16615,0 16627,1 16713,0 16774,1 16797,0 16890,1 16941,0 16961,1 16991,0 17017,1 17023,0 17059,1 17118,0 17165,1 17232,0 17275,1 17369,0 17394,1 17441,0 17495,1 17533,0 17562,1 17576,0 17663,1 17745,0 17758,1 17834,0 17905,1 17925,0 18021,1 18036,0 18047,1 18074,0 18120,1 18139,0 18169,1 18238,0 18241,1 18272,0 18303,1 18384,0 18409,1 18418,0 18505,1 18560,0 18614,1 18695,0 18725,1 18823,0 18841,1 18930,0 18970,1 18991,0 19082,1 19155,0 19233,1 19261,0 19324,1 19410,0 19456,1 19541,0 19543,1 19629,0 19637,1 19707,0 19723,1 19726,0 19759,1 19831,0 19905,1 19957,0 19986,1 19999,0 20081,1 20153,0 20160,1 20206,0 20303,1 20395,0 20483,1 20572,0 20591,1 20631,0 20657,1 20703,0 20706,1 20713,0 20762,1 20823,0 20888,1 20904,0 20976,1 21007,0 21088,1 21156,0 21181,1 21202,0 21299,1 21322,0 21391,1 21432,0 21529,1 21555,0 21598,1 21680,0 21688,1 21749,0 21765,1 21824,0 21859,1 21877,0 21937,1 21971,0 22022,1 22064,0 22151,1 22190,0 22230,1 22321,0 22399,1 22486,0 22554,1 22579,0 22581,1 22639,0 22683,1 22692,0 22760,1 22791,0 22792,1 22820,0 22854,1 22893,0 22949,1 22979,0 22984,1 23014,0 23090,1 23104,0 23128,1 23194,0 23250,1 23308,0 23366,1 23457,0 23555,1 23653,0 23733,1 23814,0 23884,1 23890,0 23979,1 23982,0 24002,1 24004,0 24015,1 24099,0 24172,1 24235,0 24277,1 24336,0 24344,1 24403,0 24409,1 24473,0 24555,1 24556,0 24624,1 24702,0 24736,1 24812,0 24899,1 24932,0 24936,1 25032,0 25124,1 25216,0 25220,1 25269,0 25271,1 25346,0 25360,1 25405,0 25490,1 25573,0 25633,1 25658,0 25741,1 25756,0 25804,1 25889,0 25959,1 26029,0 26073,1 26109,0 26190,1 26263,0 26275,1 26294,0 26367,1 26423,0 26499,1 26542,0 26574,1 26643,0 26663,1 26716,0 26802,1 26813,0 26858,1 26885,0 26921,1 27021,0 27035,1 27062,0 27140,1 27153,0 27239,1 27293,0 27391,1 27450,0 27462,1 27560,0 27578,1 27633,0 27692,1 27730,0 27767,1 27785,0 27883,1 27894,0 27947,1 27966,0 27998,1 28077,0 28096,1 28156,0 28208,1 28237,0 28257,1 28259,0 28284,1 28317,0 28343,1 28433,0 28528,1 28594,0 28661,1 28710,0 28777,1 28800,0 28869,1 28890,0 28921,1 29005,0 29078,1 29107,0 29158,1 29199,0 29249,1 29291,0 29312,1 29367,0 29464,1 29560,0 29565,1 29600,0 29666,1 29671,0 29744,1 29748,0 29815,1 29829,0 29868,1 29962,0 30019,1 30118,0 30168,1 30227,0 30233,1 30261,0 30291,1 30357,0 30435,1 30489,0 30583,1 30623,0 30656,1 30699,0 30781,1 30839,0 30869,1 30934,0 30995,1 31094,0 31123,1 31156,0 31184,1 31229,0 31238,1 31266,0 31337,1 31351,0 31394,1 31466,0 31529,1 31573,0 31626,1 31714,0 31715,1 31728,0 31740,1 31832,0 31921,1 31954,0 32018,1 32116,0 32121,1 32178,0 32229,1 32311,0 32367,1 32392,0 32403,1 32445,0 32511,1 32589,0 32660,1 32724,0 32799,1 32828,0 32857,1 32868,0 32928,1 33025,0 33080,1 33125,0 33139,1 33226,0 33306,1 33307,0 33396,1 33399,0 33480,1 33559,0 33618,1 33661,0 33671,1 33727,0 33740,1 33815,0 33901,1 33979,0 34054,1 34152,0 34216,1 34228,0 34306,1 34362,0 34370,1 34444,0 34529,1 34587,0 34602,1 34684,0 34727,1 34738,0 34809,1 34880,0 34914,1 34994,0 35069,1 35131,0 35183,1 35252,0 35282,1 35298,0 35395,1 35430,0 35515,1 35584,0 35620,1 35666,0 35677,1 35777,0 35834,1 35929,0 35995,1 36009,0 36072,1 36126,0 36158,1 36253,0 36294,1 36341,0 36433,1 36468,0 36471,1 36489,0 36566,1 36641,0 36682,1 36684,0 36753,1 36813,0 36828,1 36857,0 36906,1 36989,0 37026,1 37073,0 37151,1 37186,0 37209,1 37291,0 37315,1 37385,0 37427,1 37467,0 37554,1 37653,0 37744,1 37756,0 37764,1 37856,0 37925,1 38018,0 38099,1 38102,0 38160,1 38209,0 38268,1 38310,0 38324,1 38362,0 38411,1 38469,0 38543,1 38600,0 38687,1 38766,0 38821,1 38914,0 39004,1 39016,0 39028,1 39044,0 39067,1 39113,0 39168,1 39232,0 39265,1 39365,0 39385,1 39416,0 39512,1 39591,0 39673,1 39718,0 39746,1 39813,0 39839,1 39861,0 39936,1 40016,0 40052,1 40107,0 40207,1 40297,0 40396,1 40450,0 40487,1 40545,0 40563,1 40640,0 40664,1 40736,0 40759,1 40791,0 40873,1 40910,0 40966,1 40971,0 40979,1 40991,0 41029,1 41081,0 41089,1 41117,0 41163,1 41189,0 41257,1 41268,0 41330,1 41384,0 41438,1 41479,0 41546,1 41636,0 41729,1 41804,0 41822,1 41914,0 41977,1 42044,0 42115,1 42209,0 42232,1 42277,0 42325,1 42348,0 42432,1 42520,0 42562,1 42620,0 42657,1 42675,0 42680,1 42693,0 42715,1 42729,0 42730,1 42809,0 42865,1 42879,0 42890,1 42910,0 42984,1 43019,0 43111,1 43134,0 43193,1 43219,0 43251,1 43305,0 43327,1 43385,0 43390,1 43464,0 43474,1 43476,0 43549,1 43559,0 43621,1 43708,0 43758,1 43787,0 43789,1 43813,0 43861,1 43909,0 43931,1 43968,0 44060,1 44130,0 44155,1 44250,0 44273,1 44277,0 44356,1 44450,0 44533,1 44611,0 44710,1 44789,0 44795,1 44839,0 44870,1 44966,0 45033,1 45046,0 45127,1 45165,0 45171,1 45263,0 45362,1 45410,0 45507,1 45550,0 45591,1 45648,0 45708,1 45768,0 45772,1 45866,0 45926,1 45933,0 45957,1 46043,0 46129,1 46229,0 46299,1 46338,0 46378,1 46477,0 46559,1 46564,0 46651,1 46745,0 46772,1 46815,0 46856,1 46902,0 46998,1 47087,0 47115,1 47175,0 47202,1 47222,0 47251,1 47302,0 47358,1 47411,0 47466,1 47498,0 47598,1 47626,0 47669,1 47699,0 47774,1 47840,0 47865,1 47872,0 47905,1 47992,0 48044,1 48091,0 48173,1 48226,0 48231,1 48269,0 48338,1 48379,0 48460,1 48464,0 48480,1 48528,0 48578,1 48611,0 48706,1 48771,0 48782,1 48870,0 48962,1 48974,0 48995,1 49013,0 49091,1 49108,0 49142,1 49147,0 49158,1 49172,0 49193,1 49261,0 49310,1 49377,0 49406,1 49492,0 49495,1 49567,0 49665,1 49752,0 49792,1 49858,0 49872,1 49892,0 49943,1 49965,0 49968,1 50033,0 50060,1 50123,0 50136,1 50171,0 50192,1 end initlist a2 0,0 52,1 88,0 163,1 215,0 259,1 314,0 405,1 439,0 472,1 560,0 568,1 594,0 669,1 728,0 813,1 855,0 916,1 938,0 1008,1 1096,0 1183,1 1271,0 1285,1 1334,0 1411,1 1432,0 1506,1 1560,0 1650,1 1695,0 1732,1 1826,0 1850,1 1926,0 1993,1 2059,0 2074,1 2161,0 2179,1 2232,0 2321,1 2392,0 2407,1 2436,0 2475,1 2509,0 2515,1 2553,0 2561,1 2638,0 2713,1 2774,0 2862,1 2961,0 2986,1 3075,0 3111,1 3173,0 3213,1 3255,0 3274,1 3369,0 3381,1 3386,0 3410,1 3493,0 3503,1 3603,0 3653,1 3657,0 3684,1 3729,0 3742,1 3752,0 3769,1 3795,0 3816,1 3820,0 3827,1 3889,0 3934,1 3961,0 4017,1 4108,0 4113,1 4165,0 4192,1 4217,0 4275,1 4306,0 4329,1 4405,0 4505,1 4506,0 4530,1 4543,0 4609,1 4649,0 4747,1 4785,0 4802,1 4883,0 4913,1 5007,0 5038,1 5060,0 5067,1 5092,0 5117,1 5209,0 5246,1 5336,0 5430,1 5469,0 5508,1 5575,0 5592,1 5607,0 5696,1 5723,0 5787,1 5814,0 5870,1 5930,0 5984,1 6019,0 6068,1 6153,0 6210,1 6299,0 6361,1 6419,0 6475,1 6571,0 6601,1 6651,0 6703,1 6742,0 6804,1 6845,0 6899,1 6947,0 6992,1 7014,0 7056,1 7057,0 7156,1 7210,0 7266,1 7361,0 7384,1 7461,0 7524,1 7620,0 7672,1 7733,0 7782,1 7807,0 7904,1 7998,0 8031,1 8093,0 8107,1 8205,0 8234,1 8238,0 8298,1 8366,0 8445,1 8523,0 8529,1 8570,0 8631,1 8687,0 8763,1 8843,0 8932,1 9004,0 9033,1 9043,0 9115,1 9127,0 9196,1 9260,0 9265,1 9282,0 9370,1 9441,0 9537,1 9611,0 9650,1 9689,0 9778,1 9840,0 9860,1 9886,0 9951,1 9964,0 10041,1 10115,0 10200,1 10263,0 10334,1 10359,0 10417,1 10498,0 10581,1 10629,0 10663,1 10670,0 10754,1 10790,0 10806,1 10904,0 10979,1 11004,0 11045,1 11126,0 11134,1 11153,0 11177,1 11211,0 11289,1 11305,0 11381,1 11429,0 11488,1 11586,0 11627,1 11652,0 11736,1 11834,0 11842,1 11911,0 11917,1 12004,0 12011,1 12089,0 12117,1 12118,0 12153,1 12167,0 12189,1 12225,0 12300,1 12384,0 12391,1 12487,0 12508,1 12520,0 12612,1 12704,0 12773,1 12843,0 12870,1 12883,0 12978,1 13051,0 13070,1 13090,0 13132,1 13214,0 13219,1 13262,0 13273,1 13304,0 13379,1 13385,0 13468,1 13492,0 13591,1 13663,0 13670,1 13755,0 13758,1 13764,0 13794,1 13819,0 13879,1 13978,0 14055,1 14132,0 14184,1 14195,0 14243,1 14314,0 14356,1 14418,0 14466,1 14488,0 14554,1 14636,0 14702,1 14777,0 14859,1 14881,0 14946,1 15020,0 15026,1 15046,0 15059,1 15082,0 15096,1 15097,0 15188,1 15251,0 15256,1 15285,0 15349,1 15351,0 15352,1 15398,0 15462,1 15501,0 15597,1 15611,0 15659,1 15724,0 15770,1 15775,0 15875,1 15888,0 15946,1 15967,0 15976,1 16038,0 16068,1 16092,0 16188,1 16286,0 16323,1 16359,0 16440,1 16478,0 16521,1 16552,0 16610,1 16688,0 16779,1 16784,0 16873,1 16942,0 16943,1 17023,0 17098,1 17197,0 17211,1 17311,0 17404,1 17479,0 17501,1 17524,0 17606,1 17700,0 17733,1 17772,0 17863,1 17910,0 17921,1 17973,0 18017,1 18105,0 18203,1 18213,0 18236,1 18328,0 18340,1 18426,0 18517,1 18534,0 18618,1 18700,0 18732,1 18808,0 18822,1 18845,0 18863,1 18947,0 18978,1 19052,0 19089,1 19163,0 19252,1 19330,0 19347,1 19439,0 19476,1 19529,0 19596,1 19662,0 19735,1 19824,0 19828,1 19918,0 19924,1 19999,0 20068,1 20151,0 20186,1 20271,0 20272,1 20347,0 20352,1 20378,0 20408,1 20439,0 20472,1 20548,0 20617,1 20633,0 20717,1 20764,0 20787,1 20875,0 20920,1 20938,0 21026,1 21099,0 21128,1 21130,0 21198,1 21232,0 21330,1 21372,0 21442,1 21538,0 21623,1 21656,0 21751,1 21840,0 21858,1 21910,0 21930,1 21956,0 21970,1 22059,0 22150,1 22193,0 22293,1 22303,0 22380,1 22413,0 22484,1 22537,0 22612,1 22708,0 22710,1 22805,0 22818,1 22866,0 22888,1 22972,0 23014,1 23017,0 23038,1 23043,0 23095,1 23098,0 23198,1 23292,0 23303,1 23380,0 23472,1 23528,0 23551,1 23636,0 23649,1 23670,0 23734,1 23744,0 23835,1 23853,0 23912,1 24007,0 24024,1 24034,0 24094,1 24173,0 24255,1 24301,0 24382,1 24470,0 24483,1 24537,0 24553,1 24629,0 24691,1 24791,0 24808,1 24889,0 24912,1 24998,0 25053,1 25152,0 25182,1 25224,0 25255,1 25339,0 25396,1 25465,0 25530,1 25606,0 25661,1 25724,0 25760,1 25791,0 25805,1 25905,0 25973,1 26032,0 26035,1 26119,0 26208,1 26299,0 26332,1 26379,0 26435,1 26475,0 26491,1 26539,0 26623,1 26639,0 26644,1 26647,0 26682,1 26781,0 26858,1 26957,0 27002,1 27038,0 27056,1 27089,0 27118,1 27154,0 27182,1 27259,0 27326,1 27406,0 27482,1 27572,0 27652,1 27749,0 27780,1 27839,0 27872,1 27919,0 28011,1 28079,0 28135,1 28179,0 28245,1 28253,0 28303,1 28360,0 28448,1 28477,0 28544,1 28642,0 28709,1 28731,0 28795,1 28825,0 28890,1 28894,0 28896,1 28916,0 29013,1 29069,0 29087,1 29157,0 29232,1 29310,0 29353,1 29431,0 29454,1 29476,0 29480,1 29548,0 29603,1 29702,0 29722,1 29724,0 29781,1 29827,0 29903,1 29944,0 29954,1 29957,0 30023,1 30026,0 30096,1 30192,0 30213,1 30306,0 30405,1 30460,0 30526,1 30537,0 30589,1 30604,0 30633,1 30724,0 30809,1 30891,0 30922,1 30970,0 30995,1 31057,0 31101,1 31111,0 31205,1 31280,0 31352,1 31395,0 31477,1 31556,0 31647,1 31671,0 31737,1 31790,0 31822,1 31905,0 31906,1 31997,0 32010,1 32101,0 32191,1 32208,0 32219,1 32272,0 32341,1 32373,0 32393,1 32398,0 32408,1 32447,0 32473,1 32521,0 32598,1 32645,0 32648,1 32703,0 32786,1 32874,0 32934,1 33017,0 33055,1 33097,0 33164,1 33251,0 33306,1 33377,0 33465,1 33535,0 33610,1 33681,0 33735,1 33741,0 33826,1 33836,0 33859,1 33946,0 34041,1 34094,0 34190,1 34240,0 34260,1 34327,0 34399,1 34493,0 34554,1 34590,0 34638,1 34734,0 34803,1 34848,0 34939,1 34983,0 35073,1 35105,0 35114,1 35163,0 35238,1 35305,0 35319,1 35352,0 35372,1 35383,0 35387,1 35423,0 35435,1 35494,0 35527,1 35602,0 35665,1 35755,0 35840,1 35926,0 35993,1 36013,0 36064,1 36121,0 36179,1 36276,0 36361,1 36432,0 36513,1 36574,0 36630,1 36723,0 36730,1 36811,0 36823,1 36878,0 36895,1 36951,0 36982,1 37056,0 37093,1 37129,0 37171,1 37255,0 37303,1 37362,0 37440,1 37501,0 37503,1 37573,0 37650,1 37678,0 37695,1 37713,0 37754,1 37837,0 37893,1 37984,0 38016,1 38025,0 38042,1 38048,0 38140,1 38175,0 38177,1 38273,0 38311,1 38384,0 38484,1 38506,0 38593,1 38685,0 38702,1 38762,0 38862,1 38924,0 39021,1 39054,0 39078,1 39091,0 39170,1 39261,0 39361,1 39387,0 39442,1 39508,0 39595,1 39619,0 39672,1 39742,0 39835,1 39853,0 39924,1 40010,0 40031,1 40052,0 40101,1 40133,0 40192,1 40252,0 40261,1 40278,0 40361,1 40439,0 40538,1 40594,0 40642,1 40731,0 40753,1 40785,0 40881,1 40884,0 40928,1 40948,0 41041,1 41067,0 41076,1 41115,0 41169,1 41269,0 41296,1 41331,0 41425,1 41517,0 41553,1 41633,0 41674,1 41680,0 41684,1 41720,0 41736,1 41780,0 41846,1 41890,0 41899,1 41973,0 42072,1 42088,0 42124,1 42128,0 42213,1 42249,0 42324,1 42389,0 42487,1 42583,0 42601,1 42686,0 42731,1 42807,0 42904,1 42972,0 43060,1 43071,0 43091,1 43142,0 43191,1 43196,0 43284,1 43314,0 43411,1 43431,0 43483,1 43553,0 43566,1 43633,0 43656,1 43714,0 43783,1 43829,0 43921,1 43984,0 44035,1 44123,0 44125,1 44225,0 44288,1 44371,0 44436,1 44503,0 44588,1 44609,0 44622,1 44661,0 44761,1 44838,0 44849,1 44855,0 44860,1 44907,0 44954,1 45002,0 45034,1 45040,0 45093,1 45162,0 45187,1 45194,0 45219,1 45318,0 45346,1 45404,0 45478,1 45546,0 45638,1 45671,0 45718,1 45771,0 45858,1 45879,0 45883,1 45967,0 46059,1 46139,0 46150,1 46238,0 46333,1 46356,0 46410,1 46472,0 46494,1 46503,0 46542,1 46617,0 46679,1 46777,0 46841,1 46920,0 46953,1 47015,0 47104,1 47145,0 47172,1 47257,0 47329,1 47398,0 47454,1 47548,0 47633,1 47667,0 47701,1 47733,0 47755,1 47784,0 47862,1 47892,0 47949,1 47962,0 48001,1 48052,0 48097,1 48129,0 48205,1 48237,0 48286,1 48374,0 48439,1 48467,0 48487,1 48586,0 48664,1 48685,0 48769,1 48817,0 48898,1 48899,0 48982,1 49076,0 49118,1 49165,0 49203,1 49219,0 49243,1 49265,0 49276,1 49321,0 49404,1 49439,0 49480,1 49568,0 49575,1 49582,0 49620,1 49623,0 49696,1 49732,0 49776,1 49818,0 49915,1 49947,0 49991,1 50088,0 50162,1 50259,0 50315,1 50398,0 50441,1 50504,0 50513,1 50577,0 50609,1 50643,0 50668,1 50743,0 50797,1 50830,0 50869,1 50959,0 51032,1 51050,0 51074,1 51147,0 51148,1 51211,0 51277,1 51278,0 51286,1 51308,0 51326,1 51366,0 51415,1 51507,0 51573,1 end initlist a3 0,0 36,1 46,0 97,1 190,0 239,1 277,0 328,1 378,0 412,1 442,0 521,1 594,0 607,1 664,0 667,1 740,0 786,1 798,0 843,1 845,0 853,1 929,0 949,1 1005,0 1025,1 1074,0 1077,1 1112,0 1129,1 1206,0 1223,1 1225,0 1297,1 1344,0 1384,1 1439,0 1500,1 1535,0 1579,1 1591,0 1593,1 1660,0 1700,1 1744,0 1755,1 1816,0 1880,1 1971,0 1977,1 2024,0 2080,1 2128,0 2193,1 2211,0 2279,1 2282,0 2326,1 2340,0 2439,1 2536,0 2622,1 2664,0 2749,1 2810,0 2870,1 2935,0 2991,1 3080,0 3163,1 3256,0 3338,1 3346,0 3414,1 3514,0 3571,1 3587,0 3657,1 3732,0 3783,1 3815,0 3833,1 3908,0 3920,1 3994,0 4085,1 4104,0 4168,1 4218,0 4243,1 4317,0 4369,1 4374,0 4456,1 4469,0 4489,1 4499,0 4531,1 4630,0 4714,1 4719,0 4812,1 4846,0 4912,1 4989,0 5037,1 5124,0 5173,1 5257,0 5347,1 5421,0 5480,1 5525,0 5533,1 5555,0 5648,1 5722,0 5725,1 5731,0 5800,1 5820,0 5893,1 5934,0 5944,1 5999,0 6081,1 6168,0 6210,1 6271,0 6361,1 6392,0 6449,1 6489,0 6505,1 6597,0 6643,1 6738,0 6774,1 6827,0 6926,1 6939,0 6969,1 6984,0 7078,1 7158,0 7210,1 7306,0 7313,1 7392,0 7466,1 7544,0 7642,1 7698,0 7781,1 7871,0 7899,1 7921,0 7944,1 8022,0 8063,1 8090,0 8147,1 8213,0 8239,1 8316,0 8400,1 8490,0 8541,1 8546,0 8576,1 8604,0 8692,1 8703,0 8803,1 8856,0 8940,1 9006,0 9037,1 9096,0 9144,1 9244,0 9316,1 9404,0 9442,1 9458,0 9541,1 9606,0 9653,1 9726,0 9812,1 9820,0 9846,1 9941,0 10003,1 10065,0 10092,1 10156,0 10216,1 10312,0 10412,1 10448,0 10545,1 10627,0 10642,1 10696,0 10742,1 10830,0 10914,1 10951,0 10988,1 11061,0 11131,1 11215,0 11312,1 11338,0 11411,1 11478,0 11503,1 11520,0 11599,1 11677,0 11761,1 11837,0 11840,1 11901,0 11969,1 12022,0 12093,1 12170,0 12267,1 12365,0 12421,1 12465,0 12474,1 12501,0 12577,1 12613,0 12674,1 12773,0 12805,1 12855,0 12915,1 12978,0 12990,1 13038,0 13095,1 13155,0 13227,1 13275,0 13357,1 13381,0 13451,1 13499,0 13514,1 13545,0 13571,1 13661,0 13698,1 13714,0 13726,1 13810,0 13864,1 13931,0 13996,1 14041,0 14054,1 14079,0 14099,1 14162,0 14251,1 14282,0 14290,1 14333,0 14358,1 14411,0 14441,1 14477,0 14527,1 14601,0 14697,1 14718,0 14815,1 14863,0 14944,1 15006,0 15029,1 15047,0 15119,1 15158,0 15206,1 15244,0 15305,1 15366,0 15414,1 15454,0 15489,1 15550,0 15626,1 15673,0 15735,1 15810,0 15865,1 15923,0 15963,1 16050,0 16059,1 16081,0 16169,1 16222,0 16311,1 16374,0 16434,1 16523,0 16564,1 16631,0 16668,1 16700,0 16721,1 16753,0 16844,1 16846,0 16880,1 16904,0 16969,1 17068,0 17139,1 17220,0 17223,1 17287,0 17347,1 17399,0 17482,1 17496,0 17582,1 17672,0 17689,1 17773,0 17788,1 17817,0 17870,1 17885,0 17913,1 17934,0 17949,1 17963,0 17981,1 18036,0 18128,1 18180,0 18195,1 18231,0 18321,1 18336,0 18424,1 18427,0 18457,1 18526,0 18553,1 18622,0 18657,1 18691,0 18766,1 18783,0 18861,1 18879,0 18947,1 19019,0 19060,1 19107,0 19125,1 19190,0 19240,1 19324,0 19353,1 19447,0 19533,1 19626,0 19702,1 19729,0 19801,1 19887,0 19987,1 19992,0 20069,1 20159,0 20241,1 20322,0 20342,1 20423,0 20474,1 20539,0 20563,1 20577,0 20638,1 20711,0 20805,1 20872,0 20952,1 20969,0 21060,1 21099,0 21169,1 21233,0 21251,1 21265,0 21294,1 21315,0 21346,1 21383,0 21457,1 21491,0 21516,1 21556,0 21615,1 21630,0 21675,1 21775,0 21827,1 21914,0 21998,1 22087,0 22128,1 22130,0 22144,1 22218,0 22268,1 22274,0 22295,1 22334,0 22404,1 22439,0 22469,1 22555,0 22635,1 22684,0 22714,1 22798,0 22860,1 22898,0 22952,1 22956,0 23004,1 23032,0 23084,1 23152,0 23172,1 23236,0 23260,1 23262,0 23266,1 23330,0 23407,1 23410,0 23473,1 23531,0 23551,1 23630,0 23679,1 23742,0 23803,1 23840,0 23854,1 23951,0 23968,1 24019,0 24069,1 24107,0 24118,1 24161,0 24223,1 24299,0 24336,1 24378,0 24412,1 24479,0 24529,1 24601,0 24629,1 24679,0 24738,1 24749,0 24824,1 24888,0 24987,1 25028,0 25115,1 25163,0 25245,1 25312,0 25327,1 25343,0 25405,1 25422,0 25430,1 25520,0 25584,1 25667,0 25756,1 25827,0 25851,1 25889,0 25919,1 25938,0 25972,1 26051,0 26143,1 26148,0 26170,1 26203,0 26277,1 26338,0 26403,1 26500,0 26524,1 26598,0 26623,1 26709,0 26791,1 26792,0 26805,1 26820,0 26865,1 26896,0 26923,1 27005,0 27052,1 27061,0 27062,1 27086,0 27165,1 27185,0 27235,1 27296,0 27383,1 27437,0 27514,1 27541,0 27629,1 27638,0 27657,1 27682,0 27715,1 27751,0 27755,1 27808,0 27886,1 27937,0 27995,1 28084,0 28131,1 28187,0 28259,1 28301,0 28354,1 28356,0 28436,1 28525,0 28560,1 28603,0 28685,1 28784,0 28803,1 28804,0 28836,1 28905,0 28985,1 29069,0 29111,1 29146,0 29218,1 29280,0 29311,1 29386,0 29450,1 29484,0 29529,1 29606,0 29704,1 29803,0 29880,1 29951,0 29952,1 29997,0 30040,1 30116,0 30189,1 30280,0 30297,1 30312,0 30397,1 30492,0 30494,1 30543,0 30571,1 30642,0 30672,1 30704,0 30786,1 30819,0 30853,1 30903,0 30920,1 30922,0 30940,1 31039,0 31055,1 31127,0 31166,1 31188,0 31201,1 31237,0 31238,1 31314,0 31322,1 31414,0 31446,1 31515,0 31553,1 31572,0 31585,1 31616,0 31667,1 31767,0 31819,1 31882,0 31902,1 31944,0 31961,1 32011,0 32053,1 32063,0 32095,1 32125,0 32182,1 32223,0 32318,1 32400,0 32500,1 32576,0 32655,1 32717,0 32785,1 32798,0 32841,1 32862,0 32925,1 33019,0 33088,1 33164,0 33257,1 33335,0 33342,1 33389,0 33433,1 33501,0 33588,1 33635,0 33668,1 33731,0 33831,1 33832,0 33862,1 33933,0 33977,1 34044,0 34125,1 34143,0 34186,1 34224,0 34289,1 34385,0 34464,1 34497,0 34531,1 34559,0 34560,1 34652,0 34659,1 34693,0 34733,1 34810,0 34890,1 34980,0 35026,1 35082,0 35167,1 35202,0 35239,1 35322,0 35367,1 35389,0 35475,1 35527,0 35557,1 35591,0 35618,1 35678,0 35705,1 35737,0 35825,1 35841,0 35877,1 35912,0 35941,1 36019,0 36065,1 36150,0 36166,1 36210,0 36226,1 36287,0 36290,1 36358,0 36417,1 36494,0 36510,1 36560,0 36599,1 36636,0 36655,1 36697,0 36725,1 36751,0 36808,1 36813,0 36846,1 36942,0 36968,1 37064,0 37098,1 37114,0 37213,1 37292,0 37353,1 37398,0 37480,1 37555,0 37644,1 37689,0 37764,1 37814,0 37816,1 37820,0 37872,1 37967,0 38066,1 38165,0 38181,1 38222,0 38310,1 38393,0 38394,1 38470,0 38569,1 38664,0 38670,1 38678,0 38749,1 38755,0 38819,1 38905,0 39001,1 39090,0 39145,1 39173,0 39194,1 39228,0 39232,1 39302,0 39322,1 39350,0 39440,1 39481,0 39581,1 39641,0 39702,1 39754,0 39760,1 39841,0 39872,1 39918,0 40007,1 40069,0 40133,1 40195,0 40203,1 40229,0 40301,1 40399,0 40453,1 40482,0 40536,1 40539,0 40606,1 40644,0 40674,1 40690,0 40732,1 40772,0 40837,1 40924,0 40962,1 40972,0 40980,1 40986,0 41053,1 41064,0 41132,1 41158,0 41179,1 41196,0 41239,1 41321,0 41380,1 41428,0 41449,1 41482,0 41499,1 41584,0 41622,1 41630,0 41682,1 41757,0 41827,1 41909,0 41981,1 42071,0 42120,1 42206,0 42284,1 42302,0 42391,1 42438,0 42522,1 42584,0 42589,1 42670,0 42725,1 42740,0 42789,1 42795,0 42852,1 42924,0 42969,1 42992,0 43049,1 43080,0 43104,1 43161,0 43181,1 43241,0 43275,1 43284,0 43360,1 43381,0 43415,1 43430,0 43502,1 43517,0 43580,1 43585,0 43680,1 43773,0 43818,1 43882,0 43980,1 44067,0 44075,1 44167,0 44180,1 44209,0 44234,1 44271,0 44272,1 44315,0 44404,1 44474,0 44564,1 44614,0 44651,1 44653,0 44713,1 44756,0 44850,1 44865,0 44867,1 44958,0 45019,1 45033,0 45063,1 45072,0 45165,1 45199,0 45213,1 45237,0 45335,1 45383,0 45480,1 45484,0 45491,1 45590,0 45640,1 45740,0 45804,1 45847,0 45906,1 45937,0 45972,1 46047,0 46058,1 46119,0 46214,1 46263,0 46336,1 46414,0 46439,1 46460,0 46556,1 46586,0 46608,1 46670,0 46704,1 46718,0 46809,1 46886,0 46960,1 47001,0 47002,1 47088,0 47101,1 47130,0 47216,1 47294,0 47327,1 47422,0 47435,1 47519,0 47586,1 47658,0 47697,1 47787,0 47833,1 47923,0 47947,1 48043,0 48085,1 48117,0 48143,1 48152,0 48240,1 48279,0 48346,1 48385,0 48403,1 48422,0 48495,1 48572,0 48615,1 48696,0 48746,1 48777,0 48836,1 48928,0 48975,1 48995,0 49039,1 49137,0 49163,1 49256,0 49298,1 49368,0 49414,1 49476,0 49485,1 49515,0 49570,1 49573,0 49648,1 49682,0 49701,1 49779,0 49815,1 49821,0 49880,1 49914,0 49959,1 50054,0 50124,1 50212,0 50256,1 50264,0 50332,1 50400,0 50446,1 50509,0 50568,1 50626,0 50698,1 50735,0 50757,1 50804,0 50901,1 end initlist a4 0,0 96,1 105,0 157,1 213,0 246,1 334,0 366,1 449,0 488,1 522,0 576,1 623,0 715,1 794,0 823,1 906,0 921,1 968,0 1058,1 1102,0 1130,1 1201,0 1291,1 1316,0 1333,1 1424,0 1434,1 1501,0 1592,1 1628,0 1637,1 1640,0 1729,1 1750,0 1756,1 1767,0 1794,1 1860,0 1886,1 1983,0 2040,1 2042,0 2055,1 2140,0 2156,1 2189,0 2262,1 2308,0 2311,1 2356,0 2444,1 2490,0 2575,1 2623,0 2666,1 2763,0 2856,1 2934,0 2994,1 3017,0 3036,1 3043,0 3052,1 3063,0 3082,1 3158,0 3201,1 3244,0 3278,1 3362,0 3449,1 3527,0 3538,1 3540,0 3631,1 3666,0 3760,1 3788,0 3812,1 3840,0 3910,1 3996,0 4044,1 4088,0 4149,1 4175,0 4270,1 4300,0 4400,1 4465,0 4511,1 4541,0 4612,1 4665,0 4765,1 4782,0 4839,1 4877,0 4878,1 4891,0 4918,1 4932,0 5020,1 5082,0 5134,1 5155,0 5159,1 5219,0 5302,1 5365,0 5451,1 5546,0 5628,1 5630,0 5647,1 5736,0 5780,1 5832,0 5895,1 5945,0 5971,1 6057,0 6144,1 6192,0 6212,1 6295,0 6340,1 6435,0 6438,1 6477,0 6577,1 6645,0 6715,1 6781,0 6866,1 6868,0 6882,1 6941,0 6996,1 7000,0 7066,1 7144,0 7151,1 7235,0 7244,1 7279,0 7365,1 7380,0 7389,1 7452,0 7515,1 7561,0 7638,1 7660,0 7680,1 7736,0 7813,1 7913,0 8000,1 8069,0 8092,1 8177,0 8232,1 8242,0 8244,1 8308,0 8376,1 8428,0 8447,1 8503,0 8557,1 8654,0 8710,1 8727,0 8807,1 8857,0 8868,1 8913,0 8941,1 9011,0 9077,1 9142,0 9170,1 9210,0 9240,1 9333,0 9407,1 9428,0 9458,1 9499,0 9541,1 9592,0 9633,1 9730,0 9746,1 9753,0 9763,1 9820,0 9825,1 9859,0 9879,1 9941,0 9960,1 9964,0 9999,1 10056,0 10057,1 10077,0 10084,1 10088,0 10173,1 10186,0 10209,1 10210,0 10252,1 10321,0 10339,1 10369,0 10426,1 10466,0 10525,1 10624,0 10706,1 10723,0 10768,1 10819,0 10872,1 10955,0 10995,1 11040,0 11070,1 11124,0 11128,1 11149,0 11245,1 11312,0 11318,1 11361,0 11389,1 11485,0 11558,1 11651,0 11681,1 11695,0 11701,1 11736,0 11777,1 11823,0 11837,1 11917,0 11993,1 11996,0 12074,1 12168,0 12210,1 12271,0 12318,1 12377,0 12442,1 12488,0 12489,1 12533,0 12552,1 12557,0 12576,1 12585,0 12644,1 12651,0 12742,1 12841,0 12941,1 13009,0 13033,1 13113,0 13187,1 13211,0 13216,1 13238,0 13270,1 13289,0 13357,1 13448,0 13517,1 13548,0 13609,1 13629,0 13631,1 13704,0 13754,1 13801,0 13847,1 13852,0 13856,1 13914,0 13931,1 13945,0 14017,1 14099,0 14124,1 14134,0 14173,1 14207,0 14263,1 14338,0 14375,1 14384,0 14442,1 14484,0 14557,1 14647,0 14730,1 14742,0 14771,1 14802,0 14880,1 14912,0 14993,1 15035,0 15049,1 15143,0 15223,1 15297,0 15353,1 15361,0 15451,1 15551,0 15600,1 15676,0 15725,1 15798,0 15849,1 15914,0 15985,1 16011,0 16026,1 16100,0 16145,1 16210,0 16281,1 16332,0 16382,1 16389,0 16414,1 16486,0 16504,1 16588,0 16614,1 16651,0 16690,1 16757,0 16850,1 16863,0 16879,1 16929,0 16997,1 17081,0 17086,1 17097,0 17174,1 17206,0 17209,1 17216,0 17266,1 17270,0 17315,1 17327,0 17383,1 17441,0 17518,1 17569,0 17642,1 17704,0 17745,1 17818,0 17841,1 17929,0 18028,1 18113,0 18149,1 18196,0 18211,1 18278,0 18326,1 18347,0 18436,1 18527,0 18536,1 18635,0 18692,1 18724,0 18776,1 18812,0 18876,1 18938,0 19022,1 19102,0 19161,1 19202,0 19255,1 19336,0 19403,1 19444,0 19478,1 19492,0 19511,1 19593,0 19662,1 19683,0 19774,1 19803,0 19860,1 19923,0 20017,1 20096,0 20187,1 20201,0 20279,1 20354,0 20429,1 20447,0 20458,1 20534,0 20539,1 20607,0 20626,1 20667,0 20744,1 20795,0 20857,1 20900,0 20922,1 20957,0 20966,1 21012,0 21091,1 21180,0 21263,1 21278,0 21317,1 21320,0 21397,1 21414,0 21446,1 21477,0 21497,1 21547,0 21619,1 21681,0 21759,1 21797,0 21851,1 21934,0 22018,1 22067,0 22098,1 22127,0 22142,1 22146,0 22152,1 22160,0 22181,1 22238,0 22253,1 22283,0 22374,1 22430,0 22480,1 22562,0 22599,1 22600,0 22664,1 22717,0 22779,1 22858,0 22930,1 22994,0 23028,1 23093,0 23095,1 23106,0 23168,1 23234,0 23241,1 23327,0 23395,1 23468,0 23488,1 23574,0 23602,1 23701,0 23714,1 23809,0 23884,1 23958,0 23977,1 24006,0 24062,1 24154,0 24226,1 24311,0 24340,1 24356,0 24433,1 24488,0 24510,1 24546,0 24613,1 24697,0 24720,1 24735,0 24832,1 24895,0 24905,1 24935,0 24999,1 25078,0 25126,1 25186,0 25258,1 25260,0 25321,1 25379,0 25470,1 25558,0 25618,1 25661,0 25681,1 25767,0 25823,1 25862,0 25902,1 25930,0 25940,1 25983,0 26054,1 26110,0 26111,1 26146,0 26157,1 26191,0 26255,1 26311,0 26320,1 26403,0 26446,1 26464,0 26544,1 26599,0 26657,1 26738,0 26800,1 26810,0 26910,1 27002,0 27098,1 27155,0 27181,1 27272,0 27334,1 27372,0 27404,1 27489,0 27495,1 27523,0 27574,1 27641,0 27669,1 27699,0 27703,1 27725,0 27790,1 27808,0 27892,1 27989,0 28075,1 28163,0 28181,1 28185,0 28187,1 28272,0 28302,1 28397,0 28494,1 28574,0 28580,1 28629,0 28659,1 28749,0 28849,1 28949,0 29011,1 29107,0 29191,1 29230,0 29323,1 29329,0 29407,1 29450,0 29511,1 29564,0 29600,1 29693,0 29714,1 29721,0 29819,1 29907,0 29914,1 29974,0 29999,1 30020,0 30120,1 30138,0 30212,1 30280,0 30291,1 30310,0 30374,1 30448,0 30498,1 30499,0 30564,1 30571,0 30608,1 30706,0 30770,1 30835,0 30931,1 30933,0 31005,1 31091,0 31123,1 31172,0 31207,1 31283,0 31300,1 31374,0 31451,1 31485,0 31537,1 31581,0 31635,1 31706,0 31709,1 31740,0 31799,1 31850,0 31906,1 31976,0 32037,1 32066,0 32117,1 32211,0 32294,1 32353,0 32431,1 32492,0 32554,1 32640,0 32665,1 32725,0 32806,1 32850,0 32926,1 32979,0 33029,1 33032,0 33082,1 33176,0 33268,1 33275,0 33328,1 33391,0 33444,1 33474,0 33477,1 33532,0 33555,1 33607,0 33645,1 33697,0 33728,1 33744,0 33811,1 33833,0 33851,1 33930,0 33965,1 34045,0 34067,1 34068,0 34097,1 34113,0 34212,1 34298,0 34302,1 34336,0 34356,1 34455,0 34492,1 34565,0 34650,1 34737,0 34807,1 34833,0 34893,1 34895,0 34964,1 35008,0 35087,1 35150,0 35185,1 35267,0 35292,1 35353,0 35411,1 35502,0 35514,1 35521,0 35574,1 35619,0 35657,1 35739,0 35800,1 35850,0 35909,1 35983,0 36002,1 36042,0 36134,1 36200,0 36275,1 36316,0 36328,1 36426,0 36479,1 36533,0 36572,1 36632,0 36649,1 36667,0 36724,1 36809,0 36884,1 36934,0 36977,1 36978,0 36987,1 37051,0 37124,1 37161,0 37176,1 37274,0 37363,1 37445,0 37466,1 37512,0 37598,1 37658,0 37751,1 37754,0 37794,1 37889,0 37939,1 38019,0 38044,1 38123,0 38152,1 38242,0 38305,1 38340,0 38342,1 38395,0 38431,1 38433,0 38521,1 38600,0 38699,1 38729,0 38735,1 38745,0 38843,1 38878,0 38921,1 38923,0 38974,1 38987,0 39033,1 39044,0 39116,1 39165,0 39241,1 39312,0 39338,1 39388,0 39436,1 39446,0 39463,1 39504,0 39574,1 39606,0 39632,1 39635,0 39692,1 39735,0 39755,1 39815,0 39830,1 39851,0 39896,1 39945,0 39985,1 40038,0 40048,1 40100,0 40195,1 40252,0 40300,1 40348,0 40427,1 40430,0 40441,1 40442,0 40498,1 40587,0 40643,1 40645,0 40652,1 40658,0 40661,1 40729,0 40824,1 40874,0 40966,1 40971,0 41027,1 41037,0 41132,1 41225,0 41324,1 41379,0 41402,1 41480,0 41563,1 41631,0 41674,1 41688,0 41716,1 41742,0 41823,1 41909,0 41985,1 42011,0 42058,1 42155,0 42206,1 42220,0 42310,1 42338,0 42412,1 42499,0 42572,1 42668,0 42717,1 42749,0 42816,1 42891,0 42923,1 43010,0 43043,1 43090,0 43120,1 43139,0 43224,1 43288,0 43371,1 43439,0 43471,1 43489,0 43549,1 43560,0 43654,1 43696,0 43796,1 43820,0 43912,1 43951,0 44012,1 44095,0 44130,1 44178,0 44191,1 44214,0 44293,1 44332,0 44342,1 44442,0 44466,1 44468,0 44477,1 44519,0 44599,1 44662,0 44730,1 44764,0 44797,1 44859,0 44899,1 44947,0 44996,1 45087,0 45174,1 45207,0 45230,1 45327,0 45382,1 45422,0 45472,1 45489,0 45526,1 45528,0 45623,1 45670,0 45675,1 45693,0 45782,1 45882,0 45962,1 46029,0 46063,1 46151,0 46242,1 46328,0 46417,1 46466,0 46489,1 46556,0 46589,1 46595,0 46693,1 46716,0 46761,1 46828,0 46833,1 46895,0 46970,1 47052,0 47146,1 47234,0 47251,1 47259,0 47281,1 47283,0 47292,1 47316,0 47415,1 47428,0 47505,1 47524,0 47531,1 47592,0 47650,1 47704,0 47774,1 47791,0 47829,1 47841,0 47859,1 47952,0 47999,1 48045,0 48066,1 48070,0 48115,1 48134,0 48228,1 48289,0 48383,1 48397,0 48478,1 48558,0 48641,1 48691,0 48694,1 48705,0 48743,1 48764,0 48831,1 48894,0 48976,1 48982,0 49060,1 49144,0 49192,1 49229,0 49314,1 49358,0 49446,1 49532,0 49630,1 49716,0 49751,1 end initlist a5 0,0 91,1 175,0 262,1 304,0 311,1 406,0 475,1 531,0 596,1 620,0 682,1 688,0 723,1 766,0 853,1 903,0 995,1 1094,0 1129,1 1132,0 1154,1 1211,0 1261,1 1265,0 1298,1 1302,0 1353,1 1385,0 1395,1 1428,0 1443,1 1523,0 1527,1 1568,0 1647,1 1693,0 1791,1 1843,0 1844,1 1896,0 1989,1 2043,0 2060,1 2062,0 2148,1 2161,0 2235,1 2279,0 2323,1 2330,0 2411,1 2472,0 2506,1 2593,0 2641,1 2681,0 2711,1 2768,0 2811,1 2896,0 2904,1 2962,0 3026,1 3109,0 3119,1 3137,0 3159,1 3188,0 3268,1 3321,0 3413,1 3417,0 3509,1 3593,0 3660,1 3751,0 3804,1 3810,0 3827,1 3904,0 3919,1 3987,0 4013,1 4109,0 4128,1 4166,0 4250,1 4258,0 4347,1 4433,0 4460,1 4516,0 4534,1 4549,0 4611,1 4687,0 4744,1 4819,0 4885,1 4917,0 4975,1 5009,0 5058,1 5113,0 5129,1 5138,0 5182,1 5251,0 5339,1 5403,0 5406,1 5438,0 5472,1 5543,0 5581,1 5620,0 5672,1 5689,0 5743,1 5774,0 5795,1 5850,0 5928,1 5998,0 6021,1 6047,0 6085,1 6096,0 6178,1 6278,0 6321,1 6384,0 6433,1 6509,0 6566,1 6573,0 6591,1 6681,0 6749,1 6779,0 6823,1 6892,0 6948,1 7034,0 7042,1 7055,0 7069,1 7075,0 7103,1 7131,0 7225,1 7318,0 7322,1 7395,0 7438,1 7510,0 7541,1 7612,0 7690,1 7756,0 7794,1 7865,0 7944,1 7999,0 8051,1 8118,0 8203,1 8232,0 8288,1 8361,0 8440,1 8459,0 8507,1 8564,0 8618,1 8631,0 8729,1 8825,0 8865,1 8940,0 9022,1 9118,0 9177,1 9217,0 9309,1 9383,0 9403,1 9474,0 9532,1 9627,0 9640,1 9663,0 9685,1 9726,0 9739,1 9762,0 9777,1 9844,0 9891,1 9900,0 9927,1 10027,0 10119,1 10155,0 10158,1 10254,0 10272,1 10274,0 10293,1 10355,0 10425,1 10513,0 10547,1 10574,0 10652,1 10686,0 10763,1 10775,0 10862,1 10941,0 10996,1 11017,0 11026,1 11088,0 11157,1 11159,0 11215,1 11285,0 11369,1 11394,0 11467,1 11545,0 11607,1 11656,0 11752,1 11813,0 11874,1 11958,0 11961,1 12060,0 12086,1 12127,0 12215,1 12245,0 12277,1 12329,0 12372,1 12392,0 12428,1 12446,0 12447,1 12528,0 12571,1 12668,0 12759,1 12796,0 12837,1 12902,0 12956,1 12958,0 13006,1 13011,0 13029,1 13105,0 13144,1 13209,0 13283,1 13325,0 13351,1 13362,0 13429,1 13490,0 13522,1 13563,0 13637,1 13670,0 13699,1 13795,0 13864,1 13912,0 13941,1 14006,0 14045,1 14047,0 14144,1 14180,0 14238,1 14297,0 14377,1 14402,0 14490,1 14579,0 14637,1 14699,0 14793,1 14794,0 14868,1 14893,0 14973,1 15068,0 15097,1 15142,0 15195,1 15242,0 15247,1 15279,0 15344,1 15403,0 15452,1 15478,0 15570,1 15577,0 15663,1 15757,0 15781,1 15791,0 15813,1 15816,0 15859,1 15919,0 15986,1 16023,0 16107,1 16135,0 16186,1 16215,0 16253,1 16336,0 16362,1 16456,0 16476,1 16553,0 16582,1 16658,0 16689,1 16700,0 16798,1 16890,0 16903,1 16915,0 17001,1 17034,0 17068,1 17082,0 17120,1 17178,0 17263,1 17270,0 17361,1 17454,0 17513,1 17587,0 17624,1 17703,0 17767,1 17832,0 17880,1 17935,0 18032,1 18084,0 18149,1 18157,0 18162,1 18224,0 18314,1 18403,0 18470,1 18502,0 18562,1 18599,0 18640,1 18660,0 18661,1 18755,0 18765,1 18777,0 18829,1 18848,0 18849,1 18914,0 18993,1 19039,0 19130,1 19217,0 19314,1 19338,0 19427,1 19433,0 19481,1 19531,0 19587,1 19616,0 19687,1 19742,0 19842,1 19928,0 20011,1 20106,0 20153,1 20200,0 20284,1 20293,0 20393,1 20447,0 20494,1 20554,0 20651,1 20676,0 20769,1 20831,0 20908,1 20950,0 20993,1 21058,0 21133,1 21143,0 21150,1 21151,0 21209,1 21305,0 21309,1 21394,0 21470,1 21480,0 21576,1 21656,0 21699,1 21711,0 21777,1 21860,0 21885,1 21914,0 21937,1 22000,0 22010,1 22023,0 22107,1 22138,0 22188,1 22212,0 22309,1 22377,0 22390,1 22440,0 22448,1 22513,0 22533,1 22555,0 22619,1 22687,0 22689,1 22774,0 22868,1 22962,0 23049,1 23124,0 23165,1 23255,0 23323,1 23375,0 23458,1 23501,0 23532,1 23590,0 23648,1 23744,0 23764,1 23810,0 23850,1 23900,0 23982,1 24032,0 24110,1 24206,0 24303,1 24304,0 24404,1 24430,0 24454,1 24489,0 24530,1 24598,0 24618,1 24675,0 24746,1 24782,0 24857,1 24942,0 24955,1 25037,0 25126,1 25131,0 25177,1 25276,0 25277,1 25315,0 25339,1 25422,0 25463,1 25505,0 25553,1 25644,0 25722,1 25764,0 25793,1 25825,0 25920,1 26018,0 26102,1 26182,0 26202,1 26230,0 26268,1 26367,0 26390,1 26443,0 26455,1 26514,0 26549,1 26558,0 26646,1 26712,0 26811,1 26875,0 26911,1 26929,0 26997,1 27009,0 27099,1 27155,0 27255,1 27310,0 27339,1 27403,0 27492,1 27523,0 27599,1 27646,0 27708,1 27725,0 27773,1 27865,0 27895,1 27994,0 28079,1 28145,0 28157,1 28211,0 28252,1 28270,0 28286,1 28325,0 28380,1 28403,0 28422,1 28453,0 28537,1 28568,0 28642,1 28663,0 28668,1 28753,0 28820,1 28821,0 28880,1 28892,0 28944,1 28976,0 28994,1 29006,0 29056,1 29076,0 29161,1 29249,0 29294,1 29391,0 29442,1 29498,0 29559,1 29615,0 29672,1 29677,0 29706,1 29739,0 29812,1 29857,0 29921,1 30020,0 30096,1 30118,0 30156,1 30215,0 30297,1 30300,0 30305,1 30387,0 30462,1 30487,0 30577,1 30583,0 30592,1 30623,0 30667,1 30740,0 30773,1 30846,0 30946,1 31011,0 31026,1 31108,0 31158,1 31165,0 31193,1 31215,0 31266,1 31308,0 31404,1 31419,0 31486,1 31539,0 31569,1 31608,0 31665,1 31738,0 31802,1 31843,0 31934,1 32022,0 32095,1 32144,0 32181,1 32196,0 32241,1 32272,0 32355,1 32439,0 32452,1 32540,0 32639,1 32694,0 32732,1 32785,0 32875,1 32915,0 33014,1 33085,0 33175,1 33252,0 33273,1 33349,0 33363,1 33391,0 33395,1 33459,0 33513,1 33573,0 33593,1 33689,0 33748,1 33779,0 33812,1 33823,0 33871,1 33924,0 34008,1 34072,0 34092,1 34140,0 34149,1 34214,0 34232,1 34303,0 34400,1 34420,0 34511,1 34568,0 34631,1 34722,0 34764,1 34810,0 34814,1 34841,0 34875,1 34960,0 35038,1 35049,0 35104,1 35113,0 35135,1 35148,0 35166,1 35208,0 35254,1 35286,0 35319,1 35387,0 35456,1 35529,0 35590,1 35609,0 35671,1 35695,0 35751,1 35826,0 35843,1 35891,0 35935,1 35956,0 35995,1 36001,0 36021,1 36061,0 36154,1 36173,0 36177,1 36230,0 36285,1 36370,0 36400,1 36440,0 36495,1 36497,0 36586,1 36599,0 36666,1 36738,0 36808,1 36864,0 36949,1 37014,0 37059,1 37137,0 37142,1 37198,0 37274,1 37291,0 37364,1 37413,0 37440,1 37533,0 37556,1 37580,0 37643,1 37730,0 37764,1 37836,0 37848,1 37931,0 37979,1 38037,0 38081,1 38166,0 38177,1 38247,0 38261,1 38263,0 38326,1 38371,0 38414,1 38472,0 38495,1 38545,0 38547,1 38586,0 38684,1 38744,0 38833,1 38869,0 38951,1 39008,0 39038,1 39114,0 39156,1 39195,0 39216,1 39268,0 39358,1 39449,0 39479,1 39545,0 39628,1 39646,0 39727,1 39798,0 39805,1 39888,0 39982,1 40053,0 40149,1 40226,0 40298,1 40305,0 40380,1 40466,0 40517,1 40563,0 40586,1 40647,0 40669,1 40745,0 40816,1 40879,0 40893,1 40903,0 40981,1 41079,0 41106,1 41116,0 41153,1 41166,0 41210,1 41279,0 41365,1 41393,0 41472,1 41511,0 41606,1 41649,0 41737,1 41836,0 41931,1 41966,0 42016,1 42018,0 42051,1 42142,0 42223,1 42226,0 42293,1 42372,0 42410,1 42497,0 42526,1 42606,0 42674,1 42740,0 42742,1 42803,0 42837,1 42898,0 42973,1 43010,0 43011,1 43043,0 43126,1 43187,0 43223,1 43295,0 43388,1 43393,0 43438,1 43464,0 43526,1 43611,0 43692,1 43712,0 43739,1 43800,0 43869,1 43872,0 43935,1 44020,0 44055,1 44082,0 44121,1 44201,0 44225,1 44318,0 44386,1 44410,0 44454,1 44476,0 44479,1 44577,0 44580,1 44659,0 44750,1 44796,0 44822,1 44878,0 44886,1 44980,0 44981,1 45047,0 45123,1 45165,0 45194,1 45243,0 45304,1 45359,0 45433,1 45519,0 45549,1 45551,0 45646,1 45698,0 45797,1 45853,0 45906,1 45979,0 46005,1 46047,0 46050,1 46103,0 46130,1 46152,0 46179,1 46276,0 46299,1 46383,0 46468,1 46511,0 46592,1 46669,0 46670,1 46726,0 46747,1 46780,0 46835,1 46912,0 46999,1 47083,0 47163,1 47262,0 47325,1 47327,0 47350,1 47366,0 47374,1 47431,0 47453,1 47470,0 47566,1 47580,0 47672,1 47740,0 47762,1 47779,0 47871,1 47901,0 47972,1 48054,0 48069,1 48130,0 48153,1 48173,0 48270,1 48344,0 48358,1 48415,0 48497,1 48582,0 48662,1 48732,0 48743,1 48827,0 48849,1 48887,0 48906,1 48953,0 49010,1 49056,0 49099,1 49173,0 49223,1 49289,0 49360,1 49441,0 49460,1 49516,0 49556,1 49583,0 49599,1 49655,0 49701,1 49716,0 49787,1 49798,0 49857,1 49948,0 50010,1 50070,0 50102,1 50104,0 50154,1 50164,0 50251,1 50310,0 50385,1 50457,0 50510,1 50554,0 50629,1 50662,0 50730,1 50813,0 50874,1 50966,0 50994,1 51024,0 51093,1 end initlist a6 0,0 87,1 167,0 189,1 203,0 247,1 272,0 310,1 350,0 420,1 485,0 580,1 595,0 599,1 697,0 765,1 825,0 827,1 893,0 937,1 972,0 1024,1 1094,0 1129,1 1214,0 1248,1 1328,0 1361,1 1429,0 1528,1 1616,0 1654,1 1665,0 1705,1 1739,0 1800,1 1805,0 1904,1 1965,0 1998,1 2093,0 2103,1 2120,0 2162,1 2212,0 2264,1 2360,0 2412,1 2483,0 2569,1 2584,0 2649,1 2705,0 2775,1 2872,0 2947,1 2961,0 3058,1 3099,0 3171,1 3270,0 3280,1 3291,0 3348,1 3372,0 3431,1 3484,0 3540,1 3638,0 3726,1 3816,0 3884,1 3892,0 3893,1 3910,0 4001,1 4046,0 4092,1 4129,0 4213,1 4309,0 4349,1 4418,0 4430,1 4455,0 4525,1 4602,0 4696,1 4703,0 4764,1 4785,0 4802,1 4807,0 4876,1 4934,0 4976,1 5062,0 5095,1 5128,0 5226,1 5308,0 5375,1 5386,0 5443,1 5494,0 5572,1 5650,0 5701,1 5795,0 5801,1 5884,0 5922,1 6015,0 6112,1 6142,0 6215,1 6313,0 6362,1 6371,0 6447,1 6456,0 6536,1 6629,0 6653,1 6717,0 6720,1 6774,0 6787,1 6795,0 6845,1 6942,0 7024,1 7036,0 7101,1 7130,0 7228,1 7289,0 7338,1 7436,0 7460,1 7466,0 7481,1 7517,0 7547,1 7596,0 7608,1 7648,0 7665,1 7715,0 7809,1 7828,0 7842,1 7878,0 7956,1 7964,0 8008,1 8101,0 8188,1 8191,0 8239,1 8329,0 8379,1 8462,0 8468,1 8491,0 8539,1 8606,0 8701,1 8753,0 8808,1 8872,0 8931,1 8973,0 9003,1 9098,0 9168,1 9179,0 9228,1 9323,0 9382,1 9445,0 9468,1 9492,0 9564,1 9583,0 9656,1 9683,0 9731,1 9754,0 9819,1 9829,0 9885,1 9926,0 9930,1 10027,0 10097,1 10109,0 10195,1 10295,0 10330,1 10418,0 10443,1 10463,0 10557,1 10601,0 10675,1 10725,0 10748,1 10761,0 10786,1 10834,0 10904,1 10928,0 10981,1 11023,0 11051,1 11097,0 11125,1 11177,0 11222,1 11311,0 11391,1 11444,0 11533,1 11552,0 11637,1 11706,0 11762,1 11819,0 11916,1 11964,0 12019,1 12028,0 12110,1 12175,0 12190,1 12286,0 12346,1 12398,0 12427,1 12473,0 12539,1 12576,0 12651,1 12715,0 12793,1 12877,0 12911,1 12971,0 13042,1 13136,0 13187,1 13269,0 13318,1 13383,0 13419,1 13459,0 13533,1 13606,0 13614,1 13712,0 13721,1 13809,0 13867,1 13889,0 13933,1 13952,0 13954,1 14032,0 14125,1 14132,0 14162,1 14178,0 14206,1 14210,0 14300,1 14305,0 14380,1 14477,0 14526,1 14598,0 14645,1 14697,0 14761,1 14773,0 14830,1 14891,0 14933,1 14944,0 14996,1 15054,0 15137,1 15193,0 15276,1 15304,0 15327,1 15361,0 15445,1 15454,0 15547,1 15603,0 15606,1 15666,0 15724,1 15782,0 15803,1 15851,0 15899,1 15953,0 15962,1 16050,0 16141,1 16157,0 16194,1 16219,0 16311,1 16347,0 16438,1 16512,0 16536,1 16561,0 16591,1 16623,0 16642,1 16658,0 16719,1 16724,0 16788,1 16848,0 16920,1 16956,0 16991,1 17048,0 17106,1 17199,0 17226,1 17260,0 17264,1 17327,0 17390,1 17489,0 17572,1 17671,0 17726,1 17756,0 17757,1 17790,0 17865,1 17965,0 18058,1 18104,0 18114,1 18192,0 18252,1 18318,0 18382,1 18429,0 18502,1 18544,0 18618,1 18685,0 18770,1 18824,0 18871,1 18960,0 18967,1 18980,0 19066,1 19143,0 19228,1 19237,0 19327,1 19380,0 19455,1 19520,0 19583,1 19656,0 19756,1 19834,0 19902,1 19942,0 20001,1 20014,0 20077,1 20135,0 20228,1 20276,0 20292,1 20377,0 20451,1 20475,0 20507,1 20607,0 20706,1 20735,0 20815,1 20854,0 20857,1 20920,0 21001,1 21038,0 21121,1 21190,0 21204,1 21304,0 21324,1 21343,0 21419,1 21486,0 21521,1 21529,0 21550,1 21552,0 21599,1 21656,0 21698,1 21748,0 21756,1 21808,0 21843,1 21896,0 21930,1 21969,0 22061,1 22094,0 22135,1 22149,0 22232,1 22253,0 22309,1 22320,0 22392,1 22450,0 22456,1 22495,0 22535,1 22625,0 22712,1 22791,0 22818,1 22899,0 22967,1 22986,0 22999,1 23013,0 23049,1 23101,0 23143,1 23154,0 23247,1 23313,0 23377,1 23426,0 23482,1 23518,0 23538,1 23549,0 23585,1 23587,0 23649,1 23748,0 23815,1 23887,0 23946,1 24008,0 24091,1 24098,0 24110,1 24150,0 24243,1 24335,0 24362,1 24395,0 24451,1 24519,0 24606,1 24693,0 24789,1 24854,0 24924,1 24985,0 24987,1 25018,0 25036,1 25097,0 25157,1 25204,0 25236,1 25253,0 25256,1 25355,0 25414,1 25472,0 25562,1 25568,0 25640,1 25705,0 25717,1 25782,0 25812,1 25887,0 25904,1 25953,0 26046,1 26085,0 26157,1 26176,0 26211,1 26273,0 26284,1 26348,0 26350,1 26400,0 26452,1 26486,0 26570,1 26628,0 26706,1 26735,0 26808,1 26831,0 26877,1 26943,0 26948,1 27005,0 27081,1 27121,0 27179,1 27181,0 27252,1 27351,0 27449,1 27530,0 27579,1 27637,0 27684,1 27762,0 27800,1 27898,0 27990,1 28072,0 28073,1 28149,0 28222,1 28260,0 28266,1 28286,0 28373,1 28380,0 28407,1 28474,0 28569,1 28642,0 28645,1 28734,0 28743,1 28767,0 28813,1 28892,0 28929,1 29007,0 29042,1 29068,0 29141,1 29238,0 29273,1 29373,0 29399,1 29404,0 29440,1 29525,0 29595,1 29617,0 29628,1 29679,0 29734,1 29783,0 29876,1 29931,0 30002,1 30066,0 30157,1 30255,0 30330,1 30375,0 30460,1 30478,0 30494,1 30528,0 30575,1 30607,0 30670,1 30700,0 30757,1 30762,0 30801,1 30820,0 30888,1 30913,0 30993,1 31069,0 31119,1 31133,0 31141,1 31174,0 31266,1 31343,0 31406,1 31444,0 31455,1 31460,0 31505,1 31599,0 31673,1 31767,0 31803,1 31853,0 31920,1 31949,0 32044,1 32076,0 32107,1 32139,0 32175,1 32198,0 32261,1 32352,0 32435,1 32479,0 32543,1 32586,0 32659,1 32689,0 32757,1 32766,0 32828,1 32874,0 32922,1 33021,0 33064,1 33096,0 33169,1 33238,0 33278,1 33335,0 33405,1 33476,0 33484,1 33489,0 33569,1 33624,0 33628,1 33663,0 33687,1 33756,0 33789,1 33831,0 33836,1 33903,0 33906,1 33926,0 34016,1 34069,0 34137,1 34209,0 34226,1 34254,0 34257,1 34351,0 34434,1 34528,0 34530,1 34620,0 34650,1 34680,0 34718,1 34750,0 34751,1 34808,0 34897,1 34942,0 34991,1 35038,0 35120,1 35199,0 35213,1 35227,0 35319,1 35352,0 35375,1 35388,0 35397,1 35445,0 35516,1 35583,0 35609,1 35630,0 35704,1 35750,0 35819,1 35910,0 36008,1 36059,0 36068,1 36098,0 36138,1 36195,0 36197,1 36205,0 36280,1 36353,0 36400,1 36414,0 36442,1 36542,0 36555,1 36606,0 36636,1 36699,0 36702,1 36730,0 36805,1 36870,0 36933,1 37010,0 37069,1 37138,0 37215,1 37270,0 37362,1 37400,0 37410,1 37443,0 37452,1 37544,0 37585,1 37661,0 37678,1 37698,0 37785,1 37787,0 37791,1 37882,0 37907,1 37993,0 38086,1 38088,0 38120,1 38179,0 38222,1 38286,0 38347,1 38373,0 38447,1 38545,0 38550,1 38609,0 38681,1 38752,0 38764,1 38787,0 38795,1 38809,0 38904,1 38953,0 39051,1 39068,0 39069,1 39145,0 39164,1 39234,0 39288,1 39342,0 39389,1 39487,0 39566,1 39631,0 39650,1 39714,0 39798,1 39889,0 39942,1 40015,0 40037,1 40099,0 40185,1 40191,0 40217,1 40312,0 40409,1 40414,0 40459,1 40514,0 40583,1 40624,0 40641,1 40718,0 40808,1 40890,0 40970,1 41002,0 41021,1 41039,0 41088,1 41134,0 41156,1 41186,0 41216,1 41246,0 41267,1 41322,0 41358,1 41369,0 41467,1 41553,0 41575,1 41592,0 41634,1 41639,0 41659,1 41698,0 41767,1 41778,0 41874,1 41906,0 41941,1 41964,0 42010,1 42105,0 42176,1 42274,0 42370,1 42382,0 42400,1 42485,0 42490,1 42586,0 42609,1 42631,0 42673,1 42715,0 42799,1 42828,0 42871,1 42911,0 42962,1 43059,0 43064,1 43093,0 43101,1 43133,0 43219,1 43316,0 43317,1 43377,0 43427,1 43493,0 43499,1 43570,0 43662,1 43729,0 43747,1 43814,0 43877,1 43946,0 43986,1 44040,0 44138,1 44219,0 44240,1 44265,0 44275,1 44374,0 44418,1 44478,0 44537,1 44621,0 44669,1 44713,0 44714,1 44759,0 44827,1 44897,0 44908,1 44991,0 44999,1 45074,0 45098,1 45127,0 45149,1 45174,0 45185,1 45243,0 45325,1 45365,0 45418,1 45453,0 45516,1 45601,0 45625,1 45655,0 45727,1 45762,0 45851,1 45916,0 45987,1 46041,0 46055,1 46091,0 46175,1 46247,0 46268,1 46332,0 46403,1 46464,0 46563,1 46626,0 46692,1 46779,0 46797,1 46893,0 46980,1 47047,0 47068,1 47118,0 47190,1 47197,0 47280,1 47311,0 47351,1 47390,0 47428,1 47472,0 47568,1 47659,0 47678,1 47707,0 47804,1 47892,0 47911,1 47942,0 47997,1 48083,0 48092,1 48124,0 48209,1 48265,0 48349,1 48415,0 48484,1 48569,0 48647,1 48688,0 48750,1 48841,0 48906,1 48935,0 48941,1 48954,0 49043,1 49095,0 49149,1 49211,0 49218,1 49313,0 49384,1 49475,0 49565,1 49620,0 49663,1 49674,0 49728,1 49805,0 49873,1 49891,0 49988,1 50011,0 50023,1 50066,0 50154,1 50236,0 50265,1 50272,0 50308,1 50345,0 50441,1 50499,0 50578,1 50663,0 50716,1 50724,0 50755,1 50819,0 50875,1 50955,0 50987,1 51034,0 51132,1 51202,0 51217,1 51267,0 51367,1 end initlist a7 0,0 74,1 153,0 182,1 270,0 359,1 380,0 447,1 468,0 489,1 551,0 567,1 634,0 654,1 719,0 742,1 753,0 765,1 771,0 844,1 880,0 894,1 975,0 1050,1 1100,0 1149,1 1225,0 1279,1 1364,0 1459,1 1496,0 1524,1 1624,0 1661,1 1680,0 1731,1 1793,0 1881,1 1931,0 2008,1 2042,0 2090,1 2162,0 2204,1 2251,0 2296,1 2303,0 2367,1 2395,0 2475,1 2496,0 2581,1 2628,0 2667,1 2718,0 2740,1 2787,0 2810,1 2876,0 2955,1 3046,0 3076,1 3114,0 3206,1 3253,0 3336,1 3418,0 3435,1 3506,0 3538,1 3602,0 3613,1 3640,0 3666,1 3737,0 3744,1 3842,0 3908,1 3934,0 4009,1 4066,0 4094,1 4097,0 4186,1 4189,0 4284,1 4375,0 4406,1 4483,0 4556,1 4557,0 4653,1 4746,0 4755,1 4848,0 4857,1 4890,0 4914,1 4962,0 5057,1 5127,0 5187,1 5235,0 5271,1 5368,0 5445,1 5460,0 5495,1 5584,0 5676,1 5697,0 5752,1 5766,0 5778,1 5784,0 5862,1 5879,0 5951,1 5985,0 6076,1 6142,0 6163,1 6193,0 6204,1 6229,0 6311,1 6328,0 6338,1 6355,0 6364,1 6455,0 6526,1 6575,0 6669,1 6709,0 6739,1 6767,0 6814,1 6873,0 6954,1 7042,0 7136,1 7208,0 7278,1 7291,0 7367,1 7453,0 7533,1 7559,0 7573,1 7588,0 7589,1 7652,0 7687,1 7732,0 7793,1 7816,0 7895,1 7954,0 8029,1 8121,0 8143,1 8217,0 8285,1 8362,0 8405,1 8495,0 8582,1 8616,0 8714,1 8721,0 8811,1 8875,0 8972,1 9023,0 9068,1 9148,0 9194,1 9226,0 9316,1 9329,0 9378,1 9407,0 9444,1 9496,0 9522,1 9552,0 9593,1 9640,0 9666,1 9761,0 9805,1 9813,0 9905,1 9976,0 10066,1 10148,0 10221,1 10293,0 10345,1 10444,0 10477,1 10513,0 10609,1 10694,0 10750,1 10798,0 10816,1 10854,0 10926,1 10970,0 11022,1 11116,0 11135,1 11201,0 11285,1 11378,0 11394,1 11432,0 11529,1 11547,0 11643,1 11704,0 11723,1 11811,0 11886,1 11953,0 12018,1 12019,0 12032,1 12045,0 12112,1 12201,0 12210,1 12278,0 12312,1 12372,0 12447,1 12527,0 12620,1 12644,0 12713,1 12726,0 12788,1 12797,0 12869,1 12953,0 13042,1 13098,0 13103,1 13121,0 13178,1 13200,0 13213,1 13300,0 13390,1 13490,0 13556,1 13640,0 13659,1 13726,0 13762,1 13832,0 13880,1 13948,0 14025,1 14060,0 14155,1 14222,0 14236,1 14247,0 14299,1 14372,0 14377,1 14437,0 14474,1 14534,0 14580,1 14647,0 14731,1 14824,0 14829,1 14900,0 14930,1 14961,0 15037,1 15109,0 15155,1 15173,0 15248,1 15337,0 15380,1 15457,0 15527,1 15553,0 15613,1 15695,0 15714,1 15786,0 15863,1 15890,0 15934,1 15980,0 16060,1 16085,0 16168,1 16235,0 16318,1 16385,0 16403,1 16412,0 16443,1 16528,0 16611,1 16666,0 16696,1 16789,0 16837,1 16896,0 16910,1 16953,0 16984,1 17001,0 17092,1 17174,0 17262,1 17294,0 17335,1 17380,0 17389,1 17398,0 17401,1 17476,0 17562,1 17609,0 17645,1 17658,0 17730,1 17797,0 17843,1 17911,0 17958,1 18044,0 18071,1 18112,0 18170,1 18189,0 18266,1 18305,0 18369,1 18421,0 18507,1 18518,0 18569,1 18656,0 18732,1 18799,0 18824,1 18892,0 18905,1 19003,0 19068,1 19168,0 19185,1 19250,0 19344,1 19362,0 19399,1 19467,0 19507,1 19542,0 19596,1 19624,0 19704,1 19767,0 19803,1 19873,0 19886,1 19977,0 20002,1 20059,0 20062,1 20093,0 20164,1 20228,0 20271,1 20300,0 20393,1 20445,0 20519,1 20576,0 20614,1 20684,0 20713,1 20754,0 20803,1 20878,0 20905,1 20912,0 20913,1 20914,0 20938,1 20966,0 21008,1 21014,0 21063,1 21142,0 21235,1 21333,0 21403,1 21490,0 21553,1 21637,0 21708,1 21721,0 21756,1 21760,0 21829,1 21830,0 21869,1 21953,0 21962,1 22051,0 22130,1 22133,0 22176,1 22199,0 22272,1 22324,0 22390,1 22480,0 22567,1 22573,0 22581,1 22609,0 22683,1 22703,0 22738,1 22808,0 22820,1 22886,0 22950,1 23030,0 23072,1 23139,0 23201,1 23208,0 23274,1 23283,0 23323,1 23349,0 23411,1 23458,0 23551,1 23648,0 23733,1 23826,0 23873,1 23959,0 23971,1 24015,0 24036,1 24098,0 24103,1 24145,0 24188,1 24228,0 24266,1 24344,0 24369,1 24441,0 24526,1 24593,0 24681,1 24765,0 24844,1 24882,0 24904,1 24919,0 24944,1 24984,0 25057,1 25063,0 25072,1 25131,0 25137,1 25193,0 25286,1 25369,0 25442,1 25541,0 25591,1 25679,0 25752,1 25761,0 25781,1 25814,0 25876,1 25966,0 26016,1 26115,0 26145,1 26202,0 26281,1 26350,0 26390,1 26397,0 26480,1 26542,0 26632,1 26661,0 26689,1 26690,0 26773,1 26838,0 26839,1 26937,0 26991,1 27013,0 27065,1 27141,0 27204,1 27243,0 27334,1 27409,0 27423,1 27518,0 27539,1 27585,0 27633,1 27703,0 27724,1 27731,0 27732,1 27790,0 27807,1 27882,0 27917,1 27931,0 27990,1 28086,0 28132,1 28210,0 28221,1 28314,0 28351,1 28420,0 28422,1 28433,0 28446,1 28537,0 28598,1 28604,0 28686,1 28690,0 28707,1 28777,0 28806,1 28826,0 28917,1 29010,0 29104,1 29200,0 29238,1 29250,0 29253,1 29271,0 29341,1 29407,0 29430,1 29484,0 29523,1 29545,0 29574,1 29634,0 29655,1 29680,0 29711,1 29783,0 29806,1 29850,0 29892,1 29908,0 29944,1 29963,0 30023,1 30043,0 30044,1 30061,0 30121,1 30127,0 30169,1 30269,0 30285,1 30292,0 30297,1 30358,0 30444,1 30472,0 30495,1 30579,0 30648,1 30652,0 30735,1 30828,0 30903,1 30932,0 31026,1 31041,0 31091,1 31130,0 31150,1 31214,0 31242,1 31266,0 31348,1 31364,0 31381,1 31464,0 31479,1 31568,0 31588,1 31628,0 31671,1 31683,0 31739,1 31809,0 31810,1 31893,0 31912,1 31913,0 31969,1 31970,0 32010,1 32087,0 32096,1 32142,0 32155,1 32235,0 32299,1 32343,0 32375,1 32471,0 32490,1 32491,0 32506,1 32606,0 32706,1 32718,0 32750,1 32844,0 32940,1 32973,0 33069,1 33122,0 33143,1 33199,0 33237,1 33280,0 33380,1 33479,0 33499,1 33519,0 33619,1 33640,0 33698,1 33743,0 33843,1 33883,0 33965,1 34030,0 34083,1 34095,0 34119,1 34178,0 34218,1 34292,0 34345,1 34419,0 34513,1 34558,0 34639,1 34670,0 34768,1 34819,0 34906,1 34962,0 35016,1 35063,0 35084,1 35110,0 35209,1 35237,0 35278,1 35304,0 35305,1 35379,0 35433,1 35456,0 35490,1 35543,0 35556,1 35581,0 35673,1 35706,0 35751,1 35835,0 35885,1 35937,0 35967,1 36039,0 36061,1 36074,0 36103,1 36113,0 36127,1 36210,0 36253,1 36261,0 36290,1 36340,0 36434,1 36515,0 36531,1 36584,0 36642,1 36733,0 36802,1 36841,0 36930,1 37000,0 37088,1 37186,0 37217,1 37264,0 37285,1 37326,0 37354,1 37356,0 37369,1 37454,0 37487,1 37551,0 37589,1 37642,0 37734,1 37824,0 37906,1 37929,0 37965,1 38012,0 38020,1 38095,0 38170,1 38207,0 38303,1 38395,0 38410,1 38429,0 38460,1 38521,0 38604,1 38660,0 38728,1 38742,0 38752,1 38787,0 38818,1 38855,0 38941,1 39018,0 39085,1 39158,0 39244,1 39326,0 39408,1 39457,0 39493,1 39556,0 39606,1 39643,0 39673,1 39719,0 39760,1 39806,0 39859,1 39923,0 40007,1 40030,0 40098,1 40126,0 40190,1 40289,0 40387,1 40429,0 40451,1 40514,0 40578,1 40592,0 40664,1 40701,0 40745,1 40782,0 40882,1 40895,0 40910,1 40954,0 41015,1 41105,0 41175,1 41260,0 41297,1 41308,0 41392,1 41429,0 41527,1 41616,0 41645,1 41676,0 41680,1 41693,0 41782,1 41859,0 41900,1 41962,0 42004,1 42026,0 42090,1 42094,0 42177,1 42214,0 42220,1 42286,0 42386,1 42425,0 42478,1 42550,0 42648,1 42673,0 42744,1 42787,0 42850,1 42942,0 42990,1 42998,0 43047,1 43102,0 43148,1 43248,0 43251,1 43284,0 43292,1 43297,0 43361,1 43425,0 43471,1 43551,0 43572,1 43656,0 43743,1 43825,0 43828,1 43858,0 43893,1 43950,0 44001,1 44010,0 44032,1 44082,0 44115,1 44170,0 44197,1 44288,0 44339,1 44407,0 44496,1 44547,0 44559,1 44619,0 44661,1 44695,0 44754,1 44761,0 44797,1 44805,0 44859,1 44920,0 44937,1 45003,0 45012,1 45043,0 45134,1 45214,0 45243,1 45288,0 45353,1 45449,0 45499,1 45504,0 45593,1 45654,0 45748,1 45807,0 45824,1 45894,0 45971,1 46057,0 46084,1 46096,0 46117,1 46185,0 46265,1 46325,0 46425,1 46432,0 46469,1 46511,0 46565,1 46601,0 46642,1 46651,0 46727,1 46748,0 46844,1 46942,0 47025,1 47071,0 47114,1 47174,0 47204,1 47264,0 47310,1 47311,0 47323,1 47334,0 47403,1 47488,0 47506,1 47509,0 47568,1 47603,0 47663,1 47728,0 47767,1 47827,0 47899,1 47977,0 47980,1 48068,0 48076,1 48080,0 48168,1 48221,0 48240,1 48306,0 48378,1 48465,0 48476,1 48573,0 48610,1 48624,0 48672,1 48726,0 48778,1 48826,0 48861,1 48913,0 48960,1 48986,0 49030,1 49063,0 49087,1 49142,0 49147,1 49178,0 49271,1 49347,0 49394,1 49480,0 49546,1 49643,0 49667,1 49727,0 49728,1 49749,0 49816,1 49868,0 49916,1 49930,0 49941,1 50036,0 50126,1 50226,0 50230,1 50288,0 50375,1 50410,0 50422,1 50426,0 50480,1 50521,0 50587,1 end initlist a8 0,0 65,1 85,0 143,1 178,0 217,1 248,0 251,1 343,0 385,1 399,0 495,1 543,0 594,1 600,0 611,1 691,0 708,1 758,0 842,1 865,0 964,1 973,0 1048,1 1136,0 1147,1 1176,0 1235,1 1300,0 1353,1 1420,0 1457,1 1466,0 1542,1 1609,0 1646,1 1663,0 1742,1 1767,0 1812,1 1905,0 1993,1 2052,0 2109,1 2145,0 2173,1 2270,0 2314,1 2332,0 2380,1 2385,0 2470,1 2511,0 2517,1 2549,0 2603,1 2691,0 2758,1 2797,0 2865,1 2945,0 2982,1 3060,0 3084,1 3169,0 3239,1 3316,0 3404,1 3455,0 3503,1 3515,0 3607,1 3681,0 3756,1 3782,0 3850,1 3934,0 3961,1 3998,0 4082,1 4097,0 4137,1 4217,0 4316,1 4400,0 4415,1 4446,0 4536,1 4564,0 4636,1 4698,0 4777,1 4858,0 4945,1 5014,0 5098,1 5185,0 5200,1 5268,0 5363,1 5448,0 5505,1 5530,0 5611,1 5672,0 5772,1 5872,0 5928,1 5988,0 6029,1 6057,0 6063,1 6083,0 6154,1 6246,0 6278,1 6366,0 6415,1 6510,0 6579,1 6655,0 6680,1 6713,0 6787,1 6822,0 6906,1 6995,0 7086,1 7161,0 7184,1 7266,0 7333,1 7424,0 7443,1 7484,0 7557,1 7604,0 7649,1 7742,0 7764,1 7849,0 7869,1 7967,0 8008,1 8040,0 8081,1 8122,0 8129,1 8188,0 8251,1 8295,0 8331,1 8408,0 8460,1 8473,0 8498,1 8527,0 8597,1 8663,0 8717,1 8811,0 8822,1 8872,0 8929,1 8948,0 8996,1 9074,0 9080,1 9081,0 9143,1 9207,0 9232,1 9257,0 9312,1 9375,0 9441,1 9458,0 9483,1 9508,0 9592,1 9643,0 9644,1 9668,0 9704,1 9753,0 9820,1 9833,0 9842,1 9924,0 9993,1 10020,0 10025,1 10103,0 10107,1 10171,0 10202,1 10297,0 10331,1 10430,0 10501,1 10576,0 10639,1 10701,0 10774,1 10809,0 10908,1 10909,0 10982,1 10994,0 11082,1 11157,0 11192,1 11292,0 11341,1 11377,0 11471,1 11489,0 11548,1 11609,0 11646,1 11676,0 11738,1 11784,0 11802,1 11891,0 11924,1 12012,0 12040,1 12054,0 12090,1 12164,0 12230,1 12293,0 12362,1 12383,0 12452,1 12551,0 12612,1 12613,0 12690,1 12698,0 12720,1 12787,0 12834,1 12913,0 12949,1 12992,0 13085,1 13092,0 13144,1 13192,0 13268,1 13311,0 13388,1 13486,0 13558,1 13598,0 13662,1 13748,0 13807,1 13877,0 13928,1 13980,0 14048,1 14096,0 14141,1 14222,0 14288,1 14322,0 14372,1 14402,0 14415,1 14445,0 14484,1 14541,0 14628,1 14646,0 14668,1 14685,0 14694,1 14751,0 14847,1 14867,0 14965,1 14986,0 15016,1 15069,0 15104,1 15156,0 15178,1 15261,0 15263,1 15340,0 15433,1 15518,0 15597,1 15600,0 15606,1 15664,0 15732,1 15822,0 15905,1 15968,0 16033,1 16113,0 16197,1 16296,0 16386,1 16428,0 16471,1 16523,0 16562,1 16587,0 16620,1 16676,0 16678,1 16693,0 16776,1 16840,0 16847,1 16946,0 17001,1 17036,0 17077,1 17109,0 17165,1 17223,0 17228,1 17320,0 17329,1 17366,0 17412,1 17419,0 17461,1 17504,0 17587,1 17682,0 17689,1 17768,0 17772,1 17845,0 17893,1 17920,0 17999,1 18088,0 18175,1 18254,0 18333,1 18365,0 18413,1 18513,0 18586,1 18668,0 18749,1 18804,0 18897,1 18969,0 19056,1 19138,0 19233,1 19240,0 19245,1 19270,0 19271,1 19347,0 19353,1 19354,0 19392,1 19450,0 19509,1 19539,0 19604,1 19651,0 19723,1 19761,0 19857,1 19897,0 19935,1 19997,0 20042,1 20103,0 20116,1 20184,0 20206,1 20301,0 20384,1 20408,0 20490,1 20555,0 20591,1 20675,0 20691,1 20705,0 20796,1 20812,0 20851,1 20900,0 20916,1 21015,0 21078,1 21098,0 21139,1 21210,0 21244,1 21343,0 21364,1 21430,0 21492,1 21584,0 21604,1 21674,0 21684,1 21767,0 21781,1 21874,0 21943,1 21962,0 22051,1 22119,0 22219,1 22319,0 22340,1 22404,0 22499,1 22541,0 22559,1 22576,0 22672,1 22730,0 22757,1 22798,0 22822,1 22908,0 22983,1 23002,0 23050,1 23113,0 23204,1 23227,0 23298,1 23356,0 23446,1 23529,0 23555,1 23566,0 23591,1 23665,0 23710,1 23715,0 23802,1 23830,0 23849,1 23859,0 23932,1 23985,0 24069,1 24134,0 24226,1 24318,0 24388,1 24473,0 24567,1 24572,0 24661,1 24670,0 24706,1 24739,0 24784,1 24823,0 24911,1 24951,0 24968,1 25023,0 25054,1 25120,0 25188,1 25190,0 25287,1 25385,0 25483,1 25574,0 25617,1 25693,0 25780,1 25876,0 25967,1 25992,0 25998,1 26034,0 26068,1 26133,0 26141,1 26178,0 26210,1 26253,0 26276,1 26313,0 26316,1 26343,0 26346,1 26424,0 26513,1 26537,0 26600,1 26682,0 26716,1 26740,0 26828,1 26830,0 26844,1 26883,0 26936,1 26940,0 26980,1 27023,0 27095,1 27174,0 27247,1 27269,0 27285,1 27308,0 27350,1 27387,0 27485,1 27553,0 27576,1 27672,0 27745,1 27826,0 27892,1 27902,0 27948,1 27971,0 27976,1 28028,0 28091,1 28106,0 28202,1 28295,0 28300,1 28373,0 28376,1 28388,0 28472,1 28565,0 28588,1 28677,0 28773,1 28828,0 28899,1 28932,0 28976,1 29053,0 29054,1 29121,0 29138,1 29156,0 29251,1 29341,0 29433,1 29469,0 29529,1 29629,0 29702,1 29785,0 29870,1 29919,0 30001,1 30078,0 30085,1 30104,0 30178,1 30216,0 30265,1 30271,0 30315,1 30369,0 30445,1 30518,0 30532,1 30619,0 30628,1 30704,0 30757,1 30772,0 30869,1 30930,0 31011,1 31100,0 31139,1 31173,0 31219,1 31228,0 31274,1 31345,0 31391,1 31446,0 31463,1 31558,0 31623,1 31655,0 31714,1 31792,0 31877,1 31890,0 31966,1 32045,0 32062,1 32143,0 32227,1 32304,0 32385,1 32469,0 32497,1 32541,0 32622,1 32661,0 32746,1 32778,0 32834,1 32874,0 32882,1 32885,0 32941,1 32957,0 32984,1 33049,0 33149,1 33226,0 33301,1 33313,0 33316,1 33364,0 33389,1 33468,0 33506,1 33574,0 33603,1 33630,0 33648,1 33659,0 33705,1 33736,0 33803,1 33827,0 33924,1 33975,0 34073,1 34126,0 34182,1 34250,0 34314,1 34335,0 34386,1 34418,0 34451,1 34534,0 34545,1 34580,0 34606,1 34641,0 34702,1 34789,0 34838,1 34922,0 35003,1 35015,0 35070,1 35131,0 35147,1 35165,0 35179,1 35275,0 35342,1 35426,0 35491,1 35564,0 35616,1 35654,0 35695,1 35731,0 35786,1 35845,0 35902,1 35928,0 35957,1 36036,0 36076,1 36080,0 36179,1 36242,0 36303,1 36401,0 36496,1 36569,0 36603,1 36653,0 36742,1 36819,0 36889,1 36894,0 36956,1 36958,0 36959,1 37022,0 37116,1 37196,0 37227,1 37261,0 37355,1 37438,0 37511,1 37608,0 37613,1 37661,0 37748,1 37831,0 37891,1 37900,0 37948,1 37961,0 37991,1 37993,0 38045,1 38049,0 38145,1 38168,0 38200,1 38287,0 38304,1 38354,0 38397,1 38405,0 38424,1 38505,0 38597,1 38610,0 38653,1 38732,0 38763,1 38861,0 38881,1 38955,0 38968,1 39065,0 39145,1 39178,0 39211,1 39274,0 39332,1 39383,0 39408,1 39425,0 39477,1 39572,0 39609,1 39688,0 39702,1 39710,0 39730,1 39750,0 39779,1 39828,0 39891,1 39943,0 40022,1 40078,0 40152,1 40245,0 40305,1 40392,0 40414,1 40445,0 40463,1 40542,0 40637,1 40683,0 40766,1 40855,0 40888,1 40918,0 41010,1 41074,0 41086,1 41120,0 41159,1 41180,0 41275,1 41283,0 41339,1 41396,0 41486,1 41524,0 41535,1 41556,0 41629,1 41666,0 41721,1 41756,0 41824,1 41841,0 41918,1 41944,0 41971,1 42018,0 42101,1 42182,0 42277,1 42346,0 42416,1 42466,0 42539,1 42544,0 42585,1 42667,0 42701,1 42798,0 42842,1 42850,0 42855,1 42886,0 42940,1 43037,0 43099,1 43134,0 43197,1 43228,0 43312,1 43378,0 43439,1 43464,0 43513,1 43574,0 43580,1 43591,0 43644,1 43680,0 43683,1 43699,0 43785,1 43836,0 43918,1 43927,0 44007,1 44080,0 44150,1 44224,0 44225,1 44284,0 44382,1 44465,0 44553,1 44651,0 44685,1 44687,0 44727,1 44816,0 44842,1 44920,0 44929,1 45029,0 45085,1 45155,0 45244,1 45341,0 45361,1 45438,0 45440,1 45507,0 45579,1 45645,0 45710,1 45752,0 45777,1 45846,0 45915,1 45917,0 46013,1 46086,0 46125,1 46191,0 46226,1 46315,0 46366,1 46414,0 46442,1 46485,0 46556,1 46653,0 46737,1 46746,0 46833,1 46876,0 46973,1 47057,0 47106,1 47122,0 47196,1 47202,0 47226,1 47269,0 47333,1 47397,0 47399,1 47453,0 47509,1 47531,0 47628,1 47641,0 47733,1 47758,0 47775,1 47812,0 47888,1 47919,0 47927,1 47972,0 48052,1 48111,0 48165,1 48208,0 48298,1 48359,0 48388,1 48399,0 48442,1 48472,0 48558,1 48633,0 48653,1 48752,0 48817,1 48859,0 48897,1 48946,0 49015,1 49018,0 49034,1 49115,0 49183,1 49235,0 49297,1 49304,0 49400,1 49402,0 49433,1 49530,0 49544,1 49582,0 49588,1 49600,0 49640,1 49676,0 49750,1 49751,0 49797,1 49820,0 49892,1 49978,0 50005,1 50042,0 50099,1 50159,0 50211,1 50212,0 50214,1 50247,0 50333,1 50387,0 50459,1 50483,0 50535,1 50549,0 50606,1 50667,0 50750,1 50803,0 50864,1 50867,0 50939,1 51022,0 51058,1 51133,0 51227,1 51296,0 51367,1 51461,0 51473,1 51546,0 51608,1 51677,0 51723,1 51770,0 51838,1 51854,0 51928,1 52018,0 52028,1 52051,0 52093,1 52102,0 52200,1 end initlist a9 0,0 12,1 59,0 137,1 212,0 217,1 218,0 267,1 326,0 342,1 393,0 474,1 487,0 587,1 628,0 678,1 716,0 781,1 785,0 815,1 883,0 918,1 925,0 1011,1 1018,0 1069,1 1079,0 1108,1 1129,0 1176,1 1224,0 1319,1 1395,0 1400,1 1455,0 1543,1 1635,0 1690,1 1754,0 1794,1 1888,0 1985,1 2058,0 2140,1 2226,0 2245,1 2318,0 2372,1 2452,0 2551,1 2617,0 2636,1 2701,0 2738,1 2755,0 2819,1 2879,0 2959,1 2999,0 3091,1 3173,0 3214,1 3264,0 3357,1 3389,0 3439,1 3449,0 3486,1 3559,0 3581,1 3655,0 3697,1 3761,0 3790,1 3816,0 3825,1 3865,0 3890,1 3940,0 3995,1 4065,0 4091,1 4156,0 4183,1 4281,0 4356,1 4399,0 4499,1 4560,0 4591,1 4598,0 4654,1 4735,0 4774,1 4850,0 4928,1 5014,0 5096,1 5110,0 5122,1 5146,0 5166,1 5179,0 5204,1 5231,0 5289,1 5318,0 5357,1 5395,0 5481,1 5526,0 5594,1 5684,0 5728,1 5793,0 5882,1 5975,0 6059,1 6094,0 6122,1 6209,0 6280,1 6346,0 6385,1 6408,0 6432,1 6488,0 6576,1 6623,0 6709,1 6730,0 6769,1 6788,0 6843,1 6911,0 6975,1 7003,0 7026,1 7057,0 7068,1 7157,0 7199,1 7297,0 7371,1 7411,0 7445,1 7537,0 7541,1 7609,0 7629,1 7643,0 7743,1 7837,0 7873,1 7953,0 8033,1 8104,0 8182,1 8241,0 8246,1 8257,0 8326,1 8357,0 8430,1 8496,0 8520,1 8562,0 8655,1 8662,0 8760,1 8824,0 8918,1 8946,0 8974,1 8985,0 9047,1 9138,0 9146,1 9166,0 9190,1 9198,0 9290,1 9364,0 9378,1 9429,0 9442,1 9447,0 9455,1 9468,0 9565,1 9578,0 9655,1 9672,0 9770,1 9814,0 9822,1 9876,0 9961,1 9964,0 9991,1 10006,0 10023,1 10046,0 10116,1 10152,0 10238,1 10281,0 10324,1 10325,0 10370,1 10413,0 10496,1 10548,0 10635,1 10672,0 10700,1 10797,0 10814,1 10834,0 10890,1 10892,0 10902,1 10946,0 10984,1 11078,0 11132,1 11141,0 11168,1 11199,0 11248,1 11265,0 11348,1 11436,0 11465,1 11474,0 11556,1 11606,0 11610,1 11669,0 11759,1 11822,0 11893,1 11968,0 12057,1 12086,0 12120,1 12148,0 12166,1 12172,0 12197,1 12243,0 12305,1 12310,0 12361,1 12446,0 12521,1 12592,0 12634,1 12665,0 12724,1 12795,0 12832,1 12853,0 12926,1 12975,0 12988,1 13079,0 13089,1 13117,0 13156,1 13225,0 13268,1 13300,0 13322,1 13351,0 13410,1 13417,0 13490,1 13496,0 13502,1 13580,0 13582,1 13597,0 13609,1 13646,0 13687,1 13707,0 13799,1 13880,0 13899,1 13990,0 14084,1 14152,0 14214,1 14292,0 14391,1 14452,0 14487,1 14521,0 14616,1 14623,0 14689,1 14714,0 14763,1 14838,0 14879,1 14905,0 14925,1 14930,0 14985,1 14992,0 15027,1 15052,0 15141,1 15164,0 15240,1 15246,0 15272,1 15358,0 15384,1 15406,0 15488,1 15498,0 15595,1 15613,0 15684,1 15757,0 15766,1 15771,0 15843,1 15891,0 15980,1 16079,0 16098,1 16108,0 16167,1 16266,0 16338,1 16429,0 16481,1 16482,0 16529,1 16583,0 16606,1 16700,0 16777,1 16806,0 16889,1 16923,0 16946,1 16964,0 17012,1 17026,0 17097,1 17123,0 17197,1 17228,0 17246,1 17335,0 17397,1 17413,0 17472,1 17572,0 17647,1 17743,0 17797,1 17876,0 17933,1 17942,0 18029,1 18093,0 18189,1 18200,0 18278,1 18345,0 18397,1 18482,0 18529,1 18578,0 18665,1 18758,0 18779,1 18828,0 18859,1 18878,0 18914,1 18934,0 18983,1 19010,0 19105,1 19131,0 19188,1 19221,0 19241,1 19288,0 19381,1 19389,0 19488,1 19586,0 19646,1 19685,0 19783,1 19794,0 19893,1 19963,0 20036,1 20084,0 20131,1 20230,0 20326,1 20417,0 20492,1 20513,0 20600,1 20647,0 20738,1 20788,0 20798,1 20852,0 20937,1 21002,0 21090,1 21093,0 21161,1 21184,0 21200,1 21236,0 21276,1 21283,0 21315,1 21350,0 21391,1 21403,0 21417,1 21461,0 21496,1 21565,0 21605,1 21669,0 21747,1 21834,0 21858,1 21938,0 22005,1 22052,0 22085,1 22103,0 22203,1 22241,0 22295,1 22351,0 22368,1 22426,0 22427,1 22522,0 22559,1 22562,0 22635,1 22656,0 22735,1 22744,0 22791,1 22832,0 22846,1 22923,0 23002,1 23044,0 23100,1 23106,0 23153,1 23253,0 23314,1 23340,0 23354,1 23380,0 23432,1 23528,0 23612,1 23654,0 23729,1 23732,0 23741,1 23761,0 23792,1 23810,0 23813,1 23875,0 23958,1 24003,0 24039,1 24086,0 24107,1 24163,0 24203,1 24294,0 24356,1 24426,0 24479,1 24560,0 24578,1 24667,0 24711,1 24736,0 24820,1 24915,0 24985,1 25078,0 25103,1 25114,0 25125,1 25192,0 25221,1 25297,0 25309,1 25357,0 25411,1 25493,0 25526,1 25530,0 25598,1 25676,0 25767,1 25818,0 25838,1 25881,0 25974,1 25990,0 26003,1 26062,0 26140,1 26205,0 26243,1 26299,0 26375,1 26383,0 26404,1 26490,0 26537,1 26632,0 26682,1 26728,0 26789,1 26838,0 26850,1 26866,0 26894,1 26906,0 26997,1 27079,0 27117,1 27133,0 27199,1 27269,0 27295,1 27331,0 27365,1 27403,0 27475,1 27562,0 27622,1 27628,0 27709,1 27777,0 27810,1 27852,0 27898,1 27956,0 28040,1 28042,0 28079,1 28081,0 28113,1 28192,0 28240,1 28282,0 28283,1 28373,0 28414,1 28472,0 28542,1 28623,0 28693,1 28760,0 28763,1 28774,0 28827,1 28882,0 28980,1 29033,0 29054,1 29151,0 29186,1 29203,0 29273,1 29343,0 29421,1 29484,0 29549,1 29567,0 29616,1 29715,0 29769,1 29842,0 29855,1 29954,0 30010,1 30041,0 30128,1 30177,0 30233,1 30257,0 30294,1 30352,0 30359,1 30430,0 30431,1 30501,0 30565,1 30630,0 30702,1 30707,0 30787,1 30880,0 30902,1 30909,0 30970,1 30989,0 31041,1 31095,0 31152,1 31224,0 31255,1 31272,0 31342,1 31433,0 31504,1 31510,0 31597,1 31625,0 31637,1 31689,0 31762,1 31770,0 31828,1 31898,0 31941,1 32036,0 32117,1 32180,0 32241,1 32245,0 32344,1 32372,0 32458,1 32461,0 32488,1 32542,0 32641,1 32707,0 32714,1 32731,0 32773,1 32789,0 32822,1 32867,0 32914,1 32955,0 33010,1 33104,0 33129,1 33223,0 33320,1 33323,0 33387,1 33431,0 33503,1 33545,0 33638,1 33692,0 33767,1 33852,0 33862,1 33890,0 33918,1 33993,0 33999,1 34018,0 34098,1 34169,0 34182,1 34224,0 34244,1 34271,0 34351,1 34385,0 34424,1 34509,0 34538,1 34611,0 34623,1 34665,0 34721,1 34762,0 34786,1 34813,0 34832,1 34863,0 34911,1 34964,0 35036,1 35072,0 35077,1 35132,0 35202,1 35269,0 35324,1 35393,0 35445,1 35517,0 35526,1 35584,0 35643,1 35650,0 35719,1 35762,0 35860,1 35903,0 35979,1 36023,0 36046,1 36060,0 36112,1 36195,0 36282,1 36328,0 36341,1 36400,0 36500,1 36567,0 36665,1 36705,0 36799,1 36817,0 36878,1 36910,0 36959,1 37015,0 37048,1 37102,0 37132,1 37188,0 37218,1 37302,0 37307,1 37337,0 37424,1 37508,0 37573,1 37617,0 37650,1 37676,0 37716,1 37790,0 37801,1 37894,0 37925,1 37976,0 38018,1 38098,0 38163,1 38206,0 38293,1 38391,0 38423,1 38446,0 38496,1 38533,0 38567,1 38640,0 38731,1 38812,0 38875,1 38933,0 38948,1 38988,0 39087,1 39140,0 39191,1 39195,0 39256,1 39289,0 39335,1 39390,0 39416,1 39501,0 39549,1 39599,0 39694,1 39770,0 39842,1 39893,0 39989,1 40022,0 40028,1 40035,0 40040,1 40094,0 40136,1 40178,0 40229,1 40278,0 40306,1 40405,0 40460,1 40490,0 40568,1 40590,0 40665,1 40745,0 40790,1 40826,0 40916,1 40950,0 40975,1 41072,0 41131,1 41176,0 41213,1 41223,0 41244,1 41260,0 41273,1 41282,0 41379,1 41426,0 41464,1 41503,0 41538,1 41606,0 41697,1 41779,0 41870,1 41871,0 41884,1 41973,0 42005,1 42064,0 42105,1 42197,0 42249,1 42300,0 42347,1 42382,0 42470,1 42548,0 42616,1 42624,0 42651,1 42748,0 42847,1 42908,0 42946,1 43002,0 43093,1 43147,0 43151,1 43239,0 43329,1 43338,0 43352,1 43393,0 43442,1 43456,0 43525,1 43549,0 43609,1 43700,0 43710,1 43804,0 43814,1 43881,0 43948,1 43989,0 43996,1 44079,0 44150,1 44153,0 44159,1 44245,0 44319,1 44417,0 44439,1 44533,0 44606,1 44663,0 44720,1 44818,0 44870,1 44928,0 44941,1 45039,0 45090,1 45152,0 45210,1 45221,0 45280,1 45284,0 45295,1 45376,0 45433,1 45494,0 45530,1 45609,0 45704,1 45747,0 45785,1 45787,0 45872,1 45889,0 45922,1 45975,0 46009,1 46050,0 46079,1 46118,0 46179,1 46255,0 46257,1 46264,0 46326,1 46403,0 46494,1 46509,0 46539,1 46557,0 46589,1 46591,0 46637,1 46736,0 46831,1 46872,0 46947,1 46985,0 47072,1 47140,0 47147,1 47225,0 47226,1 47253,0 47344,1 47406,0 47481,1 47509,0 47532,1 47592,0 47624,1 47660,0 47676,1 47724,0 47737,1 47738,0 47828,1 47879,0 47902,1 47944,0 47986,1 47999,0 48016,1 48056,0 48123,1 48162,0 48253,1 48328,0 48395,1 48412,0 48417,1 48466,0 48488,1 48580,0 48585,1 48668,0 48720,1 48771,0 48808,1 48850,0 48878,1 48959,0 48984,1 49043,0 49056,1 49155,0 49178,1 49232,0 49312,1 49363,0 49424,1 49433,0 49466,1 49541,0 49589,1 49614,0 49674,1 end initlist a10 0,0 91,1 159,0 180,1 219,0 244,1 312,0 319,1 408,0 478,1 572,0 595,1 654,0 665,1 753,0 794,1 837,0 902,1 977,0 1053,1 1068,0 1100,1 1121,0 1167,1 1262,0 1302,1 1358,0 1415,1 1440,0 1441,1 1514,0 1562,1 1569,0 1611,1 1643,0 1652,1 1732,0 1773,1 1817,0 1886,1 1945,0 1991,1 2051,0 2126,1 2179,0 2263,1 2299,0 2327,1 2343,0 2440,1 2484,0 2556,1 2576,0 2612,1 2654,0 2668,1 2715,0 2725,1 2777,0 2805,1 2856,0 2937,1 3020,0 3118,1 3204,0 3255,1 3302,0 3318,1 3395,0 3449,1 3499,0 3502,1 3600,0 3629,1 3663,0 3707,1 3798,0 3845,1 3873,0 3968,1 4004,0 4064,1 4081,0 4171,1 4226,0 4293,1 4313,0 4378,1 4477,0 4552,1 4637,0 4684,1 4747,0 4813,1 4814,0 4892,1 4903,0 4918,1 4985,0 5047,1 5051,0 5086,1 5183,0 5274,1 5361,0 5379,1 5387,0 5415,1 5424,0 5510,1 5549,0 5643,1 5665,0 5726,1 5779,0 5833,1 5916,0 5973,1 6003,0 6077,1 6150,0 6214,1 6249,0 6275,1 6334,0 6356,1 6445,0 6540,1 6628,0 6639,1 6671,0 6678,1 6733,0 6776,1 6822,0 6857,1 6910,0 6952,1 6982,0 7063,1 7083,0 7169,1 7172,0 7272,1 7342,0 7382,1 7422,0 7521,1 7580,0 7671,1 7749,0 7801,1 7831,0 7902,1 7990,0 8053,1 8130,0 8142,1 8242,0 8297,1 8350,0 8394,1 8482,0 8573,1 8620,0 8658,1 8700,0 8734,1 8834,0 8920,1 8953,0 8954,1 8973,0 9054,1 9068,0 9076,1 9167,0 9197,1 9286,0 9366,1 9368,0 9385,1 9473,0 9478,1 9528,0 9545,1 9584,0 9648,1 9656,0 9732,1 9788,0 9818,1 9850,0 9920,1 9987,0 10057,1 10117,0 10160,1 10233,0 10326,1 10396,0 10438,1 10479,0 10539,1 10563,0 10578,1 10653,0 10679,1 10680,0 10687,1 10700,0 10702,1 10717,0 10734,1 10774,0 10819,1 10908,0 10964,1 10974,0 11030,1 11113,0 11153,1 11226,0 11260,1 11338,0 11375,1 11456,0 11556,1 11617,0 11716,1 11809,0 11811,1 11899,0 11936,1 11938,0 11987,1 11994,0 12060,1 12085,0 12184,1 12206,0 12282,1 12334,0 12352,1 12371,0 12384,1 12385,0 12394,1 12431,0 12521,1 12537,0 12561,1 12633,0 12644,1 12647,0 12713,1 12742,0 12831,1 12921,0 12932,1 12984,0 13059,1 13135,0 13186,1 13246,0 13247,1 13250,0 13335,1 13420,0 13494,1 13497,0 13532,1 13546,0 13605,1 13695,0 13741,1 13781,0 13827,1 13833,0 13860,1 13907,0 13952,1 13987,0 14034,1 14092,0 14104,1 14137,0 14207,1 14258,0 14352,1 14430,0 14464,1 14472,0 14546,1 14583,0 14599,1 14639,0 14649,1 14655,0 14676,1 14761,0 14806,1 14901,0 14959,1 14989,0 15012,1 15023,0 15082,1 15180,0 15247,1 15282,0 15370,1 15442,0 15489,1 15521,0 15566,1 15593,0 15693,1 15786,0 15838,1 15935,0 15963,1 16063,0 16080,1 16121,0 16211,1 16287,0 16357,1 16404,0 16457,1 16531,0 16545,1 16617,0 16668,1 16688,0 16744,1 16842,0 16937,1 16979,0 17079,1 17145,0 17162,1 17198,0 17261,1 17330,0 17377,1 17468,0 17502,1 17530,0 17556,1 17585,0 17605,1 17646,0 17741,1 17782,0 17874,1 17925,0 17981,1 18074,0 18153,1 18225,0 18315,1 18329,0 18333,1 18388,0 18487,1 18579,0 18648,1 18675,0 18704,1 18751,0 18809,1 18826,0 18849,1 18897,0 18929,1 18940,0 19007,1 19094,0 19184,1 19235,0 19307,1 19385,0 19465,1 19515,0 19609,1 19657,0 19692,1 19790,0 19845,1 19878,0 19895,1 19904,0 19936,1 19943,0 19993,1 20041,0 20055,1 20084,0 20151,1 20193,0 20247,1 20347,0 20420,1 20468,0 20536,1 20607,0 20659,1 20725,0 20808,1 20888,0 20905,1 20983,0 21015,1 21023,0 21080,1 21095,0 21114,1 21182,0 21254,1 21326,0 21342,1 21434,0 21496,1 21585,0 21592,1 21653,0 21725,1 21747,0 21819,1 21856,0 21917,1 21951,0 22028,1 22040,0 22050,1 22142,0 22229,1 22258,0 22301,1 22389,0 22416,1 22463,0 22496,1 22545,0 22623,1 22688,0 22756,1 22774,0 22794,1 22855,0 22935,1 23012,0 23078,1 23128,0 23148,1 23193,0 23240,1 23286,0 23344,1 23444,0 23505,1 23535,0 23550,1 23605,0 23674,1 23709,0 23759,1 23760,0 23794,1 23882,0 23891,1 23958,0 23997,1 24026,0 24074,1 24170,0 24230,1 24316,0 24337,1 24409,0 24492,1 24515,0 24551,1 24563,0 24645,1 24729,0 24749,1 24810,0 24879,1 24935,0 25006,1 25052,0 25139,1 25180,0 25265,1 25276,0 25376,1 25395,0 25447,1 25473,0 25549,1 25611,0 25687,1 25688,0 25708,1 25727,0 25799,1 25802,0 25895,1 25904,0 25975,1 26058,0 26131,1 26211,0 26271,1 26344,0 26428,1 26515,0 26557,1 26628,0 26699,1 26747,0 26766,1 26865,0 26965,1 27027,0 27083,1 27095,0 27156,1 27210,0 27256,1 27316,0 27376,1 27452,0 27523,1 27541,0 27587,1 27655,0 27662,1 27692,0 27773,1 27832,0 27924,1 28016,0 28023,1 28116,0 28119,1 28159,0 28197,1 28272,0 28294,1 28324,0 28346,1 28361,0 28391,1 28394,0 28477,1 28547,0 28563,1 28579,0 28609,1 28662,0 28742,1 28824,0 28923,1 28940,0 28949,1 28975,0 29061,1 29095,0 29166,1 29219,0 29249,1 29278,0 29294,1 29337,0 29415,1 29449,0 29482,1 29580,0 29676,1 29684,0 29762,1 29800,0 29867,1 29897,0 29988,1 30067,0 30113,1 30199,0 30218,1 30245,0 30284,1 30313,0 30413,1 30477,0 30522,1 30560,0 30588,1 30597,0 30670,1 30707,0 30713,1 30795,0 30884,1 30915,0 30997,1 31013,0 31023,1 31096,0 31161,1 31200,0 31245,1 31329,0 31348,1 31388,0 31416,1 31441,0 31528,1 31617,0 31702,1 31727,0 31812,1 31903,0 31969,1 31979,0 32078,1 32157,0 32222,1 32283,0 32316,1 32369,0 32450,1 32520,0 32540,1 32631,0 32722,1 32774,0 32830,1 32834,0 32907,1 32940,0 33027,1 33116,0 33216,1 33271,0 33352,1 33424,0 33448,1 33491,0 33499,1 33547,0 33599,1 33674,0 33770,1 33817,0 33858,1 33904,0 33984,1 34052,0 34064,1 34082,0 34162,1 34183,0 34240,1 34249,0 34261,1 34280,0 34292,1 34361,0 34421,1 34467,0 34487,1 34551,0 34581,1 34610,0 34703,1 34724,0 34755,1 34847,0 34921,1 34946,0 34999,1 35029,0 35116,1 35175,0 35201,1 35271,0 35345,1 35402,0 35500,1 35515,0 35523,1 35524,0 35598,1 35646,0 35707,1 35792,0 35819,1 35910,0 35945,1 36024,0 36087,1 36185,0 36273,1 36355,0 36396,1 36430,0 36449,1 36487,0 36499,1 36545,0 36578,1 36644,0 36645,1 36661,0 36720,1 36761,0 36821,1 36896,0 36989,1 37065,0 37085,1 37161,0 37261,1 37312,0 37326,1 37426,0 37479,1 37526,0 37626,1 37636,0 37675,1 37756,0 37852,1 37926,0 37946,1 37960,0 38049,1 38053,0 38126,1 38129,0 38183,1 38210,0 38213,1 38227,0 38316,1 38351,0 38423,1 38429,0 38487,1 38499,0 38510,1 38534,0 38583,1 38600,0 38647,1 38693,0 38730,1 38769,0 38867,1 38956,0 38984,1 39044,0 39119,1 39196,0 39222,1 39237,0 39286,1 39316,0 39395,1 39420,0 39458,1 39517,0 39533,1 39602,0 39680,1 39709,0 39751,1 39806,0 39882,1 39967,0 39969,1 39986,0 40079,1 40162,0 40243,1 40247,0 40325,1 40366,0 40383,1 40441,0 40451,1 40530,0 40559,1 40651,0 40736,1 40759,0 40797,1 40830,0 40840,1 40908,0 40913,1 40915,0 40991,1 41069,0 41074,1 41103,0 41173,1 41263,0 41281,1 41342,0 41390,1 41441,0 41527,1 41587,0 41653,1 41664,0 41689,1 41699,0 41766,1 41862,0 41931,1 41958,0 41975,1 42008,0 42038,1 42050,0 42149,1 42247,0 42341,1 42417,0 42423,1 42462,0 42562,1 42603,0 42664,1 42720,0 42740,1 42747,0 42805,1 42866,0 42877,1 42958,0 43036,1 43104,0 43202,1 43250,0 43269,1 43311,0 43350,1 43414,0 43506,1 43568,0 43668,1 43765,0 43834,1 43839,0 43883,1 43939,0 44013,1 44041,0 44141,1 44216,0 44219,1 44268,0 44302,1 44395,0 44412,1 44502,0 44579,1 44636,0 44662,1 44667,0 44722,1 44729,0 44744,1 44751,0 44783,1 44806,0 44849,1 44880,0 44932,1 44952,0 44968,1 45024,0 45085,1 45110,0 45168,1 45189,0 45261,1 45331,0 45346,1 45367,0 45400,1 45416,0 45501,1 45576,0 45577,1 45625,0 45626,1 45700,0 45756,1 45782,0 45808,1 45869,0 45965,1 46024,0 46059,1 46069,0 46070,1 46084,0 46153,1 46245,0 46335,1 46408,0 46440,1 46526,0 46583,1 46640,0 46730,1 46753,0 46853,1 46917,0 46957,1 47018,0 47110,1 47187,0 47222,1 47292,0 47355,1 47452,0 47538,1 47599,0 47629,1 47728,0 47749,1 47804,0 47869,1 47907,0 47960,1 47991,0 48072,1 48160,0 48207,1 48277,0 48360,1 48450,0 48496,1 48572,0 48628,1 48649,0 48713,1 48771,0 48786,1 48876,0 48897,1 48913,0 48919,1 48925,0 48996,1 49022,0 49101,1 49133,0 49226,1 49285,0 49301,1 49360,0 49423,1 49517,0 49528,1 49565,0 49630,1 49646,0 49698,1 49750,0 49765,1 49776,0 49867,1 49957,0 49979,1 50012,0 50059,1 50150,0 50154,1 50236,0 50253,1 50335,0 50404,1 50502,0 50562,1 50624,0 50637,1 50696,0 50778,1 50805,0 50825,1 50917,0 50922,1 50977,0 51018,1 end initlist a11 0,0 82,1 128,0 154,1 190,0 252,1 319,0 372,1 386,0 458,1 552,0 587,1 648,0 664,1 667,0 726,1 823,0 831,1 885,0 902,1 905,0 946,1 1032,0 1119,1 1127,0 1178,1 1238,0 1286,1 1311,0 1393,1 1414,0 1511,1 1582,0 1598,1 1638,0 1641,1 1650,0 1670,1 1694,0 1727,1 1819,0 1835,1 1852,0 1928,1 1969,0 2018,1 2115,0 2182,1 2268,0 2329,1 2381,0 2430,1 2483,0 2516,1 2580,0 2635,1 2711,0 2731,1 2801,0 2853,1 2953,0 2960,1 3014,0 3055,1 3113,0 3128,1 3163,0 3183,1 3256,0 3331,1 3399,0 3481,1 3536,0 3594,1 3601,0 3609,1 3707,0 3740,1 3758,0 3815,1 3885,0 3975,1 4035,0 4090,1 4145,0 4202,1 4293,0 4332,1 4358,0 4402,1 4460,0 4465,1 4468,0 4548,1 4572,0 4585,1 4676,0 4695,1 4702,0 4769,1 4805,0 4868,1 4954,0 4992,1 4998,0 5088,1 5138,0 5216,1 5278,0 5283,1 5320,0 5406,1 5463,0 5536,1 5539,0 5598,1 5671,0 5674,1 5741,0 5803,1 5889,0 5900,1 5916,0 6009,1 6088,0 6089,1 6101,0 6121,1 6139,0 6164,1 6207,0 6248,1 6320,0 6394,1 6436,0 6529,1 6559,0 6617,1 6657,0 6660,1 6695,0 6790,1 6870,0 6911,1 6929,0 7020,1 7061,0 7130,1 7152,0 7222,1 7261,0 7328,1 7428,0 7457,1 7504,0 7567,1 7606,0 7635,1 7669,0 7768,1 7817,0 7917,1 7990,0 8056,1 8123,0 8212,1 8307,0 8355,1 8425,0 8450,1 8536,0 8578,1 8602,0 8630,1 8681,0 8718,1 8726,0 8816,1 8851,0 8934,1 8943,0 8992,1 9056,0 9124,1 9172,0 9225,1 9284,0 9320,1 9349,0 9378,1 9454,0 9509,1 9554,0 9569,1 9580,0 9583,1 9615,0 9715,1 9787,0 9852,1 9896,0 9972,1 10050,0 10126,1 10145,0 10169,1 10220,0 10227,1 10306,0 10315,1 10345,0 10361,1 10438,0 10536,1 10571,0 10591,1 10617,0 10697,1 10769,0 10837,1 10894,0 10933,1 10999,0 11036,1 11061,0 11127,1 11182,0 11184,1 11212,0 11281,1 11289,0 11362,1 11424,0 11433,1 11508,0 11552,1 11574,0 11623,1 11685,0 11756,1 11810,0 11811,1 11841,0 11939,1 12011,0 12102,1 12125,0 12194,1 12243,0 12303,1 12358,0 12433,1 12447,0 12459,1 12480,0 12577,1 12648,0 12669,1 12762,0 12817,1 12867,0 12934,1 12983,0 13055,1 13126,0 13203,1 13275,0 13364,1 13386,0 13442,1 13459,0 13467,1 13476,0 13493,1 13496,0 13585,1 13595,0 13660,1 13741,0 13769,1 13791,0 13857,1 13931,0 13935,1 13972,0 14046,1 14061,0 14154,1 14199,0 14245,1 14315,0 14405,1 14432,0 14483,1 14508,0 14599,1 14610,0 14623,1 14699,0 14753,1 14777,0 14859,1 14895,0 14991,1 14995,0 15081,1 15148,0 15206,1 15270,0 15305,1 15366,0 15389,1 15413,0 15507,1 15578,0 15656,1 15746,0 15813,1 15849,0 15929,1 16027,0 16083,1 16144,0 16198,1 16269,0 16292,1 16366,0 16406,1 16504,0 16604,1 16668,0 16758,1 16778,0 16810,1 16866,0 16930,1 16952,0 17005,1 17019,0 17115,1 17168,0 17184,1 17188,0 17257,1 17318,0 17333,1 17382,0 17453,1 17522,0 17619,1 17674,0 17706,1 17709,0 17756,1 17762,0 17811,1 17868,0 17897,1 17950,0 17972,1 17981,0 18008,1 18057,0 18077,1 18094,0 18117,1 18132,0 18138,1 18204,0 18225,1 18240,0 18318,1 18376,0 18379,1 18414,0 18438,1 18482,0 18533,1 18631,0 18708,1 18738,0 18809,1 18897,0 18957,1 19030,0 19091,1 19135,0 19191,1 19235,0 19271,1 19355,0 19389,1 19392,0 19487,1 19519,0 19525,1 19526,0 19538,1 19574,0 19579,1 19631,0 19670,1 19729,0 19791,1 19817,0 19879,1 19904,0 19961,1 19983,0 19996,1 20017,0 20108,1 20152,0 20195,1 20262,0 20325,1 20329,0 20349,1 20366,0 20371,1 20394,0 20442,1 20539,0 20566,1 20607,0 20611,1 20671,0 20750,1 20819,0 20899,1 20968,0 20995,1 21065,0 21071,1 21141,0 21189,1 21200,0 21285,1 21356,0 21365,1 21405,0 21466,1 21563,0 21652,1 21722,0 21762,1 21769,0 21836,1 21837,0 21934,1 22010,0 22048,1 22065,0 22072,1 22077,0 22141,1 22187,0 22274,1 22339,0 22405,1 22495,0 22508,1 22536,0 22560,1 22599,0 22617,1 22684,0 22738,1 22742,0 22788,1 22823,0 22882,1 22950,0 22970,1 23022,0 23054,1 23116,0 23125,1 23209,0 23216,1 23249,0 23309,1 23352,0 23373,1 23466,0 23490,1 23565,0 23590,1 23640,0 23676,1 23696,0 23784,1 23813,0 23836,1 23917,0 24012,1 24034,0 24054,1 24152,0 24224,1 24317,0 24341,1 24345,0 24430,1 24467,0 24491,1 24554,0 24607,1 24693,0 24729,1 24829,0 24916,1 24987,0 25035,1 25123,0 25165,1 25211,0 25213,1 25246,0 25265,1 25361,0 25423,1 25485,0 25534,1 25544,0 25619,1 25670,0 25740,1 25785,0 25806,1 25818,0 25848,1 25865,0 25899,1 25905,0 25938,1 25990,0 26005,1 26074,0 26145,1 26219,0 26301,1 26370,0 26461,1 26511,0 26535,1 26591,0 26651,1 26726,0 26817,1 26878,0 26918,1 26936,0 26990,1 27035,0 27127,1 27167,0 27225,1 27277,0 27327,1 27401,0 27497,1 27512,0 27545,1 27593,0 27608,1 27660,0 27738,1 27759,0 27824,1 27842,0 27940,1 28031,0 28033,1 28119,0 28185,1 28202,0 28260,1 28270,0 28315,1 28356,0 28375,1 28408,0 28435,1 28511,0 28589,1 28641,0 28700,1 28760,0 28810,1 28854,0 28913,1 29003,0 29062,1 29115,0 29132,1 29200,0 29233,1 29260,0 29354,1 29399,0 29462,1 29481,0 29546,1 29583,0 29660,1 29676,0 29738,1 29746,0 29831,1 29858,0 29920,1 29940,0 30017,1 30060,0 30134,1 30211,0 30268,1 30308,0 30311,1 30390,0 30424,1 30452,0 30518,1 30547,0 30573,1 30661,0 30739,1 30814,0 30853,1 30867,0 30881,1 30916,0 30931,1 30960,0 30997,1 31056,0 31077,1 31139,0 31180,1 31280,0 31375,1 31380,0 31432,1 31459,0 31527,1 31595,0 31633,1 31671,0 31679,1 31724,0 31742,1 31759,0 31773,1 31827,0 31836,1 31852,0 31891,1 31987,0 31999,1 32080,0 32116,1 32178,0 32182,1 32270,0 32283,1 32331,0 32388,1 32393,0 32405,1 32473,0 32510,1 32610,0 32708,1 32733,0 32786,1 32834,0 32838,1 32861,0 32863,1 32909,0 32966,1 32979,0 32991,1 33025,0 33092,1 33156,0 33251,1 33315,0 33404,1 33464,0 33498,1 33538,0 33552,1 33642,0 33662,1 33751,0 33769,1 33816,0 33893,1 33969,0 34064,1 34149,0 34246,1 34256,0 34281,1 34306,0 34325,1 34359,0 34444,1 34499,0 34532,1 34589,0 34688,1 34692,0 34787,1 34859,0 34867,1 34925,0 34927,1 35000,0 35100,1 35184,0 35190,1 35259,0 35343,1 35377,0 35463,1 35534,0 35546,1 35551,0 35559,1 35596,0 35599,1 35675,0 35739,1 35763,0 35861,1 35893,0 35971,1 35973,0 35980,1 36005,0 36098,1 36186,0 36240,1 36248,0 36272,1 36357,0 36446,1 36542,0 36589,1 36672,0 36677,1 36678,0 36723,1 36727,0 36806,1 36833,0 36884,1 36888,0 36949,1 37026,0 37094,1 37105,0 37161,1 37250,0 37295,1 37298,0 37331,1 37428,0 37520,1 37529,0 37596,1 37631,0 37686,1 37740,0 37797,1 37840,0 37888,1 37968,0 37971,1 37979,0 38051,1 38086,0 38171,1 38181,0 38219,1 38254,0 38317,1 38349,0 38415,1 38455,0 38506,1 38578,0 38626,1 38663,0 38744,1 38810,0 38829,1 38910,0 38933,1 39027,0 39082,1 39105,0 39191,1 39229,0 39286,1 39381,0 39423,1 39488,0 39508,1 39541,0 39571,1 39625,0 39709,1 39797,0 39808,1 39897,0 39933,1 40020,0 40117,1 40210,0 40253,1 40334,0 40367,1 40434,0 40500,1 40516,0 40615,1 40634,0 40664,1 40718,0 40767,1 40793,0 40878,1 40940,0 40975,1 41062,0 41134,1 41180,0 41246,1 41298,0 41300,1 41342,0 41429,1 41521,0 41538,1 41575,0 41605,1 41662,0 41728,1 41812,0 41832,1 41882,0 41917,1 41936,0 41972,1 41991,0 42045,1 42057,0 42100,1 42143,0 42166,1 42259,0 42322,1 42409,0 42471,1 42522,0 42601,1 42682,0 42697,1 42698,0 42726,1 42735,0 42775,1 42809,0 42825,1 42914,0 42962,1 43049,0 43116,1 43120,0 43122,1 43169,0 43253,1 43324,0 43416,1 43501,0 43503,1 43530,0 43552,1 43603,0 43641,1 43736,0 43797,1 43839,0 43851,1 43884,0 43948,1 43973,0 43991,1 44036,0 44095,1 44112,0 44132,1 44174,0 44214,1 44226,0 44305,1 44342,0 44377,1 44413,0 44487,1 44549,0 44622,1 44701,0 44705,1 44747,0 44789,1 44860,0 44937,1 45020,0 45078,1 45141,0 45157,1 45170,0 45256,1 45302,0 45330,1 45343,0 45383,1 45440,0 45498,1 45594,0 45691,1 45704,0 45788,1 45845,0 45940,1 46010,0 46105,1 46134,0 46143,1 46153,0 46235,1 46293,0 46313,1 46403,0 46466,1 46547,0 46598,1 46665,0 46691,1 46763,0 46768,1 46800,0 46890,1 46989,0 47054,1 47108,0 47161,1 47167,0 47245,1 47287,0 47352,1 47409,0 47415,1 47427,0 47516,1 47537,0 47569,1 47595,0 47668,1 47690,0 47775,1 47776,0 47785,1 47786,0 47876,1 47880,0 47913,1 47920,0 47925,1 47996,0 48007,1 48077,0 48151,1 48240,0 48299,1 48335,0 48409,1 48470,0 48515,1 48534,0 48560,1 48650,0 48707,1 48763,0 48824,1 48897,0 48920,1 end initlist a12 0,0 56,1 58,0 100,1 193,0 257,1 294,0 361,1 430,0 479,1 567,0 571,1 619,0 648,1 714,0 718,1 801,0 885,1 922,0 926,1 1008,0 1093,1 1163,0 1181,1 1185,0 1274,1 1369,0 1455,1 1535,0 1598,1 1649,0 1715,1 1719,0 1809,1 1891,0 1946,1 2039,0 2059,1 2135,0 2161,1 2200,0 2210,1 2259,0 2322,1 2413,0 2512,1 2569,0 2581,1 2625,0 2714,1 2764,0 2795,1 2872,0 2970,1 2972,0 3058,1 3143,0 3189,1 3202,0 3258,1 3275,0 3291,1 3332,0 3374,1 3473,0 3515,1 3556,0 3644,1 3731,0 3777,1 3783,0 3803,1 3825,0 3856,1 3943,0 3958,1 4001,0 4077,1 4098,0 4161,1 4185,0 4195,1 4257,0 4301,1 4388,0 4408,1 4416,0 4475,1 4509,0 4594,1 4668,0 4765,1 4849,0 4942,1 4982,0 5027,1 5100,0 5167,1 5263,0 5350,1 5443,0 5514,1 5591,0 5659,1 5732,0 5747,1 5801,0 5803,1 5840,0 5899,1 5903,0 5937,1 5958,0 5960,1 6010,0 6040,1 6113,0 6124,1 6177,0 6197,1 6203,0 6296,1 6322,0 6342,1 6403,0 6470,1 6486,0 6497,1 6529,0 6557,1 6602,0 6627,1 6632,0 6657,1 6672,0 6757,1 6777,0 6798,1 6871,0 6944,1 7020,0 7053,1 7071,0 7166,1 7226,0 7300,1 7340,0 7418,1 7495,0 7540,1 7588,0 7670,1 7677,0 7766,1 7827,0 7875,1 7877,0 7879,1 7891,0 7913,1 7926,0 7963,1 8049,0 8084,1 8145,0 8218,1 8272,0 8279,1 8321,0 8323,1 8412,0 8464,1 8520,0 8598,1 8619,0 8696,1 8714,0 8721,1 8778,0 8791,1 8802,0 8840,1 8859,0 8910,1 8933,0 8950,1 8988,0 9022,1 9113,0 9150,1 9161,0 9197,1 9253,0 9266,1 9275,0 9290,1 9349,0 9350,1 9389,0 9446,1 9499,0 9520,1 9609,0 9667,1 9720,0 9810,1 9892,0 9939,1 10003,0 10025,1 10084,0 10120,1 10131,0 10188,1 10238,0 10315,1 10381,0 10430,1 10440,0 10472,1 10544,0 10559,1 10563,0 10637,1 10658,0 10678,1 10765,0 10825,1 10893,0 10894,1 10928,0 10966,1 11001,0 11005,1 11044,0 11045,1 11065,0 11141,1 11203,0 11261,1 11324,0 11364,1 11365,0 11371,1 11390,0 11435,1 11509,0 11539,1 11549,0 11599,1 11692,0 11778,1 11794,0 11890,1 11901,0 11994,1 12091,0 12107,1 12130,0 12191,1 12282,0 12292,1 12293,0 12353,1 12431,0 12504,1 12602,0 12618,1 12655,0 12708,1 12790,0 12799,1 12801,0 12889,1 12969,0 12993,1 13031,0 13063,1 13109,0 13163,1 13208,0 13252,1 13275,0 13352,1 13432,0 13443,1 13533,0 13536,1 13588,0 13664,1 13672,0 13707,1 13729,0 13779,1 13866,0 13951,1 14022,0 14038,1 14078,0 14168,1 14251,0 14267,1 14271,0 14350,1 14427,0 14431,1 14445,0 14513,1 14517,0 14588,1 14648,0 14709,1 14728,0 14774,1 14842,0 14924,1 15017,0 15023,1 15036,0 15108,1 15179,0 15218,1 15252,0 15274,1 15325,0 15348,1 15421,0 15443,1 15541,0 15574,1 15629,0 15644,1 15697,0 15719,1 15811,0 15885,1 15980,0 16064,1 16065,0 16087,1 16121,0 16171,1 16216,0 16311,1 16313,0 16408,1 16430,0 16520,1 16546,0 16570,1 16602,0 16686,1 16725,0 16748,1 16755,0 16772,1 16837,0 16840,1 16883,0 16914,1 17000,0 17029,1 17090,0 17125,1 17223,0 17257,1 17264,0 17313,1 17360,0 17386,1 17395,0 17451,1 17550,0 17581,1 17591,0 17618,1 17647,0 17697,1 17752,0 17794,1 17801,0 17880,1 17976,0 18055,1 18066,0 18121,1 18152,0 18210,1 18310,0 18394,1 18397,0 18474,1 18535,0 18607,1 18698,0 18726,1 18742,0 18828,1 18890,0 18925,1 19019,0 19039,1 19090,0 19098,1 19157,0 19224,1 19290,0 19328,1 19405,0 19499,1 19545,0 19560,1 19566,0 19634,1 19706,0 19745,1 19773,0 19859,1 19942,0 20000,1 20085,0 20111,1 20138,0 20229,1 20279,0 20280,1 20377,0 20447,1 20506,0 20508,1 20520,0 20565,1 20581,0 20615,1 20700,0 20708,1 20742,0 20784,1 20876,0 20901,1 20915,0 21007,1 21076,0 21109,1 21178,0 21249,1 21263,0 21336,1 21352,0 21364,1 21420,0 21514,1 21550,0 21610,1 21667,0 21756,1 21848,0 21852,1 21876,0 21918,1 22009,0 22052,1 22073,0 22168,1 22256,0 22300,1 22305,0 22313,1 22349,0 22445,1 22534,0 22620,1 22699,0 22764,1 22831,0 22858,1 22882,0 22976,1 23011,0 23042,1 23081,0 23154,1 23157,0 23189,1 23241,0 23327,1 23347,0 23440,1 23444,0 23483,1 23484,0 23503,1 23571,0 23578,1 23624,0 23710,1 23714,0 23776,1 23830,0 23886,1 23917,0 23985,1 24056,0 24099,1 24142,0 24153,1 24228,0 24244,1 24278,0 24375,1 24398,0 24425,1 24451,0 24525,1 24563,0 24580,1 24626,0 24653,1 24655,0 24661,1 24705,0 24739,1 24742,0 24836,1 24903,0 24952,1 24959,0 24972,1 25009,0 25018,1 25043,0 25114,1 25179,0 25202,1 25242,0 25278,1 25372,0 25418,1 25453,0 25497,1 25523,0 25589,1 25655,0 25745,1 25801,0 25871,1 25919,0 26011,1 26099,0 26191,1 26236,0 26331,1 26365,0 26383,1 26414,0 26507,1 26537,0 26602,1 26673,0 26708,1 26758,0 26839,1 26933,0 26997,1 27021,0 27121,1 27129,0 27181,1 27184,0 27279,1 27331,0 27359,1 27415,0 27486,1 27506,0 27520,1 27542,0 27622,1 27676,0 27766,1 27847,0 27921,1 28019,0 28048,1 28127,0 28167,1 28233,0 28257,1 28322,0 28411,1 28431,0 28498,1 28527,0 28593,1 28621,0 28684,1 28737,0 28779,1 28874,0 28910,1 28930,0 29025,1 29076,0 29145,1 29210,0 29274,1 29359,0 29415,1 29455,0 29520,1 29606,0 29655,1 29704,0 29772,1 29854,0 29873,1 29924,0 29941,1 29971,0 29981,1 30045,0 30099,1 30141,0 30175,1 30258,0 30309,1 30341,0 30425,1 30431,0 30482,1 30558,0 30582,1 30626,0 30680,1 30751,0 30829,1 30889,0 30959,1 30981,0 30995,1 31046,0 31077,1 31089,0 31188,1 31247,0 31277,1 31303,0 31322,1 31389,0 31457,1 31490,0 31554,1 31621,0 31692,1 31787,0 31836,1 31894,0 31974,1 32049,0 32147,1 32217,0 32235,1 32245,0 32311,1 32337,0 32358,1 32416,0 32469,1 32555,0 32566,1 32642,0 32699,1 32762,0 32859,1 32931,0 33008,1 33055,0 33097,1 33100,0 33120,1 33138,0 33219,1 33241,0 33282,1 33335,0 33404,1 33504,0 33556,1 33571,0 33572,1 33618,0 33669,1 33767,0 33850,1 33854,0 33929,1 33979,0 33992,1 33993,0 34073,1 34109,0 34135,1 34189,0 34237,1 34315,0 34411,1 34478,0 34493,1 34585,0 34612,1 34650,0 34668,1 34685,0 34747,1 34762,0 34802,1 34873,0 34924,1 34932,0 35007,1 35039,0 35109,1 35201,0 35282,1 35316,0 35389,1 35465,0 35514,1 35552,0 35599,1 35660,0 35744,1 35779,0 35805,1 35896,0 35898,1 35972,0 36000,1 36065,0 36111,1 36193,0 36261,1 36292,0 36359,1 36440,0 36456,1 36497,0 36576,1 36580,0 36593,1 36682,0 36747,1 36807,0 36843,1 36935,0 37021,1 37064,0 37123,1 37165,0 37203,1 37242,0 37278,1 37323,0 37324,1 37393,0 37434,1 37511,0 37555,1 37614,0 37667,1 37717,0 37809,1 37845,0 37922,1 37952,0 37954,1 37985,0 38001,1 38058,0 38071,1 38141,0 38219,1 38222,0 38254,1 38260,0 38342,1 38349,0 38434,1 38456,0 38458,1 38460,0 38536,1 38580,0 38668,1 38743,0 38747,1 38842,0 38846,1 38930,0 38935,1 39020,0 39061,1 39145,0 39216,1 39228,0 39296,1 39329,0 39389,1 39429,0 39526,1 39607,0 39644,1 39692,0 39791,1 39883,0 39944,1 40020,0 40081,1 40144,0 40180,1 40210,0 40223,1 40280,0 40335,1 40417,0 40483,1 40579,0 40620,1 40703,0 40730,1 40762,0 40776,1 40816,0 40865,1 40895,0 40976,1 41048,0 41126,1 41166,0 41222,1 41303,0 41347,1 41443,0 41472,1 41530,0 41596,1 41641,0 41682,1 41717,0 41790,1 41808,0 41856,1 41951,0 41955,1 41973,0 42043,1 42080,0 42137,1 42226,0 42270,1 42319,0 42335,1 42408,0 42438,1 42523,0 42589,1 42662,0 42762,1 42800,0 42898,1 42925,0 42994,1 43032,0 43039,1 43111,0 43180,1 43230,0 43320,1 43417,0 43484,1 43520,0 43562,1 43623,0 43661,1 43697,0 43750,1 43800,0 43898,1 43951,0 44049,1 44065,0 44098,1 44115,0 44187,1 44197,0 44266,1 44351,0 44433,1 44435,0 44509,1 44609,0 44654,1 44729,0 44804,1 44815,0 44907,1 44962,0 44970,1 45028,0 45119,1 45213,0 45263,1 45323,0 45357,1 45443,0 45542,1 45605,0 45657,1 45665,0 45726,1 45790,0 45795,1 45863,0 45958,1 46025,0 46063,1 46086,0 46155,1 46232,0 46256,1 46259,0 46272,1 46291,0 46337,1 46356,0 46450,1 46529,0 46533,1 46615,0 46629,1 46684,0 46739,1 46828,0 46832,1 46856,0 46935,1 46943,0 46944,1 47043,0 47126,1 47128,0 47137,1 47235,0 47308,1 47356,0 47425,1 47447,0 47477,1 47525,0 47578,1 47605,0 47619,1 47715,0 47788,1 47862,0 47930,1 47987,0 48073,1 48140,0 48193,1 48246,0 48299,1 48378,0 48387,1 48399,0 48446,1 48454,0 48482,1 48532,0 48538,1 48605,0 48676,1 48739,0 48836,1 48854,0 48925,1 48989,0 49081,1 49094,0 49100,1 49150,0 49183,1 49221,0 49223,1 49317,0 49372,1 49385,0 49434,1 49503,0 49557,1 49622,0 49631,1 end initlist a13 0,0 39,1 106,0 161,1 213,0 276,1 341,0 387,1 403,0 473,1 493,0 504,1 561,0 596,1 671,0 705,1 805,0 849,1 905,0 991,1 1025,0 1076,1 1078,0 1116,1 1125,0 1133,1 1214,0 1261,1 1349,0 1351,1 1354,0 1404,1 1431,0 1474,1 1551,0 1645,1 1653,0 1740,1 1744,0 1774,1 1834,0 1900,1 1950,0 2032,1 2091,0 2154,1 2229,0 2276,1 2342,0 2410,1 2440,0 2525,1 2613,0 2673,1 2751,0 2763,1 2816,0 2878,1 2969,0 3009,1 3041,0 3112,1 3114,0 3178,1 3196,0 3284,1 3361,0 3443,1 3483,0 3548,1 3566,0 3649,1 3714,0 3728,1 3738,0 3780,1 3830,0 3842,1 3858,0 3928,1 4026,0 4050,1 4140,0 4220,1 4261,0 4303,1 4332,0 4364,1 4452,0 4519,1 4538,0 4590,1 4601,0 4616,1 4617,0 4711,1 4802,0 4879,1 4946,0 4992,1 5070,0 5158,1 5201,0 5253,1 5319,0 5400,1 5423,0 5478,1 5497,0 5579,1 5675,0 5757,1 5842,0 5918,1 5925,0 5997,1 6091,0 6096,1 6148,0 6165,1 6181,0 6275,1 6361,0 6433,1 6517,0 6590,1 6649,0 6651,1 6691,0 6753,1 6819,0 6840,1 6852,0 6907,1 6942,0 6997,1 7064,0 7149,1 7221,0 7302,1 7360,0 7413,1 7424,0 7477,1 7544,0 7602,1 7659,0 7694,1 7788,0 7813,1 7848,0 7940,1 7960,0 7975,1 8046,0 8048,1 8078,0 8095,1 8111,0 8179,1 8184,0 8278,1 8344,0 8422,1 8426,0 8467,1 8492,0 8552,1 8583,0 8599,1 8652,0 8713,1 8735,0 8756,1 8807,0 8812,1 8846,0 8929,1 9011,0 9055,1 9153,0 9223,1 9290,0 9376,1 9442,0 9483,1 9491,0 9534,1 9580,0 9585,1 9666,0 9741,1 9808,0 9891,1 9965,0 10025,1 10079,0 10178,1 10223,0 10238,1 10301,0 10312,1 10385,0 10394,1 10418,0 10494,1 10531,0 10575,1 10660,0 10734,1 10799,0 10837,1 10850,0 10938,1 10979,0 10998,1 11028,0 11049,1 11098,0 11115,1 11204,0 11295,1 11364,0 11371,1 11405,0 11438,1 11519,0 11604,1 11697,0 11728,1 11796,0 11801,1 11835,0 11924,1 11976,0 12062,1 12158,0 12218,1 12240,0 12269,1 12360,0 12367,1 12438,0 12501,1 12595,0 12672,1 12767,0 12797,1 12884,0 12931,1 12993,0 13089,1 13120,0 13169,1 13213,0 13306,1 13359,0 13451,1 13483,0 13532,1 13560,0 13645,1 13661,0 13729,1 13737,0 13770,1 13835,0 13929,1 14017,0 14085,1 14125,0 14135,1 14160,0 14247,1 14338,0 14394,1 14405,0 14427,1 14478,0 14480,1 14514,0 14528,1 14618,0 14692,1 14748,0 14809,1 14829,0 14891,1 14895,0 14968,1 14984,0 15081,1 15096,0 15126,1 15214,0 15247,1 15257,0 15307,1 15399,0 15435,1 15471,0 15510,1 15527,0 15532,1 15619,0 15646,1 15703,0 15716,1 15790,0 15810,1 15903,0 15924,1 15992,0 16083,1 16127,0 16166,1 16234,0 16254,1 16314,0 16359,1 16395,0 16490,1 16546,0 16644,1 16726,0 16784,1 16838,0 16854,1 16945,0 17002,1 17016,0 17027,1 17087,0 17163,1 17192,0 17240,1 17242,0 17302,1 17362,0 17448,1 17481,0 17546,1 17583,0 17611,1 17613,0 17656,1 17722,0 17809,1 17847,0 17935,1 17976,0 18058,1 18133,0 18225,1 18254,0 18338,1 18417,0 18468,1 18532,0 18576,1 18619,0 18674,1 18676,0 18744,1 18786,0 18851,1 18878,0 18943,1 18956,0 19014,1 19047,0 19117,1 19145,0 19172,1 19220,0 19232,1 19263,0 19327,1 19345,0 19384,1 19453,0 19533,1 19545,0 19632,1 19706,0 19747,1 19816,0 19909,1 19994,0 20084,1 20117,0 20145,1 20242,0 20276,1 20343,0 20432,1 20454,0 20479,1 20577,0 20611,1 20653,0 20738,1 20785,0 20811,1 20833,0 20913,1 20958,0 21055,1 21097,0 21161,1 21198,0 21203,1 21205,0 21301,1 21318,0 21329,1 21370,0 21431,1 21449,0 21530,1 21560,0 21583,1 21614,0 21685,1 21770,0 21823,1 21915,0 21963,1 22045,0 22090,1 22096,0 22166,1 22220,0 22265,1 22328,0 22410,1 22485,0 22524,1 22574,0 22641,1 22715,0 22780,1 22806,0 22843,1 22869,0 22946,1 22963,0 23026,1 23032,0 23057,1 23104,0 23140,1 23225,0 23294,1 23345,0 23373,1 23454,0 23517,1 23551,0 23631,1 23680,0 23744,1 23808,0 23899,1 23979,0 24065,1 24069,0 24145,1 24155,0 24196,1 24229,0 24309,1 24321,0 24370,1 24379,0 24420,1 24461,0 24479,1 24550,0 24576,1 24638,0 24691,1 24720,0 24771,1 24835,0 24929,1 25021,0 25109,1 25206,0 25207,1 25210,0 25246,1 25325,0 25361,1 25442,0 25447,1 25494,0 25574,1 25649,0 25729,1 25744,0 25767,1 25858,0 25887,1 25933,0 25954,1 25969,0 26050,1 26074,0 26075,1 26093,0 26133,1 26180,0 26191,1 26278,0 26292,1 26384,0 26396,1 26402,0 26423,1 26498,0 26521,1 26526,0 26578,1 26642,0 26672,1 26715,0 26804,1 26878,0 26938,1 26950,0 27009,1 27043,0 27106,1 27138,0 27226,1 27279,0 27300,1 27333,0 27358,1 27404,0 27481,1 27499,0 27578,1 27586,0 27671,1 27757,0 27811,1 27894,0 27954,1 28019,0 28060,1 28076,0 28087,1 28166,0 28258,1 28279,0 28307,1 28385,0 28467,1 28529,0 28576,1 28650,0 28667,1 28671,0 28674,1 28760,0 28765,1 28812,0 28854,1 28947,0 29045,1 29133,0 29210,1 29303,0 29383,1 29478,0 29559,1 29565,0 29658,1 29748,0 29752,1 29852,0 29886,1 29904,0 29927,1 30007,0 30022,1 30029,0 30074,1 30114,0 30181,1 30237,0 30261,1 30320,0 30393,1 30466,0 30509,1 30536,0 30614,1 30666,0 30681,1 30700,0 30775,1 30793,0 30869,1 30902,0 30985,1 31026,0 31104,1 31158,0 31221,1 31282,0 31297,1 31343,0 31346,1 31392,0 31403,1 31470,0 31481,1 31484,0 31536,1 31621,0 31697,1 31704,0 31800,1 31879,0 31907,1 31970,0 31989,1 32008,0 32088,1 32136,0 32223,1 32231,0 32308,1 32361,0 32434,1 32527,0 32549,1 32623,0 32640,1 32702,0 32734,1 32802,0 32872,1 32940,0 33022,1 33030,0 33113,1 33148,0 33211,1 33250,0 33278,1 33347,0 33424,1 33522,0 33527,1 33568,0 33629,1 33646,0 33682,1 33752,0 33823,1 33851,0 33915,1 33996,0 34002,1 34098,0 34131,1 34190,0 34204,1 34217,0 34264,1 34284,0 34371,1 34414,0 34445,1 34542,0 34599,1 34673,0 34713,1 34758,0 34836,1 34919,0 34925,1 34955,0 35041,1 35109,0 35140,1 35234,0 35248,1 35345,0 35355,1 35373,0 35426,1 35468,0 35531,1 35589,0 35676,1 35729,0 35769,1 35777,0 35786,1 35883,0 35980,1 36077,0 36105,1 36188,0 36242,1 36275,0 36341,1 36426,0 36467,1 36474,0 36517,1 36581,0 36629,1 36728,0 36787,1 36797,0 36839,1 36927,0 36938,1 36993,0 37038,1 37052,0 37062,1 37103,0 37111,1 37116,0 37167,1 37183,0 37203,1 37233,0 37270,1 37365,0 37380,1 37478,0 37503,1 37569,0 37628,1 37697,0 37699,1 37715,0 37776,1 37837,0 37889,1 37962,0 37978,1 38068,0 38085,1 38144,0 38178,1 38269,0 38326,1 38384,0 38410,1 38460,0 38560,1 38574,0 38624,1 38636,0 38651,1 38693,0 38761,1 38814,0 38831,1 38885,0 38908,1 38916,0 38996,1 39034,0 39078,1 39160,0 39252,1 39282,0 39355,1 39359,0 39412,1 39495,0 39576,1 39597,0 39635,1 39692,0 39713,1 39732,0 39813,1 39905,0 39953,1 40026,0 40054,1 40082,0 40111,1 40148,0 40163,1 40250,0 40295,1 40315,0 40374,1 40398,0 40447,1 40517,0 40568,1 40573,0 40630,1 40668,0 40752,1 40831,0 40840,1 40858,0 40933,1 40987,0 40998,1 41016,0 41108,1 41117,0 41128,1 41156,0 41208,1 41222,0 41280,1 41326,0 41390,1 41434,0 41483,1 41560,0 41589,1 41627,0 41708,1 41786,0 41816,1 41841,0 41910,1 41958,0 42044,1 42142,0 42148,1 42219,0 42228,1 42328,0 42388,1 42433,0 42496,1 42558,0 42569,1 42612,0 42655,1 42663,0 42695,1 42711,0 42755,1 42842,0 42881,1 42886,0 42939,1 43002,0 43014,1 43023,0 43075,1 43077,0 43125,1 43143,0 43155,1 43240,0 43266,1 43302,0 43317,1 43363,0 43403,1 43475,0 43526,1 43583,0 43633,1 43699,0 43703,1 43708,0 43741,1 43748,0 43834,1 43901,0 43956,1 44043,0 44113,1 44170,0 44269,1 44316,0 44381,1 44406,0 44457,1 44523,0 44591,1 44682,0 44723,1 44737,0 44762,1 44785,0 44847,1 44887,0 44943,1 44961,0 45013,1 45066,0 45151,1 45230,0 45283,1 45301,0 45359,1 45396,0 45440,1 45451,0 45509,1 45511,0 45561,1 45588,0 45654,1 45675,0 45679,1 45703,0 45735,1 45781,0 45810,1 45883,0 45949,1 46014,0 46039,1 46071,0 46120,1 46127,0 46149,1 46154,0 46228,1 46308,0 46370,1 46394,0 46431,1 46476,0 46553,1 46579,0 46650,1 46724,0 46788,1 46854,0 46936,1 46971,0 47020,1 47060,0 47105,1 47135,0 47160,1 47233,0 47269,1 47282,0 47320,1 47334,0 47391,1 47465,0 47555,1 47583,0 47675,1 47726,0 47805,1 47831,0 47887,1 47895,0 47921,1 47956,0 48055,1 48114,0 48203,1 48271,0 48279,1 48315,0 48369,1 48418,0 48507,1 48552,0 48594,1 48689,0 48789,1 48875,0 48890,1 48926,0 49004,1 49012,0 49066,1 49139,0 49176,1 49226,0 49304,1 49317,0 49395,1 49487,0 49509,1 49604,0 49649,1 49676,0 49691,1 49736,0 49804,1 49885,0 49909,1 end initlist a14 0,0 45,1 105,0 163,1 248,0 277,1 339,0 368,1 447,0 484,1 566,0 643,1 650,0 678,1 769,0 770,1 775,0 874,1 919,0 925,1 935,0 950,1 1020,0 1118,1 1190,0 1227,1 1304,0 1314,1 1339,0 1389,1 1443,0 1485,1 1499,0 1505,1 1573,0 1604,1 1653,0 1686,1 1753,0 1781,1 1782,0 1790,1 1804,0 1904,1 1954,0 2050,1 2099,0 2153,1 2243,0 2283,1 2356,0 2437,1 2527,0 2530,1 2543,0 2608,1 2667,0 2743,1 2831,0 2915,1 2972,0 3001,1 3093,0 3108,1 3119,0 3181,1 3204,0 3225,1 3279,0 3365,1 3373,0 3428,1 3509,0 3533,1 3628,0 3653,1 3698,0 3714,1 3722,0 3738,1 3746,0 3752,1 3821,0 3913,1 3922,0 3932,1 3950,0 3996,1 4018,0 4110,1 4133,0 4147,1 4179,0 4245,1 4275,0 4349,1 4384,0 4436,1 4528,0 4539,1 4601,0 4684,1 4748,0 4826,1 4925,0 5001,1 5036,0 5084,1 5124,0 5216,1 5263,0 5280,1 5317,0 5321,1 5410,0 5446,1 5469,0 5484,1 5538,0 5592,1 5672,0 5690,1 5699,0 5789,1 5856,0 5932,1 5965,0 5966,1 5972,0 5984,1 5990,0 6017,1 6028,0 6069,1 6115,0 6137,1 6150,0 6227,1 6297,0 6382,1 6402,0 6491,1 6535,0 6580,1 6614,0 6712,1 6757,0 6849,1 6884,0 6911,1 7010,0 7024,1 7039,0 7052,1 7085,0 7173,1 7261,0 7274,1 7320,0 7413,1 7418,0 7505,1 7589,0 7671,1 7746,0 7828,1 7873,0 7892,1 7967,0 8000,1 8025,0 8074,1 8117,0 8177,1 8220,0 8264,1 8337,0 8378,1 8382,0 8462,1 8507,0 8535,1 8621,0 8705,1 8739,0 8821,1 8909,0 8941,1 8957,0 9041,1 9121,0 9130,1 9151,0 9199,1 9211,0 9216,1 9229,0 9321,1 9419,0 9491,1 9536,0 9606,1 9654,0 9731,1 9818,0 9840,1 9909,0 9987,1 9992,0 10021,1 10101,0 10117,1 10128,0 10146,1 10150,0 10169,1 10209,0 10284,1 10303,0 10341,1 10416,0 10452,1 10510,0 10525,1 10549,0 10597,1 10662,0 10754,1 10811,0 10830,1 10868,0 10942,1 10981,0 11049,1 11132,0 11172,1 11208,0 11223,1 11248,0 11262,1 11328,0 11366,1 11439,0 11461,1 11536,0 11553,1 11563,0 11574,1 11656,0 11683,1 11720,0 11777,1 11856,0 11920,1 12005,0 12079,1 12104,0 12195,1 12275,0 12310,1 12395,0 12435,1 12504,0 12543,1 12625,0 12690,1 12725,0 12815,1 12892,0 12902,1 12936,0 13021,1 13115,0 13185,1 13197,0 13237,1 13334,0 13403,1 13489,0 13556,1 13572,0 13649,1 13686,0 13779,1 13817,0 13893,1 13967,0 14000,1 14066,0 14100,1 14169,0 14248,1 14282,0 14346,1 14373,0 14457,1 14458,0 14527,1 14586,0 14587,1 14625,0 14635,1 14711,0 14775,1 14782,0 14871,1 14906,0 14999,1 15059,0 15062,1 15161,0 15229,1 15268,0 15306,1 15385,0 15412,1 15464,0 15550,1 15648,0 15705,1 15792,0 15795,1 15889,0 15947,1 15948,0 15965,1 16023,0 16053,1 16062,0 16087,1 16129,0 16180,1 16214,0 16303,1 16359,0 16373,1 16450,0 16515,1 16590,0 16643,1 16721,0 16725,1 16753,0 16816,1 16859,0 16894,1 16972,0 16985,1 17003,0 17072,1 17073,0 17124,1 17160,0 17205,1 17272,0 17323,1 17404,0 17457,1 17540,0 17590,1 17625,0 17632,1 17645,0 17731,1 17788,0 17813,1 17887,0 17943,1 18016,0 18024,1 18114,0 18169,1 18244,0 18270,1 18342,0 18386,1 18422,0 18515,1 18566,0 18650,1 18665,0 18702,1 18728,0 18769,1 18812,0 18899,1 18919,0 18939,1 19032,0 19079,1 19168,0 19201,1 19257,0 19312,1 19356,0 19390,1 19462,0 19543,1 19571,0 19582,1 19584,0 19595,1 19682,0 19703,1 19777,0 19805,1 19839,0 19893,1 19973,0 19978,1 20060,0 20083,1 20104,0 20183,1 20196,0 20231,1 20278,0 20320,1 20324,0 20401,1 20444,0 20461,1 20462,0 20467,1 20523,0 20560,1 20641,0 20736,1 20796,0 20868,1 20882,0 20942,1 20953,0 21029,1 21030,0 21058,1 21104,0 21151,1 21247,0 21330,1 21337,0 21375,1 21411,0 21462,1 21562,0 21582,1 21590,0 21635,1 21721,0 21731,1 21786,0 21811,1 21889,0 21915,1 21991,0 22042,1 22140,0 22204,1 22269,0 22355,1 22415,0 22488,1 22549,0 22623,1 22716,0 22779,1 22842,0 22926,1 23004,0 23094,1 23141,0 23230,1 23273,0 23299,1 23387,0 23460,1 23469,0 23519,1 23562,0 23654,1 23682,0 23716,1 23796,0 23817,1 23890,0 23908,1 23988,0 23996,1 24024,0 24046,1 24126,0 24187,1 24255,0 24287,1 24350,0 24417,1 24466,0 24473,1 24495,0 24546,1 24644,0 24717,1 24738,0 24751,1 24758,0 24858,1 24873,0 24923,1 25021,0 25087,1 25115,0 25182,1 25265,0 25316,1 25337,0 25366,1 25380,0 25407,1 25506,0 25561,1 25635,0 25693,1 25785,0 25865,1 25894,0 25903,1 25948,0 25968,1 26033,0 26100,1 26158,0 26232,1 26250,0 26319,1 26402,0 26415,1 26445,0 26542,1 26634,0 26656,1 26668,0 26753,1 26760,0 26839,1 26885,0 26975,1 27012,0 27097,1 27103,0 27126,1 27141,0 27208,1 27305,0 27392,1 27416,0 27481,1 27563,0 27582,1 27611,0 27633,1 27663,0 27704,1 27753,0 27812,1 27845,0 27855,1 27880,0 27975,1 28018,0 28037,1 28087,0 28140,1 28228,0 28302,1 28342,0 28395,1 28413,0 28490,1 28552,0 28603,1 28686,0 28720,1 28744,0 28818,1 28845,0 28896,1 28903,0 28995,1 29003,0 29016,1 29050,0 29136,1 29214,0 29225,1 29254,0 29310,1 29353,0 29443,1 29448,0 29520,1 29597,0 29663,1 29709,0 29753,1 29820,0 29867,1 29907,0 29933,1 29999,0 30075,1 30158,0 30246,1 30293,0 30391,1 30412,0 30494,1 30543,0 30640,1 30718,0 30797,1 30821,0 30877,1 30945,0 31028,1 31101,0 31160,1 31256,0 31346,1 31373,0 31406,1 31407,0 31409,1 31453,0 31461,1 31549,0 31599,1 31684,0 31765,1 31796,0 31879,1 31936,0 31977,1 32064,0 32072,1 32167,0 32266,1 32293,0 32389,1 32468,0 32477,1 32529,0 32535,1 32616,0 32654,1 32717,0 32768,1 32775,0 32782,1 32803,0 32901,1 32938,0 32995,1 33003,0 33066,1 33094,0 33147,1 33221,0 33290,1 33378,0 33472,1 33544,0 33639,1 33668,0 33680,1 33718,0 33778,1 33869,0 33895,1 33975,0 33986,1 34075,0 34133,1 34165,0 34195,1 34205,0 34297,1 34299,0 34314,1 34371,0 34401,1 34496,0 34513,1 34566,0 34660,1 34710,0 34725,1 34772,0 34805,1 34894,0 34940,1 34963,0 35012,1 35109,0 35205,1 35245,0 35251,1 35270,0 35349,1 35366,0 35387,1 35450,0 35452,1 35474,0 35483,1 35494,0 35533,1 35603,0 35641,1 35723,0 35811,1 35851,0 35947,1 36033,0 36101,1 36152,0 36173,1 36208,0 36296,1 36335,0 36432,1 36443,0 36478,1 36530,0 36553,1 36571,0 36631,1 36684,0 36749,1 36751,0 36826,1 36894,0 36944,1 36955,0 37029,1 37082,0 37124,1 37219,0 37308,1 37353,0 37388,1 37463,0 37552,1 37586,0 37662,1 37690,0 37692,1 37725,0 37765,1 37784,0 37841,1 37851,0 37875,1 37956,0 38039,1 38089,0 38176,1 38227,0 38252,1 38349,0 38443,1 38527,0 38619,1 38650,0 38706,1 38748,0 38773,1 38814,0 38847,1 38872,0 38966,1 39011,0 39076,1 39098,0 39129,1 39229,0 39309,1 39331,0 39375,1 39446,0 39512,1 39534,0 39583,1 39588,0 39616,1 39691,0 39766,1 39781,0 39841,1 39939,0 39946,1 40010,0 40066,1 40118,0 40212,1 40219,0 40264,1 40334,0 40398,1 40432,0 40476,1 40498,0 40586,1 40636,0 40648,1 40673,0 40701,1 40763,0 40829,1 40902,0 40983,1 40994,0 41062,1 41110,0 41145,1 41195,0 41201,1 41244,0 41333,1 41397,0 41480,1 41535,0 41602,1 41690,0 41750,1 41767,0 41801,1 41815,0 41862,1 41907,0 41940,1 41995,0 42075,1 42102,0 42144,1 42205,0 42294,1 42372,0 42450,1 42545,0 42619,1 42652,0 42718,1 42817,0 42837,1 42896,0 42953,1 42961,0 43020,1 43074,0 43100,1 43150,0 43203,1 43283,0 43350,1 43402,0 43500,1 43565,0 43606,1 43639,0 43650,1 43720,0 43817,1 43861,0 43914,1 43977,0 44037,1 44136,0 44187,1 44272,0 44334,1 44401,0 44433,1 44516,0 44579,1 44633,0 44733,1 44784,0 44810,1 44818,0 44879,1 44884,0 44929,1 44986,0 45065,1 45143,0 45218,1 45294,0 45382,1 45475,0 45568,1 45610,0 45690,1 45744,0 45778,1 45866,0 45875,1 45974,0 45994,1 46001,0 46052,1 46078,0 46091,1 46180,0 46268,1 46289,0 46389,1 46458,0 46556,1 46640,0 46715,1 46808,0 46816,1 46846,0 46911,1 46927,0 46934,1 46986,0 47053,1 47098,0 47154,1 47210,0 47217,1 47300,0 47393,1 47422,0 47506,1 47601,0 47662,1 47695,0 47698,1 47795,0 47890,1 47898,0 47911,1 47936,0 47950,1 48039,0 48107,1 48178,0 48260,1 48277,0 48348,1 48383,0 48390,1 48472,0 48557,1 48558,0 48616,1 48688,0 48761,1 48771,0 48793,1 48882,0 48897,1 48921,0 48989,1 49003,0 49014,1 49080,0 49177,1 49243,0 49303,1 49305,0 49336,1 49395,0 49446,1 49546,0 49579,1 49581,0 49613,1 49697,0 49757,1 49853,0 49933,1 50005,0 50051,1 50065,0 50129,1 50175,0 50212,1 50222,0 50238,1 50258,0 50294,1 50349,0 50415,1 50465,0 50487,1 50528,0 50546,1 50551,0 50634,1 end initlist a15 0,0 14,1 87,0 162,1 198,0 214,1 223,0 298,1 322,0 346,1 427,0 496,1 506,0 547,1 551,0 560,1 569,0 595,1 612,0 655,1 714,0 798,1 800,0 846,1 854,0 917,1 1013,0 1065,1 1121,0 1139,1 1215,0 1247,1 1285,0 1384,1 1429,0 1522,1 1567,0 1615,1 1631,0 1653,1 1700,0 1739,1 1828,0 1899,1 1900,0 1997,1 2049,0 2095,1 2161,0 2180,1 2257,0 2316,1 2360,0 2442,1 2444,0 2468,1 2561,0 2564,1 2600,0 2648,1 2737,0 2810,1 2813,0 2843,1 2857,0 2934,1 3030,0 3037,1 3108,0 3185,1 3205,0 3261,1 3305,0 3380,1 3408,0 3433,1 3514,0 3589,1 3591,0 3660,1 3672,0 3681,1 3749,0 3784,1 3806,0 3891,1 3972,0 4061,1 4131,0 4195,1 4284,0 4372,1 4425,0 4440,1 4498,0 4593,1 4639,0 4693,1 4774,0 4869,1 4939,0 4972,1 5008,0 5084,1 5142,0 5157,1 5234,0 5313,1 5377,0 5436,1 5522,0 5583,1 5662,0 5712,1 5760,0 5765,1 5785,0 5855,1 5879,0 5913,1 5984,0 6049,1 6092,0 6102,1 6138,0 6225,1 6317,0 6340,1 6343,0 6374,1 6386,0 6449,1 6542,0 6547,1 6560,0 6621,1 6659,0 6723,1 6812,0 6895,1 6965,0 6972,1 7037,0 7120,1 7218,0 7240,1 7298,0 7388,1 7439,0 7463,1 7466,0 7524,1 7535,0 7599,1 7645,0 7711,1 7800,0 7842,1 7847,0 7945,1 7951,0 7988,1 7995,0 8044,1 8134,0 8165,1 8233,0 8310,1 8365,0 8377,1 8432,0 8513,1 8592,0 8605,1 8640,0 8717,1 8753,0 8774,1 8819,0 8845,1 8924,0 8944,1 8992,0 9027,1 9090,0 9174,1 9201,0 9204,1 9280,0 9370,1 9433,0 9448,1 9506,0 9603,1 9641,0 9717,1 9813,0 9894,1 9938,0 9968,1 10068,0 10110,1 10135,0 10215,1 10242,0 10308,1 10321,0 10353,1 10425,0 10437,1 10531,0 10586,1 10590,0 10605,1 10658,0 10735,1 10769,0 10786,1 10864,0 10885,1 10981,0 11070,1 11091,0 11102,1 11133,0 11216,1 11230,0 11233,1 11302,0 11380,1 11423,0 11462,1 11562,0 11597,1 11623,0 11639,1 11661,0 11727,1 11794,0 11868,1 11937,0 12033,1 12055,0 12104,1 12110,0 12122,1 12208,0 12227,1 12322,0 12368,1 12436,0 12509,1 12548,0 12648,1 12657,0 12679,1 12750,0 12754,1 12811,0 12847,1 12859,0 12870,1 12937,0 12991,1 13008,0 13032,1 13067,0 13164,1 13168,0 13213,1 13227,0 13251,1 13317,0 13347,1 13442,0 13454,1 13467,0 13505,1 13549,0 13642,1 13736,0 13777,1 13817,0 13867,1 13885,0 13965,1 13984,0 14036,1 14090,0 14163,1 14172,0 14196,1 14242,0 14333,1 14377,0 14467,1 14523,0 14568,1 14623,0 14672,1 14683,0 14722,1 14784,0 14860,1 14931,0 14992,1 15090,0 15188,1 15226,0 15310,1 15408,0 15432,1 15473,0 15551,1 15579,0 15588,1 15625,0 15673,1 15733,0 15809,1 15878,0 15894,1 15932,0 15950,1 16020,0 16114,1 16180,0 16193,1 16257,0 16290,1 16328,0 16358,1 16365,0 16426,1 16461,0 16500,1 16577,0 16594,1 16627,0 16640,1 16665,0 16737,1 16828,0 16846,1 16915,0 16942,1 16991,0 17076,1 17112,0 17196,1 17205,0 17240,1 17282,0 17347,1 17428,0 17455,1 17517,0 17568,1 17667,0 17695,1 17735,0 17758,1 17772,0 17830,1 17838,0 17874,1 17894,0 17898,1 17979,0 17990,1 18059,0 18096,1 18166,0 18239,1 18264,0 18340,1 18399,0 18465,1 18498,0 18539,1 18603,0 18702,1 18732,0 18817,1 18911,0 18990,1 19061,0 19083,1 19164,0 19188,1 19207,0 19243,1 19266,0 19349,1 19424,0 19517,1 19586,0 19615,1 19632,0 19712,1 19733,0 19736,1 19748,0 19772,1 19833,0 19887,1 19985,0 20077,1 20136,0 20204,1 20220,0 20226,1 20259,0 20305,1 20404,0 20436,1 20474,0 20534,1 20546,0 20586,1 20588,0 20610,1 20619,0 20705,1 20711,0 20774,1 20824,0 20870,1 20938,0 20971,1 20972,0 21019,1 21033,0 21103,1 21145,0 21175,1 21253,0 21337,1 21375,0 21454,1 21503,0 21506,1 21577,0 21632,1 21641,0 21737,1 21820,0 21833,1 21837,0 21931,1 21967,0 22013,1 22063,0 22079,1 22165,0 22253,1 22275,0 22351,1 22396,0 22434,1 22487,0 22551,1 22633,0 22708,1 22729,0 22770,1 22828,0 22836,1 22854,0 22911,1 22988,0 23067,1 23079,0 23102,1 23112,0 23180,1 23250,0 23302,1 23335,0 23409,1 23429,0 23513,1 23517,0 23600,1 23672,0 23757,1 23849,0 23883,1 23933,0 24017,1 24093,0 24172,1 24265,0 24361,1 24451,0 24521,1 24523,0 24557,1 24651,0 24689,1 24768,0 24852,1 24877,0 24887,1 24932,0 24990,1 25005,0 25042,1 25048,0 25084,1 25115,0 25203,1 25302,0 25317,1 25409,0 25493,1 25500,0 25558,1 25570,0 25645,1 25650,0 25681,1 25739,0 25747,1 25823,0 25838,1 25888,0 25968,1 25978,0 26038,1 26082,0 26108,1 26183,0 26279,1 26368,0 26449,1 26523,0 26619,1 26664,0 26719,1 26812,0 26821,1 26868,0 26938,1 27035,0 27038,1 27064,0 27142,1 27234,0 27333,1 27391,0 27392,1 27432,0 27501,1 27595,0 27641,1 27666,0 27683,1 27766,0 27798,1 27862,0 27897,1 27952,0 27981,1 27985,0 28005,1 28092,0 28147,1 28167,0 28239,1 28312,0 28355,1 28454,0 28519,1 28573,0 28607,1 28680,0 28756,1 28849,0 28895,1 28964,0 29045,1 29117,0 29202,1 29230,0 29266,1 29282,0 29292,1 29351,0 29363,1 29460,0 29482,1 29550,0 29596,1 29631,0 29692,1 29735,0 29798,1 29809,0 29888,1 29946,0 29990,1 30084,0 30149,1 30217,0 30274,1 30324,0 30371,1 30390,0 30443,1 30543,0 30626,1 30650,0 30745,1 30752,0 30776,1 30844,0 30873,1 30907,0 30953,1 31013,0 31096,1 31102,0 31145,1 31151,0 31188,1 31209,0 31227,1 31233,0 31300,1 31376,0 31434,1 31463,0 31541,1 31607,0 31693,1 31732,0 31831,1 31874,0 31899,1 31992,0 32027,1 32052,0 32055,1 32082,0 32145,1 32168,0 32215,1 32282,0 32306,1 32328,0 32342,1 32345,0 32392,1 32424,0 32486,1 32566,0 32611,1 32674,0 32752,1 32774,0 32854,1 32883,0 32884,1 32931,0 32944,1 32967,0 32978,1 33014,0 33015,1 33049,0 33074,1 33094,0 33101,1 33199,0 33249,1 33261,0 33341,1 33394,0 33412,1 33448,0 33541,1 33566,0 33567,1 33647,0 33716,1 33763,0 33800,1 33837,0 33888,1 33968,0 34001,1 34085,0 34176,1 34218,0 34222,1 34285,0 34331,1 34352,0 34415,1 34515,0 34589,1 34660,0 34735,1 34834,0 34885,1 34963,0 35021,1 35072,0 35126,1 35222,0 35234,1 35306,0 35378,1 35383,0 35461,1 35551,0 35630,1 35721,0 35804,1 35823,0 35916,1 35934,0 36026,1 36027,0 36109,1 36163,0 36175,1 36192,0 36283,1 36338,0 36392,1 36484,0 36558,1 36561,0 36570,1 36649,0 36709,1 36780,0 36790,1 36853,0 36935,1 37007,0 37083,1 37139,0 37159,1 37249,0 37340,1 37363,0 37411,1 37437,0 37511,1 37529,0 37608,1 37689,0 37696,1 37737,0 37784,1 37799,0 37818,1 37862,0 37917,1 37921,0 38010,1 38039,0 38054,1 38144,0 38180,1 38213,0 38293,1 38323,0 38370,1 38398,0 38421,1 38425,0 38493,1 38520,0 38553,1 38635,0 38731,1 38741,0 38799,1 38872,0 38875,1 38927,0 38999,1 39074,0 39154,1 39222,0 39245,1 39309,0 39343,1 39427,0 39520,1 39578,0 39637,1 39735,0 39753,1 39786,0 39796,1 39807,0 39844,1 39847,0 39928,1 39963,0 39971,1 40042,0 40131,1 40213,0 40256,1 40316,0 40336,1 40403,0 40439,1 40519,0 40585,1 40619,0 40697,1 40708,0 40798,1 40860,0 40955,1 40967,0 40969,1 40999,0 41084,1 41147,0 41219,1 41226,0 41259,1 41307,0 41344,1 41432,0 41532,1 41597,0 41650,1 41672,0 41711,1 41788,0 41864,1 41910,0 41993,1 42030,0 42105,1 42112,0 42194,1 42275,0 42289,1 42366,0 42457,1 42491,0 42591,1 42643,0 42649,1 42718,0 42801,1 42884,0 42958,1 43012,0 43086,1 43094,0 43189,1 43245,0 43331,1 43414,0 43444,1 43534,0 43634,1 43701,0 43735,1 43829,0 43928,1 43995,0 44024,1 44044,0 44139,1 44181,0 44238,1 44315,0 44340,1 44424,0 44480,1 44485,0 44573,1 44588,0 44633,1 44696,0 44775,1 44828,0 44870,1 44876,0 44878,1 44930,0 44981,1 45015,0 45051,1 45139,0 45199,1 45213,0 45271,1 45330,0 45393,1 45418,0 45441,1 45530,0 45532,1 45555,0 45584,1 45642,0 45714,1 45722,0 45767,1 45845,0 45931,1 45933,0 45983,1 46076,0 46118,1 46126,0 46162,1 46222,0 46273,1 46336,0 46372,1 46402,0 46424,1 46488,0 46507,1 46560,0 46623,1 46661,0 46745,1 46769,0 46787,1 46825,0 46891,1 46932,0 46999,1 47077,0 47124,1 47197,0 47228,1 47285,0 47329,1 47338,0 47427,1 47511,0 47544,1 47625,0 47655,1 47722,0 47801,1 47882,0 47884,1 47983,0 48055,1 48087,0 48132,1 48183,0 48191,1 48281,0 48333,1 48352,0 48363,1 48397,0 48478,1 48499,0 48517,1 48523,0 48593,1 48693,0 48705,1 48778,0 48856,1 48889,0 48939,1 48949,0 49005,1 49082,0 49122,1 49150,0 49179,1 49239,0 49266,1 49366,0 49438,1 49493,0 49496,1 49499,0 49530,1 49573,0 49673,1 49705,0 49776,1 49874,0 49889,1 49956,0 49988,1 49993,0 50061,1 50076,0 50162,1 end initlist a16 0,0 57,1 118,0 154,1 249,0 342,1 435,0 466,1 525,0 536,1 603,0 612,1 702,0 771,1 813,0 818,1 895,0 989,1 1007,0 1018,1 1038,0 1048,1 1092,0 1100,1 1111,0 1134,1 1159,0 1209,1 1256,0 1268,1 1359,0 1364,1 1464,0 1550,1 1607,0 1627,1 1634,0 1679,1 1703,0 1713,1 1724,0 1805,1 1806,0 1816,1 1875,0 1964,1 2023,0 2102,1 2195,0 2241,1 2248,0 2257,1 2306,0 2339,1 2396,0 2472,1 2491,0 2501,1 2544,0 2597,1 2632,0 2704,1 2731,0 2745,1 2839,0 2855,1 2896,0 2949,1 2988,0 3070,1 3118,0 3149,1 3177,0 3250,1 3311,0 3402,1 3404,0 3474,1 3519,0 3568,1 3585,0 3658,1 3747,0 3767,1 3774,0 3822,1 3914,0 3983,1 4021,0 4109,1 4209,0 4282,1 4348,0 4406,1 4443,0 4485,1 4568,0 4607,1 4667,0 4744,1 4819,0 4820,1 4856,0 4879,1 4937,0 5035,1 5038,0 5088,1 5139,0 5150,1 5196,0 5225,1 5311,0 5319,1 5356,0 5357,1 5372,0 5376,1 5471,0 5472,1 5503,0 5592,1 5618,0 5675,1 5724,0 5819,1 5868,0 5901,1 5939,0 6028,1 6124,0 6224,1 6297,0 6354,1 6395,0 6432,1 6454,0 6549,1 6603,0 6673,1 6689,0 6738,1 6795,0 6803,1 6830,0 6859,1 6899,0 6946,1 7030,0 7104,1 7112,0 7199,1 7245,0 7275,1 7339,0 7361,1 7448,0 7537,1 7609,0 7650,1 7721,0 7785,1 7856,0 7858,1 7941,0 8038,1 8136,0 8203,1 8207,0 8257,1 8276,0 8354,1 8360,0 8446,1 8528,0 8574,1 8648,0 8652,1 8696,0 8757,1 8763,0 8836,1 8903,0 8923,1 8978,0 9003,1 9088,0 9106,1 9188,0 9213,1 9219,0 9231,1 9330,0 9388,1 9440,0 9487,1 9505,0 9533,1 9567,0 9618,1 9677,0 9749,1 9767,0 9834,1 9860,0 9884,1 9903,0 9911,1 9922,0 9984,1 10033,0 10096,1 10116,0 10156,1 10197,0 10263,1 10302,0 10394,1 10445,0 10522,1 10552,0 10642,1 10662,0 10701,1 10775,0 10817,1 10842,0 10885,1 10912,0 10983,1 11033,0 11047,1 11128,0 11221,1 11313,0 11356,1 11441,0 11475,1 11506,0 11514,1 11600,0 11649,1 11719,0 11798,1 11803,0 11829,1 11898,0 11909,1 11958,0 11964,1 12052,0 12065,1 12122,0 12182,1 12209,0 12255,1 12353,0 12397,1 12484,0 12504,1 12527,0 12571,1 12594,0 12687,1 12766,0 12792,1 12837,0 12870,1 12937,0 12964,1 13010,0 13103,1 13150,0 13153,1 13214,0 13272,1 13326,0 13361,1 13399,0 13428,1 13434,0 13462,1 13556,0 13567,1 13607,0 13623,1 13645,0 13691,1 13781,0 13869,1 13957,0 14011,1 14029,0 14059,1 14134,0 14233,1 14242,0 14281,1 14325,0 14343,1 14366,0 14440,1 14481,0 14509,1 14555,0 14560,1 14565,0 14632,1 14710,0 14794,1 14851,0 14855,1 14944,0 15025,1 15087,0 15141,1 15221,0 15241,1 15264,0 15279,1 15325,0 15351,1 15448,0 15541,1 15545,0 15626,1 15689,0 15758,1 15780,0 15874,1 15940,0 15968,1 15996,0 16007,1 16064,0 16099,1 16175,0 16242,1 16299,0 16318,1 16403,0 16410,1 16487,0 16554,1 16601,0 16620,1 16664,0 16718,1 16774,0 16798,1 16869,0 16916,1 16970,0 17002,1 17031,0 17082,1 17125,0 17224,1 17261,0 17311,1 17380,0 17381,1 17382,0 17435,1 17487,0 17586,1 17678,0 17702,1 17773,0 17857,1 17924,0 18005,1 18093,0 18175,1 18273,0 18367,1 18375,0 18402,1 18422,0 18432,1 18459,0 18498,1 18533,0 18567,1 18666,0 18752,1 18831,0 18924,1 18934,0 18991,1 19009,0 19080,1 19094,0 19127,1 19218,0 19245,1 19246,0 19322,1 19353,0 19429,1 19459,0 19483,1 19528,0 19543,1 19640,0 19644,1 19671,0 19687,1 19705,0 19723,1 19742,0 19817,1 19834,0 19868,1 19941,0 19954,1 19971,0 19993,1 20019,0 20105,1 20142,0 20241,1 20284,0 20336,1 20347,0 20411,1 20456,0 20486,1 20552,0 20611,1 20665,0 20687,1 20702,0 20791,1 20800,0 20887,1 20916,0 20991,1 21022,0 21109,1 21167,0 21227,1 21256,0 21309,1 21362,0 21458,1 21464,0 21505,1 21555,0 21627,1 21671,0 21717,1 21731,0 21804,1 21839,0 21936,1 22022,0 22079,1 22149,0 22196,1 22244,0 22274,1 22355,0 22435,1 22506,0 22509,1 22587,0 22611,1 22618,0 22666,1 22692,0 22756,1 22766,0 22774,1 22849,0 22943,1 23025,0 23043,1 23078,0 23123,1 23167,0 23226,1 23309,0 23356,1 23446,0 23495,1 23529,0 23555,1 23639,0 23723,1 23815,0 23877,1 23970,0 24053,1 24140,0 24216,1 24233,0 24312,1 24358,0 24393,1 24476,0 24552,1 24621,0 24677,1 24769,0 24827,1 24910,0 24943,1 24978,0 25033,1 25113,0 25208,1 25254,0 25354,1 25409,0 25444,1 25473,0 25545,1 25596,0 25688,1 25705,0 25800,1 25887,0 25987,1 26081,0 26140,1 26204,0 26233,1 26296,0 26309,1 26408,0 26482,1 26518,0 26546,1 26635,0 26706,1 26749,0 26750,1 26751,0 26767,1 26850,0 26854,1 26922,0 26967,1 27014,0 27065,1 27151,0 27238,1 27310,0 27401,1 27496,0 27533,1 27620,0 27631,1 27728,0 27733,1 27742,0 27763,1 27814,0 27834,1 27926,0 27977,1 27993,0 28065,1 28073,0 28078,1 28092,0 28130,1 28208,0 28224,1 28244,0 28318,1 28348,0 28393,1 28418,0 28429,1 28452,0 28516,1 28602,0 28692,1 28740,0 28771,1 28783,0 28810,1 28811,0 28886,1 28957,0 29028,1 29074,0 29114,1 29119,0 29146,1 29218,0 29311,1 29321,0 29332,1 29337,0 29357,1 29399,0 29426,1 29517,0 29563,1 29606,0 29694,1 29794,0 29812,1 29843,0 29849,1 29877,0 29968,1 30040,0 30106,1 30197,0 30237,1 30334,0 30365,1 30421,0 30449,1 30525,0 30527,1 30592,0 30601,1 30651,0 30691,1 30725,0 30782,1 30838,0 30907,1 30950,0 31030,1 31035,0 31078,1 31112,0 31135,1 31189,0 31286,1 31350,0 31405,1 31482,0 31495,1 31568,0 31655,1 31667,0 31669,1 31679,0 31754,1 31781,0 31867,1 31904,0 31938,1 31978,0 32004,1 32044,0 32110,1 32165,0 32206,1 32285,0 32374,1 32433,0 32529,1 32586,0 32620,1 32698,0 32722,1 32755,0 32827,1 32872,0 32963,1 33022,0 33066,1 33149,0 33176,1 33240,0 33310,1 33340,0 33377,1 33442,0 33507,1 33565,0 33655,1 33716,0 33749,1 33813,0 33859,1 33904,0 33963,1 34062,0 34135,1 34184,0 34220,1 34228,0 34307,1 34355,0 34375,1 34458,0 34557,1 34647,0 34712,1 34742,0 34807,1 34854,0 34911,1 34929,0 34944,1 34975,0 35057,1 35076,0 35134,1 35226,0 35240,1 35285,0 35379,1 35428,0 35478,1 35542,0 35577,1 35580,0 35582,1 35648,0 35710,1 35740,0 35792,1 35858,0 35881,1 35886,0 35967,1 36004,0 36068,1 36088,0 36142,1 36167,0 36209,1 36270,0 36274,1 36351,0 36412,1 36416,0 36417,1 36443,0 36483,1 36516,0 36599,1 36630,0 36647,1 36688,0 36714,1 36802,0 36875,1 36923,0 37005,1 37022,0 37056,1 37072,0 37154,1 37206,0 37229,1 37287,0 37365,1 37457,0 37468,1 37540,0 37594,1 37606,0 37666,1 37672,0 37725,1 37794,0 37820,1 37911,0 37963,1 38004,0 38009,1 38031,0 38037,1 38091,0 38151,1 38181,0 38185,1 38240,0 38269,1 38324,0 38385,1 38484,0 38572,1 38579,0 38644,1 38704,0 38766,1 38772,0 38842,1 38861,0 38940,1 39021,0 39025,1 39094,0 39128,1 39157,0 39232,1 39292,0 39374,1 39471,0 39550,1 39604,0 39631,1 39705,0 39797,1 39819,0 39863,1 39919,0 39957,1 40031,0 40110,1 40201,0 40224,1 40261,0 40320,1 40387,0 40413,1 40474,0 40563,1 40636,0 40734,1 40826,0 40880,1 40895,0 40973,1 41061,0 41136,1 41188,0 41241,1 41259,0 41337,1 41382,0 41387,1 41409,0 41451,1 41474,0 41525,1 41534,0 41580,1 41584,0 41645,1 41727,0 41804,1 41827,0 41842,1 41892,0 41931,1 41950,0 42037,1 42088,0 42117,1 42169,0 42196,1 42205,0 42295,1 42339,0 42421,1 42474,0 42566,1 42648,0 42670,1 42689,0 42760,1 42803,0 42863,1 42868,0 42885,1 42953,0 42972,1 42992,0 43055,1 43123,0 43195,1 43263,0 43321,1 43367,0 43402,1 43458,0 43545,1 43642,0 43695,1 43774,0 43844,1 43906,0 44006,1 44016,0 44102,1 44202,0 44285,1 44294,0 44334,1 44400,0 44468,1 44530,0 44616,1 44662,0 44760,1 44763,0 44788,1 44863,0 44961,1 45039,0 45104,1 45125,0 45208,1 45218,0 45309,1 45393,0 45411,1 45416,0 45510,1 45539,0 45573,1 45593,0 45676,1 45774,0 45817,1 45856,0 45934,1 46013,0 46055,1 46144,0 46206,1 46245,0 46303,1 46336,0 46380,1 46450,0 46520,1 46592,0 46660,1 46731,0 46827,1 46896,0 46984,1 47030,0 47110,1 47206,0 47277,1 47369,0 47432,1 47527,0 47576,1 47670,0 47705,1 47734,0 47754,1 47854,0 47940,1 47943,0 48032,1 48044,0 48116,1 48155,0 48224,1 48234,0 48269,1 48352,0 48375,1 48472,0 48476,1 48510,0 48524,1 48533,0 48621,1 48645,0 48649,1 48725,0 48782,1 48848,0 48903,1 48941,0 49003,1 49023,0 49070,1 49163,0 49240,1 49280,0 49321,1 49327,0 49365,1 49434,0 49525,1 49607,0 49701,1 49796,0 49815,1 49856,0 49889,1 49950,0 50035,1 50070,0 50101,1 50172,0 50251,1 50270,0 50335,1 50386,0 50423,1 50518,0 50571,1 end initlist a17 0,0 35,1 71,0 166,1 234,0 329,1 330,0 331,1 426,0 470,1 500,0 529,1 600,0 660,1 692,0 718,1 751,0 801,1 832,0 898,1 964,0 1012,1 1041,0 1109,1 1119,0 1129,1 1157,0 1180,1 1196,0 1198,1 1261,0 1310,1 1371,0 1402,1 1476,0 1574,1 1635,0 1658,1 1758,0 1792,1 1855,0 1871,1 1896,0 1914,1 1976,0 2069,1 2137,0 2202,1 2298,0 2390,1 2490,0 2492,1 2530,0 2584,1 2604,0 2659,1 2679,0 2770,1 2784,0 2837,1 2934,0 3034,1 3073,0 3085,1 3133,0 3153,1 3198,0 3218,1 3282,0 3313,1 3381,0 3476,1 3571,0 3590,1 3634,0 3674,1 3718,0 3732,1 3794,0 3817,1 3913,0 3934,1 3982,0 4082,1 4102,0 4126,1 4166,0 4196,1 4227,0 4260,1 4298,0 4315,1 4337,0 4424,1 4456,0 4528,1 4571,0 4621,1 4682,0 4693,1 4741,0 4787,1 4857,0 4893,1 4965,0 5020,1 5049,0 5100,1 5113,0 5185,1 5277,0 5359,1 5425,0 5454,1 5522,0 5608,1 5657,0 5746,1 5755,0 5804,1 5855,0 5926,1 5979,0 6056,1 6107,0 6150,1 6219,0 6283,1 6317,0 6387,1 6390,0 6448,1 6535,0 6587,1 6606,0 6704,1 6751,0 6848,1 6930,0 7014,1 7061,0 7153,1 7171,0 7190,1 7196,0 7272,1 7288,0 7334,1 7434,0 7470,1 7510,0 7536,1 7591,0 7691,1 7771,0 7839,1 7840,0 7862,1 7948,0 7972,1 8006,0 8083,1 8114,0 8116,1 8125,0 8199,1 8227,0 8293,1 8375,0 8435,1 8451,0 8474,1 8553,0 8643,1 8709,0 8788,1 8815,0 8835,1 8927,0 8929,1 9009,0 9037,1 9096,0 9123,1 9202,0 9294,1 9365,0 9400,1 9446,0 9507,1 9511,0 9605,1 9666,0 9703,1 9800,0 9883,1 9971,0 10022,1 10088,0 10095,1 10146,0 10215,1 10218,0 10222,1 10306,0 10389,1 10457,0 10489,1 10518,0 10560,1 10618,0 10642,1 10723,0 10754,1 10803,0 10857,1 10868,0 10881,1 10969,0 10981,1 11027,0 11126,1 11127,0 11172,1 11250,0 11285,1 11323,0 11363,1 11401,0 11432,1 11491,0 11509,1 11588,0 11634,1 11670,0 11765,1 11779,0 11819,1 11836,0 11903,1 11973,0 11998,1 12058,0 12095,1 12169,0 12172,1 12245,0 12326,1 12358,0 12369,1 12400,0 12411,1 12474,0 12552,1 12562,0 12613,1 12670,0 12760,1 12843,0 12878,1 12925,0 12981,1 13070,0 13125,1 13180,0 13189,1 13272,0 13371,1 13425,0 13458,1 13538,0 13603,1 13680,0 13713,1 13800,0 13871,1 13923,0 14004,1 14022,0 14105,1 14168,0 14185,1 14250,0 14314,1 14322,0 14375,1 14383,0 14463,1 14557,0 14568,1 14591,0 14627,1 14640,0 14717,1 14765,0 14848,1 14922,0 15006,1 15074,0 15121,1 15148,0 15173,1 15196,0 15214,1 15256,0 15297,1 15312,0 15409,1 15421,0 15452,1 15464,0 15482,1 15546,0 15549,1 15566,0 15628,1 15699,0 15774,1 15820,0 15863,1 15915,0 15927,1 15934,0 15957,1 15975,0 16020,1 16103,0 16195,1 16242,0 16268,1 16292,0 16297,1 16306,0 16368,1 16372,0 16389,1 16452,0 16512,1 16523,0 16531,1 16624,0 16628,1 16696,0 16791,1 16821,0 16883,1 16946,0 17005,1 17092,0 17185,1 17240,0 17287,1 17346,0 17414,1 17510,0 17567,1 17570,0 17611,1 17705,0 17751,1 17806,0 17873,1 17966,0 18038,1 18043,0 18139,1 18202,0 18294,1 18361,0 18383,1 18394,0 18483,1 18531,0 18575,1 18669,0 18677,1 18719,0 18758,1 18838,0 18905,1 18985,0 19012,1 19112,0 19131,1 19154,0 19184,1 19228,0 19290,1 19381,0 19467,1 19499,0 19591,1 19653,0 19703,1 19788,0 19791,1 19824,0 19838,1 19929,0 19950,1 20030,0 20090,1 20144,0 20172,1 20244,0 20254,1 20293,0 20339,1 20364,0 20453,1 20553,0 20570,1 20617,0 20670,1 20680,0 20708,1 20724,0 20808,1 20845,0 20922,1 21019,0 21095,1 21138,0 21142,1 21208,0 21216,1 21302,0 21304,1 21365,0 21370,1 21465,0 21550,1 21631,0 21663,1 21664,0 21683,1 21751,0 21800,1 21804,0 21869,1 21916,0 21999,1 22016,0 22025,1 22041,0 22109,1 22158,0 22232,1 22297,0 22364,1 22426,0 22449,1 22541,0 22549,1 22559,0 22648,1 22670,0 22699,1 22735,0 22794,1 22850,0 22871,1 22904,0 22906,1 23006,0 23065,1 23165,0 23170,1 23238,0 23316,1 23392,0 23446,1 23475,0 23517,1 23617,0 23648,1 23698,0 23762,1 23838,0 23924,1 23936,0 23957,1 23984,0 24021,1 24079,0 24112,1 24163,0 24180,1 24278,0 24331,1 24368,0 24418,1 24514,0 24602,1 24660,0 24760,1 24860,0 24866,1 24910,0 24925,1 25006,0 25025,1 25068,0 25112,1 25116,0 25134,1 25200,0 25273,1 25293,0 25371,1 25407,0 25483,1 25572,0 25590,1 25606,0 25624,1 25715,0 25804,1 25808,0 25839,1 25937,0 26004,1 26049,0 26128,1 26207,0 26209,1 26232,0 26299,1 26303,0 26360,1 26429,0 26465,1 26484,0 26533,1 26561,0 26579,1 26658,0 26663,1 26713,0 26803,1 26828,0 26885,1 26926,0 26934,1 26987,0 26996,1 27094,0 27139,1 27140,0 27210,1 27282,0 27351,1 27373,0 27401,1 27493,0 27578,1 27580,0 27656,1 27756,0 27803,1 27812,0 27868,1 27913,0 27994,1 28019,0 28116,1 28210,0 28280,1 28325,0 28420,1 28457,0 28538,1 28618,0 28715,1 28801,0 28823,1 28865,0 28920,1 28983,0 28989,1 29040,0 29113,1 29174,0 29240,1 29336,0 29414,1 29496,0 29589,1 29626,0 29705,1 29757,0 29768,1 29804,0 29836,1 29848,0 29946,1 30042,0 30096,1 30178,0 30232,1 30325,0 30389,1 30482,0 30492,1 30545,0 30637,1 30686,0 30759,1 30849,0 30918,1 30936,0 31031,1 31131,0 31210,1 31277,0 31350,1 31383,0 31385,1 31410,0 31438,1 31515,0 31535,1 31565,0 31633,1 31712,0 31798,1 31805,0 31873,1 31876,0 31912,1 31924,0 32014,1 32095,0 32102,1 32162,0 32201,1 32277,0 32341,1 32374,0 32395,1 32451,0 32503,1 32508,0 32532,1 32621,0 32635,1 32699,0 32750,1 32820,0 32884,1 32932,0 33001,1 33081,0 33105,1 33121,0 33179,1 33259,0 33333,1 33368,0 33411,1 33412,0 33468,1 33485,0 33543,1 33547,0 33641,1 33682,0 33690,1 33775,0 33777,1 33867,0 33909,1 33934,0 33977,1 34064,0 34069,1 34086,0 34127,1 34168,0 34254,1 34284,0 34370,1 34403,0 34479,1 34553,0 34608,1 34700,0 34783,1 34790,0 34830,1 34855,0 34933,1 34978,0 35032,1 35077,0 35124,1 35138,0 35226,1 35286,0 35307,1 35367,0 35446,1 35528,0 35620,1 35635,0 35676,1 35726,0 35769,1 35842,0 35879,1 35911,0 35990,1 36052,0 36073,1 36111,0 36155,1 36233,0 36261,1 36320,0 36339,1 36399,0 36449,1 36494,0 36497,1 36586,0 36613,1 36699,0 36796,1 36836,0 36907,1 36916,0 37003,1 37079,0 37155,1 37184,0 37264,1 37316,0 37383,1 37454,0 37548,1 37603,0 37604,1 37609,0 37664,1 37674,0 37723,1 37774,0 37818,1 37885,0 37961,1 38034,0 38100,1 38179,0 38254,1 38342,0 38427,1 38521,0 38545,1 38620,0 38707,1 38774,0 38813,1 38874,0 38940,1 38996,0 39088,1 39181,0 39183,1 39242,0 39327,1 39336,0 39385,1 39422,0 39460,1 39500,0 39544,1 39601,0 39675,1 39691,0 39773,1 39831,0 39928,1 39967,0 40047,1 40120,0 40200,1 40223,0 40256,1 40274,0 40317,1 40335,0 40360,1 40368,0 40374,1 40456,0 40513,1 40562,0 40618,1 40664,0 40755,1 40764,0 40823,1 40878,0 40948,1 40984,0 41064,1 41127,0 41215,1 41311,0 41367,1 41467,0 41510,1 41557,0 41610,1 41633,0 41674,1 41737,0 41791,1 41810,0 41901,1 41917,0 42001,1 42088,0 42168,1 42205,0 42278,1 42283,0 42293,1 42382,0 42400,1 42483,0 42497,1 42593,0 42675,1 42684,0 42736,1 42756,0 42847,1 42920,0 42938,1 43016,0 43043,1 43071,0 43134,1 43192,0 43259,1 43274,0 43283,1 43321,0 43371,1 43395,0 43467,1 43487,0 43497,1 43547,0 43565,1 43582,0 43592,1 43692,0 43763,1 43854,0 43915,1 43924,0 44016,1 44081,0 44111,1 44129,0 44177,1 44188,0 44283,1 44305,0 44355,1 44442,0 44487,1 44545,0 44619,1 44665,0 44719,1 44731,0 44739,1 44762,0 44831,1 44862,0 44954,1 44988,0 45056,1 45116,0 45191,1 45272,0 45369,1 45378,0 45419,1 45450,0 45522,1 45591,0 45660,1 45718,0 45812,1 45846,0 45858,1 45896,0 45992,1 46086,0 46149,1 46242,0 46287,1 46316,0 46405,1 46417,0 46471,1 46532,0 46632,1 46705,0 46751,1 46843,0 46873,1 46874,0 46883,1 46965,0 47004,1 47024,0 47106,1 47180,0 47272,1 47328,0 47372,1 47440,0 47441,1 47471,0 47501,1 47541,0 47542,1 47625,0 47644,1 47673,0 47757,1 47788,0 47802,1 47848,0 47897,1 47973,0 47981,1 47988,0 48078,1 48139,0 48226,1 48242,0 48331,1 48422,0 48494,1 48579,0 48652,1 48668,0 48671,1 48707,0 48780,1 48860,0 48896,1 48914,0 49008,1 49075,0 49173,1 49266,0 49268,1 49341,0 49384,1 49433,0 49495,1 49551,0 49615,1 49655,0 49674,1 49729,0 49752,1 49761,0 49784,1 49788,0 49796,1 49813,0 49912,1 49974,0 50044,1 50103,0 50135,1 50218,0 50234,1 50256,0 50341,1 50353,0 50415,1 50494,0 50552,1 50639,0 50648,1 50679,0 50700,1 50766,0 50824,1 50857,0 50909,1 50935,0 50975,1 end initlist a18 0,0 58,1 98,0 101,1 188,0 257,1 263,0 343,1 363,0 414,1 418,0 454,1 488,0 496,1 531,0 586,1 682,0 781,1 831,0 896,1 939,0 972,1 997,0 1030,1 1095,0 1103,1 1188,0 1276,1 1282,0 1369,1 1447,0 1512,1 1527,0 1561,1 1591,0 1648,1 1725,0 1737,1 1758,0 1842,1 1862,0 1961,1 2057,0 2108,1 2175,0 2245,1 2274,0 2353,1 2395,0 2426,1 2460,0 2462,1 2542,0 2589,1 2653,0 2705,1 2712,0 2795,1 2812,0 2873,1 2928,0 2997,1 3010,0 3055,1 3078,0 3174,1 3224,0 3265,1 3275,0 3362,1 3434,0 3508,1 3533,0 3568,1 3603,0 3635,1 3682,0 3782,1 3785,0 3845,1 3892,0 3976,1 4054,0 4119,1 4214,0 4279,1 4348,0 4421,1 4479,0 4515,1 4535,0 4610,1 4665,0 4674,1 4710,0 4764,1 4846,0 4885,1 4886,0 4966,1 5052,0 5082,1 5096,0 5150,1 5165,0 5214,1 5232,0 5264,1 5310,0 5398,1 5494,0 5499,1 5584,0 5632,1 5710,0 5742,1 5838,0 5935,1 5983,0 6042,1 6113,0 6160,1 6192,0 6254,1 6274,0 6349,1 6360,0 6443,1 6496,0 6541,1 6550,0 6622,1 6700,0 6727,1 6748,0 6796,1 6816,0 6865,1 6895,0 6989,1 7084,0 7129,1 7183,0 7208,1 7267,0 7268,1 7340,0 7405,1 7505,0 7543,1 7622,0 7687,1 7754,0 7854,1 7950,0 7964,1 8064,0 8108,1 8139,0 8239,1 8325,0 8395,1 8416,0 8479,1 8500,0 8551,1 8587,0 8602,1 8612,0 8627,1 8665,0 8749,1 8817,0 8833,1 8922,0 8950,1 9005,0 9096,1 9176,0 9261,1 9353,0 9426,1 9491,0 9560,1 9653,0 9695,1 9786,0 9874,1 9955,0 9976,1 10074,0 10110,1 10116,0 10182,1 10280,0 10371,1 10402,0 10407,1 10463,0 10515,1 10549,0 10589,1 10674,0 10721,1 10732,0 10793,1 10869,0 10948,1 11021,0 11081,1 11123,0 11156,1 11190,0 11208,1 11269,0 11280,1 11334,0 11402,1 11489,0 11561,1 11621,0 11669,1 11730,0 11795,1 11881,0 11967,1 11991,0 12016,1 12049,0 12074,1 12174,0 12209,1 12271,0 12291,1 12302,0 12329,1 12415,0 12486,1 12540,0 12589,1 12645,0 12731,1 12749,0 12811,1 12821,0 12875,1 12878,0 12978,1 13054,0 13130,1 13192,0 13224,1 13291,0 13367,1 13451,0 13547,1 13604,0 13617,1 13714,0 13789,1 13814,0 13911,1 13930,0 13982,1 14058,0 14089,1 14163,0 14179,1 14243,0 14285,1 14356,0 14377,1 14469,0 14540,1 14628,0 14644,1 14672,0 14759,1 14761,0 14798,1 14833,0 14865,1 14899,0 14914,1 14965,0 14988,1 15073,0 15128,1 15138,0 15212,1 15262,0 15362,1 15403,0 15435,1 15514,0 15588,1 15645,0 15690,1 15703,0 15770,1 15807,0 15898,1 15927,0 15928,1 15952,0 15986,1 16086,0 16127,1 16178,0 16181,1 16219,0 16313,1 16336,0 16343,1 16401,0 16444,1 16455,0 16547,1 16645,0 16726,1 16754,0 16834,1 16885,0 16965,1 17014,0 17073,1 17165,0 17180,1 17212,0 17267,1 17361,0 17393,1 17462,0 17488,1 17566,0 17639,1 17664,0 17733,1 17767,0 17841,1 17928,0 17984,1 18011,0 18029,1 18108,0 18140,1 18188,0 18241,1 18243,0 18318,1 18323,0 18332,1 18346,0 18398,1 18425,0 18520,1 18577,0 18647,1 18667,0 18703,1 18715,0 18734,1 18741,0 18811,1 18881,0 18942,1 19037,0 19103,1 19191,0 19285,1 19289,0 19362,1 19369,0 19407,1 19496,0 19589,1 19642,0 19660,1 19711,0 19744,1 19820,0 19837,1 19930,0 20008,1 20060,0 20128,1 20201,0 20262,1 20310,0 20394,1 20415,0 20444,1 20531,0 20548,1 20591,0 20663,1 20682,0 20767,1 20797,0 20859,1 20928,0 20995,1 21075,0 21099,1 21123,0 21219,1 21296,0 21314,1 21354,0 21449,1 21498,0 21503,1 21504,0 21581,1 21659,0 21669,1 21729,0 21732,1 21816,0 21889,1 21914,0 21982,1 22060,0 22112,1 22127,0 22169,1 22195,0 22256,1 22349,0 22421,1 22452,0 22468,1 22525,0 22624,1 22669,0 22757,1 22758,0 22782,1 22801,0 22853,1 22896,0 22916,1 22934,0 22936,1 22949,0 22980,1 23040,0 23065,1 23136,0 23218,1 23284,0 23298,1 23383,0 23458,1 23521,0 23562,1 23632,0 23711,1 23730,0 23743,1 23796,0 23844,1 23871,0 23895,1 23994,0 24022,1 24100,0 24121,1 24142,0 24241,1 24256,0 24323,1 24329,0 24429,1 24441,0 24533,1 24588,0 24667,1 24709,0 24732,1 24752,0 24784,1 24865,0 24923,1 25019,0 25051,1 25132,0 25208,1 25288,0 25325,1 25413,0 25459,1 25501,0 25600,1 25606,0 25692,1 25727,0 25821,1 25886,0 25925,1 26001,0 26100,1 26149,0 26223,1 26308,0 26391,1 26397,0 26493,1 26530,0 26533,1 26609,0 26614,1 26662,0 26709,1 26773,0 26821,1 26840,0 26891,1 26951,0 26974,1 27000,0 27066,1 27111,0 27139,1 27171,0 27209,1 27247,0 27285,1 27288,0 27357,1 27394,0 27450,1 27476,0 27536,1 27591,0 27647,1 27724,0 27793,1 27850,0 27903,1 27991,0 28012,1 28092,0 28149,1 28160,0 28207,1 28279,0 28347,1 28365,0 28464,1 28475,0 28495,1 28526,0 28544,1 28579,0 28640,1 28722,0 28729,1 28825,0 28890,1 28942,0 29039,1 29086,0 29149,1 29233,0 29251,1 29350,0 29418,1 29506,0 29592,1 29625,0 29707,1 29739,0 29826,1 29900,0 29974,1 29990,0 30045,1 30056,0 30138,1 30157,0 30229,1 30266,0 30326,1 30337,0 30341,1 30361,0 30446,1 30501,0 30545,1 30574,0 30656,1 30678,0 30761,1 30815,0 30900,1 30957,0 31042,1 31058,0 31114,1 31182,0 31267,1 31320,0 31406,1 31459,0 31552,1 31651,0 31703,1 31751,0 31816,1 31905,0 31981,1 32041,0 32079,1 32097,0 32197,1 32209,0 32298,1 32390,0 32435,1 32467,0 32547,1 32568,0 32579,1 32609,0 32698,1 32759,0 32832,1 32851,0 32870,1 32929,0 32960,1 33040,0 33140,1 33240,0 33297,1 33380,0 33403,1 33442,0 33453,1 33492,0 33524,1 33577,0 33640,1 33729,0 33818,1 33847,0 33917,1 33931,0 34012,1 34105,0 34196,1 34290,0 34299,1 34312,0 34322,1 34352,0 34443,1 34503,0 34582,1 34628,0 34651,1 34656,0 34724,1 34759,0 34790,1 34835,0 34854,1 34931,0 35030,1 35070,0 35162,1 35183,0 35228,1 35277,0 35366,1 35419,0 35473,1 35528,0 35545,1 35565,0 35631,1 35689,0 35726,1 35732,0 35810,1 35818,0 35820,1 35890,0 35917,1 35941,0 36008,1 36076,0 36104,1 36181,0 36241,1 36300,0 36389,1 36428,0 36504,1 36527,0 36607,1 36634,0 36721,1 36736,0 36769,1 36832,0 36840,1 36870,0 36895,1 36919,0 36959,1 36964,0 36993,1 37057,0 37107,1 37160,0 37215,1 37244,0 37306,1 37336,0 37354,1 37359,0 37459,1 37559,0 37585,1 37602,0 37695,1 37726,0 37786,1 37803,0 37901,1 37924,0 37985,1 37997,0 38036,1 38046,0 38091,1 38182,0 38237,1 38297,0 38334,1 38374,0 38436,1 38499,0 38524,1 38539,0 38541,1 38633,0 38650,1 38730,0 38828,1 38888,0 38968,1 39060,0 39131,1 39213,0 39285,1 39364,0 39449,1 39500,0 39539,1 39618,0 39624,1 39643,0 39659,1 39671,0 39744,1 39828,0 39892,1 39978,0 40059,1 40077,0 40151,1 40192,0 40287,1 40289,0 40324,1 40335,0 40384,1 40435,0 40452,1 40493,0 40586,1 40668,0 40764,1 40823,0 40827,1 40919,0 40954,1 41023,0 41054,1 41134,0 41213,1 41283,0 41286,1 41373,0 41418,1 41464,0 41466,1 41471,0 41473,1 41508,0 41607,1 41682,0 41702,1 41745,0 41786,1 41831,0 41904,1 41974,0 42050,1 42096,0 42167,1 42241,0 42280,1 42295,0 42389,1 42468,0 42469,1 42549,0 42577,1 42588,0 42615,1 42619,0 42630,1 42672,0 42675,1 42748,0 42812,1 42866,0 42926,1 43002,0 43023,1 43036,0 43119,1 43134,0 43166,1 43191,0 43275,1 43347,0 43423,1 43456,0 43522,1 43560,0 43578,1 43644,0 43675,1 43724,0 43805,1 43843,0 43907,1 43977,0 44059,1 44113,0 44210,1 44289,0 44363,1 44388,0 44483,1 44491,0 44494,1 44575,0 44591,1 44659,0 44699,1 44765,0 44843,1 44879,0 44950,1 45042,0 45067,1 45140,0 45186,1 45199,0 45238,1 45255,0 45262,1 45339,0 45398,1 45439,0 45517,1 45612,0 45664,1 45740,0 45834,1 45840,0 45926,1 46023,0 46044,1 46106,0 46127,1 46178,0 46221,1 46318,0 46327,1 46408,0 46472,1 46547,0 46618,1 46717,0 46760,1 46834,0 46933,1 46979,0 47057,1 47091,0 47101,1 47125,0 47181,1 47207,0 47260,1 47331,0 47345,1 47405,0 47429,1 47528,0 47555,1 47572,0 47645,1 47674,0 47716,1 47779,0 47858,1 47875,0 47930,1 48002,0 48063,1 48075,0 48077,1 48121,0 48184,1 48258,0 48264,1 48279,0 48316,1 48410,0 48444,1 48453,0 48471,1 48565,0 48601,1 48689,0 48721,1 48736,0 48757,1 48768,0 48780,1 48808,0 48890,1 48965,0 49009,1 49099,0 49143,1 49169,0 49207,1 49243,0 49337,1 49426,0 49451,1 49489,0 49497,1 49566,0 49574,1 49596,0 49678,1 49764,0 49778,1 49852,0 49856,1 49873,0 49951,1 49995,0 50021,1 50045,0 50144,1 50213,0 50302,1 50326,0 50402,1 50427,0 50444,1 50509,0 50587,1 50672,0 50737,1 50810,0 50904,1 51000,0 51081,1 51101,0 51196,1 51202,0 51208,1 51244,0 51294,1 51376,0 51409,1 51507,0 51550,1 51599,0 51621,1 end initlist a19 0,0 9,1 12,0 90,1 187,0 202,1 244,0 246,1 270,0 322,1 421,0 436,1 481,0 509,1 513,0 591,1 631,0 678,1 691,0 701,1 744,0 771,1 831,0 884,1 928,0 1028,1 1057,0 1149,1 1200,0 1232,1 1282,0 1369,1 1428,0 1441,1 1485,0 1525,1 1586,0 1631,1 1724,0 1786,1 1843,0 1853,1 1910,0 1969,1 2038,0 2132,1 2195,0 2229,1 2325,0 2362,1 2397,0 2473,1 2522,0 2556,1 2574,0 2582,1 2608,0 2689,1 2776,0 2786,1 2795,0 2866,1 2958,0 3018,1 3088,0 3171,1 3173,0 3254,1 3312,0 3391,1 3465,0 3557,1 3625,0 3636,1 3664,0 3699,1 3713,0 3724,1 3770,0 3859,1 3868,0 3922,1 3984,0 4040,1 4129,0 4154,1 4187,0 4233,1 4314,0 4371,1 4408,0 4486,1 4501,0 4556,1 4622,0 4721,1 4749,0 4777,1 4842,0 4916,1 5015,0 5100,1 5109,0 5132,1 5183,0 5192,1 5272,0 5366,1 5442,0 5486,1 5521,0 5617,1 5695,0 5731,1 5825,0 5874,1 5937,0 5948,1 6006,0 6022,1 6024,0 6093,1 6130,0 6212,1 6250,0 6272,1 6329,0 6368,1 6372,0 6463,1 6472,0 6519,1 6568,0 6629,1 6661,0 6721,1 6821,0 6911,1 7008,0 7043,1 7120,0 7197,1 7213,0 7307,1 7378,0 7390,1 7455,0 7541,1 7550,0 7565,1 7651,0 7667,1 7688,0 7699,1 7723,0 7770,1 7813,0 7905,1 7979,0 8005,1 8041,0 8059,1 8081,0 8143,1 8218,0 8219,1 8265,0 8315,1 8350,0 8425,1 8508,0 8552,1 8594,0 8674,1 8676,0 8730,1 8813,0 8895,1 8916,0 8928,1 8964,0 9008,1 9093,0 9145,1 9212,0 9264,1 9321,0 9364,1 9444,0 9471,1 9494,0 9512,1 9555,0 9619,1 9623,0 9627,1 9646,0 9709,1 9794,0 9846,1 9891,0 9958,1 9960,0 10020,1 10091,0 10170,1 10196,0 10245,1 10312,0 10380,1 10475,0 10572,1 10573,0 10635,1 10687,0 10722,1 10767,0 10797,1 10812,0 10827,1 10920,0 10948,1 11027,0 11061,1 11092,0 11186,1 11263,0 11295,1 11338,0 11424,1 11456,0 11524,1 11604,0 11612,1 11616,0 11619,1 11660,0 11754,1 11798,0 11802,1 11881,0 11955,1 11980,0 12012,1 12102,0 12158,1 12205,0 12273,1 12280,0 12360,1 12367,0 12395,1 12485,0 12503,1 12587,0 12599,1 12642,0 12662,1 12740,0 12769,1 12778,0 12875,1 12907,0 13005,1 13052,0 13138,1 13215,0 13243,1 13244,0 13327,1 13426,0 13488,1 13579,0 13597,1 13669,0 13719,1 13762,0 13773,1 13831,0 13897,1 13936,0 13970,1 14008,0 14043,1 14056,0 14117,1 14162,0 14170,1 14266,0 14306,1 14366,0 14380,1 14393,0 14468,1 14530,0 14577,1 14644,0 14693,1 14780,0 14819,1 14917,0 14957,1 14969,0 15005,1 15028,0 15105,1 15187,0 15225,1 15306,0 15366,1 15399,0 15472,1 15515,0 15574,1 15656,0 15714,1 15801,0 15864,1 15934,0 15935,1 16006,0 16007,1 16084,0 16138,1 16203,0 16204,1 16205,0 16255,1 16285,0 16355,1 16409,0 16442,1 16533,0 16547,1 16567,0 16646,1 16686,0 16786,1 16829,0 16901,1 16981,0 17040,1 17090,0 17095,1 17130,0 17193,1 17212,0 17312,1 17377,0 17385,1 17471,0 17520,1 17603,0 17672,1 17751,0 17797,1 17820,0 17887,1 17937,0 17997,1 18007,0 18022,1 18024,0 18027,1 18028,0 18109,1 18156,0 18188,1 18260,0 18292,1 18377,0 18416,1 18460,0 18495,1 18553,0 18646,1 18681,0 18718,1 18789,0 18846,1 18888,0 18970,1 18975,0 19013,1 19016,0 19048,1 19129,0 19214,1 19279,0 19353,1 19413,0 19457,1 19541,0 19608,1 19663,0 19731,1 19780,0 19803,1 19826,0 19925,1 20020,0 20034,1 20117,0 20204,1 20236,0 20286,1 20329,0 20381,1 20461,0 20535,1 20539,0 20614,1 20692,0 20718,1 20796,0 20890,1 20961,0 21055,1 21111,0 21122,1 21150,0 21230,1 21237,0 21287,1 21292,0 21343,1 21344,0 21413,1 21442,0 21518,1 21547,0 21642,1 21673,0 21758,1 21760,0 21822,1 21894,0 21936,1 22014,0 22062,1 22080,0 22092,1 22128,0 22226,1 22313,0 22393,1 22475,0 22558,1 22603,0 22617,1 22711,0 22758,1 22831,0 22876,1 22944,0 23025,1 23107,0 23120,1 23125,0 23205,1 23273,0 23350,1 23450,0 23469,1 23492,0 23558,1 23590,0 23659,1 23695,0 23787,1 23879,0 23978,1 24011,0 24074,1 24174,0 24234,1 24262,0 24320,1 24324,0 24391,1 24444,0 24476,1 24563,0 24662,1 24684,0 24710,1 24762,0 24795,1 24806,0 24810,1 24902,0 24999,1 25016,0 25098,1 25144,0 25148,1 25162,0 25207,1 25286,0 25308,1 25317,0 25370,1 25395,0 25455,1 25507,0 25572,1 25595,0 25668,1 25733,0 25742,1 25805,0 25868,1 25948,0 25984,1 26061,0 26124,1 26145,0 26207,1 26243,0 26290,1 26306,0 26325,1 26396,0 26436,1 26477,0 26557,1 26592,0 26685,1 26692,0 26730,1 26772,0 26794,1 26798,0 26806,1 26905,0 26959,1 27039,0 27052,1 27102,0 27165,1 27201,0 27211,1 27227,0 27271,1 27319,0 27343,1 27374,0 27462,1 27538,0 27552,1 27595,0 27618,1 27662,0 27695,1 27736,0 27760,1 27793,0 27875,1 27968,0 28056,1 28091,0 28153,1 28198,0 28211,1 28292,0 28298,1 28371,0 28454,1 28467,0 28490,1 28583,0 28671,1 28755,0 28808,1 28819,0 28872,1 28914,0 28921,1 29008,0 29055,1 29069,0 29070,1 29099,0 29145,1 29205,0 29300,1 29326,0 29376,1 29391,0 29401,1 29465,0 29491,1 29590,0 29668,1 29725,0 29807,1 29817,0 29820,1 29848,0 29929,1 30012,0 30079,1 30102,0 30117,1 30215,0 30264,1 30290,0 30342,1 30371,0 30463,1 30478,0 30537,1 30548,0 30624,1 30650,0 30729,1 30735,0 30765,1 30864,0 30935,1 31023,0 31068,1 31160,0 31191,1 31219,0 31258,1 31321,0 31343,1 31382,0 31477,1 31497,0 31553,1 31642,0 31685,1 31765,0 31844,1 31859,0 31900,1 31943,0 32031,1 32044,0 32068,1 32123,0 32151,1 32209,0 32218,1 32294,0 32355,1 32412,0 32496,1 32532,0 32598,1 32651,0 32743,1 32800,0 32887,1 32987,0 33009,1 33033,0 33080,1 33082,0 33140,1 33205,0 33272,1 33318,0 33339,1 33377,0 33474,1 33510,0 33535,1 33557,0 33648,1 33739,0 33745,1 33818,0 33844,1 33929,0 33944,1 33969,0 34048,1 34084,0 34164,1 34215,0 34306,1 34381,0 34480,1 34518,0 34614,1 34700,0 34757,1 34850,0 34923,1 34959,0 35031,1 35033,0 35121,1 35144,0 35162,1 35236,0 35300,1 35400,0 35481,1 35485,0 35578,1 35622,0 35682,1 35768,0 35865,1 35884,0 35955,1 35974,0 36015,1 36049,0 36078,1 36152,0 36199,1 36234,0 36320,1 36349,0 36397,1 36457,0 36495,1 36510,0 36545,1 36582,0 36637,1 36720,0 36736,1 36745,0 36795,1 36801,0 36803,1 36876,0 36896,1 36906,0 36985,1 37014,0 37104,1 37112,0 37115,1 37129,0 37219,1 37262,0 37283,1 37367,0 37402,1 37498,0 37519,1 37536,0 37575,1 37649,0 37730,1 37755,0 37792,1 37875,0 37966,1 37990,0 38072,1 38105,0 38164,1 38223,0 38238,1 38264,0 38267,1 38362,0 38386,1 38460,0 38507,1 38511,0 38584,1 38659,0 38743,1 38843,0 38934,1 39012,0 39026,1 39066,0 39132,1 39194,0 39229,1 39307,0 39314,1 39385,0 39438,1 39448,0 39541,1 39625,0 39679,1 39722,0 39739,1 39789,0 39858,1 39928,0 39981,1 39983,0 39995,1 40035,0 40057,1 40130,0 40152,1 40206,0 40253,1 40328,0 40409,1 40424,0 40434,1 40527,0 40577,1 40589,0 40607,1 40649,0 40729,1 40788,0 40849,1 40932,0 41029,1 41108,0 41124,1 41213,0 41312,1 41392,0 41413,1 41478,0 41534,1 41567,0 41600,1 41683,0 41685,1 41721,0 41767,1 41858,0 41919,1 41970,0 42014,1 42077,0 42127,1 42175,0 42189,1 42238,0 42264,1 42270,0 42308,1 42340,0 42394,1 42475,0 42540,1 42556,0 42558,1 42573,0 42622,1 42670,0 42684,1 42693,0 42777,1 42824,0 42869,1 42895,0 42919,1 42981,0 42988,1 43087,0 43111,1 43181,0 43195,1 43215,0 43219,1 43309,0 43356,1 43427,0 43490,1 43545,0 43645,1 43663,0 43713,1 43754,0 43832,1 43905,0 43912,1 43925,0 43990,1 44004,0 44063,1 44078,0 44104,1 44158,0 44179,1 44252,0 44274,1 44348,0 44435,1 44482,0 44509,1 44534,0 44595,1 44604,0 44692,1 44723,0 44765,1 44770,0 44781,1 44863,0 44926,1 44944,0 45040,1 45076,0 45111,1 45125,0 45157,1 45253,0 45288,1 45302,0 45374,1 45426,0 45506,1 45595,0 45649,1 45738,0 45741,1 45766,0 45776,1 45822,0 45875,1 45971,0 46070,1 46166,0 46213,1 46258,0 46313,1 46408,0 46502,1 46575,0 46586,1 46614,0 46684,1 46741,0 46814,1 46905,0 46913,1 46945,0 46999,1 47090,0 47146,1 47168,0 47219,1 47286,0 47371,1 47450,0 47506,1 47548,0 47599,1 47671,0 47713,1 47749,0 47770,1 47822,0 47870,1 47915,0 47974,1 48048,0 48110,1 48208,0 48220,1 48291,0 48381,1 48432,0 48530,1 48536,0 48545,1 48565,0 48626,1 48678,0 48739,1 48763,0 48810,1 48857,0 48910,1 48922,0 48937,1 49022,0 49117,1 49163,0 49217,1 49288,0 49355,1 49416,0 49459,1 49499,0 49586,1 49622,0 49710,1 49779,0 49876,1 49909,0 49959,1 50059,0 50134,1 50141,0 50200,1 50280,0 50322,1 50403,0 50501,1 end initlist a20 0,0 23,1 65,0 128,1 148,0 198,1 208,0 226,1 254,0 261,1 353,0 440,1 499,0 549,1 595,0 652,1 687,0 763,1 776,0 778,1 841,0 866,1 914,0 978,1 1062,0 1129,1 1214,0 1226,1 1240,0 1277,1 1305,0 1375,1 1402,0 1444,1 1508,0 1545,1 1548,0 1611,1 1625,0 1658,1 1669,0 1733,1 1750,0 1757,1 1845,0 1859,1 1940,0 2026,1 2087,0 2112,1 2153,0 2245,1 2339,0 2345,1 2362,0 2456,1 2489,0 2582,1 2590,0 2643,1 2710,0 2801,1 2866,0 2868,1 2927,0 3016,1 3071,0 3113,1 3189,0 3205,1 3277,0 3352,1 3366,0 3414,1 3460,0 3560,1 3583,0 3615,1 3656,0 3697,1 3750,0 3825,1 3865,0 3953,1 3971,0 3994,1 4026,0 4095,1 4108,0 4193,1 4261,0 4297,1 4346,0 4379,1 4403,0 4487,1 4547,0 4642,1 4742,0 4763,1 4785,0 4817,1 4910,0 4960,1 5002,0 5085,1 5152,0 5209,1 5216,0 5264,1 5279,0 5343,1 5350,0 5417,1 5423,0 5447,1 5508,0 5513,1 5525,0 5601,1 5685,0 5717,1 5783,0 5879,1 5945,0 6041,1 6086,0 6144,1 6240,0 6338,1 6343,0 6434,1 6460,0 6497,1 6536,0 6630,1 6701,0 6719,1 6775,0 6788,1 6824,0 6894,1 6958,0 7020,1 7023,0 7057,1 7093,0 7164,1 7165,0 7171,1 7200,0 7281,1 7323,0 7397,1 7407,0 7445,1 7469,0 7500,1 7546,0 7580,1 7630,0 7656,1 7744,0 7793,1 7797,0 7830,1 7842,0 7916,1 7938,0 7969,1 8057,0 8099,1 8150,0 8233,1 8333,0 8367,1 8379,0 8473,1 8510,0 8544,1 8601,0 8611,1 8633,0 8703,1 8798,0 8885,1 8905,0 8954,1 8972,0 8997,1 9094,0 9187,1 9213,0 9280,1 9313,0 9330,1 9400,0 9481,1 9493,0 9510,1 9569,0 9634,1 9665,0 9713,1 9731,0 9778,1 9843,0 9940,1 9965,0 10021,1 10063,0 10071,1 10130,0 10193,1 10207,0 10223,1 10311,0 10353,1 10378,0 10412,1 10421,0 10449,1 10453,0 10533,1 10548,0 10618,1 10680,0 10756,1 10783,0 10843,1 10860,0 10957,1 11002,0 11066,1 11135,0 11145,1 11167,0 11182,1 11214,0 11241,1 11303,0 11387,1 11443,0 11489,1 11558,0 11564,1 11637,0 11690,1 11701,0 11782,1 11804,0 11829,1 11878,0 11909,1 11962,0 12027,1 12089,0 12121,1 12202,0 12231,1 12243,0 12273,1 12320,0 12363,1 12387,0 12448,1 12459,0 12478,1 12518,0 12543,1 12555,0 12641,1 12651,0 12717,1 12723,0 12811,1 12877,0 12916,1 12998,0 13083,1 13139,0 13212,1 13257,0 13274,1 13284,0 13330,1 13409,0 13413,1 13501,0 13518,1 13560,0 13620,1 13677,0 13738,1 13781,0 13799,1 13856,0 13907,1 13933,0 14006,1 14035,0 14066,1 14150,0 14232,1 14273,0 14315,1 14347,0 14350,1 14432,0 14513,1 14564,0 14655,1 14711,0 14786,1 14872,0 14948,1 14998,0 15029,1 15110,0 15161,1 15174,0 15228,1 15302,0 15323,1 15418,0 15501,1 15532,0 15544,1 15629,0 15649,1 15714,0 15772,1 15863,0 15962,1 15983,0 15989,1 16045,0 16090,1 16162,0 16253,1 16266,0 16330,1 16364,0 16434,1 16509,0 16590,1 16610,0 16677,1 16763,0 16793,1 16858,0 16938,1 16974,0 17051,1 17087,0 17095,1 17192,0 17283,1 17287,0 17289,1 17338,0 17399,1 17407,0 17499,1 17558,0 17591,1 17644,0 17740,1 17747,0 17838,1 17928,0 18025,1 18095,0 18114,1 18211,0 18290,1 18371,0 18449,1 18547,0 18611,1 18616,0 18669,1 18706,0 18771,1 18785,0 18826,1 18862,0 18941,1 18990,0 19064,1 19147,0 19176,1 19209,0 19249,1 19252,0 19310,1 19366,0 19452,1 19465,0 19552,1 19604,0 19691,1 19693,0 19778,1 19792,0 19794,1 19876,0 19893,1 19957,0 20038,1 20073,0 20149,1 20233,0 20296,1 20320,0 20376,1 20475,0 20547,1 20617,0 20664,1 20715,0 20716,1 20722,0 20773,1 20846,0 20907,1 20931,0 21019,1 21092,0 21176,1 21204,0 21292,1 21377,0 21467,1 21510,0 21533,1 21557,0 21567,1 21595,0 21691,1 21733,0 21817,1 21874,0 21927,1 21970,0 21990,1 22030,0 22047,1 22124,0 22129,1 22158,0 22177,1 22251,0 22274,1 22358,0 22457,1 22527,0 22596,1 22617,0 22668,1 22692,0 22732,1 22824,0 22861,1 22953,0 23033,1 23057,0 23090,1 23140,0 23173,1 23257,0 23318,1 23332,0 23418,1 23480,0 23489,1 23497,0 23510,1 23590,0 23658,1 23717,0 23763,1 23794,0 23812,1 23831,0 23876,1 23967,0 23982,1 24072,0 24125,1 24221,0 24301,1 24323,0 24409,1 24491,0 24584,1 24678,0 24763,1 24810,0 24859,1 24861,0 24960,1 25043,0 25137,1 25234,0 25266,1 25294,0 25320,1 25333,0 25391,1 25460,0 25541,1 25615,0 25647,1 25660,0 25701,1 25747,0 25749,1 25775,0 25871,1 25930,0 26026,1 26090,0 26098,1 26121,0 26208,1 26262,0 26362,1 26367,0 26385,1 26482,0 26520,1 26543,0 26597,1 26602,0 26674,1 26681,0 26713,1 26746,0 26825,1 26829,0 26924,1 26950,0 27031,1 27055,0 27060,1 27111,0 27211,1 27220,0 27233,1 27332,0 27347,1 27386,0 27405,1 27446,0 27491,1 27590,0 27669,1 27757,0 27843,1 27931,0 28005,1 28093,0 28121,1 28219,0 28261,1 28359,0 28365,1 28398,0 28490,1 28521,0 28551,1 28638,0 28664,1 28754,0 28755,1 28788,0 28875,1 28915,0 28926,1 28971,0 29005,1 29098,0 29150,1 29159,0 29229,1 29249,0 29308,1 29384,0 29471,1 29483,0 29524,1 29540,0 29568,1 29573,0 29578,1 29623,0 29630,1 29726,0 29756,1 29804,0 29829,1 29863,0 29918,1 29995,0 30067,1 30128,0 30176,1 30228,0 30307,1 30310,0 30363,1 30448,0 30540,1 30597,0 30697,1 30722,0 30731,1 30803,0 30807,1 30811,0 30877,1 30945,0 30968,1 31001,0 31004,1 31087,0 31102,1 31145,0 31147,1 31241,0 31321,1 31337,0 31411,1 31463,0 31502,1 31590,0 31659,1 31662,0 31675,1 31748,0 31789,1 31850,0 31925,1 31935,0 31952,1 32014,0 32092,1 32172,0 32213,1 32248,0 32294,1 32380,0 32402,1 32462,0 32510,1 32539,0 32571,1 32654,0 32685,1 32732,0 32761,1 32769,0 32787,1 32819,0 32833,1 32867,0 32960,1 32988,0 33058,1 33114,0 33214,1 33300,0 33315,1 33343,0 33431,1 33461,0 33512,1 33609,0 33633,1 33678,0 33719,1 33749,0 33786,1 33828,0 33888,1 33941,0 33950,1 33951,0 34040,1 34056,0 34083,1 34112,0 34177,1 34183,0 34225,1 34289,0 34355,1 34431,0 34482,1 34519,0 34520,1 34538,0 34636,1 34689,0 34709,1 34780,0 34868,1 34885,0 34952,1 34980,0 35078,1 35093,0 35120,1 35177,0 35270,1 35310,0 35318,1 35363,0 35432,1 35471,0 35496,1 35551,0 35570,1 35588,0 35624,1 35645,0 35693,1 35720,0 35810,1 35835,0 35922,1 35943,0 35962,1 35996,0 36058,1 36079,0 36167,1 36255,0 36324,1 36367,0 36414,1 36508,0 36560,1 36587,0 36616,1 36650,0 36663,1 36708,0 36774,1 36859,0 36955,1 37049,0 37110,1 37205,0 37220,1 37278,0 37354,1 37381,0 37457,1 37509,0 37601,1 37649,0 37654,1 37690,0 37705,1 37757,0 37811,1 37863,0 37943,1 38008,0 38081,1 38169,0 38258,1 38321,0 38342,1 38436,0 38440,1 38540,0 38547,1 38594,0 38627,1 38705,0 38769,1 38836,0 38924,1 38931,0 38951,1 39016,0 39038,1 39045,0 39052,1 39144,0 39152,1 39154,0 39208,1 39276,0 39304,1 39393,0 39476,1 39572,0 39610,1 39648,0 39674,1 39725,0 39786,1 39817,0 39900,1 39901,0 39944,1 40008,0 40067,1 40078,0 40147,1 40175,0 40274,1 40363,0 40395,1 40428,0 40496,1 40508,0 40515,1 40592,0 40632,1 40662,0 40664,1 40724,0 40745,1 40808,0 40814,1 40872,0 40874,1 40947,0 40960,1 40993,0 40998,1 41017,0 41097,1 41182,0 41211,1 41232,0 41260,1 41293,0 41296,1 41389,0 41406,1 41469,0 41559,1 41575,0 41592,1 41673,0 41768,1 41866,0 41950,1 41959,0 41987,1 41998,0 42037,1 42091,0 42128,1 42176,0 42246,1 42263,0 42271,1 42279,0 42317,1 42345,0 42349,1 42404,0 42459,1 42550,0 42560,1 42654,0 42737,1 42801,0 42841,1 42924,0 42995,1 43007,0 43049,1 43061,0 43155,1 43210,0 43252,1 43307,0 43354,1 43355,0 43449,1 43529,0 43606,1 43665,0 43736,1 43741,0 43773,1 43841,0 43846,1 43914,0 43984,1 44055,0 44074,1 44106,0 44148,1 44214,0 44309,1 44333,0 44404,1 44409,0 44462,1 44485,0 44487,1 44539,0 44542,1 44598,0 44676,1 44769,0 44774,1 44814,0 44897,1 44950,0 45043,1 45097,0 45132,1 45226,0 45260,1 45301,0 45310,1 45392,0 45452,1 45505,0 45585,1 45618,0 45654,1 45749,0 45811,1 45879,0 45975,1 46018,0 46103,1 46171,0 46246,1 46284,0 46315,1 46321,0 46346,1 46378,0 46416,1 46447,0 46454,1 46511,0 46531,1 46621,0 46688,1 46774,0 46843,1 46924,0 46993,1 46998,0 47094,1 47167,0 47191,1 47285,0 47297,1 47314,0 47356,1 47415,0 47451,1 47511,0 47532,1 47621,0 47710,1 47788,0 47842,1 47893,0 47954,1 47980,0 48078,1 48116,0 48214,1 48295,0 48320,1 48388,0 48400,1 48483,0 48529,1 48600,0 48636,1 48637,0 48692,1 48790,0 48827,1 48927,0 48981,1 49076,0 49164,1 49261,0 49296,1 49340,0 49426,1 49436,0 49513,1 49561,0 49612,1 end initlist a21 0,0 59,1 128,0 138,1 185,0 192,1 215,0 302,1 401,0 434,1 463,0 502,1 520,0 547,1 582,0 621,1 681,0 698,1 789,0 829,1 877,0 895,1 985,0 1076,1 1163,0 1180,1 1235,0 1279,1 1326,0 1378,1 1387,0 1404,1 1424,0 1522,1 1559,0 1652,1 1691,0 1791,1 1849,0 1872,1 1936,0 2007,1 2093,0 2161,1 2169,0 2183,1 2231,0 2329,1 2416,0 2511,1 2513,0 2538,1 2582,0 2634,1 2672,0 2723,1 2784,0 2800,1 2818,0 2843,1 2887,0 2970,1 3061,0 3093,1 3098,0 3141,1 3220,0 3255,1 3306,0 3361,1 3460,0 3487,1 3512,0 3528,1 3598,0 3648,1 3722,0 3780,1 3815,0 3871,1 3918,0 4009,1 4026,0 4051,1 4069,0 4098,1 4105,0 4191,1 4224,0 4239,1 4311,0 4383,1 4469,0 4504,1 4551,0 4557,1 4649,0 4732,1 4813,0 4836,1 4847,0 4903,1 4941,0 4984,1 5042,0 5116,1 5154,0 5179,1 5250,0 5272,1 5320,0 5417,1 5509,0 5544,1 5617,0 5715,1 5731,0 5753,1 5805,0 5816,1 5846,0 5878,1 5928,0 5980,1 6001,0 6064,1 6096,0 6137,1 6204,0 6261,1 6360,0 6380,1 6415,0 6501,1 6553,0 6642,1 6715,0 6741,1 6755,0 6818,1 6867,0 6957,1 6958,0 6994,1 7048,0 7125,1 7221,0 7256,1 7330,0 7392,1 7466,0 7482,1 7582,0 7642,1 7693,0 7723,1 7732,0 7751,1 7781,0 7834,1 7905,0 7950,1 8020,0 8077,1 8151,0 8245,1 8319,0 8409,1 8426,0 8433,1 8470,0 8502,1 8528,0 8577,1 8654,0 8676,1 8754,0 8794,1 8888,0 8895,1 8941,0 8997,1 9016,0 9094,1 9149,0 9214,1 9228,0 9328,1 9384,0 9430,1 9458,0 9519,1 9583,0 9679,1 9747,0 9790,1 9791,0 9879,1 9967,0 10060,1 10090,0 10124,1 10144,0 10145,1 10193,0 10202,1 10222,0 10252,1 10319,0 10347,1 10389,0 10450,1 10547,0 10623,1 10663,0 10753,1 10760,0 10814,1 10840,0 10916,1 10980,0 11029,1 11125,0 11217,1 11242,0 11269,1 11329,0 11390,1 11445,0 11464,1 11477,0 11493,1 11506,0 11537,1 11603,0 11630,1 11722,0 11759,1 11834,0 11932,1 11937,0 11976,1 12048,0 12061,1 12145,0 12196,1 12252,0 12285,1 12316,0 12376,1 12386,0 12478,1 12527,0 12619,1 12664,0 12723,1 12777,0 12843,1 12854,0 12922,1 12957,0 12962,1 12971,0 13034,1 13089,0 13178,1 13180,0 13262,1 13320,0 13348,1 13367,0 13413,1 13508,0 13549,1 13601,0 13685,1 13781,0 13814,1 13890,0 13949,1 13962,0 13966,1 14031,0 14087,1 14150,0 14217,1 14313,0 14357,1 14375,0 14444,1 14529,0 14612,1 14663,0 14703,1 14772,0 14851,1 14914,0 14943,1 15011,0 15066,1 15159,0 15247,1 15281,0 15326,1 15403,0 15447,1 15524,0 15566,1 15666,0 15732,1 15746,0 15770,1 15801,0 15865,1 15938,0 15961,1 16057,0 16148,1 16165,0 16221,1 16307,0 16375,1 16474,0 16565,1 16575,0 16620,1 16656,0 16731,1 16785,0 16789,1 16813,0 16910,1 16927,0 16986,1 17060,0 17130,1 17184,0 17224,1 17269,0 17349,1 17378,0 17402,1 17478,0 17501,1 17522,0 17543,1 17599,0 17623,1 17701,0 17781,1 17864,0 17866,1 17891,0 17895,1 17969,0 17984,1 18071,0 18074,1 18080,0 18171,1 18227,0 18323,1 18336,0 18386,1 18465,0 18513,1 18587,0 18591,1 18691,0 18735,1 18781,0 18880,1 18961,0 19020,1 19058,0 19143,1 19213,0 19239,1 19257,0 19356,1 19407,0 19454,1 19551,0 19571,1 19644,0 19737,1 19771,0 19787,1 19793,0 19826,1 19879,0 19907,1 19975,0 20035,1 20071,0 20077,1 20081,0 20088,1 20135,0 20154,1 20235,0 20323,1 20357,0 20397,1 20463,0 20478,1 20564,0 20625,1 20629,0 20656,1 20669,0 20670,1 20731,0 20802,1 20833,0 20869,1 20943,0 21013,1 21018,0 21086,1 21097,0 21147,1 21191,0 21205,1 21224,0 21283,1 21373,0 21426,1 21509,0 21522,1 21558,0 21568,1 21619,0 21651,1 21666,0 21670,1 21721,0 21770,1 21828,0 21905,1 21998,0 22024,1 22039,0 22040,1 22044,0 22144,1 22182,0 22263,1 22363,0 22425,1 22488,0 22532,1 22592,0 22662,1 22737,0 22781,1 22881,0 22922,1 22939,0 22999,1 23048,0 23142,1 23185,0 23198,1 23265,0 23285,1 23300,0 23329,1 23397,0 23420,1 23467,0 23548,1 23604,0 23699,1 23707,0 23763,1 23858,0 23879,1 23951,0 23977,1 23993,0 24046,1 24123,0 24210,1 24307,0 24401,1 24493,0 24550,1 24641,0 24662,1 24678,0 24718,1 24814,0 24878,1 24889,0 24960,1 25034,0 25085,1 25155,0 25214,1 25224,0 25225,1 25325,0 25375,1 25461,0 25482,1 25562,0 25647,1 25743,0 25804,1 25896,0 25978,1 26032,0 26102,1 26112,0 26207,1 26253,0 26287,1 26328,0 26412,1 26467,0 26557,1 26617,0 26670,1 26751,0 26753,1 26849,0 26929,1 26945,0 26948,1 27035,0 27095,1 27186,0 27203,1 27283,0 27380,1 27447,0 27459,1 27492,0 27499,1 27560,0 27623,1 27688,0 27705,1 27718,0 27774,1 27781,0 27862,1 27952,0 27980,1 27981,0 28004,1 28040,0 28074,1 28156,0 28245,1 28319,0 28348,1 28429,0 28516,1 28523,0 28588,1 28621,0 28658,1 28661,0 28704,1 28730,0 28765,1 28785,0 28811,1 28910,0 29001,1 29050,0 29130,1 29178,0 29218,1 29294,0 29366,1 29408,0 29464,1 29534,0 29625,1 29664,0 29665,1 29679,0 29768,1 29835,0 29928,1 30016,0 30062,1 30142,0 30217,1 30253,0 30278,1 30372,0 30466,1 30487,0 30526,1 30604,0 30642,1 30671,0 30740,1 30819,0 30875,1 30914,0 30973,1 31059,0 31158,1 31213,0 31299,1 31357,0 31440,1 31503,0 31557,1 31610,0 31669,1 31743,0 31833,1 31845,0 31910,1 31970,0 32031,1 32124,0 32208,1 32237,0 32299,1 32362,0 32456,1 32474,0 32571,1 32665,0 32728,1 32738,0 32749,1 32823,0 32915,1 32942,0 32976,1 33050,0 33096,1 33139,0 33223,1 33279,0 33329,1 33422,0 33465,1 33508,0 33519,1 33545,0 33614,1 33698,0 33701,1 33711,0 33782,1 33825,0 33859,1 33904,0 33905,1 33998,0 34065,1 34090,0 34147,1 34183,0 34254,1 34308,0 34381,1 34430,0 34466,1 34490,0 34495,1 34538,0 34554,1 34559,0 34633,1 34719,0 34746,1 34753,0 34794,1 34853,0 34897,1 34936,0 34978,1 35034,0 35062,1 35106,0 35155,1 35216,0 35293,1 35325,0 35395,1 35481,0 35492,1 35591,0 35632,1 35681,0 35682,1 35690,0 35719,1 35809,0 35865,1 35886,0 35927,1 35932,0 36011,1 36081,0 36092,1 36176,0 36206,1 36294,0 36389,1 36475,0 36560,1 36588,0 36631,1 36675,0 36716,1 36767,0 36839,1 36904,0 36954,1 36963,0 36975,1 37020,0 37065,1 37101,0 37137,1 37140,0 37195,1 37230,0 37314,1 37402,0 37502,1 37579,0 37633,1 37655,0 37752,1 37816,0 37830,1 37842,0 37907,1 37949,0 37951,1 38049,0 38149,1 38207,0 38257,1 38261,0 38332,1 38365,0 38421,1 38500,0 38560,1 38579,0 38589,1 38643,0 38699,1 38793,0 38795,1 38830,0 38853,1 38865,0 38929,1 38944,0 38988,1 39045,0 39049,1 39091,0 39146,1 39188,0 39192,1 39229,0 39328,1 39336,0 39381,1 39436,0 39512,1 39605,0 39663,1 39714,0 39765,1 39790,0 39830,1 39876,0 39945,1 39946,0 40007,1 40042,0 40138,1 40196,0 40234,1 40285,0 40308,1 40320,0 40402,1 40442,0 40460,1 40556,0 40629,1 40676,0 40684,1 40747,0 40779,1 40803,0 40895,1 40948,0 40950,1 41019,0 41043,1 41109,0 41155,1 41180,0 41263,1 41322,0 41392,1 41472,0 41486,1 41517,0 41582,1 41604,0 41678,1 41697,0 41758,1 41788,0 41881,1 41891,0 41904,1 41924,0 41946,1 41972,0 42044,1 42123,0 42214,1 42278,0 42314,1 42375,0 42436,1 42523,0 42530,1 42537,0 42603,1 42700,0 42783,1 42863,0 42900,1 42915,0 42948,1 42964,0 42983,1 43071,0 43133,1 43147,0 43242,1 43337,0 43386,1 43469,0 43549,1 43633,0 43686,1 43724,0 43737,1 43748,0 43765,1 43839,0 43881,1 43959,0 44036,1 44135,0 44143,1 44200,0 44289,1 44363,0 44412,1 44442,0 44478,1 44508,0 44541,1 44548,0 44641,1 44739,0 44789,1 44878,0 44960,1 45012,0 45013,1 45070,0 45164,1 45180,0 45270,1 45309,0 45389,1 45411,0 45415,1 45468,0 45500,1 45564,0 45565,1 45612,0 45621,1 45648,0 45731,1 45799,0 45851,1 45870,0 45906,1 45921,0 45934,1 45937,0 45996,1 46064,0 46138,1 46202,0 46260,1 46301,0 46349,1 46414,0 46464,1 46473,0 46497,1 46550,0 46585,1 46611,0 46612,1 46615,0 46626,1 46633,0 46665,1 46671,0 46687,1 46765,0 46799,1 46852,0 46952,1 47036,0 47082,1 47110,0 47137,1 47149,0 47161,1 47225,0 47303,1 47368,0 47417,1 47487,0 47554,1 47626,0 47716,1 47762,0 47766,1 47835,0 47866,1 47925,0 47965,1 48043,0 48048,1 48106,0 48129,1 48199,0 48221,1 48290,0 48307,1 48312,0 48393,1 48431,0 48527,1 48576,0 48649,1 48697,0 48758,1 48799,0 48899,1 48940,0 49000,1 49009,0 49080,1 49087,0 49136,1 49207,0 49216,1 49314,0 49366,1 49367,0 49433,1 49452,0 49503,1 49548,0 49639,1 49725,0 49747,1 49817,0 49901,1 49939,0 49948,1 50031,0 50102,1 50117,0 50166,1 50259,0 50336,1 50420,0 50459,1 50509,0 50510,1 end initlist a22 0,0 20,1 26,0 28,1 42,0 102,1 145,0 158,1 211,0 214,1 257,0 303,1 348,0 375,1 466,0 522,1 537,0 616,1 636,0 668,1 743,0 841,1 869,0 959,1 977,0 1049,1 1066,0 1125,1 1207,0 1242,1 1278,0 1312,1 1327,0 1371,1 1380,0 1458,1 1518,0 1584,1 1647,0 1737,1 1785,0 1853,1 1907,0 1921,1 1941,0 1960,1 1988,0 2046,1 2053,0 2073,1 2120,0 2176,1 2188,0 2206,1 2221,0 2286,1 2288,0 2312,1 2376,0 2385,1 2393,0 2491,1 2523,0 2589,1 2625,0 2703,1 2795,0 2870,1 2952,0 2956,1 3002,0 3025,1 3061,0 3153,1 3217,0 3287,1 3349,0 3376,1 3469,0 3568,1 3569,0 3641,1 3703,0 3755,1 3833,0 3849,1 3902,0 3948,1 4028,0 4066,1 4154,0 4212,1 4241,0 4259,1 4283,0 4370,1 4393,0 4481,1 4565,0 4568,1 4653,0 4737,1 4836,0 4929,1 4998,0 5011,1 5082,0 5152,1 5155,0 5225,1 5325,0 5412,1 5456,0 5462,1 5468,0 5563,1 5565,0 5604,1 5629,0 5685,1 5764,0 5819,1 5859,0 5942,1 5962,0 5964,1 6037,0 6135,1 6181,0 6252,1 6336,0 6387,1 6428,0 6509,1 6580,0 6619,1 6628,0 6693,1 6701,0 6712,1 6812,0 6879,1 6902,0 6988,1 7003,0 7009,1 7093,0 7145,1 7212,0 7214,1 7247,0 7330,1 7347,0 7410,1 7461,0 7523,1 7562,0 7640,1 7660,0 7680,1 7777,0 7785,1 7844,0 7926,1 8009,0 8062,1 8100,0 8176,1 8264,0 8292,1 8299,0 8318,1 8368,0 8461,1 8531,0 8623,1 8643,0 8665,1 8757,0 8761,1 8853,0 8911,1 8946,0 9045,1 9054,0 9121,1 9161,0 9245,1 9247,0 9267,1 9306,0 9362,1 9441,0 9512,1 9530,0 9595,1 9681,0 9693,1 9698,0 9793,1 9861,0 9943,1 9998,0 10046,1 10075,0 10121,1 10141,0 10184,1 10284,0 10383,1 10442,0 10498,1 10538,0 10563,1 10612,0 10700,1 10702,0 10709,1 10751,0 10843,1 10931,0 10942,1 11001,0 11008,1 11055,0 11100,1 11136,0 11138,1 11152,0 11232,1 11250,0 11315,1 11381,0 11434,1 11441,0 11466,1 11554,0 11620,1 11676,0 11692,1 11707,0 11760,1 11812,0 11851,1 11951,0 11986,1 12059,0 12065,1 12160,0 12238,1 12243,0 12246,1 12283,0 12372,1 12397,0 12404,1 12448,0 12456,1 12505,0 12598,1 12650,0 12736,1 12745,0 12770,1 12850,0 12918,1 13003,0 13008,1 13067,0 13130,1 13184,0 13236,1 13275,0 13296,1 13381,0 13476,1 13572,0 13624,1 13693,0 13743,1 13828,0 13924,1 13937,0 13986,1 14074,0 14090,1 14118,0 14128,1 14203,0 14229,1 14320,0 14403,1 14406,0 14474,1 14506,0 14586,1 14657,0 14751,1 14785,0 14854,1 14889,0 14985,1 15061,0 15128,1 15162,0 15218,1 15310,0 15374,1 15447,0 15448,1 15511,0 15570,1 15573,0 15636,1 15719,0 15819,1 15918,0 15946,1 16020,0 16103,1 16187,0 16193,1 16208,0 16268,1 16340,0 16341,1 16381,0 16462,1 16521,0 16615,1 16683,0 16712,1 16762,0 16822,1 16838,0 16934,1 16965,0 16972,1 16979,0 17021,1 17023,0 17096,1 17110,0 17129,1 17201,0 17284,1 17360,0 17373,1 17384,0 17404,1 17424,0 17485,1 17548,0 17611,1 17657,0 17692,1 17704,0 17733,1 17788,0 17805,1 17868,0 17930,1 17999,0 18081,1 18111,0 18135,1 18183,0 18200,1 18294,0 18327,1 18333,0 18382,1 18451,0 18495,1 18592,0 18608,1 18662,0 18738,1 18828,0 18886,1 18980,0 18988,1 19033,0 19043,1 19112,0 19161,1 19183,0 19246,1 19307,0 19345,1 19424,0 19508,1 19570,0 19650,1 19729,0 19802,1 19854,0 19935,1 19966,0 19983,1 20074,0 20081,1 20139,0 20207,1 20289,0 20346,1 20398,0 20476,1 20502,0 20540,1 20612,0 20681,1 20713,0 20732,1 20733,0 20781,1 20855,0 20941,1 21010,0 21065,1 21101,0 21117,1 21210,0 21276,1 21278,0 21323,1 21364,0 21463,1 21535,0 21581,1 21596,0 21623,1 21663,0 21714,1 21746,0 21837,1 21895,0 21927,1 21976,0 22041,1 22079,0 22083,1 22177,0 22252,1 22257,0 22324,1 22412,0 22481,1 22496,0 22567,1 22625,0 22652,1 22677,0 22740,1 22840,0 22937,1 22951,0 22979,1 23016,0 23041,1 23103,0 23166,1 23168,0 23175,1 23252,0 23311,1 23335,0 23368,1 23399,0 23429,1 23448,0 23504,1 23505,0 23561,1 23630,0 23686,1 23778,0 23829,1 23840,0 23878,1 23966,0 24053,1 24152,0 24193,1 24219,0 24304,1 24363,0 24400,1 24488,0 24585,1 24659,0 24702,1 24707,0 24774,1 24781,0 24880,1 24964,0 25029,1 25059,0 25120,1 25165,0 25214,1 25215,0 25296,1 25356,0 25391,1 25410,0 25485,1 25565,0 25604,1 25666,0 25743,1 25772,0 25844,1 25867,0 25950,1 26044,0 26087,1 26142,0 26164,1 26216,0 26290,1 26358,0 26400,1 26416,0 26463,1 26539,0 26562,1 26605,0 26685,1 26725,0 26812,1 26869,0 26946,1 27005,0 27055,1 27149,0 27244,1 27326,0 27367,1 27464,0 27547,1 27631,0 27655,1 27710,0 27715,1 27806,0 27837,1 27868,0 27947,1 28017,0 28047,1 28062,0 28119,1 28187,0 28213,1 28223,0 28296,1 28305,0 28357,1 28419,0 28502,1 28590,0 28665,1 28694,0 28759,1 28764,0 28788,1 28790,0 28852,1 28932,0 28976,1 29013,0 29022,1 29085,0 29179,1 29258,0 29310,1 29406,0 29473,1 29555,0 29652,1 29737,0 29761,1 29763,0 29834,1 29927,0 29954,1 30051,0 30067,1 30098,0 30122,1 30132,0 30219,1 30225,0 30235,1 30277,0 30349,1 30448,0 30533,1 30553,0 30591,1 30608,0 30629,1 30659,0 30699,1 30793,0 30886,1 30971,0 30992,1 31084,0 31153,1 31228,0 31263,1 31341,0 31353,1 31415,0 31508,1 31606,0 31691,1 31723,0 31757,1 31828,0 31855,1 31886,0 31932,1 31982,0 32072,1 32150,0 32173,1 32231,0 32283,1 32299,0 32304,1 32346,0 32440,1 32529,0 32627,1 32713,0 32769,1 32857,0 32938,1 32955,0 33007,1 33076,0 33146,1 33208,0 33287,1 33359,0 33453,1 33502,0 33517,1 33593,0 33652,1 33747,0 33782,1 33853,0 33901,1 33926,0 33995,1 34033,0 34067,1 34102,0 34191,1 34213,0 34290,1 34332,0 34376,1 34377,0 34416,1 34446,0 34467,1 34512,0 34603,1 34643,0 34738,1 34786,0 34813,1 34828,0 34864,1 34964,0 35030,1 35072,0 35108,1 35137,0 35169,1 35205,0 35212,1 35288,0 35327,1 35402,0 35430,1 35459,0 35517,1 35530,0 35595,1 35637,0 35693,1 35694,0 35744,1 35750,0 35816,1 35828,0 35862,1 35916,0 36004,1 36005,0 36006,1 36018,0 36042,1 36090,0 36137,1 36216,0 36282,1 36300,0 36396,1 36463,0 36521,1 36608,0 36644,1 36657,0 36704,1 36783,0 36883,1 36960,0 37059,1 37118,0 37119,1 37216,0 37243,1 37327,0 37390,1 37400,0 37468,1 37558,0 37651,1 37751,0 37845,1 37929,0 37989,1 38018,0 38033,1 38102,0 38171,1 38200,0 38229,1 38259,0 38312,1 38359,0 38362,1 38451,0 38523,1 38575,0 38597,1 38609,0 38628,1 38646,0 38684,1 38691,0 38764,1 38813,0 38874,1 38967,0 39026,1 39117,0 39164,1 39176,0 39190,1 39286,0 39358,1 39430,0 39470,1 39545,0 39613,1 39697,0 39766,1 39861,0 39880,1 39980,0 40037,1 40059,0 40061,1 40141,0 40219,1 40293,0 40376,1 40388,0 40410,1 40423,0 40454,1 40549,0 40647,1 40699,0 40760,1 40806,0 40814,1 40855,0 40926,1 40930,0 40978,1 41043,0 41053,1 41091,0 41160,1 41193,0 41233,1 41321,0 41379,1 41415,0 41452,1 41479,0 41558,1 41578,0 41600,1 41639,0 41715,1 41761,0 41848,1 41856,0 41933,1 41967,0 41995,1 42017,0 42100,1 42198,0 42210,1 42236,0 42268,1 42358,0 42364,1 42451,0 42458,1 42478,0 42524,1 42548,0 42613,1 42704,0 42803,1 42806,0 42901,1 42922,0 42992,1 43087,0 43138,1 43174,0 43200,1 43293,0 43310,1 43322,0 43413,1 43468,0 43535,1 43620,0 43667,1 43741,0 43791,1 43869,0 43942,1 43998,0 44083,1 44164,0 44241,1 44322,0 44373,1 44460,0 44483,1 44533,0 44576,1 44659,0 44686,1 44785,0 44799,1 44882,0 44978,1 45004,0 45054,1 45143,0 45241,1 45261,0 45306,1 45369,0 45416,1 45452,0 45544,1 45635,0 45718,1 45779,0 45802,1 45841,0 45915,1 45956,0 45961,1 45979,0 45995,1 46018,0 46097,1 46115,0 46211,1 46221,0 46291,1 46336,0 46414,1 46479,0 46503,1 46584,0 46613,1 46638,0 46727,1 46815,0 46884,1 46892,0 46974,1 46985,0 47071,1 47134,0 47173,1 47185,0 47254,1 47278,0 47378,1 47438,0 47499,1 47535,0 47539,1 47603,0 47637,1 47718,0 47803,1 47859,0 47908,1 47910,0 47920,1 47924,0 47945,1 48008,0 48030,1 48045,0 48072,1 48154,0 48211,1 48271,0 48272,1 48293,0 48300,1 48345,0 48382,1 48432,0 48488,1 48524,0 48589,1 48647,0 48725,1 48748,0 48782,1 48871,0 48894,1 48911,0 48982,1 49061,0 49072,1 49158,0 49237,1 49284,0 49383,1 49465,0 49493,1 49517,0 49601,1 49650,0 49677,1 49742,0 49804,1 49904,0 49973,1 49983,0 50044,1 50046,0 50079,1 50163,0 50165,1 50265,0 50272,1 50365,0 50433,1 50437,0 50480,1 50577,0 50601,1 50636,0 50722,1 50735,0 50808,1 50842,0 50927,1 50961,0 50983,1 51026,0 51077,1 51123,0 51199,1 51294,0 51353,1 end initlist a23 0,0 60,1 85,0 156,1 167,0 206,1 246,0 251,1 304,0 370,1 374,0 448,1 528,0 535,1 595,0 643,1 716,0 760,1 814,0 850,1 864,0 957,1 1036,0 1100,1 1127,0 1186,1 1207,0 1248,1 1300,0 1312,1 1341,0 1437,1 1510,0 1523,1 1602,0 1629,1 1699,0 1751,1 1769,0 1790,1 1838,0 1891,1 1975,0 2063,1 2120,0 2207,1 2287,0 2374,1 2463,0 2521,1 2555,0 2603,1 2667,0 2723,1 2745,0 2757,1 2845,0 2938,1 3032,0 3052,1 3063,0 3086,1 3129,0 3198,1 3248,0 3261,1 3278,0 3372,1 3470,0 3525,1 3576,0 3667,1 3675,0 3741,1 3834,0 3854,1 3905,0 3926,1 4024,0 4045,1 4113,0 4148,1 4178,0 4215,1 4308,0 4327,1 4391,0 4407,1 4504,0 4538,1 4575,0 4588,1 4674,0 4726,1 4784,0 4844,1 4876,0 4953,1 4994,0 5060,1 5124,0 5168,1 5194,0 5270,1 5282,0 5288,1 5304,0 5318,1 5356,0 5400,1 5423,0 5467,1 5554,0 5649,1 5696,0 5777,1 5783,0 5787,1 5881,0 5974,1 6049,0 6052,1 6121,0 6215,1 6283,0 6284,1 6328,0 6372,1 6397,0 6478,1 6545,0 6605,1 6622,0 6662,1 6738,0 6813,1 6827,0 6854,1 6944,0 7021,1 7022,0 7033,1 7089,0 7139,1 7150,0 7152,1 7154,0 7180,1 7225,0 7313,1 7396,0 7408,1 7436,0 7447,1 7453,0 7480,1 7547,0 7643,1 7710,0 7756,1 7787,0 7875,1 7904,0 7997,1 8048,0 8123,1 8162,0 8218,1 8239,0 8263,1 8349,0 8447,1 8482,0 8508,1 8532,0 8597,1 8622,0 8631,1 8656,0 8737,1 8837,0 8879,1 8880,0 8882,1 8938,0 9008,1 9019,0 9084,1 9087,0 9157,1 9226,0 9230,1 9277,0 9299,1 9335,0 9343,1 9378,0 9460,1 9464,0 9531,1 9626,0 9703,1 9705,0 9745,1 9819,0 9912,1 9987,0 10052,1 10117,0 10197,1 10231,0 10237,1 10241,0 10329,1 10375,0 10435,1 10467,0 10556,1 10654,0 10709,1 10741,0 10832,1 10856,0 10906,1 10997,0 11039,1 11068,0 11096,1 11127,0 11172,1 11246,0 11299,1 11355,0 11358,1 11386,0 11450,1 11536,0 11571,1 11626,0 11653,1 11658,0 11681,1 11716,0 11746,1 11801,0 11841,1 11865,0 11875,1 11953,0 12052,1 12068,0 12156,1 12222,0 12300,1 12310,0 12352,1 12359,0 12420,1 12513,0 12572,1 12656,0 12696,1 12729,0 12782,1 12795,0 12869,1 12886,0 12906,1 12984,0 13004,1 13044,0 13098,1 13130,0 13138,1 13148,0 13210,1 13237,0 13312,1 13353,0 13394,1 13407,0 13475,1 13548,0 13597,1 13637,0 13697,1 13757,0 13761,1 13842,0 13904,1 13974,0 13991,1 14001,0 14041,1 14068,0 14079,1 14158,0 14198,1 14226,0 14301,1 14382,0 14445,1 14506,0 14552,1 14631,0 14730,1 14746,0 14786,1 14881,0 14957,1 15013,0 15015,1 15022,0 15069,1 15124,0 15149,1 15212,0 15240,1 15262,0 15284,1 15330,0 15396,1 15416,0 15429,1 15465,0 15484,1 15527,0 15583,1 15616,0 15628,1 15705,0 15805,1 15849,0 15887,1 15958,0 15992,1 16044,0 16104,1 16179,0 16241,1 16299,0 16310,1 16348,0 16431,1 16531,0 16535,1 16615,0 16714,1 16735,0 16756,1 16855,0 16904,1 17001,0 17089,1 17182,0 17230,1 17278,0 17292,1 17303,0 17309,1 17363,0 17419,1 17477,0 17478,1 17573,0 17630,1 17646,0 17706,1 17716,0 17803,1 17886,0 17953,1 18029,0 18112,1 18192,0 18241,1 18270,0 18362,1 18402,0 18415,1 18479,0 18488,1 18496,0 18559,1 18651,0 18703,1 18745,0 18823,1 18921,0 19000,1 19098,0 19128,1 19131,0 19180,1 19255,0 19265,1 19291,0 19357,1 19398,0 19435,1 19468,0 19472,1 19568,0 19658,1 19661,0 19679,1 19705,0 19761,1 19778,0 19878,1 19967,0 19982,1 20027,0 20045,1 20049,0 20084,1 20151,0 20242,1 20290,0 20375,1 20386,0 20396,1 20420,0 20464,1 20553,0 20589,1 20626,0 20635,1 20672,0 20682,1 20684,0 20714,1 20772,0 20866,1 20915,0 20977,1 21011,0 21032,1 21085,0 21107,1 21184,0 21223,1 21235,0 21299,1 21340,0 21381,1 21414,0 21466,1 21498,0 21504,1 21591,0 21608,1 21655,0 21713,1 21786,0 21852,1 21916,0 21978,1 22054,0 22085,1 22093,0 22099,1 22116,0 22149,1 22242,0 22328,1 22374,0 22375,1 22419,0 22487,1 22552,0 22640,1 22710,0 22725,1 22767,0 22804,1 22827,0 22919,1 22969,0 23012,1 23097,0 23109,1 23118,0 23150,1 23219,0 23221,1 23251,0 23341,1 23355,0 23452,1 23467,0 23543,1 23572,0 23660,1 23673,0 23740,1 23835,0 23915,1 23994,0 24026,1 24076,0 24150,1 24186,0 24208,1 24291,0 24327,1 24386,0 24467,1 24490,0 24543,1 24599,0 24673,1 24677,0 24715,1 24777,0 24797,1 24868,0 24895,1 24899,0 24935,1 25016,0 25047,1 25113,0 25133,1 25186,0 25254,1 25280,0 25347,1 25384,0 25419,1 25442,0 25445,1 25507,0 25594,1 25667,0 25684,1 25746,0 25845,1 25878,0 25947,1 25975,0 26035,1 26054,0 26085,1 26146,0 26171,1 26190,0 26208,1 26209,0 26262,1 26342,0 26356,1 26427,0 26504,1 26583,0 26613,1 26627,0 26691,1 26775,0 26868,1 26902,0 26980,1 27041,0 27075,1 27123,0 27193,1 27224,0 27260,1 27316,0 27340,1 27394,0 27401,1 27487,0 27569,1 27661,0 27739,1 27751,0 27812,1 27874,0 27882,1 27932,0 28001,1 28065,0 28121,1 28124,0 28159,1 28177,0 28244,1 28308,0 28343,1 28392,0 28420,1 28476,0 28573,1 28655,0 28714,1 28715,0 28809,1 28842,0 28892,1 28922,0 28978,1 28983,0 29019,1 29059,0 29093,1 29122,0 29129,1 29134,0 29163,1 29222,0 29232,1 29270,0 29287,1 29335,0 29407,1 29444,0 29502,1 29592,0 29605,1 29684,0 29780,1 29826,0 29837,1 29936,0 29975,1 29981,0 30078,1 30091,0 30122,1 30179,0 30199,1 30279,0 30295,1 30316,0 30412,1 30473,0 30569,1 30666,0 30724,1 30795,0 30884,1 30885,0 30938,1 30996,0 31079,1 31146,0 31216,1 31261,0 31352,1 31448,0 31515,1 31594,0 31631,1 31669,0 31708,1 31758,0 31854,1 31949,0 31970,1 32017,0 32074,1 32097,0 32165,1 32180,0 32208,1 32295,0 32367,1 32390,0 32445,1 32523,0 32553,1 32583,0 32644,1 32682,0 32730,1 32754,0 32797,1 32889,0 32891,1 32959,0 32963,1 33006,0 33081,1 33096,0 33111,1 33116,0 33132,1 33137,0 33139,1 33214,0 33274,1 33306,0 33351,1 33393,0 33399,1 33447,0 33535,1 33562,0 33572,1 33639,0 33689,1 33769,0 33835,1 33911,0 33974,1 34040,0 34070,1 34151,0 34160,1 34252,0 34321,1 34421,0 34424,1 34494,0 34521,1 34603,0 34662,1 34718,0 34790,1 34868,0 34880,1 34928,0 35014,1 35049,0 35130,1 35205,0 35245,1 35293,0 35302,1 35338,0 35359,1 35376,0 35432,1 35452,0 35481,1 35565,0 35599,1 35616,0 35626,1 35631,0 35657,1 35705,0 35760,1 35832,0 35862,1 35908,0 35995,1 36083,0 36127,1 36176,0 36197,1 36269,0 36361,1 36386,0 36430,1 36499,0 36559,1 36602,0 36637,1 36645,0 36653,1 36748,0 36787,1 36861,0 36916,1 36952,0 36999,1 37090,0 37100,1 37101,0 37192,1 37267,0 37350,1 37384,0 37408,1 37473,0 37517,1 37584,0 37675,1 37724,0 37799,1 37844,0 37938,1 37970,0 38062,1 38103,0 38174,1 38254,0 38267,1 38325,0 38391,1 38456,0 38532,1 38558,0 38637,1 38703,0 38755,1 38815,0 38868,1 38870,0 38970,1 39018,0 39114,1 39153,0 39218,1 39259,0 39300,1 39307,0 39401,1 39436,0 39515,1 39563,0 39609,1 39680,0 39691,1 39754,0 39790,1 39878,0 39923,1 39980,0 39988,1 40082,0 40095,1 40137,0 40219,1 40263,0 40310,1 40394,0 40475,1 40487,0 40582,1 40651,0 40659,1 40667,0 40729,1 40768,0 40784,1 40864,0 40919,1 40928,0 40990,1 41029,0 41121,1 41134,0 41137,1 41153,0 41183,1 41218,0 41301,1 41336,0 41363,1 41397,0 41479,1 41564,0 41617,1 41662,0 41720,1 41761,0 41808,1 41868,0 41918,1 41996,0 42037,1 42129,0 42174,1 42218,0 42260,1 42300,0 42357,1 42379,0 42389,1 42483,0 42496,1 42501,0 42508,1 42566,0 42654,1 42686,0 42711,1 42753,0 42767,1 42835,0 42882,1 42895,0 42947,1 43017,0 43112,1 43182,0 43210,1 43269,0 43313,1 43357,0 43439,1 43526,0 43572,1 43668,0 43768,1 43853,0 43925,1 43939,0 44037,1 44052,0 44068,1 44115,0 44120,1 44183,0 44215,1 44267,0 44352,1 44423,0 44478,1 44541,0 44630,1 44640,0 44703,1 44772,0 44825,1 44871,0 44876,1 44954,0 44967,1 44976,0 44995,1 45008,0 45096,1 45175,0 45200,1 45233,0 45330,1 45403,0 45456,1 45490,0 45504,1 45541,0 45588,1 45658,0 45666,1 45736,0 45778,1 45821,0 45861,1 45893,0 45947,1 46009,0 46034,1 46100,0 46172,1 46261,0 46318,1 46406,0 46493,1 46567,0 46643,1 46717,0 46799,1 46881,0 46925,1 47008,0 47089,1 47144,0 47154,1 47228,0 47324,1 47335,0 47356,1 47395,0 47401,1 47456,0 47538,1 47599,0 47679,1 47688,0 47783,1 47821,0 47832,1 47931,0 47983,1 48032,0 48034,1 48117,0 48133,1 48198,0 48241,1 48294,0 48340,1 48393,0 48477,1 48531,0 48626,1 48692,0 48738,1 48748,0 48814,1 48889,0 48960,1 49011,0 49013,1 49022,0 49025,1 49082,0 49151,1 end initlist a24 0,0 47,1 135,0 208,1 295,0 315,1 390,0 468,1 551,0 580,1 623,0 659,1 748,0 773,1 859,0 911,1 998,0 1092,1 1168,0 1231,1 1295,0 1301,1 1367,0 1387,1 1388,0 1437,1 1472,0 1530,1 1570,0 1599,1 1612,0 1711,1 1749,0 1794,1 1801,0 1833,1 1901,0 1944,1 1992,0 1995,1 2059,0 2117,1 2183,0 2214,1 2306,0 2388,1 2437,0 2508,1 2548,0 2616,1 2686,0 2741,1 2826,0 2860,1 2867,0 2936,1 2948,0 2956,1 3012,0 3052,1 3058,0 3117,1 3160,0 3217,1 3264,0 3326,1 3341,0 3405,1 3485,0 3508,1 3513,0 3592,1 3632,0 3660,1 3740,0 3743,1 3776,0 3839,1 3869,0 3963,1 3972,0 4004,1 4054,0 4128,1 4174,0 4274,1 4282,0 4359,1 4411,0 4429,1 4441,0 4520,1 4565,0 4572,1 4646,0 4741,1 4801,0 4894,1 4923,0 4962,1 5022,0 5023,1 5117,0 5129,1 5227,0 5325,1 5402,0 5484,1 5552,0 5614,1 5653,0 5739,1 5761,0 5787,1 5878,0 5953,1 6013,0 6113,1 6158,0 6252,1 6283,0 6295,1 6394,0 6494,1 6516,0 6552,1 6574,0 6646,1 6720,0 6811,1 6844,0 6853,1 6952,0 7049,1 7125,0 7182,1 7211,0 7265,1 7281,0 7332,1 7376,0 7432,1 7517,0 7602,1 7644,0 7718,1 7728,0 7768,1 7798,0 7836,1 7882,0 7944,1 7999,0 8053,1 8152,0 8246,1 8313,0 8358,1 8422,0 8516,1 8525,0 8566,1 8657,0 8666,1 8693,0 8722,1 8760,0 8825,1 8889,0 8935,1 9026,0 9027,1 9088,0 9114,1 9170,0 9240,1 9285,0 9287,1 9326,0 9359,1 9416,0 9460,1 9485,0 9499,1 9568,0 9575,1 9638,0 9689,1 9763,0 9855,1 9944,0 9995,1 9998,0 10009,1 10083,0 10112,1 10165,0 10174,1 10217,0 10301,1 10334,0 10379,1 10421,0 10521,1 10541,0 10573,1 10621,0 10652,1 10697,0 10768,1 10803,0 10853,1 10892,0 10920,1 10975,0 11007,1 11052,0 11105,1 11167,0 11210,1 11215,0 11307,1 11317,0 11404,1 11477,0 11483,1 11552,0 11553,1 11584,0 11680,1 11737,0 11786,1 11880,0 11966,1 12017,0 12073,1 12168,0 12176,1 12262,0 12265,1 12365,0 12392,1 12484,0 12490,1 12496,0 12585,1 12652,0 12689,1 12753,0 12764,1 12804,0 12820,1 12870,0 12929,1 12936,0 12997,1 13074,0 13166,1 13178,0 13232,1 13322,0 13364,1 13377,0 13407,1 13493,0 13526,1 13600,0 13700,1 13791,0 13796,1 13880,0 13893,1 13945,0 13999,1 14005,0 14028,1 14082,0 14136,1 14223,0 14277,1 14328,0 14341,1 14382,0 14417,1 14498,0 14519,1 14546,0 14586,1 14631,0 14665,1 14759,0 14849,1 14923,0 15004,1 15054,0 15129,1 15181,0 15201,1 15268,0 15320,1 15337,0 15379,1 15388,0 15473,1 15526,0 15590,1 15632,0 15684,1 15699,0 15790,1 15883,0 15980,1 15985,0 16064,1 16103,0 16140,1 16213,0 16285,1 16295,0 16378,1 16394,0 16493,1 16592,0 16616,1 16668,0 16688,1 16782,0 16882,1 16970,0 16992,1 17036,0 17057,1 17108,0 17133,1 17212,0 17272,1 17297,0 17370,1 17416,0 17509,1 17526,0 17558,1 17584,0 17612,1 17686,0 17728,1 17771,0 17801,1 17818,0 17828,1 17912,0 17966,1 17998,0 18069,1 18077,0 18116,1 18165,0 18234,1 18241,0 18321,1 18382,0 18385,1 18411,0 18491,1 18518,0 18582,1 18645,0 18721,1 18727,0 18745,1 18806,0 18861,1 18950,0 19022,1 19121,0 19164,1 19192,0 19269,1 19369,0 19380,1 19470,0 19473,1 19549,0 19580,1 19624,0 19655,1 19690,0 19710,1 19744,0 19814,1 19894,0 19983,1 20035,0 20122,1 20146,0 20221,1 20320,0 20370,1 20392,0 20448,1 20475,0 20540,1 20633,0 20647,1 20700,0 20795,1 20871,0 20896,1 20980,0 21066,1 21140,0 21170,1 21206,0 21248,1 21341,0 21385,1 21466,0 21522,1 21560,0 21647,1 21676,0 21746,1 21747,0 21789,1 21856,0 21866,1 21883,0 21892,1 21932,0 21978,1 22021,0 22085,1 22167,0 22222,1 22300,0 22301,1 22364,0 22423,1 22472,0 22507,1 22530,0 22603,1 22631,0 22688,1 22774,0 22799,1 22825,0 22826,1 22848,0 22925,1 22977,0 22993,1 23076,0 23170,1 23223,0 23299,1 23374,0 23471,1 23532,0 23593,1 23605,0 23637,1 23655,0 23720,1 23740,0 23780,1 23877,0 23976,1 24000,0 24011,1 24084,0 24141,1 24196,0 24284,1 24363,0 24376,1 24472,0 24501,1 24519,0 24571,1 24607,0 24657,1 24659,0 24722,1 24787,0 24844,1 24847,0 24887,1 24904,0 24921,1 25011,0 25096,1 25166,0 25222,1 25240,0 25292,1 25328,0 25386,1 25480,0 25550,1 25616,0 25680,1 25687,0 25770,1 25850,0 25905,1 25960,0 26059,1 26086,0 26090,1 26144,0 26182,1 26203,0 26205,1 26241,0 26301,1 26318,0 26396,1 26406,0 26435,1 26469,0 26534,1 26587,0 26619,1 26662,0 26710,1 26721,0 26802,1 26889,0 26989,1 27030,0 27109,1 27207,0 27215,1 27231,0 27298,1 27304,0 27371,1 27396,0 27476,1 27513,0 27578,1 27597,0 27673,1 27689,0 27765,1 27801,0 27832,1 27857,0 27892,1 27918,0 27937,1 28009,0 28027,1 28065,0 28131,1 28171,0 28210,1 28284,0 28354,1 28448,0 28457,1 28467,0 28531,1 28539,0 28616,1 28691,0 28789,1 28837,0 28910,1 28941,0 29022,1 29045,0 29053,1 29129,0 29162,1 29172,0 29227,1 29285,0 29359,1 29423,0 29442,1 29461,0 29507,1 29512,0 29536,1 29573,0 29664,1 29705,0 29743,1 29792,0 29800,1 29884,0 29964,1 30050,0 30139,1 30194,0 30239,1 30270,0 30322,1 30410,0 30434,1 30529,0 30559,1 30623,0 30628,1 30640,0 30672,1 30694,0 30786,1 30827,0 30883,1 30928,0 30960,1 31048,0 31142,1 31177,0 31237,1 31334,0 31412,1 31425,0 31447,1 31537,0 31558,1 31567,0 31653,1 31743,0 31794,1 31889,0 31981,1 32053,0 32123,1 32149,0 32163,1 32192,0 32199,1 32222,0 32271,1 32275,0 32322,1 32400,0 32406,1 32453,0 32538,1 32577,0 32657,1 32756,0 32772,1 32780,0 32806,1 32813,0 32821,1 32822,0 32898,1 32961,0 33021,1 33031,0 33039,1 33082,0 33155,1 33164,0 33254,1 33308,0 33309,1 33387,0 33463,1 33477,0 33536,1 33583,0 33643,1 33699,0 33734,1 33798,0 33889,1 33958,0 34049,1 34061,0 34077,1 34086,0 34157,1 34168,0 34175,1 34256,0 34355,1 34411,0 34461,1 34487,0 34526,1 34577,0 34670,1 34711,0 34750,1 34812,0 34868,1 34898,0 34976,1 35052,0 35138,1 35226,0 35227,1 35253,0 35299,1 35349,0 35402,1 35475,0 35573,1 35649,0 35728,1 35757,0 35828,1 35848,0 35948,1 36028,0 36097,1 36159,0 36225,1 36259,0 36326,1 36398,0 36489,1 36496,0 36499,1 36569,0 36594,1 36653,0 36687,1 36729,0 36792,1 36802,0 36809,1 36907,0 36997,1 37048,0 37077,1 37148,0 37157,1 37177,0 37195,1 37215,0 37313,1 37384,0 37422,1 37441,0 37541,1 37632,0 37657,1 37694,0 37754,1 37778,0 37822,1 37867,0 37950,1 37967,0 37980,1 38007,0 38078,1 38118,0 38157,1 38172,0 38189,1 38256,0 38301,1 38371,0 38466,1 38492,0 38507,1 38556,0 38563,1 38632,0 38672,1 38750,0 38828,1 38847,0 38897,1 38934,0 38986,1 39053,0 39093,1 39160,0 39192,1 39254,0 39321,1 39340,0 39383,1 39469,0 39553,1 39644,0 39690,1 39754,0 39781,1 39790,0 39832,1 39856,0 39908,1 39938,0 39959,1 40047,0 40093,1 40165,0 40183,1 40194,0 40213,1 40281,0 40366,1 40422,0 40521,1 40529,0 40572,1 40630,0 40725,1 40750,0 40834,1 40899,0 40979,1 41038,0 41087,1 41152,0 41239,1 41335,0 41387,1 41427,0 41462,1 41539,0 41592,1 41624,0 41656,1 41708,0 41753,1 41827,0 41907,1 41920,0 41966,1 42028,0 42038,1 42124,0 42169,1 42201,0 42258,1 42298,0 42343,1 42390,0 42488,1 42541,0 42588,1 42634,0 42659,1 42687,0 42713,1 42783,0 42795,1 42841,0 42869,1 42912,0 42949,1 43033,0 43047,1 43093,0 43095,1 43152,0 43252,1 43349,0 43409,1 43444,0 43469,1 43478,0 43492,1 43512,0 43589,1 43635,0 43673,1 43761,0 43840,1 43862,0 43914,1 43937,0 43974,1 44035,0 44133,1 44229,0 44239,1 44319,0 44334,1 44377,0 44466,1 44537,0 44619,1 44642,0 44648,1 44709,0 44757,1 44789,0 44856,1 44927,0 44940,1 44946,0 44953,1 45034,0 45125,1 45221,0 45231,1 45329,0 45391,1 45427,0 45468,1 45544,0 45612,1 45639,0 45686,1 45713,0 45769,1 45850,0 45868,1 45941,0 45998,1 46055,0 46120,1 46220,0 46257,1 46356,0 46423,1 46509,0 46547,1 46560,0 46585,1 46629,0 46663,1 46749,0 46828,1 46893,0 46981,1 47068,0 47069,1 47116,0 47171,1 47256,0 47278,1 47353,0 47395,1 47454,0 47466,1 47546,0 47583,1 47680,0 47762,1 47814,0 47897,1 47992,0 48064,1 48135,0 48150,1 48161,0 48213,1 48231,0 48270,1 48341,0 48440,1 48522,0 48622,1 48662,0 48737,1 48775,0 48803,1 48863,0 48892,1 48942,0 48995,1 49046,0 49119,1 49173,0 49241,1 49267,0 49277,1 49377,0 49413,1 49445,0 49540,1 49635,0 49722,1 49750,0 49839,1 49914,0 49928,1 50025,0 50097,1 50163,0 50243,1 50317,0 50388,1 50443,0 50515,1 50525,0 50543,1 50607,0 50626,1 50715,0 50721,1 50819,0 50867,1 50924,0 50999,1 51075,0 51093,1 end initlist a25 0,0 64,1 102,0 171,1 259,0 294,1 308,0 406,1 426,0 439,1 504,0 578,1 612,0 691,1 745,0 817,1 840,0 891,1 982,0 1062,1 1087,0 1097,1 1147,0 1236,1 1255,0 1355,1 1411,0 1451,1 1483,0 1541,1 1597,0 1623,1 1683,0 1757,1 1778,0 1789,1 1807,0 1842,1 1922,0 1970,1 2055,0 2121,1 2148,0 2165,1 2172,0 2243,1 2318,0 2391,1 2468,0 2495,1 2537,0 2601,1 2670,0 2764,1 2767,0 2775,1 2798,0 2882,1 2887,0 2889,1 2971,0 3006,1 3008,0 3068,1 3111,0 3168,1 3173,0 3228,1 3309,0 3368,1 3466,0 3552,1 3623,0 3657,1 3686,0 3780,1 3785,0 3873,1 3892,0 3962,1 3989,0 4053,1 4069,0 4076,1 4167,0 4203,1 4250,0 4280,1 4294,0 4339,1 4390,0 4476,1 4524,0 4559,1 4585,0 4683,1 4703,0 4785,1 4854,0 4934,1 5017,0 5116,1 5138,0 5139,1 5223,0 5248,1 5338,0 5423,1 5488,0 5505,1 5518,0 5553,1 5557,0 5628,1 5669,0 5766,1 5857,0 5945,1 6027,0 6041,1 6063,0 6079,1 6118,0 6199,1 6279,0 6365,1 6391,0 6459,1 6492,0 6537,1 6566,0 6652,1 6741,0 6804,1 6817,0 6824,1 6827,0 6852,1 6927,0 6971,1 7055,0 7148,1 7225,0 7246,1 7307,0 7329,1 7341,0 7411,1 7459,0 7504,1 7517,0 7527,1 7584,0 7586,1 7595,0 7632,1 7686,0 7727,1 7827,0 7913,1 7956,0 8019,1 8084,0 8131,1 8137,0 8215,1 8311,0 8370,1 8411,0 8490,1 8567,0 8644,1 8680,0 8708,1 8767,0 8786,1 8787,0 8828,1 8906,0 8974,1 9044,0 9139,1 9204,0 9256,1 9301,0 9399,1 9465,0 9526,1 9569,0 9579,1 9634,0 9639,1 9657,0 9716,1 9745,0 9833,1 9896,0 9979,1 10067,0 10119,1 10151,0 10217,1 10245,0 10311,1 10373,0 10423,1 10508,0 10519,1 10525,0 10622,1 10660,0 10711,1 10781,0 10851,1 10928,0 11006,1 11047,0 11085,1 11095,0 11167,1 11249,0 11268,1 11331,0 11414,1 11478,0 11556,1 11643,0 11688,1 11741,0 11811,1 11844,0 11899,1 11918,0 11937,1 11952,0 12025,1 12099,0 12197,1 12285,0 12350,1 12372,0 12433,1 12519,0 12533,1 12570,0 12652,1 12691,0 12784,1 12830,0 12840,1 12924,0 13001,1 13086,0 13140,1 13167,0 13194,1 13220,0 13224,1 13258,0 13306,1 13393,0 13407,1 13501,0 13530,1 13604,0 13665,1 13696,0 13794,1 13834,0 13860,1 13919,0 13961,1 13997,0 14076,1 14144,0 14198,1 14230,0 14302,1 14317,0 14368,1 14462,0 14466,1 14565,0 14578,1 14627,0 14657,1 14735,0 14792,1 14804,0 14904,1 14951,0 15043,1 15142,0 15195,1 15264,0 15344,1 15352,0 15423,1 15441,0 15457,1 15534,0 15592,1 15662,0 15694,1 15714,0 15724,1 15807,0 15852,1 15921,0 15943,1 16041,0 16134,1 16188,0 16217,1 16281,0 16282,1 16291,0 16343,1 16432,0 16477,1 16478,0 16524,1 16538,0 16564,1 16628,0 16685,1 16738,0 16835,1 16860,0 16931,1 16994,0 17056,1 17083,0 17140,1 17166,0 17266,1 17327,0 17393,1 17396,0 17460,1 17491,0 17590,1 17643,0 17742,1 17830,0 17895,1 17988,0 18060,1 18147,0 18247,1 18271,0 18342,1 18420,0 18431,1 18521,0 18544,1 18619,0 18662,1 18686,0 18712,1 18774,0 18819,1 18889,0 18896,1 18942,0 18983,1 19070,0 19145,1 19198,0 19228,1 19265,0 19287,1 19353,0 19407,1 19408,0 19503,1 19544,0 19624,1 19647,0 19650,1 19740,0 19835,1 19929,0 19987,1 20023,0 20035,1 20076,0 20163,1 20184,0 20270,1 20353,0 20380,1 20446,0 20519,1 20610,0 20683,1 20748,0 20765,1 20775,0 20811,1 20903,0 20977,1 20984,0 21028,1 21049,0 21103,1 21185,0 21255,1 21327,0 21403,1 21408,0 21430,1 21528,0 21532,1 21589,0 21614,1 21634,0 21649,1 21658,0 21684,1 21719,0 21792,1 21797,0 21861,1 21927,0 21933,1 21969,0 22005,1 22078,0 22139,1 22217,0 22265,1 22279,0 22325,1 22398,0 22459,1 22512,0 22583,1 22641,0 22701,1 22723,0 22737,1 22747,0 22777,1 22876,0 22895,1 22917,0 22930,1 22965,0 22987,1 23053,0 23116,1 23156,0 23202,1 23261,0 23348,1 23432,0 23475,1 23512,0 23592,1 23664,0 23678,1 23711,0 23801,1 23844,0 23916,1 23987,0 24033,1 24112,0 24212,1 24217,0 24246,1 24276,0 24337,1 24437,0 24523,1 24552,0 24622,1 24718,0 24751,1 24839,0 24929,1 25019,0 25040,1 25097,0 25098,1 25128,0 25167,1 25194,0 25261,1 25356,0 25384,1 25433,0 25460,1 25464,0 25498,1 25584,0 25599,1 25695,0 25756,1 25762,0 25799,1 25835,0 25857,1 25931,0 25942,1 25966,0 25978,1 26019,0 26042,1 26076,0 26164,1 26168,0 26215,1 26242,0 26279,1 26300,0 26368,1 26374,0 26430,1 26462,0 26527,1 26606,0 26634,1 26655,0 26672,1 26715,0 26737,1 26775,0 26825,1 26826,0 26880,1 26974,0 27060,1 27072,0 27095,1 27165,0 27200,1 27273,0 27333,1 27417,0 27422,1 27457,0 27470,1 27541,0 27585,1 27667,0 27722,1 27778,0 27823,1 27903,0 27999,1 28086,0 28101,1 28106,0 28125,1 28127,0 28205,1 28248,0 28336,1 28361,0 28364,1 28405,0 28464,1 28468,0 28492,1 28584,0 28654,1 28739,0 28745,1 28803,0 28898,1 28920,0 28932,1 28973,0 29068,1 29127,0 29215,1 29298,0 29348,1 29406,0 29425,1 29434,0 29491,1 29493,0 29556,1 29628,0 29672,1 29708,0 29807,1 29883,0 29963,1 30027,0 30126,1 30157,0 30207,1 30285,0 30381,1 30449,0 30530,1 30556,0 30599,1 30652,0 30704,1 30750,0 30800,1 30879,0 30887,1 30957,0 30977,1 31068,0 31092,1 31126,0 31164,1 31246,0 31273,1 31336,0 31390,1 31471,0 31526,1 31582,0 31622,1 31628,0 31651,1 31714,0 31794,1 31845,0 31848,1 31852,0 31924,1 31957,0 32003,1 32026,0 32069,1 32127,0 32223,1 32265,0 32325,1 32332,0 32353,1 32417,0 32496,1 32565,0 32603,1 32654,0 32722,1 32779,0 32798,1 32828,0 32892,1 32990,0 33041,1 33052,0 33064,1 33093,0 33182,1 33216,0 33243,1 33304,0 33308,1 33316,0 33342,1 33384,0 33405,1 33504,0 33527,1 33557,0 33615,1 33652,0 33715,1 33721,0 33755,1 33760,0 33764,1 33864,0 33883,1 33930,0 33938,1 33941,0 33986,1 34004,0 34082,1 34093,0 34113,1 34129,0 34146,1 34226,0 34231,1 34275,0 34325,1 34399,0 34462,1 34503,0 34586,1 34686,0 34769,1 34803,0 34854,1 34878,0 34962,1 34974,0 34978,1 35048,0 35127,1 35223,0 35245,1 35320,0 35412,1 35450,0 35531,1 35536,0 35601,1 35626,0 35703,1 35735,0 35741,1 35808,0 35896,1 35966,0 36030,1 36113,0 36206,1 36227,0 36315,1 36402,0 36486,1 36533,0 36633,1 36644,0 36739,1 36752,0 36801,1 36894,0 36909,1 36960,0 37009,1 37041,0 37118,1 37131,0 37230,1 37232,0 37321,1 37403,0 37486,1 37530,0 37595,1 37680,0 37764,1 37847,0 37943,1 38039,0 38122,1 38195,0 38291,1 38382,0 38434,1 38493,0 38521,1 38592,0 38646,1 38709,0 38758,1 38774,0 38862,1 38959,0 39022,1 39115,0 39209,1 39240,0 39281,1 39340,0 39379,1 39429,0 39471,1 39535,0 39554,1 39572,0 39577,1 39623,0 39683,1 39699,0 39753,1 39821,0 39873,1 39959,0 40032,1 40089,0 40110,1 40144,0 40162,1 40175,0 40253,1 40345,0 40427,1 40429,0 40523,1 40593,0 40621,1 40644,0 40691,1 40788,0 40862,1 40883,0 40972,1 41048,0 41099,1 41180,0 41197,1 41278,0 41378,1 41440,0 41518,1 41600,0 41685,1 41706,0 41747,1 41752,0 41807,1 41875,0 41958,1 42017,0 42110,1 42112,0 42165,1 42167,0 42236,1 42238,0 42266,1 42344,0 42415,1 42451,0 42462,1 42515,0 42575,1 42648,0 42703,1 42800,0 42897,1 42912,0 42957,1 43000,0 43077,1 43106,0 43156,1 43220,0 43308,1 43351,0 43443,1 43542,0 43583,1 43627,0 43657,1 43757,0 43822,1 43906,0 43918,1 44007,0 44049,1 44146,0 44147,1 44224,0 44246,1 44281,0 44362,1 44370,0 44456,1 44458,0 44558,1 44620,0 44678,1 44740,0 44756,1 44815,0 44836,1 44884,0 44979,1 45010,0 45082,1 45160,0 45231,1 45273,0 45291,1 45317,0 45364,1 45437,0 45472,1 45552,0 45556,1 45615,0 45629,1 45649,0 45717,1 45766,0 45821,1 45879,0 45905,1 46000,0 46011,1 46034,0 46133,1 46204,0 46226,1 46279,0 46288,1 46328,0 46335,1 46369,0 46376,1 46411,0 46497,1 46551,0 46557,1 46590,0 46676,1 46703,0 46749,1 46751,0 46776,1 46812,0 46883,1 46979,0 47017,1 47042,0 47131,1 47153,0 47250,1 47318,0 47324,1 47363,0 47434,1 47470,0 47546,1 47584,0 47632,1 47721,0 47733,1 47790,0 47879,1 47889,0 47905,1 47926,0 47939,1 48025,0 48105,1 48178,0 48233,1 48279,0 48294,1 48363,0 48438,1 48445,0 48527,1 48584,0 48614,1 48689,0 48694,1 48728,0 48743,1 48778,0 48825,1 48925,0 48992,1 49041,0 49110,1 49193,0 49213,1 49255,0 49316,1 49395,0 49473,1 49522,0 49617,1 49633,0 49697,1 49795,0 49810,1 49851,0 49897,1 49977,0 49989,1 50080,0 50147,1 50172,0 50252,1 50271,0 50298,1 50392,0 50472,1 50473,0 50510,1 50571,0 50623,1 50672,0 50673,1 50722,0 50790,1 50852,0 50896,1 50951,0 50954,1 50957,0 51041,1 end initlist a26 0,0 7,1 62,0 91,1 128,0 155,1 166,0 190,1 253,0 348,1 415,0 494,1 504,0 514,1 593,0 648,1 661,0 706,1 771,0 796,1 847,0 864,1 938,0 947,1 1038,0 1072,1 1163,0 1183,1 1224,0 1239,1 1290,0 1310,1 1359,0 1456,1 1533,0 1565,1 1640,0 1681,1 1755,0 1797,1 1868,0 1966,1 1998,0 2036,1 2087,0 2144,1 2230,0 2288,1 2362,0 2430,1 2447,0 2544,1 2583,0 2599,1 2616,0 2653,1 2682,0 2769,1 2797,0 2889,1 2972,0 3004,1 3076,0 3155,1 3186,0 3243,1 3286,0 3338,1 3424,0 3466,1 3565,0 3604,1 3646,0 3718,1 3763,0 3806,1 3857,0 3930,1 4003,0 4097,1 4129,0 4164,1 4208,0 4258,1 4353,0 4448,1 4456,0 4527,1 4550,0 4581,1 4607,0 4630,1 4654,0 4735,1 4795,0 4876,1 4969,0 5028,1 5126,0 5169,1 5233,0 5311,1 5353,0 5412,1 5422,0 5428,1 5461,0 5511,1 5592,0 5676,1 5731,0 5742,1 5835,0 5912,1 5922,0 5929,1 5996,0 6034,1 6123,0 6136,1 6217,0 6221,1 6257,0 6290,1 6364,0 6418,1 6458,0 6527,1 6566,0 6580,1 6598,0 6667,1 6740,0 6787,1 6834,0 6923,1 7014,0 7102,1 7134,0 7226,1 7313,0 7408,1 7448,0 7516,1 7602,0 7632,1 7690,0 7759,1 7846,0 7850,1 7934,0 8016,1 8097,0 8123,1 8129,0 8130,1 8198,0 8269,1 8334,0 8386,1 8437,0 8453,1 8553,0 8621,1 8655,0 8662,1 8727,0 8820,1 8839,0 8938,1 8992,0 8999,1 9076,0 9099,1 9178,0 9197,1 9208,0 9249,1 9251,0 9256,1 9285,0 9382,1 9471,0 9570,1 9647,0 9733,1 9773,0 9776,1 9856,0 9867,1 9904,0 9926,1 10002,0 10083,1 10142,0 10170,1 10239,0 10314,1 10338,0 10342,1 10379,0 10444,1 10499,0 10546,1 10619,0 10694,1 10775,0 10798,1 10876,0 10974,1 11002,0 11087,1 11143,0 11188,1 11218,0 11264,1 11359,0 11375,1 11466,0 11524,1 11551,0 11646,1 11669,0 11680,1 11697,0 11724,1 11782,0 11818,1 11868,0 11906,1 12000,0 12013,1 12019,0 12026,1 12090,0 12117,1 12199,0 12205,1 12236,0 12248,1 12306,0 12330,1 12397,0 12408,1 12493,0 12507,1 12553,0 12607,1 12677,0 12769,1 12802,0 12834,1 12859,0 12943,1 13042,0 13081,1 13148,0 13196,1 13226,0 13278,1 13289,0 13334,1 13432,0 13453,1 13532,0 13592,1 13602,0 13648,1 13691,0 13709,1 13786,0 13861,1 13881,0 13976,1 14058,0 14148,1 14195,0 14229,1 14275,0 14341,1 14402,0 14417,1 14474,0 14528,1 14557,0 14596,1 14678,0 14767,1 14816,0 14842,1 14886,0 14937,1 14993,0 15014,1 15038,0 15113,1 15196,0 15275,1 15278,0 15331,1 15413,0 15459,1 15480,0 15485,1 15569,0 15584,1 15607,0 15611,1 15682,0 15751,1 15838,0 15863,1 15880,0 15905,1 15954,0 16035,1 16063,0 16153,1 16249,0 16342,1 16351,0 16396,1 16454,0 16535,1 16573,0 16626,1 16708,0 16783,1 16851,0 16868,1 16889,0 16980,1 17029,0 17101,1 17171,0 17232,1 17290,0 17307,1 17400,0 17430,1 17484,0 17562,1 17581,0 17630,1 17650,0 17740,1 17840,0 17926,1 17948,0 18021,1 18041,0 18079,1 18179,0 18218,1 18234,0 18333,1 18360,0 18362,1 18419,0 18485,1 18547,0 18644,1 18692,0 18762,1 18824,0 18861,1 18958,0 19056,1 19151,0 19180,1 19264,0 19311,1 19370,0 19412,1 19474,0 19492,1 19564,0 19592,1 19677,0 19763,1 19819,0 19884,1 19961,0 20030,1 20055,0 20089,1 20122,0 20148,1 20200,0 20291,1 20303,0 20401,1 20402,0 20446,1 20461,0 20493,1 20520,0 20601,1 20667,0 20673,1 20699,0 20756,1 20786,0 20884,1 20977,0 21049,1 21096,0 21146,1 21214,0 21225,1 21304,0 21399,1 21439,0 21535,1 21536,0 21574,1 21651,0 21689,1 21715,0 21782,1 21820,0 21826,1 21915,0 21988,1 22047,0 22065,1 22164,0 22204,1 22280,0 22352,1 22409,0 22426,1 22448,0 22485,1 22506,0 22547,1 22575,0 22649,1 22735,0 22835,1 22839,0 22936,1 22982,0 23008,1 23020,0 23081,1 23125,0 23151,1 23181,0 23195,1 23225,0 23285,1 23289,0 23378,1 23429,0 23483,1 23532,0 23541,1 23563,0 23624,1 23701,0 23773,1 23838,0 23861,1 23885,0 23887,1 23926,0 23975,1 24064,0 24084,1 24089,0 24121,1 24201,0 24241,1 24306,0 24308,1 24310,0 24407,1 24471,0 24496,1 24524,0 24533,1 24595,0 24685,1 24751,0 24788,1 24818,0 24892,1 24928,0 24958,1 24960,0 25029,1 25084,0 25173,1 25265,0 25332,1 25340,0 25359,1 25417,0 25424,1 25503,0 25554,1 25565,0 25590,1 25625,0 25658,1 25678,0 25703,1 25739,0 25815,1 25867,0 25956,1 25984,0 26043,1 26109,0 26135,1 26137,0 26222,1 26236,0 26328,1 26334,0 26404,1 26416,0 26459,1 26547,0 26611,1 26628,0 26661,1 26679,0 26724,1 26779,0 26825,1 26917,0 27009,1 27031,0 27082,1 27154,0 27187,1 27221,0 27281,1 27311,0 27359,1 27395,0 27438,1 27481,0 27533,1 27542,0 27569,1 27580,0 27590,1 27629,0 27688,1 27749,0 27796,1 27882,0 27974,1 27999,0 28043,1 28099,0 28119,1 28145,0 28189,1 28283,0 28371,1 28422,0 28437,1 28460,0 28541,1 28560,0 28567,1 28639,0 28703,1 28744,0 28751,1 28782,0 28848,1 28882,0 28955,1 29021,0 29094,1 29140,0 29152,1 29171,0 29200,1 29261,0 29285,1 29323,0 29387,1 29454,0 29551,1 29552,0 29564,1 29633,0 29663,1 29689,0 29711,1 29737,0 29828,1 29921,0 29992,1 30071,0 30143,1 30217,0 30257,1 30350,0 30363,1 30426,0 30450,1 30549,0 30649,1 30686,0 30744,1 30784,0 30794,1 30881,0 30955,1 31049,0 31067,1 31093,0 31184,1 31250,0 31254,1 31309,0 31334,1 31347,0 31418,1 31463,0 31545,1 31632,0 31636,1 31694,0 31761,1 31784,0 31837,1 31906,0 31937,1 32006,0 32030,1 32065,0 32151,1 32171,0 32254,1 32324,0 32341,1 32434,0 32457,1 32522,0 32576,1 32674,0 32754,1 32776,0 32788,1 32793,0 32888,1 32919,0 32981,1 33068,0 33084,1 33159,0 33232,1 33276,0 33329,1 33338,0 33438,1 33498,0 33523,1 33539,0 33578,1 33655,0 33748,1 33823,0 33908,1 33914,0 33986,1 33998,0 34005,1 34072,0 34139,1 34189,0 34274,1 34275,0 34339,1 34378,0 34411,1 34492,0 34561,1 34627,0 34664,1 34709,0 34790,1 34800,0 34890,1 34895,0 34906,1 34957,0 35049,1 35103,0 35193,1 35217,0 35307,1 35381,0 35454,1 35471,0 35535,1 35622,0 35661,1 35718,0 35744,1 35781,0 35810,1 35842,0 35904,1 35927,0 35991,1 36046,0 36117,1 36187,0 36234,1 36318,0 36326,1 36331,0 36398,1 36477,0 36556,1 36586,0 36660,1 36677,0 36730,1 36757,0 36782,1 36881,0 36893,1 36972,0 37060,1 37131,0 37194,1 37197,0 37235,1 37271,0 37360,1 37405,0 37468,1 37489,0 37567,1 37657,0 37702,1 37799,0 37827,1 37829,0 37847,1 37926,0 38007,1 38021,0 38048,1 38118,0 38120,1 38126,0 38196,1 38204,0 38302,1 38398,0 38464,1 38535,0 38608,1 38636,0 38642,1 38667,0 38762,1 38820,0 38878,1 38970,0 39003,1 39022,0 39087,1 39098,0 39104,1 39114,0 39155,1 39179,0 39232,1 39244,0 39259,1 39313,0 39334,1 39418,0 39488,1 39564,0 39604,1 39614,0 39669,1 39672,0 39711,1 39716,0 39791,1 39841,0 39867,1 39895,0 39982,1 40012,0 40075,1 40132,0 40155,1 40161,0 40247,1 40337,0 40401,1 40450,0 40522,1 40591,0 40637,1 40705,0 40733,1 40743,0 40824,1 40889,0 40924,1 40980,0 40995,1 40998,0 41096,1 41196,0 41264,1 41359,0 41370,1 41454,0 41481,1 41540,0 41546,1 41597,0 41625,1 41652,0 41717,1 41721,0 41800,1 41804,0 41871,1 41940,0 42030,1 42080,0 42163,1 42241,0 42308,1 42377,0 42426,1 42436,0 42505,1 42540,0 42602,1 42643,0 42720,1 42815,0 42863,1 42955,0 43034,1 43129,0 43199,1 43208,0 43294,1 43390,0 43438,1 43466,0 43548,1 43595,0 43634,1 43635,0 43661,1 43669,0 43712,1 43743,0 43814,1 43819,0 43882,1 43923,0 44009,1 44090,0 44122,1 44215,0 44247,1 44314,0 44351,1 44432,0 44440,1 44468,0 44546,1 44609,0 44694,1 44758,0 44776,1 44867,0 44876,1 44952,0 45001,1 45077,0 45156,1 45214,0 45309,1 45396,0 45442,1 45526,0 45544,1 45601,0 45696,1 45734,0 45768,1 45855,0 45920,1 45978,0 45981,1 46009,0 46052,1 46076,0 46132,1 46229,0 46296,1 46310,0 46385,1 46425,0 46434,1 46439,0 46444,1 46497,0 46523,1 46621,0 46671,1 46702,0 46712,1 46803,0 46897,1 46990,0 47057,1 47079,0 47169,1 47249,0 47254,1 47321,0 47419,1 47426,0 47491,1 47509,0 47536,1 47553,0 47564,1 47582,0 47602,1 47646,0 47697,1 47773,0 47788,1 47804,0 47851,1 47948,0 48011,1 48061,0 48120,1 48215,0 48283,1 48302,0 48333,1 48431,0 48434,1 48465,0 48489,1 48502,0 48524,1 48610,0 48666,1 48766,0 48846,1 48911,0 48933,1 49023,0 49036,1 49045,0 49066,1 49117,0 49202,1 49262,0 49305,1 49345,0 49437,1 49492,0 49502,1 49581,0 49587,1 49661,0 49670,1 49679,0 49719,1 49745,0 49759,1 49858,0 49866,1 49965,0 50027,1 50091,0 50184,1 50215,0 50225,1 50264,0 50326,1 50335,0 50353,1 end initlist a27 0,0 29,1 85,0 114,1 185,0 267,1 342,0 372,1 403,0 487,1 526,0 550,1 570,0 646,1 718,0 814,1 896,0 943,1 971,0 1070,1 1090,0 1155,1 1252,0 1272,1 1301,0 1310,1 1377,0 1476,1 1568,0 1594,1 1669,0 1727,1 1746,0 1772,1 1832,0 1916,1 1958,0 1991,1 2006,0 2032,1 2075,0 2092,1 2101,0 2103,1 2105,0 2187,1 2215,0 2311,1 2406,0 2467,1 2490,0 2553,1 2586,0 2665,1 2760,0 2860,1 2877,0 2928,1 2956,0 3039,1 3120,0 3208,1 3304,0 3394,1 3403,0 3477,1 3577,0 3657,1 3706,0 3730,1 3757,0 3832,1 3880,0 3891,1 3927,0 3959,1 3980,0 4058,1 4066,0 4099,1 4105,0 4121,1 4138,0 4199,1 4295,0 4335,1 4422,0 4440,1 4529,0 4534,1 4572,0 4584,1 4649,0 4675,1 4763,0 4764,1 4845,0 4886,1 4943,0 4957,1 4994,0 5048,1 5085,0 5087,1 5168,0 5224,1 5271,0 5315,1 5345,0 5354,1 5384,0 5387,1 5415,0 5488,1 5567,0 5666,1 5686,0 5734,1 5809,0 5838,1 5891,0 5971,1 6043,0 6130,1 6154,0 6161,1 6210,0 6287,1 6326,0 6413,1 6511,0 6592,1 6650,0 6750,1 6802,0 6901,1 6927,0 7009,1 7088,0 7103,1 7152,0 7248,1 7285,0 7315,1 7390,0 7454,1 7542,0 7577,1 7675,0 7695,1 7725,0 7740,1 7769,0 7815,1 7881,0 7959,1 8051,0 8151,1 8161,0 8182,1 8229,0 8329,1 8355,0 8407,1 8491,0 8562,1 8605,0 8670,1 8690,0 8782,1 8805,0 8817,1 8881,0 8894,1 8908,0 8959,1 9045,0 9129,1 9205,0 9265,1 9344,0 9441,1 9521,0 9549,1 9602,0 9652,1 9689,0 9709,1 9741,0 9748,1 9785,0 9786,1 9876,0 9943,1 10023,0 10097,1 10108,0 10184,1 10190,0 10268,1 10302,0 10365,1 10449,0 10507,1 10559,0 10645,1 10680,0 10715,1 10791,0 10865,1 10894,0 10916,1 10976,0 11060,1 11151,0 11250,1 11331,0 11347,1 11372,0 11444,1 11538,0 11584,1 11666,0 11724,1 11804,0 11868,1 11968,0 11998,1 12091,0 12135,1 12155,0 12190,1 12245,0 12310,1 12381,0 12475,1 12500,0 12567,1 12652,0 12745,1 12816,0 12833,1 12930,0 12975,1 13005,0 13077,1 13160,0 13190,1 13221,0 13314,1 13322,0 13403,1 13495,0 13524,1 13564,0 13591,1 13673,0 13766,1 13804,0 13838,1 13906,0 13973,1 14060,0 14087,1 14135,0 14180,1 14269,0 14327,1 14336,0 14368,1 14378,0 14400,1 14474,0 14500,1 14560,0 14657,1 14691,0 14789,1 14827,0 14878,1 14898,0 14987,1 15020,0 15120,1 15177,0 15261,1 15315,0 15332,1 15413,0 15432,1 15480,0 15555,1 15571,0 15658,1 15731,0 15810,1 15842,0 15867,1 15949,0 16004,1 16035,0 16081,1 16122,0 16162,1 16169,0 16226,1 16229,0 16269,1 16365,0 16453,1 16501,0 16571,1 16608,0 16651,1 16673,0 16688,1 16701,0 16783,1 16806,0 16822,1 16887,0 16955,1 16962,0 17060,1 17065,0 17073,1 17092,0 17114,1 17136,0 17207,1 17265,0 17321,1 17367,0 17417,1 17468,0 17524,1 17612,0 17704,1 17754,0 17796,1 17842,0 17878,1 17930,0 18000,1 18021,0 18121,1 18215,0 18246,1 18274,0 18279,1 18343,0 18384,1 18435,0 18460,1 18485,0 18528,1 18603,0 18657,1 18726,0 18765,1 18856,0 18924,1 18997,0 19074,1 19146,0 19177,1 19258,0 19293,1 19373,0 19439,1 19448,0 19511,1 19533,0 19597,1 19607,0 19625,1 19695,0 19710,1 19774,0 19834,1 19920,0 19932,1 20006,0 20023,1 20054,0 20137,1 20220,0 20231,1 20238,0 20284,1 20341,0 20375,1 20472,0 20547,1 20554,0 20645,1 20714,0 20814,1 20817,0 20906,1 20987,0 21044,1 21110,0 21114,1 21184,0 21210,1 21280,0 21293,1 21341,0 21393,1 21450,0 21516,1 21551,0 21605,1 21650,0 21659,1 21717,0 21815,1 21869,0 21959,1 21985,0 22022,1 22034,0 22116,1 22146,0 22231,1 22310,0 22333,1 22345,0 22395,1 22443,0 22508,1 22595,0 22611,1 22709,0 22744,1 22758,0 22842,1 22916,0 22955,1 22988,0 23013,1 23106,0 23127,1 23187,0 23273,1 23352,0 23425,1 23476,0 23480,1 23542,0 23549,1 23644,0 23698,1 23724,0 23820,1 23845,0 23900,1 23966,0 24041,1 24067,0 24103,1 24172,0 24245,1 24328,0 24397,1 24435,0 24513,1 24545,0 24575,1 24626,0 24697,1 24756,0 24789,1 24889,0 24903,1 24928,0 24953,1 25010,0 25074,1 25115,0 25128,1 25148,0 25198,1 25238,0 25240,1 25278,0 25358,1 25454,0 25505,1 25571,0 25604,1 25610,0 25636,1 25720,0 25809,1 25832,0 25880,1 25930,0 26006,1 26104,0 26188,1 26238,0 26312,1 26411,0 26437,1 26523,0 26589,1 26636,0 26644,1 26653,0 26715,1 26753,0 26846,1 26848,0 26853,1 26919,0 26996,1 27076,0 27171,1 27200,0 27263,1 27315,0 27318,1 27413,0 27488,1 27520,0 27530,1 27562,0 27568,1 27628,0 27640,1 27674,0 27709,1 27775,0 27837,1 27880,0 27953,1 27995,0 28002,1 28037,0 28129,1 28168,0 28227,1 28263,0 28292,1 28392,0 28452,1 28461,0 28500,1 28537,0 28549,1 28552,0 28579,1 28656,0 28691,1 28746,0 28816,1 28840,0 28931,1 29019,0 29073,1 29172,0 29191,1 29209,0 29270,1 29369,0 29418,1 29433,0 29500,1 29512,0 29563,1 29619,0 29678,1 29722,0 29779,1 29816,0 29864,1 29877,0 29915,1 29983,0 30078,1 30158,0 30241,1 30315,0 30340,1 30413,0 30488,1 30582,0 30677,1 30682,0 30698,1 30741,0 30821,1 30825,0 30864,1 30875,0 30959,1 30970,0 31026,1 31110,0 31125,1 31204,0 31239,1 31320,0 31380,1 31475,0 31507,1 31530,0 31576,1 31592,0 31681,1 31765,0 31809,1 31908,0 31999,1 32071,0 32161,1 32258,0 32352,1 32431,0 32509,1 32514,0 32578,1 32591,0 32683,1 32703,0 32766,1 32808,0 32819,1 32832,0 32845,1 32865,0 32949,1 32982,0 33046,1 33090,0 33151,1 33162,0 33173,1 33209,0 33274,1 33344,0 33348,1 33442,0 33465,1 33476,0 33497,1 33573,0 33659,1 33724,0 33781,1 33798,0 33848,1 33855,0 33867,1 33873,0 33924,1 33994,0 34030,1 34034,0 34050,1 34101,0 34118,1 34156,0 34173,1 34218,0 34224,1 34305,0 34344,1 34439,0 34447,1 34455,0 34536,1 34544,0 34548,1 34579,0 34604,1 34688,0 34703,1 34799,0 34894,1 34939,0 35009,1 35022,0 35098,1 35100,0 35117,1 35141,0 35157,1 35185,0 35220,1 35230,0 35320,1 35341,0 35431,1 35522,0 35534,1 35560,0 35563,1 35660,0 35725,1 35784,0 35859,1 35863,0 35896,1 35950,0 35989,1 35991,0 36009,1 36021,0 36062,1 36091,0 36169,1 36205,0 36260,1 36357,0 36377,1 36439,0 36486,1 36488,0 36569,1 36621,0 36627,1 36690,0 36738,1 36821,0 36900,1 36948,0 37024,1 37119,0 37149,1 37244,0 37293,1 37305,0 37323,1 37339,0 37411,1 37445,0 37507,1 37518,0 37546,1 37568,0 37616,1 37648,0 37697,1 37791,0 37806,1 37840,0 37908,1 38002,0 38100,1 38119,0 38155,1 38176,0 38264,1 38354,0 38453,1 38463,0 38531,1 38552,0 38576,1 38604,0 38673,1 38712,0 38778,1 38823,0 38848,1 38905,0 38952,1 38962,0 38983,1 39044,0 39074,1 39107,0 39145,1 39204,0 39218,1 39272,0 39294,1 39386,0 39467,1 39490,0 39529,1 39576,0 39578,1 39614,0 39698,1 39774,0 39842,1 39869,0 39904,1 39983,0 40060,1 40078,0 40109,1 40198,0 40243,1 40314,0 40368,1 40389,0 40396,1 40399,0 40418,1 40513,0 40609,1 40643,0 40662,1 40681,0 40706,1 40711,0 40801,1 40808,0 40830,1 40877,0 40937,1 41013,0 41017,1 41045,0 41067,1 41141,0 41235,1 41321,0 41328,1 41339,0 41428,1 41441,0 41533,1 41589,0 41631,1 41691,0 41726,1 41766,0 41815,1 41859,0 41954,1 41978,0 42041,1 42066,0 42149,1 42150,0 42156,1 42203,0 42287,1 42382,0 42480,1 42503,0 42545,1 42610,0 42623,1 42643,0 42712,1 42729,0 42791,1 42831,0 42898,1 42974,0 43047,1 43119,0 43199,1 43234,0 43304,1 43339,0 43378,1 43474,0 43549,1 43567,0 43638,1 43730,0 43777,1 43853,0 43905,1 43920,0 44007,1 44011,0 44014,1 44077,0 44159,1 44188,0 44220,1 44305,0 44329,1 44429,0 44455,1 44546,0 44572,1 44617,0 44685,1 44781,0 44846,1 44936,0 45012,1 45069,0 45087,1 45152,0 45206,1 45252,0 45348,1 45378,0 45400,1 45423,0 45497,1 45541,0 45604,1 45608,0 45618,1 45649,0 45747,1 45819,0 45867,1 45917,0 45956,1 46033,0 46038,1 46094,0 46175,1 46202,0 46261,1 46320,0 46405,1 46453,0 46532,1 46579,0 46638,1 46661,0 46689,1 46698,0 46726,1 46815,0 46862,1 46922,0 46936,1 46945,0 47021,1 47034,0 47048,1 47116,0 47166,1 47232,0 47308,1 47403,0 47496,1 47543,0 47574,1 47579,0 47663,1 47673,0 47720,1 47765,0 47862,1 47941,0 48020,1 48109,0 48116,1 48139,0 48213,1 48264,0 48320,1 48386,0 48410,1 48461,0 48509,1 48561,0 48619,1 48705,0 48788,1 48875,0 48923,1 48984,0 49080,1 49152,0 49179,1 49203,0 49267,1 49312,0 49375,1 49400,0 49404,1 49426,0 49472,1 49487,0 49494,1 49559,0 49561,1 49642,0 49644,1 49688,0 49730,1 49736,0 49827,1 49899,0 49934,1 49953,0 50029,1 50111,0 50148,1 50184,0 50274,1 50287,0 50387,1 50389,0 50448,1 end initlist a28 0,0 35,1 76,0 156,1 224,0 231,1 322,0 367,1 384,0 474,1 564,0 644,1 694,0 699,1 711,0 767,1 776,0 858,1 943,0 994,1 1061,0 1065,1 1080,0 1157,1 1241,0 1306,1 1358,0 1446,1 1466,0 1517,1 1598,0 1656,1 1693,0 1747,1 1794,0 1863,1 1867,0 1893,1 1928,0 1940,1 1986,0 2004,1 2104,0 2189,1 2260,0 2331,1 2360,0 2431,1 2516,0 2610,1 2617,0 2684,1 2706,0 2738,1 2814,0 2821,1 2849,0 2890,1 2923,0 2972,1 3031,0 3103,1 3132,0 3170,1 3269,0 3337,1 3386,0 3420,1 3483,0 3487,1 3502,0 3574,1 3659,0 3746,1 3775,0 3846,1 3925,0 3939,1 4036,0 4049,1 4111,0 4126,1 4203,0 4210,1 4264,0 4338,1 4425,0 4508,1 4553,0 4643,1 4718,0 4738,1 4829,0 4845,1 4934,0 4993,1 5028,0 5122,1 5196,0 5257,1 5308,0 5351,1 5389,0 5463,1 5535,0 5620,1 5640,0 5725,1 5782,0 5825,1 5921,0 6006,1 6098,0 6185,1 6258,0 6270,1 6296,0 6302,1 6351,0 6378,1 6413,0 6458,1 6495,0 6547,1 6645,0 6704,1 6776,0 6807,1 6830,0 6927,1 6946,0 7026,1 7115,0 7148,1 7210,0 7250,1 7340,0 7387,1 7449,0 7486,1 7549,0 7601,1 7652,0 7699,1 7745,0 7791,1 7825,0 7886,1 7957,0 8025,1 8100,0 8171,1 8269,0 8289,1 8356,0 8440,1 8510,0 8566,1 8594,0 8598,1 8656,0 8721,1 8740,0 8759,1 8787,0 8833,1 8839,0 8913,1 8964,0 9014,1 9101,0 9189,1 9248,0 9281,1 9379,0 9421,1 9517,0 9554,1 9613,0 9701,1 9733,0 9762,1 9794,0 9867,1 9938,0 9972,1 10061,0 10086,1 10156,0 10243,1 10251,0 10290,1 10297,0 10322,1 10323,0 10373,1 10417,0 10442,1 10488,0 10537,1 10541,0 10561,1 10631,0 10712,1 10742,0 10765,1 10807,0 10872,1 10912,0 11010,1 11038,0 11064,1 11080,0 11125,1 11128,0 11161,1 11186,0 11250,1 11266,0 11280,1 11296,0 11369,1 11412,0 11454,1 11468,0 11521,1 11588,0 11681,1 11728,0 11816,1 11859,0 11881,1 11907,0 12002,1 12063,0 12158,1 12192,0 12243,1 12312,0 12340,1 12355,0 12420,1 12487,0 12512,1 12598,0 12679,1 12683,0 12754,1 12812,0 12889,1 12914,0 12931,1 12947,0 12956,1 13056,0 13070,1 13106,0 13146,1 13211,0 13220,1 13292,0 13305,1 13376,0 13405,1 13441,0 13535,1 13555,0 13610,1 13651,0 13665,1 13731,0 13796,1 13855,0 13900,1 13922,0 14013,1 14059,0 14082,1 14103,0 14110,1 14154,0 14161,1 14219,0 14240,1 14258,0 14312,1 14376,0 14455,1 14495,0 14531,1 14611,0 14660,1 14739,0 14789,1 14856,0 14871,1 14961,0 15014,1 15107,0 15164,1 15165,0 15216,1 15290,0 15319,1 15374,0 15386,1 15481,0 15484,1 15571,0 15619,1 15719,0 15815,1 15906,0 16006,1 16093,0 16141,1 16154,0 16197,1 16292,0 16307,1 16316,0 16375,1 16397,0 16398,1 16441,0 16454,1 16539,0 16579,1 16587,0 16642,1 16722,0 16772,1 16774,0 16824,1 16885,0 16920,1 16939,0 17015,1 17098,0 17148,1 17161,0 17258,1 17322,0 17390,1 17434,0 17437,1 17439,0 17507,1 17564,0 17621,1 17634,0 17697,1 17723,0 17809,1 17838,0 17918,1 17966,0 18057,1 18133,0 18145,1 18221,0 18251,1 18306,0 18337,1 18398,0 18447,1 18479,0 18569,1 18655,0 18726,1 18798,0 18844,1 18875,0 18972,1 19052,0 19078,1 19174,0 19210,1 19274,0 19317,1 19364,0 19377,1 19431,0 19483,1 19549,0 19644,1 19709,0 19735,1 19800,0 19843,1 19904,0 19914,1 19986,0 20048,1 20115,0 20122,1 20221,0 20294,1 20335,0 20408,1 20432,0 20437,1 20477,0 20540,1 20567,0 20653,1 20697,0 20738,1 20792,0 20879,1 20961,0 21020,1 21025,0 21043,1 21096,0 21181,1 21236,0 21239,1 21282,0 21326,1 21376,0 21395,1 21438,0 21462,1 21546,0 21593,1 21691,0 21747,1 21798,0 21860,1 21922,0 22022,1 22070,0 22121,1 22138,0 22179,1 22272,0 22360,1 22392,0 22408,1 22411,0 22415,1 22469,0 22562,1 22588,0 22616,1 22621,0 22673,1 22723,0 22771,1 22802,0 22843,1 22856,0 22911,1 22913,0 23002,1 23041,0 23106,1 23116,0 23178,1 23239,0 23280,1 23330,0 23366,1 23441,0 23525,1 23575,0 23602,1 23654,0 23749,1 23805,0 23843,1 23874,0 23885,1 23917,0 23984,1 24019,0 24106,1 24152,0 24157,1 24233,0 24300,1 24392,0 24414,1 24419,0 24516,1 24550,0 24586,1 24613,0 24623,1 24657,0 24711,1 24724,0 24797,1 24854,0 24856,1 24923,0 24985,1 25011,0 25088,1 25115,0 25213,1 25306,0 25307,1 25358,0 25367,1 25420,0 25457,1 25459,0 25529,1 25545,0 25594,1 25681,0 25701,1 25800,0 25875,1 25964,0 25965,1 26038,0 26070,1 26111,0 26139,1 26194,0 26202,1 26246,0 26304,1 26353,0 26367,1 26381,0 26438,1 26538,0 26628,1 26640,0 26657,1 26675,0 26696,1 26777,0 26789,1 26878,0 26951,1 27020,0 27109,1 27153,0 27162,1 27252,0 27266,1 27357,0 27366,1 27385,0 27446,1 27497,0 27545,1 27548,0 27556,1 27599,0 27658,1 27752,0 27772,1 27847,0 27875,1 27887,0 27912,1 27992,0 28007,1 28096,0 28182,1 28185,0 28203,1 28223,0 28289,1 28358,0 28427,1 28460,0 28482,1 28487,0 28489,1 28577,0 28638,1 28639,0 28728,1 28733,0 28749,1 28802,0 28806,1 28820,0 28912,1 28987,0 29069,1 29112,0 29142,1 29168,0 29189,1 29269,0 29300,1 29324,0 29400,1 29437,0 29480,1 29512,0 29604,1 29697,0 29796,1 29811,0 29853,1 29897,0 29898,1 29906,0 29994,1 30073,0 30120,1 30146,0 30168,1 30255,0 30331,1 30429,0 30478,1 30568,0 30598,1 30603,0 30672,1 30744,0 30762,1 30825,0 30887,1 30955,0 30962,1 31045,0 31125,1 31220,0 31285,1 31359,0 31420,1 31499,0 31554,1 31611,0 31683,1 31740,0 31754,1 31813,0 31845,1 31931,0 31964,1 32031,0 32073,1 32164,0 32199,1 32219,0 32233,1 32245,0 32301,1 32321,0 32405,1 32432,0 32467,1 32493,0 32521,1 32524,0 32598,1 32657,0 32698,1 32719,0 32730,1 32802,0 32805,1 32815,0 32879,1 32930,0 32947,1 32948,0 33019,1 33062,0 33099,1 33141,0 33203,1 33214,0 33253,1 33258,0 33263,1 33339,0 33344,1 33415,0 33426,1 33482,0 33501,1 33601,0 33691,1 33696,0 33713,1 33747,0 33831,1 33850,0 33931,1 34024,0 34037,1 34131,0 34182,1 34247,0 34341,1 34427,0 34505,1 34604,0 34694,1 34787,0 34880,1 34972,0 34975,1 35063,0 35156,1 35181,0 35209,1 35262,0 35330,1 35363,0 35447,1 35532,0 35546,1 35550,0 35585,1 35596,0 35694,1 35705,0 35743,1 35753,0 35808,1 35824,0 35896,1 35990,0 36086,1 36103,0 36131,1 36224,0 36263,1 36270,0 36311,1 36378,0 36469,1 36536,0 36636,1 36701,0 36757,1 36782,0 36795,1 36797,0 36882,1 36962,0 36966,1 37038,0 37127,1 37210,0 37249,1 37339,0 37392,1 37445,0 37467,1 37506,0 37555,1 37623,0 37625,1 37671,0 37711,1 37800,0 37842,1 37871,0 37921,1 37924,0 37934,1 37957,0 38017,1 38086,0 38144,1 38157,0 38184,1 38280,0 38339,1 38406,0 38462,1 38548,0 38588,1 38593,0 38629,1 38630,0 38727,1 38773,0 38841,1 38911,0 38922,1 38974,0 38978,1 39024,0 39108,1 39182,0 39246,1 39304,0 39401,1 39490,0 39584,1 39679,0 39697,1 39795,0 39865,1 39890,0 39921,1 39939,0 40019,1 40036,0 40125,1 40174,0 40175,1 40246,0 40316,1 40394,0 40421,1 40494,0 40529,1 40538,0 40546,1 40603,0 40699,1 40773,0 40782,1 40846,0 40904,1 40968,0 41006,1 41069,0 41096,1 41166,0 41256,1 41339,0 41407,1 41480,0 41527,1 41577,0 41627,1 41687,0 41784,1 41867,0 41946,1 42008,0 42062,1 42137,0 42178,1 42251,0 42323,1 42400,0 42449,1 42454,0 42497,1 42544,0 42627,1 42680,0 42703,1 42744,0 42776,1 42846,0 42890,1 42964,0 43019,1 43089,0 43172,1 43203,0 43250,1 43318,0 43383,1 43470,0 43525,1 43562,0 43597,1 43668,0 43766,1 43784,0 43861,1 43882,0 43886,1 43960,0 43963,1 44062,0 44095,1 44172,0 44231,1 44274,0 44288,1 44352,0 44421,1 44461,0 44495,1 44496,0 44553,1 44606,0 44698,1 44745,0 44816,1 44819,0 44861,1 44960,0 45007,1 45065,0 45127,1 45187,0 45194,1 45258,0 45293,1 45303,0 45361,1 45363,0 45406,1 45494,0 45503,1 45567,0 45622,1 45628,0 45645,1 45743,0 45795,1 45812,0 45863,1 45869,0 45937,1 45944,0 45966,1 46041,0 46116,1 46216,0 46233,1 46238,0 46266,1 46335,0 46373,1 46446,0 46481,1 46565,0 46566,1 46577,0 46629,1 46656,0 46700,1 46746,0 46822,1 46920,0 47005,1 47012,0 47023,1 47103,0 47106,1 47184,0 47274,1 47298,0 47341,1 47387,0 47411,1 47445,0 47540,1 47595,0 47673,1 47689,0 47787,1 47874,0 47935,1 47974,0 48071,1 48141,0 48238,1 48261,0 48264,1 48313,0 48321,1 48378,0 48421,1 48430,0 48479,1 48500,0 48544,1 48565,0 48589,1 48657,0 48678,1 48756,0 48795,1 48860,0 48869,1 48880,0 48964,1 49055,0 49134,1 49156,0 49219,1 49265,0 49305,1 49358,0 49403,1 49414,0 49464,1 49475,0 49520,1 49612,0 49684,1 49732,0 49748,1 49780,0 49843,1 49894,0 49897,1 end initlist a29 0,0 4,1 44,0 86,1 122,0 165,1 240,0 257,1 277,0 303,1 391,0 414,1 503,0 585,1 614,0 616,1 634,0 670,1 761,0 802,1 806,0 905,1 976,0 1072,1 1171,0 1203,1 1206,0 1244,1 1318,0 1372,1 1409,0 1442,1 1480,0 1493,1 1542,0 1566,1 1596,0 1694,1 1793,0 1875,1 1918,0 1943,1 1951,0 1952,1 2052,0 2097,1 2145,0 2196,1 2212,0 2300,1 2376,0 2471,1 2499,0 2515,1 2533,0 2576,1 2633,0 2702,1 2752,0 2795,1 2820,0 2888,1 2951,0 2952,1 2995,0 3067,1 3133,0 3173,1 3227,0 3256,1 3331,0 3389,1 3485,0 3496,1 3570,0 3601,1 3617,0 3678,1 3725,0 3817,1 3887,0 3972,1 4064,0 4078,1 4102,0 4148,1 4244,0 4328,1 4420,0 4473,1 4514,0 4517,1 4609,0 4622,1 4660,0 4752,1 4779,0 4871,1 4929,0 5004,1 5074,0 5171,1 5270,0 5275,1 5286,0 5344,1 5421,0 5458,1 5547,0 5618,1 5624,0 5632,1 5645,0 5683,1 5775,0 5777,1 5815,0 5846,1 5934,0 5967,1 6008,0 6036,1 6084,0 6090,1 6130,0 6150,1 6163,0 6183,1 6198,0 6239,1 6275,0 6329,1 6336,0 6396,1 6427,0 6443,1 6489,0 6511,1 6589,0 6688,1 6784,0 6840,1 6933,0 6970,1 7034,0 7132,1 7230,0 7306,1 7396,0 7438,1 7532,0 7586,1 7635,0 7719,1 7764,0 7863,1 7880,0 7969,1 8006,0 8100,1 8148,0 8165,1 8245,0 8288,1 8328,0 8420,1 8519,0 8549,1 8587,0 8592,1 8610,0 8672,1 8684,0 8720,1 8804,0 8822,1 8851,0 8943,1 8947,0 9038,1 9110,0 9179,1 9226,0 9244,1 9339,0 9382,1 9412,0 9430,1 9449,0 9461,1 9480,0 9490,1 9534,0 9594,1 9676,0 9679,1 9750,0 9812,1 9897,0 9919,1 10004,0 10072,1 10171,0 10174,1 10207,0 10227,1 10271,0 10316,1 10397,0 10425,1 10445,0 10465,1 10527,0 10620,1 10664,0 10716,1 10796,0 10815,1 10847,0 10940,1 10976,0 11057,1 11138,0 11211,1 11273,0 11326,1 11371,0 11386,1 11425,0 11426,1 11484,0 11526,1 11612,0 11674,1 11762,0 11848,1 11945,0 12029,1 12035,0 12107,1 12182,0 12192,1 12284,0 12327,1 12328,0 12402,1 12444,0 12517,1 12615,0 12637,1 12712,0 12784,1 12804,0 12834,1 12871,0 12971,1 13003,0 13081,1 13177,0 13223,1 13248,0 13285,1 13286,0 13334,1 13345,0 13351,1 13353,0 13422,1 13493,0 13591,1 13604,0 13627,1 13678,0 13716,1 13784,0 13882,1 13967,0 13994,1 14071,0 14101,1 14157,0 14192,1 14228,0 14251,1 14283,0 14352,1 14402,0 14448,1 14534,0 14592,1 14653,0 14748,1 14844,0 14854,1 14933,0 14998,1 15036,0 15112,1 15117,0 15122,1 15145,0 15220,1 15275,0 15325,1 15384,0 15395,1 15441,0 15481,1 15506,0 15516,1 15557,0 15566,1 15660,0 15680,1 15738,0 15786,1 15806,0 15865,1 15889,0 15905,1 15958,0 16005,1 16057,0 16136,1 16172,0 16230,1 16329,0 16387,1 16396,0 16448,1 16536,0 16632,1 16688,0 16766,1 16838,0 16841,1 16923,0 16936,1 16992,0 17059,1 17073,0 17171,1 17262,0 17322,1 17366,0 17381,1 17435,0 17517,1 17585,0 17650,1 17718,0 17816,1 17871,0 17880,1 17889,0 17891,1 17911,0 17997,1 18012,0 18036,1 18101,0 18167,1 18239,0 18276,1 18319,0 18362,1 18417,0 18468,1 18545,0 18549,1 18586,0 18625,1 18689,0 18766,1 18774,0 18860,1 18951,0 19009,1 19075,0 19079,1 19152,0 19209,1 19211,0 19291,1 19361,0 19413,1 19477,0 19535,1 19612,0 19706,1 19726,0 19812,1 19900,0 19916,1 19998,0 20011,1 20022,0 20085,1 20089,0 20188,1 20199,0 20295,1 20333,0 20410,1 20467,0 20479,1 20571,0 20625,1 20701,0 20788,1 20808,0 20835,1 20837,0 20931,1 20961,0 21055,1 21154,0 21197,1 21252,0 21269,1 21355,0 21362,1 21450,0 21481,1 21510,0 21584,1 21626,0 21714,1 21742,0 21828,1 21918,0 21988,1 22012,0 22047,1 22063,0 22121,1 22179,0 22228,1 22236,0 22298,1 22392,0 22476,1 22508,0 22510,1 22586,0 22630,1 22685,0 22719,1 22805,0 22880,1 22941,0 22991,1 23061,0 23111,1 23114,0 23144,1 23187,0 23250,1 23303,0 23351,1 23395,0 23468,1 23544,0 23625,1 23704,0 23761,1 23825,0 23898,1 23946,0 24027,1 24089,0 24119,1 24161,0 24250,1 24258,0 24265,1 24290,0 24390,1 24454,0 24464,1 24521,0 24548,1 24638,0 24675,1 24702,0 24728,1 24763,0 24766,1 24771,0 24806,1 24894,0 24931,1 24963,0 25039,1 25076,0 25156,1 25194,0 25260,1 25290,0 25387,1 25397,0 25441,1 25476,0 25534,1 25592,0 25642,1 25740,0 25786,1 25862,0 25885,1 25934,0 26013,1 26021,0 26089,1 26176,0 26182,1 26229,0 26272,1 26274,0 26353,1 26393,0 26493,1 26552,0 26590,1 26671,0 26739,1 26781,0 26861,1 26894,0 26968,1 27035,0 27056,1 27100,0 27195,1 27240,0 27329,1 27337,0 27398,1 27446,0 27474,1 27492,0 27572,1 27580,0 27676,1 27680,0 27734,1 27829,0 27893,1 27965,0 28012,1 28096,0 28189,1 28217,0 28294,1 28310,0 28367,1 28457,0 28554,1 28588,0 28641,1 28699,0 28771,1 28843,0 28925,1 28962,0 28968,1 29033,0 29088,1 29156,0 29173,1 29272,0 29333,1 29422,0 29442,1 29514,0 29570,1 29613,0 29683,1 29715,0 29772,1 29815,0 29912,1 29929,0 29998,1 30024,0 30107,1 30118,0 30168,1 30186,0 30282,1 30350,0 30368,1 30420,0 30473,1 30538,0 30607,1 30654,0 30689,1 30757,0 30778,1 30832,0 30897,1 30981,0 31009,1 31054,0 31088,1 31107,0 31163,1 31176,0 31239,1 31268,0 31284,1 31375,0 31419,1 31466,0 31523,1 31589,0 31632,1 31724,0 31773,1 31805,0 31812,1 31873,0 31970,1 31985,0 32057,1 32105,0 32132,1 32192,0 32219,1 32255,0 32266,1 32308,0 32387,1 32464,0 32543,1 32597,0 32651,1 32660,0 32699,1 32722,0 32752,1 32831,0 32871,1 32881,0 32944,1 32999,0 33048,1 33113,0 33165,1 33232,0 33267,1 33274,0 33344,1 33427,0 33485,1 33585,0 33646,1 33649,0 33673,1 33723,0 33811,1 33893,0 33930,1 33973,0 33994,1 34034,0 34127,1 34191,0 34238,1 34244,0 34306,1 34339,0 34421,1 34468,0 34529,1 34607,0 34691,1 34737,0 34778,1 34796,0 34834,1 34929,0 34936,1 34966,0 34989,1 35051,0 35076,1 35123,0 35198,1 35274,0 35304,1 35316,0 35399,1 35450,0 35456,1 35518,0 35544,1 35560,0 35629,1 35634,0 35665,1 35695,0 35749,1 35794,0 35865,1 35953,0 35998,1 36056,0 36124,1 36138,0 36225,1 36324,0 36418,1 36467,0 36470,1 36526,0 36591,1 36641,0 36725,1 36823,0 36918,1 36920,0 36973,1 36979,0 36989,1 37014,0 37042,1 37057,0 37135,1 37160,0 37244,1 37304,0 37402,1 37486,0 37573,1 37574,0 37671,1 37706,0 37786,1 37836,0 37929,1 37988,0 38080,1 38121,0 38124,1 38126,0 38135,1 38199,0 38232,1 38308,0 38353,1 38391,0 38451,1 38456,0 38545,1 38613,0 38614,1 38620,0 38629,1 38658,0 38672,1 38677,0 38752,1 38824,0 38883,1 38899,0 38933,1 38974,0 39041,1 39131,0 39223,1 39242,0 39323,1 39417,0 39511,1 39545,0 39574,1 39663,0 39690,1 39756,0 39798,1 39872,0 39877,1 39908,0 39973,1 40022,0 40043,1 40073,0 40170,1 40184,0 40225,1 40324,0 40328,1 40382,0 40477,1 40491,0 40578,1 40636,0 40697,1 40767,0 40815,1 40894,0 40948,1 41026,0 41062,1 41154,0 41250,1 41343,0 41354,1 41444,0 41474,1 41492,0 41528,1 41530,0 41602,1 41680,0 41754,1 41815,0 41860,1 41870,0 41918,1 41964,0 42038,1 42076,0 42150,1 42172,0 42262,1 42267,0 42361,1 42459,0 42541,1 42618,0 42674,1 42695,0 42719,1 42760,0 42777,1 42808,0 42882,1 42931,0 42946,1 43038,0 43106,1 43189,0 43191,1 43213,0 43294,1 43363,0 43373,1 43376,0 43415,1 43431,0 43521,1 43585,0 43675,1 43736,0 43836,1 43933,0 43975,1 44060,0 44153,1 44180,0 44241,1 44312,0 44363,1 44415,0 44486,1 44524,0 44552,1 44628,0 44670,1 44679,0 44770,1 44836,0 44914,1 45009,0 45010,1 45097,0 45172,1 45228,0 45286,1 45306,0 45356,1 45364,0 45409,1 45449,0 45506,1 45594,0 45634,1 45681,0 45731,1 45757,0 45764,1 45790,0 45864,1 45933,0 45999,1 46067,0 46102,1 46201,0 46250,1 46308,0 46404,1 46438,0 46526,1 46556,0 46584,1 46662,0 46716,1 46792,0 46871,1 46893,0 46931,1 46960,0 47005,1 47090,0 47091,1 47117,0 47203,1 47269,0 47315,1 47367,0 47430,1 47451,0 47503,1 47523,0 47540,1 47633,0 47670,1 47696,0 47763,1 47854,0 47921,1 48013,0 48021,1 48117,0 48193,1 48217,0 48284,1 48347,0 48399,1 48439,0 48477,1 48549,0 48649,1 48747,0 48805,1 48832,0 48842,1 48928,0 48991,1 49000,0 49005,1 49102,0 49157,1 49255,0 49330,1 49400,0 49479,1 49509,0 49583,1 49636,0 49651,1 49688,0 49750,1 49839,0 49840,1 49887,0 49909,1 49973,0 49996,1 50055,0 50073,1 50078,0 50127,1 50142,0 50227,1 50281,0 50292,1 50350,0 50418,1 50471,0 50564,1 50634,0 50699,1 50747,0 50803,1 50808,0 50872,1 50919,0 50968,1 51059,0 51086,1 51106,0 51189,1 51270,0 51360,1 51374,0 51450,1 51513,0 51589,1 end initlist a30 0,0 24,1 119,0 143,1 229,0 299,1 351,0 425,1 433,0 513,1 553,0 619,1 638,0 681,1 691,0 707,1 800,0 891,1 907,0 939,1 944,0 975,1 979,0 1018,1 1110,0 1137,1 1167,0 1202,1 1221,0 1250,1 1270,0 1275,1 1287,0 1368,1 1459,0 1553,1 1601,0 1673,1 1699,0 1786,1 1793,0 1845,1 1918,0 1968,1 1998,0 2093,1 2100,0 2141,1 2154,0 2216,1 2252,0 2257,1 2281,0 2369,1 2391,0 2408,1 2430,0 2483,1 2537,0 2607,1 2669,0 2754,1 2819,0 2879,1 2953,0 3049,1 3116,0 3121,1 3124,0 3170,1 3201,0 3228,1 3242,0 3301,1 3332,0 3346,1 3444,0 3521,1 3547,0 3634,1 3708,0 3739,1 3761,0 3767,1 3836,0 3924,1 3995,0 4032,1 4101,0 4107,1 4117,0 4213,1 4276,0 4283,1 4310,0 4400,1 4484,0 4546,1 4558,0 4631,1 4713,0 4764,1 4827,0 4849,1 4942,0 4997,1 5077,0 5171,1 5200,0 5209,1 5277,0 5375,1 5376,0 5453,1 5468,0 5540,1 5617,0 5709,1 5744,0 5824,1 5852,0 5897,1 5913,0 5995,1 6076,0 6090,1 6188,0 6248,1 6297,0 6371,1 6400,0 6478,1 6551,0 6640,1 6693,0 6788,1 6886,0 6895,1 6991,0 7025,1 7064,0 7113,1 7181,0 7254,1 7335,0 7355,1 7393,0 7412,1 7491,0 7562,1 7572,0 7620,1 7645,0 7658,1 7742,0 7806,1 7835,0 7875,1 7892,0 7979,1 8012,0 8092,1 8157,0 8245,1 8263,0 8350,1 8430,0 8526,1 8527,0 8607,1 8691,0 8777,1 8817,0 8823,1 8909,0 8985,1 9013,0 9061,1 9077,0 9122,1 9220,0 9234,1 9264,0 9293,1 9388,0 9411,1 9460,0 9550,1 9560,0 9656,1 9745,0 9796,1 9823,0 9871,1 9906,0 9909,1 9927,0 10009,1 10035,0 10095,1 10133,0 10217,1 10236,0 10308,1 10346,0 10358,1 10423,0 10444,1 10519,0 10611,1 10635,0 10696,1 10772,0 10823,1 10903,0 10923,1 10932,0 10996,1 11016,0 11079,1 11080,0 11096,1 11195,0 11236,1 11319,0 11331,1 11332,0 11366,1 11373,0 11436,1 11480,0 11536,1 11559,0 11653,1 11686,0 11743,1 11765,0 11779,1 11780,0 11802,1 11858,0 11861,1 11960,0 12053,1 12151,0 12221,1 12244,0 12301,1 12392,0 12456,1 12485,0 12498,1 12540,0 12601,1 12655,0 12715,1 12765,0 12808,1 12843,0 12940,1 12970,0 12980,1 13055,0 13114,1 13202,0 13234,1 13258,0 13351,1 13413,0 13452,1 13538,0 13567,1 13582,0 13658,1 13740,0 13757,1 13806,0 13864,1 13884,0 13984,1 14065,0 14130,1 14132,0 14197,1 14271,0 14272,1 14301,0 14352,1 14421,0 14506,1 14552,0 14600,1 14688,0 14692,1 14763,0 14782,1 14859,0 14950,1 14962,0 15032,1 15128,0 15197,1 15258,0 15268,1 15364,0 15435,1 15459,0 15531,1 15588,0 15608,1 15676,0 15711,1 15804,0 15865,1 15888,0 15933,1 16009,0 16056,1 16104,0 16108,1 16182,0 16210,1 16298,0 16326,1 16426,0 16448,1 16513,0 16560,1 16638,0 16686,1 16702,0 16740,1 16775,0 16859,1 16896,0 16928,1 16996,0 17081,1 17105,0 17195,1 17275,0 17307,1 17326,0 17351,1 17368,0 17410,1 17440,0 17515,1 17570,0 17647,1 17703,0 17774,1 17824,0 17865,1 17893,0 17951,1 17975,0 17980,1 18036,0 18037,1 18048,0 18055,1 18143,0 18184,1 18229,0 18260,1 18292,0 18376,1 18404,0 18429,1 18460,0 18477,1 18551,0 18624,1 18660,0 18733,1 18744,0 18753,1 18847,0 18855,1 18887,0 18984,1 19015,0 19076,1 19172,0 19215,1 19218,0 19249,1 19337,0 19355,1 19390,0 19477,1 19516,0 19555,1 19604,0 19615,1 19672,0 19724,1 19799,0 19897,1 19934,0 19957,1 20028,0 20078,1 20086,0 20171,1 20182,0 20227,1 20271,0 20360,1 20399,0 20450,1 20534,0 20537,1 20631,0 20682,1 20726,0 20760,1 20789,0 20855,1 20945,0 21021,1 21046,0 21110,1 21161,0 21208,1 21305,0 21391,1 21437,0 21466,1 21491,0 21511,1 21550,0 21609,1 21658,0 21712,1 21766,0 21783,1 21813,0 21910,1 21937,0 21959,1 21997,0 22027,1 22109,0 22189,1 22240,0 22308,1 22402,0 22460,1 22464,0 22518,1 22523,0 22588,1 22655,0 22718,1 22775,0 22799,1 22814,0 22897,1 22940,0 22947,1 23002,0 23066,1 23076,0 23100,1 23169,0 23179,1 23206,0 23303,1 23304,0 23370,1 23465,0 23514,1 23566,0 23609,1 23688,0 23785,1 23815,0 23911,1 23999,0 24040,1 24101,0 24160,1 24220,0 24244,1 24257,0 24356,1 24416,0 24463,1 24508,0 24600,1 24618,0 24639,1 24696,0 24721,1 24812,0 24900,1 24930,0 24963,1 24970,0 25052,1 25071,0 25131,1 25203,0 25275,1 25322,0 25372,1 25379,0 25419,1 25480,0 25526,1 25535,0 25583,1 25599,0 25624,1 25647,0 25678,1 25752,0 25770,1 25814,0 25867,1 25933,0 25963,1 26051,0 26052,1 26054,0 26138,1 26186,0 26200,1 26238,0 26262,1 26362,0 26403,1 26411,0 26431,1 26524,0 26539,1 26590,0 26647,1 26656,0 26701,1 26744,0 26798,1 26820,0 26833,1 26900,0 26930,1 26972,0 27018,1 27086,0 27106,1 27133,0 27190,1 27229,0 27244,1 27246,0 27336,1 27365,0 27415,1 27431,0 27501,1 27504,0 27598,1 27683,0 27699,1 27790,0 27864,1 27876,0 27931,1 28024,0 28064,1 28149,0 28215,1 28270,0 28315,1 28349,0 28350,1 28432,0 28478,1 28495,0 28547,1 28569,0 28590,1 28631,0 28682,1 28736,0 28829,1 28883,0 28910,1 29005,0 29019,1 29098,0 29193,1 29234,0 29249,1 29253,0 29271,1 29310,0 29372,1 29428,0 29484,1 29562,0 29611,1 29696,0 29736,1 29792,0 29815,1 29816,0 29850,1 29897,0 29941,1 29960,0 30021,1 30100,0 30195,1 30273,0 30320,1 30363,0 30462,1 30525,0 30581,1 30617,0 30650,1 30675,0 30730,1 30794,0 30847,1 30880,0 30973,1 31020,0 31085,1 31159,0 31234,1 31276,0 31341,1 31437,0 31530,1 31558,0 31579,1 31624,0 31672,1 31772,0 31784,1 31810,0 31827,1 31888,0 31940,1 31988,0 32082,1 32179,0 32237,1 32327,0 32421,1 32519,0 32535,1 32571,0 32630,1 32709,0 32730,1 32828,0 32860,1 32948,0 33037,1 33067,0 33136,1 33190,0 33225,1 33314,0 33353,1 33362,0 33450,1 33480,0 33501,1 33516,0 33528,1 33555,0 33613,1 33642,0 33738,1 33758,0 33803,1 33856,0 33881,1 33898,0 33920,1 34011,0 34073,1 34130,0 34190,1 34265,0 34279,1 34352,0 34399,1 34400,0 34461,1 34551,0 34619,1 34705,0 34759,1 34817,0 34839,1 34907,0 34938,1 34979,0 35000,1 35088,0 35141,1 35175,0 35258,1 35260,0 35278,1 35346,0 35445,1 35520,0 35589,1 35656,0 35694,1 35788,0 35871,1 35875,0 35896,1 35909,0 35980,1 35997,0 36083,1 36135,0 36219,1 36268,0 36326,1 36359,0 36394,1 36408,0 36457,1 36522,0 36607,1 36630,0 36667,1 36734,0 36834,1 36889,0 36960,1 37034,0 37107,1 37205,0 37293,1 37302,0 37385,1 37468,0 37503,1 37594,0 37669,1 37711,0 37777,1 37782,0 37790,1 37794,0 37819,1 37842,0 37936,1 37998,0 38029,1 38036,0 38046,1 38128,0 38196,1 38261,0 38317,1 38340,0 38366,1 38441,0 38444,1 38532,0 38542,1 38638,0 38727,1 38814,0 38861,1 38903,0 38961,1 39008,0 39050,1 39110,0 39206,1 39210,0 39296,1 39302,0 39388,1 39474,0 39568,1 39652,0 39738,1 39748,0 39782,1 39855,0 39892,1 39930,0 39965,1 39993,0 40073,1 40164,0 40200,1 40290,0 40351,1 40419,0 40497,1 40541,0 40601,1 40691,0 40706,1 40725,0 40791,1 40853,0 40935,1 41025,0 41095,1 41185,0 41229,1 41311,0 41362,1 41402,0 41475,1 41567,0 41602,1 41665,0 41760,1 41822,0 41853,1 41914,0 41944,1 41995,0 42049,1 42136,0 42191,1 42204,0 42300,1 42335,0 42363,1 42422,0 42490,1 42563,0 42594,1 42667,0 42677,1 42747,0 42846,1 42903,0 42909,1 43003,0 43032,1 43130,0 43133,1 43200,0 43232,1 43296,0 43384,1 43473,0 43517,1 43548,0 43639,1 43659,0 43716,1 43812,0 43899,1 43946,0 43976,1 44063,0 44149,1 44206,0 44238,1 44313,0 44410,1 44422,0 44486,1 44501,0 44593,1 44630,0 44633,1 44645,0 44693,1 44708,0 44712,1 44792,0 44829,1 44889,0 44928,1 45012,0 45064,1 45117,0 45127,1 45220,0 45287,1 45362,0 45456,1 45517,0 45542,1 45592,0 45605,1 45620,0 45701,1 45778,0 45801,1 45811,0 45883,1 45888,0 45912,1 45942,0 45982,1 46053,0 46135,1 46186,0 46219,1 46319,0 46330,1 46428,0 46449,1 46477,0 46482,1 46572,0 46625,1 46691,0 46711,1 46805,0 46821,1 46841,0 46871,1 46910,0 47006,1 47054,0 47134,1 47158,0 47249,1 47261,0 47266,1 47323,0 47407,1 47472,0 47488,1 47524,0 47577,1 47582,0 47613,1 47691,0 47774,1 47842,0 47909,1 47933,0 47976,1 48067,0 48074,1 48155,0 48245,1 48267,0 48329,1 48395,0 48491,1 48518,0 48568,1 48590,0 48609,1 48706,0 48780,1 48804,0 48868,1 48935,0 48985,1 49018,0 49068,1 49089,0 49165,1 49218,0 49226,1 49244,0 49296,1 49352,0 49353,1 49420,0 49434,1 49440,0 49525,1 49556,0 49597,1 49607,0 49668,1 49753,0 49812,1 49834,0 49884,1 49930,0 49936,1 50030,0 50072,1 50122,0 50141,1 50155,0 50175,1 50196,0 50263,1 50282,0 50337,1 50431,0 50477,1 end initlist a31 0,0 29,1 114,0 137,1 199,0 260,1 270,0 279,1 344,0 368,1 443,0 456,1 509,0 513,1 596,0 660,1 668,0 697,1 726,0 824,1 864,0 929,1 977,0 1030,1 1092,0 1187,1 1271,0 1285,1 1353,0 1426,1 1450,0 1543,1 1576,0 1654,1 1705,0 1785,1 1870,0 1875,1 1962,0 2004,1 2005,0 2063,1 2137,0 2193,1 2201,0 2262,1 2343,0 2380,1 2404,0 2426,1 2433,0 2458,1 2545,0 2639,1 2721,0 2817,1 2904,0 2917,1 2993,0 3093,1 3181,0 3207,1 3288,0 3363,1 3372,0 3450,1 3514,0 3605,1 3649,0 3724,1 3769,0 3865,1 3931,0 3966,1 3989,0 4077,1 4104,0 4178,1 4259,0 4327,1 4376,0 4475,1 4509,0 4544,1 4577,0 4638,1 4684,0 4764,1 4816,0 4833,1 4931,0 4952,1 4963,0 5012,1 5057,0 5088,1 5175,0 5254,1 5294,0 5307,1 5337,0 5377,1 5383,0 5457,1 5464,0 5561,1 5595,0 5634,1 5697,0 5739,1 5801,0 5868,1 5940,0 5990,1 6065,0 6165,1 6223,0 6239,1 6254,0 6279,1 6283,0 6332,1 6408,0 6441,1 6499,0 6509,1 6606,0 6639,1 6688,0 6753,1 6782,0 6833,1 6924,0 6996,1 7022,0 7026,1 7046,0 7082,1 7132,0 7151,1 7209,0 7305,1 7317,0 7358,1 7369,0 7443,1 7536,0 7592,1 7615,0 7701,1 7731,0 7733,1 7741,0 7786,1 7790,0 7840,1 7907,0 8001,1 8093,0 8100,1 8142,0 8179,1 8245,0 8321,1 8401,0 8434,1 8444,0 8490,1 8532,0 8597,1 8624,0 8667,1 8686,0 8701,1 8755,0 8757,1 8760,0 8790,1 8814,0 8864,1 8913,0 8969,1 8976,0 8983,1 9046,0 9119,1 9155,0 9208,1 9251,0 9274,1 9323,0 9398,1 9428,0 9471,1 9498,0 9514,1 9542,0 9622,1 9699,0 9762,1 9800,0 9841,1 9847,0 9876,1 9965,0 10031,1 10093,0 10142,1 10204,0 10273,1 10351,0 10440,1 10485,0 10492,1 10502,0 10554,1 10584,0 10655,1 10740,0 10746,1 10844,0 10868,1 10944,0 10951,1 10964,0 10994,1 11046,0 11121,1 11203,0 11234,1 11254,0 11284,1 11322,0 11351,1 11451,0 11501,1 11538,0 11562,1 11618,0 11632,1 11673,0 11678,1 11729,0 11767,1 11783,0 11814,1 11874,0 11879,1 11922,0 11959,1 12030,0 12071,1 12129,0 12144,1 12219,0 12276,1 12373,0 12417,1 12502,0 12526,1 12583,0 12638,1 12644,0 12671,1 12754,0 12783,1 12848,0 12911,1 12943,0 12956,1 13040,0 13129,1 13185,0 13258,1 13312,0 13335,1 13364,0 13461,1 13464,0 13508,1 13546,0 13553,1 13626,0 13676,1 13747,0 13773,1 13858,0 13863,1 13907,0 13958,1 14037,0 14060,1 14122,0 14143,1 14225,0 14285,1 14287,0 14311,1 14403,0 14483,1 14531,0 14572,1 14655,0 14755,1 14787,0 14799,1 14845,0 14923,1 14979,0 14981,1 15078,0 15137,1 15195,0 15287,1 15318,0 15364,1 15432,0 15471,1 15476,0 15549,1 15607,0 15615,1 15624,0 15635,1 15677,0 15744,1 15761,0 15827,1 15830,0 15836,1 15921,0 15947,1 15996,0 16044,1 16073,0 16154,1 16247,0 16290,1 16294,0 16392,1 16463,0 16532,1 16617,0 16688,1 16767,0 16769,1 16818,0 16852,1 16881,0 16954,1 17002,0 17066,1 17125,0 17176,1 17232,0 17262,1 17343,0 17373,1 17417,0 17461,1 17466,0 17486,1 17540,0 17574,1 17672,0 17714,1 17776,0 17862,1 17938,0 18015,1 18092,0 18129,1 18165,0 18191,1 18258,0 18354,1 18372,0 18393,1 18447,0 18487,1 18499,0 18574,1 18660,0 18725,1 18817,0 18856,1 18858,0 18875,1 18909,0 18910,1 18961,0 19040,1 19113,0 19196,1 19293,0 19325,1 19384,0 19441,1 19447,0 19540,1 19547,0 19554,1 19641,0 19653,1 19681,0 19722,1 19786,0 19813,1 19867,0 19949,1 20003,0 20068,1 20141,0 20207,1 20227,0 20293,1 20318,0 20325,1 20418,0 20441,1 20454,0 20492,1 20552,0 20637,1 20733,0 20756,1 20855,0 20915,1 20929,0 21028,1 21081,0 21144,1 21219,0 21258,1 21270,0 21323,1 21382,0 21412,1 21498,0 21563,1 21591,0 21676,1 21725,0 21813,1 21869,0 21957,1 21992,0 22055,1 22136,0 22219,1 22231,0 22244,1 22249,0 22343,1 22401,0 22440,1 22512,0 22602,1 22619,0 22705,1 22776,0 22783,1 22843,0 22924,1 23010,0 23014,1 23028,0 23082,1 23123,0 23146,1 23225,0 23283,1 23355,0 23368,1 23408,0 23499,1 23576,0 23579,1 23674,0 23732,1 23787,0 23798,1 23817,0 23898,1 23943,0 23966,1 23987,0 24029,1 24064,0 24156,1 24236,0 24285,1 24384,0 24389,1 24481,0 24526,1 24537,0 24541,1 24595,0 24673,1 24716,0 24725,1 24820,0 24920,1 24921,0 24922,1 25022,0 25069,1 25137,0 25139,1 25151,0 25201,1 25274,0 25308,1 25313,0 25365,1 25383,0 25468,1 25553,0 25614,1 25697,0 25699,1 25781,0 25875,1 25915,0 25993,1 26078,0 26135,1 26143,0 26189,1 26237,0 26298,1 26384,0 26413,1 26434,0 26465,1 26502,0 26592,1 26625,0 26638,1 26664,0 26726,1 26778,0 26807,1 26833,0 26922,1 26932,0 26933,1 26947,0 26980,1 26989,0 26994,1 27050,0 27135,1 27220,0 27269,1 27324,0 27346,1 27408,0 27454,1 27503,0 27514,1 27523,0 27581,1 27618,0 27674,1 27720,0 27820,1 27823,0 27867,1 27965,0 28060,1 28076,0 28083,1 28109,0 28157,1 28216,0 28278,1 28336,0 28385,1 28402,0 28404,1 28497,0 28583,1 28596,0 28597,1 28611,0 28697,1 28746,0 28776,1 28830,0 28921,1 28928,0 28930,1 28965,0 28971,1 29012,0 29029,1 29111,0 29143,1 29187,0 29238,1 29266,0 29287,1 29367,0 29392,1 29403,0 29415,1 29438,0 29485,1 29537,0 29625,1 29675,0 29752,1 29829,0 29830,1 29884,0 29913,1 29980,0 29995,1 30018,0 30067,1 30155,0 30245,1 30308,0 30342,1 30419,0 30439,1 30489,0 30498,1 30514,0 30560,1 30579,0 30655,1 30754,0 30831,1 30928,0 31014,1 31072,0 31106,1 31192,0 31264,1 31350,0 31429,1 31471,0 31536,1 31537,0 31543,1 31588,0 31649,1 31656,0 31734,1 31748,0 31825,1 31899,0 31921,1 31982,0 31989,1 32045,0 32048,1 32135,0 32184,1 32212,0 32304,1 32321,0 32337,1 32345,0 32402,1 32460,0 32473,1 32500,0 32511,1 32524,0 32556,1 32579,0 32652,1 32715,0 32760,1 32811,0 32830,1 32923,0 32942,1 33029,0 33098,1 33152,0 33175,1 33233,0 33280,1 33368,0 33375,1 33439,0 33537,1 33550,0 33575,1 33611,0 33642,1 33691,0 33785,1 33883,0 33961,1 34045,0 34109,1 34122,0 34195,1 34286,0 34365,1 34448,0 34459,1 34532,0 34552,1 34605,0 34606,1 34619,0 34668,1 34706,0 34755,1 34773,0 34781,1 34855,0 34865,1 34872,0 34876,1 34880,0 34923,1 34951,0 35029,1 35128,0 35160,1 35220,0 35275,1 35362,0 35363,1 35420,0 35475,1 35574,0 35621,1 35659,0 35687,1 35689,0 35737,1 35780,0 35831,1 35893,0 35964,1 36013,0 36045,1 36142,0 36240,1 36241,0 36279,1 36345,0 36427,1 36527,0 36598,1 36623,0 36701,1 36767,0 36850,1 36907,0 36927,1 36948,0 36957,1 37002,0 37026,1 37030,0 37125,1 37221,0 37310,1 37362,0 37377,1 37474,0 37527,1 37619,0 37711,1 37715,0 37721,1 37817,0 37883,1 37887,0 37937,1 38005,0 38016,1 38023,0 38123,1 38204,0 38304,1 38393,0 38444,1 38484,0 38548,1 38577,0 38612,1 38649,0 38720,1 38800,0 38882,1 38967,0 39042,1 39056,0 39096,1 39135,0 39207,1 39212,0 39245,1 39335,0 39337,1 39437,0 39502,1 39566,0 39643,1 39675,0 39748,1 39791,0 39886,1 39969,0 40014,1 40026,0 40071,1 40102,0 40174,1 40241,0 40248,1 40284,0 40325,1 40362,0 40408,1 40477,0 40487,1 40526,0 40582,1 40597,0 40644,1 40726,0 40784,1 40810,0 40845,1 40924,0 40992,1 41039,0 41042,1 41089,0 41186,1 41272,0 41302,1 41376,0 41416,1 41502,0 41522,1 41606,0 41659,1 41721,0 41792,1 41837,0 41845,1 41941,0 41989,1 42068,0 42084,1 42178,0 42197,1 42225,0 42238,1 42244,0 42250,1 42348,0 42447,1 42489,0 42558,1 42623,0 42717,1 42808,0 42818,1 42855,0 42920,1 42959,0 43045,1 43070,0 43139,1 43194,0 43265,1 43273,0 43302,1 43356,0 43363,1 43386,0 43403,1 43444,0 43532,1 43572,0 43644,1 43677,0 43717,1 43765,0 43847,1 43852,0 43922,1 43949,0 44038,1 44077,0 44087,1 44111,0 44117,1 44162,0 44199,1 44239,0 44240,1 44274,0 44369,1 44426,0 44520,1 44561,0 44661,1 44730,0 44816,1 44888,0 44961,1 44966,0 44983,1 45079,0 45178,1 45193,0 45229,1 45275,0 45351,1 45383,0 45444,1 45492,0 45576,1 45587,0 45591,1 45593,0 45620,1 45693,0 45719,1 45724,0 45772,1 45807,0 45811,1 45836,0 45862,1 45891,0 45904,1 45920,0 45941,1 46030,0 46056,1 46144,0 46199,1 46254,0 46257,1 46350,0 46413,1 46419,0 46465,1 46486,0 46498,1 46519,0 46534,1 46613,0 46690,1 46697,0 46765,1 46787,0 46868,1 46936,0 46996,1 47002,0 47061,1 47104,0 47119,1 47202,0 47288,1 47372,0 47404,1 47405,0 47420,1 47476,0 47494,1 47535,0 47624,1 47667,0 47759,1 47798,0 47848,1 47872,0 47897,1 47909,0 47963,1 47987,0 48018,1 48084,0 48170,1 48255,0 48294,1 48356,0 48409,1 48469,0 48519,1 48601,0 48606,1 48635,0 48652,1 end initlist a32 0,0 35,1 100,0 167,1 240,0 280,1 308,0 363,1 453,0 537,1 609,0 689,1 718,0 740,1 769,0 833,1 933,0 972,1 982,0 1035,1 1119,0 1127,1 1170,0 1239,1 1282,0 1333,1 1384,0 1458,1 1502,0 1569,1 1659,0 1677,1 1764,0 1848,1 1935,0 1954,1 1956,0 2056,1 2113,0 2186,1 2215,0 2284,1 2354,0 2452,1 2489,0 2562,1 2629,0 2645,1 2669,0 2756,1 2758,0 2802,1 2848,0 2921,1 2997,0 3053,1 3082,0 3104,1 3135,0 3186,1 3220,0 3310,1 3381,0 3434,1 3525,0 3572,1 3654,0 3656,1 3697,0 3705,1 3794,0 3797,1 3894,0 3916,1 3991,0 4013,1 4064,0 4121,1 4123,0 4157,1 4192,0 4241,1 4271,0 4316,1 4325,0 4343,1 4435,0 4511,1 4587,0 4675,1 4681,0 4694,1 4701,0 4720,1 4736,0 4782,1 4817,0 4891,1 4947,0 4954,1 4959,0 4972,1 5000,0 5020,1 5065,0 5124,1 5194,0 5282,1 5382,0 5415,1 5431,0 5471,1 5498,0 5583,1 5636,0 5644,1 5698,0 5739,1 5805,0 5842,1 5856,0 5917,1 5989,0 6082,1 6143,0 6243,1 6248,0 6342,1 6388,0 6485,1 6585,0 6676,1 6698,0 6699,1 6766,0 6824,1 6874,0 6966,1 6999,0 7045,1 7119,0 7152,1 7211,0 7309,1 7359,0 7381,1 7412,0 7441,1 7469,0 7488,1 7496,0 7504,1 7505,0 7507,1 7520,0 7602,1 7645,0 7687,1 7787,0 7861,1 7890,0 7944,1 8022,0 8108,1 8184,0 8195,1 8254,0 8312,1 8360,0 8432,1 8487,0 8501,1 8537,0 8551,1 8641,0 8652,1 8678,0 8735,1 8819,0 8820,1 8890,0 8970,1 9015,0 9102,1 9117,0 9142,1 9173,0 9216,1 9260,0 9355,1 9416,0 9419,1 9450,0 9485,1 9546,0 9600,1 9634,0 9658,1 9683,0 9703,1 9799,0 9820,1 9912,0 9931,1 9954,0 9982,1 10051,0 10145,1 10241,0 10261,1 10269,0 10287,1 10336,0 10390,1 10464,0 10466,1 10566,0 10585,1 10634,0 10680,1 10699,0 10777,1 10805,0 10893,1 10993,0 11005,1 11050,0 11058,1 11154,0 11198,1 11257,0 11279,1 11294,0 11300,1 11336,0 11417,1 11507,0 11573,1 11628,0 11695,1 11769,0 11799,1 11807,0 11892,1 11935,0 11996,1 12027,0 12035,1 12063,0 12097,1 12141,0 12207,1 12277,0 12373,1 12421,0 12449,1 12491,0 12583,1 12595,0 12665,1 12694,0 12744,1 12825,0 12871,1 12949,0 12951,1 12970,0 13063,1 13108,0 13130,1 13192,0 13222,1 13270,0 13275,1 13367,0 13451,1 13483,0 13561,1 13595,0 13601,1 13614,0 13699,1 13751,0 13753,1 13791,0 13807,1 13879,0 13894,1 13966,0 14015,1 14082,0 14088,1 14112,0 14161,1 14238,0 14304,1 14378,0 14473,1 14502,0 14544,1 14561,0 14584,1 14606,0 14655,1 14726,0 14806,1 14886,0 14926,1 14968,0 15015,1 15057,0 15122,1 15163,0 15178,1 15276,0 15340,1 15413,0 15431,1 15531,0 15612,1 15682,0 15765,1 15793,0 15888,1 15926,0 16014,1 16106,0 16156,1 16164,0 16232,1 16306,0 16324,1 16356,0 16443,1 16448,0 16477,1 16487,0 16553,1 16626,0 16679,1 16767,0 16824,1 16908,0 16973,1 17034,0 17109,1 17112,0 17184,1 17195,0 17210,1 17294,0 17340,1 17362,0 17413,1 17507,0 17578,1 17637,0 17718,1 17723,0 17743,1 17837,0 17876,1 17915,0 17990,1 18002,0 18048,1 18092,0 18096,1 18177,0 18199,1 18236,0 18259,1 18337,0 18401,1 18405,0 18440,1 18517,0 18582,1 18597,0 18629,1 18652,0 18700,1 18788,0 18805,1 18876,0 18908,1 18962,0 18967,1 19017,0 19097,1 19159,0 19188,1 19254,0 19330,1 19336,0 19409,1 19485,0 19579,1 19598,0 19695,1 19736,0 19810,1 19860,0 19898,1 19909,0 20004,1 20087,0 20114,1 20123,0 20125,1 20145,0 20164,1 20236,0 20279,1 20289,0 20372,1 20429,0 20497,1 20578,0 20635,1 20659,0 20731,1 20822,0 20909,1 21004,0 21062,1 21127,0 21203,1 21281,0 21380,1 21422,0 21439,1 21510,0 21543,1 21603,0 21665,1 21705,0 21788,1 21858,0 21930,1 21989,0 22020,1 22091,0 22126,1 22173,0 22225,1 22271,0 22326,1 22387,0 22411,1 22483,0 22550,1 22648,0 22667,1 22739,0 22756,1 22778,0 22804,1 22880,0 22909,1 22946,0 22993,1 23003,0 23017,1 23025,0 23094,1 23102,0 23186,1 23213,0 23299,1 23391,0 23469,1 23508,0 23581,1 23677,0 23762,1 23766,0 23811,1 23845,0 23860,1 23891,0 23925,1 23988,0 24006,1 24078,0 24093,1 24181,0 24233,1 24318,0 24387,1 24425,0 24512,1 24521,0 24566,1 24615,0 24684,1 24760,0 24850,1 24910,0 24974,1 25037,0 25076,1 25151,0 25158,1 25162,0 25182,1 25216,0 25229,1 25303,0 25403,1 25428,0 25433,1 25467,0 25540,1 25634,0 25668,1 25759,0 25856,1 25893,0 25954,1 26038,0 26041,1 26140,0 26172,1 26220,0 26270,1 26302,0 26355,1 26414,0 26475,1 26485,0 26530,1 26607,0 26696,1 26734,0 26833,1 26889,0 26945,1 26987,0 27050,1 27146,0 27179,1 27222,0 27239,1 27309,0 27407,1 27465,0 27524,1 27552,0 27620,1 27640,0 27663,1 27682,0 27769,1 27846,0 27882,1 27891,0 27962,1 28048,0 28059,1 28142,0 28184,1 28272,0 28328,1 28345,0 28410,1 28419,0 28487,1 28528,0 28563,1 28593,0 28600,1 28601,0 28628,1 28699,0 28734,1 28748,0 28776,1 28858,0 28919,1 28974,0 29047,1 29137,0 29160,1 29236,0 29271,1 29291,0 29304,1 29344,0 29430,1 29501,0 29521,1 29548,0 29609,1 29641,0 29725,1 29742,0 29771,1 29774,0 29824,1 29845,0 29922,1 29992,0 30075,1 30102,0 30108,1 30128,0 30199,1 30231,0 30320,1 30326,0 30348,1 30387,0 30476,1 30556,0 30654,1 30741,0 30796,1 30872,0 30888,1 30910,0 30946,1 31002,0 31075,1 31127,0 31130,1 31206,0 31250,1 31276,0 31337,1 31360,0 31385,1 31434,0 31465,1 31497,0 31511,1 31599,0 31605,1 31636,0 31691,1 31708,0 31802,1 31892,0 31945,1 31954,0 32022,1 32110,0 32117,1 32148,0 32239,1 32246,0 32272,1 32362,0 32394,1 32450,0 32478,1 32536,0 32576,1 32578,0 32579,1 32624,0 32651,1 32686,0 32767,1 32770,0 32815,1 32909,0 32939,1 33008,0 33097,1 33155,0 33174,1 33269,0 33270,1 33286,0 33378,1 33444,0 33536,1 33584,0 33635,1 33656,0 33752,1 33759,0 33839,1 33840,0 33883,1 33954,0 34048,1 34101,0 34172,1 34268,0 34274,1 34279,0 34359,1 34408,0 34471,1 34503,0 34508,1 34585,0 34653,1 34732,0 34787,1 34868,0 34900,1 34955,0 35041,1 35070,0 35102,1 35159,0 35244,1 35290,0 35302,1 35320,0 35415,1 35487,0 35488,1 35584,0 35676,1 35768,0 35850,1 35909,0 35916,1 35996,0 36076,1 36135,0 36181,1 36268,0 36327,1 36387,0 36478,1 36535,0 36620,1 36643,0 36743,1 36747,0 36782,1 36837,0 36847,1 36900,0 36927,1 37017,0 37048,1 37083,0 37133,1 37171,0 37262,1 37322,0 37382,1 37475,0 37512,1 37610,0 37689,1 37715,0 37782,1 37827,0 37831,1 37857,0 37898,1 37952,0 38025,1 38029,0 38124,1 38127,0 38166,1 38208,0 38275,1 38355,0 38376,1 38423,0 38521,1 38587,0 38618,1 38633,0 38687,1 38776,0 38785,1 38875,0 38935,1 38954,0 38990,1 39070,0 39129,1 39154,0 39156,1 39235,0 39251,1 39308,0 39374,1 39406,0 39477,1 39561,0 39593,1 39636,0 39685,1 39769,0 39859,1 39928,0 39973,1 39996,0 40018,1 40088,0 40094,1 40134,0 40149,1 40196,0 40202,1 40256,0 40348,1 40444,0 40526,1 40624,0 40644,1 40692,0 40723,1 40753,0 40825,1 40902,0 40913,1 40976,0 40992,1 41005,0 41073,1 41087,0 41166,1 41175,0 41200,1 41214,0 41280,1 41322,0 41386,1 41435,0 41466,1 41539,0 41546,1 41584,0 41599,1 41654,0 41659,1 41699,0 41738,1 41793,0 41856,1 41873,0 41878,1 41889,0 41890,1 41911,0 41974,1 41981,0 42079,1 42156,0 42223,1 42238,0 42245,1 42252,0 42261,1 42287,0 42332,1 42391,0 42435,1 42486,0 42518,1 42612,0 42652,1 42660,0 42718,1 42805,0 42863,1 42951,0 43048,1 43061,0 43134,1 43214,0 43314,1 43353,0 43378,1 43444,0 43494,1 43580,0 43651,1 43736,0 43745,1 43808,0 43817,1 43870,0 43926,1 43943,0 44022,1 44087,0 44144,1 44219,0 44225,1 44256,0 44331,1 44406,0 44415,1 44456,0 44551,1 44646,0 44668,1 44745,0 44803,1 44828,0 44877,1 44956,0 44984,1 45073,0 45161,1 45214,0 45284,1 45365,0 45429,1 45529,0 45543,1 45633,0 45709,1 45775,0 45785,1 45792,0 45862,1 45922,0 45945,1 45972,0 45982,1 46068,0 46081,1 46101,0 46153,1 46192,0 46193,1 46245,0 46320,1 46383,0 46404,1 46443,0 46517,1 46532,0 46548,1 46619,0 46659,1 46707,0 46715,1 46747,0 46797,1 46846,0 46920,1 47016,0 47034,1 47071,0 47129,1 47219,0 47238,1 47266,0 47343,1 47364,0 47383,1 47453,0 47495,1 47535,0 47588,1 47668,0 47671,1 47742,0 47780,1 47789,0 47836,1 47839,0 47872,1 47878,0 47921,1 47963,0 48001,1 48047,0 48086,1 48162,0 48183,1 48218,0 48259,1 48280,0 48306,1 48309,0 48342,1 48387,0 48486,1 48541,0 48631,1 48654,0 48719,1 48808,0 48860,1 48934,0 49032,1 49065,0 49111,1 49129,0 49167,1 49198,0 49212,1 49226,0 49302,1 49304,0 49325,1 end initlist a33 0,0 80,1 131,0 224,1 226,0 257,1 277,0 322,1 392,0 432,1 496,0 526,1 624,0 668,1 753,0 840,1 845,0 943,1 1008,0 1077,1 1126,0 1201,1 1245,0 1308,1 1406,0 1480,1 1565,0 1589,1 1651,0 1678,1 1696,0 1703,1 1706,0 1713,1 1775,0 1776,1 1838,0 1842,1 1925,0 2011,1 2083,0 2157,1 2217,0 2301,1 2308,0 2363,1 2406,0 2490,1 2576,0 2600,1 2663,0 2697,1 2714,0 2781,1 2876,0 2879,1 2900,0 2997,1 3024,0 3118,1 3157,0 3212,1 3312,0 3389,1 3419,0 3429,1 3440,0 3446,1 3486,0 3501,1 3505,0 3523,1 3602,0 3607,1 3698,0 3756,1 3768,0 3825,1 3853,0 3933,1 3961,0 3993,1 4029,0 4090,1 4168,0 4209,1 4226,0 4281,1 4363,0 4369,1 4412,0 4504,1 4525,0 4548,1 4610,0 4666,1 4738,0 4751,1 4780,0 4805,1 4867,0 4944,1 5019,0 5045,1 5097,0 5152,1 5189,0 5194,1 5233,0 5265,1 5358,0 5368,1 5453,0 5477,1 5500,0 5536,1 5632,0 5664,1 5726,0 5782,1 5812,0 5878,1 5887,0 5943,1 5962,0 5963,1 6036,0 6135,1 6140,0 6188,1 6205,0 6242,1 6326,0 6406,1 6453,0 6551,1 6648,0 6727,1 6755,0 6777,1 6787,0 6856,1 6863,0 6899,1 6959,0 6972,1 6982,0 7073,1 7156,0 7184,1 7220,0 7297,1 7306,0 7310,1 7406,0 7454,1 7519,0 7616,1 7696,0 7722,1 7798,0 7880,1 7891,0 7966,1 8002,0 8035,1 8102,0 8152,1 8183,0 8204,1 8258,0 8294,1 8332,0 8377,1 8471,0 8516,1 8528,0 8568,1 8617,0 8668,1 8707,0 8758,1 8824,0 8903,1 8944,0 8960,1 9009,0 9017,1 9109,0 9143,1 9156,0 9217,1 9229,0 9262,1 9265,0 9307,1 9336,0 9350,1 9392,0 9429,1 9478,0 9560,1 9636,0 9682,1 9747,0 9761,1 9824,0 9868,1 9892,0 9908,1 9936,0 9976,1 9977,0 10066,1 10080,0 10086,1 10126,0 10136,1 10233,0 10325,1 10403,0 10475,1 10476,0 10488,1 10504,0 10554,1 10591,0 10621,1 10718,0 10789,1 10857,0 10888,1 10933,0 10986,1 11083,0 11151,1 11221,0 11297,1 11374,0 11400,1 11492,0 11530,1 11600,0 11616,1 11642,0 11729,1 11826,0 11869,1 11969,0 12006,1 12046,0 12083,1 12180,0 12208,1 12258,0 12283,1 12382,0 12467,1 12531,0 12603,1 12699,0 12737,1 12827,0 12900,1 12934,0 12991,1 13018,0 13051,1 13079,0 13142,1 13150,0 13192,1 13257,0 13293,1 13390,0 13452,1 13530,0 13622,1 13667,0 13763,1 13777,0 13841,1 13908,0 13916,1 13946,0 13984,1 14022,0 14104,1 14114,0 14130,1 14209,0 14301,1 14332,0 14337,1 14374,0 14469,1 14494,0 14552,1 14570,0 14662,1 14693,0 14777,1 14799,0 14824,1 14844,0 14929,1 14936,0 15035,1 15091,0 15148,1 15216,0 15260,1 15325,0 15349,1 15407,0 15471,1 15551,0 15564,1 15625,0 15707,1 15802,0 15873,1 15878,0 15965,1 16021,0 16108,1 16182,0 16202,1 16297,0 16376,1 16469,0 16534,1 16599,0 16606,1 16662,0 16700,1 16780,0 16835,1 16858,0 16917,1 16939,0 17037,1 17103,0 17122,1 17171,0 17191,1 17201,0 17216,1 17266,0 17305,1 17402,0 17452,1 17509,0 17517,1 17583,0 17594,1 17678,0 17738,1 17772,0 17796,1 17818,0 17908,1 17942,0 17948,1 17996,0 18087,1 18120,0 18191,1 18253,0 18278,1 18339,0 18422,1 18491,0 18509,1 18548,0 18599,1 18671,0 18674,1 18721,0 18818,1 18844,0 18917,1 18950,0 18991,1 19033,0 19118,1 19127,0 19217,1 19298,0 19398,1 19468,0 19550,1 19560,0 19657,1 19732,0 19744,1 19766,0 19821,1 19879,0 19930,1 20009,0 20041,1 20101,0 20174,1 20262,0 20330,1 20377,0 20417,1 20487,0 20581,1 20640,0 20674,1 20694,0 20773,1 20871,0 20943,1 20972,0 21058,1 21070,0 21105,1 21176,0 21250,1 21334,0 21412,1 21483,0 21487,1 21539,0 21579,1 21587,0 21686,1 21740,0 21752,1 21821,0 21907,1 21940,0 22011,1 22094,0 22184,1 22249,0 22345,1 22363,0 22455,1 22478,0 22498,1 22516,0 22580,1 22640,0 22679,1 22725,0 22778,1 22817,0 22909,1 22924,0 22970,1 23045,0 23137,1 23148,0 23236,1 23288,0 23364,1 23377,0 23436,1 23518,0 23594,1 23664,0 23683,1 23772,0 23773,1 23848,0 23937,1 24032,0 24041,1 24092,0 24117,1 24165,0 24254,1 24346,0 24399,1 24432,0 24504,1 24589,0 24645,1 24728,0 24814,1 24827,0 24861,1 24928,0 24982,1 25046,0 25072,1 25095,0 25104,1 25110,0 25133,1 25231,0 25323,1 25352,0 25355,1 25418,0 25439,1 25501,0 25593,1 25661,0 25742,1 25818,0 25896,1 25904,0 25906,1 25922,0 25982,1 26031,0 26106,1 26160,0 26234,1 26291,0 26292,1 26364,0 26438,1 26496,0 26573,1 26602,0 26653,1 26741,0 26797,1 26833,0 26900,1 26901,0 26982,1 27046,0 27144,1 27168,0 27215,1 27276,0 27305,1 27404,0 27490,1 27589,0 27661,1 27761,0 27788,1 27827,0 27833,1 27871,0 27963,1 27976,0 27996,1 28072,0 28130,1 28229,0 28271,1 28312,0 28367,1 28428,0 28482,1 28494,0 28587,1 28612,0 28674,1 28681,0 28734,1 28774,0 28846,1 28941,0 29036,1 29046,0 29056,1 29096,0 29101,1 29135,0 29157,1 29241,0 29272,1 29342,0 29365,1 29431,0 29504,1 29562,0 29635,1 29710,0 29739,1 29800,0 29882,1 29931,0 29976,1 30038,0 30052,1 30128,0 30166,1 30173,0 30270,1 30290,0 30309,1 30324,0 30372,1 30412,0 30494,1 30549,0 30565,1 30650,0 30729,1 30773,0 30807,1 30859,0 30925,1 30944,0 30957,1 31053,0 31114,1 31204,0 31254,1 31286,0 31330,1 31399,0 31492,1 31572,0 31671,1 31692,0 31774,1 31778,0 31817,1 31851,0 31930,1 31964,0 32035,1 32135,0 32163,1 32235,0 32283,1 32370,0 32460,1 32525,0 32557,1 32608,0 32702,1 32780,0 32852,1 32900,0 32994,1 33090,0 33159,1 33182,0 33271,1 33294,0 33331,1 33361,0 33378,1 33414,0 33415,1 33481,0 33557,1 33654,0 33666,1 33695,0 33734,1 33754,0 33827,1 33903,0 33939,1 33964,0 34008,1 34085,0 34128,1 34133,0 34156,1 34231,0 34321,1 34418,0 34483,1 34558,0 34647,1 34716,0 34813,1 34895,0 34972,1 35044,0 35130,1 35154,0 35244,1 35289,0 35328,1 35382,0 35431,1 35455,0 35544,1 35559,0 35580,1 35634,0 35639,1 35674,0 35720,1 35767,0 35798,1 35847,0 35902,1 35970,0 36034,1 36085,0 36110,1 36176,0 36229,1 36324,0 36341,1 36377,0 36397,1 36438,0 36517,1 36566,0 36657,1 36702,0 36798,1 36898,0 36984,1 37060,0 37121,1 37131,0 37143,1 37221,0 37301,1 37327,0 37351,1 37432,0 37460,1 37519,0 37573,1 37634,0 37730,1 37781,0 37849,1 37926,0 37993,1 38045,0 38070,1 38120,0 38138,1 38179,0 38208,1 38258,0 38276,1 38328,0 38377,1 38444,0 38521,1 38597,0 38617,1 38623,0 38639,1 38731,0 38766,1 38782,0 38836,1 38929,0 39010,1 39053,0 39124,1 39154,0 39176,1 39193,0 39234,1 39321,0 39377,1 39407,0 39494,1 39499,0 39576,1 39592,0 39673,1 39680,0 39719,1 39722,0 39778,1 39818,0 39874,1 39957,0 40012,1 40080,0 40123,1 40174,0 40187,1 40253,0 40334,1 40351,0 40407,1 40413,0 40457,1 40515,0 40549,1 40569,0 40631,1 40719,0 40726,1 40811,0 40815,1 40832,0 40866,1 40921,0 40928,1 40966,0 40977,1 40982,0 41028,1 41123,0 41144,1 41197,0 41219,1 41277,0 41278,1 41285,0 41336,1 41398,0 41459,1 41557,0 41653,1 41677,0 41705,1 41795,0 41887,1 41951,0 42019,1 42066,0 42149,1 42217,0 42289,1 42365,0 42409,1 42507,0 42508,1 42601,0 42651,1 42734,0 42825,1 42919,0 42979,1 42990,0 43034,1 43107,0 43110,1 43169,0 43192,1 43285,0 43384,1 43421,0 43424,1 43465,0 43529,1 43563,0 43590,1 43681,0 43688,1 43749,0 43818,1 43828,0 43840,1 43876,0 43911,1 43916,0 43920,1 43957,0 43979,1 44061,0 44140,1 44187,0 44277,1 44334,0 44407,1 44429,0 44463,1 44551,0 44594,1 44595,0 44691,1 44702,0 44713,1 44793,0 44799,1 44899,0 44919,1 44991,0 45055,1 45134,0 45167,1 45248,0 45348,1 45387,0 45427,1 45480,0 45524,1 45549,0 45556,1 45591,0 45657,1 45704,0 45750,1 45818,0 45881,1 45894,0 45914,1 46012,0 46077,1 46160,0 46207,1 46276,0 46292,1 46353,0 46443,1 46508,0 46574,1 46580,0 46601,1 46609,0 46687,1 46707,0 46748,1 46777,0 46822,1 46831,0 46870,1 46933,0 47002,1 47035,0 47133,1 47214,0 47276,1 47369,0 47460,1 47461,0 47556,1 47584,0 47648,1 47680,0 47684,1 47722,0 47771,1 47827,0 47921,1 47991,0 48064,1 48109,0 48176,1 48226,0 48242,1 48298,0 48365,1 48463,0 48517,1 48553,0 48584,1 48655,0 48748,1 48784,0 48829,1 48841,0 48888,1 48974,0 48989,1 48998,0 49088,1 49188,0 49229,1 49326,0 49399,1 49484,0 49530,1 49590,0 49605,1 49677,0 49742,1 49763,0 49853,1 49922,0 49987,1 49997,0 50068,1 50166,0 50212,1 50224,0 50311,1 50383,0 50467,1 50520,0 50610,1 50618,0 50675,1 50695,0 50759,1 50802,0 50860,1 50958,0 51029,1 51085,0 51095,1 51128,0 51158,1 51193,0 51289,1 51299,0 51349,1 51424,0 51482,1 51544,0 51600,1 51649,0 51674,1 end initlist a34 0,0 47,1 48,0 146,1 213,0 232,1 269,0 350,1 403,0 481,1 523,0 588,1 686,0 760,1 857,0 922,1 1018,0 1101,1 1168,0 1215,1 1258,0 1272,1 1297,0 1353,1 1405,0 1481,1 1509,0 1586,1 1645,0 1681,1 1762,0 1790,1 1867,0 1961,1 2013,0 2065,1 2133,0 2192,1 2287,0 2363,1 2425,0 2468,1 2529,0 2554,1 2616,0 2704,1 2752,0 2797,1 2877,0 2932,1 2976,0 3020,1 3051,0 3101,1 3188,0 3280,1 3320,0 3347,1 3378,0 3438,1 3484,0 3567,1 3570,0 3670,1 3699,0 3709,1 3794,0 3806,1 3886,0 3899,1 3903,0 3951,1 3989,0 4018,1 4068,0 4129,1 4151,0 4159,1 4217,0 4317,1 4394,0 4481,1 4537,0 4562,1 4596,0 4599,1 4693,0 4757,1 4804,0 4832,1 4847,0 4922,1 4941,0 5010,1 5051,0 5086,1 5088,0 5119,1 5138,0 5190,1 5251,0 5304,1 5345,0 5387,1 5454,0 5518,1 5590,0 5620,1 5656,0 5749,1 5765,0 5800,1 5876,0 5964,1 6046,0 6093,1 6132,0 6154,1 6181,0 6259,1 6264,0 6295,1 6371,0 6422,1 6515,0 6603,1 6683,0 6733,1 6751,0 6831,1 6901,0 6911,1 7007,0 7032,1 7079,0 7125,1 7143,0 7160,1 7178,0 7213,1 7244,0 7340,1 7389,0 7478,1 7555,0 7590,1 7681,0 7710,1 7724,0 7765,1 7862,0 7920,1 7996,0 8011,1 8063,0 8147,1 8243,0 8329,1 8388,0 8477,1 8483,0 8568,1 8622,0 8694,1 8713,0 8736,1 8807,0 8849,1 8947,0 8995,1 9053,0 9144,1 9173,0 9175,1 9193,0 9201,1 9224,0 9255,1 9333,0 9422,1 9431,0 9514,1 9533,0 9611,1 9699,0 9720,1 9738,0 9774,1 9798,0 9859,1 9864,0 9915,1 9986,0 10030,1 10110,0 10139,1 10235,0 10325,1 10404,0 10484,1 10567,0 10647,1 10741,0 10773,1 10817,0 10867,1 10966,0 11056,1 11076,0 11123,1 11166,0 11259,1 11303,0 11334,1 11396,0 11428,1 11500,0 11528,1 11551,0 11571,1 11669,0 11754,1 11824,0 11843,1 11919,0 11922,1 11932,0 12006,1 12047,0 12062,1 12125,0 12128,1 12199,0 12244,1 12333,0 12354,1 12370,0 12386,1 12470,0 12532,1 12623,0 12719,1 12755,0 12812,1 12859,0 12868,1 12902,0 12995,1 13039,0 13054,1 13070,0 13157,1 13243,0 13245,1 13246,0 13287,1 13370,0 13456,1 13468,0 13547,1 13634,0 13695,1 13713,0 13714,1 13726,0 13762,1 13767,0 13863,1 13892,0 13981,1 14030,0 14063,1 14082,0 14161,1 14195,0 14262,1 14348,0 14368,1 14428,0 14437,1 14531,0 14610,1 14621,0 14720,1 14748,0 14798,1 14822,0 14841,1 14852,0 14879,1 14954,0 14966,1 15049,0 15130,1 15155,0 15173,1 15238,0 15272,1 15285,0 15301,1 15352,0 15450,1 15498,0 15569,1 15603,0 15673,1 15773,0 15819,1 15861,0 15862,1 15949,0 16040,1 16065,0 16097,1 16148,0 16166,1 16178,0 16231,1 16297,0 16338,1 16397,0 16461,1 16479,0 16503,1 16567,0 16636,1 16727,0 16806,1 16831,0 16883,1 16896,0 16956,1 17026,0 17063,1 17147,0 17206,1 17283,0 17359,1 17425,0 17458,1 17534,0 17568,1 17642,0 17682,1 17766,0 17813,1 17816,0 17875,1 17942,0 17980,1 18054,0 18077,1 18111,0 18141,1 18205,0 18286,1 18316,0 18318,1 18326,0 18405,1 18489,0 18533,1 18558,0 18564,1 18611,0 18650,1 18741,0 18821,1 18833,0 18864,1 18961,0 18988,1 19035,0 19112,1 19131,0 19194,1 19249,0 19250,1 19304,0 19379,1 19383,0 19415,1 19500,0 19596,1 19643,0 19651,1 19656,0 19732,1 19735,0 19743,1 19805,0 19897,1 19956,0 19991,1 20086,0 20155,1 20215,0 20263,1 20361,0 20438,1 20459,0 20520,1 20603,0 20633,1 20649,0 20693,1 20768,0 20799,1 20845,0 20894,1 20932,0 20937,1 21004,0 21078,1 21167,0 21265,1 21289,0 21371,1 21404,0 21476,1 21575,0 21609,1 21662,0 21698,1 21748,0 21762,1 21825,0 21857,1 21934,0 21976,1 21987,0 22023,1 22058,0 22153,1 22163,0 22211,1 22305,0 22314,1 22404,0 22424,1 22450,0 22550,1 22609,0 22653,1 22695,0 22702,1 22748,0 22770,1 22847,0 22896,1 22960,0 22990,1 23061,0 23100,1 23186,0 23243,1 23314,0 23363,1 23415,0 23432,1 23444,0 23497,1 23566,0 23622,1 23680,0 23717,1 23775,0 23788,1 23882,0 23940,1 23981,0 24081,1 24145,0 24181,1 24240,0 24326,1 24397,0 24487,1 24579,0 24636,1 24721,0 24755,1 24776,0 24845,1 24913,0 24993,1 25047,0 25127,1 25139,0 25207,1 25228,0 25285,1 25293,0 25328,1 25348,0 25382,1 25408,0 25492,1 25569,0 25615,1 25632,0 25700,1 25702,0 25707,1 25725,0 25738,1 25808,0 25895,1 25917,0 26003,1 26102,0 26195,1 26240,0 26304,1 26327,0 26337,1 26404,0 26433,1 26527,0 26595,1 26662,0 26717,1 26754,0 26767,1 26774,0 26809,1 26880,0 26916,1 26968,0 26985,1 27081,0 27122,1 27155,0 27187,1 27277,0 27327,1 27353,0 27372,1 27382,0 27476,1 27542,0 27617,1 27645,0 27655,1 27683,0 27719,1 27737,0 27791,1 27813,0 27896,1 27946,0 28000,1 28094,0 28113,1 28115,0 28202,1 28252,0 28258,1 28319,0 28411,1 28427,0 28448,1 28455,0 28554,1 28568,0 28574,1 28627,0 28660,1 28704,0 28717,1 28787,0 28789,1 28804,0 28840,1 28871,0 28915,1 28920,0 28976,1 29004,0 29048,1 29130,0 29135,1 29227,0 29303,1 29355,0 29431,1 29444,0 29522,1 29579,0 29607,1 29612,0 29678,1 29711,0 29798,1 29874,0 29951,1 30003,0 30015,1 30055,0 30131,1 30220,0 30235,1 30277,0 30357,1 30412,0 30470,1 30521,0 30548,1 30631,0 30701,1 30749,0 30803,1 30833,0 30883,1 30930,0 31018,1 31072,0 31171,1 31247,0 31281,1 31320,0 31386,1 31446,0 31500,1 31566,0 31613,1 31649,0 31739,1 31767,0 31822,1 31827,0 31885,1 31911,0 31989,1 32027,0 32038,1 32090,0 32113,1 32179,0 32182,1 32281,0 32337,1 32379,0 32449,1 32538,0 32576,1 32669,0 32747,1 32754,0 32844,1 32881,0 32937,1 33032,0 33073,1 33134,0 33196,1 33221,0 33303,1 33309,0 33333,1 33403,0 33501,1 33598,0 33686,1 33749,0 33766,1 33818,0 33830,1 33880,0 33891,1 33926,0 33958,1 33995,0 34013,1 34108,0 34206,1 34254,0 34349,1 34405,0 34459,1 34532,0 34545,1 34629,0 34717,1 34753,0 34788,1 34876,0 34884,1 34888,0 34956,1 35047,0 35054,1 35111,0 35164,1 35249,0 35313,1 35400,0 35418,1 35425,0 35493,1 35529,0 35612,1 35703,0 35752,1 35753,0 35793,1 35868,0 35927,1 35984,0 36036,1 36109,0 36151,1 36249,0 36296,1 36356,0 36416,1 36512,0 36519,1 36614,0 36714,1 36718,0 36813,1 36820,0 36905,1 36923,0 36954,1 37019,0 37090,1 37102,0 37197,1 37247,0 37288,1 37290,0 37371,1 37392,0 37417,1 37515,0 37558,1 37594,0 37605,1 37648,0 37659,1 37720,0 37773,1 37850,0 37863,1 37912,0 37938,1 38002,0 38053,1 38118,0 38161,1 38258,0 38281,1 38371,0 38432,1 38511,0 38512,1 38519,0 38596,1 38666,0 38707,1 38740,0 38836,1 38910,0 38922,1 38933,0 39019,1 39113,0 39204,1 39242,0 39308,1 39398,0 39458,1 39507,0 39563,1 39655,0 39662,1 39728,0 39768,1 39782,0 39838,1 39879,0 39903,1 39979,0 39989,1 40014,0 40053,1 40143,0 40157,1 40238,0 40293,1 40393,0 40410,1 40450,0 40451,1 40491,0 40536,1 40608,0 40630,1 40705,0 40717,1 40727,0 40752,1 40797,0 40863,1 40877,0 40902,1 40972,0 40980,1 41006,0 41045,1 41098,0 41109,1 41182,0 41202,1 41246,0 41324,1 41389,0 41419,1 41435,0 41471,1 41494,0 41502,1 41595,0 41631,1 41729,0 41775,1 41815,0 41902,1 41926,0 41984,1 42056,0 42122,1 42143,0 42152,1 42240,0 42255,1 42339,0 42433,1 42454,0 42460,1 42481,0 42548,1 42602,0 42616,1 42658,0 42744,1 42831,0 42887,1 42952,0 43008,1 43014,0 43057,1 43137,0 43160,1 43197,0 43290,1 43326,0 43359,1 43413,0 43500,1 43570,0 43594,1 43693,0 43717,1 43725,0 43743,1 43766,0 43790,1 43837,0 43917,1 43919,0 44008,1 44074,0 44164,1 44189,0 44216,1 44221,0 44292,1 44383,0 44430,1 44437,0 44467,1 44482,0 44514,1 44610,0 44630,1 44639,0 44720,1 44753,0 44839,1 44898,0 44902,1 44925,0 45000,1 45058,0 45156,1 45252,0 45321,1 45358,0 45359,1 45378,0 45396,1 45448,0 45502,1 45562,0 45623,1 45679,0 45708,1 45718,0 45725,1 45771,0 45860,1 45907,0 45932,1 45946,0 46026,1 46103,0 46141,1 46213,0 46268,1 46269,0 46302,1 46385,0 46393,1 46418,0 46431,1 46483,0 46561,1 46650,0 46727,1 46810,0 46899,1 46920,0 46980,1 47038,0 47121,1 47135,0 47222,1 47319,0 47338,1 47375,0 47402,1 47481,0 47514,1 47554,0 47567,1 47618,0 47650,1 47746,0 47758,1 47771,0 47853,1 47924,0 47933,1 47952,0 48001,1 48021,0 48088,1 48148,0 48172,1 48216,0 48229,1 48252,0 48290,1 48313,0 48407,1 48499,0 48540,1 48631,0 48656,1 48675,0 48692,1 48699,0 48761,1 48850,0 48854,1 48951,0 48962,1 48964,0 48999,1 49077,0 49169,1 49265,0 49310,1 49317,0 49342,1 49386,0 49439,1 49456,0 49522,1 49554,0 49616,1 49636,0 49727,1 49825,0 49904,1 49992,0 50013,1 50088,0 50120,1 end initlist a35 0,0 22,1 115,0 122,1 141,0 160,1 222,0 229,1 328,0 345,1 425,0 490,1 585,0 610,1 652,0 706,1 733,0 753,1 821,0 823,1 914,0 917,1 987,0 1027,1 1063,0 1073,1 1123,0 1189,1 1204,0 1283,1 1329,0 1345,1 1430,0 1455,1 1468,0 1504,1 1543,0 1595,1 1691,0 1744,1 1801,0 1851,1 1891,0 1941,1 2028,0 2047,1 2138,0 2220,1 2266,0 2288,1 2347,0 2426,1 2494,0 2551,1 2553,0 2595,1 2658,0 2701,1 2759,0 2815,1 2833,0 2917,1 2960,0 3038,1 3134,0 3234,1 3288,0 3361,1 3374,0 3473,1 3549,0 3576,1 3639,0 3679,1 3712,0 3727,1 3805,0 3872,1 3934,0 4021,1 4099,0 4164,1 4204,0 4255,1 4352,0 4358,1 4387,0 4402,1 4452,0 4532,1 4538,0 4630,1 4677,0 4761,1 4781,0 4798,1 4894,0 4929,1 4953,0 5019,1 5115,0 5173,1 5233,0 5320,1 5352,0 5441,1 5446,0 5538,1 5555,0 5581,1 5631,0 5665,1 5689,0 5716,1 5748,0 5773,1 5852,0 5932,1 5982,0 6078,1 6085,0 6150,1 6181,0 6218,1 6279,0 6328,1 6392,0 6440,1 6522,0 6602,1 6654,0 6720,1 6722,0 6788,1 6874,0 6939,1 6957,0 6967,1 7007,0 7070,1 7101,0 7162,1 7246,0 7288,1 7360,0 7449,1 7457,0 7504,1 7581,0 7598,1 7628,0 7713,1 7730,0 7814,1 7838,0 7849,1 7912,0 7992,1 8077,0 8163,1 8231,0 8267,1 8287,0 8309,1 8365,0 8451,1 8523,0 8599,1 8614,0 8714,1 8715,0 8734,1 8814,0 8912,1 8940,0 9021,1 9121,0 9169,1 9211,0 9223,1 9319,0 9378,1 9419,0 9482,1 9501,0 9574,1 9649,0 9664,1 9699,0 9767,1 9806,0 9818,1 9917,0 9929,1 10016,0 10035,1 10119,0 10144,1 10201,0 10260,1 10332,0 10430,1 10464,0 10544,1 10576,0 10673,1 10747,0 10768,1 10835,0 10863,1 10937,0 10965,1 11016,0 11017,1 11071,0 11147,1 11184,0 11212,1 11303,0 11343,1 11352,0 11362,1 11416,0 11431,1 11524,0 11616,1 11679,0 11768,1 11772,0 11799,1 11805,0 11809,1 11814,0 11877,1 11955,0 12047,1 12136,0 12158,1 12233,0 12312,1 12365,0 12388,1 12442,0 12533,1 12580,0 12618,1 12646,0 12669,1 12686,0 12762,1 12822,0 12903,1 12919,0 12955,1 12980,0 13038,1 13073,0 13153,1 13229,0 13285,1 13356,0 13440,1 13489,0 13518,1 13540,0 13582,1 13613,0 13692,1 13725,0 13766,1 13829,0 13847,1 13937,0 13980,1 14074,0 14091,1 14133,0 14186,1 14247,0 14265,1 14284,0 14325,1 14414,0 14447,1 14531,0 14627,1 14656,0 14677,1 14681,0 14728,1 14814,0 14879,1 14891,0 14907,1 15007,0 15036,1 15080,0 15135,1 15162,0 15250,1 15280,0 15289,1 15301,0 15348,1 15383,0 15471,1 15474,0 15549,1 15577,0 15583,1 15612,0 15667,1 15684,0 15754,1 15830,0 15926,1 15942,0 15996,1 16085,0 16155,1 16214,0 16266,1 16357,0 16398,1 16419,0 16502,1 16594,0 16668,1 16713,0 16780,1 16853,0 16925,1 16966,0 17054,1 17143,0 17210,1 17242,0 17264,1 17300,0 17385,1 17476,0 17549,1 17641,0 17685,1 17735,0 17793,1 17864,0 17916,1 18016,0 18062,1 18136,0 18137,1 18180,0 18259,1 18343,0 18371,1 18411,0 18470,1 18471,0 18562,1 18638,0 18725,1 18812,0 18885,1 18890,0 18941,1 18978,0 19004,1 19028,0 19116,1 19132,0 19148,1 19237,0 19313,1 19406,0 19459,1 19538,0 19567,1 19632,0 19698,1 19712,0 19756,1 19798,0 19800,1 19855,0 19895,1 19899,0 19961,1 19963,0 19998,1 20085,0 20168,1 20188,0 20225,1 20228,0 20277,1 20296,0 20322,1 20385,0 20397,1 20448,0 20452,1 20525,0 20564,1 20570,0 20639,1 20646,0 20662,1 20663,0 20684,1 20748,0 20798,1 20859,0 20941,1 20953,0 20961,1 21006,0 21093,1 21123,0 21148,1 21208,0 21301,1 21320,0 21361,1 21386,0 21451,1 21528,0 21620,1 21713,0 21725,1 21772,0 21832,1 21926,0 21942,1 22001,0 22100,1 22133,0 22141,1 22239,0 22295,1 22360,0 22380,1 22474,0 22519,1 22613,0 22704,1 22801,0 22861,1 22929,0 22930,1 23004,0 23036,1 23114,0 23212,1 23238,0 23322,1 23391,0 23411,1 23468,0 23559,1 23568,0 23611,1 23669,0 23670,1 23680,0 23708,1 23792,0 23819,1 23840,0 23925,1 23955,0 24023,1 24070,0 24077,1 24170,0 24254,1 24328,0 24422,1 24467,0 24524,1 24587,0 24678,1 24696,0 24791,1 24797,0 24865,1 24884,0 24983,1 24987,0 25059,1 25113,0 25205,1 25246,0 25279,1 25374,0 25385,1 25397,0 25475,1 25488,0 25559,1 25612,0 25655,1 25723,0 25739,1 25765,0 25810,1 25846,0 25903,1 25922,0 25934,1 25990,0 26010,1 26101,0 26156,1 26204,0 26226,1 26246,0 26313,1 26362,0 26370,1 26399,0 26491,1 26572,0 26670,1 26761,0 26810,1 26836,0 26849,1 26886,0 26896,1 26993,0 27071,1 27167,0 27217,1 27259,0 27349,1 27369,0 27453,1 27488,0 27547,1 27630,0 27654,1 27656,0 27702,1 27705,0 27773,1 27802,0 27803,1 27849,0 27908,1 27942,0 27974,1 28020,0 28098,1 28191,0 28257,1 28337,0 28413,1 28479,0 28562,1 28624,0 28701,1 28767,0 28850,1 28929,0 28995,1 29006,0 29088,1 29108,0 29114,1 29201,0 29250,1 29277,0 29323,1 29342,0 29411,1 29473,0 29498,1 29586,0 29595,1 29638,0 29737,1 29752,0 29837,1 29881,0 29933,1 30017,0 30064,1 30120,0 30139,1 30176,0 30275,1 30283,0 30327,1 30373,0 30430,1 30463,0 30519,1 30596,0 30614,1 30700,0 30786,1 30877,0 30962,1 30986,0 31050,1 31060,0 31075,1 31167,0 31173,1 31197,0 31202,1 31282,0 31373,1 31469,0 31532,1 31595,0 31673,1 31772,0 31792,1 31853,0 31931,1 32011,0 32103,1 32193,0 32219,1 32263,0 32325,1 32392,0 32393,1 32491,0 32501,1 32547,0 32643,1 32649,0 32718,1 32768,0 32843,1 32857,0 32925,1 33019,0 33027,1 33058,0 33118,1 33184,0 33242,1 33341,0 33403,1 33491,0 33566,1 33665,0 33738,1 33745,0 33818,1 33862,0 33916,1 33974,0 33996,1 34055,0 34113,1 34127,0 34186,1 34246,0 34310,1 34354,0 34373,1 34464,0 34535,1 34548,0 34640,1 34729,0 34749,1 34820,0 34907,1 34965,0 35021,1 35090,0 35095,1 35100,0 35196,1 35221,0 35266,1 35302,0 35374,1 35395,0 35436,1 35459,0 35498,1 35578,0 35665,1 35720,0 35737,1 35834,0 35854,1 35900,0 35904,1 35912,0 35925,1 36002,0 36066,1 36129,0 36190,1 36249,0 36292,1 36324,0 36395,1 36460,0 36493,1 36593,0 36674,1 36695,0 36737,1 36742,0 36825,1 36911,0 36992,1 37082,0 37156,1 37232,0 37248,1 37265,0 37357,1 37423,0 37428,1 37504,0 37512,1 37570,0 37632,1 37683,0 37767,1 37787,0 37820,1 37869,0 37895,1 37972,0 38008,1 38015,0 38105,1 38132,0 38137,1 38215,0 38251,1 38266,0 38344,1 38411,0 38430,1 38518,0 38587,1 38664,0 38705,1 38798,0 38825,1 38871,0 38905,1 38966,0 39018,1 39026,0 39110,1 39153,0 39228,1 39231,0 39235,1 39331,0 39335,1 39385,0 39404,1 39452,0 39551,1 39580,0 39647,1 39679,0 39689,1 39747,0 39825,1 39919,0 39976,1 40055,0 40091,1 40136,0 40206,1 40248,0 40293,1 40341,0 40426,1 40493,0 40519,1 40556,0 40651,1 40748,0 40841,1 40906,0 40953,1 41026,0 41065,1 41132,0 41168,1 41221,0 41320,1 41394,0 41478,1 41516,0 41543,1 41572,0 41621,1 41673,0 41696,1 41738,0 41812,1 41835,0 41851,1 41886,0 41915,1 41946,0 42011,1 42096,0 42184,1 42244,0 42282,1 42360,0 42378,1 42427,0 42434,1 42523,0 42551,1 42586,0 42615,1 42705,0 42745,1 42751,0 42755,1 42811,0 42873,1 42921,0 42999,1 43061,0 43107,1 43202,0 43252,1 43351,0 43411,1 43441,0 43505,1 43573,0 43670,1 43740,0 43767,1 43774,0 43842,1 43872,0 43895,1 43935,0 43989,1 44008,0 44031,1 44036,0 44084,1 44144,0 44213,1 44217,0 44274,1 44294,0 44362,1 44376,0 44459,1 44496,0 44592,1 44654,0 44751,1 44769,0 44810,1 44816,0 44892,1 44971,0 45033,1 45101,0 45118,1 45139,0 45211,1 45301,0 45350,1 45447,0 45530,1 45630,0 45719,1 45783,0 45829,1 45894,0 45968,1 46020,0 46069,1 46120,0 46191,1 46241,0 46274,1 46349,0 46390,1 46485,0 46574,1 46597,0 46646,1 46709,0 46744,1 46828,0 46867,1 46900,0 46904,1 46905,0 46963,1 47017,0 47061,1 47157,0 47210,1 47286,0 47320,1 47351,0 47375,1 47462,0 47492,1 47555,0 47574,1 47621,0 47713,1 47797,0 47869,1 47878,0 47921,1 47984,0 48015,1 48018,0 48082,1 48117,0 48177,1 48181,0 48241,1 48330,0 48363,1 48421,0 48472,1 48489,0 48525,1 48601,0 48679,1 48701,0 48709,1 48713,0 48714,1 48759,0 48811,1 48902,0 48914,1 48940,0 49010,1 49018,0 49066,1 49068,0 49121,1 49200,0 49224,1 49297,0 49318,1 49385,0 49460,1 49462,0 49551,1 49555,0 49635,1 49725,0 49791,1 49853,0 49931,1 49978,0 50069,1 50141,0 50149,1 50189,0 50193,1 50250,0 50263,1 50323,0 50396,1 50414,0 50507,1 50551,0 50632,1 50713,0 50803,1 50874,0 50943,1 50990,0 51033,1 51072,0 51075,1 51154,0 51225,1 51239,0 51310,1 51400,0 51425,1 51453,0 51459,1 51485,0 51518,1 end initlist a36 0,0 11,1 56,0 66,1 137,0 211,1 260,0 265,1 300,0 330,1 367,0 467,1 482,0 501,1 575,0 629,1 696,0 780,1 799,0 833,1 897,0 978,1 1052,0 1088,1 1113,0 1122,1 1143,0 1200,1 1233,0 1333,1 1395,0 1452,1 1542,0 1623,1 1636,0 1688,1 1726,0 1795,1 1876,0 1946,1 2036,0 2044,1 2072,0 2167,1 2257,0 2308,1 2311,0 2380,1 2438,0 2527,1 2617,0 2678,1 2750,0 2808,1 2889,0 2979,1 3045,0 3132,1 3153,0 3238,1 3307,0 3328,1 3376,0 3399,1 3418,0 3476,1 3482,0 3518,1 3557,0 3652,1 3723,0 3739,1 3767,0 3834,1 3896,0 3936,1 3957,0 3988,1 4026,0 4072,1 4148,0 4219,1 4251,0 4346,1 4347,0 4441,1 4445,0 4495,1 4580,0 4589,1 4629,0 4726,1 4792,0 4804,1 4893,0 4914,1 4957,0 5054,1 5129,0 5182,1 5193,0 5243,1 5330,0 5368,1 5442,0 5492,1 5531,0 5613,1 5688,0 5779,1 5878,0 5931,1 6015,0 6113,1 6203,0 6244,1 6271,0 6279,1 6285,0 6299,1 6356,0 6413,1 6444,0 6464,1 6504,0 6570,1 6581,0 6601,1 6620,0 6673,1 6728,0 6734,1 6775,0 6865,1 6915,0 7010,1 7044,0 7132,1 7137,0 7164,1 7212,0 7260,1 7277,0 7366,1 7424,0 7436,1 7498,0 7505,1 7570,0 7585,1 7594,0 7656,1 7680,0 7753,1 7818,0 7911,1 7932,0 7974,1 8045,0 8084,1 8178,0 8254,1 8299,0 8360,1 8396,0 8455,1 8497,0 8522,1 8596,0 8635,1 8698,0 8767,1 8849,0 8856,1 8904,0 8919,1 8973,0 9070,1 9097,0 9117,1 9145,0 9188,1 9241,0 9309,1 9407,0 9465,1 9506,0 9582,1 9646,0 9674,1 9749,0 9750,1 9850,0 9865,1 9957,0 10031,1 10116,0 10167,1 10187,0 10204,1 10260,0 10354,1 10355,0 10395,1 10470,0 10529,1 10535,0 10632,1 10663,0 10750,1 10836,0 10854,1 10857,0 10864,1 10933,0 11015,1 11045,0 11102,1 11137,0 11138,1 11215,0 11261,1 11295,0 11316,1 11333,0 11417,1 11428,0 11449,1 11498,0 11566,1 11640,0 11704,1 11757,0 11771,1 11842,0 11879,1 11925,0 11961,1 12013,0 12110,1 12186,0 12234,1 12311,0 12394,1 12465,0 12472,1 12510,0 12536,1 12629,0 12726,1 12751,0 12784,1 12808,0 12826,1 12832,0 12902,1 12973,0 13010,1 13015,0 13103,1 13145,0 13154,1 13240,0 13307,1 13318,0 13342,1 13412,0 13474,1 13558,0 13625,1 13629,0 13707,1 13791,0 13794,1 13805,0 13863,1 13917,0 13998,1 14064,0 14123,1 14154,0 14165,1 14211,0 14279,1 14329,0 14401,1 14478,0 14550,1 14557,0 14648,1 14669,0 14754,1 14794,0 14853,1 14897,0 14921,1 14922,0 14962,1 15050,0 15104,1 15164,0 15249,1 15252,0 15306,1 15345,0 15375,1 15446,0 15448,1 15455,0 15534,1 15576,0 15637,1 15664,0 15685,1 15721,0 15761,1 15833,0 15846,1 15879,0 15960,1 16053,0 16126,1 16138,0 16140,1 16223,0 16233,1 16285,0 16351,1 16363,0 16421,1 16477,0 16504,1 16527,0 16563,1 16659,0 16712,1 16760,0 16764,1 16796,0 16825,1 16860,0 16861,1 16879,0 16961,1 16995,0 16999,1 17099,0 17171,1 17179,0 17212,1 17275,0 17361,1 17459,0 17472,1 17505,0 17599,1 17602,0 17673,1 17764,0 17852,1 17887,0 17954,1 18005,0 18097,1 18148,0 18189,1 18273,0 18304,1 18388,0 18401,1 18457,0 18547,1 18598,0 18642,1 18707,0 18718,1 18740,0 18750,1 18819,0 18840,1 18898,0 18985,1 19041,0 19139,1 19148,0 19195,1 19229,0 19245,1 19286,0 19308,1 19390,0 19405,1 19492,0 19528,1 19538,0 19539,1 19634,0 19692,1 19763,0 19854,1 19933,0 19945,1 20044,0 20073,1 20136,0 20158,1 20209,0 20218,1 20314,0 20392,1 20475,0 20559,1 20582,0 20588,1 20624,0 20689,1 20701,0 20787,1 20887,0 20962,1 20964,0 21019,1 21021,0 21089,1 21115,0 21130,1 21225,0 21291,1 21368,0 21468,1 21563,0 21623,1 21638,0 21698,1 21787,0 21876,1 21883,0 21975,1 21977,0 22044,1 22065,0 22156,1 22212,0 22303,1 22392,0 22469,1 22547,0 22619,1 22632,0 22714,1 22798,0 22840,1 22931,0 22988,1 23076,0 23146,1 23157,0 23168,1 23245,0 23338,1 23412,0 23460,1 23514,0 23584,1 23665,0 23753,1 23778,0 23872,1 23967,0 24017,1 24099,0 24121,1 24142,0 24175,1 24251,0 24305,1 24340,0 24399,1 24469,0 24533,1 24563,0 24624,1 24702,0 24775,1 24855,0 24930,1 24941,0 24981,1 25028,0 25114,1 25175,0 25181,1 25241,0 25265,1 25268,0 25358,1 25379,0 25432,1 25477,0 25553,1 25579,0 25617,1 25665,0 25761,1 25852,0 25937,1 26017,0 26027,1 26040,0 26110,1 26167,0 26221,1 26244,0 26303,1 26394,0 26487,1 26555,0 26585,1 26617,0 26656,1 26731,0 26749,1 26778,0 26856,1 26897,0 26957,1 27026,0 27094,1 27137,0 27160,1 27169,0 27244,1 27340,0 27360,1 27398,0 27401,1 27475,0 27499,1 27573,0 27593,1 27644,0 27645,1 27673,0 27733,1 27822,0 27842,1 27899,0 27995,1 28068,0 28083,1 28101,0 28200,1 28250,0 28346,1 28381,0 28429,1 28463,0 28485,1 28498,0 28529,1 28561,0 28606,1 28664,0 28760,1 28843,0 28910,1 28932,0 29006,1 29063,0 29129,1 29146,0 29202,1 29229,0 29241,1 29329,0 29350,1 29449,0 29549,1 29595,0 29692,1 29693,0 29726,1 29787,0 29789,1 29854,0 29926,1 29932,0 29988,1 30039,0 30073,1 30100,0 30177,1 30184,0 30235,1 30321,0 30349,1 30377,0 30388,1 30482,0 30524,1 30552,0 30649,1 30699,0 30747,1 30812,0 30863,1 30927,0 30972,1 30976,0 31002,1 31018,0 31019,1 31083,0 31108,1 31144,0 31192,1 31255,0 31296,1 31300,0 31352,1 31374,0 31429,1 31499,0 31536,1 31633,0 31670,1 31754,0 31776,1 31862,0 31872,1 31895,0 31952,1 32007,0 32069,1 32071,0 32094,1 32102,0 32152,1 32161,0 32196,1 32271,0 32344,1 32409,0 32445,1 32515,0 32552,1 32624,0 32687,1 32771,0 32864,1 32953,0 32985,1 33006,0 33066,1 33103,0 33137,1 33192,0 33280,1 33284,0 33322,1 33397,0 33475,1 33515,0 33574,1 33603,0 33642,1 33669,0 33761,1 33765,0 33813,1 33846,0 33892,1 33908,0 33996,1 34007,0 34096,1 34151,0 34232,1 34294,0 34301,1 34319,0 34399,1 34444,0 34488,1 34525,0 34593,1 34673,0 34674,1 34762,0 34839,1 34928,0 34965,1 35065,0 35100,1 35102,0 35174,1 35192,0 35257,1 35279,0 35324,1 35397,0 35488,1 35520,0 35545,1 35561,0 35590,1 35680,0 35693,1 35791,0 35816,1 35902,0 35920,1 36002,0 36059,1 36062,0 36083,1 36127,0 36202,1 36245,0 36340,1 36369,0 36466,1 36492,0 36553,1 36629,0 36640,1 36710,0 36774,1 36870,0 36927,1 37010,0 37090,1 37184,0 37248,1 37290,0 37362,1 37425,0 37485,1 37561,0 37596,1 37664,0 37746,1 37818,0 37867,1 37868,0 37912,1 37945,0 38030,1 38043,0 38086,1 38151,0 38233,1 38259,0 38345,1 38409,0 38451,1 38460,0 38533,1 38607,0 38637,1 38717,0 38793,1 38825,0 38871,1 38932,0 39021,1 39118,0 39212,1 39218,0 39273,1 39280,0 39318,1 39377,0 39415,1 39481,0 39534,1 39557,0 39618,1 39651,0 39728,1 39757,0 39838,1 39925,0 39937,1 40006,0 40079,1 40133,0 40135,1 40234,0 40251,1 40347,0 40381,1 40417,0 40505,1 40590,0 40614,1 40678,0 40741,1 40752,0 40831,1 40908,0 40968,1 41025,0 41064,1 41126,0 41186,1 41231,0 41286,1 41313,0 41388,1 41467,0 41528,1 41578,0 41664,1 41696,0 41754,1 41789,0 41803,1 41862,0 41952,1 42041,0 42105,1 42140,0 42213,1 42217,0 42289,1 42385,0 42397,1 42438,0 42497,1 42553,0 42604,1 42660,0 42722,1 42811,0 42856,1 42870,0 42927,1 42969,0 43038,1 43109,0 43138,1 43216,0 43265,1 43329,0 43414,1 43505,0 43559,1 43637,0 43698,1 43778,0 43781,1 43813,0 43847,1 43935,0 43947,1 44032,0 44054,1 44091,0 44150,1 44206,0 44276,1 44348,0 44412,1 44417,0 44432,1 44503,0 44508,1 44598,0 44618,1 44625,0 44630,1 44666,0 44750,1 44835,0 44839,1 44935,0 44962,1 45037,0 45133,1 45157,0 45167,1 45220,0 45264,1 45279,0 45304,1 45324,0 45355,1 45400,0 45496,1 45549,0 45643,1 45687,0 45701,1 45773,0 45838,1 45875,0 45959,1 46026,0 46059,1 46131,0 46138,1 46216,0 46242,1 46244,0 46276,1 46293,0 46354,1 46360,0 46434,1 46510,0 46550,1 46568,0 46659,1 46723,0 46791,1 46887,0 46949,1 46990,0 47033,1 47118,0 47177,1 47237,0 47243,1 47323,0 47398,1 47478,0 47569,1 47627,0 47657,1 47744,0 47784,1 47848,0 47859,1 47860,0 47946,1 47971,0 48008,1 48042,0 48074,1 48119,0 48173,1 48272,0 48332,1 48414,0 48443,1 48480,0 48542,1 48636,0 48688,1 48768,0 48792,1 48819,0 48894,1 48904,0 48929,1 48951,0 48975,1 49032,0 49081,1 49123,0 49142,1 49166,0 49192,1 49269,0 49349,1 49398,0 49417,1 49461,0 49496,1 49511,0 49531,1 49626,0 49628,1 49722,0 49728,1 49746,0 49793,1 49826,0 49836,1 49930,0 49950,1 50013,0 50034,1 50102,0 50191,1 50291,0 50343,1 50420,0 50474,1 50539,0 50565,1 50648,0 50731,1 50765,0 50849,1 50911,0 50922,1 51011,0 51033,1 51125,0 51193,1 end initlist a37 0,0 100,1 120,0 188,1 256,0 323,1 351,0 367,1 418,0 446,1 447,0 461,1 498,0 582,1 650,0 699,1 762,0 819,1 897,0 929,1 938,0 961,1 1030,0 1101,1 1184,0 1199,1 1265,0 1283,1 1377,0 1431,1 1503,0 1540,1 1613,0 1650,1 1688,0 1781,1 1794,0 1884,1 1973,0 1994,1 2043,0 2047,1 2064,0 2137,1 2172,0 2261,1 2335,0 2420,1 2517,0 2571,1 2638,0 2657,1 2678,0 2771,1 2783,0 2840,1 2886,0 2914,1 2975,0 3019,1 3062,0 3127,1 3170,0 3187,1 3198,0 3278,1 3365,0 3424,1 3489,0 3569,1 3618,0 3715,1 3758,0 3769,1 3825,0 3855,1 3872,0 3918,1 3942,0 3961,1 3967,0 3978,1 4008,0 4049,1 4094,0 4157,1 4226,0 4261,1 4352,0 4363,1 4391,0 4458,1 4523,0 4570,1 4632,0 4653,1 4700,0 4703,1 4802,0 4849,1 4928,0 5019,1 5061,0 5108,1 5180,0 5224,1 5275,0 5295,1 5342,0 5368,1 5428,0 5467,1 5555,0 5578,1 5619,0 5647,1 5648,0 5709,1 5772,0 5784,1 5815,0 5853,1 5906,0 5913,1 5931,0 5938,1 5999,0 6054,1 6119,0 6177,1 6199,0 6216,1 6256,0 6325,1 6341,0 6380,1 6403,0 6501,1 6514,0 6577,1 6621,0 6698,1 6757,0 6766,1 6801,0 6878,1 6946,0 7007,1 7015,0 7074,1 7110,0 7208,1 7276,0 7347,1 7403,0 7439,1 7451,0 7549,1 7615,0 7666,1 7712,0 7767,1 7796,0 7878,1 7954,0 7971,1 8044,0 8127,1 8210,0 8244,1 8315,0 8389,1 8435,0 8445,1 8447,0 8512,1 8559,0 8652,1 8692,0 8713,1 8745,0 8762,1 8844,0 8926,1 8984,0 9044,1 9054,0 9108,1 9205,0 9252,1 9337,0 9404,1 9478,0 9565,1 9581,0 9624,1 9644,0 9669,1 9737,0 9745,1 9816,0 9835,1 9872,0 9907,1 9991,0 10057,1 10096,0 10132,1 10215,0 10263,1 10276,0 10283,1 10311,0 10321,1 10395,0 10425,1 10502,0 10535,1 10565,0 10632,1 10720,0 10794,1 10828,0 10859,1 10959,0 11021,1 11027,0 11037,1 11110,0 11125,1 11132,0 11134,1 11139,0 11220,1 11292,0 11368,1 11396,0 11400,1 11439,0 11454,1 11470,0 11508,1 11604,0 11684,1 11771,0 11870,1 11874,0 11945,1 11995,0 12025,1 12092,0 12184,1 12269,0 12334,1 12390,0 12458,1 12502,0 12503,1 12544,0 12617,1 12636,0 12681,1 12692,0 12735,1 12786,0 12822,1 12897,0 12916,1 12953,0 13029,1 13075,0 13142,1 13168,0 13181,1 13244,0 13322,1 13405,0 13492,1 13510,0 13607,1 13690,0 13725,1 13783,0 13826,1 13854,0 13903,1 13989,0 14068,1 14117,0 14150,1 14240,0 14313,1 14360,0 14386,1 14458,0 14557,1 14563,0 14598,1 14662,0 14691,1 14774,0 14782,1 14788,0 14870,1 14966,0 15016,1 15036,0 15087,1 15114,0 15124,1 15192,0 15249,1 15305,0 15356,1 15359,0 15420,1 15463,0 15478,1 15481,0 15482,1 15554,0 15604,1 15638,0 15658,1 15676,0 15684,1 15759,0 15772,1 15834,0 15911,1 16005,0 16028,1 16111,0 16188,1 16205,0 16261,1 16311,0 16315,1 16387,0 16455,1 16465,0 16484,1 16543,0 16609,1 16636,0 16699,1 16784,0 16805,1 16833,0 16874,1 16906,0 16921,1 16960,0 17033,1 17108,0 17114,1 17150,0 17219,1 17235,0 17296,1 17306,0 17351,1 17412,0 17506,1 17605,0 17703,1 17738,0 17777,1 17860,0 17952,1 17988,0 18045,1 18115,0 18117,1 18126,0 18132,1 18223,0 18278,1 18294,0 18371,1 18400,0 18465,1 18496,0 18536,1 18551,0 18614,1 18632,0 18694,1 18767,0 18841,1 18925,0 19020,1 19036,0 19041,1 19080,0 19171,1 19224,0 19320,1 19332,0 19424,1 19468,0 19528,1 19578,0 19674,1 19711,0 19801,1 19807,0 19848,1 19891,0 19906,1 19942,0 20035,1 20087,0 20151,1 20175,0 20247,1 20300,0 20352,1 20426,0 20451,1 20548,0 20598,1 20639,0 20694,1 20734,0 20767,1 20774,0 20782,1 20783,0 20880,1 20966,0 20980,1 20993,0 21071,1 21111,0 21162,1 21262,0 21264,1 21343,0 21368,1 21378,0 21460,1 21486,0 21494,1 21561,0 21634,1 21664,0 21676,1 21741,0 21766,1 21812,0 21846,1 21892,0 21901,1 21961,0 22037,1 22074,0 22077,1 22089,0 22125,1 22155,0 22252,1 22255,0 22342,1 22359,0 22379,1 22459,0 22525,1 22579,0 22656,1 22720,0 22744,1 22826,0 22924,1 23005,0 23084,1 23137,0 23154,1 23181,0 23215,1 23268,0 23273,1 23296,0 23339,1 23347,0 23351,1 23420,0 23467,1 23548,0 23645,1 23662,0 23685,1 23693,0 23751,1 23850,0 23931,1 23982,0 24057,1 24151,0 24235,1 24316,0 24365,1 24454,0 24485,1 24488,0 24576,1 24675,0 24747,1 24777,0 24857,1 24869,0 24917,1 24987,0 25086,1 25152,0 25213,1 25270,0 25302,1 25349,0 25431,1 25520,0 25608,1 25692,0 25785,1 25849,0 25927,1 26022,0 26103,1 26141,0 26179,1 26253,0 26299,1 26391,0 26393,1 26437,0 26534,1 26609,0 26659,1 26682,0 26709,1 26740,0 26829,1 26840,0 26938,1 26990,0 27041,1 27046,0 27054,1 27134,0 27190,1 27219,0 27255,1 27320,0 27354,1 27405,0 27482,1 27498,0 27582,1 27656,0 27732,1 27820,0 27854,1 27884,0 27982,1 27997,0 28066,1 28147,0 28196,1 28209,0 28286,1 28289,0 28350,1 28413,0 28448,1 28514,0 28573,1 28636,0 28685,1 28700,0 28705,1 28775,0 28866,1 28927,0 28958,1 28988,0 29038,1 29068,0 29167,1 29193,0 29197,1 29256,0 29326,1 29329,0 29354,1 29400,0 29483,1 29524,0 29538,1 29630,0 29663,1 29677,0 29759,1 29772,0 29830,1 29839,0 29938,1 30019,0 30083,1 30101,0 30145,1 30160,0 30228,1 30234,0 30236,1 30304,0 30333,1 30422,0 30514,1 30523,0 30605,1 30615,0 30679,1 30753,0 30799,1 30874,0 30919,1 31007,0 31055,1 31068,0 31128,1 31148,0 31182,1 31264,0 31323,1 31405,0 31494,1 31513,0 31548,1 31595,0 31630,1 31654,0 31666,1 31705,0 31751,1 31848,0 31911,1 31978,0 31992,1 32072,0 32086,1 32167,0 32266,1 32338,0 32396,1 32403,0 32468,1 32498,0 32516,1 32522,0 32551,1 32633,0 32726,1 32773,0 32803,1 32862,0 32909,1 32998,0 33021,1 33058,0 33103,1 33123,0 33168,1 33260,0 33304,1 33337,0 33396,1 33419,0 33449,1 33543,0 33568,1 33620,0 33665,1 33719,0 33765,1 33858,0 33901,1 33955,0 33969,1 34043,0 34055,1 34137,0 34187,1 34281,0 34296,1 34310,0 34328,1 34348,0 34377,1 34437,0 34503,1 34528,0 34533,1 34617,0 34690,1 34759,0 34832,1 34861,0 34942,1 34969,0 35046,1 35125,0 35217,1 35248,0 35279,1 35292,0 35364,1 35408,0 35423,1 35497,0 35573,1 35646,0 35712,1 35801,0 35804,1 35858,0 35938,1 35960,0 36032,1 36101,0 36137,1 36179,0 36269,1 36287,0 36384,1 36447,0 36452,1 36492,0 36511,1 36544,0 36565,1 36577,0 36625,1 36657,0 36687,1 36705,0 36804,1 36856,0 36869,1 36921,0 36925,1 36939,0 37012,1 37052,0 37112,1 37193,0 37238,1 37251,0 37317,1 37376,0 37456,1 37458,0 37539,1 37607,0 37703,1 37776,0 37861,1 37878,0 37900,1 37955,0 38038,1 38134,0 38185,1 38271,0 38336,1 38419,0 38449,1 38518,0 38607,1 38660,0 38753,1 38846,0 38895,1 38939,0 38952,1 39015,0 39067,1 39069,0 39141,1 39181,0 39219,1 39232,0 39242,1 39307,0 39407,1 39411,0 39467,1 39527,0 39626,1 39718,0 39743,1 39764,0 39823,1 39831,0 39865,1 39878,0 39931,1 39950,0 39955,1 39964,0 39972,1 40020,0 40049,1 40086,0 40179,1 40256,0 40265,1 40291,0 40355,1 40378,0 40382,1 40390,0 40438,1 40445,0 40493,1 40579,0 40610,1 40703,0 40803,1 40838,0 40896,1 40950,0 41012,1 41032,0 41120,1 41180,0 41274,1 41288,0 41319,1 41410,0 41457,1 41484,0 41534,1 41548,0 41551,1 41571,0 41631,1 41714,0 41733,1 41813,0 41845,1 41942,0 42001,1 42077,0 42101,1 42128,0 42202,1 42207,0 42295,1 42361,0 42441,1 42500,0 42507,1 42571,0 42655,1 42747,0 42780,1 42814,0 42900,1 42969,0 42981,1 42993,0 43017,1 43027,0 43062,1 43123,0 43159,1 43229,0 43280,1 43374,0 43414,1 43423,0 43425,1 43475,0 43512,1 43587,0 43682,1 43744,0 43757,1 43818,0 43899,1 43960,0 44028,1 44032,0 44124,1 44180,0 44183,1 44226,0 44322,1 44390,0 44408,1 44482,0 44542,1 44558,0 44654,1 44711,0 44730,1 44780,0 44805,1 44859,0 44881,1 44890,0 44919,1 44958,0 45058,1 45131,0 45209,1 45302,0 45305,1 45347,0 45356,1 45454,0 45478,1 45488,0 45534,1 45630,0 45676,1 45725,0 45804,1 45828,0 45884,1 45925,0 45984,1 46078,0 46155,1 46182,0 46251,1 46270,0 46292,1 46295,0 46385,1 46468,0 46549,1 46623,0 46709,1 46755,0 46790,1 46861,0 46909,1 46978,0 47036,1 47131,0 47216,1 47229,0 47328,1 47359,0 47385,1 47441,0 47455,1 47506,0 47515,1 47543,0 47597,1 47633,0 47641,1 47720,0 47753,1 47824,0 47890,1 47927,0 47954,1 47996,0 48078,1 48121,0 48186,1 48268,0 48317,1 48326,0 48411,1 48508,0 48597,1 48673,0 48746,1 48833,0 48862,1 48894,0 48992,1 49074,0 49125,1 49192,0 49285,1 49297,0 49352,1 49409,0 49498,1 49522,0 49568,1 49635,0 49659,1 49664,0 49707,1 49708,0 49801,1 end initlist a38 0,0 25,1 125,0 199,1 239,0 272,1 337,0 393,1 403,0 451,1 452,0 478,1 523,0 617,1 675,0 698,1 723,0 753,1 794,0 840,1 845,0 908,1 960,0 975,1 1043,0 1063,1 1111,0 1165,1 1246,0 1341,1 1353,0 1449,1 1494,0 1500,1 1563,0 1643,1 1720,0 1740,1 1804,0 1861,1 1920,0 1972,1 2055,0 2107,1 2128,0 2178,1 2187,0 2223,1 2307,0 2385,1 2398,0 2436,1 2523,0 2527,1 2602,0 2669,1 2731,0 2802,1 2888,0 2940,1 2947,0 3044,1 3058,0 3141,1 3218,0 3309,1 3408,0 3499,1 3552,0 3627,1 3637,0 3656,1 3745,0 3752,1 3766,0 3783,1 3878,0 3908,1 3919,0 4005,1 4012,0 4013,1 4056,0 4075,1 4095,0 4172,1 4253,0 4271,1 4299,0 4304,1 4381,0 4392,1 4451,0 4453,1 4457,0 4518,1 4545,0 4570,1 4663,0 4710,1 4739,0 4780,1 4844,0 4856,1 4942,0 4957,1 5046,0 5047,1 5054,0 5063,1 5149,0 5206,1 5294,0 5349,1 5357,0 5376,1 5438,0 5527,1 5530,0 5598,1 5619,0 5637,1 5671,0 5708,1 5763,0 5839,1 5918,0 5982,1 6047,0 6116,1 6152,0 6194,1 6245,0 6345,1 6357,0 6367,1 6370,0 6444,1 6530,0 6548,1 6612,0 6664,1 6691,0 6746,1 6796,0 6877,1 6945,0 6996,1 7032,0 7053,1 7081,0 7162,1 7239,0 7262,1 7323,0 7382,1 7425,0 7486,1 7499,0 7538,1 7604,0 7614,1 7659,0 7745,1 7773,0 7803,1 7813,0 7872,1 7959,0 8013,1 8019,0 8117,1 8183,0 8270,1 8272,0 8344,1 8360,0 8439,1 8469,0 8538,1 8545,0 8631,1 8649,0 8683,1 8781,0 8811,1 8855,0 8863,1 8939,0 9018,1 9070,0 9127,1 9207,0 9264,1 9353,0 9382,1 9420,0 9443,1 9536,0 9589,1 9623,0 9662,1 9694,0 9708,1 9758,0 9762,1 9805,0 9818,1 9827,0 9926,1 9968,0 9985,1 10008,0 10083,1 10110,0 10181,1 10272,0 10370,1 10467,0 10500,1 10557,0 10648,1 10652,0 10665,1 10754,0 10832,1 10899,0 10998,1 11097,0 11123,1 11129,0 11182,1 11210,0 11260,1 11323,0 11392,1 11433,0 11470,1 11527,0 11547,1 11616,0 11697,1 11777,0 11801,1 11847,0 11893,1 11944,0 11991,1 12007,0 12014,1 12103,0 12140,1 12236,0 12302,1 12388,0 12438,1 12516,0 12538,1 12550,0 12558,1 12638,0 12676,1 12770,0 12868,1 12881,0 12918,1 12983,0 13003,1 13032,0 13105,1 13124,0 13191,1 13279,0 13292,1 13360,0 13438,1 13477,0 13485,1 13557,0 13636,1 13728,0 13740,1 13780,0 13830,1 13852,0 13944,1 14018,0 14092,1 14160,0 14228,1 14264,0 14331,1 14410,0 14453,1 14464,0 14530,1 14569,0 14618,1 14619,0 14699,1 14736,0 14783,1 14879,0 14934,1 14996,0 15047,1 15122,0 15172,1 15223,0 15270,1 15317,0 15388,1 15393,0 15405,1 15500,0 15508,1 15530,0 15540,1 15548,0 15645,1 15724,0 15802,1 15803,0 15874,1 15896,0 15985,1 16083,0 16110,1 16164,0 16231,1 16312,0 16347,1 16375,0 16432,1 16471,0 16540,1 16613,0 16663,1 16721,0 16819,1 16872,0 16911,1 16995,0 17059,1 17138,0 17236,1 17292,0 17382,1 17411,0 17499,1 17598,0 17665,1 17721,0 17789,1 17828,0 17923,1 17975,0 17982,1 18051,0 18097,1 18154,0 18186,1 18267,0 18320,1 18322,0 18394,1 18413,0 18450,1 18520,0 18572,1 18655,0 18673,1 18747,0 18764,1 18820,0 18869,1 18920,0 18946,1 18954,0 19004,1 19034,0 19044,1 19131,0 19159,1 19173,0 19251,1 19336,0 19392,1 19417,0 19494,1 19566,0 19647,1 19654,0 19674,1 19761,0 19771,1 19791,0 19848,1 19876,0 19934,1 20028,0 20119,1 20198,0 20280,1 20369,0 20388,1 20404,0 20413,1 20509,0 20567,1 20661,0 20664,1 20702,0 20714,1 20727,0 20796,1 20851,0 20925,1 21001,0 21089,1 21187,0 21214,1 21276,0 21296,1 21385,0 21404,1 21419,0 21517,1 21549,0 21639,1 21654,0 21683,1 21780,0 21839,1 21925,0 21937,1 21942,0 22025,1 22066,0 22092,1 22164,0 22196,1 22280,0 22294,1 22367,0 22397,1 22423,0 22517,1 22617,0 22651,1 22697,0 22780,1 22811,0 22899,1 22937,0 22958,1 22993,0 23042,1 23085,0 23140,1 23173,0 23271,1 23272,0 23306,1 23308,0 23381,1 23406,0 23453,1 23552,0 23592,1 23670,0 23680,1 23688,0 23693,1 23785,0 23825,1 23830,0 23929,1 23943,0 24035,1 24133,0 24209,1 24302,0 24347,1 24418,0 24498,1 24596,0 24694,1 24700,0 24790,1 24817,0 24896,1 24900,0 24985,1 25005,0 25044,1 25112,0 25136,1 25201,0 25252,1 25309,0 25348,1 25368,0 25467,1 25479,0 25495,1 25593,0 25658,1 25677,0 25735,1 25808,0 25834,1 25878,0 25945,1 26000,0 26009,1 26066,0 26113,1 26177,0 26275,1 26296,0 26345,1 26377,0 26437,1 26440,0 26516,1 26554,0 26604,1 26684,0 26696,1 26712,0 26718,1 26777,0 26852,1 26936,0 27019,1 27039,0 27069,1 27072,0 27078,1 27106,0 27119,1 27209,0 27218,1 27290,0 27357,1 27393,0 27471,1 27473,0 27505,1 27517,0 27543,1 27602,0 27635,1 27671,0 27770,1 27799,0 27852,1 27856,0 27928,1 27981,0 28046,1 28058,0 28104,1 28176,0 28225,1 28248,0 28337,1 28403,0 28502,1 28594,0 28691,1 28706,0 28804,1 28873,0 28895,1 28961,0 29032,1 29082,0 29098,1 29102,0 29198,1 29281,0 29346,1 29441,0 29510,1 29568,0 29613,1 29650,0 29669,1 29746,0 29780,1 29849,0 29904,1 29929,0 30015,1 30103,0 30135,1 30166,0 30167,1 30171,0 30270,1 30313,0 30359,1 30383,0 30483,1 30556,0 30557,1 30602,0 30673,1 30698,0 30762,1 30787,0 30864,1 30962,0 31008,1 31028,0 31048,1 31107,0 31121,1 31154,0 31189,1 31268,0 31284,1 31294,0 31375,1 31440,0 31518,1 31579,0 31642,1 31729,0 31766,1 31794,0 31886,1 31916,0 31994,1 32067,0 32149,1 32156,0 32224,1 32277,0 32294,1 32310,0 32327,1 32329,0 32427,1 32469,0 32473,1 32561,0 32613,1 32676,0 32710,1 32717,0 32810,1 32846,0 32880,1 32915,0 32977,1 32997,0 33066,1 33164,0 33207,1 33302,0 33358,1 33424,0 33487,1 33560,0 33605,1 33632,0 33695,1 33712,0 33752,1 33790,0 33797,1 33867,0 33881,1 33911,0 33915,1 33983,0 34074,1 34123,0 34127,1 34177,0 34243,1 34305,0 34375,1 34408,0 34452,1 34506,0 34598,1 34668,0 34763,1 34816,0 34887,1 34948,0 34979,1 35041,0 35117,1 35210,0 35232,1 35312,0 35318,1 35345,0 35416,1 35448,0 35515,1 35528,0 35622,1 35694,0 35758,1 35821,0 35899,1 35910,0 36006,1 36081,0 36137,1 36205,0 36215,1 36278,0 36363,1 36404,0 36409,1 36453,0 36511,1 36573,0 36645,1 36705,0 36749,1 36778,0 36786,1 36885,0 36951,1 36962,0 37021,1 37121,0 37205,1 37216,0 37284,1 37373,0 37441,1 37484,0 37571,1 37601,0 37603,1 37688,0 37735,1 37789,0 37842,1 37858,0 37941,1 38032,0 38084,1 38133,0 38136,1 38200,0 38250,1 38338,0 38409,1 38458,0 38510,1 38610,0 38618,1 38709,0 38784,1 38821,0 38918,1 38947,0 38971,1 39042,0 39065,1 39076,0 39129,1 39148,0 39158,1 39199,0 39212,1 39273,0 39308,1 39385,0 39456,1 39457,0 39536,1 39542,0 39550,1 39611,0 39705,1 39716,0 39779,1 39790,0 39841,1 39906,0 39980,1 40020,0 40040,1 40135,0 40232,1 40275,0 40303,1 40358,0 40365,1 40438,0 40469,1 40540,0 40560,1 40584,0 40586,1 40684,0 40750,1 40814,0 40876,1 40967,0 40976,1 41075,0 41159,1 41256,0 41273,1 41309,0 41401,1 41492,0 41535,1 41555,0 41621,1 41691,0 41739,1 41804,0 41852,1 41855,0 41897,1 41915,0 42012,1 42028,0 42122,1 42129,0 42226,1 42286,0 42295,1 42336,0 42370,1 42436,0 42440,1 42486,0 42543,1 42547,0 42562,1 42642,0 42716,1 42726,0 42754,1 42762,0 42792,1 42819,0 42841,1 42897,0 42934,1 43016,0 43023,1 43035,0 43111,1 43169,0 43212,1 43266,0 43310,1 43330,0 43380,1 43405,0 43499,1 43550,0 43610,1 43708,0 43776,1 43796,0 43886,1 43943,0 44036,1 44101,0 44118,1 44124,0 44130,1 44158,0 44231,1 44298,0 44326,1 44361,0 44367,1 44420,0 44512,1 44560,0 44590,1 44612,0 44633,1 44673,0 44697,1 44757,0 44833,1 44890,0 44928,1 45024,0 45032,1 45116,0 45214,1 45291,0 45308,1 45367,0 45406,1 45451,0 45489,1 45552,0 45634,1 45704,0 45730,1 45769,0 45787,1 45881,0 45964,1 46007,0 46044,1 46078,0 46080,1 46093,0 46104,1 46181,0 46244,1 46332,0 46352,1 46391,0 46477,1 46498,0 46594,1 46617,0 46643,1 46662,0 46712,1 46717,0 46730,1 46766,0 46851,1 46892,0 46905,1 47002,0 47054,1 47077,0 47138,1 47161,0 47186,1 47268,0 47275,1 47357,0 47361,1 47461,0 47518,1 47539,0 47637,1 47681,0 47770,1 47805,0 47896,1 47971,0 48047,1 48129,0 48171,1 48259,0 48260,1 48354,0 48361,1 48425,0 48480,1 48529,0 48587,1 48666,0 48766,1 48841,0 48856,1 48893,0 48938,1 48962,0 49034,1 49045,0 49137,1 49163,0 49204,1 49282,0 49319,1 49336,0 49391,1 49467,0 49488,1 49568,0 49664,1 49748,0 49791,1 49859,0 49930,1 49991,0 50050,1 50096,0 50115,1 50194,0 50258,1 50317,0 50407,1 50495,0 50539,1 end initlist a39 0,0 78,1 115,0 175,1 194,0 240,1 320,0 323,1 343,0 347,1 409,0 472,1 492,0 573,1 662,0 679,1 741,0 799,1 869,0 951,1 1016,0 1108,1 1188,0 1216,1 1309,0 1344,1 1381,0 1414,1 1426,0 1486,1 1517,0 1541,1 1545,0 1596,1 1633,0 1732,1 1795,0 1828,1 1926,0 1963,1 2060,0 2117,1 2207,0 2221,1 2311,0 2372,1 2382,0 2450,1 2463,0 2524,1 2566,0 2576,1 2615,0 2704,1 2778,0 2869,1 2959,0 2999,1 3083,0 3135,1 3201,0 3282,1 3289,0 3369,1 3379,0 3439,1 3470,0 3476,1 3490,0 3560,1 3561,0 3609,1 3648,0 3720,1 3739,0 3787,1 3872,0 3909,1 3956,0 4013,1 4037,0 4090,1 4159,0 4234,1 4266,0 4270,1 4279,0 4363,1 4409,0 4459,1 4541,0 4562,1 4661,0 4696,1 4760,0 4792,1 4849,0 4932,1 4933,0 5021,1 5023,0 5093,1 5131,0 5202,1 5284,0 5341,1 5415,0 5499,1 5528,0 5619,1 5713,0 5778,1 5788,0 5823,1 5836,0 5889,1 5970,0 6053,1 6074,0 6134,1 6151,0 6177,1 6273,0 6349,1 6369,0 6374,1 6448,0 6504,1 6514,0 6572,1 6618,0 6629,1 6710,0 6794,1 6889,0 6972,1 7007,0 7100,1 7103,0 7196,1 7220,0 7221,1 7245,0 7307,1 7400,0 7404,1 7423,0 7429,1 7527,0 7545,1 7624,0 7719,1 7779,0 7851,1 7895,0 7907,1 7980,0 8058,1 8082,0 8172,1 8220,0 8287,1 8346,0 8392,1 8464,0 8559,1 8572,0 8659,1 8720,0 8752,1 8814,0 8903,1 8922,0 8961,1 8986,0 9079,1 9098,0 9161,1 9215,0 9275,1 9310,0 9405,1 9435,0 9502,1 9601,0 9654,1 9669,0 9750,1 9801,0 9804,1 9858,0 9928,1 9943,0 10026,1 10104,0 10195,1 10202,0 10234,1 10249,0 10337,1 10350,0 10419,1 10457,0 10487,1 10514,0 10516,1 10518,0 10598,1 10695,0 10718,1 10757,0 10854,1 10904,0 10905,1 10977,0 11025,1 11120,0 11164,1 11227,0 11228,1 11303,0 11323,1 11420,0 11518,1 11531,0 11577,1 11644,0 11688,1 11773,0 11847,1 11940,0 11958,1 12035,0 12087,1 12151,0 12213,1 12252,0 12292,1 12302,0 12376,1 12393,0 12454,1 12489,0 12501,1 12530,0 12552,1 12567,0 12630,1 12664,0 12683,1 12685,0 12735,1 12833,0 12925,1 12977,0 13069,1 13165,0 13170,1 13243,0 13298,1 13316,0 13385,1 13483,0 13533,1 13616,0 13698,1 13768,0 13835,1 13905,0 13926,1 13969,0 13983,1 14064,0 14129,1 14163,0 14241,1 14254,0 14263,1 14331,0 14410,1 14427,0 14489,1 14567,0 14650,1 14722,0 14740,1 14808,0 14879,1 14896,0 14981,1 14989,0 15011,1 15016,0 15063,1 15158,0 15220,1 15246,0 15288,1 15313,0 15375,1 15387,0 15475,1 15533,0 15576,1 15599,0 15632,1 15732,0 15810,1 15887,0 15925,1 15941,0 15993,1 16067,0 16097,1 16141,0 16163,1 16194,0 16241,1 16299,0 16316,1 16384,0 16414,1 16427,0 16494,1 16576,0 16622,1 16641,0 16728,1 16772,0 16782,1 16801,0 16898,1 16913,0 16971,1 17030,0 17066,1 17103,0 17170,1 17181,0 17229,1 17256,0 17283,1 17313,0 17412,1 17483,0 17518,1 17527,0 17600,1 17646,0 17717,1 17739,0 17810,1 17881,0 17941,1 17984,0 18043,1 18053,0 18081,1 18178,0 18193,1 18206,0 18219,1 18253,0 18254,1 18324,0 18334,1 18344,0 18420,1 18512,0 18527,1 18581,0 18667,1 18696,0 18749,1 18800,0 18838,1 18890,0 18966,1 19064,0 19083,1 19176,0 19203,1 19213,0 19223,1 19290,0 19300,1 19330,0 19350,1 19389,0 19408,1 19481,0 19568,1 19668,0 19725,1 19782,0 19815,1 19847,0 19864,1 19876,0 19918,1 19978,0 19989,1 20012,0 20077,1 20145,0 20176,1 20197,0 20242,1 20311,0 20398,1 20468,0 20506,1 20597,0 20661,1 20738,0 20796,1 20857,0 20940,1 21021,0 21089,1 21185,0 21212,1 21301,0 21330,1 21358,0 21362,1 21434,0 21516,1 21550,0 21614,1 21619,0 21673,1 21700,0 21758,1 21825,0 21847,1 21892,0 21977,1 22065,0 22150,1 22195,0 22237,1 22301,0 22399,1 22461,0 22494,1 22586,0 22659,1 22708,0 22786,1 22825,0 22874,1 22938,0 23026,1 23110,0 23195,1 23197,0 23216,1 23227,0 23292,1 23337,0 23353,1 23391,0 23411,1 23435,0 23451,1 23489,0 23539,1 23624,0 23706,1 23749,0 23805,1 23827,0 23896,1 23993,0 24063,1 24108,0 24144,1 24180,0 24252,1 24268,0 24313,1 24398,0 24407,1 24493,0 24587,1 24627,0 24719,1 24766,0 24829,1 24901,0 24978,1 25002,0 25067,1 25130,0 25178,1 25205,0 25232,1 25233,0 25290,1 25291,0 25357,1 25407,0 25415,1 25469,0 25498,1 25582,0 25612,1 25659,0 25752,1 25800,0 25833,1 25845,0 25849,1 25854,0 25907,1 25952,0 25999,1 26039,0 26089,1 26097,0 26163,1 26257,0 26301,1 26309,0 26339,1 26432,0 26484,1 26577,0 26625,1 26656,0 26690,1 26749,0 26791,1 26889,0 26962,1 27038,0 27137,1 27152,0 27223,1 27265,0 27342,1 27409,0 27443,1 27534,0 27624,1 27717,0 27753,1 27835,0 27929,1 28021,0 28056,1 28115,0 28151,1 28162,0 28183,1 28283,0 28320,1 28414,0 28443,1 28497,0 28522,1 28597,0 28690,1 28696,0 28768,1 28811,0 28891,1 28907,0 28923,1 28980,0 28981,1 28984,0 29047,1 29068,0 29132,1 29177,0 29253,1 29279,0 29335,1 29423,0 29504,1 29549,0 29558,1 29635,0 29690,1 29742,0 29835,1 29933,0 29984,1 30012,0 30044,1 30093,0 30157,1 30162,0 30173,1 30267,0 30280,1 30359,0 30425,1 30514,0 30549,1 30562,0 30629,1 30720,0 30763,1 30770,0 30847,1 30929,0 30935,1 31003,0 31068,1 31097,0 31099,1 31182,0 31250,1 31271,0 31272,1 31297,0 31327,1 31341,0 31427,1 31465,0 31469,1 31492,0 31543,1 31578,0 31618,1 31681,0 31752,1 31851,0 31929,1 31962,0 32001,1 32095,0 32136,1 32204,0 32263,1 32288,0 32310,1 32317,0 32330,1 32380,0 32468,1 32519,0 32582,1 32588,0 32680,1 32762,0 32829,1 32874,0 32910,1 32950,0 33023,1 33109,0 33127,1 33173,0 33244,1 33274,0 33304,1 33334,0 33335,1 33417,0 33499,1 33522,0 33587,1 33649,0 33701,1 33779,0 33780,1 33875,0 33876,1 33932,0 33980,1 34055,0 34120,1 34133,0 34161,1 34251,0 34283,1 34315,0 34322,1 34372,0 34425,1 34525,0 34625,1 34648,0 34722,1 34742,0 34812,1 34881,0 34894,1 34927,0 34935,1 34999,0 35041,1 35074,0 35165,1 35247,0 35322,1 35358,0 35376,1 35409,0 35426,1 35444,0 35536,1 35543,0 35632,1 35634,0 35731,1 35769,0 35867,1 35914,0 35982,1 36034,0 36095,1 36148,0 36158,1 36182,0 36183,1 36273,0 36293,1 36309,0 36313,1 36392,0 36404,1 36451,0 36476,1 36545,0 36568,1 36610,0 36663,1 36762,0 36763,1 36781,0 36829,1 36847,0 36929,1 37006,0 37083,1 37161,0 37221,1 37320,0 37404,1 37438,0 37493,1 37580,0 37617,1 37697,0 37773,1 37822,0 37842,1 37890,0 37911,1 37945,0 38005,1 38051,0 38055,1 38143,0 38208,1 38262,0 38318,1 38403,0 38501,1 38543,0 38618,1 38716,0 38719,1 38808,0 38819,1 38893,0 38929,1 39027,0 39102,1 39198,0 39292,1 39309,0 39399,1 39493,0 39496,1 39519,0 39548,1 39614,0 39621,1 39668,0 39685,1 39692,0 39743,1 39835,0 39899,1 39920,0 39976,1 40063,0 40094,1 40100,0 40113,1 40123,0 40188,1 40189,0 40200,1 40297,0 40353,1 40414,0 40472,1 40544,0 40581,1 40584,0 40589,1 40632,0 40724,1 40816,0 40846,1 40850,0 40918,1 40922,0 40938,1 41031,0 41069,1 41080,0 41085,1 41105,0 41187,1 41247,0 41253,1 41301,0 41364,1 41429,0 41515,1 41597,0 41667,1 41756,0 41848,1 41915,0 41984,1 42048,0 42055,1 42149,0 42210,1 42249,0 42280,1 42322,0 42373,1 42463,0 42512,1 42514,0 42529,1 42600,0 42615,1 42683,0 42745,1 42837,0 42888,1 42931,0 42959,1 43003,0 43019,1 43101,0 43170,1 43231,0 43247,1 43253,0 43262,1 43265,0 43323,1 43376,0 43473,1 43565,0 43612,1 43625,0 43675,1 43691,0 43720,1 43819,0 43854,1 43946,0 44043,1 44049,0 44111,1 44205,0 44267,1 44281,0 44286,1 44374,0 44405,1 44417,0 44444,1 44497,0 44523,1 44545,0 44610,1 44636,0 44649,1 44700,0 44781,1 44844,0 44941,1 44953,0 45027,1 45061,0 45114,1 45186,0 45285,1 45286,0 45378,1 45472,0 45554,1 45590,0 45667,1 45693,0 45750,1 45782,0 45791,1 45843,0 45860,1 45919,0 45952,1 45993,0 46086,1 46154,0 46234,1 46332,0 46398,1 46476,0 46495,1 46520,0 46607,1 46658,0 46748,1 46767,0 46797,1 46877,0 46939,1 47027,0 47086,1 47111,0 47113,1 47155,0 47178,1 47204,0 47269,1 47356,0 47437,1 47442,0 47485,1 47550,0 47580,1 47647,0 47718,1 47814,0 47873,1 47877,0 47934,1 48020,0 48066,1 48156,0 48166,1 48178,0 48255,1 48309,0 48312,1 48406,0 48483,1 48507,0 48516,1 48517,0 48567,1 48577,0 48636,1 48643,0 48737,1 48740,0 48752,1 48820,0 48884,1 48885,0 48933,1 48950,0 49040,1 49095,0 49187,1 49262,0 49324,1 49414,0 49444,1 49481,0 49496,1 49522,0 49541,1 49618,0 49674,1 49766,0 49785,1 49845,0 49865,1 49952,0 49963,1 50030,0 50070,1 50123,0 50190,1 50206,0 50290,1 end initlist a40 0,0 6,1 8,0 41,1 42,0 134,1 149,0 183,1 234,0 323,1 359,0 421,1 457,0 472,1 556,0 602,1 648,0 737,1 777,0 863,1 868,0 961,1 1010,0 1028,1 1059,0 1081,1 1104,0 1120,1 1172,0 1185,1 1193,0 1235,1 1297,0 1367,1 1376,0 1382,1 1479,0 1515,1 1580,0 1594,1 1647,0 1731,1 1750,0 1819,1 1877,0 1899,1 1959,0 1967,1 1986,0 2019,1 2066,0 2163,1 2238,0 2311,1 2381,0 2439,1 2490,0 2536,1 2581,0 2633,1 2694,0 2755,1 2819,0 2913,1 2956,0 2970,1 2974,0 3013,1 3023,0 3109,1 3129,0 3142,1 3201,0 3299,1 3366,0 3409,1 3497,0 3574,1 3637,0 3644,1 3665,0 3755,1 3757,0 3824,1 3914,0 3960,1 4013,0 4086,1 4154,0 4200,1 4210,0 4236,1 4238,0 4275,1 4304,0 4377,1 4414,0 4487,1 4550,0 4571,1 4607,0 4683,1 4773,0 4823,1 4902,0 4924,1 4994,0 5068,1 5143,0 5217,1 5314,0 5409,1 5466,0 5532,1 5609,0 5634,1 5655,0 5702,1 5715,0 5740,1 5751,0 5765,1 5781,0 5825,1 5901,0 5965,1 6034,0 6067,1 6102,0 6115,1 6138,0 6216,1 6294,0 6324,1 6336,0 6426,1 6476,0 6494,1 6497,0 6558,1 6619,0 6642,1 6700,0 6707,1 6727,0 6768,1 6826,0 6891,1 6963,0 7047,1 7097,0 7102,1 7119,0 7179,1 7215,0 7262,1 7328,0 7398,1 7469,0 7477,1 7556,0 7643,1 7685,0 7707,1 7773,0 7809,1 7904,0 7952,1 7959,0 8024,1 8070,0 8151,1 8187,0 8258,1 8314,0 8370,1 8444,0 8489,1 8558,0 8566,1 8599,0 8699,1 8714,0 8755,1 8778,0 8825,1 8902,0 8937,1 8985,0 9059,1 9105,0 9153,1 9215,0 9301,1 9309,0 9390,1 9449,0 9491,1 9517,0 9584,1 9587,0 9643,1 9728,0 9738,1 9742,0 9747,1 9749,0 9825,1 9916,0 9956,1 10038,0 10110,1 10166,0 10238,1 10298,0 10312,1 10339,0 10349,1 10368,0 10423,1 10438,0 10507,1 10520,0 10540,1 10562,0 10585,1 10631,0 10720,1 10812,0 10842,1 10915,0 10938,1 10968,0 11061,1 11070,0 11128,1 11218,0 11309,1 11322,0 11362,1 11364,0 11436,1 11471,0 11499,1 11582,0 11589,1 11608,0 11619,1 11698,0 11795,1 11891,0 11923,1 12018,0 12094,1 12130,0 12145,1 12206,0 12213,1 12294,0 12343,1 12358,0 12457,1 12515,0 12615,1 12696,0 12735,1 12816,0 12865,1 12932,0 13025,1 13115,0 13135,1 13144,0 13178,1 13222,0 13273,1 13274,0 13363,1 13438,0 13522,1 13553,0 13641,1 13704,0 13777,1 13860,0 13954,1 14008,0 14028,1 14086,0 14148,1 14240,0 14292,1 14364,0 14389,1 14416,0 14508,1 14521,0 14589,1 14606,0 14619,1 14640,0 14668,1 14677,0 14711,1 14811,0 14905,1 14930,0 14988,1 15052,0 15063,1 15112,0 15167,1 15188,0 15228,1 15230,0 15329,1 15392,0 15410,1 15464,0 15564,1 15570,0 15597,1 15626,0 15711,1 15778,0 15824,1 15902,0 15975,1 16033,0 16100,1 16130,0 16161,1 16192,0 16195,1 16283,0 16310,1 16342,0 16383,1 16389,0 16441,1 16461,0 16529,1 16611,0 16636,1 16662,0 16676,1 16691,0 16762,1 16814,0 16876,1 16914,0 16955,1 17002,0 17005,1 17025,0 17105,1 17187,0 17193,1 17194,0 17294,1 17322,0 17368,1 17455,0 17538,1 17632,0 17715,1 17786,0 17823,1 17843,0 17930,1 17977,0 18017,1 18034,0 18062,1 18101,0 18122,1 18153,0 18175,1 18228,0 18253,1 18276,0 18310,1 18341,0 18348,1 18377,0 18464,1 18494,0 18551,1 18621,0 18655,1 18720,0 18803,1 18873,0 18965,1 18988,0 19042,1 19103,0 19150,1 19225,0 19228,1 19310,0 19405,1 19459,0 19518,1 19532,0 19596,1 19597,0 19650,1 19732,0 19786,1 19826,0 19831,1 19892,0 19924,1 20018,0 20072,1 20129,0 20173,1 20200,0 20210,1 20215,0 20296,1 20318,0 20397,1 20415,0 20443,1 20524,0 20569,1 20589,0 20664,1 20731,0 20782,1 20785,0 20846,1 20849,0 20935,1 21004,0 21077,1 21162,0 21176,1 21227,0 21264,1 21289,0 21308,1 21400,0 21486,1 21552,0 21611,1 21682,0 21749,1 21841,0 21923,1 21935,0 22018,1 22081,0 22144,1 22235,0 22262,1 22359,0 22395,1 22480,0 22493,1 22496,0 22524,1 22572,0 22590,1 22639,0 22687,1 22716,0 22760,1 22810,0 22893,1 22970,0 23026,1 23057,0 23127,1 23169,0 23184,1 23195,0 23204,1 23224,0 23308,1 23337,0 23428,1 23470,0 23569,1 23645,0 23668,1 23758,0 23781,1 23799,0 23856,1 23899,0 23980,1 24063,0 24069,1 24163,0 24262,1 24318,0 24329,1 24332,0 24352,1 24380,0 24448,1 24478,0 24503,1 24538,0 24567,1 24647,0 24685,1 24692,0 24791,1 24845,0 24888,1 24920,0 24956,1 24996,0 25056,1 25128,0 25151,1 25189,0 25265,1 25328,0 25342,1 25437,0 25495,1 25582,0 25622,1 25638,0 25656,1 25659,0 25741,1 25776,0 25782,1 25824,0 25883,1 25932,0 25942,1 25981,0 26060,1 26138,0 26237,1 26264,0 26362,1 26383,0 26431,1 26473,0 26531,1 26581,0 26582,1 26587,0 26685,1 26710,0 26753,1 26764,0 26782,1 26842,0 26843,1 26861,0 26862,1 26947,0 26960,1 26978,0 27060,1 27114,0 27190,1 27243,0 27265,1 27360,0 27458,1 27539,0 27629,1 27692,0 27738,1 27802,0 27818,1 27897,0 27976,1 28043,0 28130,1 28143,0 28242,1 28300,0 28317,1 28410,0 28501,1 28551,0 28622,1 28700,0 28746,1 28766,0 28812,1 28836,0 28843,1 28926,0 28956,1 28991,0 29011,1 29105,0 29202,1 29287,0 29321,1 29348,0 29425,1 29512,0 29527,1 29579,0 29623,1 29632,0 29678,1 29768,0 29798,1 29802,0 29896,1 29925,0 29996,1 30016,0 30039,1 30069,0 30127,1 30189,0 30234,1 30250,0 30330,1 30409,0 30438,1 30505,0 30506,1 30532,0 30623,1 30646,0 30685,1 30729,0 30817,1 30828,0 30915,1 30996,0 31078,1 31111,0 31208,1 31259,0 31305,1 31342,0 31399,1 31468,0 31496,1 31578,0 31615,1 31673,0 31722,1 31811,0 31898,1 31964,0 32051,1 32060,0 32110,1 32152,0 32205,1 32242,0 32342,1 32436,0 32531,1 32605,0 32669,1 32696,0 32789,1 32841,0 32906,1 32940,0 32954,1 32965,0 32984,1 33016,0 33060,1 33100,0 33127,1 33213,0 33260,1 33355,0 33418,1 33471,0 33532,1 33618,0 33667,1 33761,0 33809,1 33821,0 33846,1 33936,0 34033,1 34120,0 34124,1 34159,0 34240,1 34268,0 34307,1 34376,0 34398,1 34416,0 34469,1 34524,0 34604,1 34664,0 34669,1 34696,0 34754,1 34806,0 34812,1 34847,0 34882,1 34950,0 34979,1 35010,0 35072,1 35073,0 35086,1 35105,0 35129,1 35167,0 35183,1 35261,0 35306,1 35356,0 35372,1 35470,0 35540,1 35608,0 35681,1 35684,0 35713,1 35783,0 35845,1 35907,0 35984,1 36000,0 36078,1 36178,0 36250,1 36312,0 36338,1 36433,0 36446,1 36492,0 36524,1 36590,0 36682,1 36725,0 36770,1 36822,0 36827,1 36840,0 36917,1 36967,0 36991,1 37022,0 37116,1 37195,0 37282,1 37351,0 37411,1 37511,0 37535,1 37588,0 37675,1 37717,0 37719,1 37740,0 37821,1 37910,0 37952,1 38013,0 38055,1 38099,0 38153,1 38236,0 38275,1 38281,0 38290,1 38318,0 38389,1 38411,0 38436,1 38495,0 38543,1 38547,0 38644,1 38661,0 38759,1 38790,0 38823,1 38889,0 38900,1 38986,0 39012,1 39078,0 39164,1 39218,0 39263,1 39320,0 39348,1 39415,0 39463,1 39472,0 39498,1 39586,0 39667,1 39693,0 39768,1 39856,0 39931,1 39991,0 40037,1 40133,0 40176,1 40270,0 40351,1 40413,0 40444,1 40456,0 40549,1 40583,0 40637,1 40695,0 40742,1 40818,0 40855,1 40930,0 40931,1 41028,0 41061,1 41088,0 41159,1 41202,0 41225,1 41275,0 41331,1 41422,0 41494,1 41542,0 41617,1 41621,0 41707,1 41791,0 41873,1 41892,0 41909,1 41912,0 41914,1 41928,0 41991,1 42039,0 42125,1 42212,0 42272,1 42357,0 42439,1 42520,0 42618,1 42629,0 42685,1 42702,0 42783,1 42809,0 42827,1 42873,0 42907,1 42937,0 42986,1 43026,0 43073,1 43168,0 43231,1 43297,0 43312,1 43358,0 43438,1 43530,0 43531,1 43557,0 43618,1 43676,0 43719,1 43738,0 43756,1 43824,0 43857,1 43905,0 43966,1 44006,0 44078,1 44090,0 44174,1 44255,0 44262,1 44321,0 44397,1 44440,0 44483,1 44545,0 44628,1 44632,0 44699,1 44776,0 44783,1 44800,0 44894,1 44916,0 44931,1 44994,0 45026,1 45045,0 45061,1 45066,0 45153,1 45247,0 45326,1 45424,0 45509,1 45513,0 45601,1 45625,0 45626,1 45668,0 45700,1 45791,0 45839,1 45896,0 45943,1 45987,0 46000,1 46099,0 46162,1 46195,0 46206,1 46288,0 46380,1 46416,0 46424,1 46474,0 46499,1 46572,0 46620,1 46649,0 46657,1 46754,0 46847,1 46901,0 46990,1 47079,0 47091,1 47181,0 47197,1 47255,0 47343,1 47403,0 47404,1 47476,0 47520,1 47545,0 47579,1 47617,0 47717,1 47763,0 47845,1 47891,0 47959,1 47992,0 48068,1 48162,0 48200,1 48239,0 48301,1 48396,0 48482,1 48522,0 48589,1 48668,0 48742,1 48744,0 48843,1 48933,0 49023,1 49061,0 49084,1 49107,0 49174,1 49240,0 49303,1 49387,0 49405,1 49504,0 49518,1 49539,0 49628,1 49709,0 49733,1 49800,0 49802,1 49859,0 49921,1 49927,0 49931,1 end initlist a41 0,0 75,1 114,0 152,1 174,0 216,1 225,0 306,1 362,0 363,1 418,0 430,1 501,0 509,1 552,0 621,1 706,0 802,1 812,0 833,1 859,0 896,1 913,0 961,1 975,0 998,1 1052,0 1092,1 1133,0 1147,1 1193,0 1227,1 1291,0 1292,1 1331,0 1378,1 1458,0 1524,1 1586,0 1656,1 1743,0 1832,1 1917,0 1982,1 2004,0 2026,1 2124,0 2137,1 2210,0 2303,1 2380,0 2411,1 2418,0 2427,1 2500,0 2580,1 2599,0 2603,1 2661,0 2760,1 2788,0 2813,1 2902,0 2978,1 2986,0 2995,1 3021,0 3082,1 3175,0 3207,1 3295,0 3391,1 3403,0 3416,1 3464,0 3519,1 3580,0 3585,1 3657,0 3707,1 3741,0 3767,1 3774,0 3794,1 3885,0 3912,1 3972,0 4032,1 4047,0 4134,1 4203,0 4221,1 4222,0 4287,1 4351,0 4370,1 4383,0 4471,1 4483,0 4553,1 4578,0 4659,1 4695,0 4703,1 4769,0 4816,1 4822,0 4829,1 4865,0 4898,1 4988,0 5027,1 5046,0 5136,1 5218,0 5297,1 5323,0 5396,1 5422,0 5497,1 5561,0 5643,1 5689,0 5697,1 5739,0 5792,1 5819,0 5892,1 5983,0 6076,1 6102,0 6135,1 6186,0 6198,1 6277,0 6357,1 6383,0 6410,1 6471,0 6523,1 6529,0 6620,1 6665,0 6679,1 6701,0 6750,1 6844,0 6941,1 6991,0 7062,1 7074,0 7127,1 7191,0 7214,1 7245,0 7344,1 7387,0 7398,1 7455,0 7518,1 7617,0 7688,1 7734,0 7823,1 7917,0 8010,1 8103,0 8193,1 8272,0 8341,1 8348,0 8365,1 8424,0 8452,1 8470,0 8532,1 8582,0 8645,1 8742,0 8837,1 8911,0 8961,1 9002,0 9049,1 9115,0 9151,1 9210,0 9285,1 9333,0 9350,1 9379,0 9394,1 9433,0 9436,1 9462,0 9494,1 9515,0 9611,1 9629,0 9645,1 9704,0 9710,1 9764,0 9768,1 9803,0 9840,1 9895,0 9925,1 9956,0 10009,1 10085,0 10127,1 10160,0 10213,1 10230,0 10276,1 10362,0 10419,1 10478,0 10563,1 10572,0 10594,1 10643,0 10731,1 10751,0 10761,1 10845,0 10924,1 11022,0 11115,1 11175,0 11263,1 11354,0 11357,1 11426,0 11489,1 11576,0 11591,1 11629,0 11726,1 11811,0 11870,1 11885,0 11887,1 11921,0 11961,1 12048,0 12133,1 12184,0 12243,1 12338,0 12343,1 12363,0 12435,1 12460,0 12464,1 12482,0 12548,1 12644,0 12650,1 12651,0 12728,1 12799,0 12848,1 12851,0 12852,1 12932,0 12977,1 13016,0 13073,1 13078,0 13149,1 13184,0 13213,1 13290,0 13342,1 13406,0 13445,1 13456,0 13528,1 13568,0 13590,1 13592,0 13680,1 13748,0 13838,1 13840,0 13867,1 13952,0 14034,1 14076,0 14145,1 14234,0 14281,1 14355,0 14434,1 14492,0 14519,1 14523,0 14588,1 14683,0 14720,1 14790,0 14854,1 14939,0 14941,1 15019,0 15058,1 15071,0 15152,1 15251,0 15267,1 15326,0 15328,1 15387,0 15444,1 15497,0 15551,1 15577,0 15613,1 15681,0 15775,1 15832,0 15928,1 15955,0 15975,1 16047,0 16074,1 16113,0 16156,1 16195,0 16229,1 16271,0 16279,1 16373,0 16452,1 16480,0 16501,1 16585,0 16588,1 16636,0 16728,1 16779,0 16855,1 16865,0 16924,1 16991,0 17073,1 17104,0 17151,1 17235,0 17285,1 17357,0 17380,1 17420,0 17491,1 17574,0 17579,1 17666,0 17766,1 17822,0 17877,1 17948,0 17950,1 18038,0 18135,1 18182,0 18259,1 18295,0 18339,1 18428,0 18471,1 18569,0 18636,1 18705,0 18714,1 18810,0 18885,1 18940,0 18950,1 18981,0 19080,1 19138,0 19182,1 19207,0 19251,1 19315,0 19389,1 19449,0 19547,1 19645,0 19715,1 19733,0 19793,1 19851,0 19927,1 19941,0 19962,1 19992,0 20057,1 20125,0 20211,1 20234,0 20281,1 20379,0 20479,1 20547,0 20585,1 20602,0 20636,1 20723,0 20798,1 20881,0 20978,1 21043,0 21061,1 21067,0 21079,1 21126,0 21157,1 21170,0 21217,1 21218,0 21246,1 21264,0 21324,1 21341,0 21384,1 21441,0 21533,1 21619,0 21669,1 21733,0 21782,1 21822,0 21884,1 21922,0 22017,1 22078,0 22096,1 22103,0 22192,1 22202,0 22255,1 22285,0 22378,1 22390,0 22449,1 22508,0 22519,1 22541,0 22547,1 22647,0 22682,1 22747,0 22808,1 22886,0 22896,1 22990,0 23057,1 23154,0 23207,1 23273,0 23299,1 23356,0 23449,1 23491,0 23526,1 23601,0 23635,1 23678,0 23703,1 23763,0 23853,1 23950,0 23961,1 24008,0 24083,1 24113,0 24167,1 24238,0 24299,1 24362,0 24372,1 24380,0 24417,1 24440,0 24521,1 24535,0 24565,1 24606,0 24706,1 24787,0 24874,1 24964,0 24990,1 25061,0 25156,1 25227,0 25313,1 25362,0 25393,1 25442,0 25481,1 25569,0 25576,1 25601,0 25693,1 25734,0 25777,1 25806,0 25905,1 25951,0 25986,1 26008,0 26057,1 26084,0 26170,1 26217,0 26282,1 26350,0 26404,1 26467,0 26525,1 26582,0 26652,1 26713,0 26808,1 26846,0 26885,1 26926,0 26987,1 27048,0 27079,1 27089,0 27147,1 27231,0 27241,1 27293,0 27388,1 27454,0 27490,1 27515,0 27567,1 27602,0 27648,1 27661,0 27748,1 27838,0 27857,1 27913,0 27968,1 28012,0 28057,1 28143,0 28156,1 28194,0 28293,1 28364,0 28406,1 28503,0 28509,1 28557,0 28565,1 28617,0 28624,1 28706,0 28802,1 28808,0 28843,1 28883,0 28974,1 28988,0 29064,1 29164,0 29250,1 29311,0 29349,1 29356,0 29415,1 29476,0 29512,1 29535,0 29604,1 29621,0 29662,1 29753,0 29807,1 29876,0 29924,1 29989,0 29996,1 30016,0 30107,1 30116,0 30154,1 30207,0 30305,1 30386,0 30403,1 30470,0 30490,1 30547,0 30587,1 30606,0 30667,1 30690,0 30785,1 30792,0 30843,1 30920,0 31004,1 31104,0 31131,1 31231,0 31303,1 31359,0 31436,1 31495,0 31552,1 31598,0 31616,1 31713,0 31719,1 31729,0 31740,1 31817,0 31826,1 31852,0 31893,1 31969,0 32023,1 32078,0 32103,1 32141,0 32176,1 32213,0 32277,1 32280,0 32364,1 32459,0 32546,1 32602,0 32640,1 32696,0 32722,1 32768,0 32820,1 32830,0 32855,1 32951,0 32982,1 32998,0 33000,1 33035,0 33130,1 33161,0 33217,1 33314,0 33407,1 33490,0 33538,1 33638,0 33700,1 33740,0 33749,1 33776,0 33825,1 33873,0 33969,1 33985,0 34003,1 34026,0 34074,1 34113,0 34136,1 34190,0 34214,1 34299,0 34362,1 34364,0 34384,1 34449,0 34519,1 34555,0 34603,1 34672,0 34680,1 34693,0 34712,1 34741,0 34808,1 34901,0 34980,1 35002,0 35056,1 35089,0 35100,1 35165,0 35181,1 35208,0 35274,1 35326,0 35388,1 35389,0 35470,1 35471,0 35567,1 35574,0 35580,1 35624,0 35697,1 35698,0 35700,1 35790,0 35869,1 35890,0 35931,1 35997,0 36012,1 36098,0 36171,1 36182,0 36269,1 36332,0 36388,1 36409,0 36488,1 36508,0 36581,1 36655,0 36662,1 36692,0 36700,1 36737,0 36809,1 36853,0 36945,1 37007,0 37008,1 37023,0 37085,1 37123,0 37196,1 37294,0 37335,1 37414,0 37425,1 37463,0 37536,1 37555,0 37608,1 37693,0 37721,1 37819,0 37909,1 37931,0 38001,1 38035,0 38109,1 38155,0 38224,1 38301,0 38346,1 38407,0 38413,1 38493,0 38575,1 38634,0 38698,1 38759,0 38806,1 38902,0 38910,1 38943,0 39037,1 39086,0 39166,1 39175,0 39247,1 39248,0 39294,1 39350,0 39433,1 39525,0 39556,1 39587,0 39654,1 39711,0 39751,1 39757,0 39816,1 39898,0 39984,1 40000,0 40012,1 40064,0 40141,1 40237,0 40273,1 40365,0 40412,1 40500,0 40598,1 40695,0 40774,1 40828,0 40916,1 40948,0 41008,1 41043,0 41085,1 41086,0 41135,1 41168,0 41183,1 41226,0 41280,1 41366,0 41444,1 41512,0 41566,1 41573,0 41588,1 41624,0 41723,1 41734,0 41828,1 41846,0 41913,1 41957,0 41976,1 42048,0 42104,1 42114,0 42129,1 42178,0 42226,1 42295,0 42311,1 42382,0 42447,1 42511,0 42573,1 42619,0 42694,1 42785,0 42839,1 42912,0 42925,1 42980,0 43013,1 43085,0 43153,1 43209,0 43301,1 43348,0 43448,1 43459,0 43481,1 43510,0 43607,1 43660,0 43697,1 43704,0 43738,1 43804,0 43902,1 43991,0 43994,1 44010,0 44105,1 44180,0 44227,1 44270,0 44304,1 44337,0 44355,1 44454,0 44479,1 44507,0 44595,1 44601,0 44608,1 44630,0 44715,1 44725,0 44737,1 44768,0 44799,1 44886,0 44938,1 44993,0 45011,1 45066,0 45159,1 45245,0 45268,1 45326,0 45411,1 45441,0 45494,1 45509,0 45563,1 45596,0 45671,1 45692,0 45787,1 45812,0 45905,1 45962,0 45975,1 45990,0 46053,1 46123,0 46160,1 46239,0 46330,1 46392,0 46485,1 46582,0 46643,1 46661,0 46694,1 46728,0 46748,1 46756,0 46763,1 46788,0 46795,1 46895,0 46945,1 46951,0 47047,1 47066,0 47121,1 47157,0 47213,1 47239,0 47335,1 47404,0 47457,1 47542,0 47619,1 47637,0 47712,1 47728,0 47765,1 47863,0 47939,1 48039,0 48109,1 48134,0 48200,1 48224,0 48243,1 48248,0 48305,1 48337,0 48375,1 48402,0 48461,1 48532,0 48594,1 48646,0 48656,1 48697,0 48717,1 48770,0 48856,1 48862,0 48921,1 48933,0 48956,1 49031,0 49125,1 49172,0 49252,1 49297,0 49302,1 49366,0 49368,1 49449,0 49496,1 49511,0 49571,1 49653,0 49727,1 49793,0 49805,1 49827,0 49880,1 49963,0 50017,1 50042,0 50082,1 50151,0 50165,1 50199,0 50213,1 50242,0 50315,1 end initlist a42 0,0 93,1 129,0 192,1 215,0 247,1 308,0 372,1 394,0 469,1 515,0 558,1 626,0 686,1 713,0 797,1 824,0 917,1 930,0 1030,1 1117,0 1202,1 1291,0 1370,1 1467,0 1472,1 1538,0 1556,1 1600,0 1641,1 1689,0 1729,1 1818,0 1850,1 1901,0 1946,1 1972,0 2037,1 2068,0 2102,1 2135,0 2184,1 2268,0 2357,1 2372,0 2410,1 2498,0 2549,1 2550,0 2591,1 2629,0 2655,1 2692,0 2745,1 2812,0 2867,1 2881,0 2890,1 2988,0 2990,1 3090,0 3180,1 3210,0 3281,1 3375,0 3401,1 3440,0 3444,1 3529,0 3612,1 3630,0 3685,1 3710,0 3735,1 3828,0 3888,1 3913,0 3977,1 4012,0 4077,1 4125,0 4213,1 4226,0 4243,1 4257,0 4274,1 4372,0 4439,1 4489,0 4559,1 4602,0 4682,1 4698,0 4776,1 4810,0 4859,1 4946,0 4998,1 5068,0 5070,1 5078,0 5109,1 5130,0 5138,1 5149,0 5247,1 5261,0 5353,1 5424,0 5479,1 5572,0 5585,1 5684,0 5750,1 5779,0 5816,1 5887,0 5919,1 5963,0 5964,1 6000,0 6078,1 6103,0 6164,1 6256,0 6337,1 6364,0 6366,1 6396,0 6490,1 6563,0 6624,1 6723,0 6755,1 6782,0 6882,1 6909,0 7006,1 7104,0 7181,1 7233,0 7302,1 7380,0 7458,1 7538,0 7556,1 7572,0 7627,1 7694,0 7750,1 7818,0 7903,1 7971,0 7989,1 8001,0 8036,1 8087,0 8147,1 8148,0 8217,1 8221,0 8260,1 8296,0 8301,1 8346,0 8418,1 8445,0 8458,1 8541,0 8561,1 8587,0 8595,1 8672,0 8673,1 8682,0 8762,1 8862,0 8879,1 8915,0 8988,1 9022,0 9071,1 9111,0 9167,1 9213,0 9275,1 9321,0 9406,1 9470,0 9569,1 9644,0 9679,1 9710,0 9809,1 9830,0 9873,1 9944,0 10036,1 10049,0 10097,1 10197,0 10240,1 10297,0 10319,1 10361,0 10388,1 10390,0 10449,1 10475,0 10515,1 10544,0 10574,1 10621,0 10631,1 10658,0 10690,1 10719,0 10776,1 10801,0 10833,1 10923,0 10954,1 11048,0 11076,1 11106,0 11196,1 11234,0 11286,1 11325,0 11343,1 11435,0 11518,1 11614,0 11671,1 11731,0 11741,1 11795,0 11866,1 11964,0 12010,1 12036,0 12064,1 12101,0 12123,1 12175,0 12249,1 12295,0 12324,1 12374,0 12453,1 12542,0 12611,1 12702,0 12798,1 12896,0 12921,1 12963,0 13003,1 13044,0 13144,1 13163,0 13263,1 13339,0 13356,1 13402,0 13496,1 13565,0 13597,1 13641,0 13667,1 13745,0 13820,1 13918,0 14012,1 14092,0 14191,1 14192,0 14238,1 14244,0 14329,1 14376,0 14462,1 14521,0 14536,1 14598,0 14692,1 14787,0 14818,1 14901,0 14954,1 15048,0 15118,1 15215,0 15308,1 15397,0 15435,1 15527,0 15601,1 15618,0 15702,1 15729,0 15816,1 15828,0 15910,1 15962,0 15980,1 15999,0 16074,1 16116,0 16215,1 16307,0 16344,1 16400,0 16427,1 16512,0 16582,1 16616,0 16679,1 16777,0 16843,1 16918,0 16921,1 16962,0 16993,1 17057,0 17097,1 17149,0 17211,1 17243,0 17282,1 17284,0 17371,1 17428,0 17479,1 17569,0 17618,1 17619,0 17705,1 17761,0 17772,1 17791,0 17890,1 17950,0 18042,1 18055,0 18115,1 18150,0 18235,1 18324,0 18380,1 18448,0 18465,1 18564,0 18646,1 18701,0 18797,1 18831,0 18832,1 18920,0 18932,1 18983,0 18994,1 19021,0 19040,1 19066,0 19089,1 19182,0 19210,1 19303,0 19329,1 19361,0 19389,1 19412,0 19417,1 19485,0 19546,1 19571,0 19588,1 19591,0 19622,1 19677,0 19718,1 19734,0 19745,1 19765,0 19844,1 19934,0 19968,1 20016,0 20104,1 20200,0 20260,1 20302,0 20338,1 20412,0 20480,1 20533,0 20613,1 20657,0 20672,1 20718,0 20798,1 20861,0 20936,1 20992,0 21087,1 21094,0 21181,1 21233,0 21314,1 21370,0 21459,1 21468,0 21567,1 21591,0 21633,1 21681,0 21695,1 21710,0 21786,1 21790,0 21828,1 21882,0 21886,1 21945,0 21995,1 22045,0 22076,1 22100,0 22160,1 22256,0 22263,1 22298,0 22369,1 22434,0 22463,1 22511,0 22568,1 22650,0 22678,1 22725,0 22741,1 22837,0 22869,1 22926,0 22977,1 22986,0 23008,1 23071,0 23074,1 23121,0 23186,1 23260,0 23352,1 23440,0 23461,1 23523,0 23561,1 23627,0 23662,1 23681,0 23774,1 23778,0 23876,1 23953,0 23972,1 23992,0 24053,1 24133,0 24147,1 24236,0 24274,1 24289,0 24293,1 24363,0 24396,1 24425,0 24501,1 24515,0 24606,1 24679,0 24754,1 24817,0 24819,1 24869,0 24893,1 24959,0 25005,1 25105,0 25113,1 25207,0 25212,1 25301,0 25364,1 25398,0 25465,1 25537,0 25573,1 25613,0 25640,1 25708,0 25726,1 25761,0 25773,1 25808,0 25837,1 25920,0 25986,1 26030,0 26088,1 26139,0 26180,1 26224,0 26246,1 26265,0 26302,1 26375,0 26440,1 26506,0 26533,1 26613,0 26669,1 26721,0 26763,1 26787,0 26801,1 26854,0 26863,1 26897,0 26974,1 27037,0 27061,1 27108,0 27173,1 27236,0 27249,1 27336,0 27416,1 27484,0 27509,1 27606,0 27637,1 27685,0 27694,1 27751,0 27757,1 27801,0 27861,1 27950,0 28023,1 28085,0 28095,1 28171,0 28229,1 28293,0 28360,1 28428,0 28510,1 28567,0 28613,1 28697,0 28773,1 28817,0 28885,1 28902,0 28996,1 29015,0 29087,1 29141,0 29237,1 29291,0 29333,1 29344,0 29393,1 29463,0 29545,1 29581,0 29667,1 29707,0 29739,1 29835,0 29847,1 29934,0 30030,1 30052,0 30089,1 30148,0 30210,1 30231,0 30306,1 30387,0 30471,1 30506,0 30534,1 30623,0 30672,1 30766,0 30860,1 30876,0 30949,1 30974,0 30995,1 31088,0 31118,1 31128,0 31175,1 31210,0 31273,1 31283,0 31300,1 31358,0 31373,1 31383,0 31453,1 31466,0 31496,1 31544,0 31614,1 31648,0 31727,1 31822,0 31899,1 31947,0 32007,1 32039,0 32098,1 32173,0 32271,1 32290,0 32292,1 32341,0 32344,1 32413,0 32431,1 32522,0 32532,1 32591,0 32634,1 32733,0 32792,1 32833,0 32895,1 32976,0 33023,1 33052,0 33132,1 33139,0 33204,1 33207,0 33276,1 33333,0 33383,1 33442,0 33447,1 33542,0 33569,1 33656,0 33701,1 33718,0 33747,1 33814,0 33825,1 33827,0 33919,1 33938,0 34018,1 34103,0 34173,1 34204,0 34219,1 34268,0 34292,1 34377,0 34448,1 34527,0 34538,1 34546,0 34635,1 34647,0 34697,1 34705,0 34792,1 34835,0 34893,1 34917,0 34993,1 35037,0 35060,1 35134,0 35152,1 35172,0 35175,1 35200,0 35261,1 35271,0 35289,1 35308,0 35315,1 35346,0 35359,1 35390,0 35415,1 35469,0 35497,1 35519,0 35598,1 35677,0 35732,1 35769,0 35797,1 35887,0 35890,1 35900,0 35917,1 35978,0 35998,1 36030,0 36075,1 36126,0 36219,1 36234,0 36254,1 36329,0 36388,1 36453,0 36502,1 36510,0 36511,1 36592,0 36665,1 36708,0 36737,1 36786,0 36813,1 36839,0 36916,1 36935,0 37012,1 37108,0 37208,1 37242,0 37270,1 37370,0 37371,1 37437,0 37447,1 37465,0 37486,1 37567,0 37612,1 37701,0 37784,1 37803,0 37846,1 37896,0 37964,1 38041,0 38054,1 38091,0 38147,1 38162,0 38226,1 38261,0 38322,1 38399,0 38404,1 38446,0 38507,1 38565,0 38654,1 38744,0 38746,1 38775,0 38807,1 38845,0 38897,1 38907,0 38986,1 39056,0 39116,1 39164,0 39254,1 39276,0 39365,1 39391,0 39408,1 39420,0 39479,1 39493,0 39535,1 39577,0 39629,1 39685,0 39695,1 39713,0 39807,1 39854,0 39859,1 39935,0 39990,1 40088,0 40117,1 40198,0 40200,1 40276,0 40343,1 40352,0 40450,1 40522,0 40549,1 40568,0 40623,1 40676,0 40770,1 40776,0 40864,1 40957,0 41043,1 41094,0 41156,1 41243,0 41302,1 41318,0 41328,1 41397,0 41474,1 41573,0 41608,1 41648,0 41746,1 41836,0 41877,1 41890,0 41953,1 42032,0 42057,1 42105,0 42106,1 42162,0 42248,1 42321,0 42386,1 42413,0 42470,1 42492,0 42540,1 42621,0 42626,1 42716,0 42751,1 42789,0 42815,1 42882,0 42911,1 42959,0 42976,1 43032,0 43094,1 43125,0 43146,1 43154,0 43191,1 43222,0 43318,1 43363,0 43416,1 43504,0 43581,1 43643,0 43703,1 43736,0 43807,1 43868,0 43916,1 43932,0 43948,1 44038,0 44044,1 44138,0 44216,1 44252,0 44349,1 44422,0 44473,1 44522,0 44558,1 44568,0 44652,1 44688,0 44734,1 44810,0 44823,1 44895,0 44931,1 45029,0 45115,1 45161,0 45165,1 45183,0 45270,1 45360,0 45394,1 45421,0 45518,1 45554,0 45559,1 45658,0 45719,1 45818,0 45854,1 45863,0 45923,1 45971,0 45986,1 46068,0 46071,1 46092,0 46181,1 46226,0 46231,1 46258,0 46305,1 46313,0 46335,1 46372,0 46426,1 46433,0 46465,1 46501,0 46591,1 46659,0 46695,1 46787,0 46829,1 46852,0 46857,1 46872,0 46954,1 47034,0 47074,1 47114,0 47196,1 47248,0 47250,1 47274,0 47360,1 47459,0 47491,1 47570,0 47571,1 47579,0 47654,1 47751,0 47787,1 47820,0 47840,1 47912,0 48011,1 48034,0 48125,1 48162,0 48252,1 48274,0 48324,1 48369,0 48456,1 48481,0 48492,1 48570,0 48652,1 48744,0 48806,1 48899,0 48987,1 49024,0 49111,1 49158,0 49215,1 49301,0 49380,1 49451,0 49541,1 49632,0 49634,1 49663,0 49710,1 49761,0 49841,1 49857,0 49884,1 49983,0 50077,1 50117,0 50213,1 50227,0 50293,1 50381,0 50447,1 50455,0 50478,1 50540,0 50565,1 end initlist a43 0,0 7,1 105,0 109,1 135,0 165,1 216,0 232,1 237,0 291,1 383,0 453,1 507,0 515,1 593,0 642,1 694,0 723,1 728,0 776,1 850,0 927,1 932,0 969,1 1007,0 1011,1 1076,0 1139,1 1215,0 1259,1 1282,0 1311,1 1400,0 1480,1 1580,0 1642,1 1742,0 1842,1 1875,0 1974,1 2041,0 2054,1 2068,0 2147,1 2220,0 2290,1 2335,0 2392,1 2429,0 2454,1 2539,0 2617,1 2697,0 2793,1 2838,0 2924,1 2997,0 3024,1 3110,0 3185,1 3253,0 3293,1 3377,0 3467,1 3551,0 3618,1 3679,0 3698,1 3741,0 3840,1 3872,0 3894,1 3952,0 3976,1 4074,0 4151,1 4230,0 4243,1 4261,0 4298,1 4334,0 4349,1 4390,0 4397,1 4436,0 4499,1 4524,0 4571,1 4667,0 4721,1 4812,0 4856,1 4858,0 4919,1 4978,0 5075,1 5082,0 5153,1 5252,0 5254,1 5346,0 5377,1 5463,0 5527,1 5560,0 5645,1 5728,0 5802,1 5858,0 5870,1 5880,0 5947,1 6007,0 6082,1 6182,0 6188,1 6234,0 6262,1 6307,0 6355,1 6375,0 6391,1 6417,0 6501,1 6551,0 6615,1 6617,0 6709,1 6728,0 6801,1 6893,0 6961,1 7026,0 7078,1 7131,0 7134,1 7175,0 7184,1 7187,0 7218,1 7228,0 7288,1 7292,0 7391,1 7488,0 7554,1 7608,0 7674,1 7744,0 7772,1 7787,0 7807,1 7869,0 7920,1 7950,0 8009,1 8105,0 8120,1 8182,0 8210,1 8225,0 8309,1 8331,0 8393,1 8492,0 8555,1 8582,0 8641,1 8661,0 8708,1 8760,0 8833,1 8898,0 8924,1 8958,0 9006,1 9011,0 9082,1 9133,0 9195,1 9223,0 9252,1 9281,0 9345,1 9360,0 9370,1 9403,0 9486,1 9575,0 9590,1 9595,0 9631,1 9643,0 9723,1 9798,0 9805,1 9811,0 9838,1 9879,0 9970,1 10063,0 10159,1 10244,0 10317,1 10345,0 10418,1 10429,0 10473,1 10534,0 10568,1 10639,0 10732,1 10808,0 10849,1 10908,0 10997,1 11018,0 11106,1 11109,0 11195,1 11289,0 11303,1 11313,0 11394,1 11418,0 11483,1 11537,0 11632,1 11715,0 11791,1 11804,0 11894,1 11986,0 12040,1 12116,0 12145,1 12232,0 12298,1 12356,0 12357,1 12380,0 12444,1 12481,0 12516,1 12519,0 12549,1 12567,0 12643,1 12661,0 12669,1 12765,0 12794,1 12876,0 12911,1 12912,0 12964,1 13027,0 13035,1 13084,0 13109,1 13146,0 13201,1 13281,0 13313,1 13402,0 13463,1 13470,0 13482,1 13556,0 13591,1 13679,0 13724,1 13765,0 13788,1 13888,0 13957,1 14011,0 14110,1 14136,0 14155,1 14166,0 14201,1 14237,0 14318,1 14356,0 14430,1 14475,0 14515,1 14541,0 14558,1 14569,0 14592,1 14666,0 14712,1 14785,0 14799,1 14858,0 14942,1 14962,0 14967,1 15022,0 15046,1 15139,0 15195,1 15265,0 15352,1 15424,0 15445,1 15482,0 15558,1 15613,0 15705,1 15801,0 15844,1 15851,0 15899,1 15997,0 16021,1 16105,0 16162,1 16168,0 16252,1 16341,0 16366,1 16456,0 16489,1 16567,0 16629,1 16673,0 16765,1 16865,0 16877,1 16972,0 17068,1 17151,0 17222,1 17268,0 17363,1 17391,0 17468,1 17544,0 17603,1 17674,0 17760,1 17778,0 17790,1 17869,0 17935,1 18035,0 18104,1 18145,0 18185,1 18269,0 18331,1 18403,0 18437,1 18473,0 18514,1 18555,0 18575,1 18627,0 18701,1 18712,0 18781,1 18828,0 18864,1 18883,0 18888,1 18950,0 19014,1 19063,0 19081,1 19117,0 19190,1 19251,0 19330,1 19411,0 19489,1 19525,0 19563,1 19634,0 19637,1 19692,0 19785,1 19841,0 19861,1 19953,0 19987,1 20069,0 20093,1 20150,0 20152,1 20205,0 20247,1 20324,0 20328,1 20338,0 20432,1 20440,0 20470,1 20570,0 20667,1 20714,0 20730,1 20827,0 20915,1 20969,0 21044,1 21134,0 21139,1 21185,0 21232,1 21258,0 21277,1 21367,0 21389,1 21423,0 21448,1 21482,0 21581,1 21635,0 21661,1 21667,0 21705,1 21723,0 21808,1 21816,0 21836,1 21855,0 21886,1 21981,0 22049,1 22117,0 22170,1 22194,0 22251,1 22260,0 22306,1 22329,0 22404,1 22451,0 22475,1 22508,0 22608,1 22615,0 22633,1 22707,0 22805,1 22885,0 22891,1 22893,0 22925,1 22995,0 23076,1 23144,0 23220,1 23268,0 23270,1 23338,0 23356,1 23358,0 23368,1 23378,0 23426,1 23520,0 23535,1 23544,0 23579,1 23664,0 23710,1 23799,0 23813,1 23889,0 23977,1 24062,0 24120,1 24138,0 24235,1 24248,0 24267,1 24286,0 24328,1 24426,0 24446,1 24496,0 24497,1 24588,0 24663,1 24707,0 24794,1 24894,0 24930,1 24993,0 25080,1 25091,0 25167,1 25189,0 25202,1 25238,0 25290,1 25364,0 25405,1 25503,0 25535,1 25546,0 25633,1 25698,0 25789,1 25812,0 25865,1 25898,0 25996,1 26080,0 26113,1 26166,0 26176,1 26203,0 26296,1 26328,0 26388,1 26467,0 26567,1 26646,0 26690,1 26729,0 26773,1 26859,0 26925,1 26989,0 27042,1 27142,0 27145,1 27227,0 27320,1 27331,0 27351,1 27448,0 27535,1 27602,0 27624,1 27649,0 27711,1 27808,0 27862,1 27904,0 28001,1 28075,0 28173,1 28197,0 28261,1 28317,0 28386,1 28388,0 28464,1 28495,0 28537,1 28619,0 28644,1 28696,0 28780,1 28839,0 28932,1 28976,0 29048,1 29118,0 29155,1 29207,0 29287,1 29354,0 29385,1 29449,0 29549,1 29557,0 29636,1 29691,0 29715,1 29757,0 29800,1 29841,0 29892,1 29935,0 29996,1 30001,0 30055,1 30090,0 30120,1 30198,0 30217,1 30229,0 30245,1 30253,0 30314,1 30401,0 30433,1 30472,0 30566,1 30654,0 30665,1 30744,0 30824,1 30856,0 30912,1 30917,0 30966,1 31037,0 31051,1 31111,0 31189,1 31244,0 31322,1 31339,0 31366,1 31380,0 31473,1 31497,0 31576,1 31598,0 31602,1 31650,0 31663,1 31761,0 31782,1 31872,0 31881,1 31964,0 32010,1 32096,0 32143,1 32150,0 32237,1 32252,0 32267,1 32303,0 32379,1 32386,0 32443,1 32454,0 32478,1 32500,0 32559,1 32591,0 32684,1 32701,0 32741,1 32795,0 32888,1 32954,0 33029,1 33094,0 33193,1 33201,0 33237,1 33245,0 33337,1 33417,0 33422,1 33434,0 33460,1 33468,0 33567,1 33635,0 33703,1 33796,0 33851,1 33887,0 33973,1 34067,0 34112,1 34117,0 34199,1 34233,0 34253,1 34309,0 34376,1 34456,0 34472,1 34563,0 34623,1 34660,0 34749,1 34843,0 34894,1 34966,0 35060,1 35144,0 35189,1 35197,0 35286,1 35334,0 35408,1 35482,0 35572,1 35608,0 35699,1 35768,0 35784,1 35828,0 35847,1 35872,0 35932,1 35978,0 36046,1 36069,0 36168,1 36178,0 36240,1 36247,0 36342,1 36435,0 36470,1 36507,0 36589,1 36638,0 36640,1 36661,0 36740,1 36836,0 36874,1 36895,0 36922,1 36928,0 36933,1 36935,0 37003,1 37085,0 37177,1 37220,0 37223,1 37307,0 37343,1 37423,0 37485,1 37556,0 37584,1 37667,0 37738,1 37769,0 37811,1 37910,0 37940,1 38008,0 38074,1 38106,0 38147,1 38230,0 38234,1 38334,0 38383,1 38396,0 38424,1 38461,0 38536,1 38614,0 38706,1 38711,0 38763,1 38810,0 38892,1 38945,0 39029,1 39057,0 39127,1 39154,0 39182,1 39221,0 39284,1 39312,0 39366,1 39466,0 39532,1 39591,0 39613,1 39679,0 39687,1 39708,0 39727,1 39804,0 39827,1 39862,0 39945,1 39996,0 40091,1 40160,0 40183,1 40213,0 40238,1 40244,0 40312,1 40363,0 40440,1 40517,0 40550,1 40583,0 40673,1 40723,0 40779,1 40790,0 40872,1 40904,0 40991,1 40993,0 41011,1 41111,0 41172,1 41217,0 41220,1 41262,0 41360,1 41441,0 41516,1 41538,0 41569,1 41615,0 41661,1 41691,0 41728,1 41826,0 41843,1 41943,0 42036,1 42120,0 42167,1 42168,0 42175,1 42238,0 42268,1 42325,0 42406,1 42485,0 42566,1 42653,0 42714,1 42734,0 42741,1 42752,0 42851,1 42907,0 43002,1 43068,0 43154,1 43215,0 43276,1 43305,0 43328,1 43423,0 43504,1 43517,0 43592,1 43635,0 43654,1 43746,0 43825,1 43858,0 43873,1 43876,0 43962,1 43976,0 44012,1 44061,0 44147,1 44233,0 44330,1 44368,0 44390,1 44404,0 44407,1 44440,0 44466,1 44538,0 44575,1 44603,0 44628,1 44707,0 44744,1 44821,0 44906,1 44937,0 44977,1 45029,0 45033,1 45038,0 45122,1 45190,0 45277,1 45374,0 45444,1 45543,0 45595,1 45611,0 45689,1 45762,0 45804,1 45813,0 45893,1 45949,0 45977,1 45997,0 46042,1 46130,0 46215,1 46264,0 46291,1 46347,0 46387,1 46456,0 46535,1 46577,0 46594,1 46655,0 46672,1 46721,0 46819,1 46842,0 46877,1 46929,0 47028,1 47065,0 47111,1 47116,0 47149,1 47198,0 47273,1 47298,0 47324,1 47351,0 47388,1 47460,0 47542,1 47582,0 47666,1 47692,0 47774,1 47807,0 47832,1 47860,0 47958,1 48019,0 48105,1 48124,0 48190,1 48227,0 48278,1 48376,0 48402,1 48450,0 48540,1 48634,0 48678,1 48688,0 48784,1 48851,0 48928,1 48954,0 49046,1 49097,0 49168,1 49210,0 49212,1 49262,0 49267,1 49320,0 49417,1 49436,0 49482,1 49568,0 49583,1 49612,0 49623,1 49709,0 49787,1 49805,0 49873,1 49964,0 50045,1 50105,0 50127,1 50147,0 50231,1 50275,0 50365,1 50415,0 50458,1 50553,0 50555,1 50649,0 50699,1 50789,0 50795,1 50801,0 50880,1 50911,0 50915,1 50928,0 50965,1 51037,0 51110,1 51180,0 51223,1 51260,0 51298,1 51331,0 51361,1 end initlist a44 0,0 21,1 109,0 115,1 201,0 242,1 300,0 346,1 402,0 457,1 521,0 538,1 563,0 636,1 707,0 712,1 808,0 823,1 837,0 924,1 1020,0 1029,1 1099,0 1169,1 1224,0 1309,1 1330,0 1372,1 1467,0 1479,1 1527,0 1623,1 1624,0 1688,1 1709,0 1758,1 1839,0 1862,1 1945,0 1977,1 1998,0 2070,1 2105,0 2106,1 2119,0 2198,1 2234,0 2235,1 2238,0 2256,1 2339,0 2377,1 2427,0 2504,1 2571,0 2653,1 2710,0 2742,1 2840,0 2855,1 2910,0 2920,1 2989,0 3052,1 3053,0 3145,1 3243,0 3280,1 3286,0 3380,1 3455,0 3480,1 3499,0 3553,1 3567,0 3568,1 3597,0 3661,1 3682,0 3751,1 3774,0 3866,1 3949,0 3968,1 4025,0 4032,1 4089,0 4129,1 4163,0 4252,1 4347,0 4371,1 4374,0 4468,1 4564,0 4660,1 4712,0 4743,1 4792,0 4860,1 4920,0 4958,1 5012,0 5016,1 5062,0 5144,1 5175,0 5218,1 5248,0 5306,1 5371,0 5382,1 5442,0 5501,1 5528,0 5534,1 5619,0 5620,1 5636,0 5731,1 5755,0 5828,1 5837,0 5896,1 5990,0 6076,1 6078,0 6136,1 6226,0 6257,1 6329,0 6416,1 6457,0 6468,1 6477,0 6557,1 6607,0 6698,1 6721,0 6806,1 6903,0 6928,1 6930,0 7019,1 7033,0 7123,1 7185,0 7248,1 7251,0 7323,1 7412,0 7504,1 7552,0 7598,1 7611,0 7613,1 7685,0 7692,1 7779,0 7807,1 7859,0 7890,1 7953,0 7967,1 7988,0 8075,1 8164,0 8216,1 8248,0 8344,1 8443,0 8502,1 8589,0 8636,1 8646,0 8718,1 8750,0 8830,1 8873,0 8877,1 8884,0 8889,1 8913,0 8918,1 9001,0 9019,1 9044,0 9081,1 9154,0 9203,1 9246,0 9306,1 9320,0 9416,1 9458,0 9463,1 9492,0 9588,1 9594,0 9658,1 9748,0 9792,1 9808,0 9905,1 10001,0 10064,1 10154,0 10226,1 10259,0 10262,1 10297,0 10301,1 10366,0 10402,1 10456,0 10542,1 10545,0 10557,1 10566,0 10625,1 10681,0 10731,1 10791,0 10830,1 10841,0 10912,1 10960,0 11041,1 11119,0 11133,1 11134,0 11153,1 11234,0 11289,1 11316,0 11412,1 11489,0 11514,1 11527,0 11604,1 11651,0 11684,1 11690,0 11706,1 11742,0 11760,1 11824,0 11826,1 11882,0 11919,1 12002,0 12051,1 12076,0 12172,1 12203,0 12272,1 12274,0 12281,1 12316,0 12400,1 12482,0 12538,1 12559,0 12659,1 12679,0 12768,1 12824,0 12893,1 12964,0 12983,1 12985,0 13050,1 13065,0 13105,1 13144,0 13170,1 13181,0 13190,1 13284,0 13289,1 13306,0 13326,1 13389,0 13456,1 13536,0 13559,1 13572,0 13639,1 13667,0 13677,1 13699,0 13706,1 13740,0 13768,1 13829,0 13873,1 13973,0 13975,1 14002,0 14029,1 14126,0 14127,1 14210,0 14241,1 14253,0 14301,1 14336,0 14351,1 14376,0 14410,1 14436,0 14506,1 14579,0 14626,1 14630,0 14723,1 14782,0 14829,1 14918,0 15007,1 15013,0 15074,1 15130,0 15174,1 15244,0 15309,1 15329,0 15350,1 15399,0 15433,1 15460,0 15517,1 15572,0 15668,1 15731,0 15811,1 15841,0 15920,1 15964,0 16033,1 16124,0 16205,1 16227,0 16305,1 16380,0 16436,1 16521,0 16614,1 16625,0 16722,1 16792,0 16843,1 16861,0 16910,1 16933,0 16951,1 17035,0 17073,1 17092,0 17159,1 17163,0 17242,1 17270,0 17298,1 17378,0 17393,1 17475,0 17519,1 17605,0 17653,1 17731,0 17814,1 17826,0 17896,1 17933,0 18000,1 18035,0 18084,1 18171,0 18205,1 18257,0 18328,1 18342,0 18442,1 18482,0 18570,1 18647,0 18680,1 18722,0 18776,1 18802,0 18830,1 18861,0 18949,1 18981,0 19068,1 19085,0 19112,1 19206,0 19259,1 19340,0 19389,1 19445,0 19466,1 19471,0 19517,1 19588,0 19609,1 19700,0 19751,1 19770,0 19792,1 19851,0 19951,1 20029,0 20094,1 20154,0 20195,1 20211,0 20307,1 20345,0 20352,1 20409,0 20461,1 20509,0 20564,1 20652,0 20743,1 20790,0 20849,1 20870,0 20914,1 21007,0 21099,1 21131,0 21196,1 21205,0 21263,1 21284,0 21318,1 21417,0 21503,1 21534,0 21626,1 21678,0 21713,1 21797,0 21857,1 21899,0 21922,1 21990,0 22054,1 22112,0 22149,1 22223,0 22310,1 22316,0 22359,1 22379,0 22404,1 22431,0 22480,1 22510,0 22528,1 22548,0 22579,1 22628,0 22654,1 22656,0 22707,1 22762,0 22769,1 22782,0 22785,1 22863,0 22875,1 22975,0 23011,1 23039,0 23116,1 23190,0 23213,1 23246,0 23315,1 23390,0 23424,1 23486,0 23525,1 23597,0 23676,1 23710,0 23767,1 23855,0 23877,1 23967,0 23990,1 24041,0 24083,1 24167,0 24206,1 24211,0 24264,1 24347,0 24373,1 24456,0 24477,1 24554,0 24609,1 24632,0 24720,1 24810,0 24831,1 24894,0 24991,1 25028,0 25091,1 25150,0 25199,1 25201,0 25233,1 25298,0 25393,1 25428,0 25504,1 25550,0 25571,1 25624,0 25635,1 25729,0 25820,1 25834,0 25854,1 25951,0 26022,1 26087,0 26150,1 26190,0 26210,1 26213,0 26282,1 26304,0 26327,1 26328,0 26364,1 26383,0 26464,1 26494,0 26527,1 26546,0 26603,1 26628,0 26648,1 26738,0 26788,1 26809,0 26881,1 26948,0 27011,1 27020,0 27117,1 27145,0 27199,1 27275,0 27290,1 27294,0 27369,1 27376,0 27444,1 27448,0 27497,1 27579,0 27601,1 27699,0 27760,1 27858,0 27937,1 28015,0 28087,1 28094,0 28146,1 28200,0 28216,1 28277,0 28286,1 28326,0 28404,1 28496,0 28594,1 28641,0 28692,1 28758,0 28760,1 28772,0 28801,1 28845,0 28942,1 28960,0 28968,1 29057,0 29139,1 29211,0 29302,1 29338,0 29386,1 29387,0 29447,1 29489,0 29569,1 29588,0 29622,1 29693,0 29784,1 29827,0 29915,1 29981,0 30016,1 30100,0 30127,1 30153,0 30224,1 30275,0 30281,1 30289,0 30290,1 30312,0 30407,1 30507,0 30570,1 30647,0 30713,1 30805,0 30842,1 30879,0 30908,1 30916,0 30980,1 31051,0 31144,1 31172,0 31221,1 31244,0 31321,1 31335,0 31393,1 31427,0 31476,1 31527,0 31565,1 31588,0 31617,1 31697,0 31753,1 31811,0 31871,1 31947,0 31992,1 32033,0 32097,1 32128,0 32215,1 32292,0 32308,1 32360,0 32438,1 32518,0 32600,1 32640,0 32726,1 32728,0 32745,1 32796,0 32869,1 32885,0 32930,1 32973,0 32994,1 33084,0 33150,1 33232,0 33236,1 33274,0 33323,1 33380,0 33470,1 33538,0 33602,1 33629,0 33632,1 33704,0 33790,1 33800,0 33858,1 33907,0 33987,1 33995,0 34066,1 34165,0 34203,1 34249,0 34267,1 34272,0 34358,1 34426,0 34484,1 34545,0 34634,1 34661,0 34697,1 34708,0 34770,1 34857,0 34858,1 34860,0 34935,1 35023,0 35111,1 35134,0 35198,1 35211,0 35271,1 35292,0 35329,1 35331,0 35408,1 35473,0 35526,1 35612,0 35655,1 35660,0 35714,1 35735,0 35780,1 35875,0 35923,1 35933,0 35994,1 36033,0 36087,1 36174,0 36244,1 36274,0 36315,1 36340,0 36414,1 36501,0 36587,1 36680,0 36772,1 36852,0 36936,1 36980,0 37028,1 37113,0 37181,1 37247,0 37300,1 37307,0 37403,1 37475,0 37571,1 37629,0 37687,1 37744,0 37839,1 37908,0 37991,1 37993,0 38062,1 38128,0 38159,1 38259,0 38289,1 38372,0 38386,1 38464,0 38515,1 38544,0 38597,1 38649,0 38748,1 38749,0 38831,1 38898,0 38931,1 38946,0 38982,1 39051,0 39091,1 39161,0 39214,1 39236,0 39289,1 39365,0 39376,1 39465,0 39563,1 39575,0 39609,1 39633,0 39696,1 39705,0 39748,1 39808,0 39882,1 39919,0 39994,1 40088,0 40182,1 40280,0 40302,1 40350,0 40382,1 40477,0 40494,1 40522,0 40545,1 40637,0 40730,1 40731,0 40813,1 40842,0 40894,1 40952,0 41040,1 41110,0 41190,1 41237,0 41262,1 41360,0 41430,1 41505,0 41537,1 41573,0 41663,1 41703,0 41751,1 41771,0 41852,1 41901,0 41960,1 41974,0 42013,1 42047,0 42135,1 42215,0 42290,1 42345,0 42391,1 42461,0 42519,1 42527,0 42528,1 42556,0 42581,1 42589,0 42668,1 42731,0 42796,1 42837,0 42861,1 42875,0 42923,1 43018,0 43093,1 43156,0 43176,1 43196,0 43289,1 43374,0 43453,1 43521,0 43537,1 43612,0 43660,1 43719,0 43755,1 43848,0 43867,1 43884,0 43929,1 43963,0 44008,1 44020,0 44103,1 44151,0 44162,1 44188,0 44238,1 44272,0 44310,1 44364,0 44386,1 44466,0 44471,1 44543,0 44592,1 44626,0 44696,1 44704,0 44779,1 44863,0 44908,1 44976,0 45043,1 45078,0 45101,1 45125,0 45214,1 45235,0 45333,1 45344,0 45377,1 45397,0 45479,1 45543,0 45563,1 45651,0 45732,1 45786,0 45820,1 45862,0 45899,1 45964,0 46004,1 46098,0 46143,1 46161,0 46167,1 46170,0 46197,1 46232,0 46321,1 46402,0 46465,1 46515,0 46537,1 46619,0 46712,1 46811,0 46826,1 46907,0 46976,1 46995,0 47075,1 47137,0 47213,1 47287,0 47331,1 47359,0 47404,1 47479,0 47502,1 47582,0 47650,1 47726,0 47794,1 47862,0 47929,1 47957,0 48034,1 48080,0 48141,1 48181,0 48274,1 48339,0 48356,1 48371,0 48453,1 48533,0 48620,1 48684,0 48725,1 48747,0 48836,1 48935,0 48990,1 49085,0 49160,1 49240,0 49248,1 49256,0 49339,1 49436,0 49479,1 49579,0 49651,1 49728,0 49778,1 49876,0 49952,1 49954,0 49996,1 50068,0 50147,1 50170,0 50179,1 50190,0 50213,1 50253,0 50325,1 50425,0 50499,1 end initlist a45 0,0 15,1 104,0 177,1 192,0 232,1 319,0 395,1 471,0 558,1 636,0 714,1 766,0 795,1 809,0 887,1 975,0 984,1 1017,0 1031,1 1070,0 1131,1 1181,0 1252,1 1295,0 1392,1 1438,0 1479,1 1556,0 1621,1 1708,0 1725,1 1751,0 1847,1 1937,0 1951,1 2027,0 2081,1 2085,0 2158,1 2182,0 2233,1 2290,0 2369,1 2389,0 2485,1 2521,0 2569,1 2657,0 2729,1 2753,0 2826,1 2856,0 2872,1 2898,0 2953,1 2976,0 2980,1 2989,0 3012,1 3053,0 3094,1 3177,0 3181,1 3253,0 3345,1 3398,0 3494,1 3544,0 3579,1 3656,0 3729,1 3794,0 3830,1 3854,0 3936,1 4021,0 4059,1 4115,0 4186,1 4193,0 4213,1 4225,0 4255,1 4264,0 4298,1 4321,0 4356,1 4360,0 4393,1 4407,0 4484,1 4527,0 4627,1 4708,0 4788,1 4872,0 4917,1 4920,0 4998,1 5012,0 5061,1 5097,0 5142,1 5229,0 5233,1 5242,0 5309,1 5314,0 5365,1 5433,0 5509,1 5553,0 5564,1 5662,0 5707,1 5807,0 5867,1 5936,0 6036,1 6062,0 6156,1 6250,0 6273,1 6294,0 6370,1 6395,0 6461,1 6498,0 6539,1 6600,0 6619,1 6622,0 6713,1 6722,0 6757,1 6768,0 6856,1 6927,0 6984,1 7006,0 7018,1 7105,0 7142,1 7199,0 7239,1 7328,0 7406,1 7503,0 7537,1 7586,0 7611,1 7699,0 7700,1 7718,0 7747,1 7815,0 7864,1 7903,0 7990,1 8008,0 8021,1 8037,0 8121,1 8159,0 8239,1 8258,0 8267,1 8343,0 8441,1 8475,0 8561,1 8562,0 8606,1 8668,0 8688,1 8721,0 8748,1 8751,0 8763,1 8833,0 8894,1 8981,0 9057,1 9137,0 9146,1 9233,0 9236,1 9276,0 9319,1 9368,0 9453,1 9458,0 9472,1 9497,0 9503,1 9567,0 9588,1 9595,0 9626,1 9695,0 9700,1 9703,0 9738,1 9789,0 9860,1 9919,0 9988,1 10037,0 10124,1 10154,0 10227,1 10233,0 10316,1 10387,0 10442,1 10516,0 10581,1 10636,0 10724,1 10777,0 10822,1 10823,0 10903,1 10991,0 11000,1 11006,0 11067,1 11122,0 11210,1 11225,0 11315,1 11370,0 11429,1 11478,0 11568,1 11639,0 11645,1 11726,0 11787,1 11793,0 11849,1 11865,0 11935,1 11970,0 12066,1 12126,0 12164,1 12210,0 12214,1 12235,0 12331,1 12367,0 12450,1 12489,0 12527,1 12589,0 12628,1 12689,0 12788,1 12819,0 12917,1 13013,0 13065,1 13114,0 13201,1 13277,0 13350,1 13428,0 13460,1 13527,0 13619,1 13679,0 13683,1 13776,0 13805,1 13809,0 13883,1 13932,0 13982,1 14048,0 14107,1 14155,0 14202,1 14295,0 14311,1 14398,0 14489,1 14557,0 14656,1 14744,0 14833,1 14879,0 14971,1 15053,0 15134,1 15213,0 15241,1 15291,0 15388,1 15441,0 15457,1 15476,0 15522,1 15539,0 15633,1 15670,0 15732,1 15768,0 15804,1 15819,0 15854,1 15860,0 15889,1 15944,0 15993,1 15998,0 16086,1 16170,0 16229,1 16236,0 16324,1 16360,0 16381,1 16461,0 16466,1 16541,0 16606,1 16614,0 16653,1 16671,0 16758,1 16830,0 16843,1 16852,0 16939,1 16974,0 17009,1 17080,0 17093,1 17120,0 17144,1 17151,0 17214,1 17237,0 17287,1 17317,0 17400,1 17446,0 17541,1 17572,0 17604,1 17693,0 17773,1 17804,0 17821,1 17826,0 17882,1 17885,0 17903,1 17942,0 17987,1 18064,0 18096,1 18155,0 18166,1 18188,0 18223,1 18310,0 18390,1 18482,0 18532,1 18564,0 18581,1 18617,0 18649,1 18705,0 18726,1 18747,0 18773,1 18813,0 18829,1 18911,0 18955,1 19020,0 19081,1 19139,0 19144,1 19205,0 19218,1 19318,0 19411,1 19481,0 19541,1 19590,0 19594,1 19613,0 19671,1 19738,0 19800,1 19825,0 19843,1 19897,0 19929,1 20028,0 20090,1 20190,0 20199,1 20201,0 20244,1 20291,0 20369,1 20397,0 20452,1 20501,0 20513,1 20611,0 20695,1 20704,0 20705,1 20801,0 20884,1 20925,0 20990,1 21038,0 21087,1 21181,0 21279,1 21378,0 21413,1 21445,0 21520,1 21527,0 21533,1 21593,0 21609,1 21691,0 21731,1 21734,0 21795,1 21804,0 21811,1 21898,0 21931,1 22013,0 22061,1 22122,0 22197,1 22203,0 22204,1 22287,0 22338,1 22360,0 22443,1 22452,0 22478,1 22540,0 22603,1 22636,0 22687,1 22704,0 22706,1 22715,0 22741,1 22778,0 22780,1 22802,0 22848,1 22945,0 22984,1 23003,0 23033,1 23070,0 23168,1 23256,0 23308,1 23334,0 23410,1 23433,0 23511,1 23561,0 23562,1 23629,0 23708,1 23744,0 23769,1 23785,0 23828,1 23868,0 23879,1 23887,0 23961,1 23993,0 23998,1 24054,0 24149,1 24202,0 24243,1 24267,0 24350,1 24418,0 24503,1 24550,0 24645,1 24686,0 24730,1 24782,0 24856,1 24859,0 24915,1 24950,0 25026,1 25124,0 25157,1 25205,0 25209,1 25262,0 25354,1 25409,0 25455,1 25539,0 25553,1 25606,0 25668,1 25748,0 25792,1 25821,0 25828,1 25855,0 25951,1 26005,0 26010,1 26027,0 26084,1 26092,0 26172,1 26202,0 26285,1 26327,0 26360,1 26407,0 26434,1 26449,0 26526,1 26547,0 26579,1 26600,0 26655,1 26662,0 26687,1 26695,0 26760,1 26766,0 26851,1 26852,0 26881,1 26922,0 26926,1 26986,0 27013,1 27044,0 27141,1 27187,0 27251,1 27283,0 27349,1 27386,0 27434,1 27473,0 27550,1 27614,0 27636,1 27647,0 27656,1 27731,0 27825,1 27908,0 27936,1 27963,0 28022,1 28082,0 28173,1 28251,0 28342,1 28345,0 28444,1 28449,0 28457,1 28540,0 28594,1 28692,0 28772,1 28869,0 28902,1 28977,0 28983,1 29068,0 29098,1 29112,0 29153,1 29232,0 29275,1 29351,0 29395,1 29480,0 29557,1 29563,0 29616,1 29663,0 29726,1 29804,0 29827,1 29913,0 29993,1 30081,0 30089,1 30130,0 30216,1 30308,0 30383,1 30415,0 30514,1 30604,0 30659,1 30709,0 30715,1 30791,0 30829,1 30868,0 30964,1 31054,0 31057,1 31156,0 31183,1 31246,0 31271,1 31353,0 31444,1 31457,0 31554,1 31635,0 31723,1 31742,0 31833,1 31892,0 31965,1 32058,0 32087,1 32153,0 32168,1 32195,0 32250,1 32269,0 32276,1 32321,0 32352,1 32387,0 32458,1 32471,0 32551,1 32634,0 32703,1 32760,0 32816,1 32843,0 32942,1 32985,0 32999,1 33011,0 33050,1 33109,0 33164,1 33250,0 33318,1 33396,0 33399,1 33409,0 33445,1 33514,0 33524,1 33553,0 33652,1 33676,0 33709,1 33766,0 33851,1 33865,0 33953,1 33969,0 33998,1 34069,0 34114,1 34186,0 34270,1 34275,0 34332,1 34359,0 34455,1 34500,0 34532,1 34547,0 34600,1 34663,0 34667,1 34680,0 34744,1 34795,0 34807,1 34907,0 34993,1 35001,0 35070,1 35114,0 35204,1 35251,0 35303,1 35391,0 35426,1 35494,0 35533,1 35602,0 35609,1 35703,0 35712,1 35810,0 35897,1 35927,0 36024,1 36054,0 36125,1 36133,0 36155,1 36253,0 36276,1 36281,0 36368,1 36378,0 36411,1 36482,0 36498,1 36552,0 36648,1 36737,0 36821,1 36867,0 36870,1 36945,0 36972,1 37039,0 37091,1 37182,0 37234,1 37283,0 37370,1 37422,0 37434,1 37480,0 37539,1 37563,0 37663,1 37744,0 37752,1 37811,0 37853,1 37868,0 37956,1 38033,0 38072,1 38126,0 38218,1 38234,0 38280,1 38292,0 38345,1 38408,0 38499,1 38597,0 38617,1 38669,0 38701,1 38712,0 38721,1 38785,0 38871,1 38921,0 38947,1 39001,0 39053,1 39057,0 39097,1 39117,0 39167,1 39228,0 39255,1 39264,0 39322,1 39379,0 39408,1 39465,0 39529,1 39544,0 39552,1 39559,0 39627,1 39670,0 39735,1 39742,0 39807,1 39894,0 39921,1 40017,0 40027,1 40112,0 40190,1 40258,0 40276,1 40309,0 40329,1 40410,0 40510,1 40555,0 40567,1 40583,0 40599,1 40627,0 40692,1 40716,0 40798,1 40892,0 40923,1 40939,0 40950,1 40956,0 41009,1 41038,0 41076,1 41151,0 41177,1 41273,0 41275,1 41347,0 41382,1 41477,0 41529,1 41591,0 41635,1 41718,0 41809,1 41868,0 41935,1 42014,0 42029,1 42093,0 42168,1 42222,0 42246,1 42274,0 42325,1 42354,0 42367,1 42379,0 42435,1 42484,0 42494,1 42557,0 42639,1 42699,0 42772,1 42859,0 42874,1 42913,0 42990,1 43013,0 43042,1 43111,0 43115,1 43121,0 43170,1 43267,0 43312,1 43393,0 43459,1 43519,0 43598,1 43689,0 43762,1 43848,0 43852,1 43882,0 43919,1 43989,0 44001,1 44009,0 44089,1 44140,0 44152,1 44159,0 44229,1 44239,0 44320,1 44338,0 44404,1 44442,0 44458,1 44467,0 44564,1 44577,0 44620,1 44657,0 44688,1 44702,0 44774,1 44816,0 44836,1 44906,0 44937,1 44994,0 45018,1 45094,0 45189,1 45215,0 45262,1 45273,0 45367,1 45455,0 45495,1 45595,0 45667,1 45711,0 45796,1 45869,0 45964,1 46002,0 46072,1 46081,0 46109,1 46189,0 46289,1 46387,0 46461,1 46481,0 46580,1 46660,0 46714,1 46748,0 46820,1 46881,0 46905,1 46939,0 47039,1 47051,0 47082,1 47140,0 47207,1 47212,0 47259,1 47269,0 47316,1 47410,0 47460,1 47507,0 47519,1 47612,0 47686,1 47723,0 47766,1 47791,0 47855,1 47949,0 47959,1 48034,0 48134,1 48169,0 48260,1 48350,0 48377,1 48441,0 48486,1 48517,0 48592,1 48623,0 48628,1 48667,0 48734,1 48743,0 48800,1 48880,0 48943,1 48979,0 48992,1 49089,0 49145,1 49211,0 49224,1 49254,0 49265,1 49340,0 49367,1 49393,0 49423,1 49465,0 49558,1 end initlist a46 0,0 16,1 36,0 101,1 180,0 216,1 240,0 319,1 341,0 416,1 460,0 525,1 531,0 535,1 540,0 562,1 570,0 581,1 590,0 621,1 656,0 694,1 695,0 723,1 762,0 821,1 919,0 965,1 1029,0 1070,1 1094,0 1113,1 1177,0 1241,1 1328,0 1402,1 1457,0 1476,1 1522,0 1618,1 1635,0 1723,1 1822,0 1904,1 1965,0 1994,1 2048,0 2133,1 2145,0 2148,1 2247,0 2315,1 2411,0 2425,1 2525,0 2591,1 2670,0 2720,1 2728,0 2740,1 2833,0 2922,1 2960,0 3044,1 3121,0 3146,1 3147,0 3247,1 3301,0 3302,1 3315,0 3410,1 3508,0 3601,1 3623,0 3682,1 3685,0 3773,1 3853,0 3891,1 3976,0 4035,1 4043,0 4127,1 4159,0 4204,1 4289,0 4324,1 4386,0 4480,1 4504,0 4549,1 4575,0 4658,1 4732,0 4808,1 4809,0 4875,1 4943,0 4972,1 5044,0 5083,1 5126,0 5143,1 5239,0 5260,1 5350,0 5404,1 5420,0 5435,1 5436,0 5483,1 5485,0 5550,1 5640,0 5673,1 5677,0 5722,1 5783,0 5837,1 5926,0 5933,1 6030,0 6066,1 6113,0 6130,1 6155,0 6174,1 6190,0 6244,1 6322,0 6324,1 6339,0 6380,1 6387,0 6409,1 6470,0 6475,1 6572,0 6610,1 6683,0 6700,1 6773,0 6780,1 6859,0 6911,1 6950,0 7050,1 7090,0 7125,1 7199,0 7239,1 7271,0 7346,1 7387,0 7406,1 7497,0 7551,1 7629,0 7704,1 7710,0 7810,1 7877,0 7965,1 8003,0 8009,1 8027,0 8078,1 8095,0 8130,1 8190,0 8260,1 8320,0 8338,1 8353,0 8364,1 8440,0 8520,1 8566,0 8573,1 8660,0 8731,1 8760,0 8830,1 8875,0 8955,1 9013,0 9073,1 9111,0 9210,1 9283,0 9371,1 9443,0 9491,1 9577,0 9673,1 9698,0 9796,1 9888,0 9944,1 9999,0 10027,1 10085,0 10148,1 10212,0 10217,1 10240,0 10273,1 10311,0 10406,1 10416,0 10496,1 10519,0 10538,1 10552,0 10579,1 10634,0 10707,1 10717,0 10775,1 10869,0 10945,1 11034,0 11117,1 11145,0 11211,1 11265,0 11314,1 11365,0 11459,1 11500,0 11523,1 11542,0 11591,1 11648,0 11732,1 11787,0 11797,1 11828,0 11925,1 11988,0 12003,1 12040,0 12051,1 12140,0 12185,1 12257,0 12336,1 12400,0 12420,1 12426,0 12438,1 12529,0 12606,1 12695,0 12748,1 12783,0 12863,1 12891,0 12893,1 12981,0 13045,1 13093,0 13163,1 13206,0 13265,1 13333,0 13383,1 13397,0 13485,1 13543,0 13594,1 13603,0 13687,1 13782,0 13859,1 13938,0 13986,1 14070,0 14113,1 14140,0 14233,1 14280,0 14283,1 14348,0 14382,1 14465,0 14559,1 14572,0 14589,1 14635,0 14657,1 14750,0 14781,1 14841,0 14881,1 14960,0 14967,1 15063,0 15121,1 15193,0 15229,1 15327,0 15351,1 15372,0 15423,1 15483,0 15539,1 15578,0 15585,1 15683,0 15763,1 15802,0 15847,1 15929,0 15970,1 16024,0 16071,1 16126,0 16162,1 16241,0 16326,1 16420,0 16428,1 16468,0 16534,1 16608,0 16667,1 16731,0 16781,1 16794,0 16801,1 16892,0 16899,1 16901,0 16995,1 16999,0 17025,1 17036,0 17037,1 17079,0 17163,1 17232,0 17308,1 17310,0 17334,1 17358,0 17380,1 17462,0 17504,1 17517,0 17537,1 17614,0 17674,1 17718,0 17792,1 17827,0 17880,1 17917,0 17919,1 18010,0 18029,1 18056,0 18119,1 18167,0 18229,1 18324,0 18358,1 18368,0 18425,1 18450,0 18461,1 18519,0 18541,1 18588,0 18638,1 18644,0 18710,1 18782,0 18837,1 18894,0 18981,1 19074,0 19142,1 19177,0 19198,1 19210,0 19283,1 19353,0 19447,1 19483,0 19493,1 19506,0 19517,1 19593,0 19596,1 19667,0 19686,1 19780,0 19855,1 19935,0 20016,1 20031,0 20085,1 20090,0 20098,1 20167,0 20221,1 20298,0 20330,1 20331,0 20431,1 20483,0 20515,1 20607,0 20612,1 20711,0 20789,1 20882,0 20969,1 21036,0 21123,1 21130,0 21160,1 21212,0 21240,1 21255,0 21267,1 21338,0 21383,1 21444,0 21483,1 21571,0 21671,1 21742,0 21838,1 21937,0 21976,1 21984,0 22084,1 22134,0 22161,1 22211,0 22286,1 22293,0 22306,1 22364,0 22433,1 22437,0 22496,1 22509,0 22560,1 22618,0 22658,1 22691,0 22786,1 22833,0 22872,1 22906,0 22963,1 22993,0 23027,1 23071,0 23168,1 23219,0 23249,1 23287,0 23366,1 23438,0 23477,1 23499,0 23572,1 23577,0 23636,1 23718,0 23785,1 23795,0 23867,1 23966,0 24039,1 24068,0 24151,1 24211,0 24258,1 24311,0 24370,1 24431,0 24459,1 24550,0 24647,1 24704,0 24713,1 24799,0 24834,1 24901,0 24995,1 25030,0 25104,1 25109,0 25209,1 25216,0 25302,1 25360,0 25433,1 25461,0 25541,1 25584,0 25606,1 25706,0 25760,1 25819,0 25874,1 25950,0 26043,1 26072,0 26108,1 26157,0 26228,1 26229,0 26322,1 26345,0 26412,1 26496,0 26547,1 26615,0 26684,1 26687,0 26780,1 26806,0 26874,1 26903,0 26950,1 26978,0 27067,1 27128,0 27176,1 27212,0 27276,1 27366,0 27404,1 27452,0 27458,1 27467,0 27554,1 27592,0 27675,1 27720,0 27775,1 27791,0 27815,1 27873,0 27936,1 27940,0 27963,1 27975,0 28002,1 28035,0 28126,1 28222,0 28319,1 28320,0 28374,1 28440,0 28467,1 28475,0 28552,1 28581,0 28632,1 28655,0 28732,1 28756,0 28783,1 28845,0 28905,1 28908,0 28971,1 29063,0 29137,1 29147,0 29193,1 29234,0 29253,1 29285,0 29322,1 29370,0 29412,1 29501,0 29577,1 29629,0 29670,1 29736,0 29819,1 29883,0 29904,1 29942,0 30003,1 30044,0 30079,1 30167,0 30255,1 30333,0 30408,1 30487,0 30578,1 30646,0 30667,1 30719,0 30767,1 30847,0 30934,1 30947,0 31012,1 31049,0 31071,1 31130,0 31203,1 31235,0 31313,1 31377,0 31389,1 31489,0 31525,1 31586,0 31599,1 31678,0 31755,1 31768,0 31830,1 31849,0 31901,1 31998,0 32093,1 32110,0 32205,1 32235,0 32298,1 32312,0 32341,1 32402,0 32413,1 32432,0 32505,1 32580,0 32593,1 32601,0 32605,1 32624,0 32701,1 32767,0 32795,1 32849,0 32939,1 33028,0 33096,1 33193,0 33253,1 33318,0 33406,1 33421,0 33506,1 33590,0 33611,1 33693,0 33791,1 33879,0 33956,1 34011,0 34070,1 34127,0 34164,1 34254,0 34263,1 34350,0 34378,1 34431,0 34477,1 34567,0 34629,1 34712,0 34811,1 34859,0 34934,1 34946,0 34956,1 34967,0 34989,1 35028,0 35044,1 35143,0 35189,1 35232,0 35296,1 35380,0 35421,1 35521,0 35532,1 35625,0 35703,1 35708,0 35712,1 35774,0 35831,1 35897,0 35968,1 36022,0 36092,1 36170,0 36184,1 36222,0 36296,1 36326,0 36411,1 36475,0 36508,1 36529,0 36544,1 36567,0 36578,1 36655,0 36657,1 36731,0 36741,1 36775,0 36780,1 36870,0 36954,1 36978,0 36986,1 37067,0 37085,1 37124,0 37179,1 37270,0 37294,1 37323,0 37339,1 37420,0 37428,1 37486,0 37556,1 37651,0 37679,1 37777,0 37820,1 37904,0 37959,1 38035,0 38056,1 38092,0 38124,1 38159,0 38229,1 38287,0 38352,1 38376,0 38462,1 38500,0 38552,1 38627,0 38665,1 38725,0 38737,1 38802,0 38812,1 38821,0 38845,1 38874,0 38953,1 39010,0 39070,1 39076,0 39094,1 39098,0 39179,1 39187,0 39252,1 39255,0 39313,1 39410,0 39458,1 39512,0 39543,1 39624,0 39630,1 39652,0 39715,1 39766,0 39769,1 39788,0 39792,1 39845,0 39863,1 39937,0 39980,1 40022,0 40037,1 40101,0 40145,1 40192,0 40268,1 40286,0 40362,1 40400,0 40423,1 40425,0 40434,1 40458,0 40511,1 40582,0 40584,1 40619,0 40695,1 40712,0 40812,1 40881,0 40902,1 40963,0 41048,1 41112,0 41131,1 41225,0 41305,1 41335,0 41394,1 41400,0 41416,1 41508,0 41547,1 41647,0 41736,1 41818,0 41880,1 41977,0 42073,1 42170,0 42231,1 42288,0 42357,1 42442,0 42449,1 42524,0 42604,1 42703,0 42706,1 42793,0 42866,1 42945,0 42995,1 43078,0 43152,1 43226,0 43295,1 43357,0 43437,1 43477,0 43557,1 43602,0 43653,1 43724,0 43795,1 43832,0 43846,1 43895,0 43942,1 43997,0 44023,1 44070,0 44111,1 44203,0 44261,1 44331,0 44355,1 44363,0 44445,1 44532,0 44570,1 44608,0 44668,1 44759,0 44785,1 44882,0 44976,1 45076,0 45135,1 45186,0 45237,1 45265,0 45310,1 45383,0 45448,1 45499,0 45573,1 45657,0 45683,1 45733,0 45825,1 45866,0 45910,1 45997,0 46046,1 46090,0 46183,1 46221,0 46270,1 46357,0 46406,1 46435,0 46512,1 46611,0 46689,1 46747,0 46825,1 46886,0 46951,1 47020,0 47048,1 47112,0 47141,1 47237,0 47335,1 47359,0 47441,1 47500,0 47551,1 47570,0 47572,1 47625,0 47686,1 47727,0 47747,1 47792,0 47869,1 47882,0 47955,1 48051,0 48088,1 48149,0 48159,1 48196,0 48229,1 48326,0 48344,1 48358,0 48453,1 48489,0 48505,1 48514,0 48515,1 48553,0 48635,1 48642,0 48656,1 48712,0 48750,1 48781,0 48869,1 48874,0 48948,1 48991,0 49057,1 49107,0 49181,1 49262,0 49338,1 49388,0 49458,1 49512,0 49589,1 49657,0 49672,1 49744,0 49783,1 49825,0 49840,1 49914,0 49925,1 50023,0 50043,1 50129,0 50229,1 50301,0 50314,1 50409,0 50461,1 50464,0 50483,1 50503,0 50598,1 50666,0 50703,1 50793,0 50850,1 50883,0 50921,1 51000,0 51083,1 51113,0 51117,1 51211,0 51226,1 51305,0 51343,1 end initlist a47 0,0 8,1 10,0 34,1 83,0 163,1 230,0 282,1 325,0 374,1 430,0 496,1 563,0 582,1 604,0 635,1 719,0 734,1 761,0 775,1 790,0 865,1 875,0 887,1 955,0 1001,1 1080,0 1146,1 1188,0 1219,1 1265,0 1363,1 1448,0 1469,1 1514,0 1568,1 1614,0 1643,1 1726,0 1737,1 1815,0 1824,1 1899,0 1913,1 2002,0 2035,1 2086,0 2164,1 2192,0 2219,1 2224,0 2238,1 2293,0 2335,1 2390,0 2428,1 2479,0 2573,1 2597,0 2606,1 2689,0 2786,1 2790,0 2830,1 2899,0 2972,1 3051,0 3060,1 3078,0 3127,1 3137,0 3208,1 3299,0 3325,1 3423,0 3447,1 3540,0 3637,1 3712,0 3717,1 3741,0 3812,1 3828,0 3842,1 3922,0 3930,1 3939,0 4033,1 4094,0 4129,1 4142,0 4226,1 4296,0 4395,1 4414,0 4482,1 4576,0 4599,1 4678,0 4696,1 4699,0 4765,1 4865,0 4918,1 4969,0 5003,1 5028,0 5119,1 5203,0 5205,1 5216,0 5229,1 5240,0 5260,1 5275,0 5297,1 5361,0 5455,1 5499,0 5577,1 5596,0 5655,1 5672,0 5693,1 5776,0 5793,1 5872,0 5890,1 5987,0 6010,1 6100,0 6164,1 6196,0 6203,1 6244,0 6287,1 6364,0 6440,1 6470,0 6555,1 6634,0 6676,1 6747,0 6839,1 6903,0 6969,1 7068,0 7089,1 7165,0 7185,1 7246,0 7268,1 7365,0 7392,1 7438,0 7452,1 7512,0 7579,1 7623,0 7687,1 7698,0 7752,1 7773,0 7794,1 7799,0 7898,1 7924,0 8020,1 8085,0 8156,1 8189,0 8196,1 8292,0 8387,1 8439,0 8462,1 8557,0 8590,1 8680,0 8739,1 8773,0 8789,1 8790,0 8876,1 8895,0 8929,1 9019,0 9094,1 9193,0 9195,1 9276,0 9360,1 9433,0 9478,1 9565,0 9569,1 9573,0 9580,1 9656,0 9695,1 9725,0 9813,1 9889,0 9936,1 9970,0 10016,1 10077,0 10091,1 10140,0 10154,1 10244,0 10300,1 10339,0 10438,1 10495,0 10582,1 10601,0 10605,1 10694,0 10719,1 10816,0 10907,1 10951,0 11019,1 11083,0 11103,1 11135,0 11193,1 11284,0 11345,1 11442,0 11484,1 11515,0 11582,1 11628,0 11645,1 11664,0 11697,1 11724,0 11817,1 11849,0 11900,1 11944,0 12044,1 12057,0 12127,1 12158,0 12174,1 12263,0 12309,1 12382,0 12453,1 12507,0 12528,1 12600,0 12618,1 12710,0 12750,1 12847,0 12905,1 12966,0 12996,1 12998,0 13076,1 13091,0 13126,1 13128,0 13218,1 13268,0 13293,1 13332,0 13360,1 13387,0 13426,1 13492,0 13548,1 13563,0 13629,1 13714,0 13784,1 13865,0 13906,1 13948,0 13966,1 13990,0 14070,1 14109,0 14204,1 14299,0 14373,1 14447,0 14497,1 14575,0 14654,1 14707,0 14766,1 14800,0 14865,1 14924,0 14925,1 15021,0 15041,1 15115,0 15128,1 15170,0 15255,1 15345,0 15404,1 15474,0 15517,1 15554,0 15643,1 15648,0 15746,1 15752,0 15832,1 15864,0 15937,1 15954,0 16012,1 16020,0 16075,1 16175,0 16177,1 16234,0 16308,1 16384,0 16451,1 16542,0 16586,1 16647,0 16714,1 16726,0 16814,1 16869,0 16943,1 16993,0 17064,1 17133,0 17155,1 17218,0 17230,1 17288,0 17387,1 17467,0 17497,1 17567,0 17580,1 17611,0 17621,1 17713,0 17763,1 17795,0 17867,1 17913,0 18005,1 18050,0 18125,1 18222,0 18264,1 18317,0 18391,1 18413,0 18476,1 18566,0 18586,1 18677,0 18721,1 18784,0 18869,1 18877,0 18912,1 18970,0 19069,1 19076,0 19135,1 19214,0 19220,1 19300,0 19352,1 19385,0 19409,1 19502,0 19573,1 19649,0 19695,1 19729,0 19745,1 19772,0 19839,1 19886,0 19968,1 20060,0 20142,1 20198,0 20212,1 20249,0 20279,1 20333,0 20387,1 20478,0 20536,1 20579,0 20654,1 20734,0 20804,1 20874,0 20899,1 20922,0 20946,1 20951,0 21023,1 21097,0 21169,1 21246,0 21253,1 21350,0 21391,1 21446,0 21468,1 21515,0 21604,1 21692,0 21788,1 21790,0 21862,1 21930,0 21983,1 22071,0 22131,1 22167,0 22170,1 22209,0 22271,1 22318,0 22415,1 22426,0 22492,1 22528,0 22531,1 22612,0 22665,1 22761,0 22808,1 22865,0 22926,1 22947,0 22989,1 23003,0 23065,1 23085,0 23155,1 23209,0 23309,1 23317,0 23379,1 23411,0 23484,1 23522,0 23609,1 23648,0 23691,1 23732,0 23763,1 23855,0 23869,1 23963,0 24015,1 24075,0 24086,1 24162,0 24193,1 24202,0 24207,1 24273,0 24313,1 24336,0 24385,1 24460,0 24480,1 24507,0 24588,1 24589,0 24608,1 24657,0 24690,1 24733,0 24780,1 24880,0 24916,1 24985,0 25009,1 25034,0 25094,1 25151,0 25230,1 25259,0 25306,1 25347,0 25425,1 25476,0 25511,1 25576,0 25616,1 25709,0 25780,1 25834,0 25921,1 25929,0 26011,1 26032,0 26132,1 26227,0 26284,1 26300,0 26332,1 26403,0 26499,1 26561,0 26591,1 26622,0 26654,1 26677,0 26700,1 26712,0 26774,1 26841,0 26895,1 26929,0 27011,1 27082,0 27099,1 27169,0 27229,1 27325,0 27380,1 27423,0 27508,1 27520,0 27533,1 27558,0 27564,1 27658,0 27711,1 27742,0 27827,1 27922,0 27944,1 28024,0 28085,1 28163,0 28242,1 28305,0 28394,1 28414,0 28511,1 28546,0 28630,1 28668,0 28740,1 28775,0 28844,1 28901,0 28910,1 28948,0 28949,1 28997,0 29065,1 29144,0 29198,1 29265,0 29304,1 29333,0 29337,1 29338,0 29395,1 29452,0 29481,1 29576,0 29577,1 29657,0 29751,1 29778,0 29821,1 29899,0 29934,1 29969,0 29999,1 30047,0 30071,1 30116,0 30129,1 30161,0 30190,1 30269,0 30275,1 30326,0 30366,1 30408,0 30457,1 30529,0 30549,1 30565,0 30595,1 30601,0 30620,1 30633,0 30668,1 30734,0 30826,1 30925,0 31005,1 31033,0 31108,1 31176,0 31268,1 31285,0 31366,1 31410,0 31476,1 31502,0 31520,1 31600,0 31653,1 31718,0 31780,1 31849,0 31918,1 31950,0 31959,1 32004,0 32040,1 32122,0 32207,1 32300,0 32322,1 32377,0 32473,1 32529,0 32612,1 32661,0 32736,1 32786,0 32853,1 32854,0 32915,1 32970,0 33037,1 33040,0 33046,1 33122,0 33217,1 33289,0 33356,1 33446,0 33456,1 33515,0 33577,1 33587,0 33672,1 33725,0 33767,1 33841,0 33897,1 33941,0 34003,1 34067,0 34162,1 34246,0 34261,1 34317,0 34365,1 34400,0 34458,1 34548,0 34568,1 34607,0 34650,1 34681,0 34769,1 34819,0 34906,1 34925,0 34945,1 35026,0 35101,1 35103,0 35160,1 35177,0 35269,1 35322,0 35384,1 35466,0 35509,1 35548,0 35580,1 35634,0 35733,1 35735,0 35768,1 35867,0 35906,1 35913,0 36010,1 36099,0 36181,1 36198,0 36292,1 36337,0 36370,1 36454,0 36522,1 36610,0 36638,1 36656,0 36677,1 36684,0 36721,1 36800,0 36862,1 36950,0 37019,1 37022,0 37069,1 37152,0 37171,1 37254,0 37267,1 37367,0 37391,1 37473,0 37489,1 37505,0 37555,1 37635,0 37664,1 37685,0 37738,1 37791,0 37834,1 37896,0 37953,1 37992,0 38074,1 38145,0 38181,1 38219,0 38313,1 38397,0 38423,1 38486,0 38577,1 38659,0 38671,1 38679,0 38700,1 38747,0 38776,1 38851,0 38950,1 39049,0 39111,1 39173,0 39180,1 39236,0 39247,1 39303,0 39388,1 39447,0 39483,1 39515,0 39540,1 39549,0 39623,1 39629,0 39672,1 39767,0 39856,1 39877,0 39970,1 40029,0 40067,1 40110,0 40138,1 40201,0 40292,1 40320,0 40341,1 40426,0 40429,1 40517,0 40598,1 40676,0 40752,1 40835,0 40909,1 40976,0 40979,1 40982,0 40984,1 41016,0 41103,1 41197,0 41245,1 41344,0 41444,1 41501,0 41538,1 41544,0 41605,1 41697,0 41740,1 41809,0 41853,1 41870,0 41946,1 42029,0 42074,1 42078,0 42112,1 42146,0 42215,1 42246,0 42326,1 42378,0 42458,1 42508,0 42605,1 42637,0 42734,1 42804,0 42856,1 42872,0 42932,1 42939,0 42964,1 42965,0 43029,1 43098,0 43158,1 43177,0 43215,1 43293,0 43354,1 43388,0 43475,1 43553,0 43612,1 43711,0 43719,1 43816,0 43833,1 43877,0 43929,1 44001,0 44002,1 44059,0 44129,1 44170,0 44187,1 44189,0 44286,1 44326,0 44366,1 44450,0 44509,1 44591,0 44667,1 44765,0 44820,1 44916,0 44937,1 44954,0 45033,1 45101,0 45141,1 45238,0 45330,1 45419,0 45430,1 45460,0 45546,1 45596,0 45691,1 45757,0 45848,1 45857,0 45938,1 46012,0 46047,1 46137,0 46212,1 46221,0 46242,1 46327,0 46410,1 46442,0 46513,1 46545,0 46575,1 46660,0 46676,1 46775,0 46813,1 46886,0 46967,1 47050,0 47100,1 47173,0 47189,1 47277,0 47349,1 47446,0 47507,1 47603,0 47688,1 47706,0 47721,1 47755,0 47822,1 47833,0 47914,1 48011,0 48090,1 48101,0 48150,1 48234,0 48276,1 48375,0 48404,1 48416,0 48496,1 48555,0 48576,1 48584,0 48684,1 48728,0 48815,1 48905,0 49004,1 49058,0 49079,1 49154,0 49213,1 49217,0 49249,1 49346,0 49434,1 49503,0 49542,1 49590,0 49655,1 49731,0 49768,1 49784,0 49854,1 49872,0 49881,1 49925,0 49968,1 50030,0 50100,1 50106,0 50141,1 50197,0 50203,1 50251,0 50288,1 50378,0 50470,1 50495,0 50499,1 50515,0 50594,1 50636,0 50689,1 50785,0 50877,1 50918,0 50931,1 51015,0 51043,1 51108,0 51146,1 51149,0 51226,1 51299,0 51319,1 51364,0 51402,1 51492,0 51535,1 51569,0 51585,1 51683,0 51708,1 51779,0 51849,1 51939,0 51979,1 52049,0 52144,1 end initlist a48 0,0 65,1 96,0 177,1 277,0 347,1 408,0 474,1 511,0 564,1 643,0 736,1 809,0 879,1 946,0 1018,1 1032,0 1089,1 1106,0 1156,1 1227,0 1276,1 1370,0 1398,1 1448,0 1534,1 1538,0 1572,1 1614,0 1682,1 1771,0 1824,1 1876,0 1879,1 1920,0 2009,1 2106,0 2177,1 2261,0 2298,1 2310,0 2381,1 2415,0 2439,1 2474,0 2534,1 2595,0 2684,1 2702,0 2736,1 2832,0 2926,1 2934,0 2937,1 2982,0 3013,1 3035,0 3121,1 3127,0 3194,1 3212,0 3234,1 3280,0 3296,1 3368,0 3441,1 3450,0 3470,1 3538,0 3553,1 3627,0 3716,1 3809,0 3844,1 3899,0 3951,1 3954,0 4001,1 4035,0 4084,1 4096,0 4147,1 4189,0 4278,1 4290,0 4336,1 4379,0 4417,1 4453,0 4522,1 4622,0 4711,1 4762,0 4769,1 4809,0 4861,1 4875,0 4951,1 4994,0 5014,1 5036,0 5112,1 5203,0 5268,1 5362,0 5409,1 5480,0 5503,1 5528,0 5569,1 5596,0 5657,1 5732,0 5784,1 5836,0 5910,1 5993,0 6092,1 6167,0 6265,1 6347,0 6443,1 6539,0 6554,1 6582,0 6609,1 6632,0 6693,1 6720,0 6786,1 6861,0 6952,1 6965,0 7044,1 7082,0 7101,1 7133,0 7169,1 7235,0 7323,1 7367,0 7457,1 7554,0 7620,1 7655,0 7738,1 7802,0 7868,1 7932,0 7966,1 7973,0 7996,1 8038,0 8127,1 8175,0 8264,1 8352,0 8387,1 8410,0 8472,1 8564,0 8589,1 8655,0 8728,1 8757,0 8825,1 8845,0 8891,1 8981,0 9075,1 9175,0 9179,1 9189,0 9200,1 9251,0 9255,1 9327,0 9340,1 9381,0 9430,1 9449,0 9505,1 9569,0 9576,1 9614,0 9701,1 9716,0 9740,1 9772,0 9829,1 9888,0 9967,1 9975,0 9977,1 10038,0 10131,1 10208,0 10267,1 10326,0 10379,1 10437,0 10461,1 10471,0 10534,1 10633,0 10701,1 10757,0 10837,1 10936,0 10980,1 11009,0 11048,1 11096,0 11191,1 11201,0 11205,1 11264,0 11315,1 11329,0 11398,1 11472,0 11561,1 11620,0 11670,1 11745,0 11794,1 11872,0 11885,1 11916,0 11948,1 11990,0 12004,1 12074,0 12129,1 12168,0 12243,1 12254,0 12295,1 12370,0 12453,1 12515,0 12552,1 12616,0 12694,1 12767,0 12818,1 12879,0 12902,1 12934,0 12982,1 13012,0 13093,1 13177,0 13183,1 13221,0 13232,1 13261,0 13264,1 13302,0 13333,1 13412,0 13413,1 13438,0 13493,1 13496,0 13561,1 13593,0 13670,1 13735,0 13785,1 13884,0 13979,1 13995,0 14018,1 14079,0 14086,1 14144,0 14197,1 14202,0 14280,1 14346,0 14427,1 14445,0 14476,1 14541,0 14592,1 14670,0 14674,1 14740,0 14824,1 14847,0 14942,1 14963,0 14980,1 15052,0 15093,1 15187,0 15264,1 15329,0 15339,1 15420,0 15485,1 15581,0 15639,1 15657,0 15689,1 15731,0 15810,1 15812,0 15887,1 15944,0 15999,1 16037,0 16047,1 16118,0 16127,1 16160,0 16201,1 16273,0 16330,1 16353,0 16385,1 16475,0 16538,1 16612,0 16670,1 16715,0 16797,1 16802,0 16867,1 16917,0 16924,1 16986,0 17056,1 17104,0 17138,1 17139,0 17152,1 17202,0 17236,1 17305,0 17362,1 17376,0 17412,1 17476,0 17479,1 17544,0 17611,1 17640,0 17680,1 17746,0 17836,1 17884,0 17932,1 17934,0 18008,1 18041,0 18089,1 18117,0 18153,1 18157,0 18178,1 18233,0 18288,1 18337,0 18352,1 18374,0 18389,1 18446,0 18510,1 18516,0 18542,1 18626,0 18710,1 18758,0 18794,1 18796,0 18886,1 18967,0 19021,1 19046,0 19110,1 19174,0 19267,1 19286,0 19385,1 19401,0 19477,1 19506,0 19568,1 19579,0 19624,1 19633,0 19679,1 19692,0 19765,1 19857,0 19878,1 19895,0 19932,1 19939,0 19993,1 20042,0 20052,1 20125,0 20209,1 20309,0 20311,1 20352,0 20396,1 20401,0 20402,1 20472,0 20512,1 20550,0 20579,1 20648,0 20653,1 20744,0 20792,1 20834,0 20899,1 20999,0 21059,1 21095,0 21190,1 21236,0 21290,1 21376,0 21450,1 21498,0 21530,1 21612,0 21672,1 21689,0 21760,1 21826,0 21891,1 21904,0 21925,1 21948,0 22005,1 22094,0 22185,1 22212,0 22214,1 22306,0 22318,1 22359,0 22455,1 22508,0 22598,1 22622,0 22651,1 22739,0 22834,1 22840,0 22882,1 22954,0 22984,1 23004,0 23075,1 23084,0 23174,1 23255,0 23347,1 23358,0 23388,1 23427,0 23506,1 23569,0 23663,1 23718,0 23776,1 23790,0 23861,1 23917,0 23962,1 23999,0 24003,1 24063,0 24123,1 24197,0 24211,1 24279,0 24368,1 24422,0 24500,1 24568,0 24579,1 24609,0 24611,1 24612,0 24668,1 24734,0 24796,1 24849,0 24882,1 24889,0 24970,1 25003,0 25035,1 25062,0 25077,1 25124,0 25141,1 25239,0 25303,1 25380,0 25391,1 25410,0 25505,1 25541,0 25591,1 25613,0 25694,1 25778,0 25859,1 25884,0 25911,1 25990,0 26006,1 26093,0 26178,1 26258,0 26263,1 26297,0 26365,1 26413,0 26481,1 26522,0 26527,1 26622,0 26629,1 26685,0 26703,1 26748,0 26833,1 26840,0 26857,1 26944,0 26978,1 27034,0 27127,1 27201,0 27283,1 27290,0 27351,1 27378,0 27386,1 27444,0 27469,1 27556,0 27629,1 27695,0 27722,1 27782,0 27790,1 27876,0 27923,1 28010,0 28039,1 28087,0 28103,1 28111,0 28157,1 28241,0 28269,1 28360,0 28394,1 28411,0 28453,1 28511,0 28527,1 28556,0 28559,1 28585,0 28588,1 28596,0 28626,1 28656,0 28755,1 28850,0 28866,1 28953,0 28968,1 29019,0 29056,1 29062,0 29154,1 29198,0 29211,1 29227,0 29255,1 29332,0 29420,1 29460,0 29497,1 29531,0 29613,1 29682,0 29705,1 29776,0 29783,1 29864,0 29933,1 30018,0 30036,1 30083,0 30125,1 30127,0 30211,1 30301,0 30391,1 30422,0 30426,1 30501,0 30586,1 30607,0 30697,1 30726,0 30769,1 30865,0 30919,1 30989,0 30993,1 31042,0 31056,1 31131,0 31193,1 31258,0 31308,1 31400,0 31467,1 31564,0 31571,1 31671,0 31744,1 31832,0 31924,1 32010,0 32033,1 32089,0 32091,1 32148,0 32248,1 32307,0 32381,1 32450,0 32483,1 32530,0 32572,1 32659,0 32735,1 32741,0 32773,1 32788,0 32849,1 32948,0 32985,1 33061,0 33111,1 33130,0 33161,1 33224,0 33258,1 33276,0 33363,1 33451,0 33468,1 33554,0 33584,1 33674,0 33755,1 33796,0 33814,1 33892,0 33919,1 33942,0 33950,1 33985,0 34068,1 34102,0 34117,1 34160,0 34252,1 34292,0 34327,1 34338,0 34360,1 34425,0 34445,1 34466,0 34561,1 34570,0 34620,1 34702,0 34740,1 34751,0 34809,1 34816,0 34864,1 34890,0 34949,1 34991,0 35018,1 35114,0 35157,1 35197,0 35237,1 35289,0 35323,1 35399,0 35411,1 35431,0 35436,1 35488,0 35582,1 35672,0 35691,1 35740,0 35804,1 35858,0 35950,1 36021,0 36093,1 36192,0 36210,1 36239,0 36310,1 36386,0 36435,1 36459,0 36558,1 36644,0 36657,1 36660,0 36670,1 36684,0 36685,1 36760,0 36853,1 36862,0 36925,1 36953,0 37048,1 37058,0 37103,1 37203,0 37287,1 37305,0 37318,1 37324,0 37406,1 37457,0 37479,1 37492,0 37511,1 37542,0 37551,1 37637,0 37657,1 37701,0 37756,1 37757,0 37792,1 37844,0 37850,1 37851,0 37894,1 37985,0 37994,1 38052,0 38086,1 38087,0 38146,1 38166,0 38230,1 38314,0 38413,1 38486,0 38504,1 38592,0 38598,1 38679,0 38704,1 38720,0 38802,1 38841,0 38869,1 38914,0 39004,1 39048,0 39078,1 39172,0 39203,1 39242,0 39307,1 39314,0 39327,1 39341,0 39362,1 39440,0 39508,1 39577,0 39613,1 39635,0 39636,1 39675,0 39703,1 39731,0 39746,1 39825,0 39874,1 39896,0 39994,1 40033,0 40098,1 40118,0 40143,1 40236,0 40321,1 40366,0 40434,1 40477,0 40529,1 40546,0 40617,1 40620,0 40706,1 40790,0 40828,1 40830,0 40921,1 40934,0 40946,1 40996,0 41012,1 41069,0 41142,1 41201,0 41216,1 41262,0 41263,1 41361,0 41382,1 41433,0 41470,1 41512,0 41549,1 41613,0 41673,1 41727,0 41756,1 41812,0 41813,1 41910,0 41940,1 42017,0 42055,1 42153,0 42240,1 42248,0 42343,1 42383,0 42418,1 42463,0 42518,1 42538,0 42628,1 42629,0 42682,1 42757,0 42829,1 42916,0 42978,1 43065,0 43116,1 43198,0 43215,1 43310,0 43321,1 43364,0 43407,1 43505,0 43570,1 43597,0 43605,1 43661,0 43743,1 43774,0 43853,1 43882,0 43959,1 43973,0 44047,1 44138,0 44224,1 44266,0 44366,1 44459,0 44465,1 44527,0 44548,1 44549,0 44629,1 44689,0 44751,1 44759,0 44828,1 44889,0 44953,1 45016,0 45052,1 45141,0 45198,1 45280,0 45360,1 45389,0 45445,1 45495,0 45508,1 45550,0 45640,1 45641,0 45728,1 45785,0 45807,1 45889,0 45957,1 46051,0 46097,1 46145,0 46160,1 46225,0 46298,1 46375,0 46413,1 46479,0 46527,1 46549,0 46588,1 46641,0 46721,1 46735,0 46752,1 46816,0 46834,1 46845,0 46870,1 46964,0 47010,1 47079,0 47108,1 47151,0 47215,1 47233,0 47322,1 47412,0 47509,1 47533,0 47602,1 47693,0 47749,1 47754,0 47773,1 47811,0 47864,1 47896,0 47953,1 47960,0 48056,1 48151,0 48190,1 48208,0 48285,1 48317,0 48380,1 48406,0 48470,1 48508,0 48513,1 48566,0 48637,1 48663,0 48738,1 48743,0 48838,1 48852,0 48936,1 48972,0 49031,1 49065,0 49093,1 49101,0 49130,1 49180,0 49241,1 49256,0 49341,1 49405,0 49421,1 end initlist a49 0,0 20,1 38,0 111,1 139,0 150,1 215,0 269,1 333,0 378,1 447,0 477,1 496,0 508,1 579,0 638,1 715,0 770,1 827,0 907,1 927,0 956,1 971,0 1066,1 1132,0 1186,1 1208,0 1279,1 1366,0 1367,1 1398,0 1470,1 1516,0 1608,1 1705,0 1778,1 1839,0 1900,1 1944,0 2022,1 2071,0 2075,1 2116,0 2193,1 2208,0 2238,1 2305,0 2319,1 2333,0 2422,1 2466,0 2501,1 2567,0 2622,1 2628,0 2652,1 2680,0 2714,1 2801,0 2841,1 2896,0 2959,1 3005,0 3008,1 3067,0 3156,1 3232,0 3268,1 3269,0 3359,1 3389,0 3482,1 3545,0 3576,1 3629,0 3695,1 3700,0 3731,1 3820,0 3884,1 3971,0 4013,1 4104,0 4179,1 4201,0 4251,1 4308,0 4391,1 4458,0 4537,1 4588,0 4590,1 4603,0 4696,1 4757,0 4812,1 4816,0 4891,1 4971,0 4976,1 5056,0 5061,1 5156,0 5236,1 5266,0 5298,1 5343,0 5440,1 5522,0 5541,1 5621,0 5634,1 5650,0 5706,1 5744,0 5825,1 5913,0 5918,1 5971,0 6052,1 6087,0 6161,1 6172,0 6188,1 6206,0 6285,1 6337,0 6432,1 6521,0 6562,1 6652,0 6709,1 6753,0 6782,1 6829,0 6871,1 6905,0 6952,1 7018,0 7083,1 7180,0 7215,1 7216,0 7249,1 7289,0 7384,1 7477,0 7483,1 7544,0 7577,1 7668,0 7703,1 7733,0 7804,1 7885,0 7891,1 7933,0 7989,1 8043,0 8074,1 8082,0 8105,1 8153,0 8215,1 8272,0 8281,1 8293,0 8390,1 8474,0 8478,1 8567,0 8645,1 8695,0 8699,1 8703,0 8791,1 8838,0 8905,1 8936,0 8938,1 9035,0 9066,1 9122,0 9140,1 9174,0 9267,1 9306,0 9356,1 9456,0 9525,1 9577,0 9676,1 9715,0 9751,1 9770,0 9772,1 9865,0 9921,1 9987,0 10086,1 10088,0 10099,1 10159,0 10213,1 10243,0 10274,1 10283,0 10376,1 10476,0 10566,1 10654,0 10704,1 10705,0 10715,1 10781,0 10844,1 10860,0 10875,1 10914,0 11010,1 11081,0 11091,1 11101,0 11103,1 11159,0 11247,1 11328,0 11333,1 11410,0 11480,1 11540,0 11568,1 11658,0 11686,1 11710,0 11750,1 11820,0 11911,1 11964,0 12020,1 12112,0 12177,1 12178,0 12194,1 12273,0 12300,1 12347,0 12400,1 12425,0 12479,1 12495,0 12499,1 12545,0 12617,1 12712,0 12782,1 12785,0 12803,1 12872,0 12924,1 12944,0 13034,1 13036,0 13046,1 13070,0 13154,1 13240,0 13255,1 13311,0 13367,1 13407,0 13462,1 13468,0 13559,1 13594,0 13602,1 13620,0 13689,1 13767,0 13838,1 13882,0 13904,1 13965,0 13982,1 14048,0 14120,1 14142,0 14212,1 14299,0 14307,1 14360,0 14449,1 14547,0 14582,1 14613,0 14708,1 14728,0 14808,1 14854,0 14878,1 14929,0 14956,1 15011,0 15012,1 15111,0 15198,1 15252,0 15324,1 15356,0 15414,1 15476,0 15517,1 15556,0 15644,1 15728,0 15796,1 15880,0 15974,1 15976,0 16005,1 16032,0 16058,1 16127,0 16145,1 16177,0 16246,1 16290,0 16362,1 16400,0 16430,1 16497,0 16577,1 16643,0 16646,1 16743,0 16775,1 16862,0 16925,1 17014,0 17090,1 17121,0 17213,1 17280,0 17291,1 17358,0 17367,1 17415,0 17514,1 17533,0 17629,1 17641,0 17661,1 17690,0 17725,1 17801,0 17895,1 17905,0 17953,1 17973,0 18022,1 18069,0 18157,1 18182,0 18190,1 18239,0 18283,1 18343,0 18346,1 18407,0 18497,1 18539,0 18578,1 18641,0 18654,1 18750,0 18795,1 18877,0 18948,1 19043,0 19074,1 19112,0 19161,1 19224,0 19276,1 19289,0 19326,1 19403,0 19493,1 19498,0 19503,1 19595,0 19647,1 19683,0 19699,1 19786,0 19840,1 19871,0 19954,1 19993,0 20084,1 20085,0 20108,1 20194,0 20243,1 20311,0 20327,1 20355,0 20408,1 20495,0 20588,1 20625,0 20662,1 20685,0 20715,1 20806,0 20831,1 20899,0 20985,1 21045,0 21129,1 21166,0 21176,1 21199,0 21204,1 21289,0 21325,1 21391,0 21427,1 21499,0 21527,1 21612,0 21619,1 21638,0 21657,1 21665,0 21684,1 21699,0 21773,1 21857,0 21878,1 21882,0 21925,1 21973,0 22041,1 22112,0 22155,1 22208,0 22299,1 22356,0 22386,1 22392,0 22395,1 22430,0 22495,1 22515,0 22543,1 22613,0 22639,1 22652,0 22714,1 22791,0 22799,1 22880,0 22904,1 22906,0 22918,1 22965,0 23008,1 23055,0 23070,1 23133,0 23225,1 23302,0 23322,1 23328,0 23417,1 23492,0 23501,1 23540,0 23616,1 23665,0 23691,1 23702,0 23791,1 23835,0 23912,1 23974,0 23975,1 24023,0 24118,1 24203,0 24285,1 24296,0 24312,1 24387,0 24391,1 24478,0 24561,1 24626,0 24709,1 24720,0 24732,1 24739,0 24773,1 24866,0 24908,1 24961,0 25018,1 25060,0 25130,1 25215,0 25228,1 25234,0 25312,1 25392,0 25422,1 25442,0 25513,1 25574,0 25638,1 25704,0 25710,1 25752,0 25771,1 25847,0 25941,1 25963,0 26012,1 26042,0 26129,1 26151,0 26201,1 26291,0 26307,1 26345,0 26416,1 26458,0 26467,1 26562,0 26574,1 26669,0 26738,1 26753,0 26787,1 26879,0 26941,1 26981,0 26987,1 27071,0 27143,1 27178,0 27254,1 27297,0 27375,1 27399,0 27427,1 27526,0 27539,1 27634,0 27678,1 27688,0 27758,1 27845,0 27877,1 27905,0 27919,1 27937,0 28033,1 28125,0 28190,1 28209,0 28226,1 28227,0 28268,1 28340,0 28410,1 28451,0 28509,1 28522,0 28524,1 28585,0 28617,1 28636,0 28640,1 28725,0 28756,1 28819,0 28850,1 28919,0 29015,1 29112,0 29143,1 29170,0 29217,1 29259,0 29264,1 29320,0 29347,1 29430,0 29468,1 29568,0 29600,1 29659,0 29666,1 29755,0 29838,1 29927,0 29941,1 29984,0 30061,1 30074,0 30109,1 30176,0 30204,1 30290,0 30372,1 30448,0 30468,1 30540,0 30622,1 30716,0 30754,1 30797,0 30867,1 30904,0 30978,1 31012,0 31102,1 31201,0 31229,1 31231,0 31261,1 31304,0 31359,1 31426,0 31506,1 31604,0 31636,1 31668,0 31758,1 31849,0 31945,1 31954,0 32006,1 32102,0 32199,1 32204,0 32296,1 32386,0 32485,1 32545,0 32558,1 32566,0 32632,1 32684,0 32717,1 32792,0 32866,1 32875,0 32971,1 32974,0 32979,1 32988,0 33003,1 33088,0 33097,1 33139,0 33143,1 33156,0 33180,1 33182,0 33268,1 33313,0 33393,1 33399,0 33435,1 33482,0 33536,1 33544,0 33561,1 33652,0 33737,1 33770,0 33775,1 33862,0 33957,1 34049,0 34131,1 34154,0 34215,1 34315,0 34327,1 34357,0 34395,1 34451,0 34511,1 34567,0 34584,1 34649,0 34722,1 34748,0 34809,1 34811,0 34904,1 34965,0 34993,1 35087,0 35172,1 35222,0 35258,1 35356,0 35374,1 35422,0 35469,1 35493,0 35532,1 35560,0 35591,1 35641,0 35728,1 35790,0 35801,1 35803,0 35884,1 35958,0 35991,1 36039,0 36045,1 36124,0 36159,1 36240,0 36302,1 36387,0 36443,1 36494,0 36501,1 36532,0 36617,1 36625,0 36630,1 36669,0 36698,1 36762,0 36843,1 36879,0 36974,1 37073,0 37148,1 37179,0 37242,1 37293,0 37313,1 37376,0 37421,1 37507,0 37530,1 37582,0 37639,1 37729,0 37755,1 37757,0 37806,1 37903,0 37946,1 38026,0 38117,1 38203,0 38240,1 38333,0 38427,1 38495,0 38563,1 38580,0 38617,1 38651,0 38739,1 38796,0 38893,1 38894,0 38905,1 38947,0 38952,1 39048,0 39143,1 39217,0 39267,1 39282,0 39323,1 39331,0 39368,1 39389,0 39410,1 39483,0 39511,1 39538,0 39636,1 39639,0 39685,1 39776,0 39852,1 39902,0 39912,1 39938,0 40025,1 40092,0 40107,1 40146,0 40205,1 40250,0 40339,1 40401,0 40469,1 40472,0 40494,1 40550,0 40629,1 40669,0 40675,1 40769,0 40848,1 40943,0 41000,1 41060,0 41081,1 41112,0 41117,1 41162,0 41253,1 41304,0 41355,1 41381,0 41461,1 41516,0 41565,1 41651,0 41706,1 41769,0 41816,1 41830,0 41848,1 41939,0 41962,1 42022,0 42080,1 42141,0 42158,1 42244,0 42295,1 42307,0 42368,1 42384,0 42442,1 42515,0 42535,1 42569,0 42596,1 42634,0 42637,1 42733,0 42771,1 42773,0 42774,1 42849,0 42860,1 42872,0 42880,1 42916,0 42918,1 42941,0 43041,1 43051,0 43082,1 43134,0 43233,1 43275,0 43347,1 43431,0 43524,1 43611,0 43650,1 43652,0 43664,1 43716,0 43776,1 43857,0 43867,1 43891,0 43948,1 43965,0 44052,1 44058,0 44096,1 44132,0 44226,1 44325,0 44403,1 44444,0 44451,1 44508,0 44530,1 44588,0 44601,1 44643,0 44703,1 44782,0 44824,1 44913,0 44971,1 45009,0 45081,1 45171,0 45262,1 45287,0 45318,1 45348,0 45356,1 45385,0 45403,1 45494,0 45522,1 45563,0 45635,1 45685,0 45784,1 45810,0 45844,1 45852,0 45909,1 45967,0 45983,1 46023,0 46028,1 46094,0 46158,1 46206,0 46208,1 46239,0 46296,1 46344,0 46360,1 46428,0 46435,1 46436,0 46469,1 46540,0 46630,1 46691,0 46766,1 46821,0 46886,1 46906,0 46958,1 46983,0 47032,1 47060,0 47083,1 47160,0 47224,1 47259,0 47357,1 47371,0 47471,1 47548,0 47595,1 47621,0 47692,1 47779,0 47818,1 47822,0 47856,1 47866,0 47950,1 47989,0 48020,1 48070,0 48133,1 48216,0 48258,1 48310,0 48404,1 48418,0 48508,1 48549,0 48611,1 48680,0 48749,1 48840,0 48931,1 48964,0 49015,1 49048,0 49062,1 49120,0 49158,1 49224,0 49289,1 49321,0 49393,1 49435,0 49499,1 49551,0 49580,1 end initlist a50 0,0 54,1 90,0 180,1 185,0 192,1 219,0 280,1 380,0 447,1 452,0 478,1 521,0 593,1 640,0 643,1 684,0 758,1 766,0 794,1 799,0 865,1 927,0 985,1 1060,0 1142,1 1235,0 1263,1 1307,0 1375,1 1405,0 1429,1 1517,0 1546,1 1623,0 1660,1 1675,0 1683,1 1713,0 1777,1 1840,0 1918,1 2009,0 2062,1 2089,0 2131,1 2162,0 2250,1 2347,0 2434,1 2476,0 2493,1 2556,0 2593,1 2687,0 2722,1 2763,0 2839,1 2912,0 2995,1 3085,0 3129,1 3202,0 3279,1 3342,0 3355,1 3407,0 3498,1 3550,0 3594,1 3629,0 3671,1 3719,0 3777,1 3840,0 3882,1 3943,0 3966,1 4010,0 4016,1 4080,0 4088,1 4114,0 4154,1 4238,0 4332,1 4346,0 4413,1 4417,0 4441,1 4475,0 4541,1 4615,0 4682,1 4733,0 4759,1 4821,0 4822,1 4863,0 4897,1 4941,0 4999,1 5090,0 5159,1 5230,0 5299,1 5323,0 5417,1 5503,0 5559,1 5611,0 5634,1 5639,0 5668,1 5724,0 5789,1 5816,0 5901,1 5997,0 6003,1 6090,0 6102,1 6173,0 6240,1 6265,0 6315,1 6378,0 6441,1 6521,0 6602,1 6685,0 6781,1 6865,0 6870,1 6924,0 6932,1 6953,0 7041,1 7125,0 7218,1 7300,0 7384,1 7453,0 7487,1 7552,0 7563,1 7609,0 7685,1 7723,0 7811,1 7823,0 7876,1 7901,0 7977,1 8074,0 8084,1 8160,0 8225,1 8308,0 8309,1 8393,0 8419,1 8489,0 8492,1 8582,0 8606,1 8637,0 8702,1 8801,0 8834,1 8898,0 8968,1 9018,0 9085,1 9117,0 9185,1 9272,0 9369,1 9457,0 9485,1 9493,0 9575,1 9592,0 9650,1 9733,0 9795,1 9805,0 9820,1 9912,0 10002,1 10076,0 10080,1 10150,0 10230,1 10311,0 10331,1 10409,0 10479,1 10503,0 10590,1 10632,0 10655,1 10691,0 10717,1 10801,0 10821,1 10883,0 10983,1 11022,0 11040,1 11102,0 11152,1 11208,0 11213,1 11260,0 11336,1 11346,0 11407,1 11436,0 11491,1 11506,0 11507,1 11523,0 11561,1 11629,0 11695,1 11781,0 11842,1 11901,0 11960,1 12052,0 12098,1 12106,0 12143,1 12201,0 12284,1 12300,0 12322,1 12396,0 12403,1 12406,0 12475,1 12525,0 12549,1 12618,0 12666,1 12743,0 12786,1 12846,0 12896,1 12930,0 12986,1 12993,0 13054,1 13068,0 13163,1 13191,0 13267,1 13353,0 13357,1 13403,0 13476,1 13490,0 13554,1 13610,0 13622,1 13677,0 13777,1 13836,0 13888,1 13979,0 14008,1 14083,0 14161,1 14168,0 14261,1 14337,0 14372,1 14455,0 14466,1 14514,0 14522,1 14615,0 14715,1 14726,0 14789,1 14810,0 14866,1 14919,0 15012,1 15034,0 15097,1 15195,0 15272,1 15346,0 15373,1 15452,0 15490,1 15568,0 15583,1 15587,0 15686,1 15783,0 15865,1 15897,0 15937,1 15971,0 16036,1 16116,0 16152,1 16227,0 16228,1 16301,0 16351,1 16432,0 16492,1 16495,0 16564,1 16603,0 16618,1 16625,0 16713,1 16731,0 16803,1 16858,0 16953,1 16989,0 17026,1 17064,0 17152,1 17167,0 17222,1 17258,0 17347,1 17439,0 17511,1 17522,0 17569,1 17669,0 17706,1 17720,0 17793,1 17819,0 17843,1 17912,0 17936,1 18023,0 18073,1 18142,0 18238,1 18279,0 18327,1 18403,0 18458,1 18466,0 18488,1 18516,0 18517,1 18574,0 18632,1 18672,0 18720,1 18811,0 18876,1 18966,0 19065,1 19159,0 19224,1 19271,0 19350,1 19422,0 19431,1 19494,0 19552,1 19623,0 19628,1 19660,0 19690,1 19708,0 19710,1 19780,0 19786,1 19848,0 19890,1 19891,0 19909,1 19987,0 19998,1 20069,0 20140,1 20218,0 20312,1 20340,0 20427,1 20433,0 20446,1 20475,0 20556,1 20589,0 20640,1 20667,0 20765,1 20768,0 20800,1 20810,0 20825,1 20838,0 20923,1 20998,0 21003,1 21088,0 21137,1 21169,0 21207,1 21223,0 21284,1 21347,0 21421,1 21423,0 21474,1 21478,0 21520,1 21572,0 21636,1 21643,0 21659,1 21726,0 21734,1 21803,0 21871,1 21875,0 21944,1 21953,0 22050,1 22061,0 22094,1 22141,0 22187,1 22274,0 22305,1 22357,0 22377,1 22472,0 22527,1 22549,0 22597,1 22682,0 22769,1 22816,0 22826,1 22916,0 22997,1 23026,0 23063,1 23127,0 23139,1 23226,0 23323,1 23379,0 23478,1 23489,0 23490,1 23492,0 23518,1 23567,0 23625,1 23646,0 23730,1 23738,0 23814,1 23848,0 23852,1 23865,0 23924,1 23934,0 23967,1 24026,0 24112,1 24139,0 24227,1 24275,0 24334,1 24365,0 24405,1 24495,0 24595,1 24666,0 24676,1 24734,0 24771,1 24869,0 24951,1 24990,0 25023,1 25041,0 25117,1 25214,0 25268,1 25281,0 25320,1 25386,0 25422,1 25462,0 25520,1 25551,0 25648,1 25676,0 25688,1 25780,0 25861,1 25921,0 25982,1 26042,0 26069,1 26123,0 26170,1 26197,0 26287,1 26331,0 26425,1 26508,0 26538,1 26599,0 26689,1 26698,0 26749,1 26771,0 26862,1 26957,0 27030,1 27041,0 27061,1 27118,0 27156,1 27229,0 27315,1 27373,0 27436,1 27460,0 27466,1 27497,0 27572,1 27638,0 27641,1 27654,0 27710,1 27778,0 27821,1 27894,0 27984,1 28012,0 28107,1 28135,0 28224,1 28275,0 28371,1 28383,0 28459,1 28460,0 28554,1 28608,0 28688,1 28777,0 28852,1 28917,0 28993,1 29088,0 29178,1 29230,0 29236,1 29244,0 29263,1 29305,0 29352,1 29420,0 29480,1 29566,0 29630,1 29667,0 29702,1 29749,0 29826,1 29828,0 29839,1 29939,0 29959,1 30010,0 30098,1 30126,0 30214,1 30303,0 30392,1 30420,0 30517,1 30540,0 30614,1 30647,0 30670,1 30742,0 30757,1 30790,0 30831,1 30881,0 30932,1 31012,0 31109,1 31139,0 31140,1 31203,0 31218,1 31242,0 31247,1 31338,0 31437,1 31498,0 31559,1 31591,0 31682,1 31725,0 31794,1 31843,0 31865,1 31912,0 31952,1 32015,0 32043,1 32092,0 32182,1 32223,0 32281,1 32328,0 32425,1 32437,0 32438,1 32462,0 32511,1 32520,0 32540,1 32568,0 32641,1 32722,0 32797,1 32873,0 32891,1 32990,0 33006,1 33100,0 33187,1 33257,0 33301,1 33380,0 33399,1 33498,0 33583,1 33622,0 33681,1 33731,0 33732,1 33804,0 33809,1 33905,0 33988,1 34015,0 34085,1 34132,0 34198,1 34211,0 34264,1 34306,0 34339,1 34383,0 34461,1 34470,0 34555,1 34627,0 34628,1 34721,0 34777,1 34861,0 34899,1 34907,0 34999,1 35038,0 35127,1 35146,0 35203,1 35259,0 35301,1 35347,0 35397,1 35478,0 35487,1 35492,0 35568,1 35590,0 35684,1 35756,0 35763,1 35793,0 35883,1 35955,0 35957,1 35989,0 36017,1 36036,0 36068,1 36085,0 36104,1 36195,0 36222,1 36228,0 36328,1 36359,0 36429,1 36460,0 36514,1 36565,0 36571,1 36605,0 36609,1 36617,0 36632,1 36652,0 36681,1 36739,0 36766,1 36769,0 36818,1 36876,0 36967,1 36977,0 37036,1 37070,0 37085,1 37090,0 37121,1 37216,0 37248,1 37344,0 37357,1 37376,0 37417,1 37471,0 37481,1 37574,0 37646,1 37727,0 37825,1 37911,0 37988,1 38018,0 38091,1 38178,0 38271,1 38325,0 38361,1 38437,0 38450,1 38460,0 38492,1 38529,0 38545,1 38561,0 38626,1 38667,0 38719,1 38818,0 38864,1 38888,0 38895,1 38968,0 39015,1 39036,0 39038,1 39083,0 39093,1 39106,0 39137,1 39202,0 39262,1 39273,0 39286,1 39365,0 39445,1 39481,0 39571,1 39670,0 39761,1 39852,0 39913,1 39991,0 40026,1 40092,0 40192,1 40199,0 40250,1 40313,0 40326,1 40379,0 40457,1 40494,0 40578,1 40636,0 40652,1 40659,0 40664,1 40740,0 40839,1 40851,0 40940,1 40972,0 40978,1 40997,0 41042,1 41052,0 41057,1 41140,0 41172,1 41218,0 41293,1 41378,0 41423,1 41441,0 41463,1 41519,0 41619,1 41643,0 41713,1 41788,0 41819,1 41883,0 41916,1 41938,0 42015,1 42023,0 42076,1 42077,0 42170,1 42215,0 42225,1 42272,0 42291,1 42362,0 42432,1 42456,0 42556,1 42613,0 42634,1 42647,0 42730,1 42777,0 42825,1 42875,0 42941,1 42951,0 43030,1 43059,0 43148,1 43199,0 43256,1 43306,0 43353,1 43419,0 43434,1 43525,0 43624,1 43626,0 43632,1 43659,0 43688,1 43711,0 43800,1 43807,0 43834,1 43893,0 43913,1 43940,0 44033,1 44049,0 44142,1 44159,0 44171,1 44268,0 44358,1 44379,0 44455,1 44507,0 44587,1 44639,0 44694,1 44767,0 44812,1 44834,0 44910,1 44989,0 45079,1 45102,0 45158,1 45206,0 45219,1 45317,0 45344,1 45349,0 45355,1 45451,0 45460,1 45524,0 45609,1 45610,0 45650,1 45748,0 45825,1 45876,0 45950,1 46026,0 46110,1 46133,0 46218,1 46245,0 46253,1 46350,0 46418,1 46438,0 46515,1 46603,0 46626,1 46706,0 46789,1 46837,0 46900,1 46969,0 47011,1 47048,0 47144,1 47232,0 47292,1 47371,0 47461,1 47487,0 47500,1 47518,0 47554,1 47587,0 47663,1 47721,0 47753,1 47842,0 47914,1 48005,0 48103,1 48122,0 48123,1 48196,0 48259,1 48273,0 48336,1 48424,0 48524,1 48574,0 48625,1 48651,0 48704,1 48718,0 48753,1 48759,0 48803,1 48853,0 48873,1 48889,0 48899,1 48989,0 49082,1 49177,0 49250,1 49316,0 49403,1 49410,0 49412,1 49475,0 49525,1 49532,0 49582,1 49630,0 49687,1 49771,0 49862,1 49951,0 49986,1 50004,0 50096,1 50132,0 50207,1 50258,0 50262,1 50311,0 50325,1 50390,0 50486,1 50536,0 50592,1 50651,0 50656,1 end initlist a51 0,0 23,1 26,0 112,1 126,0 133,1 147,0 234,1 271,0 318,1 364,0 373,1 443,0 502,1 556,0 623,1 709,0 729,1 776,0 801,1 818,0 912,1 957,0 1009,1 1063,0 1144,1 1236,0 1274,1 1339,0 1358,1 1373,0 1411,1 1440,0 1511,1 1532,0 1625,1 1632,0 1704,1 1773,0 1794,1 1823,0 1887,1 1914,0 1927,1 1956,0 1978,1 2012,0 2064,1 2071,0 2096,1 2162,0 2197,1 2238,0 2286,1 2340,0 2375,1 2416,0 2466,1 2508,0 2523,1 2572,0 2655,1 2729,0 2734,1 2797,0 2811,1 2877,0 2898,1 2959,0 3034,1 3072,0 3114,1 3165,0 3234,1 3330,0 3342,1 3373,0 3470,1 3474,0 3566,1 3649,0 3731,1 3746,0 3799,1 3888,0 3910,1 3993,0 4090,1 4117,0 4180,1 4259,0 4309,1 4385,0 4458,1 4508,0 4585,1 4662,0 4720,1 4723,0 4769,1 4819,0 4834,1 4872,0 4948,1 4973,0 5029,1 5045,0 5131,1 5220,0 5317,1 5415,0 5445,1 5487,0 5493,1 5504,0 5518,1 5520,0 5620,1 5627,0 5727,1 5777,0 5873,1 5967,0 5970,1 6035,0 6105,1 6186,0 6210,1 6284,0 6300,1 6372,0 6414,1 6509,0 6522,1 6557,0 6653,1 6676,0 6752,1 6769,0 6860,1 6891,0 6917,1 6974,0 7007,1 7054,0 7102,1 7145,0 7240,1 7340,0 7388,1 7461,0 7475,1 7530,0 7556,1 7654,0 7734,1 7783,0 7816,1 7876,0 7944,1 8030,0 8060,1 8144,0 8153,1 8216,0 8261,1 8316,0 8400,1 8488,0 8490,1 8537,0 8595,1 8596,0 8609,1 8680,0 8732,1 8733,0 8794,1 8847,0 8918,1 9004,0 9071,1 9089,0 9093,1 9151,0 9199,1 9228,0 9238,1 9250,0 9309,1 9362,0 9380,1 9434,0 9526,1 9571,0 9633,1 9674,0 9692,1 9746,0 9802,1 9805,0 9902,1 9990,0 10054,1 10143,0 10155,1 10190,0 10253,1 10328,0 10403,1 10461,0 10509,1 10565,0 10583,1 10634,0 10649,1 10740,0 10755,1 10815,0 10838,1 10915,0 10953,1 11008,0 11030,1 11089,0 11185,1 11227,0 11248,1 11290,0 11343,1 11431,0 11433,1 11504,0 11546,1 11570,0 11595,1 11649,0 11665,1 11738,0 11762,1 11859,0 11905,1 11974,0 12006,1 12056,0 12116,1 12185,0 12261,1 12328,0 12383,1 12454,0 12520,1 12542,0 12572,1 12612,0 12665,1 12701,0 12786,1 12838,0 12906,1 12976,0 12981,1 13014,0 13100,1 13144,0 13207,1 13285,0 13342,1 13418,0 13438,1 13508,0 13526,1 13586,0 13599,1 13656,0 13728,1 13737,0 13810,1 13860,0 13869,1 13911,0 13933,1 13957,0 13978,1 14018,0 14053,1 14100,0 14110,1 14150,0 14190,1 14220,0 14317,1 14340,0 14425,1 14435,0 14498,1 14555,0 14566,1 14654,0 14703,1 14707,0 14711,1 14789,0 14800,1 14802,0 14832,1 14843,0 14887,1 14965,0 15059,1 15124,0 15188,1 15280,0 15301,1 15303,0 15360,1 15381,0 15479,1 15536,0 15593,1 15693,0 15753,1 15759,0 15794,1 15859,0 15893,1 15952,0 16008,1 16034,0 16078,1 16145,0 16165,1 16192,0 16263,1 16288,0 16383,1 16384,0 16392,1 16439,0 16448,1 16453,0 16482,1 16563,0 16613,1 16690,0 16753,1 16803,0 16889,1 16983,0 17073,1 17082,0 17155,1 17170,0 17250,1 17308,0 17363,1 17376,0 17457,1 17474,0 17517,1 17555,0 17628,1 17727,0 17807,1 17851,0 17944,1 18044,0 18096,1 18127,0 18149,1 18156,0 18160,1 18256,0 18342,1 18421,0 18521,1 18555,0 18557,1 18637,0 18694,1 18769,0 18805,1 18807,0 18850,1 18891,0 18975,1 18983,0 19042,1 19059,0 19123,1 19171,0 19188,1 19196,0 19292,1 19296,0 19364,1 19431,0 19454,1 19497,0 19585,1 19635,0 19673,1 19684,0 19706,1 19765,0 19849,1 19902,0 19924,1 19976,0 20068,1 20150,0 20194,1 20280,0 20300,1 20346,0 20401,1 20430,0 20487,1 20572,0 20631,1 20674,0 20711,1 20783,0 20829,1 20862,0 20959,1 21017,0 21026,1 21028,0 21036,1 21039,0 21043,1 21084,0 21091,1 21186,0 21196,1 21203,0 21280,1 21314,0 21408,1 21481,0 21514,1 21604,0 21688,1 21761,0 21784,1 21875,0 21925,1 21970,0 21995,1 22003,0 22021,1 22065,0 22094,1 22144,0 22147,1 22150,0 22192,1 22268,0 22307,1 22385,0 22458,1 22474,0 22507,1 22584,0 22650,1 22652,0 22715,1 22766,0 22822,1 22922,0 22964,1 23039,0 23074,1 23133,0 23135,1 23231,0 23287,1 23289,0 23351,1 23390,0 23435,1 23480,0 23578,1 23626,0 23726,1 23795,0 23808,1 23830,0 23866,1 23908,0 23953,1 24010,0 24013,1 24047,0 24051,1 24111,0 24130,1 24201,0 24241,1 24292,0 24364,1 24462,0 24517,1 24605,0 24675,1 24680,0 24765,1 24789,0 24805,1 24831,0 24851,1 24857,0 24932,1 25018,0 25078,1 25105,0 25145,1 25225,0 25276,1 25352,0 25427,1 25441,0 25527,1 25603,0 25694,1 25779,0 25866,1 25926,0 25947,1 26007,0 26071,1 26126,0 26158,1 26212,0 26305,1 26388,0 26435,1 26479,0 26526,1 26622,0 26654,1 26741,0 26785,1 26869,0 26963,1 27056,0 27134,1 27210,0 27285,1 27320,0 27383,1 27396,0 27450,1 27518,0 27533,1 27621,0 27720,1 27802,0 27859,1 27902,0 27938,1 28015,0 28073,1 28169,0 28184,1 28192,0 28220,1 28320,0 28385,1 28477,0 28518,1 28605,0 28655,1 28742,0 28833,1 28889,0 28894,1 28960,0 28966,1 29050,0 29058,1 29135,0 29185,1 29259,0 29344,1 29363,0 29452,1 29474,0 29544,1 29602,0 29636,1 29735,0 29743,1 29793,0 29847,1 29931,0 29993,1 30016,0 30093,1 30142,0 30242,1 30323,0 30385,1 30429,0 30521,1 30550,0 30556,1 30636,0 30723,1 30804,0 30852,1 30866,0 30935,1 30972,0 31027,1 31056,0 31115,1 31197,0 31284,1 31330,0 31387,1 31446,0 31500,1 31549,0 31645,1 31742,0 31786,1 31831,0 31915,1 31938,0 32006,1 32050,0 32111,1 32132,0 32230,1 32253,0 32315,1 32359,0 32377,1 32404,0 32437,1 32488,0 32581,1 32643,0 32645,1 32723,0 32745,1 32817,0 32832,1 32842,0 32939,1 32993,0 33001,1 33058,0 33067,1 33130,0 33163,1 33198,0 33298,1 33361,0 33416,1 33425,0 33524,1 33539,0 33627,1 33708,0 33780,1 33878,0 33906,1 33956,0 33997,1 34044,0 34075,1 34129,0 34177,1 34221,0 34276,1 34314,0 34383,1 34401,0 34471,1 34542,0 34568,1 34615,0 34679,1 34697,0 34710,1 34756,0 34797,1 34890,0 34933,1 35005,0 35015,1 35113,0 35143,1 35201,0 35216,1 35235,0 35263,1 35334,0 35374,1 35375,0 35396,1 35433,0 35465,1 35549,0 35581,1 35632,0 35651,1 35683,0 35696,1 35749,0 35786,1 35790,0 35873,1 35918,0 35931,1 36025,0 36075,1 36124,0 36192,1 36255,0 36329,1 36363,0 36387,1 36430,0 36499,1 36548,0 36616,1 36643,0 36657,1 36710,0 36748,1 36824,0 36912,1 36963,0 37030,1 37103,0 37181,1 37208,0 37265,1 37319,0 37343,1 37438,0 37449,1 37456,0 37524,1 37617,0 37674,1 37751,0 37790,1 37827,0 37916,1 37970,0 38020,1 38108,0 38128,1 38208,0 38296,1 38304,0 38347,1 38380,0 38386,1 38435,0 38527,1 38585,0 38639,1 38736,0 38784,1 38816,0 38906,1 38936,0 39026,1 39052,0 39076,1 39080,0 39132,1 39147,0 39190,1 39281,0 39315,1 39377,0 39457,1 39538,0 39562,1 39647,0 39689,1 39762,0 39796,1 39844,0 39878,1 39903,0 39914,1 39922,0 39952,1 39961,0 39981,1 40035,0 40050,1 40133,0 40144,1 40208,0 40210,1 40213,0 40283,1 40339,0 40352,1 40353,0 40376,1 40380,0 40397,1 40419,0 40477,1 40560,0 40580,1 40596,0 40619,1 40698,0 40709,1 40732,0 40747,1 40787,0 40862,1 40891,0 40988,1 41020,0 41042,1 41128,0 41180,1 41182,0 41185,1 41234,0 41288,1 41386,0 41389,1 41421,0 41428,1 41471,0 41524,1 41568,0 41596,1 41678,0 41778,1 41789,0 41800,1 41857,0 41860,1 41878,0 41941,1 42040,0 42125,1 42168,0 42258,1 42284,0 42317,1 42348,0 42443,1 42516,0 42606,1 42665,0 42737,1 42754,0 42786,1 42836,0 42849,1 42940,0 43003,1 43025,0 43119,1 43204,0 43268,1 43365,0 43374,1 43385,0 43462,1 43534,0 43583,1 43680,0 43717,1 43763,0 43778,1 43860,0 43910,1 43951,0 44008,1 44021,0 44078,1 44174,0 44231,1 44249,0 44260,1 44327,0 44424,1 44450,0 44456,1 44478,0 44505,1 44562,0 44574,1 44616,0 44688,1 44729,0 44808,1 44882,0 44924,1 44942,0 44991,1 45079,0 45141,1 45172,0 45210,1 45211,0 45237,1 45253,0 45290,1 45355,0 45399,1 45468,0 45549,1 45649,0 45658,1 45676,0 45708,1 45710,0 45747,1 45797,0 45815,1 45915,0 45963,1 46019,0 46056,1 46059,0 46060,1 46153,0 46179,1 46249,0 46342,1 46369,0 46468,1 46550,0 46606,1 46706,0 46711,1 46772,0 46837,1 46853,0 46881,1 46954,0 47049,1 47132,0 47154,1 47168,0 47221,1 47303,0 47311,1 47326,0 47424,1 47487,0 47489,1 47510,0 47552,1 47568,0 47590,1 47597,0 47671,1 47732,0 47785,1 47840,0 47906,1 47995,0 48012,1 48034,0 48115,1 48170,0 48234,1 48251,0 48341,1 48388,0 48441,1 48461,0 48488,1 48586,0 48654,1 48722,0 48810,1 48902,0 48938,1 49022,0 49083,1 49084,0 49169,1 49240,0 49266,1 49283,0 49289,1 49301,0 49326,1 49343,0 49427,1 49501,0 49519,1 end initlist a52 0,0 34,1 91,0 102,1 177,0 207,1 248,0 345,1 419,0 454,1 470,0 550,1 557,0 631,1 729,0 774,1 791,0 856,1 890,0 982,1 1079,0 1135,1 1231,0 1264,1 1266,0 1365,1 1452,0 1536,1 1628,0 1684,1 1709,0 1710,1 1776,0 1789,1 1841,0 1858,1 1930,0 1952,1 1958,0 2048,1 2101,0 2131,1 2132,0 2205,1 2212,0 2236,1 2332,0 2387,1 2462,0 2491,1 2506,0 2571,1 2646,0 2653,1 2713,0 2775,1 2804,0 2845,1 2893,0 2956,1 3028,0 3095,1 3187,0 3283,1 3340,0 3407,1 3460,0 3545,1 3553,0 3592,1 3642,0 3688,1 3724,0 3790,1 3797,0 3837,1 3911,0 3991,1 4089,0 4132,1 4180,0 4237,1 4239,0 4264,1 4361,0 4409,1 4471,0 4537,1 4623,0 4683,1 4704,0 4711,1 4734,0 4786,1 4881,0 4896,1 4929,0 5016,1 5053,0 5141,1 5142,0 5206,1 5236,0 5332,1 5366,0 5427,1 5502,0 5520,1 5596,0 5631,1 5662,0 5733,1 5736,0 5741,1 5780,0 5783,1 5798,0 5843,1 5936,0 5963,1 6040,0 6117,1 6188,0 6245,1 6309,0 6359,1 6397,0 6434,1 6490,0 6589,1 6624,0 6688,1 6718,0 6796,1 6839,0 6870,1 6925,0 6944,1 6980,0 7039,1 7110,0 7123,1 7209,0 7241,1 7256,0 7272,1 7319,0 7379,1 7474,0 7569,1 7630,0 7636,1 7662,0 7677,1 7709,0 7788,1 7817,0 7836,1 7921,0 7951,1 7985,0 8023,1 8050,0 8142,1 8221,0 8223,1 8298,0 8305,1 8315,0 8385,1 8427,0 8483,1 8532,0 8543,1 8627,0 8675,1 8681,0 8703,1 8777,0 8851,1 8901,0 8912,1 9003,0 9006,1 9020,0 9071,1 9121,0 9150,1 9151,0 9159,1 9189,0 9223,1 9322,0 9377,1 9433,0 9477,1 9565,0 9570,1 9644,0 9656,1 9749,0 9763,1 9802,0 9809,1 9900,0 9978,1 10050,0 10143,1 10219,0 10232,1 10318,0 10354,1 10377,0 10385,1 10471,0 10472,1 10478,0 10484,1 10568,0 10657,1 10675,0 10763,1 10803,0 10894,1 10986,0 10988,1 11003,0 11093,1 11157,0 11174,1 11177,0 11232,1 11301,0 11307,1 11312,0 11403,1 11410,0 11468,1 11485,0 11584,1 11637,0 11650,1 11706,0 11713,1 11757,0 11778,1 11856,0 11911,1 11930,0 12021,1 12029,0 12061,1 12110,0 12199,1 12203,0 12292,1 12389,0 12443,1 12489,0 12561,1 12570,0 12591,1 12600,0 12617,1 12652,0 12687,1 12721,0 12800,1 12889,0 12961,1 12990,0 13079,1 13105,0 13110,1 13207,0 13297,1 13324,0 13342,1 13378,0 13453,1 13537,0 13621,1 13702,0 13757,1 13800,0 13875,1 13926,0 13977,1 14063,0 14082,1 14099,0 14127,1 14220,0 14265,1 14343,0 14367,1 14458,0 14515,1 14609,0 14665,1 14712,0 14781,1 14857,0 14953,1 14959,0 15038,1 15123,0 15177,1 15225,0 15270,1 15346,0 15394,1 15438,0 15512,1 15522,0 15564,1 15620,0 15661,1 15730,0 15768,1 15776,0 15845,1 15856,0 15951,1 16002,0 16030,1 16041,0 16130,1 16214,0 16225,1 16244,0 16328,1 16381,0 16390,1 16426,0 16431,1 16497,0 16521,1 16551,0 16633,1 16695,0 16762,1 16773,0 16831,1 16879,0 16902,1 16981,0 17074,1 17107,0 17147,1 17152,0 17252,1 17338,0 17404,1 17492,0 17539,1 17572,0 17671,1 17740,0 17806,1 17865,0 17958,1 18041,0 18104,1 18174,0 18191,1 18231,0 18310,1 18317,0 18358,1 18399,0 18472,1 18476,0 18526,1 18543,0 18586,1 18667,0 18670,1 18754,0 18841,1 18931,0 18961,1 19021,0 19058,1 19130,0 19146,1 19210,0 19239,1 19303,0 19317,1 19375,0 19448,1 19531,0 19550,1 19556,0 19608,1 19705,0 19776,1 19822,0 19840,1 19846,0 19849,1 19884,0 19934,1 19953,0 19976,1 20009,0 20058,1 20146,0 20197,1 20215,0 20223,1 20260,0 20324,1 20384,0 20397,1 20495,0 20501,1 20561,0 20576,1 20642,0 20659,1 20733,0 20773,1 20857,0 20889,1 20925,0 20997,1 21084,0 21146,1 21155,0 21244,1 21331,0 21359,1 21394,0 21441,1 21526,0 21614,1 21689,0 21711,1 21753,0 21852,1 21924,0 21928,1 21932,0 22015,1 22046,0 22120,1 22203,0 22275,1 22346,0 22404,1 22490,0 22548,1 22631,0 22643,1 22697,0 22709,1 22782,0 22856,1 22942,0 23023,1 23104,0 23199,1 23279,0 23295,1 23318,0 23402,1 23469,0 23487,1 23578,0 23678,1 23772,0 23788,1 23873,0 23886,1 23895,0 23956,1 23999,0 24025,1 24072,0 24133,1 24136,0 24219,1 24308,0 24340,1 24415,0 24497,1 24564,0 24592,1 24657,0 24752,1 24802,0 24891,1 24896,0 24917,1 25015,0 25095,1 25168,0 25191,1 25246,0 25337,1 25360,0 25396,1 25473,0 25503,1 25507,0 25525,1 25551,0 25607,1 25670,0 25680,1 25754,0 25762,1 25792,0 25843,1 25900,0 25971,1 26009,0 26090,1 26158,0 26238,1 26280,0 26345,1 26422,0 26425,1 26470,0 26477,1 26576,0 26628,1 26673,0 26699,1 26735,0 26753,1 26768,0 26794,1 26880,0 26947,1 27047,0 27117,1 27119,0 27124,1 27198,0 27238,1 27319,0 27337,1 27355,0 27429,1 27477,0 27546,1 27563,0 27657,1 27732,0 27827,1 27856,0 27873,1 27888,0 27960,1 27963,0 27971,1 28047,0 28130,1 28184,0 28260,1 28315,0 28319,1 28340,0 28412,1 28425,0 28481,1 28572,0 28617,1 28686,0 28716,1 28719,0 28758,1 28796,0 28853,1 28924,0 28933,1 28999,0 29049,1 29134,0 29171,1 29214,0 29233,1 29321,0 29364,1 29456,0 29524,1 29598,0 29674,1 29694,0 29703,1 29704,0 29710,1 29717,0 29725,1 29794,0 29834,1 29894,0 29960,1 29982,0 30042,1 30044,0 30131,1 30148,0 30187,1 30282,0 30334,1 30379,0 30467,1 30557,0 30625,1 30632,0 30690,1 30742,0 30786,1 30833,0 30881,1 30899,0 30961,1 31051,0 31080,1 31101,0 31126,1 31212,0 31309,1 31322,0 31355,1 31374,0 31431,1 31440,0 31442,1 31492,0 31519,1 31596,0 31621,1 31647,0 31723,1 31786,0 31787,1 31867,0 31904,1 31917,0 31980,1 31989,0 32089,1 32145,0 32189,1 32249,0 32299,1 32310,0 32332,1 32432,0 32477,1 32518,0 32530,1 32601,0 32683,1 32722,0 32734,1 32809,0 32820,1 32885,0 32911,1 32999,0 33072,1 33146,0 33239,1 33293,0 33341,1 33430,0 33511,1 33516,0 33548,1 33590,0 33619,1 33662,0 33745,1 33793,0 33843,1 33884,0 33975,1 34065,0 34159,1 34199,0 34238,1 34251,0 34331,1 34367,0 34378,1 34462,0 34490,1 34586,0 34663,1 34716,0 34772,1 34824,0 34909,1 34990,0 35038,1 35058,0 35131,1 35133,0 35217,1 35271,0 35310,1 35315,0 35373,1 35433,0 35489,1 35582,0 35599,1 35640,0 35720,1 35817,0 35819,1 35861,0 35930,1 35958,0 36019,1 36093,0 36122,1 36142,0 36172,1 36230,0 36283,1 36284,0 36353,1 36425,0 36454,1 36495,0 36512,1 36595,0 36600,1 36642,0 36678,1 36740,0 36827,1 36846,0 36929,1 36997,0 37062,1 37138,0 37184,1 37283,0 37332,1 37417,0 37448,1 37473,0 37498,1 37539,0 37555,1 37649,0 37663,1 37667,0 37750,1 37767,0 37791,1 37857,0 37952,1 38050,0 38145,1 38242,0 38302,1 38402,0 38456,1 38518,0 38571,1 38643,0 38681,1 38752,0 38851,1 38866,0 38951,1 38966,0 39062,1 39088,0 39134,1 39169,0 39204,1 39233,0 39272,1 39331,0 39430,1 39478,0 39508,1 39543,0 39550,1 39568,0 39597,1 39645,0 39658,1 39731,0 39747,1 39833,0 39918,1 39962,0 40022,1 40041,0 40111,1 40125,0 40206,1 40259,0 40349,1 40393,0 40472,1 40565,0 40605,1 40678,0 40719,1 40758,0 40779,1 40819,0 40908,1 40970,0 40995,1 41067,0 41104,1 41188,0 41251,1 41265,0 41333,1 41380,0 41410,1 41419,0 41421,1 41453,0 41520,1 41561,0 41639,1 41662,0 41682,1 41683,0 41706,1 41714,0 41738,1 41812,0 41827,1 41878,0 41899,1 41924,0 41989,1 41998,0 42060,1 42102,0 42122,1 42216,0 42222,1 42280,0 42292,1 42362,0 42380,1 42403,0 42496,1 42509,0 42589,1 42607,0 42670,1 42748,0 42762,1 42828,0 42834,1 42929,0 43007,1 43008,0 43014,1 43057,0 43118,1 43176,0 43177,1 43182,0 43235,1 43323,0 43381,1 43436,0 43521,1 43587,0 43642,1 43732,0 43814,1 43836,0 43874,1 43888,0 43947,1 44045,0 44103,1 44134,0 44216,1 44271,0 44312,1 44340,0 44382,1 44428,0 44458,1 44530,0 44581,1 44598,0 44618,1 44659,0 44687,1 44754,0 44853,1 44873,0 44887,1 44978,0 45044,1 45135,0 45224,1 45301,0 45329,1 45406,0 45429,1 45456,0 45550,1 45582,0 45670,1 45705,0 45749,1 45755,0 45790,1 45797,0 45826,1 45849,0 45942,1 45985,0 46006,1 46020,0 46070,1 46117,0 46163,1 46205,0 46208,1 46255,0 46297,1 46300,0 46390,1 46479,0 46510,1 46518,0 46552,1 46595,0 46597,1 46601,0 46629,1 46709,0 46724,1 46730,0 46795,1 46887,0 46927,1 47005,0 47080,1 47082,0 47181,1 47207,0 47273,1 47300,0 47331,1 47404,0 47487,1 47545,0 47632,1 47657,0 47728,1 47828,0 47852,1 47922,0 47933,1 48011,0 48045,1 48113,0 48176,1 48222,0 48238,1 48291,0 48384,1 48479,0 48540,1 48638,0 48669,1 48721,0 48732,1 48771,0 48819,1 48883,0 48904,1 48947,0 49035,1 49069,0 49122,1 49182,0 49231,1 49257,0 49294,1 49352,0 49442,1 49492,0 49508,1 49522,0 49555,1 end initlist a53 0,0 6,1 40,0 119,1 219,0 299,1 314,0 392,1 468,0 503,1 548,0 595,1 675,0 764,1 772,0 856,1 921,0 1003,1 1094,0 1147,1 1244,0 1264,1 1341,0 1402,1 1457,0 1459,1 1493,0 1547,1 1565,0 1583,1 1616,0 1669,1 1685,0 1698,1 1760,0 1842,1 1911,0 1998,1 2098,0 2117,1 2150,0 2152,1 2226,0 2317,1 2331,0 2414,1 2483,0 2537,1 2609,0 2638,1 2678,0 2752,1 2825,0 2912,1 2925,0 2992,1 3005,0 3048,1 3099,0 3183,1 3247,0 3336,1 3370,0 3455,1 3506,0 3552,1 3557,0 3572,1 3672,0 3755,1 3829,0 3877,1 3923,0 3949,1 4001,0 4093,1 4131,0 4167,1 4239,0 4260,1 4346,0 4439,1 4506,0 4542,1 4609,0 4630,1 4632,0 4682,1 4762,0 4825,1 4896,0 4902,1 4993,0 5087,1 5168,0 5182,1 5260,0 5270,1 5316,0 5318,1 5371,0 5385,1 5485,0 5577,1 5606,0 5697,1 5788,0 5863,1 5912,0 5951,1 6017,0 6086,1 6149,0 6213,1 6256,0 6351,1 6439,0 6525,1 6529,0 6572,1 6647,0 6701,1 6704,0 6755,1 6805,0 6873,1 6891,0 6980,1 7030,0 7035,1 7133,0 7141,1 7167,0 7181,1 7237,0 7326,1 7347,0 7407,1 7496,0 7568,1 7626,0 7667,1 7726,0 7727,1 7749,0 7772,1 7813,0 7859,1 7951,0 7996,1 8062,0 8142,1 8172,0 8195,1 8272,0 8286,1 8344,0 8387,1 8403,0 8414,1 8512,0 8600,1 8691,0 8712,1 8792,0 8874,1 8882,0 8893,1 8948,0 8991,1 9009,0 9090,1 9097,0 9158,1 9247,0 9304,1 9312,0 9405,1 9445,0 9527,1 9544,0 9572,1 9643,0 9669,1 9693,0 9695,1 9779,0 9792,1 9800,0 9802,1 9843,0 9898,1 9933,0 9950,1 10004,0 10009,1 10063,0 10131,1 10200,0 10231,1 10258,0 10316,1 10379,0 10409,1 10432,0 10443,1 10480,0 10537,1 10544,0 10638,1 10688,0 10743,1 10769,0 10790,1 10858,0 10937,1 10987,0 11063,1 11158,0 11210,1 11247,0 11315,1 11395,0 11454,1 11513,0 11546,1 11595,0 11670,1 11767,0 11845,1 11930,0 11984,1 12004,0 12040,1 12132,0 12187,1 12247,0 12308,1 12351,0 12395,1 12488,0 12543,1 12555,0 12634,1 12730,0 12750,1 12827,0 12885,1 12955,0 13035,1 13057,0 13103,1 13107,0 13175,1 13270,0 13298,1 13300,0 13315,1 13316,0 13359,1 13441,0 13521,1 13528,0 13616,1 13662,0 13684,1 13750,0 13832,1 13916,0 13923,1 13978,0 14040,1 14084,0 14120,1 14148,0 14179,1 14199,0 14293,1 14377,0 14433,1 14529,0 14540,1 14598,0 14654,1 14692,0 14710,1 14747,0 14749,1 14824,0 14899,1 14980,0 15069,1 15113,0 15156,1 15238,0 15325,1 15360,0 15381,1 15459,0 15489,1 15533,0 15626,1 15695,0 15729,1 15808,0 15905,1 15956,0 15959,1 16002,0 16009,1 16010,0 16103,1 16160,0 16180,1 16242,0 16325,1 16327,0 16412,1 16494,0 16540,1 16598,0 16624,1 16704,0 16707,1 16802,0 16860,1 16894,0 16916,1 16959,0 16992,1 17034,0 17039,1 17125,0 17153,1 17176,0 17242,1 17303,0 17391,1 17406,0 17455,1 17477,0 17543,1 17571,0 17589,1 17590,0 17597,1 17624,0 17692,1 17705,0 17784,1 17814,0 17815,1 17895,0 17984,1 18026,0 18073,1 18143,0 18155,1 18231,0 18268,1 18279,0 18315,1 18413,0 18440,1 18493,0 18547,1 18617,0 18677,1 18702,0 18781,1 18808,0 18881,1 18896,0 18913,1 18981,0 19003,1 19083,0 19088,1 19166,0 19228,1 19318,0 19331,1 19359,0 19408,1 19467,0 19549,1 19638,0 19733,1 19779,0 19813,1 19902,0 19926,1 19956,0 20023,1 20102,0 20147,1 20171,0 20192,1 20197,0 20251,1 20327,0 20343,1 20430,0 20460,1 20553,0 20615,1 20661,0 20665,1 20727,0 20789,1 20856,0 20953,1 21001,0 21094,1 21150,0 21206,1 21228,0 21257,1 21352,0 21439,1 21527,0 21613,1 21662,0 21749,1 21825,0 21860,1 21943,0 22021,1 22070,0 22170,1 22247,0 22306,1 22316,0 22328,1 22413,0 22469,1 22556,0 22594,1 22687,0 22717,1 22757,0 22768,1 22868,0 22883,1 22909,0 22992,1 23020,0 23030,1 23111,0 23180,1 23242,0 23306,1 23381,0 23427,1 23445,0 23470,1 23510,0 23553,1 23573,0 23628,1 23643,0 23656,1 23701,0 23739,1 23839,0 23904,1 23916,0 23924,1 23973,0 23982,1 24004,0 24064,1 24119,0 24162,1 24205,0 24222,1 24288,0 24383,1 24454,0 24505,1 24605,0 24683,1 24727,0 24748,1 24796,0 24815,1 24891,0 24991,1 25015,0 25058,1 25109,0 25182,1 25190,0 25286,1 25316,0 25387,1 25393,0 25409,1 25468,0 25516,1 25575,0 25592,1 25656,0 25724,1 25745,0 25810,1 25890,0 25953,1 25962,0 26012,1 26020,0 26110,1 26118,0 26205,1 26272,0 26301,1 26343,0 26389,1 26418,0 26448,1 26490,0 26581,1 26587,0 26642,1 26650,0 26724,1 26733,0 26801,1 26859,0 26887,1 26914,0 26932,1 26965,0 27018,1 27036,0 27058,1 27129,0 27191,1 27230,0 27314,1 27378,0 27455,1 27475,0 27495,1 27508,0 27534,1 27633,0 27717,1 27753,0 27795,1 27842,0 27906,1 27988,0 28031,1 28035,0 28069,1 28150,0 28233,1 28326,0 28392,1 28447,0 28454,1 28471,0 28545,1 28634,0 28717,1 28754,0 28816,1 28906,0 28945,1 29015,0 29069,1 29144,0 29213,1 29232,0 29254,1 29306,0 29353,1 29378,0 29409,1 29498,0 29526,1 29606,0 29686,1 29756,0 29803,1 29840,0 29860,1 29864,0 29957,1 30019,0 30090,1 30129,0 30175,1 30220,0 30227,1 30233,0 30327,1 30367,0 30403,1 30487,0 30563,1 30565,0 30639,1 30711,0 30792,1 30881,0 30927,1 30972,0 31054,1 31114,0 31214,1 31313,0 31315,1 31325,0 31391,1 31395,0 31473,1 31536,0 31550,1 31636,0 31715,1 31797,0 31888,1 31973,0 31981,1 32008,0 32024,1 32070,0 32168,1 32231,0 32270,1 32294,0 32352,1 32385,0 32397,1 32417,0 32512,1 32562,0 32574,1 32665,0 32747,1 32814,0 32840,1 32873,0 32960,1 33038,0 33069,1 33150,0 33220,1 33284,0 33373,1 33390,0 33485,1 33550,0 33561,1 33628,0 33659,1 33746,0 33823,1 33888,0 33937,1 33961,0 34060,1 34096,0 34112,1 34129,0 34185,1 34224,0 34236,1 34319,0 34390,1 34454,0 34545,1 34572,0 34652,1 34748,0 34780,1 34821,0 34909,1 35004,0 35092,1 35106,0 35127,1 35151,0 35248,1 35278,0 35328,1 35369,0 35450,1 35498,0 35559,1 35650,0 35679,1 35719,0 35798,1 35858,0 35902,1 35976,0 35997,1 36040,0 36057,1 36131,0 36210,1 36253,0 36347,1 36348,0 36432,1 36500,0 36592,1 36606,0 36676,1 36714,0 36808,1 36813,0 36913,1 36960,0 37028,1 37123,0 37200,1 37300,0 37313,1 37347,0 37395,1 37483,0 37521,1 37568,0 37588,1 37642,0 37675,1 37775,0 37853,1 37889,0 37966,1 37996,0 38044,1 38098,0 38198,1 38240,0 38279,1 38351,0 38396,1 38433,0 38459,1 38513,0 38576,1 38664,0 38732,1 38751,0 38843,1 38913,0 39012,1 39062,0 39153,1 39207,0 39292,1 39377,0 39429,1 39514,0 39610,1 39683,0 39757,1 39758,0 39784,1 39808,0 39812,1 39821,0 39823,1 39871,0 39885,1 39899,0 39928,1 39941,0 39943,1 39965,0 40008,1 40024,0 40111,1 40189,0 40244,1 40325,0 40352,1 40444,0 40544,1 40598,0 40610,1 40619,0 40666,1 40667,0 40763,1 40832,0 40850,1 40936,0 41014,1 41035,0 41125,1 41221,0 41273,1 41287,0 41294,1 41365,0 41392,1 41437,0 41485,1 41541,0 41591,1 41628,0 41672,1 41714,0 41741,1 41802,0 41843,1 41925,0 41958,1 42004,0 42077,1 42081,0 42170,1 42239,0 42284,1 42304,0 42375,1 42413,0 42453,1 42528,0 42600,1 42605,0 42671,1 42686,0 42770,1 42782,0 42791,1 42884,0 42885,1 42980,0 43074,1 43140,0 43227,1 43285,0 43306,1 43343,0 43399,1 43472,0 43475,1 43502,0 43596,1 43632,0 43717,1 43768,0 43805,1 43886,0 43908,1 43982,0 43989,1 44080,0 44109,1 44175,0 44177,1 44223,0 44307,1 44379,0 44449,1 44468,0 44516,1 44535,0 44607,1 44669,0 44765,1 44854,0 44948,1 45012,0 45051,1 45131,0 45178,1 45261,0 45264,1 45268,0 45366,1 45411,0 45450,1 45522,0 45543,1 45584,0 45597,1 45670,0 45739,1 45826,0 45849,1 45893,0 45913,1 45985,0 46011,1 46073,0 46124,1 46220,0 46299,1 46351,0 46403,1 46490,0 46493,1 46590,0 46681,1 46686,0 46764,1 46791,0 46850,1 46889,0 46941,1 47002,0 47010,1 47049,0 47124,1 47215,0 47222,1 47320,0 47402,1 47439,0 47513,1 47562,0 47618,1 47621,0 47700,1 47713,0 47772,1 47789,0 47829,1 47848,0 47910,1 47965,0 48008,1 48025,0 48120,1 48190,0 48225,1 48324,0 48366,1 48434,0 48494,1 48522,0 48538,1 48605,0 48699,1 48760,0 48825,1 48860,0 48928,1 48957,0 48982,1 49068,0 49151,1 49169,0 49245,1 49319,0 49419,1 49433,0 49453,1 49509,0 49596,1 49663,0 49735,1 49785,0 49833,1 49889,0 49968,1 50022,0 50028,1 50039,0 50045,1 50141,0 50194,1 50290,0 50293,1 50302,0 50360,1 50431,0 50472,1 50522,0 50524,1 50561,0 50620,1 50643,0 50738,1 50759,0 50786,1 50879,0 50940,1 50963,0 50981,1 51081,0 51161,1 51234,0 51305,1 51326,0 51334,1 51404,0 51494,1 51529,0 51558,1 51625,0 51663,1 51692,0 51728,1 end initlist a54 0,0 74,1 162,0 251,1 260,0 336,1 362,0 407,1 408,0 434,1 493,0 570,1 576,0 663,1 687,0 736,1 789,0 815,1 908,0 1008,1 1023,0 1118,1 1210,0 1268,1 1287,0 1379,1 1458,0 1465,1 1548,0 1586,1 1633,0 1680,1 1745,0 1823,1 1839,0 1886,1 1930,0 1935,1 2028,0 2032,1 2065,0 2156,1 2256,0 2296,1 2379,0 2448,1 2538,0 2600,1 2652,0 2714,1 2795,0 2828,1 2917,0 2974,1 2975,0 3071,1 3152,0 3226,1 3239,0 3292,1 3345,0 3409,1 3423,0 3504,1 3560,0 3563,1 3611,0 3697,1 3771,0 3843,1 3869,0 3884,1 3954,0 4051,1 4085,0 4150,1 4154,0 4180,1 4272,0 4322,1 4391,0 4466,1 4516,0 4523,1 4602,0 4603,1 4664,0 4671,1 4704,0 4739,1 4791,0 4798,1 4860,0 4911,1 4961,0 4973,1 5056,0 5151,1 5241,0 5270,1 5327,0 5418,1 5433,0 5511,1 5551,0 5619,1 5698,0 5758,1 5858,0 5860,1 5889,0 5914,1 5922,0 5973,1 6003,0 6038,1 6070,0 6087,1 6160,0 6237,1 6253,0 6318,1 6367,0 6417,1 6463,0 6562,1 6593,0 6623,1 6643,0 6669,1 6716,0 6782,1 6851,0 6918,1 6966,0 6991,1 7004,0 7057,1 7096,0 7127,1 7200,0 7267,1 7298,0 7372,1 7374,0 7473,1 7490,0 7512,1 7557,0 7634,1 7663,0 7699,1 7716,0 7736,1 7754,0 7826,1 7847,0 7865,1 7927,0 7929,1 8007,0 8033,1 8111,0 8155,1 8246,0 8298,1 8333,0 8351,1 8367,0 8390,1 8428,0 8468,1 8485,0 8546,1 8548,0 8624,1 8688,0 8698,1 8773,0 8788,1 8846,0 8895,1 8921,0 9002,1 9048,0 9121,1 9152,0 9217,1 9294,0 9355,1 9376,0 9468,1 9550,0 9589,1 9663,0 9703,1 9738,0 9810,1 9842,0 9903,1 9991,0 10025,1 10109,0 10205,1 10214,0 10304,1 10376,0 10469,1 10475,0 10526,1 10538,0 10607,1 10637,0 10659,1 10665,0 10714,1 10809,0 10865,1 10945,0 11045,1 11112,0 11160,1 11190,0 11288,1 11336,0 11365,1 11387,0 11472,1 11547,0 11556,1 11559,0 11648,1 11702,0 11719,1 11768,0 11835,1 11840,0 11874,1 11880,0 11885,1 11969,0 12027,1 12074,0 12153,1 12190,0 12290,1 12344,0 12421,1 12450,0 12508,1 12573,0 12591,1 12627,0 12641,1 12648,0 12685,1 12686,0 12786,1 12798,0 12862,1 12890,0 12965,1 13036,0 13109,1 13150,0 13187,1 13264,0 13291,1 13299,0 13300,1 13306,0 13328,1 13330,0 13379,1 13435,0 13456,1 13506,0 13520,1 13535,0 13551,1 13608,0 13627,1 13682,0 13690,1 13723,0 13765,1 13806,0 13856,1 13944,0 14028,1 14043,0 14107,1 14140,0 14164,1 14176,0 14275,1 14294,0 14384,1 14389,0 14411,1 14453,0 14548,1 14622,0 14654,1 14694,0 14729,1 14742,0 14808,1 14837,0 14937,1 15017,0 15055,1 15088,0 15159,1 15229,0 15240,1 15298,0 15317,1 15371,0 15427,1 15459,0 15486,1 15496,0 15502,1 15587,0 15645,1 15683,0 15746,1 15828,0 15880,1 15903,0 15972,1 16064,0 16095,1 16177,0 16205,1 16264,0 16326,1 16327,0 16426,1 16430,0 16527,1 16606,0 16692,1 16739,0 16820,1 16853,0 16946,1 16957,0 17037,1 17117,0 17135,1 17219,0 17274,1 17358,0 17385,1 17450,0 17527,1 17555,0 17600,1 17648,0 17722,1 17755,0 17832,1 17886,0 17949,1 18033,0 18107,1 18115,0 18158,1 18182,0 18190,1 18260,0 18271,1 18321,0 18345,1 18381,0 18421,1 18471,0 18527,1 18588,0 18664,1 18700,0 18764,1 18786,0 18815,1 18893,0 18928,1 18951,0 18973,1 19011,0 19105,1 19109,0 19141,1 19197,0 19198,1 19253,0 19315,1 19357,0 19408,1 19425,0 19446,1 19531,0 19620,1 19690,0 19788,1 19807,0 19836,1 19921,0 19976,1 20033,0 20050,1 20062,0 20086,1 20097,0 20120,1 20154,0 20237,1 20242,0 20259,1 20318,0 20378,1 20440,0 20530,1 20600,0 20616,1 20651,0 20663,1 20738,0 20834,1 20836,0 20870,1 20967,0 20989,1 21063,0 21074,1 21163,0 21175,1 21223,0 21305,1 21362,0 21445,1 21537,0 21558,1 21571,0 21662,1 21700,0 21712,1 21766,0 21822,1 21836,0 21870,1 21928,0 21984,1 22063,0 22088,1 22098,0 22182,1 22268,0 22282,1 22323,0 22401,1 22471,0 22528,1 22546,0 22593,1 22603,0 22698,1 22735,0 22806,1 22901,0 22903,1 22906,0 22978,1 23015,0 23039,1 23079,0 23130,1 23223,0 23256,1 23346,0 23443,1 23478,0 23525,1 23548,0 23647,1 23694,0 23751,1 23807,0 23846,1 23894,0 23955,1 23987,0 24087,1 24135,0 24145,1 24244,0 24285,1 24384,0 24450,1 24498,0 24593,1 24638,0 24716,1 24724,0 24768,1 24852,0 24861,1 24891,0 24968,1 25042,0 25076,1 25171,0 25247,1 25300,0 25346,1 25401,0 25414,1 25490,0 25566,1 25647,0 25736,1 25813,0 25838,1 25880,0 25920,1 25990,0 26006,1 26079,0 26092,1 26141,0 26147,1 26203,0 26259,1 26314,0 26357,1 26371,0 26450,1 26525,0 26598,1 26697,0 26707,1 26715,0 26784,1 26814,0 26870,1 26947,0 26951,1 26993,0 27000,1 27058,0 27113,1 27202,0 27221,1 27260,0 27334,1 27396,0 27460,1 27549,0 27591,1 27657,0 27681,1 27775,0 27860,1 27865,0 27965,1 28028,0 28079,1 28155,0 28208,1 28268,0 28319,1 28411,0 28476,1 28512,0 28533,1 28613,0 28692,1 28728,0 28761,1 28853,0 28881,1 28955,0 28963,1 29017,0 29063,1 29113,0 29209,1 29229,0 29316,1 29389,0 29488,1 29537,0 29565,1 29642,0 29736,1 29753,0 29833,1 29852,0 29940,1 29943,0 30005,1 30034,0 30036,1 30065,0 30069,1 30095,0 30132,1 30184,0 30195,1 30258,0 30332,1 30399,0 30448,1 30497,0 30523,1 30590,0 30681,1 30695,0 30715,1 30757,0 30790,1 30840,0 30907,1 30915,0 31006,1 31055,0 31110,1 31116,0 31182,1 31254,0 31346,1 31372,0 31385,1 31456,0 31493,1 31578,0 31632,1 31697,0 31709,1 31734,0 31736,1 31749,0 31821,1 31887,0 31936,1 32033,0 32069,1 32109,0 32142,1 32150,0 32151,1 32212,0 32272,1 32332,0 32342,1 32424,0 32467,1 32487,0 32521,1 32571,0 32635,1 32720,0 32729,1 32775,0 32871,1 32966,0 32981,1 33036,0 33130,1 33214,0 33302,1 33396,0 33495,1 33561,0 33661,1 33677,0 33720,1 33730,0 33750,1 33769,0 33846,1 33907,0 34003,1 34059,0 34142,1 34199,0 34214,1 34236,0 34266,1 34290,0 34318,1 34319,0 34328,1 34334,0 34383,1 34409,0 34423,1 34507,0 34572,1 34640,0 34719,1 34769,0 34782,1 34834,0 34916,1 34981,0 35046,1 35051,0 35147,1 35175,0 35241,1 35292,0 35298,1 35385,0 35485,1 35528,0 35583,1 35602,0 35633,1 35651,0 35735,1 35777,0 35832,1 35889,0 35959,1 36020,0 36107,1 36154,0 36170,1 36182,0 36275,1 36345,0 36381,1 36382,0 36481,1 36557,0 36608,1 36646,0 36703,1 36719,0 36803,1 36866,0 36953,1 37010,0 37057,1 37067,0 37144,1 37225,0 37272,1 37277,0 37295,1 37338,0 37434,1 37470,0 37494,1 37573,0 37599,1 37610,0 37667,1 37676,0 37743,1 37837,0 37847,1 37916,0 37919,1 37966,0 38014,1 38062,0 38094,1 38148,0 38233,1 38252,0 38299,1 38302,0 38356,1 38422,0 38439,1 38475,0 38523,1 38565,0 38660,1 38682,0 38686,1 38759,0 38772,1 38816,0 38822,1 38882,0 38945,1 38967,0 39066,1 39073,0 39096,1 39193,0 39228,1 39270,0 39303,1 39311,0 39391,1 39465,0 39503,1 39571,0 39625,1 39680,0 39766,1 39833,0 39843,1 39892,0 39984,1 40011,0 40092,1 40188,0 40229,1 40272,0 40323,1 40339,0 40368,1 40448,0 40520,1 40560,0 40586,1 40596,0 40686,1 40730,0 40792,1 40871,0 40902,1 40905,0 40944,1 40971,0 40993,1 41043,0 41089,1 41182,0 41216,1 41288,0 41337,1 41377,0 41470,1 41486,0 41536,1 41552,0 41578,1 41631,0 41666,1 41694,0 41722,1 41745,0 41753,1 41852,0 41907,1 41987,0 41993,1 42082,0 42117,1 42134,0 42234,1 42237,0 42251,1 42293,0 42310,1 42320,0 42326,1 42338,0 42370,1 42438,0 42502,1 42571,0 42633,1 42692,0 42735,1 42750,0 42784,1 42809,0 42873,1 42896,0 42933,1 43031,0 43126,1 43128,0 43226,1 43294,0 43357,1 43434,0 43514,1 43612,0 43654,1 43699,0 43763,1 43827,0 43918,1 43930,0 44024,1 44073,0 44094,1 44142,0 44163,1 44211,0 44254,1 44330,0 44381,1 44467,0 44487,1 44578,0 44674,1 44700,0 44795,1 44833,0 44916,1 44929,0 45016,1 45033,0 45108,1 45109,0 45123,1 45163,0 45237,1 45273,0 45318,1 45389,0 45453,1 45454,0 45525,1 45625,0 45686,1 45756,0 45833,1 45915,0 46011,1 46100,0 46173,1 46223,0 46236,1 46255,0 46349,1 46398,0 46454,1 46456,0 46495,1 46579,0 46623,1 46629,0 46654,1 46752,0 46829,1 46926,0 46962,1 47061,0 47161,1 47225,0 47256,1 47354,0 47368,1 47386,0 47395,1 47431,0 47467,1 47525,0 47553,1 47574,0 47589,1 47649,0 47727,1 47738,0 47804,1 47902,0 47960,1 48037,0 48079,1 48135,0 48215,1 48217,0 48270,1 48289,0 48293,1 48311,0 48388,1 48437,0 48515,1 48606,0 48702,1 48726,0 48825,1 48834,0 48877,1 48965,0 48987,1 49076,0 49080,1 49097,0 49196,1 49282,0 49381,1 49430,0 49495,1 49575,0 49632,1 49684,0 49696,1 49766,0 49819,1 end initlist a55 0,0 11,1 28,0 122,1 147,0 235,1 261,0 356,1 392,0 437,1 526,0 591,1 638,0 666,1 695,0 710,1 781,0 856,1 890,0 895,1 985,0 988,1 1062,0 1153,1 1172,0 1265,1 1350,0 1424,1 1476,0 1511,1 1580,0 1598,1 1688,0 1753,1 1823,0 1918,1 1958,0 1996,1 2006,0 2066,1 2162,0 2213,1 2218,0 2285,1 2303,0 2357,1 2441,0 2528,1 2597,0 2620,1 2718,0 2745,1 2755,0 2838,1 2929,0 2942,1 2997,0 2998,1 3015,0 3105,1 3178,0 3183,1 3205,0 3297,1 3315,0 3356,1 3435,0 3499,1 3531,0 3561,1 3593,0 3640,1 3703,0 3785,1 3795,0 3846,1 3900,0 3917,1 3934,0 3949,1 4023,0 4103,1 4147,0 4204,1 4260,0 4346,1 4446,0 4454,1 4515,0 4523,1 4578,0 4628,1 4655,0 4746,1 4793,0 4890,1 4987,0 5068,1 5127,0 5156,1 5178,0 5187,1 5240,0 5284,1 5299,0 5351,1 5355,0 5415,1 5514,0 5564,1 5583,0 5644,1 5651,0 5730,1 5736,0 5742,1 5795,0 5856,1 5875,0 5900,1 5990,0 6006,1 6036,0 6076,1 6151,0 6154,1 6218,0 6240,1 6282,0 6321,1 6385,0 6433,1 6505,0 6513,1 6597,0 6673,1 6685,0 6703,1 6742,0 6782,1 6865,0 6919,1 6982,0 7007,1 7034,0 7091,1 7163,0 7243,1 7299,0 7335,1 7394,0 7449,1 7484,0 7549,1 7565,0 7570,1 7669,0 7706,1 7731,0 7783,1 7831,0 7857,1 7948,0 7984,1 8065,0 8118,1 8139,0 8185,1 8211,0 8304,1 8370,0 8392,1 8417,0 8481,1 8577,0 8588,1 8688,0 8720,1 8736,0 8790,1 8810,0 8899,1 8950,0 9032,1 9060,0 9155,1 9239,0 9274,1 9280,0 9291,1 9361,0 9446,1 9494,0 9537,1 9632,0 9730,1 9824,0 9848,1 9875,0 9974,1 10045,0 10111,1 10162,0 10198,1 10201,0 10280,1 10305,0 10315,1 10322,0 10331,1 10385,0 10469,1 10470,0 10475,1 10508,0 10586,1 10636,0 10675,1 10717,0 10730,1 10760,0 10764,1 10773,0 10779,1 10821,0 10891,1 10940,0 10975,1 11034,0 11054,1 11145,0 11202,1 11264,0 11348,1 11350,0 11446,1 11494,0 11504,1 11553,0 11630,1 11678,0 11740,1 11815,0 11824,1 11866,0 11926,1 11969,0 12055,1 12061,0 12064,1 12077,0 12129,1 12196,0 12220,1 12283,0 12352,1 12397,0 12446,1 12461,0 12513,1 12613,0 12686,1 12705,0 12778,1 12839,0 12877,1 12941,0 12949,1 13042,0 13134,1 13218,0 13247,1 13253,0 13285,1 13291,0 13379,1 13463,0 13549,1 13626,0 13677,1 13684,0 13760,1 13762,0 13857,1 13874,0 13952,1 13993,0 14023,1 14039,0 14049,1 14105,0 14142,1 14172,0 14242,1 14252,0 14300,1 14360,0 14376,1 14396,0 14460,1 14515,0 14532,1 14575,0 14606,1 14607,0 14702,1 14745,0 14772,1 14828,0 14885,1 14929,0 14977,1 14993,0 15026,1 15033,0 15035,1 15092,0 15167,1 15243,0 15341,1 15347,0 15349,1 15410,0 15458,1 15543,0 15574,1 15642,0 15718,1 15770,0 15830,1 15903,0 15951,1 16021,0 16045,1 16142,0 16154,1 16246,0 16311,1 16332,0 16375,1 16377,0 16442,1 16533,0 16581,1 16586,0 16648,1 16665,0 16761,1 16768,0 16795,1 16881,0 16909,1 16991,0 17056,1 17066,0 17131,1 17132,0 17210,1 17303,0 17358,1 17395,0 17480,1 17500,0 17528,1 17585,0 17600,1 17695,0 17758,1 17844,0 17897,1 17951,0 17966,1 18047,0 18060,1 18088,0 18173,1 18242,0 18331,1 18377,0 18388,1 18437,0 18517,1 18522,0 18555,1 18631,0 18636,1 18690,0 18747,1 18748,0 18823,1 18826,0 18835,1 18848,0 18860,1 18872,0 18938,1 18982,0 19009,1 19083,0 19147,1 19237,0 19297,1 19395,0 19469,1 19569,0 19661,1 19676,0 19735,1 19797,0 19821,1 19880,0 19959,1 19985,0 20036,1 20075,0 20120,1 20220,0 20229,1 20266,0 20272,1 20310,0 20368,1 20417,0 20512,1 20518,0 20569,1 20582,0 20592,1 20601,0 20635,1 20648,0 20747,1 20805,0 20844,1 20848,0 20930,1 20957,0 21049,1 21103,0 21143,1 21225,0 21226,1 21268,0 21301,1 21390,0 21482,1 21563,0 21652,1 21653,0 21716,1 21737,0 21786,1 21827,0 21850,1 21903,0 21918,1 22001,0 22004,1 22038,0 22042,1 22139,0 22235,1 22322,0 22417,1 22516,0 22592,1 22677,0 22724,1 22761,0 22837,1 22884,0 22899,1 22974,0 23025,1 23081,0 23127,1 23168,0 23224,1 23287,0 23294,1 23362,0 23380,1 23451,0 23534,1 23552,0 23572,1 23606,0 23610,1 23614,0 23630,1 23703,0 23785,1 23831,0 23875,1 23937,0 23983,1 24052,0 24100,1 24166,0 24190,1 24218,0 24221,1 24269,0 24294,1 24390,0 24447,1 24476,0 24556,1 24571,0 24666,1 24731,0 24822,1 24905,0 24951,1 24983,0 25061,1 25119,0 25215,1 25284,0 25321,1 25383,0 25438,1 25463,0 25539,1 25624,0 25636,1 25729,0 25801,1 25827,0 25828,1 25889,0 25950,1 26033,0 26042,1 26133,0 26183,1 26270,0 26315,1 26358,0 26441,1 26489,0 26544,1 26595,0 26671,1 26707,0 26759,1 26823,0 26881,1 26981,0 27027,1 27056,0 27057,1 27109,0 27136,1 27141,0 27156,1 27207,0 27211,1 27270,0 27323,1 27394,0 27491,1 27514,0 27539,1 27636,0 27668,1 27676,0 27766,1 27777,0 27842,1 27899,0 27981,1 27986,0 27999,1 28073,0 28109,1 28172,0 28248,1 28324,0 28417,1 28512,0 28525,1 28585,0 28676,1 28713,0 28736,1 28769,0 28801,1 28869,0 28879,1 28976,0 28977,1 29024,0 29118,1 29147,0 29217,1 29258,0 29268,1 29292,0 29375,1 29474,0 29568,1 29588,0 29623,1 29701,0 29796,1 29802,0 29840,1 29898,0 29948,1 29963,0 30016,1 30046,0 30141,1 30177,0 30251,1 30290,0 30300,1 30339,0 30398,1 30446,0 30494,1 30580,0 30588,1 30624,0 30706,1 30739,0 30831,1 30839,0 30842,1 30882,0 30904,1 30961,0 31002,1 31025,0 31096,1 31147,0 31197,1 31227,0 31229,1 31248,0 31291,1 31342,0 31418,1 31474,0 31478,1 31533,0 31600,1 31626,0 31666,1 31695,0 31741,1 31802,0 31875,1 31897,0 31927,1 32024,0 32084,1 32132,0 32155,1 32239,0 32240,1 32333,0 32353,1 32443,0 32513,1 32557,0 32655,1 32688,0 32690,1 32749,0 32764,1 32815,0 32877,1 32900,0 33000,1 33067,0 33096,1 33104,0 33198,1 33227,0 33247,1 33307,0 33354,1 33370,0 33461,1 33499,0 33550,1 33562,0 33627,1 33640,0 33649,1 33652,0 33711,1 33722,0 33781,1 33859,0 33878,1 33903,0 33992,1 34047,0 34099,1 34128,0 34189,1 34195,0 34239,1 34320,0 34323,1 34412,0 34463,1 34556,0 34608,1 34655,0 34737,1 34830,0 34868,1 34885,0 34937,1 34959,0 35036,1 35111,0 35154,1 35229,0 35260,1 35290,0 35292,1 35326,0 35418,1 35491,0 35542,1 35588,0 35631,1 35677,0 35739,1 35839,0 35935,1 36025,0 36124,1 36199,0 36214,1 36240,0 36307,1 36407,0 36463,1 36557,0 36582,1 36627,0 36643,1 36675,0 36730,1 36812,0 36827,1 36914,0 36991,1 37048,0 37062,1 37086,0 37161,1 37199,0 37236,1 37285,0 37371,1 37407,0 37429,1 37483,0 37575,1 37619,0 37654,1 37655,0 37702,1 37763,0 37795,1 37797,0 37854,1 37892,0 37981,1 37999,0 38057,1 38077,0 38083,1 38111,0 38122,1 38126,0 38208,1 38295,0 38341,1 38387,0 38452,1 38486,0 38539,1 38558,0 38568,1 38637,0 38710,1 38780,0 38841,1 38906,0 38922,1 38961,0 39060,1 39090,0 39098,1 39141,0 39241,1 39306,0 39372,1 39415,0 39454,1 39529,0 39538,1 39579,0 39645,1 39678,0 39712,1 39768,0 39863,1 39960,0 40014,1 40080,0 40091,1 40161,0 40253,1 40342,0 40403,1 40416,0 40459,1 40470,0 40529,1 40590,0 40677,1 40722,0 40784,1 40877,0 40957,1 40985,0 40997,1 41094,0 41126,1 41143,0 41186,1 41259,0 41293,1 41350,0 41446,1 41498,0 41589,1 41677,0 41769,1 41772,0 41850,1 41921,0 41988,1 41997,0 42055,1 42077,0 42124,1 42137,0 42138,1 42177,0 42211,1 42278,0 42366,1 42458,0 42517,1 42558,0 42634,1 42657,0 42721,1 42796,0 42816,1 42866,0 42965,1 43028,0 43128,1 43187,0 43223,1 43235,0 43304,1 43385,0 43424,1 43469,0 43564,1 43581,0 43677,1 43755,0 43831,1 43850,0 43950,1 44002,0 44097,1 44112,0 44185,1 44231,0 44262,1 44310,0 44408,1 44489,0 44535,1 44583,0 44608,1 44646,0 44657,1 44739,0 44747,1 44757,0 44823,1 44884,0 44972,1 45041,0 45050,1 45133,0 45193,1 45239,0 45262,1 45325,0 45326,1 45394,0 45460,1 45479,0 45523,1 45600,0 45628,1 45672,0 45705,1 45790,0 45827,1 45922,0 45955,1 46038,0 46095,1 46181,0 46254,1 46265,0 46355,1 46393,0 46468,1 46474,0 46503,1 46599,0 46604,1 46637,0 46692,1 46696,0 46758,1 46807,0 46850,1 46895,0 46909,1 46937,0 46938,1 46966,0 46967,1 47035,0 47089,1 47159,0 47196,1 47221,0 47285,1 47374,0 47412,1 47417,0 47478,1 47521,0 47562,1 47595,0 47689,1 47691,0 47724,1 47788,0 47865,1 47944,0 47959,1 48020,0 48093,1 48186,0 48262,1 48362,0 48397,1 48480,0 48494,1 48587,0 48642,1 48645,0 48688,1 48711,0 48712,1 48774,0 48809,1 48886,0 48912,1 48945,0 48986,1 49079,0 49099,1 49159,0 49185,1 49226,0 49284,1 49362,0 49397,1 49445,0 49450,1 end initlist a56 0,0 81,1 99,0 168,1 244,0 313,1 405,0 428,1 523,0 581,1 620,0 701,1 762,0 804,1 845,0 848,1 933,0 973,1 1021,0 1111,1 1161,0 1182,1 1246,0 1252,1 1270,0 1296,1 1308,0 1363,1 1379,0 1454,1 1523,0 1620,1 1660,0 1726,1 1728,0 1738,1 1767,0 1812,1 1831,0 1884,1 1946,0 1966,1 1999,0 2032,1 2098,0 2132,1 2180,0 2264,1 2327,0 2420,1 2495,0 2498,1 2525,0 2531,1 2552,0 2561,1 2590,0 2628,1 2682,0 2706,1 2711,0 2789,1 2823,0 2902,1 2926,0 2974,1 3017,0 3088,1 3145,0 3146,1 3177,0 3242,1 3275,0 3348,1 3429,0 3455,1 3457,0 3477,1 3568,0 3647,1 3706,0 3736,1 3829,0 3878,1 3978,0 4014,1 4033,0 4034,1 4111,0 4185,1 4264,0 4336,1 4364,0 4428,1 4476,0 4503,1 4508,0 4518,1 4545,0 4580,1 4608,0 4654,1 4693,0 4743,1 4828,0 4914,1 4997,0 5015,1 5057,0 5062,1 5160,0 5221,1 5256,0 5283,1 5296,0 5336,1 5382,0 5395,1 5414,0 5419,1 5464,0 5470,1 5512,0 5517,1 5529,0 5607,1 5614,0 5639,1 5734,0 5767,1 5811,0 5872,1 5919,0 5951,1 6003,0 6094,1 6177,0 6257,1 6272,0 6344,1 6427,0 6514,1 6530,0 6588,1 6631,0 6643,1 6673,0 6678,1 6679,0 6697,1 6699,0 6789,1 6869,0 6892,1 6900,0 6915,1 6940,0 7006,1 7089,0 7155,1 7187,0 7284,1 7300,0 7336,1 7356,0 7416,1 7476,0 7563,1 7658,0 7702,1 7731,0 7741,1 7746,0 7784,1 7868,0 7918,1 7926,0 7962,1 7992,0 8006,1 8076,0 8139,1 8234,0 8298,1 8348,0 8349,1 8430,0 8476,1 8568,0 8645,1 8721,0 8775,1 8874,0 8966,1 9053,0 9094,1 9122,0 9157,1 9167,0 9245,1 9343,0 9369,1 9406,0 9453,1 9515,0 9610,1 9699,0 9734,1 9742,0 9827,1 9922,0 9971,1 10056,0 10066,1 10160,0 10248,1 10337,0 10418,1 10475,0 10538,1 10613,0 10713,1 10807,0 10901,1 10964,0 11057,1 11112,0 11193,1 11266,0 11279,1 11285,0 11302,1 11387,0 11441,1 11483,0 11545,1 11595,0 11602,1 11677,0 11777,1 11848,0 11933,1 11986,0 12048,1 12095,0 12105,1 12165,0 12235,1 12335,0 12427,1 12466,0 12540,1 12580,0 12669,1 12765,0 12774,1 12838,0 12889,1 12954,0 12996,1 13036,0 13131,1 13221,0 13261,1 13327,0 13357,1 13402,0 13437,1 13439,0 13537,1 13576,0 13631,1 13702,0 13745,1 13785,0 13868,1 13881,0 13896,1 13899,0 13976,1 14025,0 14103,1 14162,0 14220,1 14314,0 14330,1 14389,0 14445,1 14462,0 14513,1 14546,0 14551,1 14570,0 14592,1 14652,0 14741,1 14812,0 14865,1 14962,0 14987,1 15053,0 15131,1 15208,0 15291,1 15345,0 15422,1 15519,0 15533,1 15611,0 15623,1 15661,0 15685,1 15688,0 15771,1 15837,0 15892,1 15904,0 15916,1 15928,0 15995,1 16069,0 16146,1 16196,0 16282,1 16328,0 16330,1 16397,0 16424,1 16465,0 16485,1 16528,0 16555,1 16561,0 16630,1 16650,0 16695,1 16743,0 16830,1 16916,0 16985,1 17073,0 17094,1 17133,0 17219,1 17297,0 17326,1 17358,0 17402,1 17433,0 17470,1 17559,0 17641,1 17741,0 17791,1 17793,0 17832,1 17849,0 17899,1 17939,0 17949,1 17984,0 18035,1 18124,0 18180,1 18266,0 18350,1 18365,0 18465,1 18473,0 18488,1 18527,0 18533,1 18586,0 18608,1 18658,0 18745,1 18763,0 18813,1 18825,0 18923,1 18954,0 18990,1 19041,0 19061,1 19158,0 19232,1 19306,0 19384,1 19389,0 19451,1 19452,0 19500,1 19505,0 19598,1 19672,0 19682,1 19762,0 19784,1 19789,0 19875,1 19922,0 19969,1 19984,0 19986,1 20080,0 20126,1 20135,0 20137,1 20221,0 20250,1 20273,0 20299,1 20385,0 20410,1 20440,0 20471,1 20524,0 20574,1 20645,0 20710,1 20764,0 20851,1 20854,0 20882,1 20884,0 20938,1 21010,0 21078,1 21138,0 21153,1 21194,0 21203,1 21303,0 21398,1 21409,0 21424,1 21514,0 21606,1 21627,0 21677,1 21761,0 21850,1 21931,0 22010,1 22019,0 22085,1 22120,0 22208,1 22246,0 22250,1 22276,0 22296,1 22379,0 22425,1 22479,0 22500,1 22546,0 22551,1 22627,0 22693,1 22707,0 22788,1 22794,0 22892,1 22967,0 23003,1 23071,0 23073,1 23130,0 23142,1 23185,0 23278,1 23279,0 23354,1 23414,0 23475,1 23527,0 23594,1 23682,0 23746,1 23764,0 23841,1 23861,0 23955,1 24014,0 24064,1 24138,0 24187,1 24214,0 24234,1 24267,0 24367,1 24412,0 24455,1 24519,0 24590,1 24627,0 24647,1 24673,0 24687,1 24707,0 24721,1 24742,0 24766,1 24836,0 24839,1 24841,0 24931,1 24939,0 25012,1 25030,0 25077,1 25100,0 25135,1 25222,0 25280,1 25364,0 25418,1 25447,0 25493,1 25563,0 25645,1 25702,0 25714,1 25807,0 25858,1 25878,0 25935,1 26011,0 26042,1 26130,0 26174,1 26207,0 26251,1 26291,0 26357,1 26409,0 26412,1 26461,0 26531,1 26606,0 26692,1 26773,0 26812,1 26842,0 26876,1 26915,0 26984,1 27033,0 27051,1 27053,0 27120,1 27144,0 27171,1 27254,0 27261,1 27297,0 27360,1 27370,0 27406,1 27419,0 27456,1 27477,0 27540,1 27620,0 27698,1 27720,0 27778,1 27831,0 27839,1 27870,0 27886,1 27898,0 27968,1 28017,0 28109,1 28209,0 28220,1 28292,0 28333,1 28338,0 28343,1 28382,0 28385,1 28415,0 28471,1 28479,0 28527,1 28556,0 28590,1 28686,0 28720,1 28809,0 28880,1 28953,0 29052,1 29075,0 29168,1 29208,0 29257,1 29299,0 29360,1 29436,0 29515,1 29569,0 29656,1 29670,0 29702,1 29735,0 29767,1 29860,0 29955,1 30052,0 30133,1 30169,0 30201,1 30204,0 30281,1 30354,0 30436,1 30443,0 30509,1 30609,0 30645,1 30732,0 30742,1 30769,0 30783,1 30823,0 30879,1 30961,0 31044,1 31062,0 31121,1 31194,0 31230,1 31263,0 31281,1 31345,0 31362,1 31433,0 31485,1 31505,0 31522,1 31540,0 31596,1 31693,0 31774,1 31862,0 31890,1 31919,0 31965,1 31992,0 32051,1 32083,0 32140,1 32180,0 32268,1 32331,0 32342,1 32347,0 32430,1 32453,0 32547,1 32617,0 32621,1 32674,0 32749,1 32797,0 32812,1 32892,0 32975,1 32998,0 33049,1 33063,0 33155,1 33181,0 33205,1 33237,0 33267,1 33313,0 33332,1 33373,0 33374,1 33458,0 33490,1 33553,0 33573,1 33649,0 33652,1 33720,0 33770,1 33825,0 33844,1 33902,0 33982,1 34069,0 34080,1 34113,0 34159,1 34199,0 34243,1 34338,0 34362,1 34406,0 34476,1 34560,0 34607,1 34684,0 34728,1 34761,0 34779,1 34875,0 34933,1 35017,0 35070,1 35130,0 35168,1 35260,0 35265,1 35310,0 35369,1 35415,0 35506,1 35510,0 35597,1 35631,0 35637,1 35704,0 35711,1 35784,0 35786,1 35807,0 35853,1 35938,0 36002,1 36021,0 36044,1 36058,0 36129,1 36156,0 36183,1 36263,0 36361,1 36362,0 36461,1 36536,0 36627,1 36670,0 36721,1 36782,0 36783,1 36866,0 36966,1 37047,0 37088,1 37127,0 37191,1 37233,0 37303,1 37371,0 37467,1 37558,0 37571,1 37579,0 37678,1 37689,0 37747,1 37764,0 37783,1 37851,0 37896,1 37943,0 37995,1 38030,0 38116,1 38119,0 38191,1 38277,0 38300,1 38385,0 38434,1 38489,0 38510,1 38565,0 38649,1 38744,0 38783,1 38855,0 38875,1 38898,0 38900,1 38963,0 38975,1 39074,0 39143,1 39150,0 39249,1 39349,0 39430,1 39478,0 39523,1 39547,0 39590,1 39595,0 39693,1 39752,0 39815,1 39817,0 39851,1 39862,0 39885,1 39917,0 39984,1 40038,0 40071,1 40114,0 40156,1 40219,0 40251,1 40315,0 40397,1 40414,0 40447,1 40482,0 40515,1 40612,0 40660,1 40662,0 40694,1 40774,0 40836,1 40916,0 40985,1 41059,0 41108,1 41172,0 41174,1 41191,0 41269,1 41359,0 41362,1 41461,0 41536,1 41615,0 41661,1 41740,0 41787,1 41795,0 41882,1 41905,0 42001,1 42008,0 42076,1 42104,0 42191,1 42266,0 42362,1 42440,0 42527,1 42528,0 42606,1 42645,0 42733,1 42801,0 42807,1 42869,0 42913,1 42959,0 42986,1 42999,0 43095,1 43111,0 43125,1 43173,0 43206,1 43222,0 43273,1 43349,0 43365,1 43462,0 43558,1 43599,0 43650,1 43736,0 43776,1 43821,0 43873,1 43899,0 43956,1 43957,0 43964,1 44041,0 44133,1 44191,0 44255,1 44299,0 44396,1 44479,0 44485,1 44499,0 44568,1 44575,0 44618,1 44642,0 44696,1 44763,0 44837,1 44928,0 45017,1 45117,0 45214,1 45236,0 45284,1 45354,0 45367,1 45454,0 45485,1 45550,0 45615,1 45635,0 45699,1 45773,0 45812,1 45886,0 45917,1 45971,0 46009,1 46019,0 46071,1 46092,0 46179,1 46192,0 46254,1 46315,0 46321,1 46331,0 46355,1 46447,0 46514,1 46568,0 46659,1 46702,0 46725,1 46816,0 46857,1 46924,0 46969,1 47064,0 47155,1 47233,0 47313,1 47384,0 47456,1 47555,0 47571,1 47577,0 47629,1 47632,0 47715,1 47815,0 47827,1 47879,0 47972,1 48011,0 48038,1 48107,0 48134,1 48182,0 48262,1 48338,0 48375,1 48408,0 48409,1 48459,0 48498,1 48502,0 48554,1 48561,0 48608,1 48641,0 48642,1 48696,0 48756,1 48811,0 48879,1 48911,0 48969,1 48984,0 49030,1 49098,0 49147,1 49189,0 49257,1 49340,0 49385,1 49446,0 49464,1 49485,0 49532,1 49580,0 49675,1 end initlist a57 0,0 26,1 73,0 161,1 178,0 266,1 313,0 413,1 499,0 543,1 581,0 673,1 686,0 778,1 811,0 856,1 894,0 901,1 924,0 957,1 1019,0 1032,1 1095,0 1187,1 1188,0 1238,1 1291,0 1360,1 1373,0 1413,1 1463,0 1543,1 1549,0 1575,1 1642,0 1729,1 1781,0 1782,1 1795,0 1877,1 1944,0 2021,1 2106,0 2205,1 2261,0 2328,1 2409,0 2449,1 2499,0 2565,1 2615,0 2710,1 2765,0 2784,1 2789,0 2853,1 2938,0 2999,1 3052,0 3136,1 3139,0 3204,1 3259,0 3275,1 3354,0 3451,1 3521,0 3593,1 3635,0 3651,1 3736,0 3811,1 3824,0 3890,1 3908,0 3992,1 4058,0 4104,1 4107,0 4150,1 4223,0 4286,1 4358,0 4413,1 4439,0 4526,1 4557,0 4586,1 4587,0 4588,1 4656,0 4736,1 4757,0 4855,1 4861,0 4915,1 4975,0 5020,1 5027,0 5068,1 5136,0 5173,1 5245,0 5319,1 5371,0 5417,1 5511,0 5590,1 5675,0 5773,1 5869,0 5901,1 5912,0 5980,1 6004,0 6063,1 6147,0 6189,1 6262,0 6285,1 6305,0 6369,1 6403,0 6486,1 6561,0 6661,1 6673,0 6731,1 6778,0 6821,1 6842,0 6859,1 6894,0 6981,1 7016,0 7035,1 7069,0 7163,1 7210,0 7224,1 7305,0 7376,1 7387,0 7471,1 7554,0 7602,1 7608,0 7627,1 7629,0 7649,1 7730,0 7740,1 7836,0 7904,1 7947,0 8019,1 8036,0 8090,1 8174,0 8246,1 8286,0 8299,1 8323,0 8368,1 8428,0 8473,1 8514,0 8580,1 8655,0 8748,1 8836,0 8888,1 8925,0 8990,1 9028,0 9121,1 9125,0 9172,1 9231,0 9271,1 9276,0 9342,1 9392,0 9451,1 9479,0 9563,1 9618,0 9678,1 9697,0 9766,1 9793,0 9848,1 9865,0 9893,1 9916,0 9977,1 9992,0 10014,1 10039,0 10120,1 10211,0 10261,1 10354,0 10365,1 10432,0 10508,1 10570,0 10604,1 10625,0 10664,1 10751,0 10806,1 10836,0 10842,1 10924,0 11004,1 11039,0 11092,1 11119,0 11198,1 11280,0 11345,1 11366,0 11457,1 11551,0 11572,1 11585,0 11684,1 11768,0 11806,1 11820,0 11849,1 11925,0 11938,1 11969,0 12007,1 12099,0 12129,1 12167,0 12197,1 12248,0 12337,1 12428,0 12432,1 12467,0 12506,1 12541,0 12610,1 12701,0 12717,1 12725,0 12762,1 12814,0 12897,1 12953,0 12970,1 13070,0 13085,1 13089,0 13156,1 13227,0 13264,1 13329,0 13415,1 13481,0 13520,1 13612,0 13674,1 13723,0 13810,1 13859,0 13918,1 13985,0 14064,1 14117,0 14145,1 14225,0 14313,1 14323,0 14334,1 14417,0 14443,1 14496,0 14591,1 14667,0 14751,1 14821,0 14850,1 14890,0 14941,1 14973,0 15034,1 15056,0 15155,1 15217,0 15268,1 15308,0 15365,1 15418,0 15510,1 15570,0 15616,1 15694,0 15758,1 15849,0 15894,1 15922,0 15932,1 15976,0 16060,1 16082,0 16181,1 16206,0 16296,1 16303,0 16403,1 16457,0 16531,1 16560,0 16562,1 16639,0 16694,1 16785,0 16832,1 16837,0 16934,1 16958,0 17035,1 17055,0 17148,1 17182,0 17194,1 17223,0 17227,1 17289,0 17295,1 17328,0 17408,1 17499,0 17516,1 17546,0 17557,1 17565,0 17569,1 17661,0 17736,1 17738,0 17777,1 17813,0 17829,1 17835,0 17931,1 18028,0 18110,1 18167,0 18249,1 18341,0 18388,1 18464,0 18564,1 18662,0 18746,1 18750,0 18759,1 18765,0 18796,1 18865,0 18880,1 18922,0 18966,1 19051,0 19055,1 19150,0 19220,1 19243,0 19307,1 19322,0 19369,1 19392,0 19456,1 19476,0 19546,1 19562,0 19627,1 19725,0 19736,1 19765,0 19771,1 19778,0 19779,1 19810,0 19903,1 19966,0 20013,1 20084,0 20179,1 20251,0 20340,1 20378,0 20474,1 20569,0 20614,1 20647,0 20661,1 20730,0 20748,1 20817,0 20840,1 20934,0 21018,1 21114,0 21140,1 21228,0 21244,1 21288,0 21345,1 21398,0 21417,1 21480,0 21546,1 21623,0 21661,1 21692,0 21703,1 21762,0 21812,1 21833,0 21902,1 21997,0 22065,1 22126,0 22143,1 22243,0 22269,1 22315,0 22350,1 22357,0 22373,1 22387,0 22477,1 22550,0 22567,1 22603,0 22678,1 22720,0 22727,1 22744,0 22768,1 22775,0 22871,1 22897,0 22913,1 22957,0 23047,1 23051,0 23118,1 23159,0 23189,1 23239,0 23314,1 23326,0 23400,1 23422,0 23481,1 23528,0 23547,1 23637,0 23696,1 23717,0 23775,1 23819,0 23866,1 23893,0 23931,1 23947,0 24030,1 24119,0 24124,1 24215,0 24224,1 24269,0 24317,1 24351,0 24402,1 24487,0 24565,1 24642,0 24736,1 24797,0 24811,1 24842,0 24936,1 25004,0 25028,1 25099,0 25155,1 25211,0 25220,1 25278,0 25372,1 25420,0 25433,1 25437,0 25514,1 25536,0 25580,1 25589,0 25611,1 25623,0 25674,1 25740,0 25798,1 25889,0 25930,1 25952,0 25964,1 26050,0 26125,1 26127,0 26173,1 26226,0 26315,1 26395,0 26425,1 26519,0 26616,1 26680,0 26762,1 26848,0 26911,1 27007,0 27093,1 27191,0 27222,1 27297,0 27344,1 27423,0 27470,1 27508,0 27580,1 27677,0 27687,1 27706,0 27802,1 27881,0 27902,1 27991,0 28015,1 28046,0 28119,1 28167,0 28240,1 28288,0 28360,1 28426,0 28465,1 28503,0 28601,1 28637,0 28675,1 28713,0 28784,1 28821,0 28904,1 28945,0 29024,1 29057,0 29155,1 29163,0 29182,1 29281,0 29362,1 29411,0 29467,1 29539,0 29569,1 29625,0 29716,1 29798,0 29812,1 29857,0 29953,1 30052,0 30097,1 30185,0 30218,1 30225,0 30271,1 30302,0 30366,1 30402,0 30487,1 30500,0 30551,1 30637,0 30646,1 30719,0 30760,1 30813,0 30911,1 30970,0 30971,1 30974,0 31026,1 31085,0 31116,1 31181,0 31213,1 31273,0 31330,1 31376,0 31427,1 31472,0 31569,1 31579,0 31625,1 31699,0 31716,1 31732,0 31735,1 31749,0 31846,1 31944,0 32018,1 32096,0 32160,1 32172,0 32271,1 32283,0 32317,1 32407,0 32416,1 32446,0 32495,1 32575,0 32664,1 32723,0 32763,1 32842,0 32869,1 32894,0 32918,1 32937,0 33011,1 33061,0 33069,1 33157,0 33172,1 33270,0 33280,1 33312,0 33356,1 33446,0 33478,1 33552,0 33576,1 33644,0 33741,1 33836,0 33855,1 33941,0 34038,1 34041,0 34044,1 34141,0 34187,1 34195,0 34255,1 34286,0 34316,1 34369,0 34439,1 34499,0 34573,1 34670,0 34708,1 34710,0 34793,1 34810,0 34878,1 34907,0 34927,1 35027,0 35095,1 35143,0 35173,1 35176,0 35272,1 35283,0 35336,1 35417,0 35474,1 35520,0 35619,1 35680,0 35778,1 35779,0 35825,1 35826,0 35858,1 35866,0 35959,1 36013,0 36047,1 36111,0 36198,1 36231,0 36280,1 36319,0 36400,1 36410,0 36458,1 36535,0 36629,1 36670,0 36701,1 36705,0 36724,1 36767,0 36783,1 36867,0 36872,1 36958,0 36970,1 37037,0 37052,1 37143,0 37192,1 37253,0 37341,1 37362,0 37376,1 37396,0 37451,1 37495,0 37572,1 37575,0 37620,1 37638,0 37655,1 37738,0 37786,1 37794,0 37863,1 37960,0 38003,1 38066,0 38126,1 38139,0 38175,1 38211,0 38306,1 38395,0 38467,1 38475,0 38504,1 38583,0 38605,1 38606,0 38655,1 38689,0 38729,1 38787,0 38856,1 38889,0 38989,1 39086,0 39113,1 39145,0 39219,1 39304,0 39400,1 39481,0 39520,1 39523,0 39615,1 39703,0 39718,1 39787,0 39861,1 39867,0 39908,1 39945,0 40039,1 40106,0 40146,1 40244,0 40293,1 40380,0 40443,1 40500,0 40589,1 40597,0 40614,1 40636,0 40682,1 40728,0 40799,1 40810,0 40853,1 40929,0 41007,1 41008,0 41059,1 41115,0 41150,1 41165,0 41248,1 41275,0 41344,1 41443,0 41479,1 41572,0 41595,1 41671,0 41760,1 41785,0 41802,1 41830,0 41836,1 41849,0 41881,1 41907,0 41939,1 41985,0 42006,1 42012,0 42083,1 42149,0 42152,1 42229,0 42325,1 42379,0 42388,1 42475,0 42572,1 42591,0 42602,1 42683,0 42691,1 42786,0 42884,1 42963,0 43063,1 43153,0 43225,1 43314,0 43395,1 43400,0 43430,1 43452,0 43480,1 43516,0 43540,1 43614,0 43657,1 43710,0 43773,1 43842,0 43902,1 43945,0 43982,1 44019,0 44039,1 44106,0 44128,1 44139,0 44214,1 44297,0 44380,1 44388,0 44402,1 44442,0 44501,1 44598,0 44698,1 44712,0 44763,1 44836,0 44842,1 44906,0 44960,1 45048,0 45140,1 45192,0 45203,1 45240,0 45266,1 45364,0 45368,1 45449,0 45543,1 45634,0 45706,1 45802,0 45892,1 45914,0 45987,1 46012,0 46014,1 46056,0 46074,1 46108,0 46147,1 46178,0 46219,1 46299,0 46323,1 46422,0 46451,1 46468,0 46559,1 46656,0 46744,1 46748,0 46834,1 46859,0 46940,1 46973,0 47004,1 47069,0 47143,1 47234,0 47246,1 47310,0 47399,1 47434,0 47505,1 47533,0 47632,1 47698,0 47748,1 47801,0 47822,1 47878,0 47895,1 47949,0 47993,1 48007,0 48044,1 48130,0 48151,1 48207,0 48211,1 48283,0 48340,1 48352,0 48371,1 48439,0 48537,1 48600,0 48657,1 48707,0 48725,1 48782,0 48851,1 48872,0 48886,1 48956,0 49041,1 49061,0 49102,1 49103,0 49108,1 49187,0 49265,1 49324,0 49332,1 49422,0 49427,1 49480,0 49572,1 49602,0 49683,1 49777,0 49835,1 49842,0 49907,1 49973,0 50009,1 50018,0 50052,1 50097,0 50124,1 50215,0 50229,1 50230,0 50244,1 50279,0 50339,1 50345,0 50403,1 50465,0 50520,1 50563,0 50613,1 50652,0 50740,1 50758,0 50774,1 50816,0 50839,1 end initlist a58 0,0 72,1 151,0 231,1 235,0 296,1 301,0 359,1 429,0 515,1 604,0 693,1 706,0 741,1 806,0 852,1 872,0 895,1 920,0 927,1 928,0 976,1 1058,0 1131,1 1184,0 1187,1 1224,0 1242,1 1280,0 1286,1 1330,0 1371,1 1409,0 1425,1 1491,0 1568,1 1654,0 1688,1 1774,0 1824,1 1844,0 1905,1 1914,0 1956,1 1991,0 2075,1 2112,0 2212,1 2306,0 2347,1 2418,0 2431,1 2456,0 2461,1 2512,0 2546,1 2591,0 2606,1 2677,0 2759,1 2837,0 2896,1 2928,0 2932,1 2937,0 3020,1 3107,0 3134,1 3219,0 3308,1 3373,0 3391,1 3486,0 3556,1 3591,0 3602,1 3610,0 3691,1 3791,0 3815,1 3854,0 3943,1 3972,0 4034,1 4057,0 4100,1 4126,0 4147,1 4153,0 4252,1 4343,0 4397,1 4430,0 4491,1 4521,0 4588,1 4611,0 4621,1 4635,0 4722,1 4771,0 4789,1 4816,0 4910,1 4933,0 4978,1 5019,0 5068,1 5124,0 5159,1 5167,0 5225,1 5250,0 5294,1 5325,0 5408,1 5468,0 5510,1 5568,0 5578,1 5617,0 5717,1 5781,0 5878,1 5890,0 5975,1 6027,0 6099,1 6163,0 6256,1 6327,0 6362,1 6400,0 6483,1 6540,0 6640,1 6740,0 6783,1 6803,0 6845,1 6888,0 6931,1 6967,0 7017,1 7052,0 7063,1 7121,0 7142,1 7211,0 7304,1 7355,0 7375,1 7447,0 7503,1 7571,0 7627,1 7691,0 7735,1 7809,0 7841,1 7888,0 7894,1 7937,0 7982,1 7994,0 8024,1 8104,0 8195,1 8272,0 8351,1 8423,0 8454,1 8525,0 8612,1 8664,0 8684,1 8775,0 8803,1 8874,0 8945,1 8984,0 8990,1 9073,0 9092,1 9139,0 9189,1 9287,0 9293,1 9318,0 9330,1 9338,0 9379,1 9401,0 9457,1 9479,0 9523,1 9545,0 9581,1 9670,0 9770,1 9829,0 9885,1 9929,0 9987,1 10076,0 10105,1 10118,0 10194,1 10289,0 10335,1 10425,0 10438,1 10465,0 10518,1 10573,0 10641,1 10682,0 10768,1 10818,0 10880,1 10889,0 10929,1 10941,0 11013,1 11108,0 11146,1 11192,0 11279,1 11337,0 11365,1 11388,0 11423,1 11490,0 11544,1 11618,0 11710,1 11787,0 11820,1 11826,0 11881,1 11938,0 11950,1 11951,0 12040,1 12090,0 12108,1 12119,0 12156,1 12236,0 12288,1 12328,0 12423,1 12518,0 12571,1 12663,0 12679,1 12739,0 12768,1 12845,0 12942,1 12947,0 12967,1 13011,0 13090,1 13103,0 13130,1 13219,0 13317,1 13367,0 13446,1 13454,0 13477,1 13520,0 13553,1 13578,0 13653,1 13671,0 13770,1 13856,0 13906,1 13996,0 14007,1 14100,0 14104,1 14159,0 14204,1 14232,0 14239,1 14315,0 14385,1 14460,0 14496,1 14547,0 14582,1 14640,0 14682,1 14719,0 14764,1 14771,0 14855,1 14880,0 14888,1 14895,0 14987,1 15081,0 15134,1 15232,0 15234,1 15269,0 15367,1 15382,0 15386,1 15417,0 15482,1 15551,0 15650,1 15732,0 15769,1 15862,0 15955,1 16006,0 16106,1 16112,0 16148,1 16158,0 16197,1 16235,0 16245,1 16303,0 16356,1 16443,0 16521,1 16537,0 16599,1 16623,0 16719,1 16801,0 16896,1 16924,0 16995,1 17041,0 17111,1 17184,0 17202,1 17278,0 17341,1 17397,0 17442,1 17495,0 17545,1 17548,0 17634,1 17701,0 17774,1 17819,0 17879,1 17972,0 18030,1 18121,0 18177,1 18265,0 18344,1 18438,0 18530,1 18618,0 18666,1 18669,0 18760,1 18789,0 18809,1 18867,0 18883,1 18938,0 19005,1 19092,0 19150,1 19225,0 19297,1 19304,0 19310,1 19408,0 19447,1 19500,0 19563,1 19580,0 19608,1 19631,0 19658,1 19749,0 19763,1 19783,0 19824,1 19879,0 19925,1 19930,0 19952,1 19992,0 20092,1 20099,0 20109,1 20169,0 20233,1 20331,0 20387,1 20467,0 20495,1 20559,0 20647,1 20700,0 20798,1 20838,0 20894,1 20895,0 20932,1 21021,0 21069,1 21151,0 21191,1 21248,0 21309,1 21322,0 21355,1 21391,0 21470,1 21569,0 21611,1 21639,0 21666,1 21715,0 21784,1 21860,0 21900,1 21926,0 22003,1 22082,0 22182,1 22269,0 22343,1 22442,0 22540,1 22544,0 22609,1 22689,0 22781,1 22785,0 22842,1 22901,0 22939,1 22955,0 22977,1 23005,0 23013,1 23041,0 23124,1 23197,0 23289,1 23356,0 23452,1 23518,0 23555,1 23593,0 23600,1 23691,0 23746,1 23804,0 23846,1 23908,0 23955,1 24012,0 24056,1 24155,0 24218,1 24233,0 24277,1 24343,0 24350,1 24401,0 24412,1 24421,0 24437,1 24510,0 24527,1 24575,0 24656,1 24728,0 24812,1 24849,0 24877,1 24959,0 24963,1 25058,0 25116,1 25127,0 25206,1 25208,0 25283,1 25372,0 25377,1 25449,0 25474,1 25508,0 25547,1 25632,0 25704,1 25786,0 25834,1 25836,0 25912,1 25940,0 26030,1 26081,0 26085,1 26132,0 26166,1 26232,0 26295,1 26345,0 26381,1 26445,0 26518,1 26539,0 26602,1 26687,0 26780,1 26791,0 26859,1 26921,0 26998,1 27005,0 27079,1 27172,0 27207,1 27215,0 27222,1 27229,0 27317,1 27382,0 27450,1 27519,0 27608,1 27651,0 27700,1 27778,0 27787,1 27833,0 27902,1 27969,0 28012,1 28017,0 28044,1 28066,0 28083,1 28137,0 28201,1 28233,0 28294,1 28334,0 28345,1 28372,0 28402,1 28486,0 28524,1 28609,0 28640,1 28712,0 28743,1 28789,0 28876,1 28902,0 28977,1 29062,0 29068,1 29077,0 29138,1 29194,0 29293,1 29378,0 29460,1 29473,0 29490,1 29575,0 29640,1 29644,0 29671,1 29768,0 29851,1 29891,0 29931,1 29936,0 29963,1 30017,0 30105,1 30130,0 30182,1 30238,0 30245,1 30262,0 30328,1 30350,0 30370,1 30379,0 30450,1 30472,0 30529,1 30588,0 30666,1 30719,0 30803,1 30814,0 30870,1 30944,0 30953,1 31028,0 31108,1 31188,0 31249,1 31282,0 31314,1 31319,0 31415,1 31441,0 31519,1 31594,0 31598,1 31696,0 31731,1 31794,0 31813,1 31824,0 31892,1 31980,0 32030,1 32038,0 32039,1 32112,0 32176,1 32243,0 32296,1 32350,0 32367,1 32410,0 32411,1 32506,0 32570,1 32599,0 32649,1 32684,0 32782,1 32818,0 32831,1 32888,0 32936,1 33012,0 33026,1 33089,0 33090,1 33175,0 33220,1 33292,0 33300,1 33398,0 33484,1 33518,0 33546,1 33616,0 33624,1 33704,0 33708,1 33715,0 33791,1 33798,0 33800,1 33852,0 33904,1 33970,0 34034,1 34095,0 34102,1 34164,0 34171,1 34239,0 34265,1 34271,0 34279,1 34350,0 34410,1 34485,0 34548,1 34561,0 34626,1 34658,0 34727,1 34820,0 34856,1 34932,0 34959,1 35049,0 35113,1 35115,0 35214,1 35215,0 35286,1 35346,0 35378,1 35428,0 35438,1 35457,0 35467,1 35513,0 35572,1 35620,0 35646,1 35726,0 35815,1 35847,0 35914,1 36013,0 36099,1 36190,0 36278,1 36282,0 36337,1 36357,0 36370,1 36467,0 36505,1 36560,0 36581,1 36619,0 36649,1 36704,0 36754,1 36781,0 36782,1 36808,0 36826,1 36847,0 36921,1 36948,0 36977,1 37046,0 37135,1 37143,0 37234,1 37318,0 37417,1 37508,0 37559,1 37562,0 37575,1 37594,0 37650,1 37658,0 37687,1 37786,0 37865,1 37868,0 37911,1 37929,0 37959,1 38037,0 38134,1 38218,0 38304,1 38307,0 38345,1 38383,0 38441,1 38503,0 38516,1 38555,0 38604,1 38696,0 38776,1 38796,0 38860,1 38892,0 38909,1 38975,0 38996,1 39088,0 39091,1 39102,0 39165,1 39221,0 39312,1 39358,0 39395,1 39419,0 39429,1 39444,0 39539,1 39568,0 39625,1 39636,0 39704,1 39731,0 39773,1 39807,0 39902,1 39966,0 40007,1 40010,0 40107,1 40174,0 40186,1 40285,0 40304,1 40363,0 40452,1 40478,0 40523,1 40538,0 40634,1 40671,0 40738,1 40826,0 40922,1 41011,0 41049,1 41061,0 41149,1 41222,0 41254,1 41256,0 41310,1 41325,0 41331,1 41338,0 41342,1 41375,0 41393,1 41493,0 41512,1 41554,0 41617,1 41678,0 41757,1 41835,0 41857,1 41900,0 41985,1 42019,0 42035,1 42098,0 42117,1 42182,0 42278,1 42291,0 42365,1 42381,0 42443,1 42447,0 42486,1 42572,0 42581,1 42669,0 42736,1 42823,0 42848,1 42882,0 42978,1 43017,0 43062,1 43125,0 43190,1 43192,0 43284,1 43326,0 43414,1 43445,0 43517,1 43538,0 43629,1 43694,0 43739,1 43766,0 43805,1 43813,0 43893,1 43929,0 44001,1 44099,0 44109,1 44155,0 44220,1 44305,0 44307,1 44329,0 44398,1 44412,0 44466,1 44520,0 44608,1 44644,0 44698,1 44699,0 44792,1 44854,0 44894,1 44952,0 45026,1 45118,0 45154,1 45178,0 45179,1 45252,0 45337,1 45427,0 45431,1 45506,0 45545,1 45559,0 45626,1 45704,0 45795,1 45854,0 45935,1 45958,0 46039,1 46137,0 46157,1 46201,0 46255,1 46334,0 46404,1 46416,0 46511,1 46519,0 46574,1 46592,0 46648,1 46737,0 46833,1 46855,0 46894,1 46968,0 47034,1 47094,0 47142,1 47217,0 47233,1 47317,0 47401,1 47491,0 47582,1 47658,0 47715,1 47790,0 47875,1 47913,0 47980,1 48037,0 48076,1 48153,0 48227,1 48321,0 48363,1 48432,0 48483,1 48490,0 48513,1 48531,0 48558,1 48653,0 48701,1 48781,0 48840,1 48926,0 48980,1 48983,0 49028,1 49050,0 49142,1 49229,0 49321,1 49369,0 49397,1 49458,0 49487,1 49499,0 49586,1 49622,0 49642,1 49671,0 49672,1 49707,0 49756,1 49764,0 49772,1 49849,0 49926,1 50020,0 50076,1 50159,0 50216,1 50238,0 50290,1 50322,0 50391,1 50438,0 50495,1 end initlist a59 0,0 81,1 98,0 124,1 185,0 233,1 320,0 366,1 395,0 429,1 506,0 534,1 556,0 599,1 600,0 645,1 672,0 736,1 751,0 850,1 890,0 985,1 1076,0 1149,1 1172,0 1246,1 1346,0 1365,1 1437,0 1497,1 1580,0 1674,1 1681,0 1742,1 1834,0 1836,1 1885,0 1925,1 2010,0 2083,1 2172,0 2260,1 2346,0 2357,1 2381,0 2467,1 2535,0 2539,1 2626,0 2633,1 2715,0 2720,1 2763,0 2807,1 2850,0 2894,1 2899,0 2941,1 2970,0 2975,1 3074,0 3095,1 3151,0 3218,1 3264,0 3340,1 3372,0 3385,1 3482,0 3575,1 3640,0 3725,1 3774,0 3846,1 3921,0 3961,1 4053,0 4095,1 4132,0 4149,1 4247,0 4259,1 4270,0 4278,1 4372,0 4427,1 4459,0 4557,1 4608,0 4637,1 4701,0 4754,1 4818,0 4820,1 4902,0 4965,1 4969,0 5040,1 5050,0 5070,1 5141,0 5199,1 5286,0 5343,1 5402,0 5429,1 5436,0 5526,1 5532,0 5538,1 5619,0 5712,1 5756,0 5772,1 5824,0 5883,1 5959,0 6011,1 6017,0 6068,1 6086,0 6137,1 6166,0 6182,1 6205,0 6226,1 6270,0 6333,1 6359,0 6402,1 6470,0 6471,1 6569,0 6596,1 6633,0 6658,1 6721,0 6759,1 6808,0 6820,1 6867,0 6909,1 6910,0 6920,1 6995,0 7055,1 7148,0 7151,1 7243,0 7270,1 7278,0 7365,1 7424,0 7453,1 7527,0 7601,1 7669,0 7695,1 7770,0 7834,1 7846,0 7881,1 7895,0 7983,1 7987,0 8053,1 8090,0 8129,1 8180,0 8233,1 8258,0 8301,1 8358,0 8402,1 8426,0 8455,1 8499,0 8578,1 8634,0 8675,1 8749,0 8790,1 8794,0 8845,1 8945,0 8950,1 8974,0 9003,1 9006,0 9046,1 9102,0 9183,1 9187,0 9226,1 9320,0 9395,1 9464,0 9466,1 9523,0 9623,1 9648,0 9660,1 9673,0 9679,1 9682,0 9759,1 9837,0 9928,1 9944,0 9964,1 9982,0 10077,1 10140,0 10155,1 10214,0 10248,1 10312,0 10317,1 10404,0 10412,1 10472,0 10482,1 10510,0 10570,1 10653,0 10700,1 10708,0 10751,1 10839,0 10870,1 10879,0 10901,1 10939,0 10987,1 11031,0 11062,1 11156,0 11192,1 11290,0 11343,1 11355,0 11400,1 11477,0 11486,1 11586,0 11641,1 11733,0 11754,1 11834,0 11920,1 11921,0 11949,1 12020,0 12109,1 12161,0 12206,1 12229,0 12235,1 12334,0 12387,1 12441,0 12512,1 12549,0 12611,1 12658,0 12662,1 12699,0 12763,1 12850,0 12933,1 13032,0 13048,1 13076,0 13129,1 13159,0 13208,1 13277,0 13336,1 13419,0 13447,1 13493,0 13525,1 13557,0 13613,1 13692,0 13725,1 13792,0 13865,1 13908,0 13940,1 14021,0 14088,1 14120,0 14155,1 14246,0 14333,1 14366,0 14380,1 14419,0 14428,1 14475,0 14574,1 14663,0 14745,1 14837,0 14927,1 14939,0 14985,1 15051,0 15115,1 15172,0 15270,1 15340,0 15377,1 15382,0 15421,1 15430,0 15461,1 15469,0 15490,1 15508,0 15529,1 15577,0 15601,1 15673,0 15736,1 15832,0 15839,1 15881,0 15977,1 15986,0 16030,1 16040,0 16053,1 16102,0 16112,1 16204,0 16285,1 16324,0 16354,1 16369,0 16441,1 16456,0 16547,1 16617,0 16641,1 16648,0 16683,1 16760,0 16798,1 16819,0 16887,1 16888,0 16904,1 16919,0 16966,1 16971,0 17031,1 17129,0 17164,1 17253,0 17274,1 17364,0 17443,1 17529,0 17582,1 17626,0 17627,1 17671,0 17714,1 17725,0 17738,1 17745,0 17757,1 17813,0 17840,1 17890,0 17956,1 18053,0 18147,1 18210,0 18270,1 18296,0 18319,1 18405,0 18484,1 18535,0 18547,1 18622,0 18716,1 18742,0 18769,1 18854,0 18943,1 18979,0 19067,1 19135,0 19202,1 19212,0 19285,1 19311,0 19335,1 19363,0 19429,1 19520,0 19616,1 19644,0 19677,1 19711,0 19750,1 19755,0 19814,1 19823,0 19845,1 19938,0 20001,1 20092,0 20106,1 20133,0 20175,1 20235,0 20244,1 20247,0 20292,1 20319,0 20394,1 20424,0 20498,1 20585,0 20652,1 20721,0 20801,1 20862,0 20889,1 20941,0 20974,1 21059,0 21149,1 21233,0 21263,1 21342,0 21410,1 21449,0 21460,1 21552,0 21554,1 21613,0 21648,1 21736,0 21831,1 21901,0 21965,1 21993,0 22085,1 22179,0 22271,1 22281,0 22371,1 22423,0 22441,1 22507,0 22556,1 22576,0 22585,1 22647,0 22702,1 22793,0 22842,1 22880,0 22974,1 23037,0 23073,1 23113,0 23133,1 23197,0 23227,1 23253,0 23300,1 23353,0 23421,1 23456,0 23503,1 23533,0 23623,1 23702,0 23753,1 23851,0 23926,1 24023,0 24033,1 24066,0 24123,1 24143,0 24171,1 24226,0 24248,1 24264,0 24302,1 24333,0 24428,1 24443,0 24479,1 24545,0 24548,1 24574,0 24651,1 24659,0 24667,1 24695,0 24739,1 24810,0 24868,1 24944,0 24975,1 25019,0 25083,1 25106,0 25161,1 25225,0 25272,1 25293,0 25310,1 25376,0 25422,1 25484,0 25536,1 25595,0 25679,1 25731,0 25819,1 25904,0 25956,1 25990,0 26051,1 26129,0 26195,1 26288,0 26347,1 26380,0 26447,1 26462,0 26546,1 26602,0 26650,1 26679,0 26760,1 26785,0 26815,1 26859,0 26941,1 27016,0 27083,1 27128,0 27137,1 27145,0 27195,1 27249,0 27285,1 27312,0 27338,1 27366,0 27401,1 27489,0 27581,1 27600,0 27656,1 27722,0 27760,1 27797,0 27835,1 27864,0 27902,1 27976,0 28055,1 28075,0 28164,1 28208,0 28256,1 28295,0 28365,1 28370,0 28398,1 28435,0 28477,1 28516,0 28544,1 28570,0 28590,1 28641,0 28707,1 28772,0 28774,1 28781,0 28868,1 28882,0 28955,1 28968,0 29022,1 29053,0 29058,1 29081,0 29164,1 29241,0 29287,1 29338,0 29410,1 29494,0 29499,1 29556,0 29650,1 29662,0 29718,1 29749,0 29772,1 29812,0 29903,1 29932,0 29979,1 30019,0 30113,1 30115,0 30142,1 30159,0 30239,1 30298,0 30367,1 30411,0 30482,1 30483,0 30559,1 30593,0 30663,1 30676,0 30686,1 30722,0 30771,1 30792,0 30884,1 30941,0 30960,1 30961,0 31050,1 31074,0 31153,1 31190,0 31199,1 31228,0 31313,1 31375,0 31457,1 31469,0 31558,1 31609,0 31615,1 31681,0 31700,1 31745,0 31842,1 31881,0 31888,1 31987,0 32046,1 32125,0 32130,1 32160,0 32224,1 32320,0 32402,1 32477,0 32489,1 32508,0 32604,1 32631,0 32698,1 32729,0 32818,1 32852,0 32883,1 32926,0 32938,1 32976,0 33037,1 33071,0 33091,1 33167,0 33181,1 33248,0 33333,1 33363,0 33385,1 33465,0 33486,1 33534,0 33548,1 33616,0 33660,1 33683,0 33775,1 33834,0 33901,1 33988,0 34040,1 34102,0 34154,1 34226,0 34303,1 34378,0 34392,1 34472,0 34552,1 34618,0 34636,1 34695,0 34711,1 34763,0 34859,1 34898,0 34977,1 35027,0 35090,1 35167,0 35176,1 35183,0 35221,1 35297,0 35372,1 35380,0 35461,1 35523,0 35585,1 35663,0 35681,1 35781,0 35859,1 35888,0 35954,1 35992,0 36090,1 36114,0 36198,1 36206,0 36256,1 36297,0 36372,1 36421,0 36461,1 36561,0 36618,1 36694,0 36758,1 36813,0 36904,1 36974,0 37062,1 37087,0 37165,1 37227,0 37305,1 37308,0 37325,1 37364,0 37434,1 37467,0 37477,1 37567,0 37614,1 37616,0 37680,1 37704,0 37751,1 37848,0 37887,1 37987,0 38046,1 38050,0 38070,1 38156,0 38210,1 38275,0 38364,1 38456,0 38513,1 38556,0 38653,1 38668,0 38709,1 38719,0 38780,1 38855,0 38880,1 38964,0 38974,1 38978,0 39062,1 39127,0 39180,1 39226,0 39282,1 39377,0 39387,1 39451,0 39497,1 39521,0 39569,1 39610,0 39681,1 39757,0 39781,1 39789,0 39837,1 39895,0 39959,1 40059,0 40144,1 40180,0 40247,1 40327,0 40388,1 40468,0 40524,1 40531,0 40619,1 40649,0 40723,1 40817,0 40908,1 40943,0 40964,1 41001,0 41031,1 41035,0 41102,1 41121,0 41216,1 41297,0 41394,1 41401,0 41484,1 41560,0 41594,1 41623,0 41659,1 41686,0 41757,1 41821,0 41915,1 41943,0 42042,1 42043,0 42089,1 42158,0 42181,1 42268,0 42359,1 42390,0 42463,1 42471,0 42542,1 42598,0 42687,1 42775,0 42787,1 42835,0 42896,1 42967,0 43060,1 43130,0 43228,1 43277,0 43303,1 43393,0 43433,1 43463,0 43531,1 43594,0 43670,1 43753,0 43808,1 43836,0 43935,1 43966,0 44030,1 44092,0 44096,1 44184,0 44214,1 44249,0 44327,1 44397,0 44468,1 44511,0 44539,1 44582,0 44680,1 44750,0 44766,1 44850,0 44913,1 44986,0 45056,1 45062,0 45073,1 45138,0 45159,1 45224,0 45301,1 45363,0 45423,1 45507,0 45557,1 45636,0 45700,1 45764,0 45816,1 45854,0 45953,1 45960,0 46037,1 46075,0 46084,1 46122,0 46137,1 46169,0 46171,1 46212,0 46287,1 46327,0 46427,1 46478,0 46514,1 46559,0 46591,1 46691,0 46698,1 46755,0 46763,1 46793,0 46861,1 46925,0 47017,1 47072,0 47134,1 47138,0 47238,1 47321,0 47413,1 47484,0 47577,1 47630,0 47653,1 47716,0 47755,1 47760,0 47770,1 47794,0 47823,1 47896,0 47991,1 47993,0 48024,1 48040,0 48074,1 48157,0 48230,1 48314,0 48368,1 48369,0 48404,1 48462,0 48508,1 48569,0 48652,1 48734,0 48790,1 48815,0 48851,1 48854,0 48870,1 48909,0 48987,1 49081,0 49176,1 49255,0 49351,1 49392,0 49481,1 49579,0 49621,1 49683,0 49741,1 49778,0 49875,1 49961,0 49967,1 50006,0 50040,1 50095,0 50102,1 50143,0 50147,1 50222,0 50317,1 end initlist a60 0,0 80,1 151,0 182,1 255,0 274,1 335,0 361,1 447,0 538,1 553,0 573,1 594,0 603,1 614,0 643,1 691,0 733,1 740,0 751,1 786,0 846,1 889,0 896,1 964,0 969,1 1032,0 1052,1 1080,0 1158,1 1187,0 1261,1 1337,0 1362,1 1453,0 1488,1 1583,0 1619,1 1684,0 1777,1 1788,0 1810,1 1901,0 1963,1 2035,0 2108,1 2177,0 2221,1 2240,0 2300,1 2354,0 2437,1 2528,0 2566,1 2633,0 2672,1 2673,0 2713,1 2807,0 2848,1 2936,0 3017,1 3028,0 3090,1 3186,0 3193,1 3262,0 3282,1 3319,0 3379,1 3390,0 3443,1 3472,0 3478,1 3501,0 3530,1 3568,0 3601,1 3614,0 3636,1 3676,0 3772,1 3829,0 3879,1 3934,0 3977,1 4052,0 4144,1 4192,0 4265,1 4346,0 4361,1 4398,0 4406,1 4485,0 4504,1 4593,0 4620,1 4625,0 4666,1 4674,0 4708,1 4796,0 4815,1 4849,0 4890,1 4941,0 5038,1 5131,0 5190,1 5234,0 5312,1 5376,0 5401,1 5427,0 5493,1 5581,0 5599,1 5660,0 5722,1 5784,0 5829,1 5895,0 5943,1 6016,0 6116,1 6177,0 6203,1 6265,0 6310,1 6395,0 6456,1 6553,0 6573,1 6591,0 6644,1 6711,0 6755,1 6837,0 6857,1 6949,0 6952,1 7027,0 7031,1 7085,0 7163,1 7216,0 7230,1 7326,0 7419,1 7454,0 7480,1 7545,0 7577,1 7587,0 7640,1 7718,0 7803,1 7838,0 7849,1 7909,0 7916,1 7991,0 8014,1 8042,0 8076,1 8108,0 8136,1 8179,0 8245,1 8267,0 8359,1 8414,0 8512,1 8595,0 8621,1 8652,0 8671,1 8734,0 8814,1 8853,0 8950,1 9026,0 9065,1 9119,0 9219,1 9258,0 9305,1 9367,0 9408,1 9505,0 9568,1 9662,0 9717,1 9762,0 9848,1 9888,0 9889,1 9890,0 9917,1 9975,0 10026,1 10082,0 10114,1 10197,0 10253,1 10263,0 10302,1 10400,0 10461,1 10491,0 10587,1 10684,0 10715,1 10758,0 10844,1 10859,0 10903,1 10972,0 11051,1 11117,0 11203,1 11210,0 11275,1 11365,0 11456,1 11534,0 11579,1 11617,0 11619,1 11664,0 11678,1 11693,0 11710,1 11728,0 11745,1 11804,0 11805,1 11877,0 11971,1 11987,0 12026,1 12111,0 12121,1 12139,0 12172,1 12266,0 12311,1 12398,0 12462,1 12502,0 12543,1 12619,0 12640,1 12704,0 12791,1 12890,0 12925,1 12931,0 12939,1 13006,0 13038,1 13116,0 13156,1 13199,0 13282,1 13293,0 13328,1 13416,0 13508,1 13517,0 13590,1 13657,0 13668,1 13764,0 13793,1 13821,0 13827,1 13907,0 14002,1 14035,0 14050,1 14074,0 14091,1 14186,0 14279,1 14335,0 14347,1 14369,0 14397,1 14429,0 14496,1 14552,0 14598,1 14651,0 14677,1 14707,0 14723,1 14740,0 14742,1 14758,0 14843,1 14881,0 14889,1 14949,0 14975,1 15020,0 15105,1 15131,0 15170,1 15210,0 15247,1 15305,0 15404,1 15461,0 15488,1 15513,0 15534,1 15560,0 15568,1 15576,0 15604,1 15686,0 15713,1 15800,0 15825,1 15854,0 15935,1 15978,0 16004,1 16054,0 16132,1 16220,0 16306,1 16369,0 16461,1 16484,0 16501,1 16566,0 16643,1 16681,0 16764,1 16828,0 16897,1 16939,0 16979,1 17006,0 17100,1 17111,0 17148,1 17177,0 17218,1 17280,0 17340,1 17377,0 17395,1 17432,0 17457,1 17498,0 17593,1 17672,0 17747,1 17757,0 17815,1 17902,0 17948,1 18022,0 18058,1 18100,0 18160,1 18244,0 18278,1 18334,0 18364,1 18435,0 18499,1 18511,0 18592,1 18686,0 18689,1 18785,0 18876,1 18878,0 18913,1 18935,0 18985,1 19085,0 19157,1 19195,0 19241,1 19334,0 19398,1 19480,0 19522,1 19592,0 19658,1 19671,0 19705,1 19714,0 19725,1 19815,0 19872,1 19894,0 19948,1 19983,0 20026,1 20072,0 20074,1 20107,0 20191,1 20267,0 20268,1 20293,0 20364,1 20375,0 20439,1 20485,0 20499,1 20541,0 20631,1 20645,0 20732,1 20788,0 20884,1 20888,0 20988,1 21057,0 21070,1 21112,0 21177,1 21180,0 21219,1 21309,0 21396,1 21495,0 21560,1 21639,0 21727,1 21818,0 21827,1 21863,0 21904,1 21949,0 22026,1 22101,0 22187,1 22220,0 22224,1 22300,0 22342,1 22422,0 22482,1 22516,0 22534,1 22619,0 22664,1 22696,0 22737,1 22778,0 22844,1 22863,0 22872,1 22873,0 22950,1 23032,0 23114,1 23214,0 23277,1 23360,0 23377,1 23415,0 23470,1 23537,0 23621,1 23630,0 23710,1 23744,0 23810,1 23909,0 23916,1 23926,0 23945,1 23983,0 24054,1 24103,0 24137,1 24177,0 24203,1 24254,0 24279,1 24321,0 24398,1 24443,0 24480,1 24539,0 24578,1 24596,0 24662,1 24703,0 24774,1 24835,0 24892,1 24972,0 25019,1 25092,0 25118,1 25212,0 25235,1 25324,0 25349,1 25423,0 25458,1 25497,0 25551,1 25588,0 25670,1 25703,0 25744,1 25780,0 25844,1 25929,0 26001,1 26019,0 26047,1 26130,0 26192,1 26199,0 26211,1 26265,0 26290,1 26389,0 26460,1 26492,0 26535,1 26593,0 26682,1 26687,0 26761,1 26774,0 26802,1 26885,0 26920,1 26927,0 26952,1 26959,0 27005,1 27076,0 27160,1 27179,0 27185,1 27269,0 27283,1 27342,0 27412,1 27483,0 27514,1 27581,0 27600,1 27699,0 27717,1 27804,0 27844,1 27885,0 27947,1 28046,0 28108,1 28172,0 28209,1 28274,0 28365,1 28407,0 28454,1 28524,0 28597,1 28603,0 28609,1 28637,0 28683,1 28693,0 28708,1 28742,0 28789,1 28856,0 28875,1 28927,0 28971,1 29039,0 29083,1 29113,0 29143,1 29171,0 29236,1 29310,0 29350,1 29366,0 29459,1 29531,0 29573,1 29581,0 29596,1 29658,0 29690,1 29757,0 29788,1 29829,0 29903,1 29995,0 30041,1 30071,0 30145,1 30233,0 30302,1 30326,0 30418,1 30428,0 30476,1 30543,0 30566,1 30606,0 30650,1 30674,0 30686,1 30718,0 30758,1 30857,0 30893,1 30945,0 30961,1 31052,0 31102,1 31198,0 31232,1 31249,0 31262,1 31318,0 31398,1 31447,0 31501,1 31577,0 31636,1 31690,0 31708,1 31727,0 31786,1 31881,0 31951,1 32030,0 32087,1 32172,0 32246,1 32278,0 32297,1 32374,0 32451,1 32500,0 32501,1 32527,0 32587,1 32594,0 32610,1 32612,0 32644,1 32716,0 32781,1 32861,0 32927,1 33024,0 33049,1 33054,0 33095,1 33104,0 33138,1 33214,0 33303,1 33402,0 33478,1 33499,0 33571,1 33646,0 33683,1 33732,0 33777,1 33818,0 33829,1 33860,0 33923,1 34005,0 34006,1 34106,0 34195,1 34224,0 34288,1 34306,0 34369,1 34442,0 34466,1 34553,0 34579,1 34629,0 34635,1 34709,0 34790,1 34854,0 34884,1 34975,0 35041,1 35080,0 35178,1 35261,0 35310,1 35377,0 35469,1 35490,0 35545,1 35547,0 35624,1 35638,0 35701,1 35704,0 35718,1 35750,0 35831,1 35903,0 35944,1 35983,0 36033,1 36075,0 36174,1 36211,0 36215,1 36290,0 36366,1 36402,0 36448,1 36533,0 36617,1 36636,0 36727,1 36800,0 36894,1 36971,0 37048,1 37051,0 37141,1 37215,0 37222,1 37292,0 37306,1 37403,0 37494,1 37563,0 37660,1 37687,0 37775,1 37795,0 37886,1 37947,0 37974,1 38040,0 38134,1 38139,0 38226,1 38305,0 38306,1 38359,0 38376,1 38446,0 38545,1 38614,0 38672,1 38681,0 38766,1 38806,0 38859,1 38930,0 38983,1 39040,0 39089,1 39124,0 39210,1 39303,0 39336,1 39410,0 39463,1 39469,0 39549,1 39614,0 39659,1 39700,0 39715,1 39777,0 39800,1 39873,0 39902,1 39926,0 40015,1 40018,0 40094,1 40117,0 40151,1 40174,0 40217,1 40267,0 40362,1 40419,0 40491,1 40531,0 40552,1 40643,0 40688,1 40736,0 40756,1 40785,0 40828,1 40846,0 40870,1 40935,0 40987,1 41080,0 41148,1 41193,0 41265,1 41353,0 41364,1 41372,0 41439,1 41508,0 41517,1 41533,0 41594,1 41627,0 41699,1 41790,0 41831,1 41888,0 41945,1 42026,0 42052,1 42091,0 42141,1 42187,0 42197,1 42274,0 42284,1 42344,0 42373,1 42387,0 42477,1 42503,0 42544,1 42573,0 42654,1 42714,0 42718,1 42727,0 42773,1 42815,0 42842,1 42903,0 42947,1 43021,0 43062,1 43092,0 43099,1 43170,0 43206,1 43292,0 43304,1 43335,0 43412,1 43445,0 43531,1 43569,0 43612,1 43677,0 43764,1 43834,0 43904,1 44001,0 44002,1 44035,0 44058,1 44140,0 44148,1 44241,0 44316,1 44395,0 44437,1 44449,0 44509,1 44576,0 44610,1 44626,0 44678,1 44745,0 44829,1 44913,0 44986,1 45044,0 45111,1 45123,0 45190,1 45211,0 45283,1 45300,0 45328,1 45355,0 45444,1 45543,0 45576,1 45666,0 45669,1 45703,0 45726,1 45783,0 45876,1 45895,0 45958,1 46046,0 46098,1 46191,0 46253,1 46311,0 46362,1 46375,0 46421,1 46491,0 46570,1 46590,0 46668,1 46685,0 46721,1 46725,0 46820,1 46858,0 46892,1 46965,0 47004,1 47051,0 47059,1 47122,0 47149,1 47215,0 47229,1 47234,0 47331,1 47392,0 47438,1 47464,0 47494,1 47510,0 47600,1 47699,0 47725,1 47744,0 47807,1 47846,0 47854,1 47882,0 47907,1 47964,0 48034,1 48043,0 48092,1 48170,0 48197,1 48283,0 48383,1 48409,0 48410,1 48424,0 48460,1 48465,0 48500,1 48558,0 48640,1 48705,0 48746,1 48824,0 48880,1 48891,0 48924,1 48982,0 48985,1 49056,0 49135,1 49166,0 49200,1 49214,0 49300,1 49340,0 49409,1 49494,0 49511,1 49564,0 49604,1 49683,0 49764,1 49815,0 49908,1 49948,0 50009,1 end initlist a61 0,0 54,1 130,0 163,1 170,0 243,1 336,0 373,1 437,0 478,1 518,0 587,1 629,0 681,1 736,0 771,1 823,0 889,1 899,0 948,1 1032,0 1036,1 1131,0 1136,1 1229,0 1265,1 1267,0 1301,1 1337,0 1404,1 1462,0 1486,1 1510,0 1518,1 1586,0 1673,1 1691,0 1746,1 1814,0 1906,1 1987,0 2052,1 2100,0 2129,1 2138,0 2219,1 2278,0 2324,1 2354,0 2409,1 2449,0 2503,1 2573,0 2644,1 2701,0 2744,1 2820,0 2913,1 2940,0 2974,1 3000,0 3060,1 3133,0 3183,1 3265,0 3364,1 3434,0 3534,1 3623,0 3673,1 3678,0 3717,1 3802,0 3892,1 3901,0 3995,1 4036,0 4112,1 4135,0 4141,1 4183,0 4257,1 4346,0 4401,1 4454,0 4482,1 4568,0 4590,1 4637,0 4657,1 4661,0 4696,1 4745,0 4775,1 4854,0 4912,1 4928,0 4979,1 5036,0 5121,1 5198,0 5219,1 5231,0 5236,1 5267,0 5339,1 5378,0 5394,1 5414,0 5509,1 5546,0 5612,1 5638,0 5737,1 5812,0 5884,1 5949,0 6008,1 6027,0 6092,1 6117,0 6182,1 6190,0 6223,1 6291,0 6319,1 6322,0 6410,1 6510,0 6602,1 6676,0 6691,1 6709,0 6768,1 6848,0 6903,1 6996,0 7084,1 7164,0 7248,1 7278,0 7281,1 7363,0 7455,1 7487,0 7570,1 7578,0 7582,1 7601,0 7623,1 7704,0 7751,1 7764,0 7818,1 7863,0 7925,1 7949,0 8012,1 8111,0 8199,1 8261,0 8273,1 8280,0 8306,1 8362,0 8412,1 8470,0 8477,1 8522,0 8616,1 8627,0 8670,1 8704,0 8722,1 8801,0 8836,1 8846,0 8940,1 8995,0 9072,1 9141,0 9157,1 9158,0 9233,1 9304,0 9400,1 9494,0 9555,1 9590,0 9591,1 9672,0 9724,1 9777,0 9784,1 9796,0 9816,1 9823,0 9864,1 9920,0 10000,1 10009,0 10101,1 10177,0 10199,1 10250,0 10330,1 10385,0 10433,1 10458,0 10542,1 10634,0 10733,1 10781,0 10838,1 10922,0 10952,1 10955,0 10977,1 11069,0 11136,1 11156,0 11254,1 11329,0 11367,1 11449,0 11521,1 11576,0 11666,1 11685,0 11739,1 11795,0 11839,1 11866,0 11916,1 12015,0 12021,1 12112,0 12177,1 12233,0 12249,1 12311,0 12328,1 12424,0 12499,1 12507,0 12553,1 12558,0 12584,1 12658,0 12660,1 12688,0 12766,1 12865,0 12896,1 12957,0 12968,1 13013,0 13096,1 13113,0 13149,1 13215,0 13220,1 13272,0 13370,1 13468,0 13505,1 13518,0 13521,1 13602,0 13631,1 13699,0 13727,1 13786,0 13806,1 13830,0 13866,1 13897,0 13943,1 14017,0 14049,1 14085,0 14185,1 14258,0 14298,1 14320,0 14372,1 14406,0 14473,1 14500,0 14530,1 14531,0 14546,1 14581,0 14646,1 14740,0 14793,1 14836,0 14935,1 14997,0 15057,1 15115,0 15118,1 15211,0 15274,1 15300,0 15305,1 15326,0 15349,1 15405,0 15455,1 15463,0 15475,1 15566,0 15568,1 15594,0 15598,1 15669,0 15710,1 15768,0 15855,1 15858,0 15895,1 15912,0 15985,1 16036,0 16070,1 16136,0 16178,1 16213,0 16273,1 16309,0 16386,1 16433,0 16439,1 16471,0 16492,1 16586,0 16595,1 16618,0 16697,1 16761,0 16820,1 16904,0 16940,1 16988,0 17075,1 17164,0 17171,1 17263,0 17358,1 17396,0 17461,1 17462,0 17496,1 17553,0 17569,1 17663,0 17715,1 17775,0 17809,1 17864,0 17931,1 18002,0 18067,1 18076,0 18099,1 18118,0 18184,1 18239,0 18337,1 18428,0 18439,1 18523,0 18573,1 18672,0 18767,1 18807,0 18872,1 18929,0 18955,1 18961,0 19061,1 19141,0 19210,1 19277,0 19291,1 19342,0 19406,1 19454,0 19475,1 19570,0 19651,1 19661,0 19708,1 19783,0 19792,1 19865,0 19954,1 20017,0 20034,1 20058,0 20158,1 20192,0 20240,1 20298,0 20358,1 20363,0 20460,1 20476,0 20536,1 20586,0 20635,1 20676,0 20721,1 20800,0 20876,1 20878,0 20919,1 20942,0 20979,1 21029,0 21099,1 21123,0 21179,1 21262,0 21278,1 21308,0 21374,1 21407,0 21448,1 21491,0 21530,1 21625,0 21721,1 21786,0 21854,1 21882,0 21928,1 21979,0 22043,1 22139,0 22208,1 22248,0 22278,1 22325,0 22351,1 22434,0 22476,1 22565,0 22616,1 22626,0 22656,1 22727,0 22753,1 22839,0 22876,1 22920,0 22923,1 22941,0 23013,1 23057,0 23142,1 23155,0 23255,1 23274,0 23317,1 23367,0 23402,1 23478,0 23554,1 23565,0 23573,1 23587,0 23638,1 23676,0 23726,1 23758,0 23841,1 23939,0 23983,1 24078,0 24174,1 24269,0 24290,1 24376,0 24406,1 24457,0 24535,1 24624,0 24645,1 24663,0 24753,1 24816,0 24835,1 24890,0 24906,1 24986,0 25037,1 25120,0 25208,1 25297,0 25387,1 25394,0 25409,1 25414,0 25415,1 25482,0 25546,1 25628,0 25653,1 25710,0 25762,1 25831,0 25909,1 26008,0 26071,1 26162,0 26222,1 26228,0 26248,1 26292,0 26346,1 26371,0 26429,1 26433,0 26508,1 26548,0 26611,1 26699,0 26793,1 26852,0 26901,1 26988,0 27074,1 27093,0 27188,1 27281,0 27333,1 27425,0 27489,1 27491,0 27591,1 27624,0 27710,1 27717,0 27757,1 27843,0 27854,1 27954,0 28050,1 28085,0 28183,1 28274,0 28362,1 28416,0 28496,1 28529,0 28548,1 28597,0 28679,1 28743,0 28823,1 28897,0 28983,1 29038,0 29126,1 29225,0 29282,1 29306,0 29371,1 29422,0 29437,1 29472,0 29512,1 29538,0 29625,1 29640,0 29673,1 29700,0 29737,1 29827,0 29922,1 29962,0 30049,1 30119,0 30185,1 30237,0 30258,1 30331,0 30401,1 30491,0 30537,1 30600,0 30642,1 30657,0 30740,1 30795,0 30826,1 30887,0 30923,1 31010,0 31054,1 31075,0 31088,1 31101,0 31161,1 31242,0 31330,1 31375,0 31419,1 31499,0 31572,1 31599,0 31604,1 31661,0 31695,1 31789,0 31872,1 31967,0 32007,1 32065,0 32139,1 32216,0 32241,1 32308,0 32311,1 32400,0 32480,1 32522,0 32552,1 32638,0 32684,1 32777,0 32809,1 32813,0 32831,1 32907,0 32938,1 33025,0 33113,1 33135,0 33143,1 33166,0 33212,1 33250,0 33344,1 33357,0 33395,1 33434,0 33532,1 33540,0 33575,1 33665,0 33763,1 33776,0 33783,1 33805,0 33859,1 33892,0 33898,1 33944,0 34007,1 34100,0 34101,1 34141,0 34191,1 34229,0 34234,1 34261,0 34360,1 34361,0 34389,1 34432,0 34497,1 34507,0 34551,1 34624,0 34638,1 34711,0 34728,1 34782,0 34878,1 34928,0 34943,1 34986,0 35071,1 35093,0 35111,1 35165,0 35171,1 35233,0 35326,1 35398,0 35440,1 35466,0 35505,1 35530,0 35630,1 35661,0 35752,1 35809,0 35896,1 35957,0 36037,1 36116,0 36134,1 36209,0 36275,1 36371,0 36447,1 36484,0 36503,1 36546,0 36612,1 36648,0 36738,1 36817,0 36836,1 36936,0 36942,1 36961,0 37018,1 37026,0 37105,1 37166,0 37167,1 37186,0 37213,1 37271,0 37287,1 37310,0 37392,1 37396,0 37434,1 37458,0 37480,1 37511,0 37536,1 37596,0 37604,1 37688,0 37759,1 37780,0 37801,1 37864,0 37887,1 37908,0 37999,1 38007,0 38061,1 38161,0 38177,1 38213,0 38244,1 38333,0 38418,1 38485,0 38547,1 38608,0 38682,1 38700,0 38786,1 38845,0 38938,1 39017,0 39065,1 39145,0 39183,1 39188,0 39285,1 39378,0 39414,1 39457,0 39551,1 39637,0 39706,1 39707,0 39757,1 39775,0 39776,1 39825,0 39884,1 39931,0 39958,1 40011,0 40046,1 40112,0 40210,1 40308,0 40334,1 40382,0 40391,1 40488,0 40501,1 40509,0 40598,1 40627,0 40656,1 40662,0 40760,1 40791,0 40816,1 40905,0 40994,1 41030,0 41042,1 41100,0 41112,1 41172,0 41254,1 41331,0 41354,1 41405,0 41428,1 41512,0 41601,1 41698,0 41784,1 41823,0 41830,1 41900,0 41942,1 41978,0 42058,1 42063,0 42112,1 42193,0 42197,1 42269,0 42337,1 42426,0 42492,1 42496,0 42514,1 42515,0 42588,1 42619,0 42663,1 42752,0 42826,1 42855,0 42866,1 42870,0 42921,1 42926,0 42999,1 43041,0 43056,1 43110,0 43166,1 43195,0 43257,1 43289,0 43385,1 43457,0 43474,1 43531,0 43599,1 43692,0 43763,1 43823,0 43844,1 43934,0 44022,1 44097,0 44168,1 44258,0 44339,1 44389,0 44468,1 44485,0 44505,1 44568,0 44608,1 44647,0 44734,1 44757,0 44812,1 44866,0 44941,1 44982,0 45070,1 45158,0 45237,1 45330,0 45409,1 45448,0 45455,1 45470,0 45491,1 45524,0 45560,1 45576,0 45668,1 45747,0 45755,1 45805,0 45840,1 45891,0 45899,1 45957,0 45960,1 46016,0 46076,1 46117,0 46160,1 46228,0 46281,1 46379,0 46410,1 46489,0 46532,1 46631,0 46656,1 46669,0 46734,1 46761,0 46844,1 46912,0 46954,1 46973,0 46988,1 47063,0 47152,1 47155,0 47211,1 47216,0 47273,1 47325,0 47356,1 47413,0 47505,1 47537,0 47608,1 47703,0 47748,1 47784,0 47866,1 47869,0 47923,1 47961,0 47994,1 48071,0 48125,1 48201,0 48222,1 48297,0 48395,1 48481,0 48544,1 48613,0 48692,1 48760,0 48843,1 48934,0 48999,1 49068,0 49130,1 49175,0 49258,1 49347,0 49402,1 49461,0 49506,1 49585,0 49670,1 49694,0 49699,1 49768,0 49807,1 49895,0 49932,1 50018,0 50050,1 50144,0 50147,1 50195,0 50252,1 50303,0 50317,1 50389,0 50428,1 50457,0 50522,1 50617,0 50695,1 50710,0 50781,1 50794,0 50877,1 50961,0 51006,1 51083,0 51107,1 51204,0 51223,1 51261,0 51274,1 51337,0 51413,1 51483,0 51572,1 end initlist a62 0,0 81,1 176,0 178,1 256,0 356,1 414,0 423,1 454,0 540,1 604,0 641,1 699,0 725,1 806,0 895,1 948,0 1047,1 1133,0 1170,1 1216,0 1285,1 1331,0 1409,1 1439,0 1515,1 1565,0 1590,1 1612,0 1640,1 1714,0 1731,1 1827,0 1880,1 1951,0 1988,1 2026,0 2057,1 2078,0 2088,1 2165,0 2202,1 2270,0 2304,1 2394,0 2408,1 2458,0 2468,1 2540,0 2564,1 2643,0 2661,1 2666,0 2672,1 2711,0 2798,1 2818,0 2869,1 2916,0 2981,1 3030,0 3126,1 3173,0 3267,1 3320,0 3389,1 3395,0 3464,1 3472,0 3556,1 3649,0 3722,1 3755,0 3818,1 3857,0 3948,1 3949,0 3973,1 4035,0 4088,1 4188,0 4199,1 4200,0 4257,1 4355,0 4377,1 4444,0 4483,1 4565,0 4637,1 4696,0 4758,1 4837,0 4840,1 4924,0 4948,1 4983,0 5072,1 5164,0 5201,1 5237,0 5264,1 5360,0 5393,1 5444,0 5538,1 5549,0 5596,1 5641,0 5672,1 5736,0 5741,1 5772,0 5844,1 5849,0 5914,1 5959,0 6027,1 6100,0 6161,1 6235,0 6281,1 6355,0 6421,1 6491,0 6532,1 6537,0 6550,1 6559,0 6599,1 6658,0 6682,1 6686,0 6734,1 6828,0 6908,1 6961,0 6998,1 7023,0 7122,1 7156,0 7196,1 7262,0 7313,1 7402,0 7473,1 7497,0 7507,1 7540,0 7640,1 7687,0 7730,1 7771,0 7824,1 7838,0 7904,1 7986,0 8085,1 8177,0 8251,1 8297,0 8314,1 8389,0 8433,1 8461,0 8487,1 8558,0 8572,1 8603,0 8677,1 8714,0 8734,1 8771,0 8809,1 8826,0 8894,1 8961,0 8987,1 9079,0 9082,1 9121,0 9202,1 9250,0 9312,1 9397,0 9474,1 9528,0 9619,1 9672,0 9764,1 9781,0 9847,1 9945,0 10003,1 10083,0 10168,1 10183,0 10229,1 10236,0 10335,1 10426,0 10513,1 10579,0 10665,1 10715,0 10785,1 10875,0 10954,1 11001,0 11012,1 11026,0 11083,1 11122,0 11200,1 11250,0 11265,1 11285,0 11384,1 11413,0 11441,1 11520,0 11556,1 11561,0 11571,1 11638,0 11673,1 11697,0 11744,1 11783,0 11802,1 11820,0 11860,1 11895,0 11973,1 12047,0 12117,1 12210,0 12282,1 12320,0 12405,1 12450,0 12461,1 12541,0 12615,1 12671,0 12752,1 12830,0 12841,1 12918,0 12921,1 12999,0 13050,1 13088,0 13098,1 13189,0 13203,1 13254,0 13281,1 13331,0 13369,1 13446,0 13514,1 13601,0 13652,1 13658,0 13680,1 13763,0 13814,1 13893,0 13923,1 13987,0 14046,1 14097,0 14168,1 14201,0 14207,1 14306,0 14403,1 14462,0 14533,1 14537,0 14570,1 14639,0 14715,1 14739,0 14810,1 14829,0 14915,1 14990,0 15008,1 15087,0 15153,1 15210,0 15215,1 15272,0 15323,1 15370,0 15372,1 15395,0 15479,1 15497,0 15500,1 15561,0 15584,1 15670,0 15767,1 15840,0 15884,1 15921,0 16005,1 16069,0 16151,1 16156,0 16234,1 16299,0 16310,1 16330,0 16379,1 16407,0 16456,1 16555,0 16611,1 16643,0 16733,1 16802,0 16871,1 16898,0 16941,1 16977,0 17066,1 17090,0 17178,1 17260,0 17324,1 17384,0 17464,1 17514,0 17566,1 17594,0 17685,1 17742,0 17803,1 17870,0 17939,1 18015,0 18019,1 18085,0 18124,1 18208,0 18305,1 18388,0 18429,1 18442,0 18495,1 18557,0 18624,1 18717,0 18793,1 18889,0 18920,1 18959,0 18962,1 18988,0 19086,1 19098,0 19109,1 19159,0 19192,1 19292,0 19301,1 19342,0 19391,1 19459,0 19506,1 19597,0 19614,1 19702,0 19704,1 19797,0 19798,1 19871,0 19894,1 19990,0 20019,1 20027,0 20074,1 20096,0 20149,1 20230,0 20243,1 20258,0 20271,1 20302,0 20310,1 20356,0 20385,1 20469,0 20559,1 20576,0 20638,1 20642,0 20731,1 20773,0 20866,1 20954,0 21033,1 21113,0 21213,1 21271,0 21276,1 21329,0 21340,1 21417,0 21485,1 21570,0 21665,1 21701,0 21792,1 21831,0 21837,1 21903,0 21942,1 22037,0 22055,1 22085,0 22087,1 22144,0 22154,1 22166,0 22259,1 22298,0 22378,1 22414,0 22479,1 22511,0 22581,1 22651,0 22717,1 22765,0 22842,1 22910,0 23009,1 23050,0 23111,1 23206,0 23290,1 23320,0 23361,1 23402,0 23422,1 23449,0 23494,1 23510,0 23561,1 23571,0 23581,1 23598,0 23629,1 23651,0 23673,1 23696,0 23761,1 23767,0 23818,1 23865,0 23914,1 23958,0 24030,1 24043,0 24059,1 24117,0 24204,1 24284,0 24298,1 24323,0 24389,1 24412,0 24454,1 24518,0 24590,1 24675,0 24706,1 24713,0 24813,1 24832,0 24874,1 24935,0 24980,1 25033,0 25034,1 25076,0 25090,1 25144,0 25233,1 25236,0 25330,1 25396,0 25434,1 25459,0 25496,1 25513,0 25609,1 25687,0 25696,1 25785,0 25800,1 25867,0 25869,1 25948,0 25987,1 26045,0 26131,1 26172,0 26224,1 26288,0 26316,1 26331,0 26355,1 26398,0 26491,1 26577,0 26598,1 26663,0 26685,1 26716,0 26791,1 26797,0 26832,1 26918,0 26972,1 27060,0 27089,1 27110,0 27185,1 27253,0 27276,1 27354,0 27410,1 27436,0 27514,1 27551,0 27605,1 27654,0 27705,1 27789,0 27810,1 27821,0 27838,1 27892,0 27941,1 28001,0 28007,1 28069,0 28098,1 28197,0 28256,1 28321,0 28356,1 28406,0 28462,1 28544,0 28582,1 28677,0 28723,1 28804,0 28896,1 28940,0 28980,1 28987,0 29037,1 29041,0 29042,1 29051,0 29132,1 29184,0 29272,1 29316,0 29361,1 29451,0 29508,1 29514,0 29601,1 29650,0 29710,1 29720,0 29784,1 29873,0 29888,1 29920,0 29973,1 29981,0 30067,1 30076,0 30110,1 30206,0 30303,1 30336,0 30342,1 30414,0 30442,1 30450,0 30544,1 30605,0 30683,1 30712,0 30730,1 30751,0 30787,1 30849,0 30937,1 31019,0 31116,1 31208,0 31225,1 31281,0 31320,1 31374,0 31387,1 31392,0 31420,1 31495,0 31539,1 31580,0 31675,1 31707,0 31738,1 31749,0 31765,1 31863,0 31943,1 31977,0 31979,1 31996,0 32004,1 32089,0 32101,1 32183,0 32229,1 32327,0 32358,1 32367,0 32386,1 32438,0 32504,1 32579,0 32637,1 32653,0 32748,1 32825,0 32828,1 32913,0 32976,1 33051,0 33067,1 33122,0 33148,1 33184,0 33281,1 33346,0 33394,1 33469,0 33505,1 33541,0 33568,1 33667,0 33708,1 33736,0 33765,1 33809,0 33853,1 33854,0 33910,1 33912,0 34010,1 34011,0 34103,1 34166,0 34185,1 34269,0 34314,1 34337,0 34410,1 34501,0 34558,1 34619,0 34627,1 34662,0 34687,1 34757,0 34825,1 34883,0 34944,1 35007,0 35058,1 35137,0 35207,1 35226,0 35301,1 35392,0 35400,1 35456,0 35461,1 35465,0 35483,1 35569,0 35598,1 35661,0 35731,1 35804,0 35898,1 35968,0 36018,1 36073,0 36165,1 36191,0 36270,1 36351,0 36389,1 36478,0 36498,1 36572,0 36601,1 36701,0 36737,1 36825,0 36851,1 36918,0 36983,1 36995,0 36999,1 37082,0 37114,1 37131,0 37219,1 37281,0 37368,1 37382,0 37415,1 37505,0 37544,1 37559,0 37632,1 37664,0 37689,1 37725,0 37771,1 37827,0 37886,1 37895,0 37922,1 37978,0 38069,1 38103,0 38153,1 38230,0 38317,1 38364,0 38447,1 38543,0 38580,1 38671,0 38689,1 38713,0 38761,1 38776,0 38843,1 38862,0 38923,1 39017,0 39024,1 39028,0 39029,1 39060,0 39153,1 39222,0 39262,1 39344,0 39427,1 39524,0 39544,1 39567,0 39602,1 39640,0 39731,1 39751,0 39769,1 39844,0 39898,1 39956,0 40009,1 40075,0 40107,1 40153,0 40199,1 40224,0 40274,1 40335,0 40358,1 40425,0 40426,1 40457,0 40552,1 40575,0 40626,1 40678,0 40690,1 40755,0 40797,1 40826,0 40853,1 40864,0 40953,1 40959,0 41023,1 41111,0 41167,1 41223,0 41238,1 41280,0 41302,1 41340,0 41420,1 41489,0 41497,1 41498,0 41513,1 41520,0 41584,1 41657,0 41677,1 41762,0 41848,1 41884,0 41918,1 41971,0 42028,1 42043,0 42062,1 42102,0 42176,1 42253,0 42289,1 42343,0 42353,1 42381,0 42465,1 42486,0 42552,1 42623,0 42626,1 42637,0 42660,1 42731,0 42749,1 42767,0 42794,1 42842,0 42914,1 42919,0 42983,1 43051,0 43089,1 43120,0 43159,1 43192,0 43229,1 43296,0 43331,1 43428,0 43496,1 43554,0 43568,1 43607,0 43652,1 43699,0 43727,1 43779,0 43799,1 43889,0 43989,1 44072,0 44119,1 44169,0 44229,1 44243,0 44289,1 44327,0 44346,1 44385,0 44393,1 44398,0 44478,1 44568,0 44653,1 44665,0 44738,1 44770,0 44797,1 44830,0 44919,1 44921,0 44972,1 44999,0 45005,1 45085,0 45130,1 45226,0 45313,1 45320,0 45383,1 45460,0 45498,1 45562,0 45610,1 45696,0 45704,1 45796,0 45870,1 45970,0 46006,1 46069,0 46122,1 46188,0 46237,1 46288,0 46347,1 46356,0 46365,1 46461,0 46481,1 46526,0 46564,1 46640,0 46726,1 46792,0 46814,1 46866,0 46918,1 46945,0 47034,1 47037,0 47078,1 47126,0 47180,1 47216,0 47231,1 47276,0 47318,1 47349,0 47423,1 47448,0 47530,1 47603,0 47679,1 47756,0 47805,1 47823,0 47827,1 47907,0 47920,1 48000,0 48060,1 48151,0 48157,1 48229,0 48288,1 48356,0 48362,1 48378,0 48382,1 48458,0 48531,1 48534,0 48552,1 48579,0 48640,1 48689,0 48732,1 48802,0 48849,1 48924,0 49011,1 49027,0 49067,1 49070,0 49124,1 49224,0 49303,1 49401,0 49499,1 49510,0 49518,1 49580,0 49673,1 49701,0 49712,1 49745,0 49809,1 49826,0 49880,1 49956,0 50009,1 end initlist a63 0,0 99,1 152,0 187,1 233,0 269,1 318,0 407,1 440,0 501,1 550,0 595,1 666,0 744,1 803,0 834,1 875,0 921,1 942,0 1019,1 1069,0 1128,1 1226,0 1267,1 1273,0 1372,1 1375,0 1415,1 1422,0 1428,1 1498,0 1579,1 1666,0 1695,1 1768,0 1838,1 1891,0 1939,1 2005,0 2079,1 2101,0 2182,1 2205,0 2293,1 2310,0 2364,1 2415,0 2454,1 2463,0 2499,1 2550,0 2607,1 2630,0 2664,1 2737,0 2774,1 2869,0 2916,1 2923,0 2988,1 2999,0 3019,1 3086,0 3135,1 3178,0 3226,1 3254,0 3286,1 3366,0 3378,1 3379,0 3451,1 3498,0 3592,1 3624,0 3678,1 3679,0 3727,1 3775,0 3784,1 3877,0 3977,1 4008,0 4053,1 4115,0 4181,1 4208,0 4257,1 4261,0 4341,1 4359,0 4459,1 4534,0 4542,1 4580,0 4638,1 4692,0 4716,1 4811,0 4888,1 4936,0 5022,1 5025,0 5032,1 5051,0 5118,1 5160,0 5232,1 5251,0 5324,1 5388,0 5412,1 5414,0 5467,1 5510,0 5554,1 5611,0 5640,1 5692,0 5709,1 5797,0 5828,1 5924,0 6007,1 6048,0 6064,1 6138,0 6197,1 6279,0 6330,1 6363,0 6367,1 6458,0 6500,1 6510,0 6608,1 6652,0 6749,1 6809,0 6871,1 6920,0 7001,1 7015,0 7017,1 7058,0 7073,1 7089,0 7174,1 7177,0 7212,1 7258,0 7305,1 7357,0 7419,1 7435,0 7438,1 7450,0 7474,1 7524,0 7577,1 7666,0 7715,1 7810,0 7846,1 7944,0 8028,1 8036,0 8109,1 8146,0 8160,1 8212,0 8235,1 8321,0 8334,1 8380,0 8416,1 8504,0 8515,1 8602,0 8679,1 8778,0 8866,1 8867,0 8901,1 8912,0 8985,1 8998,0 8999,1 9080,0 9113,1 9173,0 9269,1 9361,0 9440,1 9447,0 9473,1 9510,0 9544,1 9639,0 9660,1 9753,0 9853,1 9945,0 10024,1 10046,0 10087,1 10113,0 10176,1 10270,0 10273,1 10327,0 10414,1 10460,0 10478,1 10482,0 10529,1 10555,0 10606,1 10696,0 10749,1 10759,0 10821,1 10842,0 10903,1 10960,0 10972,1 11026,0 11075,1 11156,0 11192,1 11285,0 11307,1 11356,0 11439,1 11516,0 11609,1 11702,0 11728,1 11765,0 11812,1 11842,0 11857,1 11930,0 11967,1 12042,0 12099,1 12109,0 12134,1 12196,0 12216,1 12236,0 12283,1 12296,0 12382,1 12402,0 12432,1 12507,0 12518,1 12561,0 12562,1 12575,0 12592,1 12636,0 12648,1 12650,0 12705,1 12787,0 12821,1 12885,0 12945,1 12976,0 13059,1 13118,0 13203,1 13236,0 13276,1 13360,0 13371,1 13413,0 13428,1 13450,0 13487,1 13585,0 13620,1 13623,0 13717,1 13758,0 13808,1 13891,0 13963,1 14031,0 14123,1 14168,0 14243,1 14309,0 14331,1 14353,0 14414,1 14494,0 14517,1 14606,0 14645,1 14733,0 14752,1 14813,0 14817,1 14898,0 14945,1 14950,0 15020,1 15071,0 15107,1 15108,0 15193,1 15198,0 15295,1 15328,0 15414,1 15437,0 15446,1 15506,0 15581,1 15628,0 15680,1 15684,0 15711,1 15806,0 15869,1 15878,0 15887,1 15986,0 16006,1 16009,0 16015,1 16060,0 16160,1 16230,0 16322,1 16357,0 16387,1 16454,0 16459,1 16464,0 16546,1 16566,0 16581,1 16594,0 16655,1 16753,0 16836,1 16841,0 16922,1 16989,0 17082,1 17155,0 17171,1 17203,0 17276,1 17349,0 17424,1 17488,0 17539,1 17588,0 17687,1 17784,0 17820,1 17835,0 17858,1 17936,0 17992,1 18020,0 18104,1 18108,0 18124,1 18172,0 18214,1 18294,0 18380,1 18478,0 18521,1 18564,0 18648,1 18649,0 18738,1 18811,0 18827,1 18850,0 18886,1 18950,0 18980,1 19020,0 19040,1 19128,0 19223,1 19302,0 19364,1 19381,0 19464,1 19544,0 19572,1 19613,0 19697,1 19752,0 19811,1 19866,0 19925,1 19999,0 20074,1 20158,0 20203,1 20209,0 20255,1 20276,0 20311,1 20371,0 20411,1 20424,0 20450,1 20542,0 20611,1 20623,0 20699,1 20760,0 20814,1 20815,0 20890,1 20902,0 20936,1 20986,0 21057,1 21140,0 21224,1 21278,0 21305,1 21353,0 21365,1 21368,0 21393,1 21471,0 21563,1 21663,0 21676,1 21691,0 21765,1 21826,0 21864,1 21924,0 22002,1 22037,0 22127,1 22208,0 22294,1 22315,0 22381,1 22437,0 22467,1 22557,0 22614,1 22615,0 22624,1 22657,0 22708,1 22790,0 22810,1 22848,0 22854,1 22899,0 22992,1 23003,0 23004,1 23029,0 23116,1 23190,0 23208,1 23262,0 23269,1 23359,0 23439,1 23522,0 23527,1 23614,0 23623,1 23629,0 23686,1 23735,0 23795,1 23867,0 23945,1 24018,0 24026,1 24097,0 24166,1 24212,0 24309,1 24321,0 24370,1 24450,0 24465,1 24563,0 24605,1 24703,0 24783,1 24875,0 24962,1 25052,0 25067,1 25092,0 25182,1 25242,0 25342,1 25366,0 25386,1 25466,0 25545,1 25615,0 25686,1 25689,0 25706,1 25762,0 25789,1 25790,0 25882,1 25963,0 26016,1 26055,0 26128,1 26132,0 26174,1 26264,0 26316,1 26387,0 26419,1 26427,0 26480,1 26503,0 26554,1 26643,0 26710,1 26780,0 26866,1 26891,0 26963,1 27047,0 27080,1 27082,0 27086,1 27135,0 27150,1 27250,0 27259,1 27322,0 27419,1 27480,0 27517,1 27584,0 27591,1 27620,0 27651,1 27663,0 27748,1 27772,0 27811,1 27890,0 27903,1 27924,0 27978,1 28045,0 28120,1 28134,0 28147,1 28194,0 28234,1 28266,0 28299,1 28393,0 28484,1 28487,0 28521,1 28562,0 28654,1 28748,0 28845,1 28918,0 28950,1 28981,0 29004,1 29009,0 29083,1 29120,0 29209,1 29210,0 29299,1 29306,0 29378,1 29388,0 29395,1 29454,0 29537,1 29562,0 29619,1 29656,0 29744,1 29800,0 29803,1 29864,0 29883,1 29911,0 29986,1 30014,0 30059,1 30091,0 30101,1 30122,0 30147,1 30189,0 30198,1 30230,0 30274,1 30338,0 30407,1 30505,0 30539,1 30579,0 30672,1 30699,0 30757,1 30852,0 30854,1 30889,0 30966,1 31041,0 31112,1 31209,0 31251,1 31315,0 31396,1 31469,0 31522,1 31562,0 31585,1 31615,0 31659,1 31685,0 31778,1 31788,0 31867,1 31926,0 32008,1 32034,0 32125,1 32196,0 32198,1 32203,0 32213,1 32265,0 32275,1 32312,0 32401,1 32463,0 32562,1 32648,0 32722,1 32738,0 32825,1 32852,0 32949,1 33037,0 33064,1 33074,0 33111,1 33203,0 33214,1 33235,0 33257,1 33345,0 33418,1 33432,0 33493,1 33533,0 33538,1 33555,0 33566,1 33631,0 33704,1 33738,0 33763,1 33842,0 33903,1 33918,0 34018,1 34048,0 34105,1 34167,0 34182,1 34264,0 34275,1 34361,0 34375,1 34446,0 34514,1 34515,0 34611,1 34623,0 34685,1 34697,0 34722,1 34774,0 34777,1 34783,0 34815,1 34836,0 34923,1 35023,0 35103,1 35173,0 35191,1 35286,0 35331,1 35430,0 35498,1 35540,0 35594,1 35688,0 35777,1 35873,0 35907,1 35982,0 36054,1 36140,0 36239,1 36260,0 36335,1 36363,0 36390,1 36425,0 36443,1 36527,0 36609,1 36654,0 36701,1 36795,0 36865,1 36965,0 36996,1 37003,0 37061,1 37109,0 37147,1 37211,0 37222,1 37273,0 37298,1 37334,0 37362,1 37410,0 37469,1 37494,0 37587,1 37660,0 37680,1 37704,0 37711,1 37751,0 37814,1 37903,0 37907,1 37987,0 38024,1 38073,0 38114,1 38186,0 38284,1 38287,0 38378,1 38446,0 38451,1 38453,0 38512,1 38592,0 38658,1 38709,0 38749,1 38772,0 38795,1 38894,0 38908,1 39007,0 39034,1 39131,0 39142,1 39198,0 39278,1 39279,0 39376,1 39393,0 39432,1 39453,0 39531,1 39536,0 39590,1 39640,0 39705,1 39725,0 39791,1 39866,0 39959,1 40053,0 40139,1 40216,0 40313,1 40337,0 40356,1 40393,0 40441,1 40486,0 40554,1 40583,0 40606,1 40627,0 40727,1 40752,0 40777,1 40876,0 40888,1 40947,0 41026,1 41039,0 41113,1 41142,0 41186,1 41286,0 41350,1 41386,0 41428,1 41451,0 41546,1 41586,0 41642,1 41739,0 41788,1 41885,0 41937,1 42032,0 42130,1 42183,0 42240,1 42278,0 42317,1 42348,0 42360,1 42454,0 42481,1 42512,0 42562,1 42661,0 42686,1 42777,0 42791,1 42795,0 42828,1 42895,0 42991,1 43052,0 43125,1 43214,0 43265,1 43308,0 43364,1 43456,0 43522,1 43590,0 43618,1 43656,0 43670,1 43700,0 43759,1 43791,0 43818,1 43896,0 43937,1 43947,0 44045,1 44131,0 44228,1 44262,0 44340,1 44391,0 44400,1 44475,0 44481,1 44505,0 44521,1 44545,0 44594,1 44693,0 44764,1 44792,0 44828,1 44842,0 44906,1 44960,0 44962,1 45053,0 45067,1 45150,0 45187,1 45260,0 45303,1 45392,0 45461,1 45470,0 45481,1 45535,0 45548,1 45575,0 45665,1 45696,0 45762,1 45829,0 45833,1 45924,0 45970,1 46029,0 46097,1 46166,0 46223,1 46250,0 46317,1 46362,0 46408,1 46412,0 46478,1 46516,0 46559,1 46563,0 46592,1 46600,0 46681,1 46722,0 46793,1 46884,0 46968,1 47042,0 47046,1 47136,0 47168,1 47186,0 47209,1 47228,0 47292,1 47346,0 47441,1 47486,0 47535,1 47577,0 47673,1 47769,0 47852,1 47942,0 47993,1 48035,0 48113,1 48147,0 48215,1 48301,0 48333,1 48389,0 48424,1 48447,0 48510,1 48522,0 48621,1 48666,0 48747,1 48843,0 48875,1 48929,0 48978,1 49005,0 49056,1 49067,0 49108,1 49117,0 49170,1 49250,0 49291,1 49297,0 49350,1 49379,0 49463,1 49530,0 49552,1 49641,0 49725,1 49746,0 49763,1 49793,0 49857,1 49873,0 49901,1 49911,0 49998,1 end initlist b0 0,0 100,1 143,0 218,1 247,0 321,1 418,0 429,1 457,0 492,1 558,0 650,1 695,0 791,1 875,0 884,1 926,0 959,1 989,0 1015,1 1046,0 1060,1 1093,0 1171,1 1259,0 1340,1 1370,0 1376,1 1414,0 1482,1 1540,0 1548,1 1644,0 1690,1 1743,0 1769,1 1846,0 1875,1 1941,0 2037,1 2132,0 2192,1 2240,0 2312,1 2367,0 2405,1 2442,0 2458,1 2556,0 2612,1 2628,0 2675,1 2727,0 2813,1 2825,0 2832,1 2889,0 2931,1 3011,0 3014,1 3039,0 3103,1 3136,0 3236,1 3330,0 3421,1 3490,0 3536,1 3548,0 3616,1 3653,0 3665,1 3672,0 3699,1 3711,0 3788,1 3866,0 3941,1 3960,0 4045,1 4050,0 4114,1 4185,0 4203,1 4218,0 4316,1 4406,0 4464,1 4557,0 4586,1 4607,0 4673,1 4773,0 4831,1 4885,0 4930,1 5021,0 5096,1 5115,0 5116,1 5208,0 5306,1 5364,0 5406,1 5473,0 5498,1 5515,0 5552,1 5584,0 5635,1 5695,0 5701,1 5792,0 5850,1 5906,0 5958,1 5976,0 6034,1 6046,0 6050,1 6120,0 6180,1 6260,0 6285,1 6379,0 6478,1 6510,0 6522,1 6545,0 6561,1 6565,0 6637,1 6642,0 6695,1 6728,0 6747,1 6759,0 6765,1 6822,0 6835,1 6908,0 6975,1 7070,0 7166,1 7249,0 7261,1 7343,0 7426,1 7462,0 7510,1 7567,0 7573,1 7669,0 7676,1 7753,0 7837,1 7841,0 7853,1 7892,0 7956,1 8043,0 8053,1 8066,0 8139,1 8150,0 8226,1 8296,0 8306,1 8351,0 8419,1 8438,0 8454,1 8469,0 8526,1 8621,0 8622,1 8651,0 8732,1 8749,0 8794,1 8862,0 8936,1 8970,0 9013,1 9034,0 9101,1 9124,0 9161,1 9195,0 9222,1 9258,0 9293,1 9353,0 9367,1 9411,0 9473,1 9482,0 9495,1 9530,0 9590,1 9637,0 9723,1 9757,0 9830,1 9913,0 9944,1 9951,0 9974,1 9987,0 10001,1 10014,0 10074,1 10112,0 10173,1 10262,0 10297,1 10364,0 10372,1 10408,0 10450,1 10534,0 10537,1 10572,0 10632,1 10658,0 10710,1 10751,0 10821,1 10908,0 10970,1 11003,0 11051,1 11073,0 11095,1 11175,0 11257,1 11326,0 11368,1 11419,0 11430,1 11454,0 11473,1 11559,0 11640,1 11642,0 11664,1 11755,0 11850,1 11856,0 11874,1 11919,0 11938,1 12006,0 12007,1 12052,0 12060,1 12149,0 12246,1 12281,0 12301,1 12395,0 12426,1 12427,0 12429,1 12465,0 12550,1 12631,0 12642,1 12657,0 12683,1 12706,0 12795,1 12806,0 12836,1 12854,0 12898,1 12899,0 12965,1 12995,0 13069,1 13129,0 13156,1 13161,0 13177,1 13269,0 13316,1 13360,0 13412,1 13510,0 13596,1 13614,0 13681,1 13775,0 13829,1 13859,0 13893,1 13970,0 14042,1 14108,0 14196,1 14198,0 14253,1 14308,0 14355,1 14452,0 14476,1 14493,0 14558,1 14589,0 14675,1 14762,0 14795,1 14843,0 14878,1 14975,0 15060,1 15112,0 15154,1 15194,0 15243,1 15293,0 15300,1 15400,0 15428,1 15480,0 15497,1 15589,0 15609,1 15621,0 15674,1 15690,0 15727,1 15795,0 15862,1 15942,0 16005,1 16090,0 16131,1 16222,0 16278,1 16331,0 16415,1 16437,0 16449,1 16504,0 16519,1 16568,0 16601,1 16693,0 16769,1 16824,0 16890,1 16904,0 16917,1 16930,0 16960,1 17052,0 17092,1 17097,0 17105,1 17178,0 17224,1 17300,0 17400,1 17421,0 17436,1 17495,0 17587,1 17593,0 17653,1 17737,0 17818,1 17830,0 17904,1 17934,0 17963,1 18014,0 18035,1 18073,0 18164,1 18250,0 18325,1 18425,0 18525,1 18550,0 18562,1 18656,0 18708,1 18795,0 18863,1 18957,0 19037,1 19065,0 19090,1 19141,0 19153,1 19249,0 19336,1 19343,0 19432,1 19508,0 19575,1 19602,0 19632,1 19646,0 19667,1 19689,0 19756,1 19782,0 19849,1 19857,0 19902,1 19981,0 20032,1 20104,0 20157,1 20158,0 20251,1 20265,0 20348,1 20376,0 20397,1 20493,0 20514,1 20599,0 20629,1 20696,0 20752,1 20852,0 20900,1 20983,0 21074,1 21166,0 21252,1 21302,0 21341,1 21438,0 21503,1 21571,0 21668,1 21751,0 21765,1 21836,0 21923,1 21969,0 22068,1 22111,0 22113,1 22152,0 22164,1 22252,0 22326,1 22346,0 22396,1 22455,0 22516,1 22604,0 22703,1 22727,0 22799,1 22895,0 22942,1 23019,0 23060,1 23084,0 23090,1 23099,0 23121,1 23183,0 23259,1 23320,0 23406,1 23442,0 23472,1 23505,0 23540,1 23561,0 23645,1 23713,0 23733,1 23753,0 23777,1 23803,0 23810,1 23868,0 23922,1 24010,0 24023,1 24062,0 24070,1 24169,0 24219,1 24303,0 24355,1 24423,0 24492,1 24554,0 24614,1 24685,0 24738,1 24747,0 24839,1 24893,0 24938,1 25016,0 25069,1 25159,0 25231,1 25267,0 25347,1 25437,0 25531,1 25631,0 25708,1 25781,0 25832,1 25861,0 25866,1 25943,0 26032,1 26045,0 26082,1 26138,0 26212,1 26231,0 26282,1 26356,0 26362,1 26414,0 26423,1 26443,0 26498,1 26518,0 26607,1 26620,0 26680,1 26728,0 26762,1 26817,0 26863,1 26894,0 26992,1 27055,0 27149,1 27162,0 27202,1 27285,0 27337,1 27431,0 27457,1 27555,0 27568,1 27666,0 27696,1 27697,0 27743,1 27760,0 27836,1 27902,0 27975,1 28061,0 28132,1 28150,0 28192,1 28243,0 28281,1 28318,0 28379,1 28445,0 28522,1 28581,0 28675,1 28750,0 28815,1 28878,0 28916,1 28969,0 28979,1 29067,0 29159,1 29160,0 29246,1 29315,0 29319,1 29347,0 29443,1 29481,0 29549,1 29558,0 29654,1 29746,0 29833,1 29918,0 29984,1 30066,0 30139,1 30215,0 30308,1 30310,0 30385,1 30457,0 30515,1 30588,0 30621,1 30679,0 30779,1 30810,0 30819,1 30892,0 30929,1 31025,0 31113,1 31186,0 31230,1 31312,0 31380,1 31430,0 31528,1 31605,0 31611,1 31695,0 31729,1 31777,0 31822,1 31850,0 31945,1 31970,0 32021,1 32052,0 32115,1 32185,0 32205,1 32234,0 32281,1 32296,0 32358,1 32456,0 32483,1 32577,0 32643,1 32706,0 32741,1 32822,0 32890,1 32914,0 32923,1 32933,0 32982,1 33050,0 33129,1 33168,0 33266,1 33332,0 33380,1 33442,0 33474,1 33560,0 33593,1 33605,0 33642,1 33663,0 33677,1 33699,0 33778,1 33810,0 33816,1 33885,0 33927,1 33936,0 34029,1 34054,0 34068,1 34110,0 34128,1 34144,0 34217,1 34275,0 34331,1 34399,0 34495,1 34530,0 34613,1 34631,0 34689,1 34783,0 34824,1 34862,0 34867,1 34960,0 35034,1 35102,0 35111,1 35127,0 35186,1 35239,0 35258,1 35338,0 35429,1 35524,0 35609,1 35701,0 35729,1 35801,0 35857,1 35884,0 35893,1 35977,0 36021,1 36112,0 36155,1 36223,0 36309,1 36326,0 36337,1 36374,0 36393,1 36425,0 36461,1 36556,0 36649,1 36671,0 36739,1 36754,0 36788,1 36803,0 36880,1 36973,0 37056,1 37112,0 37135,1 37183,0 37198,1 37286,0 37386,1 37420,0 37433,1 37458,0 37535,1 37569,0 37610,1 37667,0 37766,1 37777,0 37838,1 37936,0 38004,1 38058,0 38132,1 38209,0 38282,1 38359,0 38437,1 38443,0 38468,1 38526,0 38622,1 38629,0 38649,1 38743,0 38776,1 38844,0 38920,1 39008,0 39052,1 39101,0 39117,1 39122,0 39150,1 39249,0 39305,1 39327,0 39362,1 39400,0 39411,1 39490,0 39521,1 39591,0 39638,1 39717,0 39766,1 39770,0 39849,1 39906,0 40006,1 40059,0 40063,1 40156,0 40173,1 40254,0 40302,1 40336,0 40409,1 40505,0 40528,1 40532,0 40549,1 40619,0 40638,1 40699,0 40725,1 40769,0 40857,1 40950,0 40982,1 41054,0 41122,1 41196,0 41272,1 41327,0 41335,1 41358,0 41441,1 41448,0 41502,1 41508,0 41539,1 41554,0 41624,1 41695,0 41745,1 41793,0 41842,1 41939,0 41941,1 41947,0 41952,1 41967,0 42045,1 42092,0 42128,1 42145,0 42217,1 42272,0 42308,1 42351,0 42436,1 42535,0 42560,1 42600,0 42625,1 42640,0 42733,1 42800,0 42838,1 42912,0 42943,1 43008,0 43083,1 43128,0 43168,1 43249,0 43313,1 43327,0 43424,1 43488,0 43554,1 43621,0 43676,1 43682,0 43774,1 43865,0 43871,1 43898,0 43972,1 43973,0 44010,1 44043,0 44069,1 44140,0 44149,1 44189,0 44219,1 44315,0 44342,1 44408,0 44415,1 44472,0 44533,1 44608,0 44652,1 44666,0 44757,1 44851,0 44942,1 44993,0 45075,1 45154,0 45188,1 45218,0 45259,1 45285,0 45287,1 45349,0 45426,1 45485,0 45577,1 45653,0 45676,1 45749,0 45829,1 45927,0 45972,1 45997,0 46015,1 46067,0 46133,1 46197,0 46264,1 46350,0 46407,1 46419,0 46473,1 46483,0 46544,1 46557,0 46629,1 46659,0 46747,1 46776,0 46849,1 46868,0 46947,1 46967,0 47005,1 47074,0 47149,1 47150,0 47239,1 47315,0 47386,1 47446,0 47464,1 47544,0 47582,1 47623,0 47662,1 47671,0 47699,1 47750,0 47768,1 47836,0 47905,1 47986,0 48084,1 48183,0 48193,1 48292,0 48360,1 48409,0 48448,1 48450,0 48494,1 48569,0 48618,1 48651,0 48701,1 48791,0 48827,1 48880,0 48965,1 49013,0 49040,1 49135,0 49209,1 49260,0 49320,1 49357,0 49444,1 49462,0 49528,1 49557,0 49628,1 49659,0 49686,1 49700,0 49744,1 49815,0 49894,1 49895,0 49959,1 49982,0 50073,1 50125,0 50224,1 50247,0 50330,1 50372,0 50384,1 50433,0 50461,1 50511,0 50567,1 50618,0 50686,1 50725,0 50735,1 50750,0 50843,1 50857,0 50881,1 50908,0 50942,1 end initlist b1 0,0 18,1 42,0 98,1 100,0 127,1 227,0 269,1 369,0 416,1 455,0 528,1 627,0 671,1 677,0 759,1 827,0 886,1 922,0 936,1 949,0 1010,1 1047,0 1051,1 1075,0 1133,1 1181,0 1185,1 1279,0 1348,1 1421,0 1478,1 1560,0 1634,1 1718,0 1772,1 1815,0 1897,1 1907,0 1956,1 1963,0 2019,1 2051,0 2115,1 2137,0 2147,1 2209,0 2305,1 2316,0 2382,1 2443,0 2509,1 2522,0 2547,1 2615,0 2663,1 2705,0 2715,1 2749,0 2767,1 2863,0 2948,1 2963,0 3063,1 3119,0 3167,1 3247,0 3277,1 3305,0 3312,1 3331,0 3423,1 3431,0 3437,1 3506,0 3565,1 3570,0 3651,1 3694,0 3718,1 3732,0 3751,1 3803,0 3878,1 3899,0 3970,1 4016,0 4095,1 4115,0 4122,1 4213,0 4304,1 4346,0 4353,1 4403,0 4406,1 4425,0 4476,1 4491,0 4583,1 4671,0 4691,1 4759,0 4837,1 4882,0 4900,1 4996,0 5007,1 5012,0 5045,1 5085,0 5120,1 5145,0 5222,1 5295,0 5342,1 5343,0 5402,1 5419,0 5426,1 5492,0 5525,1 5615,0 5652,1 5705,0 5781,1 5855,0 5951,1 6032,0 6096,1 6117,0 6165,1 6225,0 6240,1 6296,0 6300,1 6318,0 6321,1 6379,0 6453,1 6541,0 6545,1 6577,0 6644,1 6736,0 6752,1 6828,0 6914,1 6952,0 6969,1 7043,0 7132,1 7172,0 7207,1 7216,0 7237,1 7261,0 7305,1 7313,0 7404,1 7455,0 7511,1 7553,0 7595,1 7690,0 7738,1 7765,0 7811,1 7815,0 7835,1 7930,0 7982,1 8047,0 8078,1 8119,0 8211,1 8300,0 8358,1 8414,0 8437,1 8524,0 8622,1 8624,0 8700,1 8720,0 8777,1 8796,0 8814,1 8883,0 8921,1 8970,0 8996,1 9085,0 9131,1 9154,0 9243,1 9343,0 9427,1 9464,0 9553,1 9583,0 9683,1 9769,0 9837,1 9852,0 9907,1 9941,0 9986,1 10036,0 10114,1 10136,0 10196,1 10259,0 10281,1 10300,0 10344,1 10384,0 10450,1 10503,0 10589,1 10661,0 10685,1 10757,0 10848,1 10945,0 11013,1 11047,0 11088,1 11134,0 11184,1 11220,0 11277,1 11325,0 11402,1 11500,0 11571,1 11606,0 11651,1 11749,0 11808,1 11885,0 11923,1 11965,0 12044,1 12071,0 12125,1 12194,0 12228,1 12295,0 12305,1 12404,0 12435,1 12437,0 12442,1 12495,0 12582,1 12674,0 12758,1 12847,0 12900,1 12994,0 13037,1 13069,0 13160,1 13223,0 13314,1 13409,0 13465,1 13539,0 13632,1 13692,0 13757,1 13806,0 13905,1 14004,0 14071,1 14089,0 14149,1 14162,0 14240,1 14282,0 14346,1 14426,0 14519,1 14551,0 14569,1 14611,0 14684,1 14712,0 14715,1 14719,0 14801,1 14899,0 14946,1 15016,0 15037,1 15098,0 15193,1 15236,0 15272,1 15275,0 15299,1 15391,0 15484,1 15492,0 15544,1 15561,0 15576,1 15661,0 15750,1 15820,0 15856,1 15911,0 15930,1 15989,0 16002,1 16023,0 16101,1 16163,0 16206,1 16305,0 16348,1 16403,0 16490,1 16511,0 16514,1 16609,0 16698,1 16788,0 16816,1 16901,0 16918,1 16984,0 17065,1 17113,0 17153,1 17209,0 17237,1 17242,0 17258,1 17315,0 17366,1 17416,0 17426,1 17523,0 17578,1 17608,0 17635,1 17735,0 17747,1 17802,0 17893,1 17983,0 18083,1 18155,0 18211,1 18241,0 18333,1 18363,0 18431,1 18473,0 18480,1 18481,0 18501,1 18568,0 18591,1 18686,0 18736,1 18742,0 18775,1 18845,0 18892,1 18909,0 18920,1 18968,0 19050,1 19086,0 19138,1 19167,0 19209,1 19222,0 19257,1 19304,0 19318,1 19326,0 19389,1 19418,0 19455,1 19458,0 19525,1 19557,0 19581,1 19672,0 19741,1 19783,0 19806,1 19841,0 19939,1 20011,0 20052,1 20121,0 20182,1 20225,0 20283,1 20297,0 20373,1 20401,0 20423,1 20497,0 20588,1 20625,0 20661,1 20739,0 20768,1 20843,0 20936,1 20997,0 21028,1 21101,0 21106,1 21121,0 21219,1 21294,0 21380,1 21404,0 21442,1 21501,0 21537,1 21567,0 21598,1 21641,0 21700,1 21781,0 21808,1 21886,0 21910,1 21985,0 21993,1 22047,0 22063,1 22086,0 22176,1 22180,0 22217,1 22311,0 22368,1 22389,0 22400,1 22421,0 22501,1 22551,0 22569,1 22607,0 22675,1 22772,0 22822,1 22857,0 22908,1 22996,0 23092,1 23115,0 23196,1 23276,0 23353,1 23418,0 23496,1 23560,0 23583,1 23646,0 23666,1 23696,0 23767,1 23836,0 23864,1 23923,0 23959,1 24019,0 24094,1 24103,0 24162,1 24188,0 24220,1 24291,0 24309,1 24326,0 24407,1 24489,0 24578,1 24592,0 24683,1 24725,0 24731,1 24746,0 24766,1 24799,0 24811,1 24852,0 24883,1 24889,0 24959,1 24991,0 24993,1 25070,0 25112,1 25169,0 25182,1 25225,0 25297,1 25355,0 25445,1 25463,0 25536,1 25617,0 25687,1 25758,0 25777,1 25841,0 25865,1 25871,0 25880,1 25968,0 26062,1 26117,0 26199,1 26238,0 26321,1 26366,0 26367,1 26433,0 26519,1 26546,0 26619,1 26637,0 26673,1 26692,0 26714,1 26762,0 26790,1 26823,0 26872,1 26906,0 26913,1 26960,0 27020,1 27101,0 27162,1 27172,0 27212,1 27232,0 27267,1 27283,0 27284,1 27351,0 27409,1 27449,0 27500,1 27595,0 27621,1 27660,0 27741,1 27765,0 27826,1 27859,0 27911,1 27954,0 27982,1 27991,0 28062,1 28075,0 28099,1 28183,0 28214,1 28261,0 28286,1 28384,0 28435,1 28478,0 28499,1 28567,0 28593,1 28636,0 28664,1 28743,0 28780,1 28820,0 28841,1 28928,0 28984,1 29049,0 29116,1 29171,0 29209,1 29251,0 29256,1 29354,0 29435,1 29479,0 29518,1 29581,0 29583,1 29683,0 29777,1 29837,0 29900,1 29919,0 29946,1 29968,0 30015,1 30076,0 30162,1 30247,0 30258,1 30325,0 30353,1 30400,0 30473,1 30548,0 30602,1 30683,0 30691,1 30757,0 30798,1 30861,0 30919,1 30979,0 31018,1 31031,0 31111,1 31130,0 31165,1 31197,0 31292,1 31315,0 31405,1 31496,0 31572,1 31618,0 31626,1 31695,0 31793,1 31854,0 31886,1 31967,0 32040,1 32113,0 32170,1 32182,0 32269,1 32333,0 32341,1 32406,0 32455,1 32538,0 32555,1 32573,0 32615,1 32642,0 32707,1 32767,0 32809,1 32909,0 32931,1 33015,0 33101,1 33135,0 33159,1 33170,0 33184,1 33204,0 33208,1 33215,0 33275,1 33366,0 33457,1 33498,0 33525,1 33567,0 33596,1 33666,0 33689,1 33774,0 33859,1 33872,0 33938,1 33971,0 34019,1 34020,0 34048,1 34099,0 34109,1 34155,0 34171,1 34206,0 34223,1 34249,0 34324,1 34346,0 34356,1 34380,0 34425,1 34426,0 34492,1 34535,0 34632,1 34634,0 34663,1 34730,0 34744,1 34765,0 34770,1 34837,0 34918,1 35014,0 35075,1 35132,0 35136,1 35158,0 35233,1 35328,0 35403,1 35473,0 35508,1 35566,0 35570,1 35578,0 35673,1 35704,0 35710,1 35795,0 35886,1 35941,0 36038,1 36048,0 36066,1 36087,0 36149,1 36216,0 36225,1 36320,0 36348,1 36412,0 36461,1 36527,0 36625,1 36673,0 36704,1 36722,0 36760,1 36781,0 36847,1 36892,0 36948,1 37032,0 37112,1 37198,0 37227,1 37285,0 37354,1 37363,0 37432,1 37461,0 37469,1 37497,0 37570,1 37637,0 37708,1 37720,0 37730,1 37820,0 37837,1 37925,0 37954,1 38041,0 38086,1 38175,0 38263,1 38303,0 38315,1 38410,0 38460,1 38498,0 38505,1 38564,0 38574,1 38578,0 38654,1 38716,0 38736,1 38778,0 38833,1 38913,0 38993,1 39045,0 39095,1 39116,0 39215,1 39258,0 39283,1 39361,0 39365,1 39421,0 39502,1 39585,0 39595,1 39602,0 39621,1 39702,0 39767,1 39847,0 39905,1 39958,0 40008,1 40024,0 40052,1 40148,0 40155,1 40218,0 40303,1 40372,0 40427,1 40526,0 40589,1 40685,0 40758,1 40799,0 40850,1 40909,0 40950,1 41024,0 41042,1 41088,0 41137,1 41205,0 41250,1 41271,0 41313,1 41400,0 41417,1 41467,0 41493,1 41593,0 41636,1 41710,0 41720,1 41735,0 41823,1 41904,0 41968,1 42011,0 42029,1 42091,0 42123,1 42172,0 42247,1 42305,0 42380,1 42442,0 42508,1 42585,0 42646,1 42724,0 42785,1 42827,0 42838,1 42864,0 42905,1 42934,0 43001,1 43058,0 43147,1 43177,0 43201,1 43264,0 43318,1 43325,0 43376,1 43405,0 43487,1 43504,0 43590,1 43657,0 43732,1 43797,0 43892,1 43989,0 44042,1 44130,0 44223,1 44285,0 44378,1 44402,0 44447,1 44475,0 44508,1 44537,0 44613,1 44705,0 44715,1 44805,0 44883,1 44946,0 44979,1 44996,0 45083,1 45120,0 45162,1 45239,0 45265,1 45353,0 45373,1 45404,0 45453,1 45456,0 45518,1 45597,0 45677,1 45761,0 45785,1 45876,0 45959,1 46016,0 46089,1 46126,0 46187,1 46230,0 46282,1 46305,0 46393,1 46490,0 46515,1 46566,0 46613,1 46688,0 46731,1 46760,0 46805,1 46863,0 46957,1 47053,0 47116,1 47201,0 47218,1 47318,0 47326,1 47363,0 47396,1 47454,0 47486,1 47507,0 47511,1 47590,0 47627,1 47675,0 47716,1 47768,0 47864,1 47890,0 47896,1 47898,0 47924,1 47964,0 48032,1 48064,0 48097,1 48121,0 48136,1 48179,0 48269,1 48318,0 48384,1 48413,0 48424,1 48522,0 48587,1 48608,0 48663,1 48716,0 48724,1 48734,0 48763,1 48848,0 48850,1 48929,0 48966,1 48971,0 49022,1 49115,0 49137,1 49153,0 49218,1 49308,0 49369,1 49389,0 49390,1 49463,0 49507,1 49510,0 49566,1 49615,0 49655,1 49703,0 49727,1 end initlist b2 0,0 71,1 110,0 145,1 156,0 218,1 308,0 392,1 406,0 457,1 535,0 633,1 680,0 779,1 821,0 909,1 960,0 1048,1 1087,0 1187,1 1234,0 1279,1 1335,0 1396,1 1486,0 1561,1 1638,0 1737,1 1793,0 1878,1 1933,0 2007,1 2058,0 2126,1 2159,0 2227,1 2241,0 2296,1 2350,0 2428,1 2435,0 2529,1 2556,0 2616,1 2629,0 2721,1 2759,0 2797,1 2833,0 2903,1 2952,0 2982,1 3056,0 3066,1 3104,0 3183,1 3215,0 3296,1 3305,0 3388,1 3448,0 3542,1 3583,0 3594,1 3666,0 3723,1 3781,0 3878,1 3891,0 3958,1 4025,0 4047,1 4058,0 4148,1 4187,0 4257,1 4314,0 4382,1 4397,0 4496,1 4541,0 4550,1 4554,0 4649,1 4719,0 4796,1 4814,0 4847,1 4875,0 4927,1 5003,0 5032,1 5035,0 5085,1 5093,0 5120,1 5152,0 5199,1 5211,0 5311,1 5382,0 5399,1 5428,0 5513,1 5553,0 5554,1 5641,0 5644,1 5698,0 5798,1 5813,0 5826,1 5871,0 5884,1 5972,0 5982,1 6039,0 6050,1 6140,0 6160,1 6218,0 6306,1 6394,0 6399,1 6445,0 6458,1 6481,0 6493,1 6584,0 6602,1 6642,0 6659,1 6694,0 6764,1 6796,0 6823,1 6864,0 6887,1 6897,0 6969,1 7025,0 7113,1 7115,0 7165,1 7216,0 7291,1 7365,0 7419,1 7515,0 7600,1 7660,0 7716,1 7727,0 7761,1 7807,0 7882,1 7952,0 8009,1 8018,0 8069,1 8157,0 8219,1 8270,0 8278,1 8345,0 8422,1 8450,0 8468,1 8485,0 8534,1 8626,0 8668,1 8699,0 8714,1 8721,0 8723,1 8758,0 8844,1 8853,0 8878,1 8893,0 8970,1 9038,0 9040,1 9045,0 9083,1 9169,0 9253,1 9336,0 9357,1 9398,0 9415,1 9426,0 9469,1 9554,0 9614,1 9703,0 9793,1 9802,0 9826,1 9892,0 9967,1 10063,0 10100,1 10143,0 10196,1 10285,0 10301,1 10376,0 10467,1 10550,0 10594,1 10684,0 10759,1 10803,0 10873,1 10942,0 11035,1 11061,0 11114,1 11185,0 11219,1 11315,0 11415,1 11442,0 11540,1 11629,0 11692,1 11694,0 11720,1 11766,0 11773,1 11781,0 11827,1 11855,0 11952,1 11953,0 12023,1 12096,0 12195,1 12281,0 12292,1 12309,0 12385,1 12399,0 12453,1 12490,0 12567,1 12584,0 12609,1 12659,0 12712,1 12781,0 12843,1 12933,0 12977,1 13011,0 13070,1 13110,0 13135,1 13162,0 13167,1 13208,0 13299,1 13327,0 13380,1 13433,0 13458,1 13508,0 13592,1 13606,0 13656,1 13750,0 13757,1 13797,0 13798,1 13813,0 13862,1 13962,0 14051,1 14128,0 14208,1 14286,0 14380,1 14461,0 14495,1 14566,0 14609,1 14681,0 14691,1 14770,0 14843,1 14847,0 14881,1 14911,0 14950,1 15045,0 15102,1 15142,0 15222,1 15261,0 15276,1 15299,0 15365,1 15465,0 15485,1 15571,0 15572,1 15633,0 15732,1 15767,0 15859,1 15877,0 15917,1 16004,0 16094,1 16098,0 16184,1 16185,0 16210,1 16253,0 16323,1 16414,0 16495,1 16519,0 16590,1 16599,0 16698,1 16713,0 16787,1 16846,0 16922,1 16941,0 17032,1 17055,0 17137,1 17208,0 17243,1 17317,0 17414,1 17431,0 17435,1 17532,0 17604,1 17631,0 17674,1 17687,0 17722,1 17743,0 17823,1 17917,0 18016,1 18114,0 18131,1 18224,0 18308,1 18327,0 18358,1 18364,0 18421,1 18468,0 18557,1 18568,0 18576,1 18604,0 18647,1 18723,0 18807,1 18843,0 18880,1 18897,0 18902,1 18994,0 19030,1 19092,0 19108,1 19199,0 19242,1 19342,0 19406,1 19490,0 19541,1 19589,0 19591,1 19628,0 19648,1 19724,0 19753,1 19830,0 19901,1 19974,0 20039,1 20092,0 20112,1 20119,0 20212,1 20215,0 20276,1 20306,0 20352,1 20353,0 20443,1 20448,0 20486,1 20514,0 20581,1 20624,0 20637,1 20660,0 20718,1 20757,0 20779,1 20848,0 20874,1 20891,0 20981,1 21053,0 21086,1 21133,0 21136,1 21161,0 21180,1 21214,0 21290,1 21313,0 21330,1 21403,0 21446,1 21522,0 21559,1 21602,0 21652,1 21719,0 21809,1 21834,0 21857,1 21950,0 22003,1 22090,0 22182,1 22275,0 22340,1 22388,0 22398,1 22424,0 22485,1 22579,0 22624,1 22721,0 22801,1 22828,0 22925,1 22955,0 23039,1 23080,0 23123,1 23142,0 23157,1 23178,0 23221,1 23222,0 23289,1 23310,0 23338,1 23415,0 23480,1 23525,0 23605,1 23607,0 23645,1 23651,0 23702,1 23707,0 23794,1 23833,0 23885,1 23979,0 24038,1 24066,0 24087,1 24119,0 24133,1 24188,0 24242,1 24311,0 24314,1 24406,0 24442,1 24445,0 24461,1 24493,0 24558,1 24619,0 24664,1 24701,0 24785,1 24840,0 24876,1 24923,0 25022,1 25070,0 25081,1 25171,0 25191,1 25273,0 25296,1 25332,0 25358,1 25376,0 25389,1 25439,0 25537,1 25605,0 25667,1 25705,0 25754,1 25778,0 25858,1 25917,0 25942,1 26024,0 26052,1 26058,0 26146,1 26156,0 26163,1 26231,0 26272,1 26355,0 26377,1 26393,0 26474,1 26543,0 26618,1 26682,0 26700,1 26791,0 26858,1 26928,0 26956,1 26976,0 26987,1 27021,0 27109,1 27194,0 27231,1 27241,0 27292,1 27325,0 27374,1 27449,0 27519,1 27556,0 27588,1 27619,0 27676,1 27768,0 27846,1 27849,0 27916,1 27979,0 27998,1 28075,0 28167,1 28174,0 28258,1 28276,0 28328,1 28408,0 28482,1 28511,0 28605,1 28692,0 28774,1 28840,0 28883,1 28958,0 29013,1 29062,0 29086,1 29162,0 29203,1 29234,0 29317,1 29384,0 29390,1 29403,0 29442,1 29541,0 29604,1 29681,0 29706,1 29723,0 29734,1 29832,0 29895,1 29914,0 30002,1 30083,0 30181,1 30234,0 30250,1 30337,0 30388,1 30392,0 30393,1 30450,0 30460,1 30492,0 30589,1 30674,0 30676,1 30694,0 30763,1 30794,0 30795,1 30816,0 30890,1 30917,0 30944,1 30947,0 30984,1 31060,0 31064,1 31144,0 31201,1 31226,0 31238,1 31315,0 31345,1 31419,0 31446,1 31502,0 31584,1 31669,0 31703,1 31704,0 31729,1 31776,0 31872,1 31928,0 32019,1 32091,0 32095,1 32173,0 32184,1 32245,0 32268,1 32312,0 32333,1 32364,0 32400,1 32422,0 32511,1 32572,0 32643,1 32669,0 32685,1 32686,0 32699,1 32709,0 32782,1 32783,0 32803,1 32811,0 32882,1 32975,0 33001,1 33054,0 33059,1 33125,0 33205,1 33220,0 33253,1 33314,0 33345,1 33407,0 33433,1 33443,0 33506,1 33511,0 33536,1 33634,0 33681,1 33752,0 33809,1 33877,0 33887,1 33968,0 34011,1 34013,0 34091,1 34139,0 34209,1 34233,0 34252,1 34286,0 34307,1 34329,0 34399,1 34488,0 34500,1 34587,0 34614,1 34641,0 34671,1 34693,0 34788,1 34810,0 34869,1 34884,0 34953,1 35000,0 35054,1 35064,0 35114,1 35153,0 35174,1 35203,0 35277,1 35356,0 35379,1 35443,0 35543,1 35642,0 35702,1 35776,0 35849,1 35894,0 35939,1 35956,0 36054,1 36111,0 36160,1 36187,0 36240,1 36337,0 36419,1 36498,0 36530,1 36606,0 36680,1 36727,0 36778,1 36793,0 36881,1 36956,0 36979,1 37034,0 37118,1 37187,0 37212,1 37215,0 37294,1 37323,0 37419,1 37452,0 37465,1 37505,0 37522,1 37549,0 37641,1 37644,0 37678,1 37770,0 37848,1 37889,0 37988,1 38058,0 38135,1 38222,0 38271,1 38324,0 38407,1 38429,0 38506,1 38514,0 38611,1 38614,0 38631,1 38706,0 38721,1 38736,0 38836,1 38897,0 38911,1 38986,0 39006,1 39103,0 39197,1 39201,0 39249,1 39316,0 39332,1 39343,0 39358,1 39406,0 39431,1 39507,0 39552,1 39604,0 39652,1 39675,0 39724,1 39731,0 39738,1 39803,0 39890,1 39898,0 39947,1 39948,0 40029,1 40092,0 40168,1 40255,0 40303,1 40359,0 40391,1 40462,0 40532,1 40570,0 40658,1 40710,0 40739,1 40833,0 40907,1 40959,0 41044,1 41074,0 41082,1 41088,0 41128,1 41165,0 41181,1 41202,0 41299,1 41343,0 41367,1 41451,0 41514,1 41543,0 41622,1 41657,0 41744,1 41839,0 41848,1 41861,0 41957,1 42045,0 42132,1 42148,0 42216,1 42271,0 42302,1 42326,0 42425,1 42486,0 42517,1 42594,0 42605,1 42692,0 42728,1 42755,0 42825,1 42924,0 42933,1 42952,0 43020,1 43047,0 43097,1 43104,0 43125,1 43174,0 43247,1 43253,0 43345,1 43390,0 43411,1 43413,0 43513,1 43562,0 43579,1 43677,0 43712,1 43771,0 43783,1 43826,0 43832,1 43860,0 43954,1 44039,0 44101,1 44108,0 44145,1 44185,0 44223,1 44320,0 44393,1 44447,0 44464,1 44559,0 44575,1 44598,0 44662,1 44727,0 44752,1 44846,0 44853,1 44864,0 44871,1 44929,0 44936,1 44988,0 45088,1 45128,0 45161,1 45229,0 45300,1 45392,0 45431,1 45531,0 45578,1 45592,0 45611,1 45685,0 45744,1 45836,0 45927,1 45972,0 46012,1 46075,0 46126,1 46175,0 46241,1 46330,0 46381,1 46396,0 46408,1 46426,0 46431,1 46441,0 46531,1 46580,0 46592,1 46640,0 46642,1 46710,0 46721,1 46821,0 46899,1 46954,0 47052,1 47113,0 47138,1 47218,0 47268,1 47295,0 47381,1 47383,0 47436,1 47527,0 47534,1 47571,0 47589,1 47651,0 47707,1 47751,0 47778,1 47821,0 47851,1 47908,0 47933,1 47946,0 48037,1 48050,0 48077,1 48164,0 48204,1 48268,0 48281,1 48291,0 48297,1 48313,0 48363,1 48422,0 48507,1 48606,0 48611,1 48692,0 48735,1 48775,0 48779,1 48842,0 48904,1 48982,0 49069,1 49128,0 49211,1 49293,0 49364,1 49383,0 49436,1 end initlist b3 0,0 95,1 118,0 180,1 192,0 218,1 256,0 312,1 354,0 392,1 481,0 499,1 572,0 597,1 628,0 725,1 736,0 796,1 881,0 927,1 938,0 948,1 1015,0 1037,1 1058,0 1066,1 1125,0 1132,1 1231,0 1264,1 1273,0 1274,1 1337,0 1363,1 1382,0 1397,1 1456,0 1552,1 1630,0 1695,1 1714,0 1805,1 1873,0 1961,1 2060,0 2064,1 2092,0 2155,1 2176,0 2257,1 2286,0 2302,1 2326,0 2392,1 2435,0 2522,1 2541,0 2629,1 2692,0 2778,1 2840,0 2852,1 2891,0 2955,1 3038,0 3115,1 3203,0 3277,1 3347,0 3376,1 3465,0 3482,1 3515,0 3611,1 3648,0 3740,1 3753,0 3799,1 3809,0 3883,1 3894,0 3902,1 3975,0 4020,1 4107,0 4144,1 4193,0 4257,1 4259,0 4339,1 4421,0 4493,1 4571,0 4638,1 4658,0 4713,1 4811,0 4812,1 4861,0 4905,1 4991,0 5010,1 5013,0 5025,1 5113,0 5175,1 5258,0 5285,1 5370,0 5404,1 5447,0 5505,1 5596,0 5604,1 5635,0 5640,1 5708,0 5805,1 5816,0 5858,1 5937,0 5961,1 6030,0 6117,1 6190,0 6285,1 6363,0 6386,1 6462,0 6536,1 6636,0 6711,1 6737,0 6744,1 6843,0 6892,1 6989,0 7013,1 7047,0 7065,1 7075,0 7132,1 7178,0 7224,1 7294,0 7295,1 7337,0 7362,1 7376,0 7400,1 7450,0 7452,1 7531,0 7589,1 7672,0 7752,1 7805,0 7868,1 7943,0 8026,1 8093,0 8166,1 8207,0 8243,1 8251,0 8315,1 8411,0 8463,1 8551,0 8570,1 8638,0 8713,1 8715,0 8770,1 8805,0 8813,1 8839,0 8919,1 8962,0 8967,1 9007,0 9027,1 9062,0 9151,1 9210,0 9260,1 9285,0 9346,1 9352,0 9443,1 9537,0 9575,1 9589,0 9652,1 9711,0 9778,1 9847,0 9894,1 9904,0 10003,1 10088,0 10167,1 10192,0 10222,1 10282,0 10331,1 10341,0 10432,1 10455,0 10533,1 10542,0 10572,1 10615,0 10630,1 10651,0 10743,1 10761,0 10840,1 10934,0 10999,1 11078,0 11120,1 11203,0 11249,1 11286,0 11331,1 11420,0 11489,1 11526,0 11601,1 11652,0 11727,1 11743,0 11754,1 11829,0 11864,1 11898,0 11908,1 11934,0 11948,1 11965,0 11986,1 12005,0 12042,1 12134,0 12163,1 12213,0 12312,1 12385,0 12404,1 12435,0 12521,1 12525,0 12604,1 12628,0 12676,1 12702,0 12731,1 12765,0 12834,1 12927,0 13008,1 13093,0 13116,1 13127,0 13130,1 13134,0 13175,1 13235,0 13239,1 13248,0 13295,1 13306,0 13330,1 13415,0 13513,1 13549,0 13573,1 13627,0 13675,1 13703,0 13784,1 13883,0 13902,1 13904,0 13925,1 13979,0 14006,1 14020,0 14090,1 14171,0 14189,1 14284,0 14365,1 14399,0 14427,1 14445,0 14455,1 14499,0 14525,1 14625,0 14709,1 14769,0 14832,1 14926,0 15005,1 15010,0 15058,1 15147,0 15153,1 15154,0 15211,1 15223,0 15273,1 15314,0 15400,1 15423,0 15491,1 15501,0 15544,1 15598,0 15614,1 15666,0 15744,1 15833,0 15852,1 15896,0 15986,1 15996,0 16058,1 16082,0 16100,1 16147,0 16202,1 16295,0 16362,1 16392,0 16474,1 16566,0 16596,1 16637,0 16662,1 16718,0 16772,1 16778,0 16866,1 16941,0 17009,1 17088,0 17120,1 17153,0 17244,1 17318,0 17345,1 17406,0 17436,1 17513,0 17550,1 17636,0 17672,1 17683,0 17744,1 17816,0 17875,1 17919,0 17999,1 18071,0 18168,1 18205,0 18257,1 18272,0 18364,1 18406,0 18426,1 18504,0 18585,1 18626,0 18655,1 18724,0 18740,1 18750,0 18774,1 18865,0 18905,1 18950,0 18958,1 18972,0 19041,1 19117,0 19125,1 19153,0 19170,1 19186,0 19285,1 19313,0 19383,1 19442,0 19513,1 19591,0 19598,1 19604,0 19697,1 19714,0 19804,1 19808,0 19872,1 19908,0 19909,1 20001,0 20033,1 20087,0 20161,1 20190,0 20252,1 20312,0 20396,1 20410,0 20419,1 20421,0 20451,1 20486,0 20487,1 20530,0 20575,1 20600,0 20653,1 20665,0 20715,1 20788,0 20801,1 20873,0 20885,1 20900,0 20940,1 20989,0 21038,1 21122,0 21177,1 21243,0 21317,1 21344,0 21385,1 21398,0 21474,1 21492,0 21516,1 21543,0 21629,1 21693,0 21732,1 21774,0 21775,1 21820,0 21833,1 21917,0 21937,1 22009,0 22030,1 22035,0 22111,1 22141,0 22212,1 22311,0 22341,1 22429,0 22486,1 22566,0 22594,1 22685,0 22687,1 22718,0 22765,1 22830,0 22919,1 22929,0 22989,1 23086,0 23109,1 23161,0 23198,1 23228,0 23274,1 23287,0 23340,1 23434,0 23457,1 23550,0 23638,1 23712,0 23728,1 23814,0 23861,1 23961,0 23998,1 24066,0 24140,1 24181,0 24196,1 24220,0 24270,1 24329,0 24392,1 24426,0 24526,1 24613,0 24632,1 24634,0 24685,1 24721,0 24756,1 24803,0 24890,1 24931,0 24951,1 24991,0 25059,1 25093,0 25117,1 25198,0 25294,1 25355,0 25366,1 25440,0 25461,1 25561,0 25618,1 25710,0 25755,1 25830,0 25851,1 25888,0 25913,1 25964,0 26038,1 26078,0 26087,1 26138,0 26184,1 26261,0 26324,1 26378,0 26420,1 26436,0 26451,1 26475,0 26522,1 26590,0 26681,1 26763,0 26832,1 26875,0 26953,1 27000,0 27042,1 27079,0 27171,1 27199,0 27293,1 27393,0 27465,1 27524,0 27552,1 27589,0 27633,1 27669,0 27703,1 27738,0 27816,1 27881,0 27910,1 27992,0 28065,1 28112,0 28137,1 28153,0 28210,1 28242,0 28340,1 28429,0 28490,1 28519,0 28613,1 28655,0 28686,1 28748,0 28806,1 28900,0 28970,1 29028,0 29105,1 29200,0 29260,1 29318,0 29411,1 29508,0 29577,1 29666,0 29746,1 29747,0 29815,1 29877,0 29971,1 30055,0 30063,1 30078,0 30158,1 30235,0 30312,1 30342,0 30410,1 30470,0 30550,1 30647,0 30712,1 30736,0 30765,1 30797,0 30831,1 30926,0 31024,1 31071,0 31156,1 31163,0 31245,1 31298,0 31325,1 31375,0 31458,1 31519,0 31527,1 31564,0 31575,1 31608,0 31672,1 31680,0 31689,1 31700,0 31784,1 31822,0 31921,1 31932,0 31971,1 32036,0 32096,1 32183,0 32276,1 32287,0 32313,1 32343,0 32365,1 32455,0 32519,1 32522,0 32533,1 32606,0 32677,1 32776,0 32853,1 32929,0 32980,1 33059,0 33060,1 33140,0 33151,1 33211,0 33249,1 33268,0 33275,1 33362,0 33435,1 33481,0 33551,1 33619,0 33627,1 33708,0 33807,1 33897,0 33967,1 33981,0 34076,1 34134,0 34211,1 34284,0 34346,1 34410,0 34479,1 34499,0 34568,1 34652,0 34664,1 34764,0 34793,1 34809,0 34903,1 34986,0 35019,1 35032,0 35111,1 35186,0 35261,1 35335,0 35419,1 35491,0 35494,1 35584,0 35613,1 35691,0 35739,1 35821,0 35910,1 35946,0 36002,1 36011,0 36023,1 36041,0 36078,1 36115,0 36194,1 36269,0 36336,1 36358,0 36396,1 36464,0 36551,1 36637,0 36676,1 36766,0 36855,1 36898,0 36945,1 36966,0 37057,1 37099,0 37199,1 37293,0 37330,1 37353,0 37378,1 37404,0 37503,1 37582,0 37649,1 37736,0 37778,1 37840,0 37873,1 37961,0 38052,1 38106,0 38195,1 38269,0 38275,1 38322,0 38332,1 38369,0 38458,1 38472,0 38494,1 38562,0 38649,1 38683,0 38727,1 38794,0 38870,1 38875,0 38935,1 39017,0 39095,1 39148,0 39158,1 39198,0 39257,1 39341,0 39402,1 39488,0 39540,1 39595,0 39695,1 39736,0 39797,1 39875,0 39956,1 39964,0 40030,1 40069,0 40155,1 40197,0 40267,1 40294,0 40368,1 40404,0 40411,1 40472,0 40481,1 40572,0 40625,1 40631,0 40707,1 40774,0 40839,1 40888,0 40972,1 40995,0 41055,1 41140,0 41227,1 41315,0 41355,1 41442,0 41510,1 41513,0 41576,1 41612,0 41629,1 41681,0 41700,1 41757,0 41827,1 41907,0 41988,1 42009,0 42034,1 42083,0 42102,1 42103,0 42121,1 42156,0 42223,1 42268,0 42278,1 42284,0 42289,1 42319,0 42355,1 42412,0 42451,1 42504,0 42533,1 42617,0 42717,1 42718,0 42773,1 42815,0 42831,1 42929,0 42987,1 43031,0 43103,1 43201,0 43295,1 43361,0 43397,1 43447,0 43510,1 43592,0 43626,1 43677,0 43708,1 43738,0 43769,1 43854,0 43919,1 43941,0 43985,1 44081,0 44102,1 44189,0 44255,1 44344,0 44398,1 44432,0 44509,1 44607,0 44700,1 44703,0 44714,1 44793,0 44824,1 44869,0 44931,1 44992,0 45088,1 45096,0 45109,1 45200,0 45235,1 45305,0 45309,1 45408,0 45463,1 45563,0 45603,1 45604,0 45632,1 45687,0 45694,1 45775,0 45825,1 45873,0 45911,1 45977,0 45988,1 46059,0 46137,1 46169,0 46170,1 46223,0 46307,1 46399,0 46472,1 46515,0 46573,1 46623,0 46655,1 46711,0 46778,1 46813,0 46861,1 46905,0 46946,1 46947,0 46995,1 47001,0 47004,1 47015,0 47044,1 47124,0 47185,1 47251,0 47292,1 47390,0 47404,1 47429,0 47480,1 47517,0 47527,1 47557,0 47597,1 47679,0 47702,1 47726,0 47736,1 47782,0 47789,1 47857,0 47946,1 48013,0 48109,1 48151,0 48164,1 48188,0 48286,1 48303,0 48337,1 48410,0 48453,1 48500,0 48559,1 48592,0 48652,1 48670,0 48766,1 48848,0 48877,1 48943,0 48953,1 49045,0 49056,1 49154,0 49155,1 49167,0 49239,1 49301,0 49328,1 49340,0 49419,1 49473,0 49502,1 49550,0 49563,1 49595,0 49689,1 49699,0 49761,1 49801,0 49869,1 49910,0 49929,1 49939,0 50031,1 50044,0 50056,1 50145,0 50179,1 50187,0 50226,1 50315,0 50339,1 50394,0 50418,1 50472,0 50531,1 end initlist b4 0,0 69,1 151,0 189,1 251,0 319,1 390,0 404,1 433,0 442,1 521,0 563,1 661,0 691,1 701,0 800,1 808,0 821,1 834,0 894,1 970,0 1054,1 1071,0 1112,1 1160,0 1210,1 1257,0 1291,1 1306,0 1318,1 1365,0 1405,1 1474,0 1525,1 1576,0 1611,1 1706,0 1781,1 1782,0 1877,1 1940,0 2037,1 2074,0 2084,1 2145,0 2229,1 2309,0 2357,1 2392,0 2415,1 2460,0 2559,1 2588,0 2643,1 2685,0 2714,1 2735,0 2803,1 2871,0 2943,1 3037,0 3102,1 3134,0 3204,1 3239,0 3310,1 3327,0 3422,1 3489,0 3565,1 3624,0 3669,1 3739,0 3786,1 3795,0 3825,1 3912,0 3954,1 3956,0 3977,1 4062,0 4161,1 4203,0 4281,1 4371,0 4435,1 4494,0 4504,1 4569,0 4623,1 4682,0 4771,1 4812,0 4859,1 4925,0 4975,1 4979,0 5074,1 5104,0 5106,1 5190,0 5273,1 5333,0 5362,1 5434,0 5533,1 5624,0 5661,1 5743,0 5793,1 5834,0 5928,1 5951,0 6000,1 6044,0 6051,1 6141,0 6175,1 6189,0 6201,1 6221,0 6307,1 6308,0 6335,1 6342,0 6408,1 6499,0 6532,1 6575,0 6619,1 6708,0 6777,1 6833,0 6893,1 6931,0 6955,1 7024,0 7070,1 7086,0 7144,1 7178,0 7255,1 7266,0 7356,1 7387,0 7421,1 7484,0 7568,1 7642,0 7679,1 7754,0 7783,1 7857,0 7881,1 7930,0 7943,1 8026,0 8057,1 8069,0 8121,1 8167,0 8170,1 8219,0 8302,1 8323,0 8362,1 8412,0 8474,1 8566,0 8606,1 8618,0 8709,1 8797,0 8869,1 8958,0 8961,1 9007,0 9089,1 9164,0 9186,1 9223,0 9253,1 9347,0 9424,1 9468,0 9470,1 9487,0 9537,1 9540,0 9640,1 9684,0 9772,1 9785,0 9872,1 9969,0 10040,1 10045,0 10070,1 10099,0 10169,1 10201,0 10233,1 10259,0 10317,1 10394,0 10466,1 10469,0 10536,1 10634,0 10704,1 10772,0 10783,1 10803,0 10900,1 10961,0 11030,1 11107,0 11169,1 11212,0 11309,1 11310,0 11313,1 11358,0 11367,1 11432,0 11451,1 11550,0 11566,1 11629,0 11677,1 11705,0 11747,1 11768,0 11838,1 11884,0 11967,1 12006,0 12014,1 12041,0 12079,1 12084,0 12134,1 12154,0 12214,1 12227,0 12289,1 12357,0 12416,1 12432,0 12525,1 12620,0 12718,1 12729,0 12732,1 12820,0 12867,1 12899,0 12960,1 12969,0 13064,1 13125,0 13223,1 13254,0 13270,1 13364,0 13392,1 13482,0 13518,1 13609,0 13676,1 13719,0 13742,1 13817,0 13874,1 13915,0 13996,1 14016,0 14029,1 14083,0 14087,1 14167,0 14171,1 14215,0 14232,1 14257,0 14274,1 14297,0 14351,1 14420,0 14478,1 14543,0 14613,1 14648,0 14649,1 14696,0 14778,1 14781,0 14879,1 14972,0 14988,1 15081,0 15135,1 15144,0 15164,1 15216,0 15264,1 15297,0 15357,1 15392,0 15486,1 15567,0 15657,1 15671,0 15676,1 15754,0 15771,1 15844,0 15925,1 15994,0 16074,1 16134,0 16170,1 16193,0 16288,1 16380,0 16461,1 16529,0 16623,1 16636,0 16648,1 16700,0 16789,1 16853,0 16860,1 16958,0 16968,1 17041,0 17065,1 17090,0 17149,1 17220,0 17225,1 17301,0 17381,1 17432,0 17452,1 17552,0 17587,1 17676,0 17756,1 17764,0 17811,1 17847,0 17859,1 17958,0 18044,1 18133,0 18205,1 18223,0 18234,1 18279,0 18299,1 18382,0 18449,1 18542,0 18555,1 18599,0 18657,1 18734,0 18821,1 18838,0 18846,1 18856,0 18930,1 18934,0 18960,1 19002,0 19010,1 19055,0 19067,1 19150,0 19159,1 19258,0 19291,1 19374,0 19435,1 19477,0 19569,1 19625,0 19630,1 19688,0 19733,1 19736,0 19742,1 19770,0 19818,1 19916,0 19993,1 20049,0 20112,1 20129,0 20206,1 20214,0 20250,1 20252,0 20288,1 20305,0 20309,1 20310,0 20333,1 20429,0 20447,1 20540,0 20553,1 20650,0 20707,1 20783,0 20869,1 20881,0 20924,1 21015,0 21064,1 21154,0 21196,1 21247,0 21308,1 21381,0 21469,1 21550,0 21640,1 21679,0 21698,1 21725,0 21775,1 21801,0 21882,1 21961,0 22046,1 22070,0 22076,1 22095,0 22166,1 22183,0 22210,1 22272,0 22325,1 22423,0 22498,1 22582,0 22639,1 22728,0 22823,1 22826,0 22854,1 22864,0 22919,1 22994,0 23080,1 23099,0 23142,1 23177,0 23231,1 23314,0 23340,1 23427,0 23454,1 23494,0 23536,1 23566,0 23599,1 23637,0 23700,1 23790,0 23804,1 23878,0 23969,1 24049,0 24093,1 24170,0 24240,1 24256,0 24305,1 24399,0 24445,1 24475,0 24562,1 24624,0 24694,1 24781,0 24836,1 24903,0 24940,1 24980,0 24987,1 25046,0 25058,1 25106,0 25193,1 25280,0 25296,1 25378,0 25415,1 25469,0 25494,1 25498,0 25566,1 25654,0 25714,1 25767,0 25793,1 25856,0 25921,1 25956,0 25996,1 26030,0 26087,1 26185,0 26229,1 26275,0 26286,1 26307,0 26322,1 26369,0 26370,1 26383,0 26476,1 26564,0 26567,1 26628,0 26667,1 26733,0 26805,1 26847,0 26886,1 26980,0 27043,1 27102,0 27152,1 27219,0 27227,1 27273,0 27284,1 27287,0 27306,1 27313,0 27335,1 27394,0 27433,1 27492,0 27575,1 27591,0 27689,1 27757,0 27795,1 27863,0 27900,1 27953,0 28002,1 28013,0 28016,1 28064,0 28088,1 28144,0 28152,1 28204,0 28276,1 28356,0 28395,1 28430,0 28443,1 28517,0 28614,1 28655,0 28710,1 28772,0 28820,1 28846,0 28909,1 28961,0 29011,1 29081,0 29112,1 29157,0 29248,1 29254,0 29262,1 29275,0 29333,1 29369,0 29397,1 29428,0 29458,1 29555,0 29565,1 29660,0 29711,1 29808,0 29888,1 29977,0 30071,1 30158,0 30193,1 30265,0 30318,1 30393,0 30399,1 30409,0 30447,1 30510,0 30594,1 30609,0 30657,1 30708,0 30790,1 30863,0 30943,1 31011,0 31084,1 31132,0 31183,1 31281,0 31314,1 31376,0 31427,1 31516,0 31521,1 31611,0 31644,1 31675,0 31775,1 31797,0 31894,1 31895,0 31898,1 31998,0 32075,1 32171,0 32257,1 32308,0 32381,1 32386,0 32474,1 32480,0 32548,1 32631,0 32639,1 32657,0 32727,1 32827,0 32842,1 32925,0 32932,1 33013,0 33017,1 33060,0 33140,1 33180,0 33250,1 33334,0 33348,1 33405,0 33467,1 33523,0 33547,1 33616,0 33652,1 33690,0 33755,1 33848,0 33885,1 33921,0 33973,1 33985,0 33988,1 34047,0 34091,1 34177,0 34181,1 34261,0 34358,1 34421,0 34518,1 34564,0 34654,1 34712,0 34812,1 34881,0 34954,1 35054,0 35106,1 35156,0 35243,1 35258,0 35312,1 35333,0 35424,1 35455,0 35465,1 35560,0 35633,1 35680,0 35689,1 35705,0 35742,1 35799,0 35878,1 35934,0 35989,1 36026,0 36058,1 36158,0 36214,1 36237,0 36266,1 36268,0 36330,1 36352,0 36389,1 36464,0 36550,1 36593,0 36602,1 36655,0 36671,1 36711,0 36807,1 36860,0 36875,1 36902,0 36929,1 37013,0 37096,1 37151,0 37162,1 37245,0 37320,1 37411,0 37507,1 37601,0 37630,1 37696,0 37792,1 37809,0 37860,1 37947,0 38045,1 38137,0 38181,1 38242,0 38274,1 38319,0 38350,1 38374,0 38433,1 38460,0 38524,1 38542,0 38624,1 38687,0 38722,1 38743,0 38820,1 38847,0 38857,1 38934,0 38937,1 38982,0 39037,1 39132,0 39159,1 39246,0 39301,1 39393,0 39403,1 39477,0 39529,1 39552,0 39580,1 39601,0 39651,1 39735,0 39825,1 39898,0 39990,1 40016,0 40042,1 40067,0 40129,1 40134,0 40173,1 40270,0 40329,1 40367,0 40419,1 40460,0 40482,1 40534,0 40584,1 40679,0 40725,1 40773,0 40784,1 40860,0 40918,1 40962,0 40970,1 41000,0 41089,1 41116,0 41123,1 41176,0 41211,1 41257,0 41357,1 41402,0 41446,1 41522,0 41523,1 41613,0 41662,1 41726,0 41772,1 41781,0 41851,1 41921,0 41969,1 42025,0 42120,1 42160,0 42175,1 42190,0 42246,1 42331,0 42418,1 42487,0 42576,1 42589,0 42628,1 42643,0 42681,1 42757,0 42788,1 42854,0 42886,1 42902,0 42982,1 43060,0 43087,1 43137,0 43144,1 43231,0 43300,1 43350,0 43420,1 43434,0 43487,1 43579,0 43600,1 43617,0 43691,1 43730,0 43755,1 43821,0 43907,1 43985,0 44016,1 44100,0 44172,1 44264,0 44266,1 44358,0 44409,1 44438,0 44464,1 44472,0 44570,1 44619,0 44646,1 44724,0 44752,1 44793,0 44870,1 44934,0 44970,1 44980,0 45045,1 45111,0 45203,1 45255,0 45283,1 45295,0 45377,1 45388,0 45448,1 45464,0 45562,1 45655,0 45710,1 45747,0 45808,1 45856,0 45930,1 45994,0 46075,1 46084,0 46168,1 46185,0 46230,1 46326,0 46338,1 46389,0 46399,1 46424,0 46452,1 46530,0 46578,1 46623,0 46709,1 46723,0 46804,1 46876,0 46902,1 46990,0 47018,1 47118,0 47141,1 47206,0 47284,1 47368,0 47380,1 47394,0 47459,1 47541,0 47615,1 47701,0 47743,1 47781,0 47856,1 47899,0 47986,1 48007,0 48094,1 48136,0 48194,1 48278,0 48346,1 48380,0 48458,1 48538,0 48607,1 48683,0 48688,1 48700,0 48756,1 48853,0 48914,1 48967,0 49007,1 49098,0 49114,1 49170,0 49231,1 49331,0 49410,1 49433,0 49449,1 49472,0 49543,1 49594,0 49667,1 49691,0 49757,1 49814,0 49846,1 49865,0 49935,1 49968,0 50045,1 50051,0 50062,1 50151,0 50173,1 50270,0 50306,1 50367,0 50448,1 50466,0 50489,1 50517,0 50546,1 50645,0 50721,1 50783,0 50820,1 50916,0 50992,1 50994,0 51001,1 51012,0 51039,1 51101,0 51164,1 end initlist b5 0,0 76,1 78,0 143,1 160,0 248,1 305,0 399,1 431,0 495,1 552,0 591,1 675,0 703,1 803,0 883,1 896,0 916,1 977,0 990,1 991,0 993,1 1082,0 1161,1 1247,0 1322,1 1335,0 1403,1 1430,0 1503,1 1584,0 1595,1 1653,0 1688,1 1698,0 1734,1 1741,0 1794,1 1893,0 1977,1 1985,0 2066,1 2074,0 2159,1 2257,0 2336,1 2395,0 2469,1 2560,0 2657,1 2676,0 2706,1 2747,0 2836,1 2869,0 2877,1 2976,0 3019,1 3116,0 3201,1 3254,0 3274,1 3331,0 3390,1 3481,0 3485,1 3534,0 3632,1 3701,0 3707,1 3712,0 3760,1 3775,0 3828,1 3905,0 3987,1 4031,0 4033,1 4093,0 4112,1 4162,0 4206,1 4302,0 4347,1 4352,0 4382,1 4417,0 4475,1 4486,0 4523,1 4589,0 4653,1 4726,0 4751,1 4804,0 4877,1 4909,0 4971,1 5014,0 5070,1 5105,0 5171,1 5199,0 5296,1 5314,0 5400,1 5479,0 5529,1 5621,0 5665,1 5670,0 5684,1 5725,0 5733,1 5827,0 5892,1 5899,0 5975,1 6037,0 6091,1 6100,0 6119,1 6139,0 6217,1 6251,0 6326,1 6342,0 6389,1 6457,0 6532,1 6551,0 6595,1 6663,0 6701,1 6785,0 6788,1 6877,0 6887,1 6976,0 7028,1 7047,0 7078,1 7164,0 7256,1 7298,0 7369,1 7388,0 7439,1 7465,0 7551,1 7583,0 7608,1 7695,0 7706,1 7787,0 7804,1 7890,0 7980,1 7983,0 8007,1 8018,0 8083,1 8111,0 8131,1 8203,0 8239,1 8266,0 8361,1 8406,0 8461,1 8506,0 8544,1 8578,0 8601,1 8637,0 8690,1 8708,0 8727,1 8803,0 8902,1 8990,0 9042,1 9057,0 9083,1 9111,0 9143,1 9240,0 9261,1 9327,0 9360,1 9449,0 9495,1 9562,0 9650,1 9738,0 9786,1 9801,0 9813,1 9847,0 9858,1 9874,0 9927,1 9959,0 10042,1 10121,0 10215,1 10268,0 10325,1 10396,0 10437,1 10452,0 10507,1 10588,0 10644,1 10701,0 10725,1 10751,0 10821,1 10889,0 10945,1 11004,0 11078,1 11140,0 11147,1 11186,0 11248,1 11340,0 11386,1 11478,0 11534,1 11565,0 11609,1 11706,0 11803,1 11811,0 11814,1 11846,0 11939,1 11974,0 12012,1 12059,0 12062,1 12143,0 12231,1 12273,0 12290,1 12380,0 12410,1 12437,0 12492,1 12522,0 12586,1 12603,0 12656,1 12721,0 12758,1 12849,0 12861,1 12915,0 12927,1 13027,0 13032,1 13077,0 13136,1 13174,0 13211,1 13220,0 13286,1 13366,0 13391,1 13478,0 13561,1 13586,0 13651,1 13657,0 13755,1 13829,0 13902,1 13965,0 13966,1 13991,0 14063,1 14114,0 14173,1 14227,0 14324,1 14354,0 14442,1 14473,0 14535,1 14551,0 14563,1 14625,0 14636,1 14725,0 14822,1 14827,0 14854,1 14947,0 15020,1 15032,0 15041,1 15087,0 15111,1 15174,0 15245,1 15343,0 15429,1 15468,0 15524,1 15589,0 15653,1 15719,0 15790,1 15877,0 15976,1 16060,0 16091,1 16146,0 16196,1 16272,0 16310,1 16399,0 16459,1 16506,0 16537,1 16606,0 16644,1 16734,0 16738,1 16815,0 16857,1 16922,0 16983,1 17052,0 17150,1 17181,0 17257,1 17348,0 17404,1 17480,0 17483,1 17549,0 17582,1 17591,0 17608,1 17658,0 17756,1 17806,0 17852,1 17920,0 17985,1 18010,0 18038,1 18095,0 18134,1 18188,0 18261,1 18300,0 18376,1 18469,0 18501,1 18601,0 18657,1 18752,0 18806,1 18851,0 18878,1 18977,0 19026,1 19104,0 19183,1 19282,0 19332,1 19383,0 19428,1 19430,0 19472,1 19512,0 19533,1 19626,0 19685,1 19729,0 19808,1 19821,0 19869,1 19887,0 19918,1 20001,0 20056,1 20114,0 20144,1 20185,0 20245,1 20321,0 20339,1 20345,0 20346,1 20411,0 20466,1 20474,0 20485,1 20492,0 20580,1 20600,0 20670,1 20739,0 20812,1 20815,0 20844,1 20927,0 20941,1 20945,0 20983,1 20984,0 21071,1 21147,0 21210,1 21297,0 21382,1 21455,0 21484,1 21496,0 21572,1 21659,0 21719,1 21807,0 21877,1 21970,0 21986,1 22011,0 22021,1 22025,0 22084,1 22149,0 22190,1 22240,0 22339,1 22416,0 22492,1 22515,0 22519,1 22552,0 22569,1 22597,0 22605,1 22662,0 22680,1 22775,0 22791,1 22819,0 22906,1 22936,0 22957,1 22985,0 23008,1 23059,0 23132,1 23196,0 23209,1 23267,0 23365,1 23442,0 23468,1 23516,0 23528,1 23545,0 23551,1 23578,0 23673,1 23677,0 23696,1 23718,0 23778,1 23867,0 23884,1 23927,0 23950,1 24006,0 24014,1 24072,0 24089,1 24151,0 24228,1 24241,0 24268,1 24323,0 24416,1 24450,0 24482,1 24569,0 24668,1 24697,0 24788,1 24805,0 24891,1 24978,0 25023,1 25064,0 25084,1 25105,0 25192,1 25288,0 25315,1 25322,0 25408,1 25474,0 25550,1 25638,0 25672,1 25734,0 25755,1 25846,0 25875,1 25969,0 26028,1 26051,0 26077,1 26121,0 26178,1 26247,0 26248,1 26345,0 26366,1 26414,0 26487,1 26511,0 26534,1 26550,0 26606,1 26622,0 26691,1 26751,0 26816,1 26916,0 26930,1 27029,0 27056,1 27139,0 27145,1 27222,0 27224,1 27246,0 27303,1 27312,0 27336,1 27353,0 27417,1 27456,0 27510,1 27592,0 27666,1 27724,0 27806,1 27833,0 27904,1 27986,0 27998,1 28027,0 28076,1 28158,0 28166,1 28168,0 28210,1 28258,0 28311,1 28325,0 28369,1 28469,0 28524,1 28537,0 28558,1 28614,0 28632,1 28722,0 28819,1 28863,0 28897,1 28934,0 28939,1 28998,0 29093,1 29129,0 29214,1 29253,0 29297,1 29319,0 29324,1 29403,0 29460,1 29504,0 29542,1 29629,0 29639,1 29714,0 29718,1 29810,0 29835,1 29916,0 29982,1 30005,0 30071,1 30106,0 30129,1 30171,0 30242,1 30275,0 30320,1 30404,0 30468,1 30546,0 30633,1 30725,0 30756,1 30804,0 30806,1 30842,0 30860,1 30959,0 31024,1 31086,0 31183,1 31195,0 31229,1 31268,0 31343,1 31399,0 31445,1 31463,0 31467,1 31518,0 31603,1 31631,0 31717,1 31778,0 31856,1 31867,0 31885,1 31968,0 31981,1 32075,0 32088,1 32090,0 32092,1 32148,0 32151,1 32187,0 32252,1 32296,0 32312,1 32406,0 32421,1 32488,0 32541,1 32564,0 32580,1 32673,0 32684,1 32779,0 32832,1 32842,0 32942,1 33025,0 33124,1 33138,0 33151,1 33217,0 33238,1 33303,0 33401,1 33482,0 33567,1 33612,0 33657,1 33667,0 33754,1 33774,0 33815,1 33866,0 33955,1 34052,0 34065,1 34103,0 34140,1 34147,0 34181,1 34232,0 34325,1 34368,0 34459,1 34506,0 34550,1 34575,0 34616,1 34636,0 34716,1 34741,0 34797,1 34874,0 34927,1 34977,0 35035,1 35100,0 35139,1 35166,0 35243,1 35308,0 35369,1 35424,0 35427,1 35467,0 35543,1 35611,0 35663,1 35691,0 35722,1 35820,0 35849,1 35900,0 35947,1 35953,0 36017,1 36018,0 36058,1 36095,0 36128,1 36226,0 36246,1 36258,0 36274,1 36356,0 36421,1 36474,0 36489,1 36537,0 36581,1 36651,0 36665,1 36750,0 36778,1 36812,0 36889,1 36948,0 36965,1 37015,0 37032,1 37061,0 37140,1 37240,0 37314,1 37397,0 37404,1 37458,0 37492,1 37496,0 37595,1 37654,0 37672,1 37706,0 37719,1 37816,0 37880,1 37972,0 38023,1 38067,0 38100,1 38142,0 38150,1 38197,0 38292,1 38356,0 38420,1 38455,0 38551,1 38649,0 38709,1 38790,0 38817,1 38882,0 38907,1 38923,0 38955,1 39051,0 39134,1 39176,0 39256,1 39300,0 39371,1 39457,0 39514,1 39558,0 39574,1 39578,0 39640,1 39660,0 39716,1 39724,0 39763,1 39831,0 39847,1 39935,0 40031,1 40099,0 40152,1 40243,0 40260,1 40316,0 40394,1 40429,0 40524,1 40568,0 40665,1 40684,0 40750,1 40786,0 40800,1 40877,0 40934,1 40950,0 40986,1 41008,0 41026,1 41066,0 41099,1 41195,0 41271,1 41290,0 41297,1 41311,0 41356,1 41376,0 41379,1 41453,0 41489,1 41539,0 41568,1 41622,0 41634,1 41659,0 41744,1 41805,0 41816,1 41887,0 41947,1 41975,0 42000,1 42012,0 42097,1 42187,0 42210,1 42258,0 42308,1 42338,0 42422,1 42481,0 42563,1 42628,0 42664,1 42695,0 42774,1 42845,0 42864,1 42874,0 42900,1 42941,0 42988,1 43031,0 43085,1 43182,0 43203,1 43227,0 43290,1 43388,0 43479,1 43576,0 43589,1 43598,0 43606,1 43700,0 43764,1 43813,0 43868,1 43895,0 43971,1 44031,0 44095,1 44166,0 44256,1 44292,0 44385,1 44480,0 44529,1 44562,0 44621,1 44680,0 44750,1 44818,0 44861,1 44933,0 44934,1 44958,0 44980,1 45022,0 45059,1 45084,0 45128,1 45183,0 45188,1 45227,0 45283,1 45347,0 45438,1 45505,0 45596,1 45659,0 45686,1 45690,0 45718,1 45736,0 45798,1 45826,0 45833,1 45908,0 45984,1 46066,0 46077,1 46164,0 46215,1 46286,0 46333,1 46382,0 46462,1 46499,0 46556,1 46592,0 46650,1 46745,0 46761,1 46791,0 46793,1 46871,0 46890,1 46983,0 46987,1 47046,0 47102,1 47167,0 47258,1 47286,0 47331,1 47364,0 47453,1 47473,0 47520,1 47559,0 47640,1 47698,0 47790,1 47828,0 47885,1 47964,0 47996,1 48075,0 48138,1 48235,0 48314,1 48347,0 48384,1 48481,0 48520,1 48537,0 48612,1 48625,0 48671,1 48755,0 48764,1 48859,0 48880,1 48936,0 49005,1 49034,0 49078,1 49162,0 49184,1 49264,0 49290,1 49346,0 49391,1 49465,0 49531,1 49628,0 49703,1 49728,0 49734,1 49787,0 49846,1 49883,0 49935,1 50022,0 50101,1 50115,0 50178,1 end initlist b6 0,0 18,1 56,0 71,1 122,0 154,1 237,0 330,1 370,0 460,1 550,0 626,1 701,0 709,1 792,0 890,1 913,0 962,1 964,0 1041,1 1055,0 1112,1 1185,0 1199,1 1215,0 1267,1 1345,0 1433,1 1509,0 1550,1 1629,0 1724,1 1725,0 1744,1 1745,0 1800,1 1805,0 1855,1 1890,0 1902,1 1921,0 1941,1 1992,0 2056,1 2155,0 2223,1 2273,0 2355,1 2422,0 2488,1 2552,0 2640,1 2699,0 2772,1 2830,0 2929,1 3028,0 3067,1 3120,0 3159,1 3222,0 3266,1 3282,0 3313,1 3355,0 3362,1 3442,0 3485,1 3492,0 3509,1 3592,0 3684,1 3757,0 3821,1 3843,0 3905,1 3977,0 4066,1 4140,0 4194,1 4291,0 4300,1 4332,0 4424,1 4513,0 4572,1 4654,0 4697,1 4745,0 4803,1 4853,0 4871,1 4905,0 4979,1 5078,0 5124,1 5211,0 5287,1 5307,0 5329,1 5399,0 5487,1 5587,0 5677,1 5686,0 5700,1 5782,0 5858,1 5920,0 5950,1 6023,0 6037,1 6117,0 6187,1 6225,0 6237,1 6269,0 6347,1 6387,0 6477,1 6505,0 6531,1 6564,0 6572,1 6649,0 6666,1 6687,0 6771,1 6820,0 6886,1 6961,0 7047,1 7145,0 7170,1 7244,0 7298,1 7383,0 7437,1 7454,0 7545,1 7606,0 7638,1 7692,0 7699,1 7712,0 7748,1 7827,0 7847,1 7876,0 7951,1 7958,0 7973,1 8073,0 8103,1 8120,0 8201,1 8216,0 8263,1 8326,0 8349,1 8425,0 8510,1 8607,0 8661,1 8733,0 8832,1 8867,0 8870,1 8887,0 8905,1 8953,0 8998,1 9023,0 9120,1 9131,0 9176,1 9251,0 9351,1 9426,0 9472,1 9535,0 9541,1 9606,0 9694,1 9700,0 9713,1 9793,0 9860,1 9900,0 9966,1 9970,0 10043,1 10089,0 10166,1 10254,0 10320,1 10343,0 10442,1 10539,0 10583,1 10634,0 10687,1 10720,0 10793,1 10804,0 10848,1 10907,0 10955,1 11028,0 11066,1 11090,0 11108,1 11188,0 11189,1 11264,0 11277,1 11332,0 11406,1 11468,0 11507,1 11564,0 11608,1 11692,0 11702,1 11773,0 11838,1 11898,0 11935,1 11959,0 11978,1 12046,0 12140,1 12215,0 12241,1 12323,0 12407,1 12452,0 12455,1 12495,0 12523,1 12550,0 12640,1 12722,0 12818,1 12885,0 12910,1 12944,0 13029,1 13098,0 13144,1 13159,0 13205,1 13303,0 13323,1 13389,0 13478,1 13560,0 13599,1 13653,0 13681,1 13745,0 13803,1 13875,0 13913,1 13926,0 13959,1 14010,0 14022,1 14106,0 14189,1 14248,0 14344,1 14401,0 14410,1 14443,0 14484,1 14513,0 14600,1 14677,0 14698,1 14731,0 14828,1 14882,0 14922,1 14959,0 14963,1 15024,0 15117,1 15142,0 15169,1 15242,0 15325,1 15363,0 15453,1 15495,0 15583,1 15630,0 15685,1 15744,0 15836,1 15847,0 15913,1 16011,0 16029,1 16036,0 16057,1 16147,0 16230,1 16244,0 16274,1 16348,0 16356,1 16364,0 16371,1 16417,0 16487,1 16566,0 16600,1 16648,0 16712,1 16742,0 16744,1 16808,0 16888,1 16910,0 16955,1 16980,0 17070,1 17091,0 17106,1 17179,0 17199,1 17218,0 17313,1 17375,0 17457,1 17526,0 17567,1 17656,0 17672,1 17712,0 17782,1 17837,0 17862,1 17901,0 17965,1 17975,0 18036,1 18091,0 18130,1 18180,0 18249,1 18343,0 18418,1 18444,0 18488,1 18552,0 18620,1 18677,0 18695,1 18777,0 18858,1 18876,0 18905,1 18942,0 19017,1 19117,0 19139,1 19185,0 19189,1 19192,0 19283,1 19357,0 19388,1 19430,0 19513,1 19546,0 19583,1 19631,0 19691,1 19777,0 19835,1 19849,0 19895,1 19940,0 19967,1 20029,0 20103,1 20165,0 20251,1 20300,0 20325,1 20422,0 20491,1 20551,0 20604,1 20641,0 20710,1 20764,0 20817,1 20826,0 20886,1 20944,0 20990,1 20999,0 21013,1 21026,0 21062,1 21095,0 21170,1 21258,0 21333,1 21385,0 21450,1 21496,0 21583,1 21592,0 21615,1 21668,0 21708,1 21763,0 21814,1 21856,0 21935,1 22035,0 22133,1 22140,0 22151,1 22236,0 22249,1 22338,0 22400,1 22407,0 22483,1 22553,0 22579,1 22671,0 22735,1 22788,0 22806,1 22862,0 22938,1 23001,0 23068,1 23097,0 23141,1 23189,0 23191,1 23250,0 23317,1 23400,0 23491,1 23588,0 23677,1 23757,0 23811,1 23840,0 23877,1 23965,0 24037,1 24110,0 24128,1 24180,0 24189,1 24250,0 24349,1 24422,0 24461,1 24514,0 24596,1 24655,0 24695,1 24727,0 24804,1 24901,0 24950,1 24990,0 25063,1 25070,0 25084,1 25163,0 25203,1 25279,0 25304,1 25359,0 25391,1 25436,0 25444,1 25531,0 25541,1 25592,0 25634,1 25733,0 25832,1 25838,0 25917,1 25920,0 25954,1 26037,0 26045,1 26128,0 26151,1 26174,0 26192,1 26195,0 26224,1 26252,0 26279,1 26344,0 26409,1 26499,0 26543,1 26635,0 26712,1 26810,0 26885,1 26968,0 27021,1 27031,0 27047,1 27135,0 27222,1 27254,0 27287,1 27313,0 27398,1 27493,0 27549,1 27567,0 27647,1 27690,0 27747,1 27761,0 27801,1 27866,0 27933,1 27961,0 28045,1 28084,0 28141,1 28208,0 28217,1 28308,0 28328,1 28346,0 28371,1 28436,0 28499,1 28518,0 28596,1 28652,0 28741,1 28774,0 28813,1 28865,0 28921,1 29003,0 29063,1 29151,0 29194,1 29213,0 29293,1 29297,0 29385,1 29434,0 29456,1 29506,0 29521,1 29566,0 29629,1 29655,0 29694,1 29774,0 29844,1 29927,0 30006,1 30095,0 30140,1 30146,0 30213,1 30268,0 30281,1 30293,0 30340,1 30407,0 30486,1 30561,0 30656,1 30703,0 30782,1 30832,0 30926,1 30951,0 30982,1 31075,0 31174,1 31268,0 31340,1 31393,0 31485,1 31523,0 31566,1 31638,0 31665,1 31671,0 31764,1 31784,0 31879,1 31973,0 32070,1 32112,0 32159,1 32205,0 32239,1 32287,0 32369,1 32445,0 32506,1 32511,0 32609,1 32692,0 32716,1 32807,0 32813,1 32890,0 32894,1 32905,0 32993,1 33026,0 33106,1 33116,0 33148,1 33212,0 33233,1 33295,0 33373,1 33458,0 33517,1 33569,0 33658,1 33743,0 33798,1 33824,0 33913,1 33986,0 33990,1 34090,0 34160,1 34210,0 34280,1 34318,0 34379,1 34420,0 34447,1 34493,0 34512,1 34562,0 34590,1 34612,0 34613,1 34628,0 34660,1 34671,0 34727,1 34806,0 34811,1 34910,0 34920,1 34983,0 35037,1 35113,0 35197,1 35203,0 35225,1 35312,0 35334,1 35385,0 35434,1 35481,0 35558,1 35649,0 35718,1 35765,0 35785,1 35804,0 35841,1 35873,0 35942,1 35954,0 36036,1 36107,0 36172,1 36255,0 36282,1 36368,0 36435,1 36469,0 36536,1 36601,0 36617,1 36656,0 36737,1 36748,0 36774,1 36865,0 36930,1 36967,0 36998,1 37098,0 37154,1 37166,0 37178,1 37277,0 37313,1 37351,0 37390,1 37486,0 37543,1 37578,0 37635,1 37710,0 37765,1 37855,0 37919,1 37921,0 37936,1 37966,0 37985,1 38048,0 38085,1 38166,0 38236,1 38250,0 38343,1 38353,0 38408,1 38491,0 38545,1 38633,0 38686,1 38735,0 38770,1 38795,0 38868,1 38955,0 39014,1 39037,0 39044,1 39058,0 39070,1 39139,0 39213,1 39298,0 39304,1 39342,0 39344,1 39394,0 39439,1 39456,0 39462,1 39497,0 39549,1 39564,0 39654,1 39657,0 39719,1 39806,0 39850,1 39863,0 39882,1 39909,0 39985,1 39994,0 39998,1 40007,0 40052,1 40131,0 40151,1 40225,0 40254,1 40295,0 40301,1 40377,0 40403,1 40422,0 40519,1 40547,0 40554,1 40645,0 40696,1 40758,0 40784,1 40801,0 40848,1 40930,0 40935,1 41004,0 41077,1 41166,0 41251,1 41264,0 41272,1 41276,0 41282,1 41358,0 41397,1 41417,0 41502,1 41541,0 41581,1 41669,0 41696,1 41769,0 41863,1 41954,0 41985,1 41996,0 42028,1 42110,0 42133,1 42147,0 42172,1 42240,0 42297,1 42381,0 42387,1 42483,0 42554,1 42563,0 42618,1 42694,0 42741,1 42824,0 42900,1 42975,0 43023,1 43029,0 43065,1 43080,0 43137,1 43226,0 43233,1 43267,0 43302,1 43328,0 43378,1 43423,0 43435,1 43518,0 43573,1 43651,0 43695,1 43758,0 43794,1 43809,0 43821,1 43860,0 43904,1 43927,0 44017,1 44076,0 44106,1 44163,0 44238,1 44328,0 44385,1 44445,0 44499,1 44520,0 44572,1 44650,0 44719,1 44761,0 44833,1 44852,0 44857,1 44924,0 44979,1 45021,0 45078,1 45094,0 45156,1 45186,0 45220,1 45242,0 45290,1 45329,0 45339,1 45436,0 45496,1 45566,0 45645,1 45706,0 45719,1 45740,0 45808,1 45836,0 45911,1 45966,0 46048,1 46131,0 46183,1 46251,0 46291,1 46328,0 46352,1 46376,0 46379,1 46407,0 46471,1 46538,0 46618,1 46633,0 46713,1 46762,0 46851,1 46853,0 46922,1 46981,0 47001,1 47063,0 47077,1 47159,0 47204,1 47249,0 47261,1 47291,0 47380,1 47476,0 47524,1 47585,0 47603,1 47701,0 47735,1 47761,0 47842,1 47930,0 47959,1 48027,0 48050,1 48110,0 48125,1 48196,0 48243,1 48265,0 48309,1 48353,0 48440,1 48508,0 48510,1 48594,0 48619,1 48695,0 48777,1 48857,0 48865,1 48929,0 49023,1 49034,0 49100,1 49155,0 49168,1 49234,0 49254,1 49351,0 49413,1 49417,0 49423,1 49451,0 49511,1 49544,0 49627,1 49707,0 49807,1 49888,0 49894,1 49906,0 49952,1 49957,0 50038,1 50119,0 50151,1 50219,0 50272,1 50330,0 50357,1 50457,0 50486,1 50543,0 50585,1 50591,0 50606,1 50699,0 50752,1 50791,0 50809,1 50843,0 50915,1 50974,0 51026,1 51099,0 51179,1 end initlist b7 0,0 28,1 72,0 117,1 202,0 300,1 374,0 425,1 521,0 540,1 614,0 695,1 707,0 767,1 805,0 822,1 873,0 950,1 1037,0 1102,1 1185,0 1202,1 1259,0 1326,1 1379,0 1466,1 1501,0 1573,1 1670,0 1730,1 1764,0 1844,1 1863,0 1871,1 1884,0 1911,1 2006,0 2022,1 2057,0 2089,1 2122,0 2199,1 2239,0 2309,1 2393,0 2474,1 2517,0 2574,1 2642,0 2667,1 2726,0 2783,1 2788,0 2801,1 2859,0 2917,1 2956,0 2972,1 3037,0 3119,1 3172,0 3238,1 3336,0 3359,1 3365,0 3395,1 3459,0 3474,1 3511,0 3530,1 3630,0 3692,1 3754,0 3760,1 3796,0 3847,1 3848,0 3856,1 3860,0 3908,1 3956,0 4026,1 4082,0 4115,1 4158,0 4195,1 4258,0 4358,1 4420,0 4477,1 4551,0 4577,1 4628,0 4639,1 4669,0 4735,1 4829,0 4898,1 4937,0 4946,1 4949,0 4959,1 5023,0 5067,1 5110,0 5207,1 5251,0 5317,1 5401,0 5490,1 5543,0 5640,1 5730,0 5803,1 5855,0 5877,1 5938,0 6005,1 6056,0 6083,1 6143,0 6240,1 6302,0 6364,1 6435,0 6503,1 6547,0 6598,1 6633,0 6697,1 6780,0 6835,1 6932,0 6951,1 6981,0 6982,1 7073,0 7133,1 7143,0 7220,1 7296,0 7345,1 7395,0 7478,1 7546,0 7552,1 7627,0 7684,1 7776,0 7857,1 7944,0 8030,1 8094,0 8172,1 8206,0 8230,1 8281,0 8300,1 8327,0 8409,1 8470,0 8506,1 8550,0 8613,1 8665,0 8701,1 8746,0 8841,1 8883,0 8946,1 8973,0 9030,1 9068,0 9115,1 9213,0 9307,1 9403,0 9423,1 9516,0 9574,1 9660,0 9730,1 9824,0 9898,1 9980,0 10071,1 10116,0 10144,1 10199,0 10292,1 10370,0 10402,1 10404,0 10426,1 10435,0 10499,1 10564,0 10590,1 10667,0 10756,1 10786,0 10800,1 10890,0 10920,1 10956,0 10965,1 11032,0 11049,1 11122,0 11189,1 11244,0 11316,1 11319,0 11388,1 11405,0 11446,1 11473,0 11520,1 11573,0 11627,1 11670,0 11691,1 11784,0 11821,1 11831,0 11922,1 11935,0 11991,1 12016,0 12084,1 12108,0 12113,1 12134,0 12153,1 12167,0 12170,1 12242,0 12257,1 12352,0 12396,1 12441,0 12454,1 12486,0 12524,1 12553,0 12574,1 12592,0 12605,1 12631,0 12678,1 12717,0 12771,1 12794,0 12856,1 12894,0 12907,1 12941,0 13012,1 13091,0 13182,1 13241,0 13321,1 13379,0 13405,1 13467,0 13547,1 13566,0 13625,1 13633,0 13703,1 13717,0 13743,1 13792,0 13793,1 13806,0 13810,1 13838,0 13901,1 13952,0 14034,1 14104,0 14116,1 14154,0 14185,1 14196,0 14229,1 14310,0 14378,1 14465,0 14524,1 14548,0 14588,1 14656,0 14718,1 14813,0 14902,1 14992,0 15064,1 15135,0 15180,1 15210,0 15227,1 15261,0 15302,1 15379,0 15391,1 15490,0 15552,1 15560,0 15617,1 15692,0 15712,1 15754,0 15782,1 15824,0 15876,1 15937,0 15953,1 15961,0 15996,1 16063,0 16109,1 16119,0 16128,1 16213,0 16242,1 16255,0 16281,1 16332,0 16398,1 16401,0 16408,1 16415,0 16460,1 16521,0 16532,1 16540,0 16612,1 16664,0 16711,1 16759,0 16779,1 16827,0 16886,1 16981,0 17027,1 17034,0 17059,1 17076,0 17153,1 17244,0 17331,1 17405,0 17423,1 17477,0 17509,1 17529,0 17593,1 17676,0 17773,1 17859,0 17883,1 17964,0 18000,1 18093,0 18124,1 18201,0 18231,1 18307,0 18361,1 18408,0 18453,1 18469,0 18489,1 18540,0 18628,1 18629,0 18726,1 18760,0 18771,1 18795,0 18848,1 18899,0 18991,1 19068,0 19143,1 19219,0 19225,1 19255,0 19309,1 19363,0 19432,1 19452,0 19485,1 19538,0 19593,1 19613,0 19692,1 19736,0 19787,1 19886,0 19921,1 19991,0 20056,1 20109,0 20174,1 20177,0 20202,1 20250,0 20309,1 20370,0 20380,1 20447,0 20494,1 20557,0 20597,1 20679,0 20707,1 20727,0 20746,1 20818,0 20869,1 20921,0 21008,1 21028,0 21061,1 21109,0 21116,1 21148,0 21247,1 21328,0 21402,1 21446,0 21485,1 21509,0 21536,1 21597,0 21646,1 21648,0 21649,1 21667,0 21707,1 21720,0 21783,1 21851,0 21853,1 21916,0 21924,1 21968,0 21984,1 21987,0 21990,1 22073,0 22087,1 22117,0 22207,1 22264,0 22327,1 22378,0 22478,1 22495,0 22568,1 22622,0 22716,1 22770,0 22810,1 22897,0 22907,1 22945,0 22947,1 22999,0 23019,1 23020,0 23042,1 23124,0 23169,1 23174,0 23255,1 23348,0 23352,1 23433,0 23526,1 23566,0 23657,1 23702,0 23783,1 23819,0 23840,1 23876,0 23880,1 23908,0 23952,1 24027,0 24094,1 24140,0 24196,1 24204,0 24253,1 24318,0 24330,1 24361,0 24454,1 24477,0 24510,1 24608,0 24613,1 24665,0 24735,1 24736,0 24750,1 24802,0 24845,1 24882,0 24920,1 25018,0 25114,1 25189,0 25206,1 25231,0 25312,1 25347,0 25403,1 25439,0 25483,1 25568,0 25601,1 25645,0 25709,1 25762,0 25821,1 25826,0 25902,1 25932,0 25968,1 26063,0 26148,1 26207,0 26231,1 26287,0 26364,1 26389,0 26460,1 26539,0 26542,1 26586,0 26628,1 26650,0 26744,1 26745,0 26833,1 26931,0 27011,1 27014,0 27107,1 27182,0 27278,1 27285,0 27333,1 27423,0 27523,1 27575,0 27657,1 27664,0 27692,1 27772,0 27825,1 27858,0 27937,1 27943,0 28011,1 28094,0 28136,1 28200,0 28282,1 28327,0 28345,1 28374,0 28382,1 28479,0 28507,1 28563,0 28583,1 28661,0 28686,1 28758,0 28818,1 28843,0 28865,1 28952,0 29001,1 29070,0 29166,1 29186,0 29221,1 29307,0 29381,1 29419,0 29450,1 29498,0 29503,1 29598,0 29653,1 29667,0 29731,1 29744,0 29839,1 29921,0 29967,1 29991,0 30026,1 30100,0 30113,1 30185,0 30267,1 30280,0 30292,1 30322,0 30372,1 30399,0 30415,1 30508,0 30514,1 30560,0 30579,1 30649,0 30670,1 30708,0 30724,1 30766,0 30813,1 30903,0 31002,1 31064,0 31092,1 31100,0 31176,1 31207,0 31290,1 31303,0 31376,1 31403,0 31417,1 31456,0 31531,1 31613,0 31661,1 31686,0 31738,1 31741,0 31756,1 31806,0 31847,1 31897,0 31987,1 32031,0 32032,1 32073,0 32133,1 32192,0 32219,1 32250,0 32333,1 32354,0 32417,1 32425,0 32429,1 32441,0 32472,1 32487,0 32561,1 32584,0 32681,1 32733,0 32734,1 32775,0 32850,1 32869,0 32958,1 33031,0 33032,1 33035,0 33107,1 33108,0 33121,1 33143,0 33216,1 33297,0 33386,1 33432,0 33450,1 33513,0 33553,1 33622,0 33625,1 33654,0 33656,1 33721,0 33747,1 33778,0 33797,1 33839,0 33888,1 33916,0 33960,1 33999,0 34011,1 34077,0 34149,1 34185,0 34228,1 34301,0 34324,1 34407,0 34434,1 34456,0 34512,1 34584,0 34616,1 34646,0 34689,1 34789,0 34867,1 34919,0 35018,1 35050,0 35078,1 35095,0 35132,1 35138,0 35232,1 35250,0 35298,1 35325,0 35376,1 35471,0 35537,1 35595,0 35686,1 35756,0 35836,1 35846,0 35856,1 35880,0 35940,1 35993,0 36091,1 36118,0 36156,1 36240,0 36323,1 36375,0 36419,1 36480,0 36494,1 36588,0 36612,1 36703,0 36774,1 36802,0 36840,1 36874,0 36956,1 36974,0 37036,1 37090,0 37152,1 37195,0 37263,1 37323,0 37418,1 37469,0 37521,1 37595,0 37629,1 37724,0 37760,1 37773,0 37839,1 37865,0 37933,1 37991,0 38001,1 38047,0 38103,1 38158,0 38168,1 38212,0 38251,1 38305,0 38373,1 38430,0 38442,1 38455,0 38490,1 38531,0 38559,1 38572,0 38669,1 38678,0 38701,1 38728,0 38791,1 38884,0 38944,1 38975,0 38978,1 38996,0 39052,1 39094,0 39107,1 39203,0 39295,1 39358,0 39395,1 39469,0 39470,1 39491,0 39565,1 39640,0 39653,1 39663,0 39731,1 39823,0 39854,1 39937,0 40002,1 40084,0 40135,1 40154,0 40221,1 40315,0 40326,1 40404,0 40493,1 40534,0 40546,1 40641,0 40677,1 40721,0 40778,1 40875,0 40967,1 40999,0 41037,1 41114,0 41202,1 41204,0 41282,1 41309,0 41314,1 41366,0 41427,1 41466,0 41491,1 41528,0 41540,1 41547,0 41553,1 41628,0 41689,1 41729,0 41776,1 41838,0 41882,1 41947,0 42037,1 42082,0 42136,1 42151,0 42245,1 42345,0 42390,1 42470,0 42558,1 42602,0 42662,1 42726,0 42815,1 42832,0 42839,1 42853,0 42904,1 42925,0 42988,1 42996,0 43036,1 43109,0 43135,1 43150,0 43236,1 43327,0 43357,1 43448,0 43471,1 43503,0 43525,1 43545,0 43618,1 43657,0 43669,1 43699,0 43770,1 43777,0 43857,1 43868,0 43870,1 43909,0 43948,1 44001,0 44064,1 44125,0 44135,1 44151,0 44170,1 44203,0 44244,1 44285,0 44302,1 44401,0 44473,1 44546,0 44600,1 44669,0 44730,1 44783,0 44832,1 44853,0 44925,1 44928,0 45021,1 45115,0 45134,1 45234,0 45246,1 45258,0 45310,1 45374,0 45412,1 45459,0 45532,1 45587,0 45648,1 45683,0 45696,1 45787,0 45866,1 45953,0 46004,1 46088,0 46143,1 46148,0 46217,1 46260,0 46276,1 46277,0 46280,1 46331,0 46400,1 46475,0 46488,1 46490,0 46513,1 46610,0 46696,1 46765,0 46779,1 46846,0 46853,1 46867,0 46870,1 46904,0 46931,1 47002,0 47092,1 47119,0 47219,1 47266,0 47283,1 47297,0 47336,1 47362,0 47426,1 47460,0 47481,1 47567,0 47598,1 47626,0 47670,1 47728,0 47782,1 47832,0 47845,1 47865,0 47964,1 47974,0 48030,1 48039,0 48088,1 48116,0 48175,1 48218,0 48229,1 end initlist b8 0,0 54,1 138,0 182,1 260,0 268,1 338,0 406,1 490,0 555,1 564,0 589,1 606,0 673,1 773,0 809,1 833,0 850,1 876,0 937,1 951,0 1040,1 1103,0 1128,1 1214,0 1262,1 1355,0 1452,1 1521,0 1524,1 1579,0 1645,1 1656,0 1747,1 1782,0 1790,1 1820,0 1871,1 1927,0 1962,1 2057,0 2109,1 2160,0 2253,1 2269,0 2276,1 2372,0 2398,1 2442,0 2472,1 2507,0 2552,1 2566,0 2611,1 2661,0 2750,1 2770,0 2817,1 2885,0 2945,1 2987,0 3000,1 3026,0 3032,1 3131,0 3172,1 3256,0 3329,1 3358,0 3376,1 3426,0 3483,1 3504,0 3599,1 3689,0 3772,1 3781,0 3856,1 3944,0 4033,1 4082,0 4159,1 4180,0 4226,1 4289,0 4383,1 4429,0 4511,1 4582,0 4629,1 4705,0 4774,1 4834,0 4843,1 4932,0 5021,1 5095,0 5176,1 5270,0 5273,1 5298,0 5368,1 5449,0 5529,1 5565,0 5577,1 5661,0 5690,1 5695,0 5707,1 5790,0 5794,1 5831,0 5904,1 5994,0 6016,1 6034,0 6037,1 6124,0 6181,1 6251,0 6310,1 6351,0 6445,1 6529,0 6628,1 6665,0 6763,1 6832,0 6915,1 6948,0 6990,1 7052,0 7100,1 7101,0 7125,1 7171,0 7188,1 7241,0 7337,1 7393,0 7486,1 7563,0 7583,1 7674,0 7734,1 7752,0 7844,1 7899,0 7986,1 8071,0 8165,1 8238,0 8293,1 8356,0 8360,1 8418,0 8454,1 8533,0 8569,1 8592,0 8603,1 8683,0 8714,1 8717,0 8785,1 8816,0 8899,1 8985,0 9057,1 9110,0 9192,1 9215,0 9258,1 9336,0 9360,1 9452,0 9501,1 9551,0 9640,1 9689,0 9703,1 9716,0 9753,1 9840,0 9876,1 9924,0 9959,1 10018,0 10020,1 10090,0 10147,1 10180,0 10242,1 10261,0 10319,1 10408,0 10409,1 10419,0 10485,1 10580,0 10614,1 10690,0 10715,1 10732,0 10804,1 10864,0 10954,1 10980,0 11001,1 11016,0 11098,1 11133,0 11138,1 11169,0 11244,1 11263,0 11294,1 11375,0 11475,1 11498,0 11565,1 11648,0 11747,1 11790,0 11884,1 11973,0 11993,1 12089,0 12147,1 12149,0 12239,1 12293,0 12351,1 12357,0 12421,1 12447,0 12448,1 12522,0 12588,1 12654,0 12696,1 12718,0 12738,1 12802,0 12881,1 12973,0 13008,1 13108,0 13172,1 13253,0 13321,1 13421,0 13465,1 13552,0 13637,1 13660,0 13754,1 13793,0 13797,1 13822,0 13878,1 13887,0 13905,1 13913,0 13918,1 14008,0 14020,1 14024,0 14040,1 14126,0 14174,1 14226,0 14275,1 14350,0 14390,1 14436,0 14534,1 14605,0 14617,1 14649,0 14709,1 14809,0 14892,1 14975,0 14983,1 15034,0 15067,1 15139,0 15175,1 15200,0 15283,1 15377,0 15475,1 15515,0 15572,1 15614,0 15710,1 15783,0 15856,1 15919,0 15933,1 16012,0 16104,1 16143,0 16186,1 16262,0 16351,1 16448,0 16498,1 16584,0 16586,1 16591,0 16607,1 16612,0 16663,1 16737,0 16756,1 16816,0 16845,1 16858,0 16938,1 16950,0 16988,1 17043,0 17074,1 17166,0 17249,1 17308,0 17377,1 17421,0 17495,1 17511,0 17580,1 17660,0 17665,1 17717,0 17768,1 17803,0 17824,1 17875,0 17911,1 17959,0 18044,1 18079,0 18084,1 18085,0 18158,1 18181,0 18191,1 18252,0 18261,1 18284,0 18337,1 18365,0 18445,1 18466,0 18485,1 18562,0 18607,1 18699,0 18793,1 18837,0 18883,1 18909,0 19004,1 19054,0 19137,1 19234,0 19236,1 19311,0 19315,1 19411,0 19507,1 19596,0 19599,1 19677,0 19737,1 19777,0 19818,1 19913,0 19987,1 20000,0 20002,1 20049,0 20133,1 20144,0 20159,1 20176,0 20266,1 20334,0 20419,1 20447,0 20529,1 20619,0 20631,1 20640,0 20669,1 20766,0 20792,1 20882,0 20946,1 20994,0 20998,1 21070,0 21107,1 21133,0 21228,1 21293,0 21370,1 21439,0 21519,1 21534,0 21549,1 21623,0 21713,1 21752,0 21762,1 21780,0 21879,1 21912,0 22008,1 22098,0 22137,1 22204,0 22255,1 22317,0 22350,1 22384,0 22395,1 22453,0 22548,1 22584,0 22585,1 22615,0 22690,1 22768,0 22868,1 22968,0 22986,1 22992,0 23092,1 23157,0 23212,1 23262,0 23272,1 23361,0 23380,1 23383,0 23421,1 23442,0 23478,1 23493,0 23553,1 23581,0 23634,1 23720,0 23811,1 23907,0 23959,1 24046,0 24131,1 24229,0 24282,1 24309,0 24395,1 24443,0 24470,1 24532,0 24557,1 24616,0 24647,1 24669,0 24706,1 24717,0 24739,1 24796,0 24817,1 24833,0 24867,1 24924,0 25011,1 25076,0 25145,1 25189,0 25214,1 25299,0 25386,1 25434,0 25517,1 25568,0 25668,1 25698,0 25789,1 25868,0 25911,1 26003,0 26046,1 26119,0 26125,1 26132,0 26200,1 26208,0 26274,1 26317,0 26355,1 26407,0 26456,1 26524,0 26547,1 26595,0 26659,1 26741,0 26810,1 26832,0 26849,1 26909,0 26993,1 27041,0 27065,1 27073,0 27094,1 27175,0 27179,1 27196,0 27282,1 27331,0 27381,1 27444,0 27479,1 27521,0 27561,1 27660,0 27664,1 27666,0 27721,1 27758,0 27779,1 27879,0 27951,1 28001,0 28085,1 28170,0 28193,1 28207,0 28275,1 28364,0 28459,1 28534,0 28569,1 28580,0 28650,1 28716,0 28798,1 28866,0 28917,1 28930,0 28979,1 28980,0 28986,1 29082,0 29164,1 29223,0 29233,1 29235,0 29315,1 29329,0 29382,1 29479,0 29536,1 29552,0 29580,1 29678,0 29736,1 29823,0 29900,1 29912,0 29961,1 30061,0 30150,1 30178,0 30269,1 30276,0 30346,1 30363,0 30364,1 30441,0 30496,1 30564,0 30587,1 30635,0 30709,1 30713,0 30748,1 30767,0 30847,1 30851,0 30917,1 30954,0 30966,1 31035,0 31126,1 31167,0 31190,1 31286,0 31319,1 31405,0 31416,1 31483,0 31544,1 31620,0 31636,1 31667,0 31696,1 31788,0 31883,1 31933,0 32030,1 32099,0 32181,1 32272,0 32307,1 32376,0 32445,1 32497,0 32563,1 32564,0 32616,1 32688,0 32737,1 32807,0 32856,1 32890,0 32928,1 32930,0 33004,1 33026,0 33116,1 33197,0 33268,1 33358,0 33436,1 33517,0 33540,1 33593,0 33687,1 33727,0 33788,1 33832,0 33833,1 33854,0 33931,1 34010,0 34059,1 34135,0 34206,1 34262,0 34286,1 34384,0 34464,1 34549,0 34569,1 34598,0 34667,1 34693,0 34698,1 34765,0 34850,1 34865,0 34882,1 34966,0 34969,1 35012,0 35043,1 35070,0 35160,1 35259,0 35296,1 35386,0 35398,1 35404,0 35441,1 35459,0 35511,1 35566,0 35577,1 35622,0 35692,1 35737,0 35742,1 35755,0 35767,1 35834,0 35850,1 35896,0 35978,1 35992,0 36086,1 36169,0 36172,1 36258,0 36292,1 36348,0 36417,1 36459,0 36540,1 36624,0 36692,1 36724,0 36739,1 36744,0 36781,1 36798,0 36802,1 36859,0 36929,1 36978,0 36991,1 37064,0 37160,1 37198,0 37285,1 37371,0 37462,1 37467,0 37512,1 37611,0 37683,1 37691,0 37714,1 37767,0 37771,1 37867,0 37941,1 38031,0 38090,1 38101,0 38174,1 38205,0 38212,1 38289,0 38299,1 38385,0 38439,1 38454,0 38462,1 38468,0 38558,1 38649,0 38704,1 38800,0 38892,1 38960,0 39036,1 39129,0 39208,1 39270,0 39339,1 39360,0 39425,1 39470,0 39505,1 39604,0 39656,1 39721,0 39797,1 39880,0 39953,1 39960,0 40001,1 40014,0 40049,1 40121,0 40152,1 40239,0 40259,1 40339,0 40439,1 40522,0 40542,1 40595,0 40621,1 40658,0 40720,1 40751,0 40770,1 40842,0 40886,1 40963,0 41035,1 41073,0 41113,1 41193,0 41218,1 41282,0 41287,1 41354,0 41382,1 41445,0 41461,1 41545,0 41641,1 41696,0 41716,1 41733,0 41755,1 41851,0 41862,1 41926,0 41988,1 42086,0 42100,1 42198,0 42281,1 42290,0 42357,1 42436,0 42472,1 42497,0 42564,1 42627,0 42709,1 42808,0 42855,1 42925,0 42977,1 42983,0 43062,1 43104,0 43134,1 43229,0 43276,1 43324,0 43374,1 43434,0 43519,1 43564,0 43615,1 43629,0 43666,1 43691,0 43692,1 43697,0 43787,1 43868,0 43918,1 43971,0 43974,1 44013,0 44018,1 44059,0 44078,1 44162,0 44246,1 44273,0 44341,1 44406,0 44474,1 44494,0 44557,1 44651,0 44657,1 44704,0 44750,1 44787,0 44828,1 44902,0 44908,1 44915,0 44927,1 45027,0 45044,1 45139,0 45222,1 45237,0 45322,1 45372,0 45379,1 45409,0 45421,1 45499,0 45572,1 45575,0 45627,1 45666,0 45748,1 45803,0 45884,1 45959,0 45992,1 46052,0 46150,1 46168,0 46193,1 46229,0 46267,1 46358,0 46442,1 46483,0 46541,1 46619,0 46627,1 46638,0 46722,1 46784,0 46871,1 46899,0 46931,1 46937,0 46948,1 46991,0 47072,1 47158,0 47186,1 47198,0 47256,1 47275,0 47326,1 47422,0 47490,1 47555,0 47609,1 47697,0 47794,1 47894,0 47979,1 48007,0 48037,1 48097,0 48119,1 48129,0 48181,1 48250,0 48293,1 48301,0 48370,1 48452,0 48542,1 48567,0 48648,1 48714,0 48715,1 48738,0 48821,1 48835,0 48914,1 49003,0 49048,1 49124,0 49166,1 49259,0 49287,1 49303,0 49400,1 49421,0 49457,1 49507,0 49511,1 49539,0 49549,1 49634,0 49644,1 49695,0 49711,1 49778,0 49868,1 49935,0 50032,1 50037,0 50111,1 50179,0 50207,1 50282,0 50319,1 50357,0 50454,1 50483,0 50493,1 50499,0 50585,1 50642,0 50721,1 50722,0 50753,1 50763,0 50796,1 50800,0 50886,1 50901,0 50965,1 50978,0 51036,1 51066,0 51158,1 51164,0 51228,1 51309,0 51393,1 51435,0 51506,1 51540,0 51609,1 end initlist b9 0,0 74,1 174,0 196,1 210,0 274,1 339,0 355,1 398,0 484,1 561,0 622,1 721,0 768,1 847,0 933,1 989,0 1073,1 1087,0 1097,1 1164,0 1228,1 1241,0 1326,1 1339,0 1394,1 1411,0 1425,1 1504,0 1543,1 1607,0 1697,1 1706,0 1793,1 1839,0 1859,1 1883,0 1968,1 2009,0 2012,1 2076,0 2109,1 2178,0 2228,1 2322,0 2350,1 2360,0 2382,1 2410,0 2421,1 2441,0 2486,1 2539,0 2576,1 2637,0 2648,1 2677,0 2699,1 2701,0 2735,1 2763,0 2809,1 2810,0 2831,1 2861,0 2891,1 2972,0 3045,1 3132,0 3184,1 3256,0 3298,1 3370,0 3410,1 3427,0 3516,1 3609,0 3698,1 3702,0 3790,1 3796,0 3831,1 3884,0 3949,1 3968,0 4000,1 4071,0 4137,1 4183,0 4272,1 4284,0 4371,1 4404,0 4473,1 4525,0 4533,1 4617,0 4672,1 4707,0 4714,1 4738,0 4808,1 4873,0 4963,1 5044,0 5055,1 5147,0 5189,1 5231,0 5256,1 5292,0 5309,1 5395,0 5427,1 5487,0 5561,1 5661,0 5662,1 5721,0 5794,1 5851,0 5907,1 5946,0 6043,1 6063,0 6087,1 6092,0 6114,1 6201,0 6263,1 6323,0 6328,1 6337,0 6383,1 6472,0 6538,1 6582,0 6655,1 6671,0 6761,1 6795,0 6871,1 6898,0 6950,1 6985,0 7016,1 7024,0 7114,1 7173,0 7229,1 7324,0 7384,1 7395,0 7495,1 7563,0 7574,1 7652,0 7688,1 7751,0 7824,1 7909,0 7945,1 7981,0 8073,1 8130,0 8196,1 8268,0 8273,1 8312,0 8314,1 8375,0 8389,1 8413,0 8462,1 8512,0 8531,1 8577,0 8638,1 8680,0 8758,1 8789,0 8809,1 8849,0 8897,1 8978,0 9068,1 9116,0 9145,1 9168,0 9265,1 9276,0 9286,1 9348,0 9383,1 9423,0 9445,1 9537,0 9567,1 9589,0 9668,1 9739,0 9768,1 9837,0 9926,1 10025,0 10042,1 10065,0 10127,1 10190,0 10196,1 10218,0 10222,1 10305,0 10373,1 10398,0 10411,1 10472,0 10570,1 10586,0 10666,1 10699,0 10724,1 10737,0 10750,1 10806,0 10810,1 10826,0 10847,1 10898,0 10913,1 10958,0 10979,1 11016,0 11092,1 11125,0 11180,1 11223,0 11278,1 11344,0 11355,1 11402,0 11482,1 11570,0 11649,1 11671,0 11685,1 11746,0 11841,1 11899,0 11961,1 11971,0 12063,1 12064,0 12153,1 12228,0 12272,1 12292,0 12330,1 12427,0 12465,1 12536,0 12537,1 12626,0 12645,1 12648,0 12704,1 12711,0 12799,1 12842,0 12901,1 12944,0 12959,1 12962,0 12964,1 12973,0 12998,1 13018,0 13117,1 13210,0 13285,1 13311,0 13359,1 13381,0 13474,1 13534,0 13563,1 13602,0 13682,1 13777,0 13852,1 13890,0 13930,1 13937,0 13959,1 14046,0 14052,1 14105,0 14112,1 14181,0 14235,1 14326,0 14417,1 14478,0 14480,1 14528,0 14530,1 14586,0 14602,1 14696,0 14706,1 14783,0 14788,1 14870,0 14932,1 14981,0 14993,1 15024,0 15065,1 15112,0 15116,1 15138,0 15169,1 15170,0 15185,1 15219,0 15301,1 15323,0 15348,1 15393,0 15397,1 15412,0 15480,1 15521,0 15530,1 15594,0 15601,1 15648,0 15670,1 15732,0 15790,1 15880,0 15885,1 15897,0 15906,1 15974,0 16043,1 16125,0 16143,1 16178,0 16245,1 16274,0 16365,1 16436,0 16506,1 16549,0 16583,1 16668,0 16757,1 16850,0 16941,1 16973,0 17056,1 17069,0 17089,1 17137,0 17168,1 17247,0 17272,1 17352,0 17395,1 17402,0 17439,1 17472,0 17546,1 17635,0 17658,1 17659,0 17711,1 17803,0 17850,1 17886,0 17925,1 17992,0 18029,1 18036,0 18056,1 18122,0 18130,1 18198,0 18260,1 18264,0 18284,1 18288,0 18345,1 18419,0 18443,1 18504,0 18577,1 18636,0 18672,1 18754,0 18768,1 18851,0 18854,1 18935,0 18938,1 19031,0 19058,1 19117,0 19195,1 19246,0 19323,1 19368,0 19403,1 19480,0 19573,1 19643,0 19649,1 19714,0 19715,1 19735,0 19792,1 19840,0 19904,1 19992,0 20038,1 20134,0 20158,1 20171,0 20200,1 20274,0 20327,1 20344,0 20352,1 20449,0 20476,1 20511,0 20583,1 20609,0 20704,1 20765,0 20779,1 20835,0 20924,1 20974,0 21057,1 21133,0 21170,1 21268,0 21323,1 21356,0 21406,1 21447,0 21504,1 21529,0 21541,1 21604,0 21688,1 21709,0 21732,1 21781,0 21804,1 21807,0 21846,1 21868,0 21943,1 21983,0 22073,1 22135,0 22186,1 22269,0 22321,1 22403,0 22443,1 22528,0 22593,1 22608,0 22688,1 22748,0 22799,1 22859,0 22860,1 22931,0 22966,1 23028,0 23117,1 23162,0 23250,1 23295,0 23354,1 23417,0 23488,1 23547,0 23645,1 23715,0 23765,1 23846,0 23865,1 23965,0 24016,1 24090,0 24136,1 24180,0 24223,1 24288,0 24306,1 24360,0 24449,1 24450,0 24515,1 24580,0 24623,1 24655,0 24714,1 24773,0 24824,1 24923,0 24924,1 24992,0 25018,1 25095,0 25110,1 25158,0 25236,1 25286,0 25373,1 25461,0 25509,1 25585,0 25666,1 25714,0 25752,1 25767,0 25798,1 25826,0 25830,1 25891,0 25947,1 25960,0 26038,1 26092,0 26186,1 26234,0 26296,1 26381,0 26395,1 26416,0 26459,1 26495,0 26561,1 26594,0 26633,1 26725,0 26819,1 26847,0 26935,1 26949,0 26962,1 27005,0 27043,1 27106,0 27152,1 27205,0 27233,1 27236,0 27264,1 27317,0 27377,1 27445,0 27468,1 27501,0 27511,1 27531,0 27612,1 27654,0 27724,1 27741,0 27811,1 27864,0 27892,1 27986,0 28040,1 28057,0 28115,1 28205,0 28249,1 28260,0 28324,1 28371,0 28441,1 28521,0 28595,1 28624,0 28668,1 28748,0 28789,1 28878,0 28958,1 29024,0 29034,1 29044,0 29115,1 29154,0 29240,1 29265,0 29303,1 29336,0 29432,1 29520,0 29530,1 29587,0 29677,1 29709,0 29726,1 29812,0 29889,1 29959,0 30010,1 30064,0 30115,1 30175,0 30216,1 30256,0 30348,1 30420,0 30505,1 30524,0 30552,1 30617,0 30685,1 30757,0 30799,1 30891,0 30986,1 31018,0 31114,1 31194,0 31265,1 31284,0 31341,1 31353,0 31375,1 31396,0 31454,1 31487,0 31537,1 31622,0 31679,1 31768,0 31824,1 31902,0 31944,1 31977,0 32067,1 32156,0 32168,1 32228,0 32318,1 32409,0 32483,1 32569,0 32595,1 32633,0 32673,1 32689,0 32696,1 32755,0 32767,1 32817,0 32907,1 32987,0 33045,1 33092,0 33133,1 33150,0 33209,1 33230,0 33297,1 33298,0 33337,1 33415,0 33506,1 33558,0 33579,1 33648,0 33742,1 33750,0 33813,1 33828,0 33876,1 33963,0 34055,1 34102,0 34193,1 34293,0 34318,1 34382,0 34435,1 34504,0 34583,1 34638,0 34709,1 34745,0 34794,1 34830,0 34872,1 34913,0 34968,1 35028,0 35078,1 35158,0 35182,1 35253,0 35337,1 35426,0 35442,1 35536,0 35584,1 35651,0 35730,1 35806,0 35876,1 35959,0 35991,1 36059,0 36120,1 36151,0 36222,1 36260,0 36285,1 36299,0 36348,1 36376,0 36396,1 36411,0 36488,1 36539,0 36600,1 36671,0 36717,1 36809,0 36822,1 36837,0 36889,1 36897,0 36904,1 36918,0 36937,1 36988,0 36996,1 37057,0 37078,1 37167,0 37245,1 37335,0 37416,1 37458,0 37539,1 37565,0 37635,1 37716,0 37757,1 37804,0 37902,1 37908,0 37914,1 37917,0 38006,1 38100,0 38170,1 38237,0 38311,1 38361,0 38398,1 38481,0 38529,1 38569,0 38648,1 38698,0 38719,1 38756,0 38773,1 38807,0 38874,1 38947,0 39029,1 39110,0 39195,1 39282,0 39319,1 39360,0 39428,1 39466,0 39469,1 39525,0 39621,1 39705,0 39790,1 39810,0 39833,1 39921,0 39986,1 40073,0 40148,1 40163,0 40189,1 40245,0 40324,1 40330,0 40341,1 40408,0 40425,1 40465,0 40516,1 40578,0 40604,1 40617,0 40713,1 40761,0 40809,1 40861,0 40948,1 40998,0 41049,1 41055,0 41080,1 41174,0 41228,1 41321,0 41417,1 41480,0 41536,1 41572,0 41589,1 41640,0 41681,1 41722,0 41749,1 41808,0 41868,1 41895,0 41912,1 41963,0 41984,1 42006,0 42068,1 42095,0 42123,1 42151,0 42187,1 42229,0 42295,1 42340,0 42424,1 42484,0 42584,1 42613,0 42661,1 42711,0 42735,1 42779,0 42830,1 42904,0 42947,1 43012,0 43056,1 43071,0 43106,1 43137,0 43214,1 43222,0 43307,1 43362,0 43414,1 43460,0 43515,1 43608,0 43651,1 43691,0 43717,1 43790,0 43856,1 43895,0 43928,1 43930,0 43984,1 44021,0 44110,1 44186,0 44198,1 44216,0 44298,1 44303,0 44395,1 44484,0 44492,1 44529,0 44561,1 44657,0 44661,1 44743,0 44752,1 44841,0 44848,1 44891,0 44918,1 44920,0 44964,1 45000,0 45079,1 45151,0 45234,1 45240,0 45266,1 45353,0 45432,1 45509,0 45563,1 45658,0 45729,1 45788,0 45818,1 45915,0 45973,1 46003,0 46047,1 46147,0 46175,1 46227,0 46307,1 46311,0 46363,1 46430,0 46517,1 46531,0 46562,1 46644,0 46694,1 46698,0 46786,1 46808,0 46829,1 46849,0 46921,1 47018,0 47112,1 47201,0 47287,1 47373,0 47457,1 47551,0 47641,1 47687,0 47688,1 47784,0 47835,1 47863,0 47900,1 47901,0 47965,1 47971,0 47975,1 48005,0 48017,1 48026,0 48031,1 48058,0 48123,1 48167,0 48207,1 48211,0 48251,1 48330,0 48390,1 48475,0 48528,1 48628,0 48671,1 48727,0 48760,1 48817,0 48908,1 48912,0 48998,1 49005,0 49045,1 49120,0 49213,1 49300,0 49320,1 49369,0 49467,1 49519,0 49571,1 49608,0 49682,1 49754,0 49757,1 49845,0 49932,1 50027,0 50094,1 end initlist b10 0,0 37,1 92,0 139,1 149,0 237,1 306,0 366,1 402,0 501,1 518,0 558,1 573,0 646,1 674,0 729,1 775,0 855,1 947,0 975,1 1024,0 1032,1 1034,0 1046,1 1132,0 1140,1 1157,0 1207,1 1268,0 1357,1 1419,0 1446,1 1515,0 1553,1 1611,0 1698,1 1788,0 1882,1 1900,0 1994,1 2094,0 2187,1 2191,0 2220,1 2248,0 2312,1 2347,0 2365,1 2439,0 2458,1 2490,0 2517,1 2582,0 2587,1 2608,0 2699,1 2773,0 2869,1 2960,0 3042,1 3142,0 3210,1 3288,0 3330,1 3424,0 3463,1 3533,0 3611,1 3640,0 3718,1 3761,0 3861,1 3911,0 3992,1 4053,0 4087,1 4113,0 4209,1 4245,0 4259,1 4319,0 4354,1 4400,0 4458,1 4495,0 4569,1 4657,0 4700,1 4745,0 4780,1 4785,0 4834,1 4897,0 4949,1 4985,0 5045,1 5058,0 5137,1 5195,0 5263,1 5319,0 5410,1 5509,0 5554,1 5645,0 5693,1 5707,0 5776,1 5779,0 5835,1 5838,0 5888,1 5930,0 5945,1 5992,0 5998,1 6012,0 6025,1 6075,0 6113,1 6172,0 6220,1 6291,0 6300,1 6306,0 6391,1 6443,0 6534,1 6600,0 6680,1 6724,0 6739,1 6761,0 6842,1 6879,0 6954,1 7016,0 7048,1 7130,0 7223,1 7299,0 7309,1 7343,0 7367,1 7400,0 7498,1 7535,0 7635,1 7663,0 7679,1 7706,0 7791,1 7828,0 7847,1 7893,0 7907,1 7974,0 8071,1 8087,0 8105,1 8184,0 8227,1 8264,0 8338,1 8434,0 8437,1 8504,0 8509,1 8578,0 8591,1 8638,0 8701,1 8706,0 8791,1 8798,0 8854,1 8952,0 8973,1 9040,0 9060,1 9064,0 9100,1 9185,0 9235,1 9239,0 9299,1 9330,0 9385,1 9435,0 9491,1 9559,0 9604,1 9608,0 9619,1 9644,0 9726,1 9735,0 9820,1 9853,0 9888,1 9942,0 9970,1 10062,0 10104,1 10158,0 10218,1 10295,0 10309,1 10386,0 10447,1 10525,0 10545,1 10579,0 10593,1 10632,0 10664,1 10666,0 10711,1 10785,0 10884,1 10957,0 11017,1 11041,0 11103,1 11143,0 11190,1 11278,0 11367,1 11427,0 11517,1 11592,0 11638,1 11691,0 11768,1 11847,0 11864,1 11909,0 11923,1 11979,0 12061,1 12067,0 12084,1 12176,0 12204,1 12247,0 12283,1 12350,0 12388,1 12390,0 12426,1 12451,0 12501,1 12546,0 12554,1 12572,0 12644,1 12720,0 12808,1 12880,0 12959,1 13029,0 13059,1 13155,0 13174,1 13264,0 13306,1 13403,0 13480,1 13544,0 13638,1 13665,0 13673,1 13772,0 13856,1 13946,0 14004,1 14037,0 14098,1 14160,0 14172,1 14266,0 14342,1 14434,0 14435,1 14439,0 14458,1 14462,0 14496,1 14506,0 14510,1 14592,0 14639,1 14643,0 14716,1 14733,0 14766,1 14827,0 14834,1 14875,0 14966,1 15016,0 15050,1 15091,0 15092,1 15109,0 15183,1 15212,0 15213,1 15222,0 15299,1 15386,0 15448,1 15527,0 15606,1 15664,0 15680,1 15761,0 15784,1 15849,0 15915,1 16007,0 16040,1 16084,0 16146,1 16187,0 16191,1 16234,0 16321,1 16375,0 16463,1 16533,0 16591,1 16627,0 16718,1 16771,0 16784,1 16881,0 16908,1 16963,0 16997,1 17080,0 17106,1 17183,0 17229,1 17256,0 17335,1 17430,0 17520,1 17546,0 17547,1 17629,0 17703,1 17750,0 17785,1 17858,0 17935,1 17941,0 18021,1 18030,0 18035,1 18094,0 18151,1 18248,0 18299,1 18380,0 18427,1 18466,0 18527,1 18607,0 18665,1 18719,0 18815,1 18886,0 18943,1 18973,0 19022,1 19077,0 19159,1 19191,0 19247,1 19304,0 19310,1 19325,0 19354,1 19369,0 19376,1 19396,0 19441,1 19492,0 19536,1 19578,0 19640,1 19657,0 19747,1 19797,0 19828,1 19877,0 19887,1 19940,0 19977,1 20059,0 20070,1 20162,0 20251,1 20305,0 20353,1 20414,0 20441,1 20492,0 20566,1 20596,0 20653,1 20735,0 20753,1 20794,0 20868,1 20946,0 20964,1 20991,0 21056,1 21063,0 21084,1 21183,0 21272,1 21321,0 21418,1 21482,0 21540,1 21619,0 21708,1 21765,0 21829,1 21906,0 21949,1 21950,0 22001,1 22041,0 22102,1 22137,0 22174,1 22206,0 22243,1 22249,0 22317,1 22346,0 22434,1 22438,0 22520,1 22521,0 22536,1 22584,0 22620,1 22692,0 22773,1 22802,0 22810,1 22844,0 22924,1 22983,0 23054,1 23152,0 23221,1 23224,0 23253,1 23274,0 23278,1 23332,0 23374,1 23464,0 23519,1 23582,0 23611,1 23659,0 23671,1 23738,0 23829,1 23888,0 23907,1 23933,0 23976,1 24031,0 24074,1 24160,0 24209,1 24288,0 24373,1 24473,0 24510,1 24578,0 24650,1 24685,0 24755,1 24790,0 24850,1 24936,0 25006,1 25087,0 25153,1 25229,0 25240,1 25280,0 25323,1 25409,0 25450,1 25457,0 25533,1 25622,0 25706,1 25791,0 25827,1 25848,0 25948,1 26014,0 26048,1 26052,0 26134,1 26232,0 26327,1 26383,0 26413,1 26474,0 26485,1 26539,0 26594,1 26663,0 26708,1 26742,0 26784,1 26796,0 26826,1 26882,0 26958,1 27051,0 27056,1 27063,0 27098,1 27159,0 27230,1 27238,0 27318,1 27391,0 27473,1 27550,0 27560,1 27593,0 27607,1 27647,0 27681,1 27696,0 27764,1 27808,0 27896,1 27921,0 28004,1 28050,0 28129,1 28212,0 28309,1 28400,0 28425,1 28462,0 28557,1 28648,0 28724,1 28729,0 28762,1 28789,0 28839,1 28844,0 28878,1 28936,0 28967,1 29015,0 29025,1 29069,0 29136,1 29213,0 29284,1 29380,0 29436,1 29486,0 29494,1 29554,0 29653,1 29749,0 29756,1 29853,0 29907,1 29958,0 29963,1 29987,0 30013,1 30090,0 30093,1 30117,0 30166,1 30202,0 30255,1 30271,0 30365,1 30405,0 30492,1 30506,0 30547,1 30632,0 30644,1 30725,0 30764,1 30831,0 30887,1 30927,0 30962,1 31008,0 31024,1 31095,0 31151,1 31201,0 31293,1 31353,0 31420,1 31443,0 31503,1 31525,0 31537,1 31613,0 31644,1 31672,0 31744,1 31747,0 31809,1 31907,0 31951,1 31996,0 32030,1 32123,0 32148,1 32150,0 32176,1 32189,0 32254,1 32317,0 32351,1 32426,0 32486,1 32489,0 32577,1 32636,0 32736,1 32785,0 32814,1 32865,0 32919,1 32981,0 33035,1 33062,0 33104,1 33189,0 33275,1 33345,0 33376,1 33470,0 33516,1 33582,0 33583,1 33600,0 33602,1 33656,0 33720,1 33757,0 33843,1 33895,0 33973,1 34017,0 34082,1 34107,0 34153,1 34235,0 34241,1 34273,0 34315,1 34396,0 34453,1 34524,0 34609,1 34670,0 34713,1 34762,0 34791,1 34833,0 34857,1 34886,0 34939,1 35022,0 35043,1 35049,0 35086,1 35108,0 35111,1 35162,0 35241,1 35280,0 35336,1 35355,0 35435,1 35491,0 35534,1 35618,0 35667,1 35712,0 35803,1 35873,0 35882,1 35916,0 35984,1 35987,0 35989,1 36004,0 36018,1 36037,0 36039,1 36139,0 36219,1 36312,0 36376,1 36384,0 36424,1 36486,0 36492,1 36499,0 36536,1 36627,0 36724,1 36744,0 36745,1 36782,0 36817,1 36852,0 36916,1 37000,0 37027,1 37107,0 37146,1 37170,0 37241,1 37304,0 37390,1 37435,0 37502,1 37584,0 37605,1 37628,0 37722,1 37781,0 37807,1 37813,0 37831,1 37880,0 37920,1 37924,0 37970,1 37995,0 38005,1 38052,0 38099,1 38139,0 38184,1 38207,0 38242,1 38302,0 38354,1 38379,0 38473,1 38524,0 38544,1 38603,0 38693,1 38781,0 38852,1 38865,0 38939,1 39030,0 39056,1 39129,0 39164,1 39211,0 39242,1 39243,0 39288,1 39356,0 39398,1 39436,0 39477,1 39506,0 39604,1 39680,0 39720,1 39774,0 39836,1 39882,0 39949,1 40021,0 40026,1 40056,0 40082,1 40116,0 40182,1 40230,0 40282,1 40367,0 40386,1 40463,0 40520,1 40563,0 40571,1 40632,0 40703,1 40708,0 40767,1 40845,0 40912,1 40967,0 41061,1 41076,0 41158,1 41227,0 41253,1 41333,0 41416,1 41490,0 41550,1 41645,0 41699,1 41733,0 41742,1 41794,0 41849,1 41935,0 41948,1 41956,0 41977,1 41990,0 42066,1 42146,0 42218,1 42271,0 42348,1 42402,0 42481,1 42494,0 42557,1 42623,0 42663,1 42688,0 42764,1 42852,0 42931,1 42990,0 43085,1 43170,0 43244,1 43255,0 43348,1 43352,0 43359,1 43409,0 43484,1 43495,0 43511,1 43603,0 43642,1 43733,0 43804,1 43834,0 43873,1 43947,0 44018,1 44112,0 44163,1 44224,0 44246,1 44275,0 44292,1 44328,0 44394,1 44424,0 44457,1 44522,0 44596,1 44653,0 44668,1 44731,0 44764,1 44787,0 44849,1 44935,0 44977,1 44993,0 45024,1 45114,0 45200,1 45242,0 45295,1 45306,0 45351,1 45397,0 45484,1 45529,0 45574,1 45649,0 45699,1 45747,0 45839,1 45905,0 45948,1 46043,0 46063,1 46087,0 46167,1 46178,0 46191,1 46193,0 46291,1 46357,0 46370,1 46416,0 46478,1 46512,0 46521,1 46573,0 46617,1 46660,0 46727,1 46824,0 46905,1 46939,0 47035,1 47096,0 47191,1 47256,0 47329,1 47350,0 47392,1 47424,0 47512,1 47592,0 47675,1 47704,0 47757,1 47785,0 47820,1 47868,0 47876,1 47947,0 47994,1 48094,0 48142,1 48175,0 48272,1 48290,0 48383,1 48435,0 48441,1 48521,0 48589,1 48671,0 48674,1 48770,0 48813,1 48862,0 48931,1 48943,0 48972,1 49069,0 49076,1 49083,0 49179,1 49180,0 49239,1 49271,0 49287,1 49353,0 49373,1 49469,0 49532,1 49625,0 49635,1 49655,0 49735,1 49801,0 49850,1 49910,0 49929,1 49938,0 49968,1 50028,0 50060,1 50116,0 50203,1 50290,0 50310,1 50330,0 50399,1 end initlist b11 0,0 37,1 129,0 147,1 205,0 266,1 356,0 425,1 506,0 584,1 638,0 733,1 824,0 843,1 938,0 1017,1 1050,0 1115,1 1139,0 1229,1 1250,0 1251,1 1281,0 1352,1 1378,0 1427,1 1486,0 1511,1 1583,0 1649,1 1684,0 1714,1 1776,0 1868,1 1891,0 1904,1 1986,0 2009,1 2051,0 2065,1 2103,0 2186,1 2200,0 2295,1 2330,0 2345,1 2352,0 2369,1 2437,0 2440,1 2448,0 2460,1 2483,0 2521,1 2594,0 2662,1 2748,0 2750,1 2822,0 2849,1 2899,0 2942,1 2962,0 3028,1 3078,0 3173,1 3218,0 3296,1 3322,0 3418,1 3473,0 3521,1 3567,0 3578,1 3614,0 3684,1 3687,0 3690,1 3758,0 3832,1 3923,0 3951,1 4012,0 4034,1 4076,0 4149,1 4205,0 4273,1 4311,0 4312,1 4391,0 4442,1 4539,0 4616,1 4617,0 4701,1 4732,0 4808,1 4888,0 4961,1 4977,0 5004,1 5102,0 5195,1 5269,0 5334,1 5390,0 5392,1 5394,0 5451,1 5487,0 5552,1 5620,0 5677,1 5742,0 5821,1 5872,0 5883,1 5899,0 5901,1 5922,0 5939,1 6026,0 6066,1 6071,0 6135,1 6181,0 6205,1 6248,0 6291,1 6391,0 6407,1 6420,0 6477,1 6549,0 6572,1 6594,0 6622,1 6702,0 6712,1 6734,0 6772,1 6869,0 6904,1 6936,0 7026,1 7084,0 7108,1 7204,0 7279,1 7325,0 7348,1 7371,0 7406,1 7412,0 7437,1 7494,0 7520,1 7557,0 7621,1 7653,0 7688,1 7717,0 7735,1 7740,0 7752,1 7820,0 7865,1 7955,0 8039,1 8121,0 8189,1 8220,0 8294,1 8331,0 8334,1 8348,0 8408,1 8415,0 8465,1 8498,0 8582,1 8633,0 8666,1 8705,0 8800,1 8895,0 8931,1 8939,0 9029,1 9059,0 9128,1 9131,0 9228,1 9287,0 9300,1 9339,0 9411,1 9478,0 9565,1 9650,0 9738,1 9812,0 9844,1 9941,0 9977,1 10012,0 10028,1 10104,0 10153,1 10176,0 10184,1 10222,0 10255,1 10306,0 10345,1 10444,0 10539,1 10553,0 10606,1 10614,0 10689,1 10715,0 10784,1 10790,0 10829,1 10848,0 10883,1 10962,0 11043,1 11070,0 11107,1 11133,0 11162,1 11251,0 11269,1 11351,0 11412,1 11507,0 11581,1 11680,0 11683,1 11737,0 11799,1 11861,0 11897,1 11909,0 11994,1 11999,0 12020,1 12034,0 12067,1 12098,0 12164,1 12194,0 12225,1 12314,0 12331,1 12391,0 12474,1 12492,0 12531,1 12540,0 12617,1 12706,0 12728,1 12772,0 12864,1 12924,0 12999,1 13084,0 13140,1 13225,0 13319,1 13332,0 13413,1 13479,0 13562,1 13595,0 13603,1 13653,0 13684,1 13707,0 13772,1 13818,0 13914,1 13950,0 14017,1 14117,0 14120,1 14210,0 14250,1 14252,0 14276,1 14370,0 14442,1 14486,0 14491,1 14507,0 14518,1 14526,0 14584,1 14613,0 14634,1 14733,0 14832,1 14922,0 15012,1 15112,0 15159,1 15213,0 15278,1 15315,0 15376,1 15459,0 15478,1 15568,0 15576,1 15659,0 15686,1 15733,0 15801,1 15819,0 15891,1 15912,0 15923,1 15959,0 16016,1 16054,0 16122,1 16217,0 16295,1 16321,0 16334,1 16429,0 16443,1 16475,0 16492,1 16588,0 16632,1 16695,0 16706,1 16730,0 16829,1 16911,0 17009,1 17087,0 17100,1 17190,0 17230,1 17278,0 17314,1 17324,0 17386,1 17452,0 17538,1 17539,0 17551,1 17564,0 17644,1 17709,0 17787,1 17840,0 17887,1 17909,0 17984,1 18028,0 18065,1 18068,0 18073,1 18164,0 18232,1 18329,0 18379,1 18463,0 18524,1 18545,0 18609,1 18615,0 18685,1 18772,0 18851,1 18852,0 18864,1 18879,0 18883,1 18957,0 19030,1 19099,0 19109,1 19116,0 19147,1 19232,0 19270,1 19358,0 19394,1 19423,0 19447,1 19520,0 19554,1 19636,0 19691,1 19734,0 19753,1 19826,0 19846,1 19859,0 19934,1 20031,0 20105,1 20160,0 20164,1 20263,0 20299,1 20303,0 20334,1 20386,0 20452,1 20530,0 20626,1 20644,0 20667,1 20745,0 20789,1 20819,0 20869,1 20951,0 20953,1 21043,0 21084,1 21098,0 21137,1 21196,0 21277,1 21352,0 21371,1 21384,0 21397,1 21495,0 21565,1 21618,0 21716,1 21731,0 21818,1 21912,0 22012,1 22087,0 22153,1 22212,0 22289,1 22372,0 22447,1 22490,0 22546,1 22626,0 22699,1 22754,0 22756,1 22795,0 22810,1 22882,0 22947,1 22982,0 23015,1 23029,0 23087,1 23127,0 23226,1 23319,0 23339,1 23391,0 23425,1 23525,0 23527,1 23618,0 23669,1 23672,0 23679,1 23763,0 23843,1 23896,0 23901,1 23907,0 23922,1 24005,0 24094,1 24158,0 24201,1 24284,0 24346,1 24379,0 24471,1 24519,0 24608,1 24696,0 24764,1 24819,0 24882,1 24962,0 24986,1 25072,0 25118,1 25178,0 25232,1 25235,0 25334,1 25396,0 25463,1 25505,0 25589,1 25610,0 25704,1 25728,0 25801,1 25821,0 25849,1 25875,0 25913,1 25931,0 26016,1 26105,0 26107,1 26144,0 26185,1 26194,0 26259,1 26328,0 26334,1 26383,0 26458,1 26483,0 26508,1 26602,0 26652,1 26740,0 26810,1 26838,0 26901,1 26936,0 26992,1 27060,0 27078,1 27079,0 27179,1 27252,0 27302,1 27355,0 27454,1 27477,0 27548,1 27648,0 27675,1 27757,0 27774,1 27842,0 27897,1 27943,0 27991,1 28010,0 28023,1 28038,0 28107,1 28170,0 28179,1 28188,0 28215,1 28311,0 28324,1 28335,0 28397,1 28437,0 28527,1 28578,0 28669,1 28703,0 28762,1 28782,0 28851,1 28862,0 28905,1 28973,0 29064,1 29076,0 29161,1 29182,0 29270,1 29370,0 29387,1 29441,0 29480,1 29513,0 29584,1 29604,0 29678,1 29733,0 29818,1 29887,0 29904,1 29933,0 29998,1 30097,0 30159,1 30190,0 30200,1 30280,0 30326,1 30357,0 30396,1 30444,0 30474,1 30510,0 30526,1 30610,0 30669,1 30725,0 30731,1 30764,0 30794,1 30894,0 30955,1 30970,0 31047,1 31069,0 31127,1 31155,0 31181,1 31208,0 31265,1 31306,0 31364,1 31377,0 31468,1 31566,0 31604,1 31625,0 31666,1 31743,0 31757,1 31838,0 31875,1 31902,0 31922,1 32015,0 32022,1 32096,0 32107,1 32145,0 32155,1 32224,0 32309,1 32348,0 32389,1 32392,0 32418,1 32488,0 32514,1 32572,0 32653,1 32746,0 32788,1 32789,0 32853,1 32875,0 32881,1 32979,0 33035,1 33057,0 33082,1 33139,0 33214,1 33273,0 33319,1 33380,0 33407,1 33412,0 33496,1 33580,0 33672,1 33729,0 33809,1 33860,0 33864,1 33882,0 33933,1 33993,0 34005,1 34059,0 34119,1 34214,0 34240,1 34312,0 34360,1 34400,0 34447,1 34498,0 34501,1 34511,0 34583,1 34608,0 34655,1 34741,0 34824,1 34833,0 34933,1 34960,0 35027,1 35123,0 35153,1 35174,0 35266,1 35298,0 35355,1 35420,0 35495,1 35560,0 35618,1 35716,0 35770,1 35823,0 35859,1 35864,0 35910,1 35933,0 36017,1 36080,0 36143,1 36207,0 36228,1 36302,0 36394,1 36472,0 36557,1 36646,0 36663,1 36718,0 36783,1 36816,0 36817,1 36912,0 36935,1 37026,0 37033,1 37058,0 37137,1 37182,0 37213,1 37270,0 37361,1 37437,0 37483,1 37504,0 37551,1 37558,0 37657,1 37731,0 37754,1 37775,0 37783,1 37831,0 37913,1 37995,0 38051,1 38060,0 38106,1 38160,0 38163,1 38249,0 38265,1 38328,0 38400,1 38449,0 38462,1 38555,0 38641,1 38736,0 38768,1 38865,0 38878,1 38884,0 38915,1 39015,0 39045,1 39098,0 39144,1 39194,0 39227,1 39312,0 39411,1 39444,0 39475,1 39511,0 39559,1 39630,0 39709,1 39757,0 39786,1 39879,0 39936,1 40011,0 40061,1 40107,0 40137,1 40226,0 40266,1 40290,0 40306,1 40353,0 40388,1 40412,0 40426,1 40501,0 40565,1 40658,0 40684,1 40691,0 40733,1 40777,0 40798,1 40881,0 40948,1 40987,0 41084,1 41126,0 41191,1 41222,0 41235,1 41323,0 41399,1 41488,0 41495,1 41557,0 41644,1 41658,0 41735,1 41748,0 41793,1 41843,0 41931,1 41950,0 41993,1 42076,0 42141,1 42198,0 42235,1 42333,0 42384,1 42415,0 42434,1 42531,0 42568,1 42612,0 42691,1 42735,0 42808,1 42871,0 42893,1 42976,0 43053,1 43099,0 43149,1 43154,0 43178,1 43260,0 43270,1 43352,0 43443,1 43459,0 43493,1 43575,0 43576,1 43635,0 43717,1 43756,0 43776,1 43849,0 43924,1 43968,0 44055,1 44088,0 44099,1 44102,0 44145,1 44194,0 44226,1 44323,0 44384,1 44476,0 44567,1 44639,0 44738,1 44811,0 44905,1 44986,0 45027,1 45080,0 45177,1 45188,0 45276,1 45316,0 45337,1 45355,0 45403,1 45443,0 45447,1 45514,0 45582,1 45635,0 45730,1 45771,0 45819,1 45880,0 45975,1 46020,0 46044,1 46121,0 46161,1 46215,0 46265,1 46362,0 46452,1 46483,0 46506,1 46557,0 46585,1 46673,0 46756,1 46757,0 46835,1 46935,0 46984,1 47055,0 47086,1 47180,0 47218,1 47285,0 47358,1 47394,0 47447,1 47470,0 47560,1 47613,0 47708,1 47741,0 47781,1 47824,0 47860,1 47937,0 48003,1 48085,0 48107,1 48127,0 48152,1 48210,0 48249,1 48291,0 48309,1 48384,0 48458,1 48517,0 48614,1 48675,0 48762,1 48815,0 48901,1 48999,0 49005,1 49023,0 49091,1 49135,0 49154,1 49224,0 49232,1 49319,0 49365,1 49433,0 49512,1 49523,0 49619,1 49703,0 49782,1 49824,0 49894,1 49921,0 49974,1 50040,0 50109,1 50143,0 50227,1 50297,0 50360,1 50450,0 50550,1 50572,0 50656,1 50714,0 50754,1 50848,0 50896,1 50980,0 51007,1 51051,0 51108,1 end initlist b12 0,0 31,1 125,0 185,1 218,0 284,1 316,0 385,1 466,0 566,1 647,0 665,1 744,0 833,1 852,0 898,1 978,0 1006,1 1096,0 1168,1 1195,0 1289,1 1301,0 1309,1 1372,0 1430,1 1437,0 1447,1 1502,0 1539,1 1629,0 1636,1 1724,0 1767,1 1804,0 1893,1 1950,0 2049,1 2103,0 2163,1 2246,0 2275,1 2323,0 2349,1 2356,0 2368,1 2397,0 2398,1 2451,0 2471,1 2528,0 2533,1 2626,0 2664,1 2723,0 2781,1 2816,0 2881,1 2914,0 2945,1 3013,0 3110,1 3112,0 3197,1 3236,0 3260,1 3336,0 3392,1 3485,0 3528,1 3562,0 3585,1 3647,0 3727,1 3770,0 3827,1 3866,0 3960,1 4042,0 4133,1 4208,0 4245,1 4315,0 4368,1 4401,0 4458,1 4525,0 4539,1 4614,0 4685,1 4749,0 4808,1 4835,0 4869,1 4874,0 4889,1 4945,0 4963,1 4967,0 5063,1 5151,0 5169,1 5186,0 5256,1 5314,0 5321,1 5372,0 5385,1 5424,0 5463,1 5506,0 5565,1 5659,0 5718,1 5724,0 5784,1 5865,0 5960,1 5973,0 6021,1 6097,0 6149,1 6204,0 6290,1 6341,0 6399,1 6489,0 6499,1 6516,0 6576,1 6617,0 6674,1 6683,0 6766,1 6849,0 6866,1 6966,0 7002,1 7082,0 7160,1 7231,0 7318,1 7402,0 7460,1 7548,0 7640,1 7692,0 7715,1 7737,0 7748,1 7794,0 7858,1 7891,0 7969,1 8044,0 8065,1 8066,0 8119,1 8160,0 8258,1 8332,0 8354,1 8360,0 8448,1 8536,0 8558,1 8597,0 8619,1 8697,0 8722,1 8799,0 8867,1 8889,0 8900,1 8946,0 9004,1 9011,0 9047,1 9093,0 9120,1 9123,0 9142,1 9207,0 9238,1 9245,0 9322,1 9377,0 9409,1 9496,0 9593,1 9630,0 9684,1 9783,0 9847,1 9892,0 9986,1 9995,0 10091,1 10172,0 10251,1 10257,0 10354,1 10379,0 10408,1 10498,0 10522,1 10609,0 10674,1 10697,0 10794,1 10802,0 10893,1 10915,0 11015,1 11085,0 11184,1 11194,0 11212,1 11246,0 11302,1 11345,0 11366,1 11416,0 11487,1 11544,0 11611,1 11681,0 11706,1 11711,0 11796,1 11852,0 11865,1 11916,0 11939,1 11983,0 11992,1 12070,0 12123,1 12170,0 12179,1 12231,0 12329,1 12425,0 12480,1 12508,0 12557,1 12614,0 12655,1 12736,0 12774,1 12817,0 12823,1 12878,0 12941,1 13034,0 13060,1 13143,0 13228,1 13281,0 13310,1 13397,0 13485,1 13583,0 13615,1 13670,0 13742,1 13819,0 13898,1 13951,0 13983,1 14077,0 14126,1 14212,0 14244,1 14293,0 14359,1 14360,0 14446,1 14451,0 14526,1 14601,0 14692,1 14779,0 14833,1 14895,0 14947,1 15017,0 15105,1 15196,0 15261,1 15285,0 15318,1 15400,0 15426,1 15501,0 15591,1 15614,0 15623,1 15703,0 15731,1 15741,0 15788,1 15874,0 15922,1 16022,0 16033,1 16091,0 16108,1 16166,0 16173,1 16261,0 16284,1 16333,0 16377,1 16449,0 16463,1 16558,0 16649,1 16727,0 16745,1 16824,0 16912,1 16940,0 16941,1 16950,0 17041,1 17133,0 17224,1 17319,0 17378,1 17470,0 17475,1 17572,0 17583,1 17609,0 17668,1 17730,0 17795,1 17815,0 17897,1 17916,0 17923,1 18014,0 18054,1 18108,0 18197,1 18219,0 18313,1 18315,0 18389,1 18395,0 18407,1 18480,0 18562,1 18653,0 18659,1 18723,0 18727,1 18743,0 18760,1 18857,0 18881,1 18900,0 18939,1 18990,0 19080,1 19099,0 19188,1 19213,0 19246,1 19271,0 19367,1 19372,0 19396,1 19449,0 19530,1 19561,0 19570,1 19615,0 19671,1 19677,0 19768,1 19851,0 19888,1 19949,0 20007,1 20045,0 20136,1 20174,0 20194,1 20253,0 20344,1 20415,0 20480,1 20572,0 20671,1 20762,0 20815,1 20842,0 20911,1 20932,0 21032,1 21051,0 21095,1 21105,0 21175,1 21275,0 21318,1 21331,0 21385,1 21475,0 21511,1 21560,0 21641,1 21678,0 21688,1 21760,0 21771,1 21789,0 21825,1 21868,0 21905,1 21978,0 22039,1 22113,0 22144,1 22177,0 22221,1 22247,0 22327,1 22361,0 22363,1 22391,0 22419,1 22426,0 22516,1 22599,0 22683,1 22700,0 22744,1 22762,0 22835,1 22884,0 22964,1 23034,0 23097,1 23185,0 23252,1 23293,0 23337,1 23428,0 23444,1 23527,0 23582,1 23593,0 23627,1 23705,0 23766,1 23773,0 23873,1 23888,0 23977,1 24068,0 24089,1 24141,0 24180,1 24212,0 24220,1 24316,0 24376,1 24387,0 24456,1 24524,0 24583,1 24635,0 24670,1 24739,0 24754,1 24809,0 24888,1 24907,0 24973,1 24990,0 25060,1 25078,0 25119,1 25217,0 25226,1 25242,0 25270,1 25348,0 25383,1 25428,0 25451,1 25543,0 25560,1 25635,0 25721,1 25807,0 25865,1 25891,0 25897,1 25902,0 25965,1 26050,0 26097,1 26106,0 26164,1 26165,0 26204,1 26212,0 26267,1 26339,0 26347,1 26446,0 26494,1 26576,0 26619,1 26688,0 26760,1 26803,0 26860,1 26899,0 26955,1 27019,0 27078,1 27091,0 27180,1 27198,0 27275,1 27280,0 27352,1 27366,0 27443,1 27467,0 27557,1 27575,0 27596,1 27639,0 27719,1 27785,0 27850,1 27869,0 27961,1 27981,0 27990,1 28033,0 28121,1 28210,0 28215,1 28230,0 28327,1 28367,0 28453,1 28523,0 28533,1 28556,0 28626,1 28717,0 28769,1 28840,0 28925,1 29019,0 29092,1 29131,0 29168,1 29187,0 29216,1 29262,0 29346,1 29418,0 29505,1 29524,0 29570,1 29637,0 29654,1 29723,0 29746,1 29806,0 29860,1 29958,0 29993,1 30087,0 30184,1 30211,0 30213,1 30260,0 30263,1 30345,0 30357,1 30423,0 30496,1 30534,0 30550,1 30584,0 30591,1 30666,0 30765,1 30846,0 30896,1 30906,0 30933,1 31008,0 31067,1 31141,0 31234,1 31275,0 31345,1 31433,0 31531,1 31621,0 31632,1 31697,0 31775,1 31831,0 31914,1 31944,0 31960,1 32049,0 32070,1 32090,0 32161,1 32217,0 32285,1 32335,0 32398,1 32417,0 32431,1 32494,0 32578,1 32663,0 32679,1 32703,0 32773,1 32788,0 32808,1 32852,0 32949,1 33042,0 33120,1 33184,0 33258,1 33327,0 33391,1 33440,0 33476,1 33506,0 33582,1 33630,0 33644,1 33705,0 33781,1 33792,0 33817,1 33823,0 33838,1 33930,0 33941,1 34021,0 34024,1 34076,0 34146,1 34176,0 34246,1 34261,0 34355,1 34403,0 34453,1 34514,0 34607,1 34701,0 34780,1 34793,0 34849,1 34863,0 34890,1 34898,0 34990,1 35014,0 35043,1 35123,0 35176,1 35179,0 35223,1 35229,0 35296,1 35352,0 35397,1 35494,0 35525,1 35557,0 35631,1 35704,0 35760,1 35775,0 35826,1 35869,0 35918,1 35993,0 36005,1 36033,0 36042,1 36079,0 36107,1 36181,0 36281,1 36335,0 36400,1 36456,0 36545,1 36629,0 36725,1 36768,0 36795,1 36819,0 36860,1 36935,0 36985,1 37082,0 37119,1 37173,0 37204,1 37215,0 37256,1 37335,0 37346,1 37445,0 37530,1 37575,0 37628,1 37727,0 37759,1 37828,0 37891,1 37936,0 37990,1 38034,0 38110,1 38189,0 38242,1 38338,0 38342,1 38420,0 38436,1 38497,0 38572,1 38591,0 38667,1 38727,0 38816,1 38855,0 38945,1 39033,0 39126,1 39166,0 39264,1 39265,0 39309,1 39315,0 39327,1 39386,0 39452,1 39460,0 39461,1 39557,0 39597,1 39620,0 39627,1 39635,0 39685,1 39720,0 39739,1 39763,0 39845,1 39868,0 39909,1 39948,0 40017,1 40069,0 40124,1 40209,0 40294,1 40359,0 40369,1 40415,0 40474,1 40546,0 40640,1 40732,0 40788,1 40796,0 40888,1 40970,0 41025,1 41098,0 41127,1 41202,0 41215,1 41232,0 41277,1 41283,0 41320,1 41352,0 41357,1 41367,0 41432,1 41479,0 41560,1 41568,0 41605,1 41663,0 41717,1 41798,0 41801,1 41803,0 41864,1 41926,0 41936,1 42007,0 42052,1 42128,0 42146,1 42202,0 42241,1 42340,0 42375,1 42445,0 42457,1 42478,0 42533,1 42550,0 42567,1 42658,0 42731,1 42740,0 42744,1 42785,0 42861,1 42956,0 43049,1 43109,0 43175,1 43196,0 43242,1 43306,0 43379,1 43454,0 43497,1 43520,0 43619,1 43691,0 43745,1 43828,0 43847,1 43940,0 43978,1 44020,0 44023,1 44037,0 44106,1 44183,0 44270,1 44337,0 44426,1 44459,0 44518,1 44519,0 44534,1 44585,0 44595,1 44659,0 44741,1 44782,0 44821,1 44879,0 44880,1 44912,0 44970,1 45050,0 45073,1 45087,0 45158,1 45229,0 45303,1 45400,0 45453,1 45459,0 45547,1 45583,0 45621,1 45644,0 45722,1 45750,0 45768,1 45788,0 45844,1 45852,0 45877,1 45941,0 46024,1 46029,0 46092,1 46177,0 46233,1 46286,0 46348,1 46434,0 46460,1 46468,0 46490,1 46524,0 46525,1 46600,0 46628,1 46728,0 46802,1 46885,0 46960,1 47026,0 47053,1 47110,0 47120,1 47206,0 47287,1 47289,0 47310,1 47409,0 47418,1 47452,0 47520,1 47534,0 47585,1 47662,0 47744,1 47776,0 47860,1 47960,0 47971,1 48069,0 48167,1 48177,0 48257,1 48314,0 48341,1 48356,0 48357,1 48391,0 48443,1 48473,0 48554,1 48562,0 48653,1 48740,0 48781,1 48851,0 48949,1 48957,0 48962,1 49060,0 49138,1 49226,0 49231,1 49241,0 49336,1 49413,0 49460,1 49544,0 49553,1 49596,0 49672,1 49686,0 49707,1 49769,0 49819,1 49835,0 49882,1 49944,0 49998,1 50071,0 50118,1 50189,0 50265,1 50359,0 50406,1 50489,0 50572,1 50593,0 50595,1 50643,0 50661,1 50758,0 50793,1 50873,0 50876,1 50929,0 51007,1 51078,0 51150,1 51155,0 51226,1 51239,0 51267,1 end initlist b13 0,0 49,1 130,0 164,1 239,0 249,1 261,0 314,1 407,0 470,1 567,0 592,1 651,0 670,1 729,0 762,1 806,0 818,1 827,0 904,1 950,0 968,1 1043,0 1141,1 1161,0 1200,1 1276,0 1331,1 1378,0 1467,1 1545,0 1557,1 1633,0 1683,1 1712,0 1737,1 1796,0 1813,1 1817,0 1885,1 1900,0 1995,1 1999,0 2006,1 2094,0 2098,1 2130,0 2168,1 2198,0 2280,1 2302,0 2340,1 2390,0 2473,1 2524,0 2539,1 2571,0 2590,1 2627,0 2650,1 2738,0 2744,1 2831,0 2919,1 2971,0 3023,1 3081,0 3147,1 3212,0 3287,1 3320,0 3324,1 3382,0 3420,1 3455,0 3520,1 3595,0 3616,1 3708,0 3777,1 3820,0 3845,1 3939,0 3979,1 4070,0 4096,1 4189,0 4258,1 4323,0 4337,1 4436,0 4515,1 4548,0 4578,1 4617,0 4715,1 4797,0 4801,1 4807,0 4887,1 4917,0 4950,1 4999,0 5084,1 5175,0 5227,1 5264,0 5352,1 5404,0 5420,1 5459,0 5518,1 5607,0 5670,1 5715,0 5727,1 5819,0 5820,1 5891,0 5987,1 5993,0 6031,1 6079,0 6131,1 6180,0 6239,1 6337,0 6367,1 6457,0 6472,1 6529,0 6580,1 6626,0 6658,1 6678,0 6704,1 6709,0 6740,1 6826,0 6860,1 6931,0 6991,1 7023,0 7093,1 7128,0 7202,1 7203,0 7301,1 7398,0 7440,1 7499,0 7547,1 7583,0 7660,1 7699,0 7754,1 7833,0 7850,1 7895,0 7923,1 8010,0 8076,1 8145,0 8196,1 8243,0 8301,1 8331,0 8347,1 8395,0 8425,1 8473,0 8506,1 8578,0 8674,1 8732,0 8819,1 8910,0 8916,1 8997,0 9031,1 9095,0 9121,1 9151,0 9205,1 9232,0 9309,1 9353,0 9393,1 9396,0 9450,1 9529,0 9604,1 9691,0 9735,1 9832,0 9916,1 9990,0 10013,1 10061,0 10135,1 10185,0 10210,1 10288,0 10300,1 10391,0 10408,1 10435,0 10530,1 10561,0 10602,1 10606,0 10670,1 10717,0 10796,1 10846,0 10918,1 10985,0 11069,1 11143,0 11149,1 11191,0 11207,1 11279,0 11348,1 11363,0 11407,1 11446,0 11526,1 11567,0 11585,1 11591,0 11599,1 11603,0 11655,1 11680,0 11770,1 11798,0 11835,1 11880,0 11959,1 11997,0 12045,1 12103,0 12134,1 12154,0 12249,1 12261,0 12343,1 12392,0 12488,1 12511,0 12609,1 12679,0 12710,1 12737,0 12800,1 12840,0 12929,1 13013,0 13019,1 13093,0 13187,1 13236,0 13288,1 13325,0 13401,1 13483,0 13582,1 13640,0 13738,1 13764,0 13770,1 13771,0 13855,1 13929,0 13945,1 14034,0 14125,1 14193,0 14261,1 14348,0 14414,1 14507,0 14562,1 14635,0 14681,1 14778,0 14783,1 14878,0 14902,1 14990,0 15023,1 15085,0 15103,1 15113,0 15123,1 15147,0 15196,1 15234,0 15304,1 15313,0 15378,1 15451,0 15487,1 15502,0 15590,1 15656,0 15707,1 15751,0 15823,1 15918,0 15964,1 16064,0 16081,1 16111,0 16167,1 16180,0 16274,1 16374,0 16401,1 16433,0 16455,1 16487,0 16502,1 16573,0 16627,1 16662,0 16735,1 16738,0 16827,1 16901,0 16956,1 17028,0 17086,1 17185,0 17197,1 17246,0 17264,1 17346,0 17417,1 17418,0 17461,1 17519,0 17597,1 17608,0 17621,1 17668,0 17684,1 17727,0 17732,1 17832,0 17876,1 17934,0 17999,1 18028,0 18057,1 18132,0 18153,1 18199,0 18248,1 18280,0 18330,1 18393,0 18396,1 18478,0 18550,1 18570,0 18641,1 18658,0 18741,1 18756,0 18808,1 18888,0 18911,1 18933,0 18960,1 18991,0 19019,1 19080,0 19154,1 19180,0 19228,1 19309,0 19313,1 19315,0 19354,1 19360,0 19375,1 19427,0 19499,1 19553,0 19611,1 19658,0 19677,1 19696,0 19771,1 19807,0 19844,1 19926,0 19972,1 19976,0 19996,1 20024,0 20105,1 20185,0 20193,1 20233,0 20242,1 20287,0 20373,1 20383,0 20414,1 20416,0 20436,1 20523,0 20565,1 20635,0 20641,1 20666,0 20761,1 20847,0 20899,1 20900,0 20944,1 21000,0 21096,1 21131,0 21152,1 21226,0 21291,1 21362,0 21447,1 21457,0 21523,1 21555,0 21566,1 21650,0 21684,1 21686,0 21764,1 21853,0 21950,1 22043,0 22128,1 22188,0 22247,1 22308,0 22392,1 22421,0 22505,1 22601,0 22680,1 22729,0 22814,1 22881,0 22935,1 22976,0 22981,1 23068,0 23151,1 23155,0 23188,1 23233,0 23292,1 23333,0 23401,1 23492,0 23548,1 23609,0 23699,1 23765,0 23774,1 23800,0 23853,1 23930,0 23944,1 24003,0 24020,1 24060,0 24119,1 24197,0 24205,1 24222,0 24270,1 24353,0 24378,1 24467,0 24499,1 24593,0 24680,1 24697,0 24766,1 24852,0 24907,1 24961,0 25046,1 25061,0 25156,1 25225,0 25287,1 25290,0 25327,1 25358,0 25375,1 25390,0 25418,1 25458,0 25515,1 25574,0 25616,1 25674,0 25740,1 25789,0 25790,1 25801,0 25841,1 25892,0 25937,1 25991,0 26068,1 26125,0 26147,1 26232,0 26284,1 26343,0 26436,1 26521,0 26564,1 26590,0 26680,1 26687,0 26705,1 26759,0 26826,1 26835,0 26902,1 26982,0 27026,1 27103,0 27138,1 27227,0 27255,1 27352,0 27388,1 27480,0 27497,1 27585,0 27681,1 27690,0 27783,1 27795,0 27819,1 27825,0 27867,1 27868,0 27903,1 27934,0 27989,1 28081,0 28091,1 28103,0 28120,1 28166,0 28219,1 28296,0 28368,1 28403,0 28436,1 28503,0 28532,1 28566,0 28648,1 28681,0 28755,1 28807,0 28865,1 28957,0 28965,1 28967,0 28982,1 29013,0 29091,1 29133,0 29213,1 29237,0 29296,1 29318,0 29365,1 29373,0 29403,1 29452,0 29529,1 29615,0 29667,1 29739,0 29805,1 29815,0 29876,1 29947,0 29983,1 29991,0 30035,1 30054,0 30068,1 30128,0 30136,1 30182,0 30281,1 30358,0 30408,1 30449,0 30520,1 30580,0 30607,1 30664,0 30754,1 30786,0 30881,1 30914,0 30921,1 31013,0 31028,1 31117,0 31213,1 31286,0 31353,1 31369,0 31407,1 31474,0 31546,1 31596,0 31628,1 31696,0 31706,1 31735,0 31828,1 31880,0 31906,1 31956,0 32043,1 32089,0 32189,1 32194,0 32234,1 32247,0 32323,1 32379,0 32430,1 32432,0 32456,1 32548,0 32551,1 32561,0 32632,1 32705,0 32706,1 32710,0 32771,1 32839,0 32922,1 32937,0 32979,1 32997,0 33084,1 33183,0 33279,1 33338,0 33389,1 33484,0 33572,1 33629,0 33716,1 33806,0 33818,1 33832,0 33915,1 33923,0 33944,1 33954,0 34017,1 34048,0 34059,1 34119,0 34178,1 34195,0 34273,1 34308,0 34369,1 34391,0 34475,1 34527,0 34610,1 34618,0 34688,1 34701,0 34794,1 34873,0 34881,1 34912,0 35010,1 35070,0 35102,1 35170,0 35211,1 35256,0 35333,1 35346,0 35387,1 35439,0 35453,1 35454,0 35480,1 35572,0 35644,1 35733,0 35743,1 35769,0 35787,1 35845,0 35855,1 35896,0 35897,1 35910,0 35964,1 36061,0 36099,1 36139,0 36218,1 36279,0 36321,1 36414,0 36495,1 36543,0 36591,1 36617,0 36620,1 36644,0 36675,1 36681,0 36777,1 36820,0 36835,1 36929,0 36999,1 37050,0 37075,1 37080,0 37138,1 37160,0 37216,1 37252,0 37261,1 37278,0 37337,1 37400,0 37404,1 37490,0 37520,1 37607,0 37664,1 37762,0 37796,1 37848,0 37896,1 37920,0 37989,1 38043,0 38078,1 38163,0 38250,1 38324,0 38351,1 38392,0 38479,1 38542,0 38579,1 38642,0 38704,1 38744,0 38787,1 38879,0 38926,1 38984,0 39063,1 39139,0 39227,1 39268,0 39285,1 39361,0 39453,1 39489,0 39553,1 39641,0 39719,1 39790,0 39835,1 39849,0 39867,1 39923,0 40020,1 40105,0 40130,1 40169,0 40209,1 40257,0 40307,1 40348,0 40438,1 40459,0 40471,1 40536,0 40631,1 40669,0 40711,1 40786,0 40857,1 40910,0 40914,1 40948,0 40976,1 41020,0 41031,1 41042,0 41084,1 41168,0 41211,1 41305,0 41331,1 41428,0 41502,1 41518,0 41521,1 41582,0 41593,1 41599,0 41601,1 41654,0 41730,1 41770,0 41850,1 41854,0 41885,1 41954,0 42054,1 42073,0 42096,1 42098,0 42105,1 42187,0 42238,1 42243,0 42277,1 42299,0 42325,1 42349,0 42359,1 42397,0 42443,1 42488,0 42583,1 42638,0 42738,1 42793,0 42859,1 42957,0 43042,1 43085,0 43120,1 43215,0 43260,1 43339,0 43374,1 43437,0 43513,1 43551,0 43596,1 43659,0 43692,1 43782,0 43841,1 43843,0 43886,1 43977,0 44057,1 44062,0 44112,1 44177,0 44254,1 44255,0 44291,1 44342,0 44402,1 44418,0 44497,1 44590,0 44600,1 44632,0 44691,1 44740,0 44756,1 44845,0 44883,1 44976,0 44984,1 44993,0 44997,1 45079,0 45157,1 45174,0 45216,1 45254,0 45346,1 45363,0 45405,1 45406,0 45500,1 45551,0 45590,1 45666,0 45715,1 45767,0 45803,1 45838,0 45858,1 45918,0 45937,1 45999,0 46078,1 46107,0 46201,1 46261,0 46308,1 46373,0 46472,1 46519,0 46572,1 46613,0 46679,1 46744,0 46793,1 46852,0 46947,1 47027,0 47081,1 47145,0 47182,1 47270,0 47362,1 47389,0 47453,1 47529,0 47598,1 47694,0 47775,1 47814,0 47876,1 47894,0 47964,1 47999,0 48097,1 48104,0 48199,1 48232,0 48255,1 48328,0 48351,1 48378,0 48429,1 48505,0 48522,1 48601,0 48666,1 48715,0 48720,1 48723,0 48749,1 48793,0 48858,1 48878,0 48910,1 48944,0 48973,1 49048,0 49105,1 49188,0 49215,1 49234,0 49331,1 49357,0 49454,1 49550,0 49590,1 49624,0 49688,1 49769,0 49839,1 49937,0 49957,1 49999,0 50064,1 50086,0 50106,1 end initlist b14 0,0 14,1 36,0 90,1 123,0 166,1 181,0 234,1 259,0 283,1 323,0 405,1 498,0 530,1 616,0 711,1 769,0 824,1 919,0 1003,1 1081,0 1106,1 1153,0 1216,1 1307,0 1382,1 1463,0 1515,1 1523,0 1618,1 1675,0 1716,1 1791,0 1880,1 1941,0 2040,1 2042,0 2057,1 2074,0 2154,1 2190,0 2218,1 2299,0 2343,1 2382,0 2387,1 2437,0 2495,1 2543,0 2596,1 2665,0 2726,1 2777,0 2811,1 2866,0 2910,1 3006,0 3008,1 3036,0 3098,1 3173,0 3250,1 3267,0 3338,1 3368,0 3437,1 3524,0 3614,1 3618,0 3642,1 3654,0 3658,1 3752,0 3833,1 3839,0 3897,1 3948,0 3987,1 4060,0 4084,1 4121,0 4173,1 4229,0 4237,1 4326,0 4336,1 4404,0 4484,1 4486,0 4582,1 4647,0 4684,1 4755,0 4776,1 4842,0 4870,1 4900,0 4935,1 4959,0 5036,1 5075,0 5171,1 5208,0 5269,1 5333,0 5399,1 5441,0 5457,1 5486,0 5542,1 5551,0 5619,1 5677,0 5692,1 5736,0 5754,1 5774,0 5784,1 5827,0 5883,1 5955,0 5964,1 5971,0 6018,1 6088,0 6168,1 6232,0 6299,1 6334,0 6394,1 6424,0 6501,1 6549,0 6552,1 6638,0 6643,1 6719,0 6810,1 6871,0 6959,1 6976,0 7058,1 7145,0 7208,1 7279,0 7325,1 7422,0 7512,1 7593,0 7659,1 7678,0 7685,1 7750,0 7822,1 7831,0 7889,1 7959,0 8022,1 8120,0 8151,1 8236,0 8254,1 8295,0 8336,1 8412,0 8422,1 8515,0 8555,1 8612,0 8689,1 8774,0 8815,1 8885,0 8949,1 8984,0 9056,1 9116,0 9186,1 9212,0 9259,1 9271,0 9311,1 9372,0 9438,1 9504,0 9589,1 9597,0 9691,1 9741,0 9745,1 9819,0 9865,1 9899,0 9909,1 9995,0 10079,1 10115,0 10116,1 10151,0 10204,1 10268,0 10290,1 10369,0 10466,1 10501,0 10535,1 10597,0 10610,1 10633,0 10682,1 10742,0 10794,1 10879,0 10967,1 11011,0 11061,1 11089,0 11091,1 11166,0 11216,1 11284,0 11366,1 11444,0 11461,1 11483,0 11509,1 11531,0 11580,1 11674,0 11715,1 11740,0 11747,1 11802,0 11861,1 11935,0 12013,1 12079,0 12144,1 12160,0 12198,1 12234,0 12298,1 12361,0 12442,1 12521,0 12596,1 12652,0 12672,1 12759,0 12803,1 12830,0 12864,1 12892,0 12964,1 13025,0 13090,1 13120,0 13130,1 13176,0 13225,1 13284,0 13294,1 13316,0 13357,1 13417,0 13512,1 13587,0 13677,1 13732,0 13800,1 13895,0 13991,1 14000,0 14021,1 14065,0 14153,1 14228,0 14328,1 14369,0 14455,1 14552,0 14557,1 14603,0 14663,1 14731,0 14785,1 14859,0 14918,1 14976,0 15051,1 15073,0 15104,1 15197,0 15275,1 15302,0 15334,1 15423,0 15464,1 15475,0 15574,1 15576,0 15660,1 15696,0 15697,1 15704,0 15743,1 15767,0 15805,1 15820,0 15892,1 15941,0 16027,1 16061,0 16150,1 16212,0 16276,1 16312,0 16355,1 16395,0 16493,1 16591,0 16607,1 16695,0 16715,1 16744,0 16793,1 16800,0 16861,1 16903,0 16925,1 16984,0 17029,1 17119,0 17131,1 17191,0 17273,1 17348,0 17398,1 17488,0 17514,1 17587,0 17681,1 17731,0 17733,1 17748,0 17786,1 17828,0 17911,1 17988,0 18078,1 18148,0 18233,1 18256,0 18325,1 18408,0 18498,1 18504,0 18545,1 18639,0 18677,1 18736,0 18822,1 18835,0 18883,1 18896,0 18939,1 19032,0 19081,1 19099,0 19181,1 19184,0 19240,1 19325,0 19425,1 19456,0 19515,1 19608,0 19702,1 19743,0 19786,1 19792,0 19890,1 19901,0 19950,1 20023,0 20098,1 20138,0 20151,1 20162,0 20210,1 20224,0 20262,1 20323,0 20398,1 20426,0 20473,1 20569,0 20587,1 20630,0 20661,1 20753,0 20813,1 20913,0 20936,1 21031,0 21126,1 21197,0 21253,1 21316,0 21362,1 21423,0 21444,1 21544,0 21644,1 21699,0 21760,1 21822,0 21906,1 21916,0 21944,1 21987,0 22010,1 22106,0 22198,1 22243,0 22260,1 22270,0 22308,1 22388,0 22485,1 22539,0 22574,1 22621,0 22707,1 22750,0 22793,1 22861,0 22921,1 23017,0 23102,1 23147,0 23163,1 23237,0 23249,1 23317,0 23381,1 23443,0 23540,1 23610,0 23681,1 23736,0 23836,1 23914,0 23968,1 23975,0 24064,1 24124,0 24191,1 24268,0 24307,1 24393,0 24451,1 24460,0 24531,1 24612,0 24651,1 24722,0 24809,1 24814,0 24861,1 24865,0 24937,1 25019,0 25049,1 25098,0 25165,1 25214,0 25275,1 25325,0 25420,1 25487,0 25570,1 25632,0 25724,1 25784,0 25842,1 25912,0 25943,1 25981,0 26051,1 26119,0 26180,1 26233,0 26327,1 26351,0 26360,1 26404,0 26451,1 26541,0 26605,1 26640,0 26681,1 26771,0 26787,1 26794,0 26819,1 26859,0 26901,1 26980,0 27028,1 27031,0 27090,1 27111,0 27113,1 27140,0 27164,1 27256,0 27319,1 27323,0 27326,1 27341,0 27416,1 27446,0 27545,1 27604,0 27654,1 27737,0 27830,1 27888,0 27981,1 28047,0 28061,1 28067,0 28091,1 28107,0 28154,1 28183,0 28226,1 28315,0 28327,1 28417,0 28444,1 28488,0 28551,1 28582,0 28630,1 28702,0 28756,1 28808,0 28825,1 28873,0 28972,1 29067,0 29138,1 29176,0 29208,1 29306,0 29364,1 29420,0 29504,1 29589,0 29668,1 29734,0 29776,1 29825,0 29915,1 30011,0 30092,1 30186,0 30248,1 30332,0 30336,1 30414,0 30424,1 30445,0 30533,1 30580,0 30660,1 30679,0 30714,1 30722,0 30798,1 30809,0 30860,1 30871,0 30947,1 30953,0 30997,1 31059,0 31063,1 31133,0 31208,1 31217,0 31246,1 31341,0 31405,1 31454,0 31527,1 31555,0 31649,1 31700,0 31712,1 31736,0 31819,1 31822,0 31881,1 31946,0 32016,1 32039,0 32088,1 32185,0 32190,1 32258,0 32283,1 32284,0 32309,1 32335,0 32374,1 32402,0 32453,1 32518,0 32618,1 32683,0 32701,1 32767,0 32824,1 32901,0 32995,1 33081,0 33099,1 33129,0 33221,1 33228,0 33254,1 33306,0 33374,1 33433,0 33478,1 33538,0 33621,1 33667,0 33716,1 33737,0 33785,1 33795,0 33874,1 33955,0 33971,1 34003,0 34012,1 34016,0 34072,1 34145,0 34236,1 34325,0 34357,1 34445,0 34505,1 34542,0 34590,1 34665,0 34738,1 34772,0 34776,1 34859,0 34942,1 35033,0 35131,1 35204,0 35275,1 35353,0 35376,1 35475,0 35494,1 35578,0 35663,1 35723,0 35733,1 35743,0 35755,1 35849,0 35857,1 35861,0 35959,1 36043,0 36098,1 36184,0 36209,1 36212,0 36300,1 36331,0 36414,1 36501,0 36521,1 36595,0 36662,1 36711,0 36790,1 36834,0 36857,1 36933,0 36942,1 36974,0 37010,1 37019,0 37059,1 37094,0 37132,1 37188,0 37244,1 37344,0 37398,1 37479,0 37549,1 37562,0 37601,1 37608,0 37654,1 37686,0 37774,1 37811,0 37845,1 37917,0 37967,1 38037,0 38062,1 38103,0 38138,1 38216,0 38307,1 38404,0 38457,1 38462,0 38478,1 38575,0 38615,1 38638,0 38717,1 38784,0 38812,1 38858,0 38924,1 38989,0 39051,1 39104,0 39191,1 39203,0 39245,1 39336,0 39372,1 39418,0 39429,1 39506,0 39605,1 39704,0 39802,1 39835,0 39865,1 39892,0 39974,1 40035,0 40113,1 40206,0 40230,1 40302,0 40356,1 40398,0 40495,1 40560,0 40601,1 40684,0 40729,1 40801,0 40814,1 40905,0 40975,1 41003,0 41026,1 41073,0 41163,1 41218,0 41305,1 41364,0 41435,1 41472,0 41558,1 41610,0 41680,1 41736,0 41799,1 41834,0 41861,1 41915,0 41973,1 41977,0 42006,1 42072,0 42160,1 42194,0 42270,1 42297,0 42358,1 42445,0 42487,1 42490,0 42542,1 42628,0 42644,1 42649,0 42680,1 42707,0 42795,1 42865,0 42892,1 42956,0 42992,1 43079,0 43137,1 43222,0 43287,1 43329,0 43421,1 43505,0 43554,1 43638,0 43676,1 43747,0 43809,1 43837,0 43933,1 43983,0 44048,1 44091,0 44190,1 44229,0 44244,1 44289,0 44329,1 44387,0 44422,1 44497,0 44537,1 44547,0 44557,1 44595,0 44658,1 44664,0 44706,1 44785,0 44811,1 44895,0 44986,1 44988,0 45082,1 45153,0 45191,1 45267,0 45279,1 45330,0 45358,1 45405,0 45452,1 45518,0 45596,1 45684,0 45765,1 45804,0 45806,1 45897,0 45905,1 45976,0 46003,1 46081,0 46127,1 46152,0 46189,1 46213,0 46299,1 46374,0 46470,1 46509,0 46523,1 46551,0 46627,1 46719,0 46786,1 46824,0 46841,1 46894,0 46906,1 46926,0 46991,1 47032,0 47036,1 47086,0 47092,1 47159,0 47201,1 47284,0 47346,1 47409,0 47499,1 47533,0 47544,1 47598,0 47664,1 47741,0 47767,1 47858,0 47882,1 47905,0 47944,1 48005,0 48042,1 48091,0 48166,1 48228,0 48289,1 48377,0 48388,1 48438,0 48471,1 48565,0 48596,1 48649,0 48727,1 48757,0 48824,1 48854,0 48871,1 48910,0 48991,1 49079,0 49082,1 49146,0 49202,1 49239,0 49251,1 49336,0 49415,1 49490,0 49572,1 49658,0 49697,1 49754,0 49821,1 49855,0 49895,1 49970,0 50022,1 50032,0 50126,1 50129,0 50229,1 50231,0 50244,1 50273,0 50292,1 50366,0 50463,1 50533,0 50561,1 50655,0 50709,1 50774,0 50862,1 50939,0 50949,1 50994,0 51003,1 51012,0 51056,1 51131,0 51156,1 51194,0 51245,1 51259,0 51268,1 51305,0 51383,1 51417,0 51446,1 51499,0 51561,1 51613,0 51637,1 51711,0 51794,1 51814,0 51877,1 51915,0 51955,1 52011,0 52035,1 52060,0 52155,1 52219,0 52319,1 52379,0 52469,1 52482,0 52524,1 end initlist b15 0,0 9,1 18,0 98,1 155,0 197,1 293,0 305,1 365,0 387,1 458,0 527,1 560,0 563,1 567,0 580,1 663,0 747,1 837,0 895,1 991,0 1019,1 1106,0 1146,1 1164,0 1210,1 1235,0 1258,1 1318,0 1388,1 1467,0 1487,1 1540,0 1629,1 1660,0 1667,1 1708,0 1749,1 1765,0 1809,1 1901,0 1918,1 2014,0 2062,1 2161,0 2182,1 2273,0 2351,1 2358,0 2368,1 2467,0 2523,1 2615,0 2643,1 2743,0 2746,1 2818,0 2888,1 2970,0 3041,1 3094,0 3111,1 3197,0 3260,1 3314,0 3387,1 3451,0 3533,1 3541,0 3575,1 3619,0 3711,1 3809,0 3812,1 3903,0 3939,1 4000,0 4076,1 4137,0 4205,1 4285,0 4327,1 4381,0 4471,1 4536,0 4582,1 4677,0 4757,1 4837,0 4887,1 4902,0 4950,1 5042,0 5104,1 5109,0 5126,1 5225,0 5302,1 5316,0 5339,1 5356,0 5359,1 5405,0 5418,1 5495,0 5512,1 5545,0 5625,1 5674,0 5708,1 5733,0 5756,1 5801,0 5815,1 5818,0 5918,1 6005,0 6030,1 6040,0 6056,1 6060,0 6095,1 6194,0 6256,1 6281,0 6292,1 6336,0 6387,1 6459,0 6558,1 6651,0 6729,1 6827,0 6847,1 6937,0 7016,1 7101,0 7183,1 7243,0 7292,1 7345,0 7397,1 7466,0 7512,1 7544,0 7630,1 7664,0 7731,1 7758,0 7827,1 7851,0 7855,1 7860,0 7867,1 7896,0 7919,1 7930,0 7953,1 8002,0 8030,1 8059,0 8065,1 8073,0 8129,1 8172,0 8179,1 8252,0 8279,1 8283,0 8332,1 8428,0 8515,1 8604,0 8630,1 8707,0 8785,1 8869,0 8907,1 8990,0 9009,1 9065,0 9104,1 9176,0 9231,1 9254,0 9286,1 9331,0 9366,1 9400,0 9405,1 9505,0 9560,1 9618,0 9671,1 9713,0 9729,1 9820,0 9895,1 9978,0 10041,1 10140,0 10223,1 10255,0 10291,1 10307,0 10349,1 10398,0 10430,1 10440,0 10462,1 10511,0 10520,1 10588,0 10645,1 10648,0 10699,1 10760,0 10852,1 10878,0 10931,1 11023,0 11055,1 11058,0 11082,1 11178,0 11262,1 11333,0 11383,1 11431,0 11446,1 11467,0 11536,1 11623,0 11663,1 11671,0 11737,1 11797,0 11872,1 11913,0 11969,1 11998,0 12031,1 12108,0 12127,1 12200,0 12285,1 12319,0 12345,1 12353,0 12380,1 12396,0 12495,1 12515,0 12560,1 12608,0 12707,1 12767,0 12839,1 12913,0 12931,1 12942,0 13011,1 13061,0 13137,1 13219,0 13220,1 13260,0 13324,1 13421,0 13424,1 13517,0 13574,1 13624,0 13650,1 13707,0 13749,1 13750,0 13765,1 13819,0 13850,1 13919,0 13983,1 14012,0 14062,1 14151,0 14233,1 14306,0 14403,1 14441,0 14477,1 14558,0 14647,1 14671,0 14725,1 14735,0 14772,1 14844,0 14942,1 15001,0 15047,1 15083,0 15144,1 15242,0 15289,1 15324,0 15376,1 15459,0 15544,1 15624,0 15649,1 15666,0 15698,1 15740,0 15795,1 15869,0 15940,1 15979,0 16062,1 16145,0 16155,1 16246,0 16253,1 16262,0 16285,1 16315,0 16379,1 16435,0 16490,1 16545,0 16628,1 16724,0 16751,1 16812,0 16823,1 16859,0 16920,1 16927,0 16978,1 17006,0 17058,1 17087,0 17139,1 17225,0 17311,1 17406,0 17502,1 17567,0 17603,1 17695,0 17716,1 17800,0 17829,1 17846,0 17907,1 17945,0 18006,1 18077,0 18105,1 18176,0 18200,1 18217,0 18222,1 18290,0 18388,1 18459,0 18517,1 18579,0 18668,1 18700,0 18757,1 18846,0 18893,1 18910,0 18944,1 19013,0 19065,1 19148,0 19214,1 19265,0 19352,1 19439,0 19462,1 19531,0 19532,1 19561,0 19563,1 19646,0 19707,1 19780,0 19821,1 19910,0 19933,1 19998,0 20021,1 20045,0 20124,1 20213,0 20282,1 20341,0 20422,1 20467,0 20525,1 20561,0 20622,1 20664,0 20725,1 20731,0 20813,1 20892,0 20926,1 20952,0 21028,1 21037,0 21043,1 21059,0 21149,1 21235,0 21256,1 21348,0 21385,1 21460,0 21516,1 21517,0 21530,1 21628,0 21653,1 21734,0 21804,1 21861,0 21913,1 21953,0 22024,1 22089,0 22158,1 22194,0 22265,1 22341,0 22441,1 22487,0 22533,1 22574,0 22672,1 22743,0 22795,1 22831,0 22928,1 22968,0 23045,1 23091,0 23181,1 23229,0 23275,1 23331,0 23380,1 23451,0 23452,1 23500,0 23591,1 23612,0 23690,1 23695,0 23727,1 23744,0 23810,1 23849,0 23917,1 24002,0 24032,1 24060,0 24088,1 24158,0 24190,1 24274,0 24355,1 24413,0 24445,1 24518,0 24605,1 24665,0 24720,1 24794,0 24844,1 24941,0 25022,1 25119,0 25156,1 25188,0 25287,1 25325,0 25375,1 25461,0 25511,1 25522,0 25604,1 25624,0 25684,1 25757,0 25788,1 25791,0 25861,1 25938,0 25976,1 25992,0 26078,1 26176,0 26245,1 26246,0 26252,1 26263,0 26318,1 26335,0 26403,1 26464,0 26481,1 26561,0 26564,1 26608,0 26689,1 26783,0 26829,1 26855,0 26943,1 26972,0 27037,1 27063,0 27124,1 27211,0 27224,1 27234,0 27277,1 27330,0 27417,1 27434,0 27493,1 27534,0 27563,1 27631,0 27634,1 27701,0 27744,1 27817,0 27841,1 27843,0 27891,1 27898,0 27989,1 28077,0 28163,1 28167,0 28200,1 28231,0 28268,1 28330,0 28387,1 28447,0 28500,1 28594,0 28595,1 28685,0 28735,1 28813,0 28815,1 28826,0 28874,1 28949,0 28987,1 29074,0 29080,1 29119,0 29122,1 29148,0 29164,1 29245,0 29339,1 29388,0 29474,1 29488,0 29575,1 29597,0 29603,1 29643,0 29715,1 29797,0 29803,1 29827,0 29846,1 29895,0 29953,1 29990,0 29991,1 30038,0 30069,1 30156,0 30250,1 30315,0 30393,1 30438,0 30479,1 30565,0 30583,1 30666,0 30729,1 30795,0 30828,1 30840,0 30851,1 30877,0 30890,1 30932,0 30990,1 31072,0 31101,1 31111,0 31195,1 31219,0 31236,1 31314,0 31316,1 31348,0 31381,1 31422,0 31494,1 31562,0 31599,1 31607,0 31680,1 31742,0 31806,1 31892,0 31919,1 31983,0 32067,1 32081,0 32148,1 32196,0 32289,1 32367,0 32467,1 32557,0 32564,1 32634,0 32678,1 32728,0 32784,1 32874,0 32903,1 32974,0 32984,1 32993,0 33088,1 33154,0 33235,1 33328,0 33415,1 33491,0 33522,1 33607,0 33611,1 33699,0 33745,1 33790,0 33811,1 33902,0 33987,1 34087,0 34165,1 34192,0 34230,1 34317,0 34360,1 34412,0 34422,1 34454,0 34473,1 34483,0 34542,1 34593,0 34642,1 34682,0 34741,1 34821,0 34856,1 34940,0 34961,1 34992,0 35074,1 35148,0 35174,1 35216,0 35227,1 35322,0 35344,1 35385,0 35455,1 35481,0 35524,1 35551,0 35600,1 35609,0 35647,1 35687,0 35709,1 35800,0 35877,1 35923,0 35984,1 36045,0 36121,1 36140,0 36214,1 36244,0 36321,1 36382,0 36442,1 36451,0 36461,1 36503,0 36570,1 36651,0 36689,1 36706,0 36795,1 36851,0 36884,1 36952,0 36962,1 36967,0 37041,1 37098,0 37103,1 37180,0 37246,1 37343,0 37441,1 37530,0 37561,1 37581,0 37592,1 37659,0 37660,1 37742,0 37803,1 37892,0 37929,1 38012,0 38047,1 38110,0 38192,1 38263,0 38345,1 38360,0 38407,1 38492,0 38516,1 38589,0 38670,1 38737,0 38825,1 38856,0 38940,1 38984,0 39034,1 39080,0 39090,1 39174,0 39243,1 39260,0 39307,1 39368,0 39438,1 39530,0 39559,1 39651,0 39677,1 39761,0 39809,1 39875,0 39920,1 39951,0 39999,1 40077,0 40138,1 40185,0 40214,1 40239,0 40313,1 40324,0 40331,1 40347,0 40366,1 40370,0 40401,1 40436,0 40481,1 40484,0 40557,1 40630,0 40677,1 40700,0 40748,1 40797,0 40870,1 40959,0 41052,1 41053,0 41074,1 41131,0 41159,1 41231,0 41306,1 41333,0 41341,1 41351,0 41402,1 41501,0 41515,1 41573,0 41630,1 41717,0 41723,1 41810,0 41905,1 41953,0 41991,1 42024,0 42029,1 42089,0 42104,1 42201,0 42232,1 42328,0 42355,1 42372,0 42380,1 42437,0 42502,1 42602,0 42698,1 42785,0 42835,1 42867,0 42908,1 42920,0 42948,1 42964,0 42997,1 43012,0 43111,1 43150,0 43152,1 43231,0 43244,1 43260,0 43274,1 43359,0 43426,1 43478,0 43554,1 43649,0 43721,1 43760,0 43848,1 43867,0 43947,1 43950,0 43958,1 44016,0 44059,1 44152,0 44160,1 44193,0 44273,1 44362,0 44377,1 44391,0 44418,1 44496,0 44588,1 44662,0 44760,1 44781,0 44787,1 44884,0 44904,1 44955,0 45031,1 45036,0 45079,1 45102,0 45129,1 45146,0 45174,1 45232,0 45260,1 45350,0 45420,1 45518,0 45608,1 45620,0 45717,1 45784,0 45800,1 45897,0 45978,1 46009,0 46012,1 46109,0 46140,1 46230,0 46231,1 46312,0 46357,1 46420,0 46477,1 46544,0 46599,1 46604,0 46699,1 46780,0 46829,1 46923,0 46939,1 46944,0 47006,1 47094,0 47097,1 47152,0 47243,1 47315,0 47384,1 47414,0 47428,1 47432,0 47451,1 47502,0 47519,1 47551,0 47563,1 47598,0 47635,1 47681,0 47725,1 47818,0 47846,1 47867,0 47926,1 48011,0 48015,1 48104,0 48178,1 48254,0 48306,1 48396,0 48476,1 48552,0 48589,1 48666,0 48747,1 48832,0 48910,1 49007,0 49018,1 49066,0 49157,1 49243,0 49329,1 49422,0 49442,1 49513,0 49588,1 49630,0 49671,1 49753,0 49812,1 49837,0 49920,1 49998,0 50023,1 50103,0 50196,1 50247,0 50250,1 50255,0 50276,1 50334,0 50433,1 50466,0 50548,1 50642,0 50691,1 50772,0 50777,1 50819,0 50889,1 50975,0 51007,1 51047,0 51073,1 51141,0 51197,1 51283,0 51345,1 end initlist b16 0,0 92,1 166,0 185,1 206,0 305,1 321,0 379,1 448,0 492,1 499,0 590,1 604,0 685,1 745,0 816,1 890,0 925,1 930,0 1002,1 1007,0 1022,1 1057,0 1128,1 1192,0 1199,1 1289,0 1369,1 1419,0 1430,1 1488,0 1571,1 1615,0 1619,1 1633,0 1703,1 1738,0 1799,1 1884,0 1963,1 2034,0 2107,1 2181,0 2271,1 2327,0 2344,1 2385,0 2413,1 2501,0 2546,1 2642,0 2680,1 2741,0 2742,1 2797,0 2805,1 2829,0 2840,1 2858,0 2945,1 3015,0 3077,1 3133,0 3218,1 3278,0 3298,1 3392,0 3435,1 3517,0 3562,1 3571,0 3659,1 3700,0 3782,1 3868,0 3874,1 3915,0 3931,1 3987,0 4086,1 4168,0 4176,1 4247,0 4303,1 4343,0 4349,1 4414,0 4426,1 4519,0 4537,1 4598,0 4684,1 4781,0 4881,1 4948,0 4990,1 5005,0 5046,1 5130,0 5135,1 5202,0 5214,1 5256,0 5290,1 5336,0 5355,1 5439,0 5533,1 5630,0 5643,1 5695,0 5770,1 5775,0 5778,1 5874,0 5945,1 6035,0 6116,1 6167,0 6180,1 6278,0 6372,1 6424,0 6484,1 6554,0 6605,1 6698,0 6779,1 6874,0 6934,1 7019,0 7066,1 7086,0 7112,1 7177,0 7212,1 7262,0 7322,1 7396,0 7474,1 7568,0 7575,1 7581,0 7644,1 7733,0 7756,1 7817,0 7878,1 7966,0 8011,1 8022,0 8080,1 8145,0 8210,1 8274,0 8337,1 8422,0 8433,1 8508,0 8518,1 8531,0 8579,1 8660,0 8670,1 8675,0 8687,1 8741,0 8806,1 8818,0 8824,1 8847,0 8910,1 8993,0 9037,1 9105,0 9184,1 9275,0 9306,1 9336,0 9427,1 9487,0 9566,1 9638,0 9655,1 9664,0 9727,1 9778,0 9850,1 9911,0 9957,1 10011,0 10071,1 10132,0 10179,1 10187,0 10194,1 10270,0 10318,1 10372,0 10416,1 10504,0 10555,1 10622,0 10714,1 10814,0 10906,1 10959,0 11055,1 11118,0 11165,1 11201,0 11281,1 11372,0 11449,1 11496,0 11507,1 11576,0 11653,1 11702,0 11732,1 11826,0 11833,1 11918,0 12017,1 12025,0 12033,1 12116,0 12125,1 12167,0 12203,1 12244,0 12299,1 12302,0 12363,1 12374,0 12414,1 12502,0 12562,1 12657,0 12737,1 12825,0 12828,1 12890,0 12944,1 13000,0 13006,1 13097,0 13179,1 13202,0 13231,1 13309,0 13346,1 13404,0 13426,1 13490,0 13555,1 13648,0 13682,1 13734,0 13764,1 13847,0 13860,1 13942,0 13991,1 14015,0 14036,1 14076,0 14134,1 14220,0 14240,1 14290,0 14377,1 14424,0 14461,1 14519,0 14554,1 14583,0 14607,1 14610,0 14705,1 14743,0 14789,1 14869,0 14895,1 14989,0 15089,1 15095,0 15168,1 15238,0 15313,1 15404,0 15475,1 15541,0 15584,1 15668,0 15754,1 15853,0 15946,1 15959,0 16010,1 16043,0 16113,1 16182,0 16232,1 16279,0 16332,1 16382,0 16383,1 16412,0 16418,1 16433,0 16519,1 16521,0 16592,1 16672,0 16761,1 16802,0 16818,1 16849,0 16903,1 16942,0 16971,1 17000,0 17068,1 17095,0 17131,1 17176,0 17244,1 17245,0 17285,1 17370,0 17382,1 17414,0 17502,1 17513,0 17530,1 17611,0 17626,1 17708,0 17785,1 17820,0 17848,1 17878,0 17909,1 18008,0 18070,1 18146,0 18236,1 18291,0 18299,1 18311,0 18367,1 18410,0 18492,1 18520,0 18612,1 18650,0 18711,1 18797,0 18892,1 18927,0 18993,1 19086,0 19161,1 19206,0 19249,1 19276,0 19368,1 19426,0 19440,1 19493,0 19509,1 19544,0 19607,1 19663,0 19731,1 19790,0 19823,1 19867,0 19894,1 19966,0 20016,1 20035,0 20115,1 20157,0 20226,1 20305,0 20364,1 20408,0 20490,1 20590,0 20615,1 20668,0 20686,1 20767,0 20811,1 20846,0 20935,1 21026,0 21045,1 21095,0 21159,1 21238,0 21335,1 21386,0 21412,1 21489,0 21528,1 21576,0 21658,1 21744,0 21821,1 21884,0 21928,1 21959,0 22038,1 22088,0 22157,1 22217,0 22308,1 22403,0 22487,1 22550,0 22604,1 22634,0 22734,1 22823,0 22853,1 22891,0 22909,1 23003,0 23069,1 23084,0 23161,1 23220,0 23232,1 23324,0 23362,1 23389,0 23475,1 23520,0 23577,1 23657,0 23750,1 23777,0 23858,1 23904,0 23999,1 24056,0 24068,1 24076,0 24163,1 24194,0 24223,1 24296,0 24391,1 24438,0 24498,1 24576,0 24633,1 24733,0 24827,1 24917,0 24982,1 25030,0 25088,1 25158,0 25236,1 25327,0 25366,1 25466,0 25531,1 25576,0 25595,1 25678,0 25767,1 25844,0 25870,1 25923,0 25973,1 25986,0 26025,1 26077,0 26117,1 26194,0 26291,1 26345,0 26429,1 26468,0 26551,1 26570,0 26662,1 26681,0 26729,1 26732,0 26768,1 26860,0 26944,1 26990,0 27022,1 27085,0 27105,1 27166,0 27179,1 27238,0 27271,1 27302,0 27368,1 27432,0 27503,1 27511,0 27593,1 27684,0 27738,1 27794,0 27865,1 27952,0 28010,1 28088,0 28166,1 28214,0 28267,1 28284,0 28320,1 28386,0 28442,1 28524,0 28603,1 28684,0 28691,1 28695,0 28752,1 28798,0 28896,1 28990,0 29024,1 29063,0 29121,1 29210,0 29245,1 29343,0 29354,1 29420,0 29460,1 29473,0 29514,1 29549,0 29558,1 29644,0 29675,1 29736,0 29821,1 29857,0 29884,1 29889,0 29926,1 29942,0 30010,1 30041,0 30086,1 30139,0 30174,1 30228,0 30312,1 30382,0 30396,1 30449,0 30494,1 30583,0 30658,1 30665,0 30748,1 30752,0 30840,1 30864,0 30873,1 30938,0 31011,1 31084,0 31163,1 31244,0 31312,1 31384,0 31472,1 31485,0 31561,1 31626,0 31688,1 31732,0 31770,1 31840,0 31912,1 31995,0 32031,1 32076,0 32103,1 32104,0 32187,1 32236,0 32262,1 32279,0 32377,1 32393,0 32413,1 32487,0 32546,1 32561,0 32569,1 32629,0 32705,1 32716,0 32762,1 32819,0 32854,1 32869,0 32963,1 32981,0 33016,1 33043,0 33047,1 33087,0 33174,1 33249,0 33260,1 33348,0 33374,1 33473,0 33571,1 33594,0 33641,1 33676,0 33720,1 33786,0 33817,1 33857,0 33946,1 33999,0 34027,1 34039,0 34049,1 34053,0 34151,1 34192,0 34255,1 34296,0 34308,1 34337,0 34418,1 34429,0 34458,1 34543,0 34577,1 34666,0 34739,1 34801,0 34805,1 34865,0 34944,1 35035,0 35084,1 35168,0 35265,1 35299,0 35377,1 35456,0 35469,1 35510,0 35558,1 35582,0 35594,1 35682,0 35721,1 35820,0 35845,1 35919,0 35994,1 36057,0 36141,1 36200,0 36270,1 36303,0 36401,1 36501,0 36591,1 36656,0 36658,1 36692,0 36749,1 36814,0 36827,1 36927,0 36930,1 37014,0 37111,1 37174,0 37180,1 37235,0 37236,1 37311,0 37321,1 37351,0 37413,1 37497,0 37585,1 37638,0 37641,1 37647,0 37672,1 37743,0 37806,1 37849,0 37945,1 38006,0 38105,1 38126,0 38148,1 38241,0 38276,1 38354,0 38423,1 38489,0 38499,1 38517,0 38519,1 38554,0 38617,1 38619,0 38630,1 38663,0 38707,1 38806,0 38870,1 38956,0 38971,1 39000,0 39013,1 39046,0 39054,1 39115,0 39137,1 39185,0 39280,1 39347,0 39349,1 39387,0 39403,1 39483,0 39545,1 39574,0 39615,1 39646,0 39700,1 39719,0 39819,1 39851,0 39894,1 39943,0 40000,1 40047,0 40089,1 40153,0 40250,1 40321,0 40368,1 40403,0 40415,1 40486,0 40534,1 40548,0 40571,1 40609,0 40614,1 40704,0 40804,1 40853,0 40882,1 40982,0 41019,1 41037,0 41089,1 41091,0 41139,1 41219,0 41229,1 41321,0 41410,1 41460,0 41507,1 41515,0 41551,1 41575,0 41660,1 41681,0 41701,1 41709,0 41715,1 41808,0 41849,1 41916,0 42014,1 42093,0 42156,1 42181,0 42248,1 42323,0 42412,1 42490,0 42530,1 42605,0 42651,1 42735,0 42737,1 42810,0 42844,1 42895,0 42992,1 43047,0 43094,1 43107,0 43205,1 43263,0 43274,1 43358,0 43458,1 43540,0 43560,1 43599,0 43600,1 43637,0 43683,1 43752,0 43804,1 43814,0 43816,1 43839,0 43928,1 44027,0 44052,1 44134,0 44160,1 44238,0 44312,1 44369,0 44373,1 44436,0 44455,1 44475,0 44526,1 44618,0 44655,1 44702,0 44727,1 44816,0 44873,1 44919,0 44989,1 45056,0 45143,1 45155,0 45254,1 45331,0 45390,1 45472,0 45541,1 45580,0 45635,1 45671,0 45689,1 45695,0 45754,1 45816,0 45873,1 45952,0 46026,1 46074,0 46144,1 46237,0 46337,1 46348,0 46354,1 46440,0 46451,1 46452,0 46501,1 46532,0 46578,1 46614,0 46617,1 46654,0 46713,1 46813,0 46832,1 46914,0 46917,1 46929,0 47024,1 47100,0 47157,1 47228,0 47284,1 47357,0 47358,1 47402,0 47409,1 47481,0 47531,1 47555,0 47595,1 47686,0 47770,1 47796,0 47856,1 47881,0 47919,1 47945,0 48021,1 48066,0 48084,1 48153,0 48208,1 48259,0 48343,1 48398,0 48455,1 48541,0 48556,1 48644,0 48689,1 48696,0 48697,1 48701,0 48710,1 48714,0 48791,1 48797,0 48826,1 48833,0 48843,1 48849,0 48947,1 48967,0 49031,1 49082,0 49127,1 49211,0 49219,1 49253,0 49309,1 49334,0 49417,1 49440,0 49449,1 49534,0 49556,1 49624,0 49691,1 49728,0 49769,1 49841,0 49857,1 49928,0 49999,1 50053,0 50085,1 50156,0 50171,1 50183,0 50189,1 50220,0 50295,1 50392,0 50456,1 50519,0 50612,1 50614,0 50652,1 50677,0 50738,1 50744,0 50826,1 50920,0 50978,1 51038,0 51107,1 51113,0 51142,1 51216,0 51239,1 51281,0 51329,1 51372,0 51437,1 51532,0 51564,1 51592,0 51625,1 51689,0 51706,1 51736,0 51781,1 51872,0 51882,1 end initlist b17 0,0 85,1 86,0 117,1 119,0 166,1 244,0 314,1 411,0 490,1 555,0 574,1 608,0 648,1 656,0 673,1 763,0 823,1 852,0 899,1 910,0 987,1 1011,0 1031,1 1049,0 1117,1 1201,0 1287,1 1352,0 1411,1 1462,0 1504,1 1517,0 1580,1 1672,0 1708,1 1722,0 1781,1 1808,0 1907,1 1916,0 1989,1 2025,0 2030,1 2113,0 2192,1 2229,0 2273,1 2306,0 2329,1 2354,0 2366,1 2384,0 2469,1 2544,0 2624,1 2696,0 2767,1 2851,0 2915,1 2922,0 2947,1 2989,0 3009,1 3032,0 3072,1 3099,0 3176,1 3182,0 3238,1 3273,0 3290,1 3386,0 3398,1 3437,0 3462,1 3548,0 3551,1 3580,0 3582,1 3672,0 3700,1 3726,0 3751,1 3802,0 3866,1 3922,0 3995,1 4092,0 4109,1 4139,0 4141,1 4219,0 4226,1 4277,0 4299,1 4390,0 4448,1 4512,0 4606,1 4668,0 4734,1 4781,0 4827,1 4925,0 4999,1 5037,0 5054,1 5065,0 5106,1 5162,0 5164,1 5205,0 5222,1 5286,0 5295,1 5370,0 5463,1 5508,0 5593,1 5637,0 5697,1 5735,0 5779,1 5785,0 5800,1 5858,0 5902,1 5965,0 5968,1 5980,0 6019,1 6095,0 6176,1 6193,0 6279,1 6296,0 6327,1 6345,0 6366,1 6372,0 6392,1 6478,0 6517,1 6520,0 6537,1 6603,0 6668,1 6683,0 6732,1 6788,0 6790,1 6801,0 6833,1 6910,0 6999,1 7045,0 7049,1 7069,0 7103,1 7136,0 7164,1 7231,0 7243,1 7294,0 7328,1 7389,0 7392,1 7445,0 7479,1 7490,0 7577,1 7620,0 7715,1 7810,0 7826,1 7827,0 7831,1 7854,0 7870,1 7908,0 7977,1 7995,0 8076,1 8173,0 8183,1 8233,0 8241,1 8245,0 8289,1 8311,0 8313,1 8317,0 8377,1 8458,0 8471,1 8509,0 8573,1 8590,0 8672,1 8701,0 8779,1 8877,0 8889,1 8965,0 9048,1 9086,0 9138,1 9227,0 9281,1 9294,0 9373,1 9391,0 9415,1 9492,0 9499,1 9549,0 9648,1 9734,0 9753,1 9842,0 9863,1 9889,0 9924,1 9943,0 9968,1 10057,0 10114,1 10191,0 10205,1 10259,0 10272,1 10306,0 10310,1 10359,0 10420,1 10476,0 10508,1 10536,0 10559,1 10608,0 10671,1 10771,0 10810,1 10820,0 10871,1 10940,0 10950,1 11020,0 11091,1 11174,0 11230,1 11279,0 11374,1 11428,0 11509,1 11511,0 11566,1 11624,0 11635,1 11717,0 11718,1 11789,0 11827,1 11873,0 11971,1 12008,0 12020,1 12071,0 12162,1 12243,0 12336,1 12376,0 12426,1 12516,0 12575,1 12582,0 12665,1 12682,0 12744,1 12761,0 12788,1 12846,0 12851,1 12897,0 12981,1 13037,0 13073,1 13142,0 13159,1 13160,0 13257,1 13278,0 13308,1 13361,0 13386,1 13470,0 13490,1 13575,0 13651,1 13677,0 13696,1 13772,0 13849,1 13877,0 13899,1 13970,0 14050,1 14059,0 14108,1 14113,0 14153,1 14219,0 14226,1 14281,0 14312,1 14412,0 14433,1 14443,0 14534,1 14579,0 14597,1 14607,0 14705,1 14742,0 14824,1 14852,0 14872,1 14908,0 14931,1 15021,0 15077,1 15114,0 15206,1 15269,0 15355,1 15415,0 15451,1 15548,0 15614,1 15679,0 15746,1 15818,0 15891,1 15959,0 15990,1 16040,0 16108,1 16196,0 16215,1 16232,0 16329,1 16383,0 16415,1 16472,0 16525,1 16601,0 16635,1 16694,0 16704,1 16712,0 16719,1 16802,0 16875,1 16945,0 16997,1 17092,0 17100,1 17126,0 17133,1 17203,0 17239,1 17275,0 17279,1 17359,0 17400,1 17461,0 17551,1 17569,0 17572,1 17672,0 17688,1 17715,0 17789,1 17807,0 17820,1 17832,0 17876,1 17928,0 17991,1 18044,0 18110,1 18172,0 18242,1 18304,0 18336,1 18340,0 18393,1 18411,0 18491,1 18555,0 18579,1 18637,0 18677,1 18705,0 18741,1 18753,0 18825,1 18907,0 18956,1 18963,0 18989,1 19045,0 19075,1 19127,0 19175,1 19200,0 19219,1 19244,0 19310,1 19317,0 19398,1 19404,0 19411,1 19479,0 19565,1 19626,0 19680,1 19698,0 19741,1 19811,0 19896,1 19940,0 19950,1 19957,0 19983,1 20035,0 20106,1 20141,0 20226,1 20260,0 20287,1 20343,0 20412,1 20491,0 20586,1 20603,0 20634,1 20640,0 20662,1 20699,0 20705,1 20728,0 20779,1 20830,0 20867,1 20910,0 20989,1 21082,0 21127,1 21143,0 21197,1 21238,0 21279,1 21287,0 21375,1 21473,0 21515,1 21554,0 21624,1 21717,0 21747,1 21800,0 21872,1 21904,0 21916,1 21941,0 21942,1 22034,0 22059,1 22138,0 22178,1 22219,0 22307,1 22331,0 22366,1 22420,0 22518,1 22529,0 22556,1 22588,0 22632,1 22638,0 22660,1 22708,0 22729,1 22812,0 22903,1 22997,0 23038,1 23133,0 23166,1 23237,0 23312,1 23336,0 23348,1 23358,0 23441,1 23521,0 23537,1 23606,0 23682,1 23693,0 23736,1 23812,0 23849,1 23877,0 23900,1 23911,0 23917,1 23958,0 24022,1 24085,0 24180,1 24267,0 24278,1 24345,0 24405,1 24450,0 24525,1 24558,0 24571,1 24584,0 24672,1 24755,0 24848,1 24857,0 24868,1 24936,0 24950,1 25045,0 25065,1 25084,0 25126,1 25164,0 25249,1 25331,0 25335,1 25426,0 25524,1 25617,0 25715,1 25730,0 25740,1 25815,0 25913,1 26011,0 26086,1 26169,0 26265,1 26328,0 26418,1 26428,0 26448,1 26461,0 26497,1 26534,0 26628,1 26639,0 26733,1 26763,0 26769,1 26779,0 26791,1 26877,0 26897,1 26900,0 26917,1 26991,0 27006,1 27104,0 27176,1 27262,0 27323,1 27393,0 27488,1 27511,0 27603,1 27671,0 27688,1 27780,0 27872,1 27967,0 28003,1 28004,0 28066,1 28112,0 28113,1 28131,0 28183,1 28239,0 28320,1 28337,0 28376,1 28377,0 28410,1 28479,0 28561,1 28620,0 28632,1 28711,0 28785,1 28837,0 28903,1 28990,0 29066,1 29134,0 29155,1 29183,0 29196,1 29228,0 29323,1 29344,0 29346,1 29405,0 29488,1 29573,0 29618,1 29644,0 29689,1 29739,0 29823,1 29841,0 29924,1 29976,0 30067,1 30085,0 30143,1 30183,0 30255,1 30341,0 30425,1 30525,0 30624,1 30630,0 30695,1 30784,0 30824,1 30865,0 30871,1 30924,0 31010,1 31059,0 31072,1 31081,0 31094,1 31150,0 31235,1 31238,0 31317,1 31345,0 31423,1 31504,0 31529,1 31575,0 31590,1 31663,0 31669,1 31723,0 31737,1 31785,0 31798,1 31868,0 31880,1 31917,0 31921,1 32010,0 32015,1 32043,0 32048,1 32114,0 32185,1 32194,0 32279,1 32365,0 32433,1 32528,0 32550,1 32621,0 32668,1 32678,0 32752,1 32762,0 32796,1 32834,0 32882,1 32931,0 32999,1 33093,0 33170,1 33264,0 33320,1 33379,0 33449,1 33548,0 33605,1 33641,0 33654,1 33740,0 33782,1 33797,0 33888,1 33904,0 33922,1 33967,0 33999,1 34095,0 34177,1 34252,0 34260,1 34287,0 34374,1 34449,0 34522,1 34620,0 34669,1 34679,0 34759,1 34831,0 34929,1 35014,0 35075,1 35079,0 35152,1 35233,0 35263,1 35289,0 35385,1 35480,0 35515,1 35614,0 35669,1 35697,0 35723,1 35760,0 35797,1 35857,0 35928,1 36004,0 36085,1 36144,0 36167,1 36179,0 36236,1 36304,0 36387,1 36394,0 36490,1 36495,0 36568,1 36607,0 36679,1 36765,0 36790,1 36886,0 36939,1 36970,0 37005,1 37043,0 37071,1 37166,0 37216,1 37290,0 37317,1 37412,0 37462,1 37463,0 37468,1 37474,0 37542,1 37548,0 37618,1 37619,0 37701,1 37763,0 37823,1 37915,0 37951,1 37965,0 37991,1 38018,0 38081,1 38164,0 38196,1 38245,0 38262,1 38293,0 38369,1 38449,0 38475,1 38573,0 38588,1 38687,0 38756,1 38855,0 38916,1 38945,0 38994,1 39084,0 39113,1 39126,0 39219,1 39294,0 39343,1 39376,0 39458,1 39479,0 39490,1 39493,0 39543,1 39608,0 39681,1 39709,0 39794,1 39832,0 39854,1 39871,0 39938,1 39940,0 40014,1 40055,0 40107,1 40205,0 40296,1 40357,0 40360,1 40435,0 40508,1 40572,0 40626,1 40679,0 40745,1 40840,0 40870,1 40961,0 40990,1 41054,0 41153,1 41201,0 41214,1 41297,0 41324,1 41374,0 41424,1 41514,0 41589,1 41619,0 41640,1 41659,0 41679,1 41733,0 41734,1 41775,0 41856,1 41931,0 42029,1 42040,0 42046,1 42101,0 42126,1 42163,0 42232,1 42323,0 42412,1 42501,0 42561,1 42623,0 42702,1 42787,0 42822,1 42831,0 42901,1 42995,0 43040,1 43133,0 43155,1 43225,0 43252,1 43269,0 43320,1 43334,0 43421,1 43506,0 43596,1 43624,0 43700,1 43748,0 43846,1 43899,0 43923,1 43978,0 44007,1 44073,0 44142,1 44164,0 44199,1 44272,0 44356,1 44439,0 44527,1 44573,0 44610,1 44619,0 44624,1 44706,0 44793,1 44816,0 44882,1 44961,0 45009,1 45044,0 45127,1 45170,0 45211,1 45287,0 45296,1 45363,0 45443,1 45449,0 45462,1 45494,0 45512,1 45549,0 45638,1 45724,0 45740,1 45806,0 45807,1 45820,0 45830,1 45912,0 45959,1 45990,0 46042,1 46060,0 46094,1 46166,0 46230,1 46282,0 46382,1 46408,0 46463,1 46558,0 46579,1 46617,0 46638,1 46653,0 46657,1 46726,0 46784,1 46812,0 46846,1 46866,0 46868,1 46925,0 46952,1 47025,0 47079,1 47092,0 47103,1 47194,0 47278,1 47348,0 47394,1 47398,0 47475,1 47506,0 47533,1 47534,0 47611,1 47650,0 47666,1 47762,0 47833,1 47915,0 48002,1 48030,0 48119,1 48161,0 48209,1 48218,0 48272,1 48324,0 48387,1 48450,0 48490,1 48587,0 48621,1 48645,0 48666,1 48683,0 48723,1 end initlist b18 0,0 62,1 147,0 200,1 205,0 267,1 298,0 315,1 351,0 404,1 477,0 538,1 607,0 697,1 768,0 769,1 843,0 856,1 944,0 1031,1 1097,0 1180,1 1183,0 1252,1 1275,0 1330,1 1402,0 1448,1 1453,0 1488,1 1526,0 1594,1 1605,0 1699,1 1758,0 1810,1 1906,0 1959,1 1977,0 1994,1 2004,0 2029,1 2067,0 2132,1 2201,0 2300,1 2321,0 2358,1 2372,0 2401,1 2457,0 2489,1 2567,0 2609,1 2660,0 2734,1 2832,0 2906,1 2996,0 3073,1 3082,0 3106,1 3119,0 3201,1 3239,0 3271,1 3299,0 3378,1 3396,0 3494,1 3519,0 3533,1 3600,0 3697,1 3783,0 3817,1 3854,0 3901,1 3970,0 4021,1 4024,0 4102,1 4143,0 4210,1 4218,0 4290,1 4337,0 4376,1 4426,0 4463,1 4508,0 4578,1 4618,0 4675,1 4705,0 4789,1 4842,0 4894,1 4917,0 4940,1 5001,0 5085,1 5089,0 5153,1 5215,0 5251,1 5334,0 5363,1 5425,0 5480,1 5510,0 5603,1 5648,0 5708,1 5785,0 5856,1 5876,0 5932,1 5957,0 6000,1 6055,0 6073,1 6084,0 6117,1 6209,0 6229,1 6270,0 6271,1 6347,0 6379,1 6385,0 6479,1 6494,0 6555,1 6644,0 6740,1 6754,0 6849,1 6915,0 6959,1 6975,0 7064,1 7081,0 7135,1 7190,0 7247,1 7295,0 7371,1 7383,0 7455,1 7520,0 7539,1 7558,0 7653,1 7718,0 7777,1 7802,0 7895,1 7948,0 7995,1 8059,0 8077,1 8084,0 8161,1 8234,0 8238,1 8333,0 8400,1 8422,0 8480,1 8484,0 8526,1 8603,0 8622,1 8697,0 8731,1 8805,0 8836,1 8862,0 8934,1 8972,0 9053,1 9105,0 9174,1 9195,0 9245,1 9287,0 9381,1 9441,0 9511,1 9528,0 9550,1 9556,0 9560,1 9614,0 9652,1 9729,0 9812,1 9867,0 9964,1 10004,0 10079,1 10126,0 10130,1 10137,0 10199,1 10254,0 10300,1 10352,0 10415,1 10508,0 10592,1 10686,0 10729,1 10829,0 10921,1 10948,0 10949,1 11040,0 11076,1 11128,0 11204,1 11207,0 11303,1 11307,0 11316,1 11335,0 11381,1 11443,0 11542,1 11587,0 11633,1 11681,0 11716,1 11732,0 11781,1 11818,0 11861,1 11952,0 11986,1 12026,0 12040,1 12069,0 12164,1 12194,0 12224,1 12303,0 12371,1 12400,0 12489,1 12501,0 12541,1 12640,0 12680,1 12768,0 12788,1 12876,0 12944,1 12994,0 13040,1 13080,0 13106,1 13137,0 13222,1 13297,0 13338,1 13424,0 13503,1 13512,0 13543,1 13565,0 13606,1 13650,0 13675,1 13678,0 13719,1 13740,0 13809,1 13823,0 13894,1 13961,0 14050,1 14150,0 14213,1 14244,0 14304,1 14330,0 14339,1 14365,0 14380,1 14409,0 14459,1 14537,0 14560,1 14578,0 14676,1 14699,0 14720,1 14732,0 14827,1 14854,0 14856,1 14867,0 14939,1 15034,0 15065,1 15071,0 15113,1 15178,0 15249,1 15332,0 15369,1 15435,0 15524,1 15581,0 15586,1 15617,0 15636,1 15667,0 15721,1 15784,0 15874,1 15884,0 15957,1 15984,0 16026,1 16047,0 16127,1 16165,0 16197,1 16236,0 16261,1 16319,0 16391,1 16401,0 16418,1 16498,0 16530,1 16536,0 16560,1 16608,0 16708,1 16783,0 16828,1 16885,0 16972,1 16995,0 16998,1 17032,0 17132,1 17167,0 17181,1 17239,0 17266,1 17346,0 17434,1 17468,0 17483,1 17506,0 17581,1 17671,0 17679,1 17738,0 17771,1 17818,0 17871,1 17899,0 17973,1 18060,0 18123,1 18158,0 18221,1 18246,0 18269,1 18337,0 18407,1 18424,0 18474,1 18540,0 18549,1 18615,0 18666,1 18738,0 18771,1 18817,0 18892,1 18902,0 18936,1 18944,0 18985,1 19061,0 19156,1 19243,0 19246,1 19304,0 19348,1 19432,0 19523,1 19561,0 19580,1 19589,0 19608,1 19612,0 19631,1 19710,0 19714,1 19768,0 19814,1 19904,0 19999,1 20097,0 20117,1 20174,0 20220,1 20253,0 20284,1 20287,0 20382,1 20402,0 20438,1 20513,0 20550,1 20624,0 20713,1 20723,0 20794,1 20797,0 20836,1 20915,0 20928,1 21016,0 21102,1 21172,0 21264,1 21309,0 21311,1 21396,0 21472,1 21555,0 21645,1 21674,0 21713,1 21760,0 21768,1 21855,0 21954,1 21990,0 22015,1 22053,0 22143,1 22177,0 22255,1 22335,0 22337,1 22406,0 22502,1 22585,0 22626,1 22646,0 22720,1 22816,0 22882,1 22937,0 23028,1 23032,0 23088,1 23168,0 23187,1 23246,0 23300,1 23360,0 23410,1 23424,0 23489,1 23541,0 23628,1 23645,0 23716,1 23795,0 23823,1 23899,0 23912,1 23973,0 24061,1 24140,0 24178,1 24252,0 24290,1 24338,0 24377,1 24389,0 24454,1 24543,0 24607,1 24706,0 24770,1 24818,0 24880,1 24908,0 24964,1 24977,0 25013,1 25073,0 25080,1 25179,0 25231,1 25254,0 25334,1 25382,0 25415,1 25425,0 25498,1 25577,0 25583,1 25631,0 25712,1 25789,0 25881,1 25972,0 26072,1 26164,0 26259,1 26332,0 26429,1 26526,0 26543,1 26609,0 26640,1 26650,0 26733,1 26756,0 26803,1 26890,0 26925,1 27018,0 27116,1 27147,0 27173,1 27183,0 27216,1 27279,0 27297,1 27363,0 27376,1 27431,0 27451,1 27519,0 27527,1 27592,0 27638,1 27670,0 27728,1 27804,0 27900,1 27936,0 27943,1 27990,0 28073,1 28150,0 28245,1 28275,0 28344,1 28428,0 28494,1 28590,0 28690,1 28777,0 28779,1 28873,0 28957,1 29008,0 29030,1 29034,0 29070,1 29115,0 29166,1 29172,0 29238,1 29328,0 29395,1 29490,0 29516,1 29590,0 29675,1 29681,0 29718,1 29734,0 29812,1 29824,0 29917,1 30001,0 30074,1 30095,0 30149,1 30235,0 30249,1 30300,0 30375,1 30399,0 30439,1 30469,0 30489,1 30511,0 30519,1 30540,0 30613,1 30646,0 30689,1 30752,0 30791,1 30855,0 30872,1 30922,0 30999,1 31094,0 31098,1 31111,0 31113,1 31208,0 31219,1 31295,0 31394,1 31397,0 31433,1 31450,0 31520,1 31606,0 31636,1 31728,0 31772,1 31866,0 31905,1 31991,0 32030,1 32095,0 32181,1 32248,0 32297,1 32370,0 32405,1 32460,0 32542,1 32641,0 32695,1 32755,0 32793,1 32837,0 32866,1 32950,0 32999,1 33093,0 33113,1 33168,0 33265,1 33273,0 33366,1 33445,0 33461,1 33518,0 33609,1 33706,0 33714,1 33813,0 33823,1 33857,0 33926,1 33949,0 34028,1 34088,0 34155,1 34247,0 34311,1 34385,0 34409,1 34473,0 34568,1 34578,0 34662,1 34668,0 34715,1 34796,0 34832,1 34923,0 35012,1 35037,0 35109,1 35125,0 35212,1 35232,0 35258,1 35326,0 35368,1 35372,0 35425,1 35500,0 35595,1 35613,0 35669,1 35714,0 35744,1 35829,0 35851,1 35906,0 35910,1 35980,0 36031,1 36092,0 36112,1 36210,0 36293,1 36382,0 36465,1 36494,0 36526,1 36551,0 36608,1 36616,0 36638,1 36660,0 36698,1 36792,0 36799,1 36869,0 36880,1 36890,0 36944,1 37014,0 37034,1 37112,0 37179,1 37189,0 37228,1 37309,0 37404,1 37496,0 37567,1 37609,0 37661,1 37700,0 37719,1 37797,0 37807,1 37906,0 37917,1 38005,0 38082,1 38129,0 38199,1 38264,0 38362,1 38390,0 38475,1 38565,0 38626,1 38668,0 38724,1 38804,0 38864,1 38894,0 38917,1 39012,0 39076,1 39087,0 39182,1 39228,0 39237,1 39285,0 39352,1 39407,0 39410,1 39487,0 39489,1 39543,0 39613,1 39673,0 39726,1 39809,0 39846,1 39900,0 39958,1 39997,0 40021,1 40045,0 40131,1 40230,0 40314,1 40342,0 40438,1 40472,0 40499,1 40549,0 40633,1 40649,0 40745,1 40801,0 40857,1 40895,0 40967,1 41066,0 41162,1 41222,0 41246,1 41343,0 41359,1 41424,0 41512,1 41514,0 41530,1 41567,0 41661,1 41732,0 41806,1 41820,0 41859,1 41919,0 41936,1 42020,0 42073,1 42113,0 42187,1 42230,0 42251,1 42281,0 42313,1 42413,0 42470,1 42511,0 42528,1 42530,0 42606,1 42608,0 42616,1 42652,0 42720,1 42783,0 42798,1 42813,0 42820,1 42916,0 42936,1 42982,0 43014,1 43035,0 43101,1 43129,0 43140,1 43215,0 43238,1 43259,0 43333,1 43390,0 43396,1 43403,0 43475,1 43566,0 43625,1 43669,0 43735,1 43766,0 43802,1 43878,0 43976,1 43980,0 44000,1 44036,0 44131,1 44224,0 44273,1 44372,0 44421,1 44494,0 44556,1 44617,0 44686,1 44724,0 44732,1 44817,0 44896,1 44906,0 44975,1 45023,0 45065,1 45145,0 45205,1 45244,0 45250,1 45259,0 45359,1 45389,0 45392,1 45408,0 45455,1 45486,0 45523,1 45606,0 45670,1 45727,0 45796,1 45867,0 45964,1 46034,0 46117,1 46188,0 46266,1 46288,0 46367,1 46433,0 46491,1 46527,0 46590,1 46670,0 46719,1 46800,0 46845,1 46933,0 46953,1 46980,0 46998,1 47089,0 47116,1 47169,0 47251,1 47320,0 47339,1 47437,0 47502,1 47557,0 47568,1 47571,0 47608,1 47672,0 47695,1 47697,0 47760,1 47830,0 47860,1 47942,0 47993,1 48000,0 48089,1 48144,0 48147,1 48184,0 48274,1 48309,0 48386,1 48438,0 48518,1 48530,0 48556,1 48640,0 48647,1 48713,0 48782,1 48871,0 48884,1 48896,0 48912,1 48924,0 48947,1 49041,0 49085,1 49123,0 49201,1 49297,0 49365,1 49431,0 49432,1 49525,0 49575,1 49628,0 49660,1 49744,0 49816,1 49901,0 49914,1 49933,0 49943,1 49996,0 50027,1 50062,0 50128,1 50150,0 50229,1 50238,0 50274,1 50315,0 50404,1 50461,0 50539,1 50558,0 50643,1 50689,0 50705,1 50793,0 50810,1 50890,0 50897,1 50921,0 50932,1 51022,0 51040,1 end initlist b19 0,0 61,1 158,0 226,1 231,0 313,1 404,0 438,1 506,0 548,1 613,0 620,1 692,0 789,1 879,0 936,1 1009,0 1087,1 1183,0 1210,1 1244,0 1288,1 1341,0 1346,1 1434,0 1489,1 1564,0 1622,1 1661,0 1731,1 1765,0 1780,1 1841,0 1861,1 1876,0 1941,1 1955,0 1960,1 2025,0 2067,1 2121,0 2141,1 2219,0 2255,1 2349,0 2434,1 2481,0 2532,1 2553,0 2619,1 2642,0 2716,1 2717,0 2775,1 2870,0 2930,1 3030,0 3098,1 3141,0 3185,1 3233,0 3296,1 3350,0 3408,1 3493,0 3554,1 3596,0 3648,1 3662,0 3762,1 3819,0 3858,1 3942,0 4005,1 4102,0 4196,1 4290,0 4370,1 4404,0 4447,1 4516,0 4601,1 4634,0 4727,1 4746,0 4801,1 4845,0 4938,1 4964,0 5030,1 5045,0 5093,1 5128,0 5132,1 5137,0 5173,1 5200,0 5253,1 5352,0 5436,1 5472,0 5552,1 5590,0 5690,1 5769,0 5814,1 5908,0 5939,1 6031,0 6121,1 6166,0 6191,1 6265,0 6305,1 6359,0 6436,1 6471,0 6515,1 6555,0 6582,1 6672,0 6716,1 6744,0 6797,1 6861,0 6897,1 6950,0 7024,1 7042,0 7086,1 7150,0 7222,1 7274,0 7302,1 7397,0 7427,1 7485,0 7514,1 7543,0 7566,1 7653,0 7700,1 7777,0 7862,1 7906,0 7946,1 7997,0 8013,1 8057,0 8126,1 8216,0 8315,1 8316,0 8404,1 8479,0 8515,1 8546,0 8613,1 8682,0 8725,1 8777,0 8866,1 8870,0 8878,1 8958,0 9001,1 9056,0 9140,1 9225,0 9272,1 9355,0 9438,1 9458,0 9522,1 9564,0 9594,1 9636,0 9730,1 9793,0 9862,1 9879,0 9968,1 9975,0 10004,1 10082,0 10106,1 10125,0 10211,1 10291,0 10376,1 10416,0 10510,1 10596,0 10623,1 10682,0 10782,1 10796,0 10873,1 10875,0 10965,1 10995,0 11037,1 11054,0 11147,1 11168,0 11184,1 11227,0 11267,1 11318,0 11388,1 11405,0 11474,1 11563,0 11661,1 11744,0 11767,1 11866,0 11927,1 11986,0 12045,1 12087,0 12096,1 12166,0 12205,1 12244,0 12282,1 12345,0 12408,1 12429,0 12460,1 12518,0 12568,1 12637,0 12650,1 12671,0 12675,1 12768,0 12841,1 12900,0 12998,1 13068,0 13143,1 13242,0 13259,1 13298,0 13398,1 13426,0 13494,1 13524,0 13571,1 13590,0 13626,1 13657,0 13679,1 13699,0 13735,1 13767,0 13817,1 13841,0 13855,1 13926,0 13965,1 14021,0 14059,1 14067,0 14075,1 14164,0 14222,1 14303,0 14348,1 14352,0 14394,1 14454,0 14547,1 14566,0 14661,1 14685,0 14703,1 14747,0 14810,1 14899,0 14916,1 15000,0 15020,1 15070,0 15106,1 15142,0 15171,1 15191,0 15224,1 15255,0 15289,1 15323,0 15328,1 15395,0 15466,1 15514,0 15541,1 15625,0 15698,1 15782,0 15867,1 15957,0 16054,1 16076,0 16126,1 16142,0 16215,1 16218,0 16285,1 16357,0 16390,1 16477,0 16540,1 16584,0 16613,1 16672,0 16719,1 16738,0 16816,1 16886,0 16922,1 16952,0 16971,1 16974,0 17005,1 17041,0 17132,1 17190,0 17266,1 17296,0 17349,1 17389,0 17394,1 17457,0 17481,1 17517,0 17552,1 17622,0 17660,1 17683,0 17741,1 17807,0 17895,1 17992,0 18071,1 18078,0 18107,1 18162,0 18185,1 18272,0 18322,1 18344,0 18354,1 18374,0 18381,1 18472,0 18475,1 18533,0 18540,1 18551,0 18574,1 18670,0 18737,1 18800,0 18847,1 18895,0 18953,1 18972,0 19014,1 19058,0 19070,1 19161,0 19228,1 19279,0 19348,1 19353,0 19399,1 19404,0 19472,1 19489,0 19567,1 19633,0 19733,1 19740,0 19819,1 19841,0 19937,1 19990,0 20050,1 20117,0 20170,1 20183,0 20192,1 20291,0 20333,1 20386,0 20454,1 20516,0 20570,1 20617,0 20694,1 20733,0 20830,1 20832,0 20860,1 20954,0 20981,1 21075,0 21157,1 21227,0 21278,1 21331,0 21405,1 21489,0 21502,1 21548,0 21648,1 21712,0 21740,1 21818,0 21840,1 21909,0 21917,1 22014,0 22077,1 22086,0 22117,1 22170,0 22255,1 22293,0 22320,1 22325,0 22406,1 22484,0 22485,1 22550,0 22551,1 22617,0 22711,1 22715,0 22745,1 22758,0 22763,1 22780,0 22798,1 22891,0 22929,1 23023,0 23081,1 23123,0 23199,1 23207,0 23215,1 23300,0 23327,1 23342,0 23410,1 23476,0 23572,1 23654,0 23680,1 23698,0 23699,1 23788,0 23809,1 23812,0 23814,1 23891,0 23948,1 23969,0 24059,1 24081,0 24101,1 24165,0 24261,1 24297,0 24383,1 24471,0 24547,1 24628,0 24690,1 24789,0 24875,1 24907,0 24917,1 24951,0 24988,1 25080,0 25118,1 25119,0 25181,1 25194,0 25237,1 25291,0 25335,1 25375,0 25467,1 25566,0 25652,1 25745,0 25790,1 25850,0 25870,1 25925,0 25987,1 26003,0 26036,1 26128,0 26163,1 26226,0 26296,1 26388,0 26461,1 26537,0 26570,1 26571,0 26621,1 26655,0 26703,1 26779,0 26813,1 26887,0 26979,1 27014,0 27048,1 27128,0 27152,1 27191,0 27278,1 27307,0 27329,1 27380,0 27448,1 27463,0 27470,1 27502,0 27519,1 27550,0 27571,1 27594,0 27646,1 27699,0 27737,1 27775,0 27803,1 27883,0 27907,1 27923,0 28023,1 28060,0 28080,1 28134,0 28234,1 28238,0 28262,1 28310,0 28338,1 28435,0 28477,1 28493,0 28585,1 28594,0 28609,1 28701,0 28743,1 28756,0 28770,1 28855,0 28949,1 29002,0 29008,1 29091,0 29171,1 29194,0 29215,1 29289,0 29296,1 29324,0 29338,1 29383,0 29473,1 29555,0 29604,1 29669,0 29712,1 29743,0 29783,1 29828,0 29904,1 29920,0 30009,1 30044,0 30073,1 30149,0 30241,1 30269,0 30341,1 30409,0 30410,1 30470,0 30497,1 30576,0 30641,1 30650,0 30736,1 30775,0 30837,1 30845,0 30926,1 30935,0 31012,1 31019,0 31081,1 31171,0 31187,1 31257,0 31272,1 31329,0 31417,1 31456,0 31555,1 31582,0 31661,1 31754,0 31785,1 31791,0 31864,1 31875,0 31877,1 31925,0 32002,1 32010,0 32096,1 32135,0 32223,1 32280,0 32294,1 32378,0 32381,1 32430,0 32446,1 32462,0 32543,1 32630,0 32659,1 32724,0 32770,1 32795,0 32851,1 32875,0 32912,1 32971,0 33028,1 33047,0 33054,1 33136,0 33213,1 33239,0 33306,1 33354,0 33442,1 33512,0 33591,1 33603,0 33657,1 33688,0 33693,1 33735,0 33803,1 33860,0 33881,1 33932,0 33986,1 33988,0 34015,1 34032,0 34107,1 34152,0 34178,1 34199,0 34235,1 34312,0 34405,1 34409,0 34473,1 34502,0 34588,1 34663,0 34705,1 34775,0 34829,1 34850,0 34889,1 34961,0 35011,1 35093,0 35139,1 35209,0 35222,1 35266,0 35346,1 35367,0 35436,1 35438,0 35479,1 35480,0 35566,1 35654,0 35705,1 35761,0 35810,1 35817,0 35865,1 35919,0 35955,1 36017,0 36040,1 36081,0 36082,1 36158,0 36172,1 36208,0 36308,1 36354,0 36443,1 36453,0 36501,1 36594,0 36691,1 36781,0 36818,1 36844,0 36862,1 36892,0 36959,1 37058,0 37110,1 37184,0 37279,1 37310,0 37339,1 37359,0 37365,1 37457,0 37470,1 37535,0 37568,1 37650,0 37664,1 37677,0 37726,1 37816,0 37842,1 37924,0 37973,1 38016,0 38045,1 38082,0 38126,1 38219,0 38304,1 38361,0 38453,1 38458,0 38535,1 38537,0 38633,1 38707,0 38751,1 38778,0 38845,1 38871,0 38909,1 38969,0 39069,1 39102,0 39127,1 39130,0 39184,1 39205,0 39304,1 39360,0 39454,1 39514,0 39573,1 39595,0 39644,1 39687,0 39761,1 39762,0 39823,1 39869,0 39895,1 39935,0 40021,1 40069,0 40167,1 40250,0 40282,1 40381,0 40390,1 40434,0 40478,1 40557,0 40615,1 40674,0 40697,1 40789,0 40805,1 40837,0 40912,1 40950,0 41028,1 41065,0 41071,1 41087,0 41142,1 41208,0 41271,1 41371,0 41462,1 41490,0 41586,1 41642,0 41646,1 41732,0 41754,1 41771,0 41853,1 41894,0 41991,1 42046,0 42116,1 42215,0 42288,1 42318,0 42326,1 42353,0 42390,1 42478,0 42539,1 42560,0 42651,1 42711,0 42773,1 42814,0 42837,1 42840,0 42936,1 42994,0 42998,1 43051,0 43110,1 43137,0 43222,1 43242,0 43318,1 43379,0 43415,1 43447,0 43479,1 43541,0 43586,1 43653,0 43710,1 43789,0 43810,1 43838,0 43921,1 43929,0 43959,1 43967,0 44059,1 44106,0 44201,1 44301,0 44401,1 44450,0 44531,1 44545,0 44551,1 44607,0 44666,1 44749,0 44843,1 44917,0 44966,1 45022,0 45026,1 45120,0 45157,1 45249,0 45329,1 45405,0 45460,1 45468,0 45506,1 45589,0 45601,1 45635,0 45718,1 45720,0 45795,1 45823,0 45891,1 45933,0 46020,1 46069,0 46094,1 46177,0 46259,1 46261,0 46271,1 46280,0 46320,1 46343,0 46345,1 46366,0 46456,1 46525,0 46596,1 46674,0 46760,1 46770,0 46825,1 46899,0 46977,1 47051,0 47080,1 47126,0 47138,1 47235,0 47332,1 47358,0 47418,1 47495,0 47537,1 47554,0 47594,1 47607,0 47654,1 47715,0 47744,1 47844,0 47860,1 47946,0 47965,1 48024,0 48120,1 48204,0 48262,1 48356,0 48374,1 48457,0 48530,1 48541,0 48566,1 48636,0 48712,1 48729,0 48781,1 48805,0 48827,1 48882,0 48957,1 49046,0 49070,1 49091,0 49178,1 49199,0 49294,1 49325,0 49389,1 49408,0 49494,1 49509,0 49569,1 49655,0 49752,1 49844,0 49890,1 49951,0 50024,1 50091,0 50159,1 50185,0 50221,1 50253,0 50340,1 50386,0 50406,1 50464,0 50547,1 50553,0 50583,1 50587,0 50646,1 50658,0 50715,1 50804,0 50826,1 end initlist b20 0,0 85,1 103,0 132,1 167,0 214,1 234,0 268,1 333,0 343,1 387,0 475,1 569,0 584,1 605,0 684,1 756,0 805,1 874,0 969,1 998,0 1039,1 1119,0 1176,1 1213,0 1310,1 1378,0 1478,1 1577,0 1625,1 1645,0 1656,1 1753,0 1850,1 1932,0 1997,1 2050,0 2140,1 2201,0 2207,1 2278,0 2298,1 2384,0 2463,1 2554,0 2654,1 2751,0 2806,1 2840,0 2892,1 2982,0 3068,1 3102,0 3126,1 3198,0 3255,1 3307,0 3325,1 3350,0 3378,1 3404,0 3467,1 3486,0 3497,1 3571,0 3630,1 3642,0 3649,1 3738,0 3800,1 3839,0 3872,1 3951,0 3993,1 4055,0 4128,1 4140,0 4191,1 4223,0 4248,1 4317,0 4358,1 4439,0 4531,1 4601,0 4616,1 4620,0 4713,1 4717,0 4797,1 4865,0 4961,1 4976,0 4985,1 5078,0 5079,1 5144,0 5227,1 5282,0 5378,1 5413,0 5440,1 5494,0 5527,1 5584,0 5657,1 5673,0 5767,1 5854,0 5864,1 5924,0 5932,1 5968,0 5995,1 6086,0 6141,1 6148,0 6232,1 6300,0 6370,1 6392,0 6470,1 6489,0 6496,1 6498,0 6554,1 6629,0 6667,1 6745,0 6807,1 6823,0 6875,1 6892,0 6982,1 6993,0 7012,1 7078,0 7102,1 7176,0 7215,1 7222,0 7244,1 7312,0 7403,1 7502,0 7544,1 7570,0 7657,1 7687,0 7689,1 7728,0 7731,1 7767,0 7820,1 7857,0 7903,1 7995,0 8015,1 8065,0 8138,1 8144,0 8225,1 8237,0 8291,1 8301,0 8361,1 8445,0 8491,1 8548,0 8612,1 8659,0 8731,1 8786,0 8848,1 8938,0 8968,1 9038,0 9137,1 9215,0 9306,1 9380,0 9451,1 9471,0 9509,1 9534,0 9614,1 9678,0 9731,1 9749,0 9799,1 9886,0 9956,1 9987,0 9996,1 9997,0 10069,1 10088,0 10104,1 10161,0 10239,1 10308,0 10322,1 10342,0 10367,1 10370,0 10407,1 10492,0 10525,1 10599,0 10678,1 10735,0 10785,1 10840,0 10939,1 11027,0 11050,1 11150,0 11169,1 11233,0 11241,1 11337,0 11349,1 11434,0 11453,1 11527,0 11546,1 11565,0 11637,1 11697,0 11749,1 11843,0 11860,1 11871,0 11895,1 11965,0 12005,1 12041,0 12060,1 12118,0 12193,1 12196,0 12253,1 12318,0 12338,1 12368,0 12434,1 12526,0 12588,1 12662,0 12760,1 12793,0 12889,1 12916,0 12939,1 13010,0 13019,1 13069,0 13074,1 13174,0 13236,1 13251,0 13273,1 13344,0 13400,1 13446,0 13456,1 13525,0 13539,1 13587,0 13636,1 13694,0 13782,1 13868,0 13921,1 13976,0 14070,1 14113,0 14134,1 14183,0 14206,1 14293,0 14347,1 14352,0 14451,1 14453,0 14547,1 14568,0 14576,1 14655,0 14670,1 14676,0 14706,1 14789,0 14848,1 14898,0 14992,1 15043,0 15118,1 15130,0 15227,1 15284,0 15354,1 15382,0 15470,1 15518,0 15546,1 15597,0 15663,1 15665,0 15744,1 15837,0 15866,1 15871,0 15874,1 15897,0 15947,1 15987,0 16007,1 16051,0 16141,1 16240,0 16318,1 16345,0 16354,1 16355,0 16361,1 16380,0 16453,1 16535,0 16619,1 16657,0 16734,1 16830,0 16870,1 16901,0 16978,1 17069,0 17166,1 17213,0 17280,1 17331,0 17380,1 17403,0 17503,1 17577,0 17655,1 17665,0 17693,1 17732,0 17804,1 17874,0 17950,1 17979,0 18043,1 18044,0 18076,1 18142,0 18153,1 18208,0 18288,1 18308,0 18341,1 18407,0 18436,1 18463,0 18532,1 18552,0 18630,1 18689,0 18786,1 18840,0 18844,1 18909,0 18968,1 18969,0 19046,1 19101,0 19191,1 19289,0 19296,1 19363,0 19406,1 19413,0 19438,1 19481,0 19504,1 19513,0 19542,1 19569,0 19603,1 19675,0 19740,1 19755,0 19813,1 19844,0 19893,1 19912,0 19947,1 20044,0 20088,1 20110,0 20171,1 20221,0 20287,1 20324,0 20335,1 20386,0 20389,1 20398,0 20454,1 20521,0 20570,1 20618,0 20710,1 20725,0 20757,1 20849,0 20907,1 20982,0 21079,1 21153,0 21178,1 21262,0 21296,1 21311,0 21355,1 21394,0 21441,1 21501,0 21521,1 21525,0 21533,1 21587,0 21641,1 21703,0 21741,1 21837,0 21875,1 21882,0 21962,1 22025,0 22074,1 22114,0 22168,1 22171,0 22219,1 22252,0 22333,1 22361,0 22444,1 22498,0 22522,1 22524,0 22533,1 22585,0 22634,1 22728,0 22812,1 22820,0 22850,1 22884,0 22921,1 22928,0 22932,1 22952,0 22968,1 23015,0 23092,1 23105,0 23190,1 23258,0 23340,1 23366,0 23386,1 23465,0 23509,1 23586,0 23593,1 23622,0 23625,1 23714,0 23730,1 23749,0 23829,1 23899,0 23937,1 23989,0 23993,1 24052,0 24080,1 24119,0 24162,1 24181,0 24250,1 24269,0 24288,1 24350,0 24411,1 24432,0 24434,1 24476,0 24572,1 24661,0 24715,1 24808,0 24848,1 24892,0 24908,1 24933,0 25017,1 25019,0 25104,1 25185,0 25233,1 25269,0 25333,1 25360,0 25423,1 25440,0 25454,1 25516,0 25590,1 25664,0 25668,1 25733,0 25826,1 25827,0 25858,1 25952,0 26040,1 26114,0 26154,1 26194,0 26219,1 26309,0 26365,1 26449,0 26463,1 26520,0 26543,1 26631,0 26703,1 26711,0 26805,1 26817,0 26872,1 26916,0 26936,1 26989,0 27052,1 27059,0 27135,1 27225,0 27291,1 27366,0 27450,1 27535,0 27566,1 27582,0 27652,1 27746,0 27794,1 27833,0 27922,1 27949,0 27998,1 28001,0 28098,1 28184,0 28196,1 28217,0 28240,1 28259,0 28303,1 28344,0 28386,1 28426,0 28509,1 28522,0 28622,1 28667,0 28755,1 28810,0 28850,1 28909,0 28939,1 29035,0 29128,1 29154,0 29230,1 29288,0 29351,1 29358,0 29375,1 29419,0 29456,1 29488,0 29502,1 29526,0 29539,1 29564,0 29638,1 29685,0 29744,1 29748,0 29812,1 29844,0 29918,1 29978,0 30053,1 30065,0 30074,1 30104,0 30180,1 30218,0 30275,1 30359,0 30364,1 30447,0 30461,1 30516,0 30559,1 30585,0 30593,1 30634,0 30667,1 30686,0 30786,1 30853,0 30921,1 30933,0 30976,1 31011,0 31045,1 31082,0 31087,1 31120,0 31166,1 31172,0 31263,1 31271,0 31347,1 31405,0 31494,1 31518,0 31592,1 31611,0 31646,1 31703,0 31724,1 31771,0 31799,1 31825,0 31827,1 31910,0 31942,1 32025,0 32062,1 32152,0 32160,1 32255,0 32299,1 32394,0 32428,1 32494,0 32513,1 32588,0 32630,1 32697,0 32717,1 32773,0 32867,1 32875,0 32949,1 33027,0 33114,1 33121,0 33148,1 33170,0 33243,1 33340,0 33420,1 33506,0 33606,1 33665,0 33699,1 33752,0 33819,1 33915,0 33984,1 34001,0 34023,1 34047,0 34064,1 34086,0 34139,1 34222,0 34280,1 34352,0 34358,1 34410,0 34452,1 34529,0 34606,1 34636,0 34657,1 34689,0 34749,1 34809,0 34894,1 34969,0 34973,1 34987,0 35054,1 35124,0 35174,1 35178,0 35243,1 35251,0 35274,1 35319,0 35403,1 35438,0 35528,1 35617,0 35634,1 35648,0 35683,1 35692,0 35770,1 35790,0 35848,1 35879,0 35892,1 35908,0 35929,1 36026,0 36114,1 36188,0 36255,1 36259,0 36328,1 36412,0 36418,1 36453,0 36529,1 36600,0 36686,1 36697,0 36725,1 36815,0 36894,1 36994,0 37005,1 37028,0 37061,1 37136,0 37153,1 37218,0 37239,1 37290,0 37294,1 37298,0 37329,1 37330,0 37376,1 37459,0 37513,1 37609,0 37619,1 37683,0 37779,1 37788,0 37843,1 37923,0 37961,1 38016,0 38077,1 38146,0 38175,1 38262,0 38361,1 38386,0 38443,1 38514,0 38545,1 38631,0 38712,1 38724,0 38797,1 38850,0 38895,1 38974,0 39013,1 39028,0 39123,1 39196,0 39234,1 39305,0 39307,1 39355,0 39406,1 39413,0 39490,1 39590,0 39611,1 39701,0 39738,1 39784,0 39788,1 39878,0 39963,1 40034,0 40099,1 40166,0 40192,1 40207,0 40219,1 40286,0 40311,1 40327,0 40367,1 40453,0 40462,1 40547,0 40615,1 40639,0 40646,1 40717,0 40808,1 40859,0 40869,1 40939,0 41005,1 41072,0 41108,1 41147,0 41156,1 41242,0 41276,1 41358,0 41367,1 41394,0 41414,1 41488,0 41553,1 41594,0 41685,1 41766,0 41809,1 41866,0 41896,1 41907,0 41950,1 42010,0 42011,1 42100,0 42119,1 42184,0 42256,1 42291,0 42328,1 42390,0 42443,1 42448,0 42535,1 42619,0 42649,1 42748,0 42799,1 42858,0 42893,1 42932,0 42938,1 43029,0 43114,1 43164,0 43220,1 43233,0 43237,1 43258,0 43301,1 43355,0 43413,1 43494,0 43516,1 43582,0 43590,1 43624,0 43686,1 43751,0 43837,1 43907,0 43919,1 44001,0 44016,1 44059,0 44153,1 44232,0 44249,1 44262,0 44271,1 44337,0 44367,1 44467,0 44561,1 44609,0 44642,1 44681,0 44746,1 44803,0 44862,1 44906,0 44966,1 44974,0 45027,1 45046,0 45073,1 45162,0 45232,1 45256,0 45320,1 45416,0 45513,1 45601,0 45638,1 45736,0 45804,1 45806,0 45829,1 45891,0 45914,1 45937,0 46020,1 46025,0 46079,1 46110,0 46193,1 46269,0 46360,1 46384,0 46438,1 46492,0 46512,1 46548,0 46589,1 46608,0 46645,1 46739,0 46741,1 46813,0 46838,1 46887,0 46961,1 47027,0 47078,1 47080,0 47127,1 47176,0 47178,1 47189,0 47243,1 47266,0 47294,1 47385,0 47412,1 47479,0 47556,1 47632,0 47708,1 47730,0 47760,1 47830,0 47907,1 47985,0 48007,1 48023,0 48028,1 48047,0 48116,1 48133,0 48231,1 48293,0 48391,1 48447,0 48519,1 48550,0 48595,1 48612,0 48635,1 48707,0 48772,1 48820,0 48849,1 48877,0 48934,1 48960,0 48995,1 48999,0 49061,1 49073,0 49125,1 end initlist b21 0,0 73,1 154,0 233,1 286,0 315,1 325,0 391,1 465,0 475,1 489,0 526,1 617,0 641,1 727,0 734,1 782,0 838,1 906,0 972,1 1046,0 1068,1 1128,0 1207,1 1270,0 1368,1 1460,0 1520,1 1561,0 1648,1 1676,0 1699,1 1797,0 1815,1 1869,0 1891,1 1910,0 1949,1 2000,0 2095,1 2110,0 2194,1 2264,0 2283,1 2309,0 2356,1 2435,0 2515,1 2555,0 2640,1 2701,0 2743,1 2770,0 2864,1 2904,0 2954,1 3031,0 3127,1 3208,0 3250,1 3326,0 3404,1 3502,0 3543,1 3568,0 3610,1 3708,0 3795,1 3810,0 3842,1 3925,0 4000,1 4038,0 4134,1 4148,0 4205,1 4265,0 4360,1 4438,0 4500,1 4503,0 4569,1 4618,0 4702,1 4764,0 4780,1 4846,0 4933,1 4956,0 5046,1 5122,0 5212,1 5267,0 5347,1 5397,0 5398,1 5437,0 5535,1 5608,0 5613,1 5649,0 5709,1 5746,0 5755,1 5756,0 5784,1 5788,0 5869,1 5905,0 5978,1 6034,0 6114,1 6154,0 6241,1 6338,0 6390,1 6441,0 6494,1 6555,0 6602,1 6639,0 6672,1 6736,0 6786,1 6795,0 6810,1 6858,0 6922,1 6931,0 6941,1 6998,0 7094,1 7115,0 7198,1 7291,0 7372,1 7451,0 7547,1 7637,0 7719,1 7774,0 7802,1 7808,0 7830,1 7893,0 7954,1 7999,0 8053,1 8106,0 8174,1 8206,0 8273,1 8347,0 8358,1 8384,0 8399,1 8448,0 8525,1 8599,0 8652,1 8725,0 8787,1 8846,0 8933,1 8944,0 8976,1 8995,0 9021,1 9051,0 9105,1 9199,0 9239,1 9320,0 9381,1 9423,0 9432,1 9446,0 9475,1 9534,0 9604,1 9611,0 9616,1 9696,0 9776,1 9860,0 9873,1 9965,0 10027,1 10109,0 10117,1 10166,0 10224,1 10267,0 10284,1 10367,0 10420,1 10460,0 10478,1 10508,0 10591,1 10627,0 10666,1 10761,0 10834,1 10872,0 10957,1 11036,0 11081,1 11100,0 11105,1 11169,0 11191,1 11264,0 11295,1 11377,0 11395,1 11458,0 11523,1 11546,0 11580,1 11628,0 11676,1 11728,0 11785,1 11846,0 11858,1 11940,0 11969,1 11970,0 11988,1 12029,0 12111,1 12142,0 12154,1 12232,0 12307,1 12355,0 12437,1 12504,0 12517,1 12616,0 12657,1 12751,0 12794,1 12880,0 12966,1 13033,0 13116,1 13158,0 13248,1 13334,0 13381,1 13402,0 13420,1 13440,0 13441,1 13485,0 13582,1 13653,0 13701,1 13737,0 13747,1 13785,0 13885,1 13895,0 13940,1 14030,0 14126,1 14179,0 14196,1 14211,0 14277,1 14292,0 14332,1 14349,0 14438,1 14492,0 14498,1 14550,0 14560,1 14614,0 14646,1 14711,0 14755,1 14774,0 14843,1 14898,0 14911,1 14987,0 15030,1 15064,0 15108,1 15113,0 15198,1 15235,0 15286,1 15314,0 15410,1 15479,0 15570,1 15656,0 15698,1 15749,0 15805,1 15879,0 15962,1 16052,0 16109,1 16164,0 16211,1 16290,0 16384,1 16428,0 16429,1 16480,0 16549,1 16638,0 16704,1 16714,0 16777,1 16872,0 16960,1 17038,0 17124,1 17209,0 17217,1 17283,0 17334,1 17398,0 17433,1 17500,0 17522,1 17539,0 17600,1 17683,0 17734,1 17794,0 17797,1 17877,0 17913,1 18010,0 18094,1 18108,0 18121,1 18170,0 18255,1 18334,0 18427,1 18520,0 18554,1 18637,0 18681,1 18715,0 18777,1 18862,0 18939,1 18982,0 19040,1 19075,0 19095,1 19192,0 19251,1 19301,0 19332,1 19387,0 19476,1 19576,0 19671,1 19705,0 19779,1 19790,0 19864,1 19933,0 19947,1 19991,0 19994,1 20017,0 20105,1 20149,0 20205,1 20276,0 20323,1 20406,0 20434,1 20476,0 20527,1 20552,0 20633,1 20667,0 20677,1 20707,0 20754,1 20789,0 20845,1 20846,0 20898,1 20928,0 20990,1 21050,0 21114,1 21173,0 21228,1 21317,0 21390,1 21441,0 21466,1 21497,0 21546,1 21584,0 21610,1 21663,0 21725,1 21735,0 21810,1 21823,0 21852,1 21920,0 21948,1 21996,0 22012,1 22089,0 22093,1 22181,0 22183,1 22236,0 22295,1 22380,0 22392,1 22403,0 22452,1 22483,0 22539,1 22627,0 22662,1 22708,0 22806,1 22827,0 22907,1 22981,0 22992,1 23016,0 23070,1 23141,0 23232,1 23315,0 23385,1 23403,0 23439,1 23466,0 23499,1 23542,0 23619,1 23684,0 23737,1 23746,0 23759,1 23847,0 23893,1 23923,0 23983,1 24006,0 24022,1 24036,0 24111,1 24190,0 24236,1 24296,0 24315,1 24334,0 24390,1 24415,0 24487,1 24570,0 24621,1 24713,0 24779,1 24874,0 24893,1 24951,0 25012,1 25031,0 25050,1 25133,0 25156,1 25196,0 25231,1 25265,0 25339,1 25388,0 25421,1 25481,0 25568,1 25667,0 25750,1 25766,0 25821,1 25902,0 25968,1 26064,0 26127,1 26133,0 26144,1 26150,0 26175,1 26221,0 26256,1 26264,0 26295,1 26300,0 26324,1 26361,0 26414,1 26456,0 26497,1 26525,0 26619,1 26624,0 26654,1 26723,0 26760,1 26837,0 26850,1 26904,0 26977,1 26996,0 27040,1 27054,0 27134,1 27168,0 27266,1 27294,0 27296,1 27382,0 27477,1 27563,0 27633,1 27642,0 27680,1 27684,0 27772,1 27822,0 27885,1 27948,0 27975,1 28026,0 28048,1 28067,0 28160,1 28164,0 28202,1 28277,0 28306,1 28323,0 28409,1 28456,0 28485,1 28576,0 28647,1 28704,0 28737,1 28783,0 28822,1 28897,0 28945,1 28962,0 29051,1 29113,0 29182,1 29183,0 29188,1 29235,0 29283,1 29324,0 29390,1 29453,0 29516,1 29526,0 29574,1 29603,0 29701,1 29742,0 29780,1 29880,0 29924,1 29972,0 30011,1 30075,0 30139,1 30161,0 30248,1 30317,0 30370,1 30460,0 30477,1 30496,0 30583,1 30664,0 30764,1 30855,0 30948,1 30986,0 31046,1 31052,0 31084,1 31159,0 31237,1 31259,0 31274,1 31367,0 31418,1 31423,0 31459,1 31523,0 31556,1 31639,0 31707,1 31727,0 31739,1 31833,0 31877,1 31907,0 31929,1 32013,0 32029,1 32099,0 32124,1 32165,0 32181,1 32241,0 32309,1 32346,0 32378,1 32385,0 32479,1 32544,0 32639,1 32641,0 32678,1 32770,0 32859,1 32942,0 32961,1 33024,0 33118,1 33198,0 33237,1 33328,0 33413,1 33467,0 33484,1 33577,0 33657,1 33695,0 33724,1 33807,0 33829,1 33837,0 33861,1 33897,0 33923,1 33976,0 34019,1 34077,0 34083,1 34120,0 34142,1 34204,0 34304,1 34323,0 34358,1 34370,0 34412,1 34421,0 34510,1 34591,0 34677,1 34728,0 34780,1 34815,0 34819,1 34858,0 34901,1 34938,0 34944,1 34959,0 34963,1 35035,0 35042,1 35142,0 35180,1 35230,0 35308,1 35312,0 35376,1 35390,0 35418,1 35517,0 35567,1 35591,0 35594,1 35611,0 35613,1 35615,0 35651,1 35733,0 35804,1 35848,0 35901,1 35915,0 35975,1 35995,0 36065,1 36067,0 36075,1 36168,0 36256,1 36263,0 36304,1 36348,0 36414,1 36514,0 36535,1 36620,0 36654,1 36732,0 36743,1 36762,0 36831,1 36926,0 36954,1 36988,0 36990,1 37040,0 37100,1 37168,0 37186,1 37270,0 37324,1 37404,0 37436,1 37508,0 37552,1 37621,0 37721,1 37795,0 37806,1 37852,0 37871,1 37971,0 37979,1 38075,0 38171,1 38232,0 38245,1 38285,0 38365,1 38407,0 38472,1 38475,0 38562,1 38633,0 38638,1 38724,0 38817,1 38882,0 38897,1 38978,0 39038,1 39079,0 39124,1 39176,0 39224,1 39249,0 39256,1 39334,0 39338,1 39360,0 39378,1 39418,0 39467,1 39545,0 39598,1 39627,0 39672,1 39688,0 39760,1 39771,0 39866,1 39958,0 39988,1 40012,0 40052,1 40076,0 40142,1 40215,0 40298,1 40347,0 40355,1 40423,0 40441,1 40489,0 40577,1 40625,0 40702,1 40768,0 40774,1 40835,0 40860,1 40944,0 40993,1 41075,0 41076,1 41097,0 41124,1 41221,0 41317,1 41324,0 41420,1 41451,0 41474,1 41563,0 41634,1 41731,0 41804,1 41839,0 41919,1 41983,0 42004,1 42041,0 42049,1 42126,0 42185,1 42276,0 42291,1 42307,0 42340,1 42351,0 42360,1 42369,0 42436,1 42501,0 42511,1 42565,0 42582,1 42672,0 42721,1 42765,0 42809,1 42865,0 42880,1 42949,0 43033,1 43076,0 43089,1 43151,0 43249,1 43335,0 43358,1 43377,0 43454,1 43489,0 43557,1 43609,0 43705,1 43717,0 43795,1 43894,0 43918,1 44017,0 44059,1 44099,0 44142,1 44182,0 44192,1 44283,0 44380,1 44432,0 44501,1 44585,0 44595,1 44686,0 44762,1 44823,0 44917,1 45016,0 45068,1 45138,0 45164,1 45177,0 45191,1 45279,0 45324,1 45338,0 45347,1 45428,0 45526,1 45593,0 45608,1 45632,0 45665,1 45695,0 45779,1 45858,0 45866,1 45883,0 45917,1 45978,0 46041,1 46136,0 46227,1 46307,0 46360,1 46362,0 46460,1 46474,0 46494,1 46570,0 46604,1 46620,0 46626,1 46668,0 46692,1 46736,0 46825,1 46833,0 46921,1 46982,0 46993,1 47032,0 47126,1 47207,0 47283,1 47351,0 47388,1 47400,0 47418,1 47425,0 47430,1 47448,0 47463,1 47544,0 47629,1 47682,0 47698,1 47763,0 47787,1 47822,0 47861,1 47870,0 47908,1 47990,0 48011,1 48064,0 48071,1 48077,0 48093,1 48178,0 48256,1 48284,0 48331,1 48364,0 48457,1 48519,0 48587,1 48668,0 48707,1 48782,0 48849,1 48900,0 48987,1 49046,0 49066,1 49158,0 49220,1 49319,0 49385,1 49469,0 49506,1 49530,0 49574,1 49613,0 49644,1 49678,0 49758,1 49791,0 49884,1 49984,0 50080,1 50106,0 50138,1 50144,0 50231,1 50263,0 50321,1 50404,0 50482,1 50528,0 50595,1 50617,0 50669,1 50725,0 50809,1 end initlist b22 0,0 44,1 129,0 141,1 176,0 212,1 290,0 296,1 369,0 378,1 423,0 431,1 460,0 481,1 549,0 610,1 615,0 616,1 714,0 787,1 859,0 885,1 938,0 975,1 1067,0 1142,1 1237,0 1335,1 1413,0 1433,1 1453,0 1544,1 1633,0 1662,1 1724,0 1823,1 1864,0 1911,1 1915,0 1974,1 1976,0 2013,1 2032,0 2040,1 2065,0 2099,1 2196,0 2270,1 2313,0 2326,1 2409,0 2503,1 2554,0 2611,1 2703,0 2759,1 2791,0 2844,1 2914,0 2953,1 2984,0 3015,1 3056,0 3146,1 3165,0 3222,1 3269,0 3365,1 3429,0 3501,1 3589,0 3647,1 3656,0 3753,1 3811,0 3838,1 3868,0 3933,1 3951,0 4022,1 4114,0 4152,1 4160,0 4260,1 4300,0 4310,1 4342,0 4434,1 4484,0 4536,1 4617,0 4699,1 4753,0 4771,1 4828,0 4840,1 4937,0 4997,1 5097,0 5133,1 5229,0 5312,1 5380,0 5409,1 5439,0 5458,1 5517,0 5568,1 5641,0 5666,1 5690,0 5779,1 5869,0 5950,1 6041,0 6133,1 6225,0 6282,1 6329,0 6403,1 6442,0 6491,1 6560,0 6634,1 6733,0 6762,1 6825,0 6833,1 6864,0 6895,1 6958,0 7037,1 7053,0 7060,1 7084,0 7094,1 7095,0 7189,1 7208,0 7272,1 7290,0 7358,1 7372,0 7402,1 7425,0 7460,1 7543,0 7608,1 7640,0 7660,1 7752,0 7833,1 7865,0 7905,1 8002,0 8043,1 8074,0 8097,1 8167,0 8222,1 8255,0 8351,1 8354,0 8399,1 8403,0 8446,1 8458,0 8527,1 8583,0 8645,1 8720,0 8724,1 8765,0 8828,1 8893,0 8948,1 9037,0 9051,1 9052,0 9073,1 9093,0 9163,1 9217,0 9236,1 9336,0 9350,1 9430,0 9442,1 9446,0 9507,1 9593,0 9677,1 9711,0 9763,1 9812,0 9896,1 9962,0 9976,1 10017,0 10110,1 10152,0 10191,1 10225,0 10245,1 10269,0 10347,1 10394,0 10411,1 10483,0 10542,1 10616,0 10675,1 10717,0 10724,1 10793,0 10877,1 10961,0 11038,1 11077,0 11150,1 11231,0 11267,1 11352,0 11430,1 11473,0 11492,1 11544,0 11576,1 11578,0 11602,1 11645,0 11741,1 11818,0 11915,1 11976,0 12054,1 12059,0 12079,1 12127,0 12208,1 12308,0 12399,1 12438,0 12507,1 12581,0 12622,1 12675,0 12756,1 12761,0 12834,1 12861,0 12949,1 12986,0 13071,1 13072,0 13146,1 13246,0 13295,1 13336,0 13349,1 13429,0 13471,1 13552,0 13554,1 13580,0 13670,1 13726,0 13799,1 13847,0 13917,1 13970,0 14042,1 14050,0 14095,1 14157,0 14254,1 14327,0 14384,1 14387,0 14420,1 14431,0 14487,1 14561,0 14623,1 14624,0 14645,1 14745,0 14766,1 14842,0 14891,1 14898,0 14925,1 14980,0 15074,1 15123,0 15169,1 15201,0 15237,1 15323,0 15413,1 15485,0 15574,1 15597,0 15607,1 15683,0 15725,1 15728,0 15744,1 15786,0 15873,1 15881,0 15912,1 16012,0 16070,1 16082,0 16150,1 16234,0 16291,1 16374,0 16425,1 16485,0 16548,1 16624,0 16698,1 16794,0 16880,1 16892,0 16937,1 16982,0 17016,1 17021,0 17089,1 17183,0 17194,1 17222,0 17294,1 17387,0 17432,1 17434,0 17509,1 17534,0 17584,1 17615,0 17708,1 17789,0 17799,1 17809,0 17813,1 17865,0 17915,1 17978,0 17980,1 18077,0 18147,1 18159,0 18235,1 18287,0 18312,1 18356,0 18447,1 18467,0 18512,1 18540,0 18559,1 18591,0 18599,1 18687,0 18732,1 18807,0 18863,1 18883,0 18931,1 18998,0 19015,1 19021,0 19076,1 19085,0 19142,1 19238,0 19275,1 19353,0 19387,1 19464,0 19523,1 19541,0 19577,1 19585,0 19617,1 19650,0 19736,1 19828,0 19843,1 19854,0 19864,1 19866,0 19906,1 19936,0 19984,1 20048,0 20057,1 20072,0 20167,1 20255,0 20312,1 20325,0 20359,1 20459,0 20524,1 20580,0 20605,1 20694,0 20750,1 20785,0 20859,1 20927,0 20967,1 20980,0 21064,1 21077,0 21138,1 21166,0 21223,1 21272,0 21344,1 21373,0 21402,1 21422,0 21510,1 21542,0 21554,1 21603,0 21702,1 21800,0 21817,1 21841,0 21847,1 21917,0 21988,1 22081,0 22105,1 22173,0 22260,1 22269,0 22286,1 22367,0 22375,1 22379,0 22380,1 22479,0 22502,1 22543,0 22634,1 22663,0 22713,1 22766,0 22858,1 22861,0 22933,1 22970,0 23020,1 23101,0 23122,1 23144,0 23154,1 23186,0 23200,1 23246,0 23328,1 23332,0 23364,1 23383,0 23399,1 23442,0 23517,1 23528,0 23537,1 23614,0 23628,1 23700,0 23796,1 23829,0 23916,1 23928,0 23961,1 23971,0 24049,1 24137,0 24198,1 24296,0 24354,1 24385,0 24453,1 24527,0 24534,1 24627,0 24700,1 24755,0 24814,1 24876,0 24938,1 24943,0 25029,1 25060,0 25150,1 25249,0 25344,1 25427,0 25523,1 25615,0 25676,1 25774,0 25815,1 25833,0 25868,1 25957,0 26051,1 26146,0 26246,1 26263,0 26324,1 26365,0 26429,1 26489,0 26551,1 26585,0 26685,1 26701,0 26776,1 26828,0 26853,1 26906,0 27005,1 27089,0 27157,1 27180,0 27213,1 27286,0 27370,1 27449,0 27540,1 27593,0 27677,1 27726,0 27771,1 27823,0 27892,1 27927,0 28010,1 28099,0 28136,1 28149,0 28192,1 28195,0 28198,1 28265,0 28275,1 28316,0 28384,1 28477,0 28533,1 28583,0 28635,1 28661,0 28670,1 28707,0 28795,1 28871,0 28966,1 29063,0 29141,1 29150,0 29248,1 29321,0 29368,1 29432,0 29471,1 29545,0 29547,1 29613,0 29666,1 29765,0 29811,1 29841,0 29903,1 29988,0 30015,1 30102,0 30131,1 30210,0 30261,1 30297,0 30336,1 30366,0 30462,1 30538,0 30566,1 30611,0 30633,1 30698,0 30701,1 30710,0 30723,1 30789,0 30880,1 30907,0 30938,1 30996,0 31068,1 31121,0 31167,1 31201,0 31232,1 31246,0 31323,1 31382,0 31416,1 31483,0 31489,1 31583,0 31585,1 31630,0 31700,1 31735,0 31785,1 31884,0 31894,1 31896,0 31982,1 32023,0 32029,1 32115,0 32136,1 32183,0 32221,1 32238,0 32301,1 32308,0 32309,1 32373,0 32381,1 32451,0 32511,1 32605,0 32702,1 32780,0 32861,1 32891,0 32957,1 33012,0 33041,1 33089,0 33105,1 33174,0 33194,1 33272,0 33334,1 33432,0 33449,1 33491,0 33530,1 33535,0 33544,1 33586,0 33600,1 33671,0 33740,1 33756,0 33761,1 33783,0 33792,1 33833,0 33922,1 33966,0 33973,1 33983,0 34021,1 34038,0 34136,1 34146,0 34153,1 34247,0 34322,1 34415,0 34462,1 34463,0 34498,1 34571,0 34597,1 34660,0 34680,1 34736,0 34760,1 34794,0 34810,1 34863,0 34912,1 34980,0 35029,1 35120,0 35184,1 35263,0 35332,1 35357,0 35455,1 35511,0 35583,1 35623,0 35679,1 35747,0 35752,1 35782,0 35850,1 35930,0 35949,1 35995,0 36039,1 36046,0 36093,1 36116,0 36157,1 36172,0 36264,1 36294,0 36361,1 36403,0 36486,1 36517,0 36609,1 36700,0 36746,1 36803,0 36821,1 36831,0 36901,1 36946,0 37031,1 37044,0 37139,1 37200,0 37252,1 37307,0 37345,1 37356,0 37418,1 37451,0 37549,1 37587,0 37660,1 37690,0 37698,1 37706,0 37801,1 37816,0 37824,1 37858,0 37875,1 37901,0 37906,1 37966,0 38024,1 38100,0 38161,1 38256,0 38299,1 38379,0 38443,1 38518,0 38519,1 38523,0 38584,1 38659,0 38720,1 38786,0 38858,1 38889,0 38904,1 38976,0 38987,1 39036,0 39090,1 39150,0 39157,1 39173,0 39225,1 39265,0 39326,1 39414,0 39454,1 39519,0 39580,1 39642,0 39689,1 39783,0 39863,1 39918,0 40013,1 40047,0 40131,1 40198,0 40287,1 40297,0 40303,1 40358,0 40426,1 40510,0 40594,1 40675,0 40679,1 40735,0 40823,1 40916,0 40975,1 41052,0 41109,1 41195,0 41207,1 41234,0 41249,1 41343,0 41365,1 41459,0 41522,1 41581,0 41618,1 41698,0 41720,1 41755,0 41829,1 41867,0 41914,1 41915,0 42000,1 42095,0 42173,1 42238,0 42308,1 42319,0 42382,1 42443,0 42495,1 42516,0 42601,1 42602,0 42606,1 42698,0 42768,1 42857,0 42869,1 42906,0 42951,1 43025,0 43070,1 43169,0 43253,1 43266,0 43325,1 43424,0 43465,1 43542,0 43555,1 43604,0 43687,1 43716,0 43788,1 43843,0 43860,1 43890,0 43912,1 43965,0 43974,1 44045,0 44104,1 44182,0 44231,1 44275,0 44373,1 44438,0 44439,1 44471,0 44473,1 44558,0 44568,1 44631,0 44706,1 44796,0 44895,1 44975,0 45005,1 45097,0 45123,1 45162,0 45209,1 45286,0 45326,1 45360,0 45412,1 45457,0 45547,1 45624,0 45649,1 45742,0 45824,1 45863,0 45956,1 45976,0 45993,1 46057,0 46145,1 46173,0 46261,1 46359,0 46425,1 46521,0 46539,1 46563,0 46570,1 46571,0 46662,1 46687,0 46763,1 46812,0 46857,1 46947,0 46953,1 47041,0 47071,1 47146,0 47209,1 47278,0 47318,1 47336,0 47340,1 47367,0 47397,1 47436,0 47443,1 47525,0 47596,1 47640,0 47708,1 47778,0 47834,1 47836,0 47847,1 47870,0 47891,1 47902,0 47942,1 48004,0 48085,1 48147,0 48148,1 48222,0 48313,1 48382,0 48467,1 48557,0 48604,1 48662,0 48681,1 48726,0 48823,1 48840,0 48865,1 48954,0 49033,1 49091,0 49115,1 49127,0 49165,1 49246,0 49322,1 49363,0 49376,1 49468,0 49472,1 49561,0 49563,1 49609,0 49707,1 49709,0 49731,1 49780,0 49830,1 49898,0 49980,1 50061,0 50103,1 50163,0 50179,1 50268,0 50363,1 50395,0 50492,1 50582,0 50583,1 50617,0 50710,1 50754,0 50797,1 50886,0 50931,1 end initlist b23 0,0 98,1 147,0 162,1 178,0 237,1 319,0 413,1 507,0 567,1 649,0 664,1 670,0 680,1 705,0 709,1 760,0 810,1 885,0 939,1 961,0 1008,1 1036,0 1071,1 1138,0 1229,1 1263,0 1281,1 1379,0 1382,1 1403,0 1466,1 1477,0 1543,1 1628,0 1692,1 1721,0 1820,1 1919,0 1962,1 2050,0 2086,1 2161,0 2231,1 2280,0 2293,1 2380,0 2414,1 2503,0 2507,1 2529,0 2592,1 2666,0 2712,1 2787,0 2853,1 2873,0 2906,1 2964,0 2996,1 3078,0 3156,1 3220,0 3255,1 3262,0 3320,1 3366,0 3367,1 3415,0 3492,1 3548,0 3597,1 3673,0 3689,1 3754,0 3834,1 3918,0 3991,1 4001,0 4066,1 4154,0 4183,1 4222,0 4273,1 4315,0 4334,1 4409,0 4503,1 4510,0 4602,1 4606,0 4636,1 4685,0 4769,1 4772,0 4831,1 4869,0 4884,1 4957,0 4984,1 5003,0 5050,1 5117,0 5158,1 5239,0 5257,1 5292,0 5294,1 5323,0 5339,1 5367,0 5455,1 5483,0 5529,1 5535,0 5566,1 5595,0 5678,1 5755,0 5794,1 5879,0 5926,1 5999,0 6011,1 6068,0 6081,1 6158,0 6244,1 6250,0 6301,1 6348,0 6398,1 6419,0 6490,1 6590,0 6648,1 6673,0 6689,1 6755,0 6775,1 6838,0 6895,1 6926,0 6989,1 7062,0 7121,1 7133,0 7165,1 7184,0 7212,1 7282,0 7345,1 7390,0 7398,1 7429,0 7437,1 7442,0 7443,1 7444,0 7473,1 7562,0 7614,1 7669,0 7683,1 7734,0 7735,1 7797,0 7846,1 7921,0 7938,1 7939,0 7976,1 8058,0 8107,1 8159,0 8221,1 8222,0 8248,1 8308,0 8408,1 8471,0 8566,1 8635,0 8636,1 8691,0 8761,1 8771,0 8781,1 8790,0 8863,1 8901,0 8974,1 9072,0 9105,1 9111,0 9196,1 9254,0 9303,1 9359,0 9406,1 9446,0 9461,1 9491,0 9550,1 9612,0 9660,1 9664,0 9732,1 9778,0 9783,1 9842,0 9934,1 9965,0 10032,1 10051,0 10141,1 10194,0 10256,1 10289,0 10296,1 10320,0 10353,1 10412,0 10508,1 10565,0 10649,1 10699,0 10758,1 10850,0 10880,1 10964,0 11028,1 11068,0 11111,1 11143,0 11237,1 11332,0 11369,1 11378,0 11409,1 11492,0 11508,1 11541,0 11542,1 11552,0 11609,1 11656,0 11695,1 11760,0 11785,1 11825,0 11888,1 11938,0 11980,1 11989,0 12039,1 12097,0 12162,1 12209,0 12235,1 12240,0 12329,1 12349,0 12405,1 12427,0 12515,1 12553,0 12585,1 12627,0 12702,1 12777,0 12859,1 12872,0 12952,1 12965,0 13042,1 13116,0 13121,1 13152,0 13248,1 13325,0 13397,1 13446,0 13456,1 13553,0 13599,1 13654,0 13697,1 13736,0 13835,1 13879,0 13929,1 13976,0 14074,1 14097,0 14193,1 14246,0 14263,1 14317,0 14360,1 14411,0 14417,1 14486,0 14581,1 14672,0 14753,1 14809,0 14888,1 14967,0 15039,1 15055,0 15113,1 15132,0 15224,1 15229,0 15303,1 15323,0 15404,1 15450,0 15531,1 15563,0 15575,1 15670,0 15683,1 15720,0 15764,1 15803,0 15837,1 15894,0 15955,1 15958,0 16021,1 16117,0 16204,1 16238,0 16264,1 16332,0 16431,1 16466,0 16483,1 16534,0 16581,1 16633,0 16706,1 16716,0 16748,1 16819,0 16833,1 16854,0 16889,1 16940,0 16956,1 16997,0 17070,1 17160,0 17228,1 17247,0 17326,1 17345,0 17406,1 17441,0 17450,1 17474,0 17564,1 17646,0 17727,1 17732,0 17812,1 17874,0 17933,1 17999,0 18034,1 18126,0 18169,1 18247,0 18338,1 18357,0 18369,1 18378,0 18386,1 18408,0 18492,1 18503,0 18553,1 18647,0 18720,1 18753,0 18812,1 18896,0 18966,1 19008,0 19057,1 19080,0 19143,1 19236,0 19304,1 19369,0 19433,1 19497,0 19561,1 19605,0 19670,1 19671,0 19748,1 19822,0 19840,1 19862,0 19864,1 19942,0 19974,1 20070,0 20107,1 20202,0 20287,1 20353,0 20399,1 20408,0 20421,1 20444,0 20495,1 20594,0 20693,1 20744,0 20756,1 20786,0 20788,1 20795,0 20887,1 20933,0 20936,1 21034,0 21104,1 21171,0 21216,1 21273,0 21368,1 21426,0 21496,1 21550,0 21579,1 21596,0 21601,1 21636,0 21654,1 21735,0 21784,1 21786,0 21882,1 21929,0 21959,1 22042,0 22065,1 22143,0 22221,1 22309,0 22337,1 22362,0 22370,1 22447,0 22530,1 22607,0 22650,1 22651,0 22689,1 22778,0 22853,1 22869,0 22911,1 23008,0 23079,1 23133,0 23232,1 23285,0 23370,1 23373,0 23422,1 23466,0 23524,1 23595,0 23690,1 23771,0 23794,1 23894,0 23972,1 24050,0 24150,1 24202,0 24293,1 24387,0 24480,1 24573,0 24673,1 24708,0 24778,1 24843,0 24900,1 24952,0 24973,1 25028,0 25032,1 25097,0 25166,1 25196,0 25275,1 25367,0 25388,1 25472,0 25558,1 25589,0 25668,1 25690,0 25763,1 25801,0 25828,1 25836,0 25844,1 25874,0 25888,1 25933,0 25952,1 26002,0 26003,1 26100,0 26114,1 26131,0 26209,1 26238,0 26276,1 26334,0 26389,1 26440,0 26461,1 26533,0 26557,1 26605,0 26688,1 26783,0 26880,1 26934,0 26971,1 27035,0 27042,1 27059,0 27090,1 27161,0 27247,1 27324,0 27407,1 27495,0 27527,1 27575,0 27674,1 27692,0 27694,1 27719,0 27740,1 27839,0 27851,1 27862,0 27887,1 27979,0 28075,1 28090,0 28131,1 28132,0 28155,1 28179,0 28225,1 28277,0 28290,1 28330,0 28427,1 28453,0 28463,1 28520,0 28556,1 28654,0 28724,1 28775,0 28862,1 28891,0 28952,1 29039,0 29118,1 29175,0 29239,1 29301,0 29319,1 29335,0 29356,1 29453,0 29543,1 29588,0 29604,1 29606,0 29680,1 29713,0 29732,1 29749,0 29821,1 29838,0 29881,1 29908,0 29993,1 30089,0 30100,1 30180,0 30203,1 30275,0 30362,1 30457,0 30546,1 30606,0 30674,1 30696,0 30698,1 30773,0 30791,1 30852,0 30863,1 30867,0 30946,1 30960,0 31010,1 31094,0 31171,1 31220,0 31285,1 31381,0 31434,1 31520,0 31560,1 31620,0 31655,1 31713,0 31747,1 31817,0 31876,1 31965,0 32016,1 32032,0 32086,1 32169,0 32220,1 32293,0 32360,1 32386,0 32476,1 32552,0 32647,1 32722,0 32723,1 32789,0 32815,1 32875,0 32952,1 32978,0 33014,1 33098,0 33173,1 33272,0 33276,1 33327,0 33427,1 33498,0 33586,1 33649,0 33730,1 33755,0 33797,1 33833,0 33901,1 33989,0 34035,1 34036,0 34109,1 34125,0 34170,1 34269,0 34326,1 34417,0 34482,1 34540,0 34626,1 34631,0 34694,1 34717,0 34748,1 34802,0 34871,1 34944,0 35026,1 35118,0 35132,1 35146,0 35155,1 35242,0 35311,1 35398,0 35399,1 35479,0 35575,1 35611,0 35641,1 35663,0 35678,1 35766,0 35850,1 35861,0 35961,1 36020,0 36113,1 36163,0 36206,1 36280,0 36330,1 36395,0 36477,1 36524,0 36602,1 36638,0 36711,1 36745,0 36830,1 36840,0 36885,1 36978,0 37045,1 37113,0 37128,1 37177,0 37231,1 37328,0 37375,1 37430,0 37463,1 37549,0 37633,1 37725,0 37778,1 37858,0 37888,1 37955,0 38014,1 38053,0 38150,1 38229,0 38294,1 38349,0 38390,1 38484,0 38526,1 38621,0 38708,1 38791,0 38827,1 38867,0 38882,1 38883,0 38976,1 39068,0 39136,1 39137,0 39204,1 39276,0 39326,1 39332,0 39423,1 39439,0 39446,1 39514,0 39576,1 39602,0 39625,1 39669,0 39726,1 39814,0 39834,1 39841,0 39923,1 40000,0 40072,1 40124,0 40158,1 40226,0 40316,1 40372,0 40435,1 40515,0 40574,1 40624,0 40626,1 40637,0 40729,1 40744,0 40775,1 40848,0 40914,1 40944,0 40976,1 41055,0 41067,1 41151,0 41245,1 41263,0 41272,1 41280,0 41299,1 41358,0 41370,1 41400,0 41434,1 41465,0 41508,1 41546,0 41561,1 41590,0 41600,1 41657,0 41689,1 41704,0 41776,1 41777,0 41789,1 41805,0 41837,1 41907,0 41945,1 42014,0 42046,1 42133,0 42176,1 42178,0 42181,1 42256,0 42333,1 42365,0 42367,1 42371,0 42433,1 42484,0 42506,1 42533,0 42557,1 42587,0 42635,1 42685,0 42727,1 42822,0 42842,1 42924,0 43018,1 43100,0 43176,1 43203,0 43266,1 43330,0 43382,1 43451,0 43473,1 43570,0 43637,1 43659,0 43683,1 43714,0 43761,1 43764,0 43816,1 43914,0 43922,1 43988,0 44053,1 44061,0 44157,1 44174,0 44209,1 44298,0 44346,1 44352,0 44392,1 44485,0 44530,1 44604,0 44678,1 44740,0 44814,1 44846,0 44912,1 44930,0 44939,1 44989,0 45043,1 45077,0 45157,1 45212,0 45311,1 45371,0 45392,1 45457,0 45546,1 45646,0 45675,1 45729,0 45745,1 45801,0 45891,1 45904,0 45918,1 45945,0 45988,1 46029,0 46096,1 46115,0 46161,1 46214,0 46258,1 46309,0 46329,1 46410,0 46464,1 46507,0 46519,1 46561,0 46588,1 46682,0 46688,1 46721,0 46754,1 46840,0 46887,1 46892,0 46925,1 47005,0 47030,1 47066,0 47137,1 47164,0 47253,1 47284,0 47367,1 47406,0 47506,1 47595,0 47690,1 47739,0 47765,1 47834,0 47871,1 47936,0 48018,1 48105,0 48178,1 48201,0 48217,1 48314,0 48322,1 48357,0 48400,1 48412,0 48419,1 48455,0 48533,1 48613,0 48709,1 48715,0 48793,1 48839,0 48931,1 48948,0 49036,1 49057,0 49084,1 49172,0 49173,1 49189,0 49277,1 49324,0 49332,1 49371,0 49415,1 49435,0 49455,1 49461,0 49530,1 49556,0 49557,1 49631,0 49701,1 49795,0 49816,1 49820,0 49917,1 49939,0 50019,1 50039,0 50117,1 50146,0 50151,1 50228,0 50328,1 50366,0 50446,1 end initlist b24 0,0 57,1 61,0 116,1 172,0 222,1 223,0 247,1 281,0 286,1 342,0 387,1 439,0 526,1 548,0 644,1 730,0 736,1 831,0 857,1 931,0 976,1 989,0 1052,1 1115,0 1169,1 1205,0 1217,1 1300,0 1354,1 1446,0 1542,1 1549,0 1598,1 1630,0 1649,1 1681,0 1730,1 1794,0 1884,1 1922,0 1994,1 2084,0 2158,1 2203,0 2242,1 2308,0 2402,1 2428,0 2438,1 2498,0 2575,1 2614,0 2653,1 2694,0 2729,1 2738,0 2759,1 2837,0 2889,1 2911,0 2960,1 3048,0 3113,1 3133,0 3140,1 3142,0 3238,1 3287,0 3363,1 3364,0 3431,1 3472,0 3546,1 3596,0 3667,1 3749,0 3794,1 3854,0 3906,1 3951,0 4031,1 4114,0 4171,1 4229,0 4243,1 4288,0 4387,1 4431,0 4476,1 4487,0 4550,1 4592,0 4660,1 4694,0 4783,1 4879,0 4916,1 4981,0 5080,1 5173,0 5185,1 5208,0 5292,1 5308,0 5319,1 5399,0 5429,1 5493,0 5587,1 5641,0 5738,1 5793,0 5824,1 5893,0 5941,1 5956,0 6011,1 6086,0 6128,1 6139,0 6151,1 6159,0 6220,1 6224,0 6304,1 6343,0 6422,1 6491,0 6573,1 6619,0 6685,1 6773,0 6836,1 6898,0 6936,1 7017,0 7038,1 7095,0 7107,1 7189,0 7253,1 7345,0 7420,1 7429,0 7446,1 7451,0 7462,1 7525,0 7582,1 7608,0 7609,1 7697,0 7787,1 7823,0 7834,1 7878,0 7902,1 7969,0 8005,1 8021,0 8112,1 8144,0 8145,1 8241,0 8261,1 8340,0 8381,1 8437,0 8461,1 8525,0 8575,1 8603,0 8621,1 8641,0 8684,1 8717,0 8723,1 8772,0 8804,1 8901,0 8951,1 8967,0 8977,1 8986,0 9042,1 9135,0 9199,1 9263,0 9315,1 9371,0 9442,1 9502,0 9553,1 9640,0 9730,1 9802,0 9814,1 9821,0 9841,1 9888,0 9982,1 9991,0 9993,1 10065,0 10121,1 10143,0 10217,1 10223,0 10250,1 10335,0 10396,1 10409,0 10444,1 10449,0 10461,1 10480,0 10563,1 10577,0 10646,1 10668,0 10722,1 10729,0 10781,1 10802,0 10827,1 10867,0 10895,1 10935,0 11032,1 11107,0 11129,1 11136,0 11143,1 11170,0 11237,1 11318,0 11392,1 11462,0 11475,1 11486,0 11557,1 11616,0 11713,1 11723,0 11729,1 11765,0 11777,1 11821,0 11831,1 11918,0 11990,1 12065,0 12082,1 12169,0 12213,1 12305,0 12371,1 12470,0 12487,1 12523,0 12588,1 12654,0 12708,1 12717,0 12735,1 12758,0 12796,1 12801,0 12888,1 12889,0 12948,1 12977,0 13049,1 13132,0 13191,1 13278,0 13360,1 13381,0 13462,1 13552,0 13638,1 13671,0 13755,1 13786,0 13850,1 13855,0 13940,1 14000,0 14035,1 14079,0 14161,1 14226,0 14292,1 14343,0 14381,1 14478,0 14493,1 14590,0 14631,1 14728,0 14778,1 14877,0 14975,1 14988,0 15020,1 15046,0 15050,1 15122,0 15132,1 15169,0 15177,1 15235,0 15333,1 15427,0 15471,1 15523,0 15556,1 15561,0 15600,1 15648,0 15740,1 15780,0 15830,1 15852,0 15908,1 15967,0 15968,1 16028,0 16124,1 16141,0 16235,1 16247,0 16296,1 16311,0 16358,1 16361,0 16393,1 16458,0 16498,1 16548,0 16646,1 16730,0 16736,1 16823,0 16882,1 16976,0 17017,1 17071,0 17103,1 17133,0 17134,1 17144,0 17238,1 17267,0 17321,1 17355,0 17423,1 17453,0 17525,1 17603,0 17632,1 17702,0 17750,1 17784,0 17873,1 17959,0 18025,1 18043,0 18131,1 18160,0 18235,1 18263,0 18266,1 18309,0 18361,1 18373,0 18374,1 18474,0 18517,1 18591,0 18623,1 18627,0 18701,1 18739,0 18806,1 18853,0 18951,1 19017,0 19111,1 19206,0 19232,1 19320,0 19352,1 19408,0 19476,1 19552,0 19604,1 19696,0 19776,1 19865,0 19958,1 20057,0 20120,1 20215,0 20273,1 20364,0 20464,1 20520,0 20532,1 20589,0 20670,1 20697,0 20735,1 20820,0 20911,1 20940,0 21017,1 21029,0 21071,1 21112,0 21115,1 21155,0 21182,1 21203,0 21243,1 21312,0 21391,1 21412,0 21461,1 21475,0 21528,1 21602,0 21695,1 21701,0 21794,1 21811,0 21863,1 21891,0 21907,1 21932,0 22012,1 22044,0 22075,1 22099,0 22102,1 22133,0 22154,1 22217,0 22304,1 22350,0 22406,1 22432,0 22494,1 22498,0 22513,1 22582,0 22666,1 22683,0 22736,1 22764,0 22810,1 22841,0 22927,1 22934,0 22999,1 23077,0 23144,1 23170,0 23217,1 23273,0 23359,1 23410,0 23500,1 23518,0 23579,1 23672,0 23684,1 23730,0 23738,1 23774,0 23778,1 23844,0 23934,1 23974,0 24070,1 24123,0 24126,1 24140,0 24203,1 24229,0 24304,1 24376,0 24459,1 24473,0 24545,1 24579,0 24602,1 24693,0 24716,1 24770,0 24819,1 24883,0 24934,1 24967,0 24984,1 25037,0 25113,1 25164,0 25175,1 25208,0 25308,1 25319,0 25333,1 25430,0 25440,1 25459,0 25509,1 25600,0 25607,1 25697,0 25730,1 25817,0 25847,1 25914,0 25979,1 26041,0 26095,1 26176,0 26197,1 26263,0 26318,1 26369,0 26388,1 26461,0 26474,1 26491,0 26569,1 26575,0 26597,1 26678,0 26690,1 26716,0 26733,1 26750,0 26763,1 26837,0 26892,1 26895,0 26987,1 27037,0 27130,1 27133,0 27207,1 27292,0 27376,1 27388,0 27437,1 27471,0 27529,1 27541,0 27630,1 27700,0 27763,1 27811,0 27845,1 27934,0 28000,1 28086,0 28167,1 28233,0 28326,1 28390,0 28424,1 28457,0 28555,1 28627,0 28639,1 28693,0 28753,1 28844,0 28856,1 28870,0 28926,1 29018,0 29106,1 29181,0 29264,1 29277,0 29375,1 29401,0 29431,1 29445,0 29508,1 29575,0 29584,1 29596,0 29682,1 29684,0 29784,1 29870,0 29900,1 29908,0 30002,1 30012,0 30038,1 30096,0 30184,1 30236,0 30292,1 30303,0 30400,1 30402,0 30471,1 30489,0 30498,1 30542,0 30613,1 30646,0 30688,1 30730,0 30770,1 30806,0 30838,1 30914,0 30970,1 31035,0 31044,1 31081,0 31123,1 31132,0 31163,1 31220,0 31246,1 31301,0 31308,1 31356,0 31381,1 31412,0 31427,1 31508,0 31511,1 31569,0 31650,1 31664,0 31701,1 31790,0 31807,1 31850,0 31860,1 31918,0 31970,1 32040,0 32123,1 32207,0 32261,1 32352,0 32364,1 32386,0 32405,1 32438,0 32465,1 32541,0 32542,1 32549,0 32577,1 32596,0 32614,1 32629,0 32726,1 32741,0 32838,1 32910,0 32933,1 32972,0 33070,1 33082,0 33165,1 33225,0 33254,1 33341,0 33404,1 33458,0 33538,1 33563,0 33607,1 33620,0 33706,1 33761,0 33766,1 33809,0 33871,1 33922,0 34001,1 34021,0 34029,1 34112,0 34120,1 34165,0 34206,1 34208,0 34213,1 34244,0 34283,1 34369,0 34423,1 34474,0 34570,1 34572,0 34634,1 34653,0 34714,1 34744,0 34803,1 34854,0 34947,1 34980,0 35009,1 35056,0 35059,1 35153,0 35177,1 35210,0 35258,1 35356,0 35379,1 35418,0 35420,1 35514,0 35576,1 35593,0 35594,1 35595,0 35668,1 35714,0 35778,1 35819,0 35902,1 35941,0 36041,1 36086,0 36119,1 36159,0 36233,1 36321,0 36401,1 36416,0 36473,1 36561,0 36587,1 36621,0 36624,1 36700,0 36701,1 36750,0 36791,1 36889,0 36907,1 36961,0 36971,1 36998,0 37023,1 37112,0 37137,1 37143,0 37213,1 37305,0 37340,1 37379,0 37462,1 37478,0 37561,1 37615,0 37712,1 37757,0 37764,1 37846,0 37915,1 38012,0 38090,1 38190,0 38246,1 38282,0 38354,1 38414,0 38440,1 38444,0 38455,1 38499,0 38518,1 38522,0 38556,1 38564,0 38598,1 38658,0 38743,1 38764,0 38850,1 38889,0 38896,1 38949,0 39013,1 39075,0 39147,1 39155,0 39209,1 39258,0 39260,1 39297,0 39310,1 39376,0 39389,1 39455,0 39487,1 39503,0 39597,1 39622,0 39625,1 39693,0 39730,1 39811,0 39832,1 39885,0 39958,1 40028,0 40120,1 40201,0 40244,1 40258,0 40295,1 40297,0 40369,1 40384,0 40480,1 40523,0 40524,1 40552,0 40632,1 40663,0 40748,1 40764,0 40817,1 40902,0 40916,1 40944,0 41017,1 41079,0 41159,1 41204,0 41294,1 41314,0 41406,1 41501,0 41510,1 41553,0 41572,1 41627,0 41717,1 41729,0 41785,1 41868,0 41922,1 41929,0 41960,1 42032,0 42072,1 42080,0 42082,1 42161,0 42193,1 42290,0 42328,1 42346,0 42419,1 42491,0 42546,1 42599,0 42628,1 42643,0 42704,1 42738,0 42827,1 42830,0 42913,1 42943,0 43034,1 43102,0 43173,1 43197,0 43224,1 43318,0 43403,1 43470,0 43474,1 43554,0 43619,1 43670,0 43715,1 43731,0 43777,1 43805,0 43863,1 43925,0 43950,1 43955,0 43974,1 44070,0 44155,1 44252,0 44318,1 44351,0 44439,1 44472,0 44487,1 44519,0 44591,1 44597,0 44642,1 44733,0 44769,1 44780,0 44859,1 44950,0 45010,1 45081,0 45082,1 45089,0 45120,1 45199,0 45260,1 45287,0 45301,1 45321,0 45370,1 45398,0 45415,1 45507,0 45589,1 45659,0 45720,1 45813,0 45867,1 45918,0 46009,1 46097,0 46107,1 46197,0 46246,1 46315,0 46355,1 46433,0 46472,1 46543,0 46619,1 46655,0 46699,1 46732,0 46771,1 46775,0 46823,1 46840,0 46854,1 46886,0 46913,1 46940,0 47029,1 47106,0 47169,1 47242,0 47269,1 47338,0 47358,1 47373,0 47393,1 47480,0 47538,1 47587,0 47633,1 47723,0 47816,1 47856,0 47932,1 48016,0 48032,1 48112,0 48140,1 48186,0 48247,1 48251,0 48268,1 48341,0 48367,1 48421,0 48516,1 48563,0 48567,1 48569,0 48616,1 48678,0 48740,1 48745,0 48826,1 end initlist b25 0,0 49,1 63,0 147,1 148,0 192,1 258,0 324,1 390,0 416,1 487,0 488,1 581,0 624,1 653,0 681,1 733,0 777,1 800,0 875,1 969,0 1026,1 1094,0 1101,1 1122,0 1160,1 1233,0 1243,1 1315,0 1335,1 1417,0 1438,1 1499,0 1593,1 1685,0 1718,1 1784,0 1834,1 1863,0 1878,1 1893,0 1974,1 2016,0 2085,1 2091,0 2113,1 2168,0 2231,1 2284,0 2337,1 2351,0 2364,1 2391,0 2473,1 2494,0 2577,1 2677,0 2701,1 2715,0 2781,1 2803,0 2868,1 2950,0 2969,1 3039,0 3095,1 3150,0 3167,1 3198,0 3293,1 3298,0 3300,1 3311,0 3342,1 3432,0 3453,1 3459,0 3532,1 3627,0 3660,1 3666,0 3757,1 3835,0 3878,1 3921,0 3928,1 3934,0 3988,1 4051,0 4147,1 4206,0 4250,1 4253,0 4274,1 4347,0 4412,1 4440,0 4470,1 4506,0 4600,1 4649,0 4664,1 4680,0 4699,1 4704,0 4707,1 4768,0 4866,1 4948,0 4997,1 5059,0 5125,1 5214,0 5255,1 5320,0 5362,1 5458,0 5502,1 5589,0 5674,1 5694,0 5718,1 5734,0 5735,1 5775,0 5807,1 5901,0 5975,1 6046,0 6068,1 6137,0 6171,1 6269,0 6337,1 6365,0 6431,1 6510,0 6541,1 6572,0 6629,1 6646,0 6671,1 6762,0 6826,1 6846,0 6870,1 6946,0 7030,1 7080,0 7086,1 7111,0 7188,1 7254,0 7330,1 7388,0 7457,1 7510,0 7511,1 7530,0 7541,1 7625,0 7674,1 7761,0 7769,1 7794,0 7847,1 7889,0 7908,1 7947,0 8009,1 8089,0 8102,1 8104,0 8172,1 8194,0 8218,1 8263,0 8305,1 8379,0 8459,1 8514,0 8525,1 8595,0 8664,1 8675,0 8698,1 8729,0 8784,1 8861,0 8876,1 8951,0 9016,1 9026,0 9053,1 9143,0 9153,1 9164,0 9186,1 9232,0 9312,1 9351,0 9417,1 9513,0 9538,1 9556,0 9584,1 9592,0 9667,1 9692,0 9721,1 9807,0 9895,1 9945,0 9962,1 10001,0 10046,1 10119,0 10184,1 10210,0 10229,1 10302,0 10400,1 10407,0 10455,1 10538,0 10541,1 10599,0 10645,1 10723,0 10765,1 10849,0 10909,1 11009,0 11101,1 11181,0 11244,1 11294,0 11367,1 11461,0 11511,1 11593,0 11658,1 11730,0 11741,1 11791,0 11809,1 11835,0 11845,1 11927,0 11960,1 12033,0 12092,1 12183,0 12236,1 12271,0 12328,1 12366,0 12436,1 12468,0 12534,1 12551,0 12597,1 12672,0 12723,1 12793,0 12819,1 12908,0 12934,1 12989,0 13022,1 13047,0 13107,1 13149,0 13159,1 13251,0 13305,1 13375,0 13440,1 13447,0 13514,1 13566,0 13580,1 13679,0 13745,1 13768,0 13791,1 13858,0 13930,1 13982,0 14000,1 14030,0 14092,1 14159,0 14186,1 14241,0 14268,1 14334,0 14335,1 14410,0 14460,1 14523,0 14533,1 14557,0 14574,1 14601,0 14693,1 14724,0 14816,1 14839,0 14887,1 14961,0 15020,1 15088,0 15145,1 15154,0 15246,1 15254,0 15301,1 15313,0 15325,1 15383,0 15465,1 15511,0 15514,1 15519,0 15552,1 15626,0 15661,1 15726,0 15732,1 15796,0 15847,1 15893,0 15973,1 16064,0 16110,1 16166,0 16177,1 16206,0 16282,1 16347,0 16356,1 16414,0 16430,1 16462,0 16560,1 16585,0 16673,1 16698,0 16736,1 16768,0 16794,1 16883,0 16896,1 16967,0 17009,1 17104,0 17203,1 17208,0 17224,1 17301,0 17345,1 17370,0 17434,1 17441,0 17505,1 17592,0 17648,1 17743,0 17751,1 17817,0 17876,1 17884,0 17899,1 17987,0 18056,1 18086,0 18152,1 18207,0 18262,1 18304,0 18352,1 18355,0 18403,1 18499,0 18553,1 18555,0 18613,1 18656,0 18731,1 18746,0 18764,1 18825,0 18919,1 19012,0 19034,1 19071,0 19170,1 19198,0 19298,1 19303,0 19347,1 19396,0 19459,1 19539,0 19589,1 19624,0 19689,1 19749,0 19757,1 19773,0 19836,1 19882,0 19944,1 19965,0 20042,1 20135,0 20174,1 20253,0 20325,1 20333,0 20336,1 20382,0 20417,1 20446,0 20463,1 20530,0 20557,1 20654,0 20721,1 20783,0 20867,1 20918,0 20963,1 21024,0 21079,1 21138,0 21222,1 21318,0 21369,1 21442,0 21541,1 21630,0 21712,1 21749,0 21823,1 21830,0 21857,1 21940,0 22031,1 22129,0 22221,1 22251,0 22332,1 22396,0 22431,1 22520,0 22593,1 22661,0 22717,1 22786,0 22819,1 22883,0 22959,1 22960,0 23017,1 23023,0 23100,1 23143,0 23194,1 23256,0 23315,1 23400,0 23466,1 23494,0 23581,1 23681,0 23777,1 23835,0 23839,1 23846,0 23898,1 23955,0 23995,1 24002,0 24076,1 24082,0 24107,1 24189,0 24267,1 24344,0 24413,1 24440,0 24475,1 24489,0 24545,1 24634,0 24696,1 24715,0 24794,1 24797,0 24802,1 24823,0 24878,1 24971,0 25065,1 25162,0 25231,1 25265,0 25315,1 25317,0 25371,1 25441,0 25539,1 25625,0 25725,1 25810,0 25832,1 25836,0 25933,1 25986,0 26051,1 26073,0 26120,1 26198,0 26283,1 26370,0 26443,1 26514,0 26530,1 26601,0 26603,1 26676,0 26766,1 26814,0 26815,1 26882,0 26944,1 27009,0 27029,1 27105,0 27188,1 27288,0 27314,1 27410,0 27413,1 27513,0 27568,1 27570,0 27658,1 27663,0 27674,1 27683,0 27780,1 27836,0 27866,1 27896,0 27922,1 27945,0 27984,1 28022,0 28060,1 28098,0 28167,1 28183,0 28262,1 28297,0 28368,1 28417,0 28456,1 28487,0 28517,1 28579,0 28656,1 28698,0 28716,1 28777,0 28854,1 28889,0 28931,1 28979,0 28981,1 29050,0 29110,1 29141,0 29220,1 29296,0 29382,1 29401,0 29494,1 29517,0 29545,1 29572,0 29593,1 29662,0 29692,1 29718,0 29753,1 29853,0 29931,1 29947,0 29970,1 29974,0 30027,1 30122,0 30202,1 30205,0 30245,1 30293,0 30349,1 30367,0 30461,1 30536,0 30585,1 30644,0 30717,1 30771,0 30792,1 30829,0 30913,1 30982,0 31012,1 31028,0 31046,1 31137,0 31237,1 31248,0 31252,1 31272,0 31314,1 31356,0 31420,1 31482,0 31528,1 31536,0 31618,1 31671,0 31694,1 31778,0 31825,1 31907,0 31973,1 31983,0 31988,1 32006,0 32056,1 32067,0 32071,1 32078,0 32079,1 32088,0 32181,1 32194,0 32215,1 32261,0 32291,1 32351,0 32390,1 32431,0 32513,1 32565,0 32612,1 32684,0 32780,1 32822,0 32825,1 32878,0 32880,1 32970,0 33038,1 33049,0 33147,1 33242,0 33278,1 33360,0 33435,1 33514,0 33605,1 33607,0 33654,1 33681,0 33758,1 33781,0 33869,1 33911,0 33982,1 34025,0 34043,1 34109,0 34182,1 34233,0 34263,1 34280,0 34364,1 34453,0 34477,1 34508,0 34569,1 34592,0 34639,1 34728,0 34766,1 34798,0 34886,1 34948,0 35038,1 35115,0 35202,1 35210,0 35251,1 35340,0 35389,1 35410,0 35412,1 35473,0 35555,1 35575,0 35667,1 35671,0 35726,1 35784,0 35854,1 35890,0 35935,1 36022,0 36025,1 36061,0 36111,1 36158,0 36251,1 36280,0 36309,1 36315,0 36393,1 36453,0 36551,1 36617,0 36704,1 36793,0 36847,1 36903,0 36921,1 36968,0 37014,1 37029,0 37116,1 37160,0 37220,1 37241,0 37292,1 37356,0 37417,1 37497,0 37549,1 37592,0 37608,1 37640,0 37723,1 37820,0 37870,1 37957,0 38041,1 38128,0 38212,1 38275,0 38372,1 38388,0 38409,1 38456,0 38496,1 38533,0 38538,1 38563,0 38606,1 38689,0 38780,1 38824,0 38893,1 38944,0 38991,1 39030,0 39055,1 39130,0 39166,1 39212,0 39242,1 39262,0 39300,1 39368,0 39418,1 39496,0 39512,1 39542,0 39608,1 39665,0 39747,1 39782,0 39827,1 39848,0 39854,1 39916,0 39992,1 40050,0 40094,1 40178,0 40230,1 40282,0 40294,1 40322,0 40342,1 40385,0 40460,1 40472,0 40478,1 40549,0 40585,1 40648,0 40651,1 40670,0 40700,1 40795,0 40868,1 40890,0 40940,1 40997,0 41023,1 41123,0 41173,1 41251,0 41317,1 41405,0 41489,1 41529,0 41614,1 41699,0 41733,1 41817,0 41900,1 41935,0 41994,1 42083,0 42151,1 42174,0 42252,1 42280,0 42298,1 42347,0 42394,1 42456,0 42521,1 42534,0 42539,1 42606,0 42684,1 42701,0 42770,1 42793,0 42833,1 42839,0 42906,1 42971,0 43059,1 43118,0 43120,1 43171,0 43175,1 43227,0 43294,1 43339,0 43362,1 43394,0 43479,1 43539,0 43597,1 43685,0 43779,1 43817,0 43907,1 43935,0 43942,1 44023,0 44107,1 44163,0 44208,1 44248,0 44274,1 44309,0 44384,1 44449,0 44532,1 44569,0 44643,1 44698,0 44791,1 44838,0 44879,1 44939,0 45035,1 45119,0 45179,1 45214,0 45255,1 45268,0 45273,1 45303,0 45325,1 45350,0 45444,1 45499,0 45535,1 45566,0 45588,1 45632,0 45718,1 45776,0 45805,1 45866,0 45887,1 45941,0 45967,1 46016,0 46083,1 46119,0 46161,1 46225,0 46239,1 46258,0 46307,1 46406,0 46459,1 46475,0 46498,1 46519,0 46589,1 46669,0 46674,1 46754,0 46848,1 46850,0 46861,1 46917,0 47006,1 47045,0 47081,1 47180,0 47182,1 47188,0 47253,1 47286,0 47357,1 47388,0 47462,1 47516,0 47560,1 47623,0 47692,1 47775,0 47799,1 47885,0 47939,1 47968,0 47973,1 48055,0 48124,1 48146,0 48222,1 48320,0 48334,1 48393,0 48419,1 48517,0 48525,1 48596,0 48638,1 48710,0 48801,1 48851,0 48884,1 48886,0 48959,1 48976,0 49062,1 49101,0 49110,1 49115,0 49164,1 49245,0 49277,1 49360,0 49405,1 49442,0 49531,1 49546,0 49596,1 49649,0 49736,1 49751,0 49829,1 49850,0 49884,1 49932,0 49988,1 end initlist b26 0,0 28,1 60,0 144,1 196,0 237,1 273,0 327,1 404,0 447,1 524,0 543,1 573,0 637,1 705,0 735,1 745,0 824,1 886,0 966,1 1014,0 1085,1 1185,0 1272,1 1356,0 1391,1 1447,0 1512,1 1574,0 1576,1 1614,0 1679,1 1755,0 1762,1 1779,0 1785,1 1825,0 1851,1 1893,0 1896,1 1957,0 1971,1 2015,0 2019,1 2021,0 2091,1 2134,0 2209,1 2289,0 2337,1 2415,0 2497,1 2573,0 2652,1 2716,0 2743,1 2806,0 2820,1 2851,0 2944,1 2976,0 3065,1 3073,0 3130,1 3179,0 3190,1 3261,0 3331,1 3388,0 3411,1 3458,0 3529,1 3578,0 3616,1 3649,0 3652,1 3733,0 3740,1 3802,0 3839,1 3894,0 3979,1 4027,0 4117,1 4175,0 4207,1 4304,0 4332,1 4385,0 4453,1 4511,0 4581,1 4646,0 4652,1 4712,0 4746,1 4775,0 4855,1 4864,0 4958,1 5007,0 5032,1 5049,0 5107,1 5159,0 5181,1 5270,0 5309,1 5403,0 5413,1 5482,0 5542,1 5549,0 5602,1 5604,0 5694,1 5743,0 5744,1 5806,0 5890,1 5911,0 5929,1 6000,0 6058,1 6059,0 6087,1 6089,0 6183,1 6211,0 6219,1 6295,0 6366,1 6454,0 6519,1 6557,0 6643,1 6645,0 6710,1 6761,0 6811,1 6859,0 6886,1 6956,0 7003,1 7102,0 7174,1 7249,0 7344,1 7393,0 7487,1 7555,0 7614,1 7622,0 7678,1 7691,0 7751,1 7784,0 7810,1 7887,0 7967,1 8055,0 8141,1 8147,0 8167,1 8267,0 8358,1 8378,0 8474,1 8523,0 8595,1 8599,0 8639,1 8726,0 8764,1 8852,0 8889,1 8911,0 8978,1 8981,0 9061,1 9122,0 9154,1 9237,0 9314,1 9365,0 9464,1 9504,0 9544,1 9585,0 9606,1 9645,0 9680,1 9776,0 9800,1 9881,0 9949,1 10004,0 10015,1 10049,0 10051,1 10058,0 10077,1 10120,0 10130,1 10142,0 10147,1 10221,0 10312,1 10322,0 10359,1 10407,0 10468,1 10495,0 10519,1 10538,0 10631,1 10708,0 10740,1 10788,0 10819,1 10836,0 10936,1 10952,0 11046,1 11054,0 11084,1 11106,0 11200,1 11261,0 11322,1 11381,0 11423,1 11446,0 11468,1 11548,0 11574,1 11603,0 11619,1 11649,0 11698,1 11775,0 11872,1 11947,0 12023,1 12116,0 12208,1 12249,0 12341,1 12393,0 12464,1 12548,0 12570,1 12605,0 12647,1 12654,0 12712,1 12732,0 12802,1 12882,0 12982,1 13001,0 13056,1 13122,0 13200,1 13203,0 13273,1 13341,0 13411,1 13464,0 13524,1 13620,0 13718,1 13751,0 13777,1 13837,0 13839,1 13897,0 13898,1 13947,0 14005,1 14006,0 14021,1 14105,0 14142,1 14159,0 14164,1 14228,0 14251,1 14285,0 14362,1 14418,0 14467,1 14548,0 14594,1 14602,0 14611,1 14666,0 14717,1 14782,0 14805,1 14849,0 14935,1 14976,0 14982,1 15005,0 15099,1 15149,0 15229,1 15288,0 15313,1 15393,0 15474,1 15558,0 15581,1 15666,0 15747,1 15789,0 15818,1 15826,0 15908,1 15992,0 16043,1 16069,0 16095,1 16158,0 16226,1 16276,0 16300,1 16394,0 16436,1 16448,0 16479,1 16487,0 16497,1 16511,0 16580,1 16623,0 16721,1 16771,0 16844,1 16872,0 16894,1 16978,0 17010,1 17051,0 17122,1 17196,0 17290,1 17339,0 17433,1 17465,0 17542,1 17597,0 17695,1 17793,0 17858,1 17927,0 17932,1 18032,0 18099,1 18152,0 18251,1 18309,0 18314,1 18323,0 18413,1 18420,0 18445,1 18523,0 18598,1 18667,0 18697,1 18788,0 18846,1 18867,0 18933,1 19023,0 19064,1 19070,0 19129,1 19213,0 19305,1 19340,0 19376,1 19431,0 19502,1 19561,0 19567,1 19635,0 19664,1 19752,0 19794,1 19865,0 19871,1 19961,0 19968,1 20033,0 20091,1 20172,0 20248,1 20268,0 20286,1 20370,0 20458,1 20498,0 20518,1 20550,0 20560,1 20565,0 20657,1 20717,0 20736,1 20778,0 20840,1 20882,0 20932,1 21021,0 21063,1 21135,0 21148,1 21230,0 21289,1 21326,0 21360,1 21442,0 21469,1 21489,0 21549,1 21600,0 21618,1 21709,0 21794,1 21805,0 21885,1 21958,0 22033,1 22075,0 22166,1 22197,0 22259,1 22293,0 22346,1 22411,0 22468,1 22519,0 22555,1 22620,0 22665,1 22746,0 22821,1 22873,0 22891,1 22918,0 22920,1 23012,0 23085,1 23152,0 23164,1 23237,0 23291,1 23365,0 23462,1 23549,0 23627,1 23681,0 23753,1 23813,0 23871,1 23897,0 23911,1 23980,0 24067,1 24074,0 24079,1 24139,0 24218,1 24274,0 24313,1 24349,0 24428,1 24523,0 24558,1 24654,0 24688,1 24748,0 24761,1 24794,0 24893,1 24924,0 24933,1 24956,0 25030,1 25105,0 25179,1 25183,0 25198,1 25260,0 25310,1 25336,0 25419,1 25428,0 25436,1 25457,0 25481,1 25556,0 25646,1 25677,0 25734,1 25770,0 25784,1 25873,0 25922,1 25935,0 26035,1 26126,0 26216,1 26299,0 26325,1 26367,0 26452,1 26478,0 26513,1 26557,0 26577,1 26662,0 26708,1 26743,0 26816,1 26887,0 26894,1 26934,0 26999,1 27091,0 27177,1 27221,0 27296,1 27342,0 27442,1 27516,0 27597,1 27626,0 27722,1 27736,0 27754,1 27757,0 27857,1 27929,0 27964,1 28025,0 28042,1 28114,0 28173,1 28272,0 28316,1 28322,0 28373,1 28388,0 28468,1 28562,0 28661,1 28744,0 28778,1 28831,0 28900,1 28997,0 29010,1 29072,0 29097,1 29151,0 29243,1 29288,0 29355,1 29443,0 29448,1 29504,0 29547,1 29596,0 29663,1 29732,0 29794,1 29878,0 29909,1 29963,0 30039,1 30041,0 30097,1 30172,0 30193,1 30202,0 30206,1 30255,0 30324,1 30409,0 30410,1 30418,0 30463,1 30545,0 30621,1 30636,0 30670,1 30683,0 30774,1 30797,0 30873,1 30915,0 31009,1 31101,0 31142,1 31214,0 31222,1 31316,0 31324,1 31369,0 31411,1 31417,0 31512,1 31518,0 31608,1 31680,0 31725,1 31737,0 31823,1 31888,0 31904,1 32000,0 32009,1 32025,0 32073,1 32162,0 32252,1 32290,0 32346,1 32362,0 32380,1 32450,0 32539,1 32635,0 32650,1 32698,0 32737,1 32745,0 32834,1 32852,0 32921,1 32993,0 33074,1 33164,0 33169,1 33257,0 33311,1 33339,0 33382,1 33396,0 33436,1 33536,0 33611,1 33689,0 33740,1 33790,0 33802,1 33873,0 33883,1 33888,0 33927,1 33945,0 34041,1 34044,0 34135,1 34155,0 34196,1 34288,0 34359,1 34438,0 34485,1 34576,0 34662,1 34726,0 34815,1 34877,0 34935,1 34963,0 34996,1 34997,0 35026,1 35036,0 35063,1 35083,0 35173,1 35263,0 35307,1 35308,0 35325,1 35379,0 35469,1 35475,0 35523,1 35577,0 35671,1 35730,0 35744,1 35840,0 35844,1 35921,0 35981,1 36005,0 36009,1 36062,0 36117,1 36208,0 36252,1 36330,0 36378,1 36442,0 36482,1 36569,0 36637,1 36666,0 36759,1 36823,0 36854,1 36954,0 37041,1 37099,0 37197,1 37277,0 37321,1 37404,0 37470,1 37520,0 37563,1 37638,0 37725,1 37770,0 37858,1 37908,0 37943,1 37964,0 37984,1 38070,0 38078,1 38167,0 38182,1 38266,0 38360,1 38424,0 38494,1 38588,0 38670,1 38754,0 38839,1 38866,0 38949,1 38982,0 39053,1 39094,0 39152,1 39230,0 39276,1 39376,0 39400,1 39472,0 39556,1 39612,0 39657,1 39663,0 39702,1 39714,0 39766,1 39833,0 39869,1 39921,0 39930,1 39955,0 40039,1 40107,0 40185,1 40251,0 40255,1 40265,0 40290,1 40379,0 40392,1 40491,0 40538,1 40633,0 40653,1 40719,0 40736,1 40757,0 40800,1 40877,0 40880,1 40936,0 40937,1 41007,0 41052,1 41058,0 41094,1 41147,0 41184,1 41237,0 41305,1 41388,0 41413,1 41468,0 41561,1 41658,0 41740,1 41757,0 41782,1 41816,0 41819,1 41914,0 42004,1 42016,0 42017,1 42029,0 42121,1 42180,0 42247,1 42260,0 42264,1 42314,0 42386,1 42469,0 42547,1 42563,0 42603,1 42680,0 42750,1 42775,0 42805,1 42897,0 42978,1 43029,0 43049,1 43103,0 43177,1 43184,0 43259,1 43351,0 43438,1 43441,0 43507,1 43603,0 43618,1 43669,0 43750,1 43808,0 43809,1 43812,0 43873,1 43930,0 44006,1 44009,0 44098,1 44141,0 44181,1 44208,0 44275,1 44340,0 44425,1 44426,0 44490,1 44537,0 44555,1 44640,0 44655,1 44691,0 44778,1 44872,0 44878,1 44888,0 44975,1 45055,0 45102,1 45160,0 45198,1 45273,0 45297,1 45395,0 45401,1 45437,0 45447,1 45506,0 45592,1 45614,0 45660,1 45686,0 45706,1 45755,0 45837,1 45919,0 45953,1 46017,0 46053,1 46060,0 46074,1 46149,0 46219,1 46263,0 46309,1 46350,0 46400,1 46425,0 46515,1 46547,0 46615,1 46623,0 46686,1 46774,0 46802,1 46812,0 46828,1 46903,0 46917,1 46919,0 46961,1 46984,0 47059,1 47074,0 47085,1 47134,0 47148,1 47203,0 47293,1 47383,0 47397,1 47468,0 47523,1 47547,0 47585,1 47626,0 47686,1 47741,0 47789,1 47810,0 47879,1 47961,0 48055,1 48106,0 48144,1 48178,0 48250,1 48286,0 48351,1 48355,0 48455,1 48524,0 48605,1 48701,0 48792,1 48798,0 48842,1 48941,0 49013,1 49030,0 49107,1 49160,0 49195,1 49266,0 49294,1 49376,0 49416,1 49471,0 49525,1 49567,0 49576,1 49653,0 49742,1 49785,0 49845,1 49895,0 49974,1 50019,0 50070,1 50170,0 50171,1 50245,0 50340,1 50370,0 50388,1 50418,0 50428,1 50451,0 50501,1 50592,0 50653,1 50748,0 50802,1 50830,0 50875,1 50879,0 50897,1 50927,0 50933,1 50971,0 50978,1 51061,0 51066,1 51109,0 51112,1 end initlist b27 0,0 22,1 57,0 90,1 173,0 266,1 349,0 409,1 459,0 529,1 533,0 608,1 656,0 711,1 802,0 868,1 916,0 950,1 1005,0 1042,1 1056,0 1072,1 1098,0 1112,1 1202,0 1246,1 1292,0 1367,1 1436,0 1494,1 1521,0 1592,1 1688,0 1706,1 1777,0 1834,1 1910,0 1923,1 1943,0 1974,1 2058,0 2061,1 2087,0 2107,1 2142,0 2197,1 2254,0 2304,1 2319,0 2387,1 2468,0 2507,1 2551,0 2616,1 2675,0 2741,1 2765,0 2780,1 2861,0 2863,1 2865,0 2930,1 2963,0 3038,1 3084,0 3162,1 3244,0 3247,1 3294,0 3324,1 3352,0 3386,1 3462,0 3515,1 3586,0 3632,1 3693,0 3702,1 3747,0 3826,1 3914,0 3986,1 4045,0 4058,1 4156,0 4178,1 4265,0 4349,1 4377,0 4420,1 4422,0 4504,1 4597,0 4687,1 4746,0 4782,1 4807,0 4861,1 4871,0 4904,1 4921,0 4962,1 5047,0 5065,1 5115,0 5155,1 5176,0 5199,1 5271,0 5370,1 5397,0 5409,1 5449,0 5536,1 5586,0 5631,1 5660,0 5722,1 5724,0 5801,1 5814,0 5900,1 5998,0 6083,1 6171,0 6240,1 6258,0 6290,1 6311,0 6328,1 6344,0 6413,1 6513,0 6532,1 6571,0 6585,1 6606,0 6663,1 6749,0 6811,1 6877,0 6917,1 6983,0 7046,1 7140,0 7167,1 7233,0 7244,1 7273,0 7337,1 7373,0 7393,1 7433,0 7529,1 7533,0 7561,1 7568,0 7666,1 7733,0 7762,1 7862,0 7930,1 7996,0 8036,1 8130,0 8194,1 8271,0 8329,1 8361,0 8376,1 8382,0 8433,1 8519,0 8609,1 8651,0 8744,1 8758,0 8769,1 8852,0 8919,1 8962,0 9028,1 9115,0 9155,1 9180,0 9266,1 9283,0 9301,1 9376,0 9426,1 9489,0 9569,1 9652,0 9663,1 9704,0 9756,1 9818,0 9889,1 9960,0 10001,1 10079,0 10142,1 10191,0 10213,1 10278,0 10350,1 10358,0 10389,1 10408,0 10488,1 10500,0 10502,1 10578,0 10632,1 10658,0 10701,1 10730,0 10738,1 10777,0 10830,1 10863,0 10885,1 10964,0 11056,1 11132,0 11152,1 11186,0 11202,1 11247,0 11304,1 11327,0 11365,1 11394,0 11409,1 11467,0 11564,1 11622,0 11694,1 11716,0 11813,1 11906,0 11945,1 12032,0 12107,1 12184,0 12217,1 12273,0 12324,1 12416,0 12467,1 12556,0 12587,1 12659,0 12754,1 12769,0 12770,1 12771,0 12844,1 12923,0 12936,1 13004,0 13102,1 13190,0 13246,1 13281,0 13331,1 13414,0 13486,1 13520,0 13584,1 13594,0 13644,1 13649,0 13727,1 13827,0 13923,1 13952,0 13997,1 14051,0 14134,1 14197,0 14243,1 14269,0 14284,1 14317,0 14351,1 14419,0 14436,1 14526,0 14597,1 14662,0 14669,1 14747,0 14767,1 14866,0 14928,1 14971,0 14992,1 15067,0 15140,1 15204,0 15207,1 15306,0 15337,1 15365,0 15386,1 15436,0 15441,1 15536,0 15591,1 15642,0 15677,1 15742,0 15743,1 15803,0 15804,1 15849,0 15934,1 15935,0 16010,1 16085,0 16114,1 16195,0 16295,1 16362,0 16373,1 16442,0 16478,1 16556,0 16592,1 16650,0 16707,1 16762,0 16799,1 16879,0 16920,1 16996,0 17051,1 17101,0 17194,1 17276,0 17361,1 17368,0 17389,1 17450,0 17486,1 17555,0 17607,1 17628,0 17648,1 17709,0 17762,1 17801,0 17860,1 17906,0 17941,1 17977,0 18056,1 18152,0 18251,1 18301,0 18357,1 18422,0 18501,1 18582,0 18679,1 18730,0 18739,1 18764,0 18850,1 18891,0 18911,1 18978,0 19003,1 19023,0 19122,1 19179,0 19231,1 19324,0 19349,1 19442,0 19525,1 19527,0 19627,1 19699,0 19705,1 19773,0 19803,1 19844,0 19876,1 19919,0 19983,1 20004,0 20054,1 20104,0 20107,1 20183,0 20193,1 20276,0 20372,1 20434,0 20510,1 20576,0 20647,1 20676,0 20761,1 20787,0 20850,1 20950,0 21045,1 21095,0 21163,1 21171,0 21248,1 21312,0 21339,1 21417,0 21418,1 21514,0 21596,1 21672,0 21685,1 21706,0 21772,1 21862,0 21938,1 22003,0 22095,1 22100,0 22178,1 22244,0 22329,1 22350,0 22356,1 22404,0 22416,1 22458,0 22482,1 22523,0 22544,1 22562,0 22618,1 22633,0 22650,1 22706,0 22757,1 22800,0 22818,1 22909,0 22956,1 23048,0 23130,1 23179,0 23220,1 23268,0 23284,1 23339,0 23362,1 23380,0 23401,1 23403,0 23484,1 23561,0 23577,1 23616,0 23632,1 23666,0 23754,1 23845,0 23866,1 23958,0 23992,1 24044,0 24116,1 24150,0 24196,1 24266,0 24305,1 24329,0 24421,1 24467,0 24493,1 24590,0 24598,1 24678,0 24695,1 24709,0 24736,1 24816,0 24885,1 24967,0 25052,1 25152,0 25212,1 25243,0 25246,1 25345,0 25424,1 25459,0 25476,1 25506,0 25533,1 25615,0 25669,1 25702,0 25759,1 25849,0 25882,1 25927,0 26013,1 26024,0 26111,1 26162,0 26213,1 26239,0 26269,1 26272,0 26311,1 26327,0 26402,1 26437,0 26445,1 26452,0 26483,1 26488,0 26500,1 26555,0 26643,1 26743,0 26792,1 26830,0 26851,1 26923,0 26977,1 27027,0 27029,1 27074,0 27104,1 27113,0 27189,1 27229,0 27261,1 27268,0 27271,1 27289,0 27311,1 27355,0 27443,1 27530,0 27603,1 27604,0 27626,1 27684,0 27773,1 27834,0 27903,1 27980,0 28042,1 28083,0 28169,1 28180,0 28218,1 28237,0 28300,1 28323,0 28369,1 28439,0 28503,1 28545,0 28630,1 28648,0 28665,1 28759,0 28845,1 28847,0 28908,1 29008,0 29049,1 29128,0 29217,1 29276,0 29318,1 29400,0 29475,1 29550,0 29574,1 29657,0 29680,1 29736,0 29794,1 29817,0 29885,1 29934,0 30009,1 30020,0 30036,1 30072,0 30157,1 30196,0 30216,1 30261,0 30307,1 30350,0 30373,1 30399,0 30449,1 30455,0 30474,1 30552,0 30573,1 30591,0 30664,1 30716,0 30777,1 30836,0 30853,1 30900,0 30912,1 30985,0 31041,1 31129,0 31164,1 31201,0 31234,1 31276,0 31363,1 31450,0 31486,1 31514,0 31600,1 31602,0 31688,1 31778,0 31847,1 31905,0 31980,1 32026,0 32065,1 32153,0 32159,1 32218,0 32274,1 32307,0 32402,1 32444,0 32543,1 32559,0 32621,1 32701,0 32727,1 32807,0 32839,1 32933,0 32939,1 33038,0 33047,1 33067,0 33133,1 33231,0 33305,1 33308,0 33329,1 33396,0 33397,1 33464,0 33495,1 33568,0 33576,1 33630,0 33683,1 33751,0 33771,1 33793,0 33888,1 33981,0 34062,1 34090,0 34175,1 34192,0 34279,1 34330,0 34349,1 34386,0 34440,1 34490,0 34511,1 34581,0 34636,1 34723,0 34782,1 34801,0 34880,1 34918,0 34950,1 35016,0 35027,1 35124,0 35191,1 35267,0 35335,1 35388,0 35426,1 35433,0 35466,1 35544,0 35606,1 35613,0 35614,1 35701,0 35735,1 35819,0 35905,1 35908,0 36003,1 36089,0 36129,1 36134,0 36185,1 36224,0 36318,1 36339,0 36377,1 36432,0 36489,1 36571,0 36649,1 36743,0 36755,1 36765,0 36850,1 36862,0 36879,1 36915,0 37015,1 37068,0 37133,1 37213,0 37301,1 37358,0 37367,1 37443,0 37472,1 37547,0 37557,1 37620,0 37718,1 37777,0 37856,1 37956,0 37996,1 38084,0 38114,1 38173,0 38174,1 38227,0 38235,1 38252,0 38315,1 38414,0 38502,1 38559,0 38595,1 38613,0 38657,1 38664,0 38682,1 38769,0 38833,1 38866,0 38961,1 39010,0 39018,1 39030,0 39043,1 39076,0 39091,1 39109,0 39171,1 39214,0 39226,1 39265,0 39351,1 39434,0 39447,1 39452,0 39498,1 39569,0 39590,1 39614,0 39617,1 39669,0 39767,1 39785,0 39854,1 39943,0 39984,1 40044,0 40139,1 40156,0 40215,1 40286,0 40359,1 40425,0 40499,1 40596,0 40635,1 40686,0 40689,1 40704,0 40786,1 40886,0 40890,1 40949,0 41039,1 41082,0 41164,1 41188,0 41271,1 41333,0 41390,1 41408,0 41489,1 41551,0 41617,1 41675,0 41695,1 41704,0 41780,1 41878,0 41898,1 41983,0 41998,1 42027,0 42055,1 42097,0 42109,1 42127,0 42163,1 42260,0 42335,1 42361,0 42409,1 42486,0 42529,1 42573,0 42599,1 42633,0 42685,1 42747,0 42757,1 42764,0 42838,1 42929,0 42954,1 43035,0 43058,1 43121,0 43128,1 43133,0 43165,1 43176,0 43242,1 43254,0 43311,1 43386,0 43407,1 43428,0 43498,1 43590,0 43615,1 43670,0 43738,1 43773,0 43871,1 43938,0 43957,1 43998,0 44087,1 44124,0 44211,1 44262,0 44296,1 44361,0 44411,1 44429,0 44511,1 44555,0 44601,1 44634,0 44688,1 44761,0 44803,1 44895,0 44980,1 45038,0 45047,1 45093,0 45155,1 45207,0 45288,1 45388,0 45442,1 45476,0 45491,1 45576,0 45610,1 45666,0 45706,1 45733,0 45787,1 45842,0 45851,1 45889,0 45946,1 46019,0 46072,1 46140,0 46164,1 46165,0 46212,1 46268,0 46279,1 46301,0 46392,1 46404,0 46469,1 46492,0 46579,1 46615,0 46628,1 46695,0 46760,1 46804,0 46893,1 46976,0 47051,1 47099,0 47153,1 47183,0 47206,1 47275,0 47300,1 47378,0 47380,1 47480,0 47579,1 47638,0 47732,1 47819,0 47852,1 47941,0 48009,1 48039,0 48052,1 48140,0 48157,1 48192,0 48254,1 48310,0 48326,1 48423,0 48461,1 48548,0 48607,1 48611,0 48624,1 48707,0 48805,1 48866,0 48921,1 48986,0 49011,1 49051,0 49138,1 49233,0 49275,1 49358,0 49454,1 49469,0 49507,1 49589,0 49621,1 49715,0 49733,1 49813,0 49843,1 49916,0 49992,1 50084,0 50184,1 50202,0 50301,1 50386,0 50449,1 50469,0 50477,1 50501,0 50588,1 50627,0 50686,1 50769,0 50812,1 end initlist b28 0,0 66,1 111,0 140,1 186,0 254,1 279,0 306,1 332,0 406,1 504,0 579,1 668,0 717,1 736,0 746,1 811,0 861,1 863,0 951,1 1002,0 1042,1 1051,0 1070,1 1151,0 1235,1 1320,0 1408,1 1427,0 1476,1 1492,0 1502,1 1522,0 1532,1 1599,0 1695,1 1772,0 1811,1 1843,0 1859,1 1875,0 1919,1 1999,0 2059,1 2119,0 2145,1 2241,0 2295,1 2322,0 2417,1 2456,0 2535,1 2613,0 2650,1 2688,0 2780,1 2853,0 2871,1 2940,0 2969,1 3068,0 3150,1 3200,0 3220,1 3295,0 3317,1 3397,0 3438,1 3498,0 3514,1 3587,0 3599,1 3674,0 3733,1 3751,0 3780,1 3804,0 3867,1 3935,0 4003,1 4067,0 4147,1 4213,0 4288,1 4352,0 4378,1 4434,0 4519,1 4585,0 4611,1 4662,0 4689,1 4722,0 4736,1 4761,0 4837,1 4890,0 4944,1 4976,0 5076,1 5102,0 5182,1 5262,0 5282,1 5288,0 5363,1 5421,0 5424,1 5464,0 5549,1 5645,0 5658,1 5733,0 5829,1 5915,0 5932,1 6023,0 6113,1 6158,0 6199,1 6211,0 6212,1 6216,0 6255,1 6299,0 6396,1 6423,0 6477,1 6508,0 6518,1 6578,0 6637,1 6714,0 6791,1 6875,0 6898,1 6948,0 7035,1 7064,0 7092,1 7189,0 7248,1 7270,0 7352,1 7415,0 7456,1 7477,0 7548,1 7567,0 7618,1 7648,0 7688,1 7694,0 7776,1 7849,0 7873,1 7958,0 8026,1 8046,0 8073,1 8137,0 8201,1 8264,0 8274,1 8310,0 8334,1 8359,0 8422,1 8424,0 8521,1 8585,0 8671,1 8672,0 8716,1 8779,0 8800,1 8887,0 8919,1 8980,0 8988,1 8997,0 9087,1 9171,0 9202,1 9220,0 9225,1 9265,0 9361,1 9363,0 9456,1 9548,0 9633,1 9681,0 9704,1 9747,0 9845,1 9903,0 9913,1 9968,0 10057,1 10118,0 10207,1 10222,0 10276,1 10313,0 10393,1 10403,0 10489,1 10535,0 10621,1 10642,0 10740,1 10788,0 10859,1 10902,0 10970,1 11041,0 11108,1 11204,0 11269,1 11287,0 11354,1 11367,0 11370,1 11413,0 11505,1 11593,0 11623,1 11699,0 11707,1 11789,0 11831,1 11889,0 11960,1 11968,0 12059,1 12131,0 12188,1 12254,0 12259,1 12322,0 12346,1 12403,0 12486,1 12500,0 12514,1 12598,0 12600,1 12626,0 12720,1 12814,0 12833,1 12903,0 12927,1 13003,0 13042,1 13065,0 13141,1 13171,0 13246,1 13251,0 13321,1 13413,0 13429,1 13437,0 13448,1 13543,0 13617,1 13665,0 13704,1 13800,0 13866,1 13965,0 14004,1 14088,0 14155,1 14198,0 14273,1 14286,0 14363,1 14387,0 14417,1 14433,0 14517,1 14574,0 14596,1 14654,0 14750,1 14828,0 14912,1 14953,0 14968,1 15049,0 15103,1 15121,0 15173,1 15220,0 15269,1 15318,0 15371,1 15470,0 15537,1 15556,0 15570,1 15638,0 15731,1 15784,0 15874,1 15920,0 15996,1 16017,0 16100,1 16123,0 16135,1 16141,0 16172,1 16219,0 16253,1 16316,0 16317,1 16363,0 16438,1 16443,0 16535,1 16599,0 16616,1 16707,0 16717,1 16807,0 16904,1 16963,0 17025,1 17081,0 17181,1 17188,0 17268,1 17356,0 17437,1 17475,0 17495,1 17510,0 17543,1 17590,0 17602,1 17696,0 17771,1 17802,0 17862,1 17960,0 17965,1 18050,0 18104,1 18203,0 18207,1 18232,0 18241,1 18309,0 18354,1 18390,0 18467,1 18545,0 18562,1 18618,0 18661,1 18757,0 18810,1 18838,0 18844,1 18871,0 18888,1 18959,0 18976,1 19059,0 19100,1 19112,0 19181,1 19204,0 19256,1 19258,0 19281,1 19314,0 19344,1 19391,0 19480,1 19534,0 19541,1 19548,0 19575,1 19636,0 19690,1 19737,0 19778,1 19819,0 19913,1 19960,0 19993,1 20053,0 20125,1 20219,0 20231,1 20312,0 20397,1 20492,0 20514,1 20597,0 20657,1 20711,0 20805,1 20864,0 20955,1 20976,0 21014,1 21042,0 21126,1 21193,0 21203,1 21249,0 21339,1 21423,0 21433,1 21519,0 21539,1 21542,0 21556,1 21604,0 21674,1 21759,0 21822,1 21842,0 21934,1 21995,0 22051,1 22107,0 22128,1 22191,0 22219,1 22262,0 22312,1 22354,0 22379,1 22453,0 22520,1 22610,0 22642,1 22702,0 22782,1 22784,0 22824,1 22840,0 22897,1 22910,0 22976,1 23034,0 23121,1 23200,0 23219,1 23304,0 23392,1 23428,0 23439,1 23461,0 23506,1 23524,0 23562,1 23641,0 23697,1 23747,0 23806,1 23898,0 23909,1 23992,0 24075,1 24142,0 24164,1 24210,0 24287,1 24352,0 24432,1 24442,0 24479,1 24544,0 24580,1 24590,0 24639,1 24720,0 24722,1 24806,0 24822,1 24831,0 24930,1 25021,0 25100,1 25168,0 25217,1 25262,0 25354,1 25362,0 25447,1 25469,0 25506,1 25513,0 25589,1 25601,0 25604,1 25687,0 25776,1 25838,0 25893,1 25943,0 25973,1 26067,0 26096,1 26129,0 26180,1 26243,0 26287,1 26324,0 26344,1 26437,0 26442,1 26470,0 26531,1 26597,0 26613,1 26693,0 26733,1 26788,0 26813,1 26893,0 26899,1 26902,0 26970,1 27021,0 27022,1 27103,0 27170,1 27244,0 27295,1 27365,0 27382,1 27408,0 27461,1 27528,0 27549,1 27574,0 27665,1 27739,0 27750,1 27848,0 27895,1 27911,0 27970,1 28038,0 28056,1 28112,0 28181,1 28182,0 28276,1 28367,0 28418,1 28468,0 28548,1 28563,0 28661,1 28734,0 28744,1 28760,0 28761,1 28833,0 28915,1 28959,0 29034,1 29124,0 29181,1 29280,0 29288,1 29364,0 29386,1 29480,0 29505,1 29513,0 29568,1 29623,0 29662,1 29721,0 29791,1 29869,0 29950,1 30031,0 30117,1 30147,0 30204,1 30274,0 30330,1 30335,0 30434,1 30527,0 30573,1 30659,0 30730,1 30742,0 30762,1 30778,0 30856,1 30879,0 30891,1 30970,0 31041,1 31104,0 31199,1 31274,0 31337,1 31432,0 31452,1 31551,0 31589,1 31597,0 31606,1 31658,0 31664,1 31757,0 31798,1 31829,0 31901,1 31963,0 31992,1 32039,0 32061,1 32098,0 32161,1 32197,0 32232,1 32287,0 32309,1 32359,0 32386,1 32428,0 32463,1 32526,0 32601,1 32643,0 32646,1 32660,0 32756,1 32798,0 32839,1 32841,0 32843,1 32934,0 32994,1 33083,0 33172,1 33214,0 33237,1 33317,0 33393,1 33424,0 33478,1 33511,0 33596,1 33667,0 33701,1 33733,0 33833,1 33909,0 33969,1 34008,0 34086,1 34158,0 34205,1 34245,0 34291,1 34342,0 34370,1 34394,0 34414,1 34507,0 34597,1 34609,0 34696,1 34732,0 34818,1 34832,0 34882,1 34884,0 34898,1 34995,0 35093,1 35157,0 35251,1 35292,0 35312,1 35396,0 35494,1 35563,0 35601,1 35641,0 35733,1 35808,0 35885,1 35952,0 35986,1 36062,0 36122,1 36150,0 36191,1 36278,0 36373,1 36399,0 36428,1 36498,0 36589,1 36608,0 36699,1 36784,0 36823,1 36862,0 36894,1 36926,0 36986,1 37066,0 37092,1 37179,0 37236,1 37301,0 37318,1 37409,0 37508,1 37553,0 37618,1 37647,0 37729,1 37774,0 37862,1 37947,0 37951,1 38043,0 38134,1 38177,0 38206,1 38251,0 38314,1 38375,0 38395,1 38448,0 38542,1 38598,0 38685,1 38758,0 38797,1 38814,0 38828,1 38890,0 38973,1 39026,0 39098,1 39124,0 39209,1 39286,0 39374,1 39433,0 39445,1 39454,0 39483,1 39567,0 39609,1 39683,0 39731,1 39776,0 39820,1 39873,0 39932,1 39983,0 40045,1 40094,0 40126,1 40225,0 40325,1 40364,0 40400,1 40416,0 40502,1 40519,0 40537,1 40571,0 40620,1 40631,0 40699,1 40726,0 40756,1 40789,0 40831,1 40849,0 40921,1 40954,0 41024,1 41053,0 41144,1 41153,0 41241,1 41279,0 41292,1 41392,0 41476,1 41507,0 41528,1 41571,0 41577,1 41631,0 41663,1 41762,0 41832,1 41889,0 41943,1 41974,0 41982,1 42011,0 42101,1 42107,0 42126,1 42172,0 42254,1 42312,0 42371,1 42391,0 42484,1 42556,0 42618,1 42668,0 42678,1 42744,0 42757,1 42806,0 42848,1 42916,0 43011,1 43028,0 43114,1 43180,0 43186,1 43254,0 43334,1 43391,0 43397,1 43416,0 43442,1 43539,0 43551,1 43647,0 43694,1 43740,0 43790,1 43833,0 43864,1 43876,0 43919,1 44000,0 44079,1 44090,0 44123,1 44146,0 44193,1 44293,0 44318,1 44352,0 44428,1 44485,0 44542,1 44618,0 44626,1 44667,0 44724,1 44770,0 44862,1 44889,0 44893,1 44955,0 45011,1 45052,0 45106,1 45206,0 45259,1 45307,0 45386,1 45465,0 45509,1 45559,0 45651,1 45737,0 45743,1 45825,0 45912,1 45973,0 45998,1 46089,0 46180,1 46271,0 46354,1 46426,0 46510,1 46573,0 46659,1 46747,0 46760,1 46828,0 46919,1 46969,0 47001,1 47063,0 47132,1 47163,0 47167,1 47232,0 47250,1 47344,0 47438,1 47459,0 47537,1 47614,0 47712,1 47812,0 47896,1 47905,0 48001,1 48057,0 48070,1 48083,0 48137,1 48224,0 48296,1 48349,0 48415,1 48417,0 48438,1 48478,0 48528,1 48626,0 48659,1 48732,0 48777,1 48805,0 48866,1 48948,0 48969,1 49069,0 49108,1 49147,0 49240,1 49250,0 49300,1 49352,0 49452,1 49531,0 49621,1 49658,0 49687,1 49773,0 49780,1 49868,0 49933,1 49938,0 49988,1 50067,0 50165,1 50198,0 50252,1 50308,0 50353,1 50365,0 50454,1 50477,0 50501,1 50509,0 50538,1 50593,0 50625,1 50703,0 50780,1 50806,0 50863,1 50870,0 50881,1 50895,0 50939,1 50974,0 51021,1 51080,0 51143,1 51168,0 51243,1 51296,0 51377,1 51435,0 51518,1 51525,0 51579,1 51670,0 51708,1 51781,0 51854,1 51866,0 51939,1 end initlist b29 0,0 22,1 48,0 69,1 167,0 184,1 195,0 288,1 345,0 407,1 496,0 501,1 563,0 636,1 729,0 735,1 809,0 843,1 880,0 899,1 926,0 934,1 1019,0 1031,1 1130,0 1223,1 1281,0 1331,1 1401,0 1438,1 1537,0 1603,1 1689,0 1789,1 1791,0 1874,1 1952,0 2042,1 2043,0 2112,1 2147,0 2244,1 2331,0 2354,1 2436,0 2438,1 2487,0 2566,1 2646,0 2653,1 2740,0 2806,1 2836,0 2927,1 2988,0 3072,1 3156,0 3202,1 3210,0 3297,1 3365,0 3451,1 3540,0 3562,1 3576,0 3623,1 3635,0 3696,1 3718,0 3777,1 3795,0 3851,1 3944,0 4002,1 4081,0 4140,1 4143,0 4151,1 4177,0 4191,1 4222,0 4230,1 4247,0 4306,1 4364,0 4394,1 4401,0 4450,1 4480,0 4534,1 4633,0 4662,1 4676,0 4681,1 4689,0 4748,1 4781,0 4846,1 4863,0 4876,1 4892,0 4969,1 4981,0 5042,1 5136,0 5233,1 5320,0 5351,1 5439,0 5441,1 5467,0 5493,1 5553,0 5617,1 5680,0 5723,1 5817,0 5825,1 5921,0 5940,1 6012,0 6072,1 6162,0 6172,1 6198,0 6231,1 6269,0 6279,1 6359,0 6420,1 6492,0 6559,1 6616,0 6634,1 6643,0 6725,1 6794,0 6879,1 6949,0 7022,1 7086,0 7124,1 7200,0 7266,1 7319,0 7406,1 7493,0 7511,1 7558,0 7581,1 7644,0 7674,1 7750,0 7849,1 7924,0 7934,1 7943,0 7992,1 8086,0 8103,1 8126,0 8160,1 8246,0 8326,1 8404,0 8440,1 8445,0 8517,1 8584,0 8606,1 8690,0 8713,1 8762,0 8830,1 8897,0 8959,1 9028,0 9106,1 9163,0 9233,1 9272,0 9326,1 9390,0 9395,1 9416,0 9498,1 9598,0 9606,1 9638,0 9734,1 9783,0 9843,1 9937,0 9943,1 10032,0 10066,1 10122,0 10191,1 10231,0 10233,1 10263,0 10265,1 10280,0 10340,1 10379,0 10431,1 10476,0 10526,1 10577,0 10670,1 10737,0 10783,1 10787,0 10806,1 10851,0 10875,1 10899,0 10953,1 11033,0 11047,1 11127,0 11128,1 11184,0 11207,1 11237,0 11285,1 11346,0 11361,1 11423,0 11471,1 11503,0 11563,1 11596,0 11672,1 11716,0 11752,1 11845,0 11932,1 11943,0 12022,1 12079,0 12120,1 12162,0 12212,1 12262,0 12306,1 12385,0 12450,1 12514,0 12602,1 12665,0 12685,1 12720,0 12743,1 12832,0 12859,1 12929,0 12982,1 13060,0 13090,1 13189,0 13242,1 13329,0 13368,1 13423,0 13507,1 13583,0 13646,1 13719,0 13816,1 13895,0 13994,1 14079,0 14121,1 14201,0 14290,1 14324,0 14341,1 14368,0 14428,1 14480,0 14536,1 14633,0 14658,1 14695,0 14789,1 14859,0 14861,1 14922,0 15017,1 15029,0 15033,1 15113,0 15181,1 15239,0 15317,1 15323,0 15410,1 15508,0 15596,1 15677,0 15713,1 15742,0 15760,1 15788,0 15797,1 15874,0 15914,1 15923,0 15989,1 16051,0 16071,1 16163,0 16196,1 16237,0 16316,1 16379,0 16478,1 16505,0 16537,1 16566,0 16607,1 16652,0 16669,1 16769,0 16862,1 16866,0 16944,1 17035,0 17089,1 17102,0 17120,1 17171,0 17224,1 17250,0 17301,1 17311,0 17406,1 17498,0 17565,1 17641,0 17650,1 17656,0 17721,1 17818,0 17905,1 17980,0 17982,1 18077,0 18117,1 18142,0 18171,1 18214,0 18265,1 18313,0 18336,1 18374,0 18425,1 18502,0 18571,1 18604,0 18665,1 18760,0 18806,1 18851,0 18924,1 18961,0 18992,1 19051,0 19110,1 19207,0 19258,1 19265,0 19295,1 19343,0 19380,1 19468,0 19564,1 19630,0 19657,1 19757,0 19797,1 19832,0 19919,1 19972,0 20000,1 20062,0 20065,1 20120,0 20165,1 20179,0 20248,1 20265,0 20307,1 20319,0 20339,1 20437,0 20471,1 20477,0 20498,1 20557,0 20567,1 20631,0 20712,1 20791,0 20824,1 20888,0 20901,1 20952,0 20998,1 21021,0 21030,1 21035,0 21072,1 21151,0 21215,1 21241,0 21294,1 21347,0 21352,1 21387,0 21405,1 21469,0 21544,1 21561,0 21612,1 21698,0 21709,1 21772,0 21818,1 21852,0 21929,1 21966,0 22024,1 22062,0 22117,1 22190,0 22213,1 22230,0 22324,1 22403,0 22470,1 22476,0 22539,1 22621,0 22631,1 22634,0 22676,1 22723,0 22800,1 22867,0 22883,1 22886,0 22950,1 22963,0 23016,1 23041,0 23115,1 23132,0 23163,1 23176,0 23183,1 23196,0 23209,1 23246,0 23286,1 23328,0 23368,1 23461,0 23513,1 23576,0 23585,1 23657,0 23696,1 23733,0 23804,1 23825,0 23925,1 23964,0 23978,1 23998,0 24090,1 24142,0 24163,1 24259,0 24296,1 24343,0 24414,1 24482,0 24538,1 24568,0 24606,1 24651,0 24683,1 24750,0 24781,1 24801,0 24869,1 24947,0 24984,1 25022,0 25028,1 25069,0 25146,1 25163,0 25209,1 25259,0 25271,1 25296,0 25358,1 25442,0 25496,1 25533,0 25593,1 25685,0 25784,1 25800,0 25808,1 25817,0 25828,1 25862,0 25941,1 25945,0 25950,1 25976,0 26023,1 26066,0 26105,1 26158,0 26197,1 26254,0 26272,1 26371,0 26424,1 26484,0 26580,1 26610,0 26705,1 26755,0 26817,1 26900,0 26914,1 26985,0 26997,1 27045,0 27076,1 27175,0 27269,1 27291,0 27321,1 27323,0 27359,1 27433,0 27478,1 27495,0 27564,1 27620,0 27716,1 27733,0 27766,1 27795,0 27867,1 27881,0 27938,1 27953,0 27980,1 28050,0 28143,1 28224,0 28300,1 28316,0 28338,1 28410,0 28421,1 28484,0 28571,1 28662,0 28758,1 28776,0 28811,1 28827,0 28876,1 28955,0 28994,1 29019,0 29044,1 29115,0 29154,1 29228,0 29237,1 29278,0 29356,1 29424,0 29431,1 29497,0 29530,1 29577,0 29656,1 29701,0 29789,1 29861,0 29866,1 29869,0 29878,1 29909,0 29929,1 29957,0 29989,1 30021,0 30075,1 30169,0 30199,1 30265,0 30276,1 30355,0 30389,1 30487,0 30489,1 30522,0 30621,1 30682,0 30764,1 30776,0 30821,1 30880,0 30905,1 30957,0 30998,1 31010,0 31070,1 31101,0 31125,1 31134,0 31227,1 31320,0 31402,1 31471,0 31493,1 31544,0 31576,1 31638,0 31639,1 31688,0 31786,1 31801,0 31829,1 31885,0 31930,1 32029,0 32110,1 32168,0 32220,1 32232,0 32257,1 32335,0 32386,1 32459,0 32504,1 32511,0 32563,1 32597,0 32673,1 32688,0 32709,1 32725,0 32821,1 32866,0 32893,1 32935,0 32948,1 32959,0 32978,1 32979,0 33011,1 33031,0 33118,1 33157,0 33196,1 33242,0 33269,1 33273,0 33373,1 33405,0 33474,1 33562,0 33581,1 33647,0 33696,1 33717,0 33744,1 33775,0 33777,1 33840,0 33910,1 33968,0 34053,1 34105,0 34112,1 34209,0 34280,1 34346,0 34377,1 34382,0 34438,1 34499,0 34572,1 34584,0 34608,1 34689,0 34710,1 34745,0 34827,1 34896,0 34996,1 35084,0 35166,1 35208,0 35241,1 35292,0 35319,1 35407,0 35460,1 35543,0 35564,1 35662,0 35738,1 35793,0 35833,1 35898,0 35912,1 35971,0 36044,1 36139,0 36219,1 36263,0 36317,1 36336,0 36355,1 36363,0 36417,1 36455,0 36460,1 36521,0 36538,1 36540,0 36640,1 36686,0 36761,1 36788,0 36852,1 36894,0 36952,1 36955,0 36981,1 37051,0 37134,1 37222,0 37227,1 37273,0 37297,1 37348,0 37354,1 37416,0 37442,1 37481,0 37567,1 37642,0 37713,1 37760,0 37762,1 37853,0 37861,1 37888,0 37926,1 37940,0 38031,1 38094,0 38125,1 38157,0 38176,1 38246,0 38270,1 38281,0 38331,1 38423,0 38459,1 38527,0 38544,1 38581,0 38678,1 38740,0 38742,1 38792,0 38837,1 38843,0 38880,1 38931,0 38980,1 39070,0 39102,1 39150,0 39221,1 39250,0 39315,1 39411,0 39455,1 39529,0 39533,1 39558,0 39631,1 39644,0 39653,1 39696,0 39756,1 39794,0 39852,1 39913,0 39958,1 39991,0 40010,1 40088,0 40096,1 40123,0 40164,1 40208,0 40293,1 40343,0 40378,1 40420,0 40439,1 40504,0 40538,1 40592,0 40690,1 40762,0 40795,1 40820,0 40862,1 40911,0 40989,1 41054,0 41107,1 41117,0 41166,1 41250,0 41265,1 41273,0 41364,1 41434,0 41479,1 41523,0 41556,1 41617,0 41685,1 41767,0 41776,1 41874,0 41931,1 41937,0 41977,1 42052,0 42128,1 42203,0 42278,1 42305,0 42397,1 42403,0 42438,1 42500,0 42560,1 42605,0 42681,1 42704,0 42750,1 42784,0 42810,1 42835,0 42858,1 42862,0 42938,1 42968,0 42998,1 43031,0 43064,1 43068,0 43128,1 43206,0 43236,1 43332,0 43431,1 43514,0 43577,1 43658,0 43692,1 43730,0 43797,1 43824,0 43873,1 43897,0 43909,1 43961,0 44059,1 44099,0 44114,1 44188,0 44223,1 44321,0 44360,1 44424,0 44473,1 44545,0 44573,1 44666,0 44708,1 44764,0 44841,1 44901,0 44985,1 45065,0 45128,1 45151,0 45214,1 45243,0 45317,1 45380,0 45425,1 45472,0 45541,1 45620,0 45621,1 45675,0 45697,1 45700,0 45794,1 45886,0 45906,1 45994,0 46072,1 46121,0 46148,1 46198,0 46254,1 46329,0 46397,1 46464,0 46494,1 46538,0 46593,1 46642,0 46683,1 46730,0 46776,1 46824,0 46869,1 46883,0 46976,1 46989,0 47018,1 47043,0 47049,1 47051,0 47056,1 47156,0 47222,1 47269,0 47309,1 47352,0 47417,1 47506,0 47530,1 47609,0 47642,1 47652,0 47675,1 47686,0 47736,1 47754,0 47839,1 47936,0 47945,1 47946,0 48033,1 48057,0 48106,1 48149,0 48165,1 48190,0 48247,1 48261,0 48263,1 48323,0 48339,1 48387,0 48417,1 48463,0 48472,1 48504,0 48604,1 48669,0 48730,1 48734,0 48787,1 end initlist b30 0,0 49,1 128,0 209,1 293,0 330,1 365,0 373,1 464,0 519,1 577,0 646,1 670,0 675,1 678,0 683,1 745,0 748,1 848,0 918,1 954,0 1030,1 1100,0 1194,1 1278,0 1342,1 1365,0 1375,1 1447,0 1448,1 1479,0 1498,1 1550,0 1556,1 1635,0 1734,1 1764,0 1802,1 1882,0 1893,1 1937,0 1954,1 2040,0 2090,1 2149,0 2159,1 2197,0 2218,1 2243,0 2315,1 2332,0 2340,1 2348,0 2426,1 2453,0 2503,1 2544,0 2642,1 2664,0 2726,1 2786,0 2828,1 2853,0 2869,1 2879,0 2880,1 2933,0 3013,1 3029,0 3044,1 3109,0 3174,1 3265,0 3301,1 3334,0 3411,1 3499,0 3529,1 3620,0 3652,1 3713,0 3748,1 3790,0 3802,1 3893,0 3922,1 3983,0 4001,1 4005,0 4048,1 4083,0 4094,1 4180,0 4187,1 4219,0 4241,1 4312,0 4410,1 4494,0 4559,1 4599,0 4617,1 4653,0 4658,1 4697,0 4753,1 4806,0 4825,1 4885,0 4981,1 5006,0 5041,1 5134,0 5181,1 5281,0 5308,1 5332,0 5340,1 5365,0 5427,1 5498,0 5591,1 5648,0 5728,1 5741,0 5794,1 5819,0 5853,1 5936,0 5938,1 6021,0 6076,1 6107,0 6193,1 6289,0 6322,1 6405,0 6439,1 6515,0 6566,1 6625,0 6630,1 6650,0 6739,1 6821,0 6876,1 6960,0 7059,1 7087,0 7186,1 7269,0 7307,1 7346,0 7349,1 7385,0 7417,1 7425,0 7513,1 7517,0 7580,1 7597,0 7652,1 7739,0 7747,1 7845,0 7892,1 7895,0 7964,1 7966,0 8065,1 8102,0 8138,1 8210,0 8282,1 8358,0 8422,1 8512,0 8538,1 8638,0 8722,1 8732,0 8789,1 8871,0 8897,1 8900,0 8908,1 8958,0 9013,1 9029,0 9052,1 9126,0 9175,1 9254,0 9319,1 9383,0 9412,1 9505,0 9521,1 9533,0 9567,1 9642,0 9737,1 9743,0 9813,1 9884,0 9932,1 10019,0 10102,1 10172,0 10200,1 10241,0 10331,1 10426,0 10430,1 10522,0 10553,1 10557,0 10611,1 10621,0 10656,1 10729,0 10743,1 10765,0 10863,1 10955,0 10956,1 11018,0 11038,1 11081,0 11133,1 11172,0 11188,1 11255,0 11319,1 11404,0 11448,1 11529,0 11579,1 11598,0 11610,1 11648,0 11658,1 11681,0 11772,1 11832,0 11843,1 11924,0 12004,1 12064,0 12154,1 12210,0 12274,1 12302,0 12353,1 12377,0 12464,1 12538,0 12557,1 12615,0 12645,1 12729,0 12750,1 12804,0 12879,1 12909,0 12920,1 12929,0 12999,1 13062,0 13129,1 13202,0 13249,1 13328,0 13355,1 13407,0 13479,1 13576,0 13579,1 13645,0 13732,1 13791,0 13865,1 13952,0 13999,1 14013,0 14048,1 14102,0 14192,1 14268,0 14322,1 14369,0 14417,1 14484,0 14498,1 14500,0 14523,1 14604,0 14612,1 14626,0 14647,1 14727,0 14805,1 14848,0 14892,1 14923,0 14995,1 15057,0 15102,1 15162,0 15209,1 15303,0 15323,1 15347,0 15384,1 15450,0 15491,1 15507,0 15509,1 15535,0 15613,1 15647,0 15689,1 15727,0 15740,1 15809,0 15871,1 15932,0 15975,1 16066,0 16153,1 16159,0 16192,1 16279,0 16319,1 16378,0 16425,1 16428,0 16473,1 16544,0 16547,1 16612,0 16683,1 16684,0 16713,1 16757,0 16819,1 16892,0 16974,1 17067,0 17105,1 17138,0 17176,1 17237,0 17252,1 17343,0 17408,1 17487,0 17508,1 17514,0 17602,1 17649,0 17709,1 17804,0 17830,1 17923,0 18011,1 18044,0 18102,1 18177,0 18209,1 18221,0 18259,1 18320,0 18380,1 18479,0 18558,1 18639,0 18659,1 18695,0 18756,1 18850,0 18882,1 18903,0 18962,1 19028,0 19044,1 19095,0 19097,1 19177,0 19227,1 19265,0 19279,1 19313,0 19353,1 19393,0 19482,1 19535,0 19548,1 19622,0 19631,1 19659,0 19687,1 19776,0 19869,1 19919,0 20006,1 20045,0 20096,1 20130,0 20148,1 20244,0 20320,1 20357,0 20390,1 20448,0 20492,1 20503,0 20593,1 20628,0 20714,1 20725,0 20770,1 20866,0 20966,1 21048,0 21128,1 21179,0 21253,1 21283,0 21334,1 21359,0 21431,1 21487,0 21542,1 21641,0 21736,1 21827,0 21848,1 21856,0 21892,1 21982,0 21996,1 22053,0 22091,1 22165,0 22200,1 22248,0 22340,1 22429,0 22432,1 22438,0 22496,1 22525,0 22612,1 22657,0 22751,1 22791,0 22810,1 22910,0 22968,1 23058,0 23094,1 23151,0 23223,1 23235,0 23275,1 23357,0 23359,1 23399,0 23460,1 23464,0 23564,1 23585,0 23623,1 23699,0 23753,1 23770,0 23836,1 23858,0 23953,1 24002,0 24030,1 24040,0 24134,1 24175,0 24212,1 24263,0 24311,1 24319,0 24362,1 24456,0 24482,1 24546,0 24626,1 24714,0 24757,1 24788,0 24864,1 24904,0 24944,1 25026,0 25086,1 25118,0 25166,1 25245,0 25317,1 25348,0 25405,1 25462,0 25475,1 25562,0 25576,1 25608,0 25665,1 25755,0 25829,1 25875,0 25908,1 25923,0 26006,1 26106,0 26157,1 26216,0 26219,1 26259,0 26270,1 26328,0 26401,1 26490,0 26538,1 26616,0 26676,1 26677,0 26747,1 26834,0 26892,1 26917,0 26967,1 26995,0 27016,1 27056,0 27103,1 27159,0 27231,1 27297,0 27389,1 27456,0 27551,1 27591,0 27647,1 27661,0 27701,1 27768,0 27814,1 27892,0 27909,1 27940,0 27977,1 28008,0 28018,1 28062,0 28108,1 28130,0 28206,1 28236,0 28308,1 28368,0 28376,1 28440,0 28448,1 28539,0 28560,1 28598,0 28676,1 28694,0 28707,1 28765,0 28815,1 28819,0 28910,1 28949,0 29035,1 29126,0 29188,1 29229,0 29241,1 29284,0 29300,1 29367,0 29438,1 29491,0 29537,1 29636,0 29669,1 29722,0 29747,1 29796,0 29830,1 29860,0 29933,1 29952,0 30009,1 30095,0 30171,1 30243,0 30260,1 30269,0 30360,1 30416,0 30467,1 30494,0 30496,1 30547,0 30569,1 30616,0 30675,1 30730,0 30770,1 30843,0 30844,1 30907,0 30986,1 31019,0 31079,1 31145,0 31155,1 31171,0 31177,1 31245,0 31293,1 31367,0 31393,1 31488,0 31499,1 31531,0 31567,1 31606,0 31675,1 31685,0 31706,1 31713,0 31740,1 31773,0 31817,1 31899,0 31902,1 31997,0 32005,1 32077,0 32098,1 32122,0 32150,1 32156,0 32244,1 32331,0 32383,1 32423,0 32452,1 32505,0 32555,1 32597,0 32601,1 32661,0 32757,1 32850,0 32872,1 32918,0 32973,1 33056,0 33084,1 33131,0 33190,1 33268,0 33366,1 33423,0 33461,1 33543,0 33630,1 33635,0 33671,1 33761,0 33854,1 33932,0 33952,1 33986,0 34009,1 34108,0 34128,1 34195,0 34200,1 34204,0 34265,1 34345,0 34378,1 34455,0 34494,1 34514,0 34604,1 34676,0 34684,1 34756,0 34760,1 34791,0 34833,1 34910,0 34997,1 35025,0 35054,1 35080,0 35112,1 35129,0 35163,1 35227,0 35289,1 35321,0 35365,1 35384,0 35481,1 35528,0 35565,1 35610,0 35689,1 35727,0 35814,1 35908,0 35997,1 36025,0 36082,1 36116,0 36182,1 36227,0 36320,1 36340,0 36395,1 36474,0 36536,1 36575,0 36666,1 36740,0 36810,1 36846,0 36882,1 36924,0 36979,1 37076,0 37144,1 37190,0 37194,1 37236,0 37272,1 37316,0 37389,1 37489,0 37569,1 37612,0 37681,1 37708,0 37715,1 37776,0 37817,1 37906,0 37940,1 37980,0 38055,1 38071,0 38121,1 38211,0 38307,1 38319,0 38409,1 38436,0 38532,1 38569,0 38647,1 38678,0 38727,1 38777,0 38808,1 38814,0 38912,1 39000,0 39052,1 39102,0 39110,1 39205,0 39234,1 39287,0 39300,1 39325,0 39417,1 39499,0 39555,1 39584,0 39678,1 39736,0 39752,1 39851,0 39883,1 39885,0 39958,1 39963,0 39984,1 40053,0 40115,1 40172,0 40187,1 40224,0 40299,1 40322,0 40358,1 40399,0 40488,1 40499,0 40551,1 40647,0 40747,1 40770,0 40821,1 40860,0 40901,1 40902,0 40992,1 41075,0 41119,1 41183,0 41188,1 41276,0 41330,1 41363,0 41384,1 41480,0 41576,1 41610,0 41693,1 41779,0 41849,1 41905,0 41995,1 42032,0 42084,1 42136,0 42141,1 42196,0 42236,1 42270,0 42272,1 42341,0 42379,1 42415,0 42446,1 42470,0 42543,1 42566,0 42651,1 42717,0 42801,1 42805,0 42854,1 42873,0 42930,1 42964,0 42973,1 43058,0 43151,1 43189,0 43196,1 43255,0 43315,1 43321,0 43402,1 43453,0 43538,1 43615,0 43620,1 43635,0 43701,1 43716,0 43730,1 43759,0 43808,1 43848,0 43918,1 43985,0 44064,1 44073,0 44152,1 44232,0 44288,1 44360,0 44407,1 44429,0 44456,1 44552,0 44651,1 44699,0 44741,1 44826,0 44886,1 44940,0 45032,1 45120,0 45195,1 45219,0 45258,1 45287,0 45326,1 45377,0 45424,1 45473,0 45572,1 45642,0 45738,1 45779,0 45867,1 45943,0 46006,1 46047,0 46049,1 46093,0 46162,1 46238,0 46328,1 46403,0 46497,1 46570,0 46607,1 46666,0 46672,1 46725,0 46737,1 46803,0 46894,1 46952,0 47027,1 47029,0 47107,1 47195,0 47275,1 47290,0 47345,1 47379,0 47418,1 47437,0 47462,1 47524,0 47551,1 47642,0 47661,1 47740,0 47839,1 47939,0 48031,1 48097,0 48130,1 48200,0 48238,1 48288,0 48371,1 48417,0 48466,1 48467,0 48505,1 48557,0 48643,1 48655,0 48690,1 48755,0 48806,1 48861,0 48946,1 48995,0 49047,1 49117,0 49141,1 49226,0 49229,1 49319,0 49325,1 49407,0 49430,1 49441,0 49496,1 49536,0 49582,1 49620,0 49713,1 49767,0 49784,1 49862,0 49943,1 49995,0 50061,1 50068,0 50152,1 50169,0 50172,1 50201,0 50227,1 50294,0 50348,1 50446,0 50495,1 end initlist b31 0,0 13,1 107,0 137,1 146,0 175,1 181,0 189,1 260,0 293,1 383,0 470,1 558,0 622,1 626,0 655,1 677,0 737,1 758,0 854,1 917,0 946,1 1036,0 1045,1 1110,0 1202,1 1261,0 1279,1 1309,0 1336,1 1364,0 1383,1 1425,0 1450,1 1457,0 1518,1 1556,0 1560,1 1565,0 1630,1 1721,0 1752,1 1820,0 1913,1 1996,0 2013,1 2063,0 2127,1 2203,0 2269,1 2290,0 2306,1 2359,0 2390,1 2401,0 2406,1 2434,0 2503,1 2516,0 2542,1 2614,0 2631,1 2673,0 2750,1 2837,0 2896,1 2965,0 3016,1 3103,0 3109,1 3197,0 3210,1 3272,0 3320,1 3321,0 3336,1 3337,0 3388,1 3430,0 3517,1 3573,0 3613,1 3669,0 3768,1 3779,0 3817,1 3891,0 3945,1 3994,0 4012,1 4023,0 4093,1 4159,0 4176,1 4180,0 4232,1 4252,0 4301,1 4367,0 4399,1 4466,0 4561,1 4649,0 4738,1 4789,0 4812,1 4841,0 4878,1 4896,0 4967,1 5006,0 5049,1 5103,0 5129,1 5143,0 5228,1 5298,0 5379,1 5472,0 5512,1 5606,0 5671,1 5762,0 5779,1 5794,0 5855,1 5913,0 5968,1 6059,0 6122,1 6177,0 6231,1 6290,0 6314,1 6363,0 6436,1 6480,0 6516,1 6570,0 6600,1 6646,0 6650,1 6682,0 6736,1 6804,0 6811,1 6856,0 6879,1 6891,0 6893,1 6933,0 6973,1 6985,0 7048,1 7133,0 7224,1 7234,0 7278,1 7296,0 7373,1 7416,0 7488,1 7583,0 7663,1 7762,0 7809,1 7906,0 7982,1 8021,0 8112,1 8151,0 8231,1 8312,0 8363,1 8399,0 8434,1 8449,0 8454,1 8520,0 8572,1 8615,0 8620,1 8665,0 8713,1 8810,0 8816,1 8886,0 8919,1 9014,0 9045,1 9122,0 9213,1 9252,0 9349,1 9439,0 9503,1 9602,0 9633,1 9675,0 9688,1 9730,0 9806,1 9889,0 9983,1 10020,0 10086,1 10173,0 10179,1 10203,0 10272,1 10285,0 10370,1 10374,0 10427,1 10510,0 10518,1 10592,0 10639,1 10670,0 10748,1 10773,0 10787,1 10844,0 10929,1 10993,0 11039,1 11041,0 11091,1 11109,0 11149,1 11245,0 11252,1 11261,0 11307,1 11329,0 11391,1 11392,0 11403,1 11405,0 11458,1 11480,0 11577,1 11645,0 11680,1 11762,0 11811,1 11873,0 11972,1 12034,0 12090,1 12158,0 12253,1 12341,0 12424,1 12459,0 12516,1 12589,0 12618,1 12689,0 12735,1 12798,0 12833,1 12846,0 12920,1 13009,0 13087,1 13098,0 13186,1 13263,0 13306,1 13346,0 13418,1 13510,0 13547,1 13586,0 13634,1 13688,0 13751,1 13851,0 13883,1 13938,0 14023,1 14027,0 14063,1 14095,0 14135,1 14146,0 14181,1 14197,0 14263,1 14266,0 14293,1 14346,0 14384,1 14430,0 14469,1 14478,0 14524,1 14549,0 14620,1 14676,0 14754,1 14782,0 14852,1 14891,0 14919,1 14942,0 15030,1 15065,0 15115,1 15127,0 15129,1 15214,0 15282,1 15334,0 15391,1 15428,0 15452,1 15505,0 15562,1 15569,0 15641,1 15717,0 15727,1 15728,0 15739,1 15778,0 15814,1 15885,0 15957,1 16001,0 16072,1 16137,0 16220,1 16316,0 16369,1 16390,0 16417,1 16426,0 16444,1 16500,0 16505,1 16572,0 16615,1 16618,0 16647,1 16725,0 16764,1 16769,0 16855,1 16929,0 17012,1 17089,0 17125,1 17225,0 17278,1 17339,0 17345,1 17357,0 17390,1 17474,0 17569,1 17632,0 17641,1 17690,0 17738,1 17796,0 17851,1 17936,0 18003,1 18070,0 18102,1 18149,0 18164,1 18237,0 18281,1 18314,0 18346,1 18363,0 18448,1 18544,0 18612,1 18707,0 18768,1 18828,0 18898,1 18906,0 18943,1 19042,0 19069,1 19070,0 19121,1 19126,0 19140,1 19217,0 19279,1 19307,0 19395,1 19416,0 19486,1 19554,0 19557,1 19646,0 19734,1 19785,0 19828,1 19858,0 19930,1 19985,0 20015,1 20107,0 20127,1 20202,0 20237,1 20281,0 20309,1 20380,0 20443,1 20536,0 20600,1 20626,0 20684,1 20770,0 20774,1 20796,0 20853,1 20950,0 21037,1 21131,0 21145,1 21177,0 21199,1 21210,0 21296,1 21297,0 21391,1 21432,0 21448,1 21544,0 21592,1 21650,0 21709,1 21797,0 21855,1 21864,0 21877,1 21912,0 21979,1 21995,0 22093,1 22165,0 22200,1 22249,0 22257,1 22327,0 22347,1 22385,0 22402,1 22439,0 22481,1 22557,0 22606,1 22654,0 22684,1 22713,0 22748,1 22782,0 22873,1 22947,0 22989,1 23026,0 23057,1 23072,0 23102,1 23121,0 23202,1 23276,0 23351,1 23426,0 23518,1 23605,0 23678,1 23691,0 23746,1 23838,0 23861,1 23909,0 23913,1 23920,0 23931,1 23964,0 24003,1 24046,0 24052,1 24108,0 24127,1 24226,0 24252,1 24316,0 24400,1 24435,0 24456,1 24541,0 24601,1 24639,0 24713,1 24769,0 24853,1 24865,0 24906,1 24972,0 25067,1 25070,0 25163,1 25230,0 25241,1 25276,0 25287,1 25315,0 25388,1 25453,0 25465,1 25504,0 25592,1 25678,0 25683,1 25689,0 25713,1 25717,0 25802,1 25813,0 25896,1 25927,0 25933,1 26012,0 26014,1 26068,0 26142,1 26197,0 26226,1 26323,0 26340,1 26371,0 26391,1 26414,0 26469,1 26550,0 26623,1 26637,0 26675,1 26717,0 26743,1 26753,0 26763,1 26809,0 26882,1 26908,0 26974,1 27072,0 27107,1 27200,0 27299,1 27315,0 27400,1 27471,0 27511,1 27523,0 27580,1 27630,0 27682,1 27713,0 27773,1 27827,0 27879,1 27903,0 28000,1 28007,0 28018,1 28026,0 28103,1 28154,0 28188,1 28196,0 28292,1 28376,0 28405,1 28484,0 28511,1 28518,0 28545,1 28626,0 28671,1 28764,0 28785,1 28841,0 28899,1 28990,0 29035,1 29101,0 29167,1 29217,0 29266,1 29309,0 29349,1 29436,0 29473,1 29552,0 29556,1 29614,0 29640,1 29734,0 29762,1 29799,0 29869,1 29951,0 29983,1 30083,0 30169,1 30197,0 30228,1 30246,0 30293,1 30301,0 30329,1 30377,0 30386,1 30446,0 30525,1 30599,0 30698,1 30749,0 30833,1 30891,0 30950,1 30974,0 31013,1 31065,0 31079,1 31116,0 31209,1 31211,0 31216,1 31291,0 31368,1 31413,0 31461,1 31521,0 31586,1 31656,0 31660,1 31703,0 31718,1 31811,0 31840,1 31939,0 31969,1 31972,0 32020,1 32069,0 32142,1 32152,0 32207,1 32233,0 32282,1 32315,0 32365,1 32381,0 32425,1 32476,0 32515,1 32519,0 32554,1 32605,0 32630,1 32663,0 32697,1 32698,0 32756,1 32834,0 32839,1 32919,0 32984,1 33051,0 33136,1 33177,0 33208,1 33270,0 33354,1 33364,0 33369,1 33448,0 33541,1 33586,0 33632,1 33670,0 33685,1 33716,0 33756,1 33810,0 33840,1 33904,0 33945,1 33948,0 33987,1 33996,0 34025,1 34106,0 34146,1 34226,0 34278,1 34325,0 34341,1 34409,0 34424,1 34466,0 34512,1 34571,0 34670,1 34698,0 34734,1 34826,0 34899,1 34914,0 34928,1 35009,0 35046,1 35073,0 35165,1 35238,0 35306,1 35366,0 35405,1 35504,0 35551,1 35595,0 35676,1 35732,0 35760,1 35855,0 35933,1 35999,0 36080,1 36176,0 36207,1 36253,0 36267,1 36309,0 36366,1 36440,0 36519,1 36552,0 36553,1 36568,0 36617,1 36618,0 36685,1 36746,0 36814,1 36873,0 36908,1 36997,0 37008,1 37084,0 37111,1 37201,0 37297,1 37388,0 37402,1 37480,0 37548,1 37621,0 37675,1 37704,0 37758,1 37813,0 37850,1 37873,0 37911,1 37993,0 38072,1 38135,0 38197,1 38216,0 38244,1 38275,0 38365,1 38424,0 38500,1 38503,0 38536,1 38561,0 38614,1 38696,0 38699,1 38712,0 38735,1 38738,0 38759,1 38814,0 38898,1 38970,0 39065,1 39119,0 39122,1 39193,0 39247,1 39279,0 39282,1 39360,0 39374,1 39427,0 39486,1 39491,0 39493,1 39579,0 39672,1 39691,0 39709,1 39800,0 39851,1 39868,0 39919,1 39978,0 40033,1 40101,0 40193,1 40233,0 40284,1 40381,0 40402,1 40471,0 40502,1 40600,0 40695,1 40745,0 40818,1 40908,0 40987,1 41029,0 41110,1 41138,0 41165,1 41207,0 41304,1 41316,0 41381,1 41438,0 41440,1 41537,0 41628,1 41638,0 41710,1 41788,0 41873,1 41909,0 41936,1 41977,0 41982,1 42064,0 42126,1 42213,0 42312,1 42315,0 42404,1 42415,0 42447,1 42494,0 42523,1 42532,0 42576,1 42597,0 42643,1 42692,0 42740,1 42806,0 42869,1 42963,0 43020,1 43118,0 43143,1 43188,0 43215,1 43280,0 43311,1 43392,0 43435,1 43512,0 43554,1 43565,0 43619,1 43688,0 43720,1 43789,0 43879,1 43932,0 44010,1 44041,0 44091,1 44103,0 44145,1 44171,0 44270,1 44370,0 44382,1 44476,0 44506,1 44599,0 44685,1 44781,0 44862,1 44908,0 44940,1 45023,0 45123,1 45127,0 45195,1 45234,0 45262,1 45300,0 45396,1 45459,0 45498,1 45583,0 45656,1 45698,0 45757,1 45830,0 45923,1 46021,0 46107,1 46185,0 46275,1 46304,0 46321,1 46384,0 46462,1 46522,0 46553,1 46641,0 46735,1 46808,0 46878,1 46978,0 47046,1 47113,0 47191,1 47221,0 47288,1 47370,0 47437,1 47446,0 47530,1 47622,0 47623,1 47692,0 47695,1 47782,0 47867,1 47950,0 48031,1 48099,0 48140,1 48168,0 48217,1 48249,0 48340,1 48392,0 48459,1 48512,0 48524,1 48556,0 48593,1 48634,0 48684,1 48698,0 48730,1 48772,0 48811,1 48899,0 48940,1 49029,0 49127,1 49218,0 49316,1 49381,0 49453,1 49474,0 49510,1 49569,0 49582,1 49594,0 49616,1 49704,0 49765,1 49822,0 49921,1 49991,0 49996,1 50073,0 50155,1 50159,0 50207,1 end initlist b32 0,0 71,1 118,0 178,1 261,0 314,1 397,0 406,1 436,0 488,1 561,0 580,1 615,0 705,1 776,0 826,1 893,0 948,1 975,0 998,1 999,0 1026,1 1117,0 1130,1 1209,0 1247,1 1253,0 1279,1 1294,0 1354,1 1407,0 1487,1 1508,0 1552,1 1637,0 1731,1 1765,0 1817,1 1875,0 1924,1 1931,0 1975,1 2035,0 2116,1 2191,0 2276,1 2306,0 2384,1 2470,0 2532,1 2565,0 2664,1 2686,0 2776,1 2806,0 2816,1 2879,0 2937,1 2975,0 2985,1 3085,0 3169,1 3183,0 3234,1 3262,0 3294,1 3325,0 3331,1 3356,0 3395,1 3420,0 3488,1 3493,0 3537,1 3542,0 3638,1 3643,0 3652,1 3661,0 3727,1 3772,0 3785,1 3828,0 3897,1 3971,0 3975,1 4073,0 4166,1 4197,0 4266,1 4311,0 4378,1 4403,0 4481,1 4539,0 4583,1 4649,0 4740,1 4796,0 4825,1 4831,0 4894,1 4921,0 5010,1 5109,0 5152,1 5154,0 5163,1 5202,0 5216,1 5281,0 5358,1 5379,0 5454,1 5462,0 5537,1 5573,0 5661,1 5691,0 5737,1 5802,0 5902,1 5976,0 6023,1 6096,0 6105,1 6135,0 6195,1 6232,0 6237,1 6273,0 6339,1 6351,0 6432,1 6511,0 6583,1 6585,0 6665,1 6752,0 6834,1 6887,0 6928,1 6980,0 7027,1 7063,0 7137,1 7183,0 7270,1 7305,0 7342,1 7414,0 7502,1 7600,0 7686,1 7738,0 7831,1 7926,0 7936,1 8031,0 8109,1 8136,0 8158,1 8210,0 8288,1 8340,0 8391,1 8446,0 8523,1 8559,0 8583,1 8659,0 8696,1 8757,0 8832,1 8836,0 8870,1 8907,0 8967,1 9020,0 9086,1 9146,0 9161,1 9197,0 9214,1 9312,0 9372,1 9471,0 9472,1 9491,0 9501,1 9543,0 9558,1 9561,0 9576,1 9604,0 9693,1 9758,0 9846,1 9862,0 9918,1 9971,0 10010,1 10069,0 10162,1 10238,0 10247,1 10314,0 10363,1 10393,0 10418,1 10498,0 10583,1 10669,0 10699,1 10720,0 10814,1 10836,0 10897,1 10913,0 11001,1 11082,0 11088,1 11156,0 11238,1 11327,0 11341,1 11397,0 11484,1 11498,0 11523,1 11558,0 11650,1 11678,0 11775,1 11866,0 11906,1 11924,0 12013,1 12061,0 12161,1 12164,0 12186,1 12207,0 12264,1 12310,0 12355,1 12404,0 12415,1 12487,0 12491,1 12584,0 12627,1 12650,0 12683,1 12778,0 12865,1 12921,0 12999,1 13063,0 13103,1 13161,0 13190,1 13262,0 13322,1 13416,0 13485,1 13526,0 13534,1 13546,0 13617,1 13629,0 13648,1 13653,0 13691,1 13758,0 13774,1 13780,0 13848,1 13931,0 13932,1 13947,0 14016,1 14021,0 14096,1 14195,0 14274,1 14340,0 14384,1 14479,0 14509,1 14572,0 14573,1 14618,0 14651,1 14678,0 14721,1 14781,0 14849,1 14881,0 14961,1 14986,0 15039,1 15132,0 15140,1 15152,0 15218,1 15283,0 15286,1 15291,0 15371,1 15421,0 15446,1 15460,0 15509,1 15525,0 15575,1 15631,0 15725,1 15799,0 15819,1 15820,0 15847,1 15887,0 15930,1 16022,0 16043,1 16102,0 16163,1 16226,0 16299,1 16335,0 16432,1 16528,0 16557,1 16611,0 16672,1 16725,0 16753,1 16807,0 16813,1 16890,0 16933,1 16975,0 16980,1 16993,0 17007,1 17081,0 17110,1 17139,0 17185,1 17260,0 17351,1 17387,0 17394,1 17427,0 17494,1 17585,0 17605,1 17683,0 17744,1 17748,0 17843,1 17916,0 17919,1 17922,0 17930,1 17988,0 17994,1 18013,0 18022,1 18118,0 18129,1 18181,0 18223,1 18254,0 18291,1 18331,0 18376,1 18397,0 18480,1 18575,0 18651,1 18680,0 18721,1 18734,0 18792,1 18844,0 18895,1 18985,0 19040,1 19136,0 19157,1 19180,0 19213,1 19263,0 19349,1 19379,0 19442,1 19539,0 19568,1 19601,0 19631,1 19719,0 19720,1 19758,0 19765,1 19823,0 19864,1 19922,0 19993,1 20079,0 20100,1 20153,0 20246,1 20270,0 20332,1 20385,0 20456,1 20531,0 20599,1 20606,0 20615,1 20681,0 20693,1 20746,0 20813,1 20824,0 20884,1 20948,0 20988,1 21014,0 21026,1 21032,0 21064,1 21135,0 21197,1 21268,0 21348,1 21388,0 21390,1 21432,0 21516,1 21612,0 21701,1 21765,0 21833,1 21864,0 21865,1 21924,0 21934,1 22030,0 22071,1 22091,0 22131,1 22196,0 22265,1 22278,0 22321,1 22354,0 22393,1 22481,0 22578,1 22628,0 22676,1 22723,0 22732,1 22747,0 22793,1 22856,0 22903,1 22943,0 22982,1 23082,0 23139,1 23208,0 23291,1 23298,0 23370,1 23416,0 23424,1 23495,0 23566,1 23616,0 23694,1 23781,0 23790,1 23864,0 23898,1 23982,0 24081,1 24103,0 24158,1 24179,0 24184,1 24208,0 24297,1 24368,0 24409,1 24415,0 24454,1 24457,0 24474,1 24539,0 24610,1 24622,0 24657,1 24685,0 24717,1 24721,0 24733,1 24786,0 24817,1 24856,0 24914,1 24997,0 25029,1 25071,0 25139,1 25235,0 25331,1 25351,0 25427,1 25485,0 25553,1 25590,0 25669,1 25674,0 25726,1 25770,0 25857,1 25862,0 25944,1 26009,0 26093,1 26120,0 26130,1 26158,0 26191,1 26283,0 26381,1 26441,0 26453,1 26530,0 26542,1 26604,0 26647,1 26650,0 26696,1 26719,0 26768,1 26846,0 26852,1 26895,0 26966,1 27012,0 27031,1 27064,0 27136,1 27150,0 27209,1 27251,0 27317,1 27329,0 27427,1 27491,0 27500,1 27528,0 27570,1 27647,0 27651,1 27744,0 27788,1 27855,0 27941,1 28009,0 28040,1 28102,0 28148,1 28228,0 28255,1 28332,0 28349,1 28418,0 28507,1 28583,0 28660,1 28671,0 28743,1 28831,0 28925,1 28976,0 29028,1 29070,0 29075,1 29076,0 29151,1 29175,0 29180,1 29186,0 29237,1 29264,0 29284,1 29351,0 29369,1 29396,0 29461,1 29525,0 29569,1 29590,0 29687,1 29705,0 29805,1 29897,0 29929,1 30003,0 30038,1 30094,0 30165,1 30263,0 30268,1 30327,0 30427,1 30448,0 30473,1 30491,0 30567,1 30625,0 30678,1 30764,0 30799,1 30812,0 30834,1 30904,0 30919,1 30989,0 30995,1 31031,0 31039,1 31125,0 31206,1 31245,0 31273,1 31355,0 31444,1 31454,0 31518,1 31570,0 31650,1 31735,0 31811,1 31827,0 31917,1 31990,0 31991,1 32001,0 32035,1 32119,0 32215,1 32307,0 32372,1 32410,0 32419,1 32468,0 32551,1 32603,0 32652,1 32727,0 32731,1 32825,0 32897,1 32913,0 32943,1 33019,0 33048,1 33147,0 33230,1 33296,0 33318,1 33332,0 33402,1 33468,0 33548,1 33644,0 33656,1 33708,0 33746,1 33823,0 33854,1 33884,0 33906,1 33960,0 34047,1 34127,0 34135,1 34155,0 34188,1 34211,0 34235,1 34318,0 34370,1 34437,0 34501,1 34504,0 34584,1 34585,0 34634,1 34638,0 34666,1 34673,0 34708,1 34762,0 34783,1 34853,0 34881,1 34960,0 35051,1 35093,0 35184,1 35278,0 35349,1 35360,0 35458,1 35473,0 35513,1 35519,0 35605,1 35678,0 35685,1 35725,0 35755,1 35777,0 35870,1 35948,0 36000,1 36060,0 36114,1 36139,0 36196,1 36270,0 36274,1 36315,0 36364,1 36447,0 36491,1 36584,0 36653,1 36679,0 36710,1 36779,0 36821,1 36919,0 36959,1 36989,0 36998,1 37065,0 37159,1 37190,0 37209,1 37244,0 37269,1 37353,0 37398,1 37461,0 37555,1 37612,0 37674,1 37753,0 37754,1 37803,0 37846,1 37943,0 37967,1 38029,0 38102,1 38109,0 38198,1 38242,0 38321,1 38381,0 38462,1 38555,0 38629,1 38723,0 38790,1 38858,0 38940,1 39017,0 39055,1 39082,0 39100,1 39135,0 39218,1 39253,0 39305,1 39320,0 39407,1 39415,0 39440,1 39481,0 39559,1 39647,0 39733,1 39762,0 39786,1 39790,0 39831,1 39923,0 39960,1 39979,0 40012,1 40033,0 40051,1 40058,0 40087,1 40163,0 40205,1 40216,0 40304,1 40362,0 40401,1 40410,0 40507,1 40543,0 40566,1 40623,0 40643,1 40686,0 40765,1 40807,0 40823,1 40870,0 40955,1 40974,0 41030,1 41122,0 41193,1 41266,0 41296,1 41375,0 41390,1 41401,0 41459,1 41527,0 41567,1 41584,0 41675,1 41762,0 41789,1 41815,0 41820,1 41825,0 41898,1 41927,0 41931,1 41972,0 42018,1 42061,0 42063,1 42126,0 42199,1 42228,0 42275,1 42311,0 42408,1 42502,0 42594,1 42652,0 42714,1 42726,0 42809,1 42903,0 42968,1 42971,0 43008,1 43082,0 43173,1 43243,0 43288,1 43294,0 43372,1 43409,0 43480,1 43519,0 43567,1 43581,0 43681,1 43697,0 43701,1 43771,0 43864,1 43929,0 43995,1 44007,0 44052,1 44088,0 44135,1 44218,0 44317,1 44387,0 44432,1 44467,0 44561,1 44659,0 44688,1 44781,0 44871,1 44956,0 45039,1 45113,0 45159,1 45233,0 45279,1 45318,0 45416,1 45436,0 45522,1 45545,0 45557,1 45640,0 45675,1 45689,0 45699,1 45704,0 45763,1 45801,0 45883,1 45976,0 45983,1 46069,0 46105,1 46156,0 46181,1 46184,0 46282,1 46315,0 46409,1 46421,0 46422,1 46489,0 46544,1 46596,0 46664,1 46699,0 46702,1 46719,0 46800,1 46866,0 46883,1 46922,0 46947,1 46981,0 47064,1 47136,0 47162,1 47190,0 47222,1 47278,0 47281,1 47311,0 47327,1 47393,0 47411,1 47464,0 47563,1 47627,0 47654,1 47667,0 47712,1 47781,0 47816,1 47826,0 47864,1 47960,0 48030,1 48067,0 48099,1 48113,0 48178,1 48217,0 48234,1 48316,0 48370,1 48378,0 48429,1 48475,0 48501,1 48566,0 48610,1 48643,0 48734,1 48833,0 48841,1 48898,0 48901,1 48993,0 49061,1 49093,0 49151,1 49161,0 49244,1 49330,0 49425,1 end initlist b33 0,0 32,1 77,0 131,1 160,0 189,1 249,0 335,1 348,0 393,1 450,0 511,1 562,0 656,1 699,0 740,1 767,0 817,1 913,0 944,1 981,0 1026,1 1118,0 1211,1 1310,0 1332,1 1415,0 1457,1 1496,0 1575,1 1631,0 1691,1 1751,0 1781,1 1846,0 1857,1 1862,0 1889,1 1932,0 1950,1 1969,0 2063,1 2071,0 2113,1 2206,0 2306,1 2347,0 2360,1 2370,0 2394,1 2403,0 2406,1 2457,0 2531,1 2555,0 2562,1 2621,0 2716,1 2786,0 2815,1 2825,0 2907,1 2952,0 2974,1 3048,0 3084,1 3184,0 3199,1 3259,0 3335,1 3425,0 3448,1 3482,0 3556,1 3605,0 3663,1 3665,0 3706,1 3779,0 3815,1 3832,0 3886,1 3963,0 4019,1 4084,0 4116,1 4153,0 4210,1 4299,0 4361,1 4447,0 4539,1 4623,0 4680,1 4748,0 4766,1 4786,0 4804,1 4889,0 4978,1 4994,0 5069,1 5125,0 5128,1 5162,0 5249,1 5278,0 5311,1 5370,0 5467,1 5476,0 5498,1 5558,0 5588,1 5618,0 5646,1 5740,0 5824,1 5882,0 5903,1 5947,0 6004,1 6053,0 6135,1 6175,0 6252,1 6291,0 6376,1 6404,0 6491,1 6554,0 6638,1 6705,0 6711,1 6768,0 6859,1 6957,0 7057,1 7096,0 7145,1 7178,0 7269,1 7316,0 7374,1 7379,0 7469,1 7540,0 7570,1 7647,0 7655,1 7741,0 7757,1 7804,0 7831,1 7839,0 7911,1 7985,0 8039,1 8085,0 8140,1 8221,0 8272,1 8314,0 8339,1 8363,0 8386,1 8449,0 8506,1 8536,0 8595,1 8624,0 8653,1 8664,0 8695,1 8737,0 8830,1 8884,0 8902,1 8925,0 8936,1 9014,0 9098,1 9157,0 9243,1 9324,0 9364,1 9450,0 9501,1 9554,0 9595,1 9677,0 9723,1 9780,0 9850,1 9950,0 10049,1 10076,0 10117,1 10126,0 10224,1 10314,0 10326,1 10372,0 10432,1 10479,0 10558,1 10569,0 10614,1 10620,0 10689,1 10743,0 10820,1 10889,0 10896,1 10975,0 10992,1 11009,0 11047,1 11100,0 11200,1 11233,0 11307,1 11401,0 11490,1 11547,0 11608,1 11693,0 11723,1 11794,0 11883,1 11969,0 12052,1 12125,0 12221,1 12229,0 12258,1 12263,0 12348,1 12426,0 12486,1 12509,0 12576,1 12584,0 12623,1 12697,0 12781,1 12806,0 12823,1 12835,0 12909,1 12995,0 13091,1 13171,0 13180,1 13271,0 13311,1 13390,0 13395,1 13444,0 13447,1 13462,0 13526,1 13578,0 13667,1 13761,0 13805,1 13807,0 13819,1 13849,0 13887,1 13897,0 13984,1 14051,0 14082,1 14094,0 14109,1 14203,0 14267,1 14294,0 14327,1 14359,0 14452,1 14499,0 14595,1 14653,0 14657,1 14715,0 14736,1 14811,0 14813,1 14896,0 14961,1 14963,0 15012,1 15031,0 15126,1 15141,0 15186,1 15207,0 15267,1 15269,0 15359,1 15441,0 15447,1 15494,0 15570,1 15668,0 15727,1 15815,0 15858,1 15885,0 15902,1 15965,0 16056,1 16113,0 16157,1 16168,0 16264,1 16309,0 16363,1 16417,0 16446,1 16537,0 16621,1 16671,0 16694,1 16755,0 16814,1 16902,0 16923,1 16940,0 16983,1 17004,0 17101,1 17134,0 17206,1 17238,0 17274,1 17367,0 17415,1 17459,0 17473,1 17570,0 17611,1 17646,0 17667,1 17751,0 17813,1 17833,0 17852,1 17902,0 17929,1 17996,0 18042,1 18098,0 18182,1 18256,0 18305,1 18403,0 18457,1 18497,0 18567,1 18569,0 18570,1 18657,0 18687,1 18744,0 18758,1 18837,0 18903,1 18925,0 19013,1 19112,0 19193,1 19248,0 19308,1 19341,0 19420,1 19442,0 19509,1 19561,0 19581,1 19659,0 19698,1 19737,0 19743,1 19793,0 19825,1 19890,0 19937,1 19942,0 20035,1 20097,0 20113,1 20174,0 20215,1 20310,0 20317,1 20398,0 20447,1 20471,0 20544,1 20631,0 20717,1 20770,0 20793,1 20816,0 20831,1 20861,0 20899,1 20994,0 21063,1 21144,0 21159,1 21161,0 21250,1 21334,0 21344,1 21380,0 21392,1 21490,0 21530,1 21621,0 21630,1 21683,0 21707,1 21721,0 21765,1 21792,0 21879,1 21956,0 22006,1 22095,0 22105,1 22162,0 22202,1 22230,0 22254,1 22349,0 22447,1 22546,0 22606,1 22649,0 22744,1 22753,0 22796,1 22887,0 22930,1 22994,0 23058,1 23071,0 23105,1 23115,0 23212,1 23219,0 23245,1 23305,0 23340,1 23425,0 23442,1 23518,0 23612,1 23677,0 23702,1 23754,0 23762,1 23791,0 23881,1 23906,0 23950,1 23993,0 24037,1 24091,0 24141,1 24181,0 24270,1 24313,0 24377,1 24421,0 24460,1 24497,0 24590,1 24641,0 24687,1 24782,0 24819,1 24838,0 24919,1 24998,0 25046,1 25073,0 25137,1 25182,0 25281,1 25327,0 25390,1 25424,0 25504,1 25506,0 25594,1 25621,0 25690,1 25718,0 25813,1 25874,0 25875,1 25960,0 26009,1 26102,0 26148,1 26239,0 26314,1 26352,0 26398,1 26474,0 26552,1 26625,0 26663,1 26682,0 26722,1 26771,0 26805,1 26856,0 26946,1 27030,0 27063,1 27090,0 27167,1 27216,0 27260,1 27287,0 27325,1 27418,0 27510,1 27570,0 27653,1 27735,0 27802,1 27834,0 27867,1 27880,0 27882,1 27885,0 27918,1 27979,0 28035,1 28071,0 28150,1 28231,0 28237,1 28333,0 28397,1 28399,0 28494,1 28508,0 28536,1 28553,0 28607,1 28686,0 28705,1 28767,0 28799,1 28863,0 28905,1 28907,0 28983,1 29035,0 29122,1 29220,0 29259,1 29352,0 29353,1 29410,0 29428,1 29487,0 29575,1 29646,0 29647,1 29668,0 29765,1 29794,0 29834,1 29868,0 29939,1 29954,0 30005,1 30007,0 30013,1 30102,0 30152,1 30235,0 30332,1 30360,0 30372,1 30389,0 30412,1 30505,0 30555,1 30583,0 30599,1 30647,0 30692,1 30768,0 30798,1 30897,0 30925,1 30957,0 31008,1 31016,0 31029,1 31097,0 31146,1 31227,0 31299,1 31394,0 31442,1 31455,0 31535,1 31617,0 31639,1 31645,0 31743,1 31756,0 31812,1 31837,0 31937,1 32014,0 32069,1 32116,0 32201,1 32230,0 32289,1 32349,0 32392,1 32492,0 32552,1 32600,0 32680,1 32714,0 32809,1 32842,0 32931,1 32942,0 32972,1 32982,0 33077,1 33086,0 33139,1 33216,0 33289,1 33334,0 33411,1 33417,0 33465,1 33565,0 33627,1 33695,0 33779,1 33820,0 33886,1 33957,0 34057,1 34122,0 34180,1 34275,0 34330,1 34372,0 34391,1 34425,0 34469,1 34534,0 34553,1 34613,0 34666,1 34691,0 34708,1 34771,0 34830,1 34878,0 34951,1 35047,0 35103,1 35121,0 35123,1 35131,0 35208,1 35247,0 35307,1 35335,0 35366,1 35408,0 35462,1 35480,0 35536,1 35602,0 35659,1 35737,0 35822,1 35883,0 35961,1 36054,0 36079,1 36113,0 36211,1 36241,0 36257,1 36267,0 36277,1 36286,0 36355,1 36379,0 36456,1 36490,0 36508,1 36574,0 36622,1 36627,0 36684,1 36767,0 36789,1 36810,0 36828,1 36878,0 36945,1 36958,0 37031,1 37118,0 37189,1 37239,0 37316,1 37373,0 37449,1 37466,0 37472,1 37559,0 37619,1 37690,0 37778,1 37849,0 37914,1 38012,0 38055,1 38111,0 38119,1 38152,0 38161,1 38226,0 38300,1 38328,0 38426,1 38488,0 38561,1 38567,0 38601,1 38693,0 38695,1 38714,0 38751,1 38758,0 38781,1 38782,0 38840,1 38846,0 38932,1 38938,0 39032,1 39123,0 39179,1 39182,0 39273,1 39307,0 39379,1 39476,0 39549,1 39611,0 39696,1 39728,0 39774,1 39842,0 39930,1 39984,0 39992,1 39996,0 40012,1 40062,0 40079,1 40113,0 40181,1 40279,0 40310,1 40384,0 40397,1 40423,0 40442,1 40468,0 40522,1 40606,0 40615,1 40656,0 40719,1 40748,0 40770,1 40836,0 40856,1 40901,0 40945,1 40978,0 41024,1 41055,0 41141,1 41169,0 41265,1 41351,0 41370,1 41450,0 41471,1 41483,0 41539,1 41625,0 41695,1 41718,0 41773,1 41832,0 41880,1 41939,0 42032,1 42056,0 42114,1 42133,0 42198,1 42215,0 42282,1 42345,0 42359,1 42381,0 42480,1 42555,0 42616,1 42630,0 42714,1 42772,0 42775,1 42808,0 42810,1 42888,0 42927,1 42969,0 42991,1 43074,0 43099,1 43172,0 43221,1 43300,0 43370,1 43418,0 43423,1 43464,0 43520,1 43593,0 43654,1 43657,0 43752,1 43808,0 43894,1 43946,0 43995,1 43996,0 44002,1 44066,0 44098,1 44176,0 44214,1 44301,0 44344,1 44434,0 44444,1 44480,0 44543,1 44640,0 44712,1 44759,0 44847,1 44869,0 44919,1 44933,0 44965,1 45007,0 45064,1 45114,0 45141,1 45210,0 45295,1 45336,0 45409,1 45501,0 45579,1 45616,0 45693,1 45724,0 45801,1 45847,0 45901,1 45909,0 45989,1 46048,0 46124,1 46137,0 46216,1 46268,0 46284,1 46343,0 46359,1 46360,0 46395,1 46414,0 46461,1 46546,0 46595,1 46691,0 46720,1 46795,0 46797,1 46813,0 46870,1 46966,0 47047,1 47143,0 47221,1 47319,0 47392,1 47450,0 47471,1 47522,0 47586,1 47649,0 47691,1 47748,0 47769,1 47840,0 47929,1 47954,0 48007,1 48060,0 48071,1 48168,0 48256,1 48336,0 48422,1 48471,0 48498,1 48562,0 48581,1 48633,0 48709,1 48802,0 48899,1 48942,0 49002,1 49085,0 49111,1 49160,0 49166,1 49230,0 49317,1 49330,0 49416,1 49481,0 49530,1 49612,0 49694,1 49732,0 49782,1 49793,0 49881,1 49971,0 50040,1 50083,0 50118,1 50215,0 50314,1 50365,0 50408,1 50502,0 50549,1 50588,0 50589,1 50643,0 50714,1 50795,0 50817,1 50853,0 50879,1 50887,0 50940,1 51034,0 51065,1 51163,0 51207,1 51261,0 51356,1 51431,0 51473,1 end initlist b34 0,0 99,1 121,0 184,1 265,0 351,1 399,0 415,1 454,0 543,1 571,0 628,1 631,0 647,1 722,0 781,1 821,0 822,1 909,0 967,1 1005,0 1084,1 1178,0 1200,1 1215,0 1227,1 1242,0 1245,1 1322,0 1402,1 1422,0 1470,1 1549,0 1607,1 1690,0 1783,1 1841,0 1909,1 1971,0 2018,1 2089,0 2124,1 2138,0 2215,1 2241,0 2321,1 2367,0 2443,1 2490,0 2583,1 2635,0 2678,1 2766,0 2837,1 2870,0 2940,1 3019,0 3073,1 3075,0 3153,1 3163,0 3215,1 3239,0 3309,1 3345,0 3355,1 3365,0 3394,1 3483,0 3494,1 3540,0 3553,1 3574,0 3588,1 3601,0 3650,1 3668,0 3766,1 3767,0 3813,1 3854,0 3887,1 3963,0 3984,1 4072,0 4129,1 4130,0 4139,1 4229,0 4256,1 4348,0 4362,1 4395,0 4421,1 4515,0 4557,1 4563,0 4569,1 4668,0 4766,1 4855,0 4924,1 4954,0 4955,1 4989,0 5007,1 5068,0 5167,1 5236,0 5267,1 5278,0 5368,1 5391,0 5477,1 5517,0 5548,1 5623,0 5656,1 5665,0 5677,1 5739,0 5838,1 5884,0 5941,1 5980,0 6039,1 6103,0 6139,1 6227,0 6306,1 6307,0 6401,1 6490,0 6522,1 6600,0 6678,1 6696,0 6774,1 6848,0 6913,1 6953,0 7024,1 7112,0 7167,1 7237,0 7310,1 7408,0 7433,1 7510,0 7580,1 7588,0 7629,1 7728,0 7752,1 7807,0 7895,1 7959,0 8044,1 8125,0 8155,1 8196,0 8277,1 8286,0 8367,1 8392,0 8473,1 8502,0 8535,1 8615,0 8679,1 8773,0 8774,1 8847,0 8927,1 8944,0 9033,1 9108,0 9111,1 9173,0 9248,1 9281,0 9333,1 9336,0 9349,1 9408,0 9482,1 9578,0 9606,1 9694,0 9768,1 9782,0 9783,1 9799,0 9862,1 9902,0 9976,1 10074,0 10144,1 10150,0 10178,1 10219,0 10316,1 10386,0 10425,1 10516,0 10540,1 10592,0 10597,1 10669,0 10746,1 10752,0 10851,1 10855,0 10923,1 10983,0 10989,1 11014,0 11112,1 11146,0 11156,1 11194,0 11197,1 11260,0 11267,1 11356,0 11425,1 11509,0 11571,1 11618,0 11620,1 11647,0 11664,1 11730,0 11760,1 11850,0 11890,1 11913,0 11964,1 12015,0 12078,1 12178,0 12205,1 12261,0 12294,1 12322,0 12349,1 12393,0 12441,1 12460,0 12547,1 12556,0 12630,1 12682,0 12692,1 12705,0 12745,1 12811,0 12892,1 12937,0 12942,1 12944,0 12974,1 13057,0 13135,1 13219,0 13270,1 13312,0 13403,1 13417,0 13496,1 13560,0 13593,1 13645,0 13679,1 13686,0 13707,1 13778,0 13805,1 13848,0 13903,1 13928,0 14001,1 14069,0 14101,1 14150,0 14218,1 14304,0 14366,1 14460,0 14533,1 14577,0 14647,1 14692,0 14752,1 14774,0 14783,1 14801,0 14843,1 14868,0 14869,1 14934,0 14955,1 15014,0 15098,1 15164,0 15236,1 15252,0 15311,1 15332,0 15365,1 15387,0 15437,1 15490,0 15512,1 15599,0 15652,1 15702,0 15736,1 15778,0 15783,1 15823,0 15838,1 15855,0 15901,1 15947,0 16022,1 16110,0 16149,1 16150,0 16222,1 16316,0 16358,1 16418,0 16432,1 16442,0 16495,1 16498,0 16540,1 16566,0 16614,1 16688,0 16712,1 16784,0 16811,1 16824,0 16900,1 16937,0 16956,1 16971,0 16991,1 17064,0 17135,1 17213,0 17296,1 17370,0 17469,1 17488,0 17547,1 17631,0 17634,1 17650,0 17694,1 17753,0 17833,1 17845,0 17848,1 17862,0 17895,1 17952,0 17976,1 18042,0 18045,1 18118,0 18161,1 18241,0 18242,1 18272,0 18345,1 18377,0 18382,1 18413,0 18452,1 18501,0 18580,1 18624,0 18656,1 18715,0 18717,1 18761,0 18803,1 18879,0 18915,1 18922,0 18986,1 18988,0 19047,1 19056,0 19065,1 19139,0 19185,1 19249,0 19270,1 19354,0 19428,1 19454,0 19473,1 19572,0 19573,1 19642,0 19673,1 19703,0 19727,1 19731,0 19807,1 19866,0 19886,1 19985,0 20044,1 20106,0 20111,1 20119,0 20167,1 20190,0 20211,1 20227,0 20307,1 20370,0 20451,1 20523,0 20585,1 20597,0 20639,1 20676,0 20695,1 20749,0 20772,1 20855,0 20939,1 20979,0 21027,1 21127,0 21130,1 21146,0 21240,1 21256,0 21287,1 21289,0 21347,1 21406,0 21443,1 21480,0 21561,1 21581,0 21649,1 21708,0 21769,1 21773,0 21810,1 21852,0 21874,1 21884,0 21905,1 21950,0 22019,1 22118,0 22159,1 22172,0 22183,1 22282,0 22355,1 22409,0 22486,1 22560,0 22648,1 22678,0 22761,1 22840,0 22928,1 22993,0 23035,1 23073,0 23117,1 23188,0 23202,1 23239,0 23260,1 23343,0 23357,1 23441,0 23539,1 23598,0 23653,1 23753,0 23803,1 23895,0 23973,1 24018,0 24044,1 24121,0 24159,1 24200,0 24213,1 24265,0 24309,1 24348,0 24378,1 24463,0 24526,1 24581,0 24634,1 24699,0 24756,1 24804,0 24854,1 24910,0 24973,1 25043,0 25098,1 25112,0 25149,1 25188,0 25270,1 25317,0 25329,1 25376,0 25463,1 25512,0 25608,1 25610,0 25691,1 25777,0 25876,1 25972,0 26060,1 26062,0 26139,1 26205,0 26266,1 26292,0 26337,1 26409,0 26432,1 26508,0 26598,1 26615,0 26622,1 26644,0 26707,1 26803,0 26836,1 26890,0 26892,1 26956,0 27031,1 27119,0 27165,1 27247,0 27313,1 27397,0 27433,1 27449,0 27524,1 27550,0 27643,1 27655,0 27670,1 27739,0 27751,1 27770,0 27805,1 27887,0 27911,1 27921,0 27944,1 27947,0 27987,1 28058,0 28059,1 28121,0 28129,1 28181,0 28231,1 28239,0 28260,1 28337,0 28391,1 28481,0 28513,1 28545,0 28585,1 28595,0 28670,1 28702,0 28709,1 28789,0 28828,1 28872,0 28943,1 28974,0 29046,1 29073,0 29080,1 29133,0 29143,1 29223,0 29292,1 29355,0 29386,1 29412,0 29512,1 29529,0 29595,1 29634,0 29682,1 29700,0 29734,1 29799,0 29876,1 29882,0 29955,1 29990,0 30035,1 30110,0 30177,1 30194,0 30293,1 30352,0 30408,1 30448,0 30487,1 30527,0 30562,1 30569,0 30669,1 30767,0 30831,1 30901,0 30905,1 30907,0 30986,1 31028,0 31090,1 31158,0 31237,1 31337,0 31390,1 31446,0 31466,1 31467,0 31562,1 31652,0 31698,1 31718,0 31785,1 31815,0 31837,1 31899,0 31981,1 32040,0 32085,1 32100,0 32120,1 32180,0 32217,1 32305,0 32327,1 32379,0 32392,1 32482,0 32543,1 32561,0 32621,1 32715,0 32764,1 32838,0 32934,1 32946,0 32956,1 32975,0 33040,1 33122,0 33152,1 33154,0 33193,1 33229,0 33293,1 33303,0 33329,1 33353,0 33453,1 33551,0 33587,1 33670,0 33711,1 33753,0 33825,1 33909,0 33976,1 34023,0 34109,1 34191,0 34286,1 34311,0 34341,1 34441,0 34535,1 34550,0 34641,1 34697,0 34747,1 34846,0 34890,1 34939,0 35008,1 35049,0 35097,1 35147,0 35222,1 35321,0 35348,1 35411,0 35509,1 35592,0 35626,1 35695,0 35739,1 35821,0 35847,1 35913,0 35976,1 36036,0 36050,1 36076,0 36118,1 36138,0 36185,1 36255,0 36324,1 36419,0 36427,1 36526,0 36566,1 36614,0 36688,1 36717,0 36746,1 36786,0 36839,1 36919,0 37006,1 37013,0 37063,1 37070,0 37116,1 37167,0 37199,1 37271,0 37337,1 37357,0 37457,1 37548,0 37566,1 37631,0 37694,1 37707,0 37757,1 37848,0 37892,1 37900,0 37921,1 37962,0 38056,1 38099,0 38175,1 38186,0 38258,1 38312,0 38345,1 38418,0 38471,1 38484,0 38579,1 38605,0 38700,1 38711,0 38742,1 38785,0 38813,1 38837,0 38937,1 38952,0 39030,1 39051,0 39147,1 39166,0 39191,1 39211,0 39249,1 39275,0 39281,1 39317,0 39413,1 39471,0 39538,1 39542,0 39596,1 39663,0 39752,1 39758,0 39823,1 39857,0 39946,1 39998,0 40016,1 40021,0 40074,1 40127,0 40219,1 40274,0 40374,1 40462,0 40511,1 40576,0 40652,1 40654,0 40748,1 40786,0 40819,1 40857,0 40878,1 40949,0 41044,1 41120,0 41154,1 41244,0 41309,1 41356,0 41446,1 41473,0 41523,1 41555,0 41581,1 41609,0 41623,1 41667,0 41671,1 41768,0 41774,1 41789,0 41812,1 41832,0 41922,1 41975,0 42033,1 42132,0 42174,1 42213,0 42277,1 42296,0 42351,1 42364,0 42432,1 42512,0 42597,1 42643,0 42699,1 42730,0 42754,1 42803,0 42813,1 42860,0 42916,1 43009,0 43086,1 43118,0 43182,1 43221,0 43314,1 43348,0 43400,1 43407,0 43426,1 43484,0 43531,1 43604,0 43646,1 43660,0 43691,1 43711,0 43732,1 43781,0 43880,1 43923,0 43948,1 43965,0 44002,1 44019,0 44035,1 44076,0 44121,1 44151,0 44242,1 44339,0 44353,1 44432,0 44516,1 44584,0 44648,1 44684,0 44757,1 44819,0 44824,1 44898,0 44987,1 45057,0 45135,1 45234,0 45323,1 45419,0 45452,1 45495,0 45588,1 45644,0 45734,1 45810,0 45880,1 45935,0 46023,1 46109,0 46159,1 46173,0 46267,1 46366,0 46445,1 46484,0 46498,1 46557,0 46592,1 46636,0 46679,1 46732,0 46821,1 46833,0 46854,1 46896,0 46905,1 46908,0 46963,1 47022,0 47086,1 47155,0 47236,1 47331,0 47405,1 47458,0 47531,1 47600,0 47636,1 47652,0 47735,1 47747,0 47835,1 47889,0 47970,1 48043,0 48090,1 48158,0 48194,1 48293,0 48375,1 48386,0 48468,1 48552,0 48597,1 48632,0 48641,1 48696,0 48746,1 48782,0 48813,1 48838,0 48919,1 48955,0 48961,1 48986,0 48993,1 49013,0 49095,1 49151,0 49210,1 49229,0 49245,1 49306,0 49373,1 49374,0 49449,1 49464,0 49505,1 49566,0 49575,1 49582,0 49621,1 end initlist b35 0,0 83,1 151,0 238,1 300,0 362,1 421,0 469,1 505,0 566,1 587,0 617,1 699,0 748,1 820,0 895,1 959,0 1038,1 1070,0 1135,1 1137,0 1202,1 1217,0 1234,1 1327,0 1386,1 1392,0 1428,1 1484,0 1571,1 1666,0 1723,1 1726,0 1805,1 1891,0 1942,1 1970,0 2005,1 2057,0 2061,1 2147,0 2223,1 2298,0 2377,1 2458,0 2529,1 2591,0 2596,1 2672,0 2683,1 2762,0 2814,1 2818,0 2841,1 2878,0 2884,1 2906,0 2984,1 3072,0 3099,1 3105,0 3127,1 3155,0 3189,1 3237,0 3266,1 3278,0 3374,1 3378,0 3439,1 3534,0 3590,1 3674,0 3745,1 3776,0 3875,1 3887,0 3950,1 3991,0 4065,1 4108,0 4165,1 4170,0 4249,1 4342,0 4411,1 4422,0 4504,1 4590,0 4637,1 4678,0 4724,1 4749,0 4782,1 4856,0 4914,1 4939,0 5027,1 5077,0 5134,1 5157,0 5196,1 5235,0 5306,1 5330,0 5359,1 5414,0 5505,1 5557,0 5622,1 5695,0 5710,1 5804,0 5876,1 5946,0 5957,1 5994,0 6006,1 6085,0 6109,1 6131,0 6162,1 6198,0 6236,1 6294,0 6353,1 6408,0 6435,1 6473,0 6503,1 6564,0 6661,1 6699,0 6707,1 6718,0 6794,1 6889,0 6905,1 6960,0 6977,1 7019,0 7026,1 7037,0 7105,1 7146,0 7207,1 7292,0 7355,1 7415,0 7490,1 7492,0 7495,1 7563,0 7574,1 7596,0 7609,1 7693,0 7761,1 7844,0 7890,1 7928,0 7975,1 8020,0 8120,1 8192,0 8259,1 8298,0 8366,1 8403,0 8498,1 8591,0 8683,1 8756,0 8759,1 8798,0 8804,1 8874,0 8931,1 8989,0 9041,1 9123,0 9192,1 9240,0 9289,1 9339,0 9429,1 9526,0 9575,1 9605,0 9611,1 9671,0 9742,1 9819,0 9837,1 9850,0 9851,1 9870,0 9890,1 9980,0 10046,1 10081,0 10099,1 10163,0 10171,1 10260,0 10348,1 10448,0 10466,1 10494,0 10587,1 10649,0 10661,1 10696,0 10713,1 10767,0 10864,1 10897,0 10985,1 11033,0 11098,1 11113,0 11134,1 11234,0 11268,1 11355,0 11449,1 11455,0 11548,1 11581,0 11670,1 11765,0 11814,1 11898,0 11945,1 12017,0 12078,1 12122,0 12151,1 12212,0 12298,1 12350,0 12363,1 12426,0 12436,1 12443,0 12518,1 12590,0 12620,1 12698,0 12796,1 12832,0 12840,1 12933,0 13019,1 13022,0 13116,1 13142,0 13192,1 13205,0 13272,1 13352,0 13405,1 13498,0 13527,1 13619,0 13678,1 13754,0 13774,1 13849,0 13925,1 13994,0 14010,1 14104,0 14180,1 14265,0 14288,1 14335,0 14431,1 14506,0 14605,1 14649,0 14694,1 14752,0 14767,1 14779,0 14869,1 14921,0 14979,1 15015,0 15066,1 15092,0 15126,1 15202,0 15259,1 15319,0 15336,1 15395,0 15462,1 15501,0 15591,1 15623,0 15625,1 15673,0 15746,1 15825,0 15921,1 15957,0 15973,1 15983,0 15984,1 16052,0 16097,1 16106,0 16201,1 16245,0 16334,1 16417,0 16448,1 16519,0 16550,1 16624,0 16706,1 16709,0 16787,1 16872,0 16918,1 16976,0 17000,1 17089,0 17121,1 17151,0 17165,1 17190,0 17261,1 17343,0 17398,1 17463,0 17545,1 17595,0 17676,1 17737,0 17820,1 17862,0 17951,1 17984,0 18060,1 18096,0 18143,1 18207,0 18281,1 18283,0 18331,1 18391,0 18395,1 18462,0 18556,1 18564,0 18631,1 18695,0 18747,1 18824,0 18923,1 18967,0 19048,1 19078,0 19169,1 19210,0 19292,1 19337,0 19345,1 19360,0 19445,1 19463,0 19485,1 19524,0 19559,1 19595,0 19635,1 19637,0 19725,1 19770,0 19788,1 19825,0 19839,1 19928,0 19988,1 19994,0 20044,1 20067,0 20162,1 20187,0 20204,1 20238,0 20246,1 20320,0 20385,1 20387,0 20394,1 20489,0 20514,1 20547,0 20630,1 20635,0 20702,1 20752,0 20792,1 20853,0 20889,1 20915,0 20953,1 20985,0 21014,1 21077,0 21101,1 21178,0 21216,1 21279,0 21291,1 21303,0 21341,1 21367,0 21402,1 21496,0 21566,1 21649,0 21689,1 21782,0 21849,1 21903,0 21979,1 22048,0 22084,1 22088,0 22146,1 22242,0 22290,1 22311,0 22365,1 22453,0 22524,1 22557,0 22604,1 22673,0 22729,1 22731,0 22775,1 22818,0 22901,1 22995,0 23032,1 23057,0 23112,1 23127,0 23169,1 23254,0 23298,1 23387,0 23423,1 23515,0 23614,1 23664,0 23738,1 23817,0 23853,1 23871,0 23896,1 23988,0 24083,1 24169,0 24247,1 24292,0 24374,1 24470,0 24567,1 24585,0 24639,1 24676,0 24703,1 24715,0 24804,1 24819,0 24856,1 24876,0 24939,1 25022,0 25035,1 25047,0 25146,1 25222,0 25270,1 25301,0 25357,1 25407,0 25499,1 25524,0 25618,1 25707,0 25760,1 25790,0 25884,1 25912,0 25933,1 25999,0 26033,1 26097,0 26151,1 26248,0 26292,1 26346,0 26359,1 26368,0 26400,1 26473,0 26494,1 26573,0 26654,1 26704,0 26707,1 26761,0 26764,1 26824,0 26890,1 26933,0 26979,1 27056,0 27122,1 27174,0 27236,1 27286,0 27312,1 27314,0 27389,1 27447,0 27478,1 27500,0 27529,1 27565,0 27572,1 27632,0 27732,1 27744,0 27752,1 27774,0 27818,1 27840,0 27939,1 27966,0 28030,1 28126,0 28141,1 28231,0 28321,1 28395,0 28470,1 28520,0 28618,1 28656,0 28743,1 28813,0 28825,1 28883,0 28890,1 28936,0 28982,1 29026,0 29067,1 29103,0 29137,1 29162,0 29172,1 29240,0 29320,1 29414,0 29468,1 29538,0 29609,1 29709,0 29751,1 29800,0 29807,1 29856,0 29863,1 29937,0 30013,1 30031,0 30122,1 30158,0 30184,1 30241,0 30294,1 30342,0 30357,1 30443,0 30449,1 30513,0 30603,1 30616,0 30672,1 30736,0 30811,1 30871,0 30891,1 30915,0 30937,1 31025,0 31088,1 31186,0 31187,1 31200,0 31260,1 31320,0 31351,1 31413,0 31492,1 31565,0 31608,1 31699,0 31725,1 31749,0 31832,1 31906,0 31910,1 31970,0 32001,1 32070,0 32151,1 32153,0 32209,1 32284,0 32326,1 32395,0 32437,1 32442,0 32540,1 32600,0 32671,1 32731,0 32796,1 32825,0 32841,1 32932,0 32977,1 33043,0 33050,1 33099,0 33170,1 33210,0 33282,1 33329,0 33354,1 33375,0 33430,1 33482,0 33567,1 33576,0 33615,1 33650,0 33683,1 33739,0 33756,1 33781,0 33843,1 33890,0 33946,1 33975,0 33981,1 34078,0 34141,1 34197,0 34206,1 34236,0 34258,1 34319,0 34347,1 34424,0 34480,1 34492,0 34539,1 34603,0 34667,1 34711,0 34756,1 34817,0 34875,1 34919,0 34920,1 35020,0 35098,1 35175,0 35218,1 35271,0 35301,1 35364,0 35368,1 35430,0 35481,1 35557,0 35623,1 35658,0 35689,1 35789,0 35868,1 35915,0 35918,1 36004,0 36012,1 36021,0 36103,1 36121,0 36212,1 36255,0 36346,1 36354,0 36450,1 36463,0 36536,1 36608,0 36616,1 36712,0 36741,1 36767,0 36866,1 36905,0 36958,1 37050,0 37113,1 37139,0 37160,1 37161,0 37171,1 37212,0 37302,1 37324,0 37391,1 37443,0 37496,1 37518,0 37608,1 37644,0 37729,1 37810,0 37887,1 37926,0 37972,1 38061,0 38086,1 38177,0 38251,1 38323,0 38402,1 38421,0 38426,1 38482,0 38542,1 38597,0 38670,1 38707,0 38723,1 38806,0 38874,1 38876,0 38975,1 39027,0 39053,1 39125,0 39182,1 39234,0 39264,1 39310,0 39401,1 39438,0 39449,1 39535,0 39602,1 39655,0 39675,1 39712,0 39782,1 39815,0 39822,1 39865,0 39883,1 39916,0 40001,1 40091,0 40112,1 40130,0 40212,1 40255,0 40303,1 40349,0 40383,1 40392,0 40423,1 40495,0 40560,1 40633,0 40700,1 40716,0 40801,1 40899,0 40966,1 41053,0 41131,1 41144,0 41216,1 41300,0 41376,1 41445,0 41487,1 41558,0 41612,1 41677,0 41724,1 41800,0 41849,1 41893,0 41900,1 41984,0 42051,1 42143,0 42215,1 42250,0 42271,1 42351,0 42361,1 42365,0 42421,1 42483,0 42487,1 42554,0 42575,1 42665,0 42762,1 42807,0 42840,1 42853,0 42899,1 42910,0 42962,1 43022,0 43117,1 43197,0 43248,1 43265,0 43299,1 43370,0 43443,1 43511,0 43577,1 43604,0 43658,1 43750,0 43843,1 43912,0 44009,1 44064,0 44086,1 44142,0 44167,1 44226,0 44303,1 44388,0 44410,1 44444,0 44540,1 44627,0 44727,1 44805,0 44845,1 44899,0 44961,1 44968,0 44980,1 44997,0 45086,1 45160,0 45165,1 45251,0 45260,1 45280,0 45284,1 45371,0 45432,1 45530,0 45611,1 45666,0 45764,1 45768,0 45821,1 45909,0 45959,1 45991,0 46006,1 46082,0 46097,1 46138,0 46212,1 46251,0 46297,1 46365,0 46456,1 46516,0 46541,1 46583,0 46661,1 46690,0 46762,1 46857,0 46950,1 47028,0 47057,1 47105,0 47205,1 47247,0 47249,1 47348,0 47426,1 47461,0 47462,1 47506,0 47528,1 47566,0 47567,1 47662,0 47718,1 47775,0 47868,1 47898,0 47935,1 47980,0 48022,1 48047,0 48122,1 48187,0 48278,1 48282,0 48360,1 48423,0 48479,1 48567,0 48628,1 48703,0 48764,1 48861,0 48942,1 48993,0 48995,1 49025,0 49034,1 49063,0 49071,1 49121,0 49185,1 49271,0 49370,1 49460,0 49495,1 49499,0 49581,1 49591,0 49619,1 49664,0 49707,1 49755,0 49836,1 49926,0 50022,1 50077,0 50154,1 50197,0 50240,1 50318,0 50396,1 50451,0 50529,1 50554,0 50619,1 50633,0 50704,1 50768,0 50810,1 50847,0 50942,1 50970,0 50978,1 51072,0 51125,1 51129,0 51166,1 51178,0 51248,1 51329,0 51332,1 51418,0 51478,1 51533,0 51600,1 51602,0 51613,1 51685,0 51706,1 end initlist b36 0,0 43,1 105,0 146,1 206,0 261,1 350,0 398,1 463,0 469,1 546,0 565,1 606,0 641,1 709,0 799,1 826,0 911,1 912,0 995,1 1054,0 1080,1 1144,0 1241,1 1308,0 1344,1 1402,0 1409,1 1435,0 1450,1 1477,0 1545,1 1571,0 1598,1 1697,0 1744,1 1807,0 1884,1 1962,0 2048,1 2123,0 2154,1 2237,0 2284,1 2349,0 2380,1 2471,0 2555,1 2627,0 2631,1 2666,0 2733,1 2764,0 2845,1 2873,0 2923,1 2942,0 2985,1 3024,0 3043,1 3078,0 3136,1 3167,0 3262,1 3352,0 3449,1 3467,0 3529,1 3578,0 3606,1 3651,0 3700,1 3793,0 3838,1 3925,0 3962,1 4033,0 4048,1 4064,0 4094,1 4163,0 4174,1 4212,0 4235,1 4281,0 4287,1 4326,0 4346,1 4422,0 4508,1 4561,0 4586,1 4602,0 4676,1 4687,0 4761,1 4842,0 4934,1 4958,0 5023,1 5114,0 5169,1 5263,0 5280,1 5327,0 5331,1 5351,0 5357,1 5417,0 5483,1 5569,0 5583,1 5606,0 5665,1 5750,0 5761,1 5815,0 5861,1 5881,0 5930,1 6029,0 6105,1 6196,0 6240,1 6322,0 6419,1 6478,0 6487,1 6551,0 6556,1 6584,0 6612,1 6675,0 6688,1 6717,0 6773,1 6821,0 6895,1 6942,0 7040,1 7057,0 7121,1 7167,0 7244,1 7310,0 7409,1 7487,0 7517,1 7577,0 7625,1 7632,0 7701,1 7703,0 7753,1 7769,0 7857,1 7947,0 8000,1 8007,0 8034,1 8127,0 8179,1 8228,0 8229,1 8294,0 8324,1 8415,0 8456,1 8503,0 8579,1 8612,0 8682,1 8688,0 8729,1 8742,0 8814,1 8833,0 8913,1 8947,0 8962,1 9048,0 9107,1 9184,0 9248,1 9304,0 9317,1 9382,0 9461,1 9543,0 9582,1 9634,0 9638,1 9677,0 9725,1 9738,0 9801,1 9834,0 9837,1 9841,0 9842,1 9865,0 9949,1 9955,0 10047,1 10104,0 10156,1 10226,0 10244,1 10340,0 10412,1 10415,0 10417,1 10457,0 10546,1 10559,0 10644,1 10724,0 10794,1 10887,0 10891,1 10924,0 10958,1 10973,0 10987,1 10988,0 11033,1 11127,0 11212,1 11292,0 11381,1 11442,0 11519,1 11585,0 11645,1 11727,0 11756,1 11856,0 11938,1 11949,0 11960,1 11980,0 12056,1 12104,0 12150,1 12197,0 12286,1 12324,0 12416,1 12448,0 12463,1 12554,0 12628,1 12712,0 12788,1 12886,0 12949,1 12981,0 13062,1 13115,0 13163,1 13189,0 13225,1 13249,0 13260,1 13266,0 13314,1 13410,0 13448,1 13547,0 13613,1 13620,0 13662,1 13755,0 13821,1 13875,0 13887,1 13976,0 14075,1 14154,0 14215,1 14289,0 14292,1 14332,0 14366,1 14458,0 14533,1 14598,0 14648,1 14708,0 14785,1 14803,0 14886,1 14951,0 15051,1 15113,0 15139,1 15160,0 15257,1 15347,0 15396,1 15427,0 15480,1 15510,0 15574,1 15636,0 15653,1 15744,0 15757,1 15760,0 15855,1 15858,0 15865,1 15918,0 15991,1 16038,0 16109,1 16158,0 16161,1 16184,0 16197,1 16217,0 16269,1 16327,0 16388,1 16394,0 16397,1 16493,0 16552,1 16650,0 16697,1 16703,0 16766,1 16830,0 16908,1 17001,0 17074,1 17120,0 17180,1 17193,0 17221,1 17315,0 17337,1 17413,0 17488,1 17533,0 17605,1 17611,0 17673,1 17701,0 17705,1 17739,0 17837,1 17920,0 18011,1 18015,0 18016,1 18077,0 18160,1 18254,0 18331,1 18409,0 18453,1 18487,0 18509,1 18590,0 18673,1 18724,0 18762,1 18825,0 18858,1 18869,0 18925,1 19024,0 19045,1 19053,0 19105,1 19120,0 19137,1 19188,0 19224,1 19227,0 19315,1 19334,0 19346,1 19443,0 19468,1 19529,0 19570,1 19584,0 19659,1 19721,0 19759,1 19805,0 19822,1 19897,0 19907,1 19909,0 19949,1 19965,0 20000,1 20012,0 20057,1 20156,0 20217,1 20287,0 20321,1 20329,0 20369,1 20415,0 20469,1 20500,0 20572,1 20654,0 20701,1 20796,0 20805,1 20821,0 20885,1 20952,0 20964,1 20982,0 21078,1 21171,0 21217,1 21222,0 21305,1 21355,0 21380,1 21435,0 21460,1 21496,0 21539,1 21592,0 21638,1 21694,0 21743,1 21752,0 21770,1 21799,0 21854,1 21937,0 22002,1 22077,0 22079,1 22103,0 22155,1 22158,0 22208,1 22266,0 22309,1 22350,0 22431,1 22518,0 22572,1 22580,0 22631,1 22636,0 22656,1 22677,0 22745,1 22781,0 22881,1 22963,0 23001,1 23055,0 23065,1 23164,0 23196,1 23217,0 23241,1 23270,0 23355,1 23396,0 23470,1 23551,0 23616,1 23685,0 23759,1 23837,0 23934,1 23969,0 23994,1 24078,0 24083,1 24099,0 24155,1 24210,0 24245,1 24290,0 24347,1 24419,0 24438,1 24468,0 24504,1 24509,0 24553,1 24577,0 24593,1 24605,0 24639,1 24656,0 24747,1 24758,0 24829,1 24860,0 24948,1 25038,0 25087,1 25135,0 25220,1 25315,0 25400,1 25414,0 25423,1 25486,0 25524,1 25613,0 25665,1 25764,0 25807,1 25837,0 25882,1 25968,0 25993,1 26010,0 26059,1 26159,0 26252,1 26264,0 26319,1 26331,0 26404,1 26441,0 26446,1 26532,0 26588,1 26638,0 26681,1 26777,0 26872,1 26877,0 26957,1 27025,0 27053,1 27116,0 27119,1 27171,0 27235,1 27253,0 27325,1 27402,0 27416,1 27432,0 27465,1 27557,0 27623,1 27656,0 27736,1 27769,0 27803,1 27811,0 27832,1 27897,0 27982,1 28007,0 28078,1 28094,0 28140,1 28230,0 28327,1 28356,0 28450,1 28453,0 28537,1 28561,0 28659,1 28676,0 28770,1 28822,0 28898,1 28971,0 29065,1 29102,0 29142,1 29228,0 29259,1 29267,0 29315,1 29337,0 29422,1 29513,0 29563,1 29654,0 29689,1 29722,0 29763,1 29776,0 29825,1 29902,0 29949,1 29962,0 29971,1 30047,0 30076,1 30121,0 30200,1 30222,0 30264,1 30288,0 30381,1 30452,0 30526,1 30566,0 30581,1 30617,0 30652,1 30689,0 30771,1 30815,0 30881,1 30923,0 30987,1 31062,0 31096,1 31181,0 31237,1 31327,0 31411,1 31489,0 31498,1 31502,0 31512,1 31548,0 31617,1 31698,0 31722,1 31789,0 31802,1 31860,0 31934,1 31961,0 32030,1 32115,0 32142,1 32210,0 32256,1 32297,0 32324,1 32408,0 32421,1 32438,0 32530,1 32593,0 32603,1 32632,0 32691,1 32764,0 32782,1 32830,0 32900,1 32986,0 33029,1 33079,0 33131,1 33222,0 33255,1 33333,0 33368,1 33425,0 33456,1 33465,0 33563,1 33575,0 33630,1 33681,0 33720,1 33771,0 33780,1 33855,0 33918,1 33996,0 34093,1 34107,0 34141,1 34154,0 34245,1 34259,0 34279,1 34284,0 34343,1 34408,0 34440,1 34462,0 34463,1 34498,0 34589,1 34681,0 34763,1 34768,0 34809,1 34856,0 34946,1 35007,0 35018,1 35114,0 35174,1 35184,0 35268,1 35358,0 35424,1 35487,0 35528,1 35575,0 35672,1 35736,0 35761,1 35788,0 35836,1 35838,0 35898,1 35965,0 36041,1 36101,0 36140,1 36146,0 36224,1 36234,0 36280,1 36357,0 36456,1 36506,0 36596,1 36615,0 36707,1 36789,0 36829,1 36916,0 36948,1 36988,0 37033,1 37131,0 37173,1 37207,0 37248,1 37285,0 37307,1 37382,0 37464,1 37497,0 37537,1 37574,0 37648,1 37695,0 37760,1 37768,0 37852,1 37936,0 37969,1 38066,0 38126,1 38186,0 38267,1 38343,0 38377,1 38470,0 38472,1 38546,0 38597,1 38670,0 38707,1 38801,0 38817,1 38895,0 38980,1 38997,0 39095,1 39189,0 39246,1 39309,0 39397,1 39440,0 39527,1 39624,0 39719,1 39783,0 39882,1 39926,0 39994,1 40019,0 40073,1 40135,0 40220,1 40269,0 40312,1 40395,0 40415,1 40450,0 40538,1 40608,0 40704,1 40800,0 40893,1 40983,0 41008,1 41058,0 41071,1 41162,0 41230,1 41265,0 41281,1 41332,0 41380,1 41471,0 41546,1 41580,0 41638,1 41729,0 41809,1 41852,0 41858,1 41933,0 41986,1 42041,0 42133,1 42214,0 42291,1 42337,0 42417,1 42445,0 42484,1 42502,0 42537,1 42579,0 42593,1 42683,0 42686,1 42737,0 42744,1 42780,0 42816,1 42873,0 42932,1 42998,0 43070,1 43136,0 43185,1 43197,0 43243,1 43279,0 43312,1 43331,0 43369,1 43389,0 43403,1 43481,0 43519,1 43548,0 43550,1 43640,0 43703,1 43786,0 43799,1 43895,0 43987,1 44011,0 44019,1 44048,0 44122,1 44199,0 44287,1 44319,0 44334,1 44379,0 44418,1 44515,0 44544,1 44633,0 44706,1 44728,0 44743,1 44770,0 44850,1 44936,0 44994,1 45013,0 45078,1 45110,0 45172,1 45184,0 45241,1 45281,0 45353,1 45358,0 45416,1 45442,0 45528,1 45609,0 45697,1 45728,0 45733,1 45735,0 45773,1 45833,0 45923,1 45936,0 45946,1 46006,0 46030,1 46126,0 46206,1 46301,0 46400,1 46448,0 46494,1 46544,0 46585,1 46615,0 46621,1 46704,0 46742,1 46826,0 46924,1 46934,0 46982,1 47071,0 47130,1 47146,0 47245,1 47308,0 47347,1 47422,0 47487,1 47532,0 47533,1 47585,0 47640,1 47681,0 47743,1 47756,0 47809,1 47869,0 47951,1 48045,0 48139,1 48220,0 48265,1 48324,0 48326,1 48338,0 48394,1 48404,0 48461,1 48494,0 48524,1 48592,0 48649,1 48739,0 48808,1 48907,0 48924,1 48968,0 49060,1 49112,0 49160,1 49163,0 49202,1 49246,0 49336,1 49388,0 49415,1 49505,0 49582,1 49596,0 49672,1 49676,0 49706,1 49805,0 49817,1 49893,0 49936,1 49961,0 50026,1 50099,0 50162,1 50205,0 50248,1 50285,0 50301,1 50314,0 50373,1 50470,0 50474,1 50484,0 50545,1 50611,0 50618,1 50658,0 50719,1 50793,0 50822,1 50898,0 50900,1 end initlist b37 0,0 77,1 150,0 173,1 176,0 270,1 273,0 339,1 341,0 368,1 403,0 500,1 538,0 597,1 617,0 698,1 789,0 861,1 885,0 957,1 1007,0 1094,1 1153,0 1229,1 1309,0 1341,1 1385,0 1428,1 1432,0 1520,1 1599,0 1661,1 1703,0 1710,1 1717,0 1766,1 1782,0 1874,1 1893,0 1980,1 2012,0 2069,1 2157,0 2254,1 2277,0 2331,1 2368,0 2407,1 2472,0 2548,1 2594,0 2673,1 2741,0 2839,1 2938,0 3025,1 3032,0 3048,1 3068,0 3087,1 3182,0 3272,1 3295,0 3371,1 3452,0 3458,1 3541,0 3605,1 3695,0 3711,1 3792,0 3856,1 3860,0 3925,1 3976,0 4047,1 4067,0 4154,1 4169,0 4172,1 4186,0 4275,1 4364,0 4459,1 4539,0 4632,1 4656,0 4697,1 4729,0 4797,1 4819,0 4905,1 4966,0 5065,1 5132,0 5174,1 5191,0 5233,1 5244,0 5308,1 5348,0 5373,1 5463,0 5467,1 5531,0 5584,1 5597,0 5679,1 5721,0 5727,1 5788,0 5868,1 5931,0 5949,1 5977,0 5992,1 6049,0 6146,1 6153,0 6245,1 6285,0 6286,1 6325,0 6405,1 6422,0 6465,1 6549,0 6620,1 6638,0 6680,1 6737,0 6765,1 6854,0 6883,1 6983,0 7011,1 7046,0 7090,1 7110,0 7127,1 7133,0 7152,1 7170,0 7212,1 7283,0 7325,1 7356,0 7371,1 7377,0 7381,1 7460,0 7546,1 7637,0 7701,1 7704,0 7768,1 7771,0 7845,1 7941,0 7978,1 7979,0 7980,1 7991,0 8063,1 8101,0 8114,1 8185,0 8229,1 8323,0 8346,1 8443,0 8539,1 8613,0 8686,1 8751,0 8792,1 8883,0 8932,1 8970,0 8996,1 9037,0 9067,1 9088,0 9156,1 9201,0 9261,1 9301,0 9363,1 9373,0 9387,1 9439,0 9479,1 9511,0 9573,1 9599,0 9653,1 9741,0 9765,1 9855,0 9863,1 9892,0 9934,1 10030,0 10083,1 10101,0 10199,1 10232,0 10267,1 10338,0 10396,1 10428,0 10510,1 10534,0 10581,1 10639,0 10663,1 10677,0 10731,1 10811,0 10892,1 10931,0 10942,1 10987,0 10994,1 11089,0 11178,1 11266,0 11341,1 11408,0 11480,1 11564,0 11616,1 11639,0 11691,1 11722,0 11729,1 11774,0 11856,1 11945,0 12030,1 12086,0 12158,1 12218,0 12305,1 12336,0 12397,1 12470,0 12568,1 12618,0 12650,1 12738,0 12807,1 12859,0 12904,1 12926,0 13018,1 13100,0 13112,1 13171,0 13196,1 13197,0 13288,1 13381,0 13388,1 13417,0 13506,1 13560,0 13577,1 13615,0 13631,1 13666,0 13722,1 13750,0 13760,1 13816,0 13869,1 13968,0 14039,1 14134,0 14176,1 14238,0 14285,1 14324,0 14377,1 14446,0 14481,1 14526,0 14534,1 14589,0 14649,1 14685,0 14714,1 14812,0 14827,1 14881,0 14966,1 15043,0 15044,1 15057,0 15081,1 15143,0 15218,1 15299,0 15304,1 15354,0 15424,1 15436,0 15501,1 15502,0 15575,1 15608,0 15641,1 15714,0 15727,1 15749,0 15768,1 15813,0 15903,1 15930,0 15989,1 16015,0 16084,1 16176,0 16217,1 16290,0 16308,1 16339,0 16397,1 16455,0 16478,1 16525,0 16596,1 16680,0 16741,1 16772,0 16833,1 16885,0 16966,1 17012,0 17029,1 17123,0 17171,1 17246,0 17284,1 17285,0 17379,1 17474,0 17542,1 17635,0 17702,1 17734,0 17742,1 17755,0 17839,1 17878,0 17909,1 17992,0 18053,1 18107,0 18108,1 18158,0 18243,1 18312,0 18329,1 18382,0 18463,1 18498,0 18592,1 18600,0 18677,1 18695,0 18760,1 18856,0 18943,1 18967,0 19001,1 19089,0 19123,1 19175,0 19190,1 19281,0 19360,1 19407,0 19437,1 19446,0 19471,1 19533,0 19558,1 19569,0 19581,1 19595,0 19622,1 19644,0 19728,1 19814,0 19841,1 19846,0 19945,1 20005,0 20083,1 20151,0 20210,1 20258,0 20318,1 20358,0 20367,1 20385,0 20464,1 20503,0 20588,1 20646,0 20716,1 20751,0 20851,1 20867,0 20890,1 20918,0 20970,1 21050,0 21085,1 21133,0 21203,1 21266,0 21348,1 21416,0 21488,1 21489,0 21546,1 21565,0 21570,1 21603,0 21641,1 21720,0 21807,1 21891,0 21990,1 22043,0 22050,1 22119,0 22164,1 22188,0 22261,1 22346,0 22394,1 22469,0 22490,1 22538,0 22629,1 22699,0 22796,1 22875,0 22920,1 22958,0 23012,1 23075,0 23117,1 23153,0 23175,1 23229,0 23237,1 23238,0 23313,1 23411,0 23417,1 23473,0 23524,1 23585,0 23630,1 23647,0 23743,1 23834,0 23921,1 24002,0 24070,1 24092,0 24166,1 24261,0 24272,1 24353,0 24435,1 24491,0 24584,1 24653,0 24742,1 24754,0 24763,1 24816,0 24882,1 24956,0 24962,1 25015,0 25100,1 25121,0 25160,1 25195,0 25231,1 25272,0 25352,1 25370,0 25451,1 25500,0 25585,1 25642,0 25733,1 25816,0 25901,1 25982,0 25997,1 26079,0 26099,1 26134,0 26143,1 26224,0 26289,1 26306,0 26378,1 26458,0 26527,1 26584,0 26631,1 26707,0 26750,1 26784,0 26805,1 26878,0 26917,1 26926,0 26978,1 26997,0 27022,1 27031,0 27050,1 27119,0 27164,1 27196,0 27242,1 27254,0 27347,1 27427,0 27526,1 27556,0 27650,1 27655,0 27668,1 27716,0 27742,1 27842,0 27844,1 27873,0 27909,1 27916,0 27935,1 27980,0 28046,1 28058,0 28061,1 28152,0 28156,1 28230,0 28273,1 28293,0 28371,1 28434,0 28484,1 28564,0 28578,1 28618,0 28717,1 28804,0 28862,1 28888,0 28960,1 28999,0 29024,1 29070,0 29095,1 29101,0 29129,1 29164,0 29215,1 29279,0 29304,1 29319,0 29394,1 29448,0 29511,1 29581,0 29648,1 29739,0 29741,1 29746,0 29834,1 29908,0 29984,1 30027,0 30075,1 30116,0 30204,1 30215,0 30252,1 30258,0 30341,1 30406,0 30437,1 30490,0 30508,1 30516,0 30570,1 30646,0 30674,1 30704,0 30736,1 30794,0 30808,1 30861,0 30885,1 30914,0 30946,1 30973,0 31067,1 31130,0 31148,1 31237,0 31275,1 31328,0 31352,1 31408,0 31420,1 31476,0 31526,1 31578,0 31624,1 31667,0 31763,1 31802,0 31807,1 31887,0 31984,1 32037,0 32121,1 32207,0 32300,1 32313,0 32319,1 32373,0 32435,1 32524,0 32585,1 32606,0 32612,1 32663,0 32733,1 32826,0 32834,1 32874,0 32899,1 32968,0 32987,1 33047,0 33119,1 33162,0 33250,1 33260,0 33261,1 33316,0 33343,1 33354,0 33361,1 33426,0 33440,1 33465,0 33559,1 33639,0 33675,1 33757,0 33857,1 33916,0 33959,1 33986,0 34080,1 34090,0 34185,1 34237,0 34296,1 34330,0 34410,1 34488,0 34508,1 34569,0 34653,1 34672,0 34687,1 34717,0 34769,1 34820,0 34851,1 34895,0 34924,1 35017,0 35047,1 35082,0 35092,1 35094,0 35178,1 35229,0 35312,1 35338,0 35402,1 35408,0 35444,1 35542,0 35603,1 35695,0 35703,1 35720,0 35748,1 35754,0 35797,1 35823,0 35850,1 35876,0 35881,1 35939,0 36031,1 36062,0 36154,1 36186,0 36204,1 36236,0 36336,1 36381,0 36407,1 36411,0 36488,1 36491,0 36523,1 36562,0 36630,1 36709,0 36737,1 36742,0 36771,1 36834,0 36850,1 36947,0 37024,1 37046,0 37135,1 37182,0 37273,1 37348,0 37372,1 37428,0 37506,1 37574,0 37612,1 37657,0 37705,1 37797,0 37866,1 37953,0 37994,1 38066,0 38082,1 38128,0 38196,1 38268,0 38317,1 38372,0 38444,1 38480,0 38488,1 38538,0 38633,1 38702,0 38710,1 38806,0 38869,1 38962,0 39059,1 39150,0 39206,1 39276,0 39314,1 39321,0 39382,1 39387,0 39461,1 39490,0 39501,1 39532,0 39552,1 39619,0 39629,1 39729,0 39818,1 39843,0 39851,1 39874,0 39943,1 40014,0 40086,1 40186,0 40192,1 40223,0 40288,1 40293,0 40310,1 40345,0 40426,1 40469,0 40526,1 40527,0 40617,1 40672,0 40741,1 40815,0 40848,1 40896,0 40914,1 40923,0 40957,1 40973,0 40990,1 41005,0 41032,1 41078,0 41112,1 41118,0 41173,1 41233,0 41266,1 41303,0 41351,1 41355,0 41411,1 41504,0 41584,1 41605,0 41699,1 41755,0 41839,1 41889,0 41984,1 42003,0 42020,1 42066,0 42108,1 42114,0 42173,1 42213,0 42297,1 42352,0 42379,1 42447,0 42473,1 42535,0 42597,1 42656,0 42711,1 42715,0 42781,1 42831,0 42846,1 42905,0 43001,1 43054,0 43131,1 43231,0 43275,1 43321,0 43374,1 43422,0 43497,1 43516,0 43548,1 43632,0 43651,1 43715,0 43737,1 43758,0 43821,1 43918,0 44008,1 44103,0 44191,1 44266,0 44286,1 44378,0 44457,1 44530,0 44558,1 44587,0 44590,1 44677,0 44716,1 44723,0 44819,1 44860,0 44919,1 44970,0 45018,1 45079,0 45147,1 45234,0 45321,1 45405,0 45434,1 45495,0 45585,1 45670,0 45710,1 45774,0 45779,1 45876,0 45923,1 46017,0 46041,1 46135,0 46233,1 46248,0 46308,1 46321,0 46351,1 46414,0 46468,1 46567,0 46600,1 46692,0 46781,1 46870,0 46927,1 47024,0 47123,1 47210,0 47233,1 47333,0 47415,1 47506,0 47531,1 47564,0 47580,1 47648,0 47743,1 47804,0 47875,1 47908,0 47970,1 48039,0 48050,1 48123,0 48203,1 48297,0 48387,1 48412,0 48430,1 48464,0 48553,1 48594,0 48671,1 48727,0 48735,1 48802,0 48830,1 48838,0 48860,1 48871,0 48937,1 48960,0 48973,1 48999,0 49053,1 49068,0 49106,1 49193,0 49253,1 49269,0 49326,1 49380,0 49406,1 49483,0 49524,1 49583,0 49612,1 49697,0 49718,1 49773,0 49850,1 49873,0 49902,1 49942,0 50037,1 50082,0 50101,1 50127,0 50194,1 50242,0 50304,1 50335,0 50350,1 50433,0 50447,1 end initlist b38 0,0 15,1 68,0 87,1 114,0 152,1 216,0 229,1 309,0 372,1 379,0 411,1 413,0 448,1 504,0 536,1 624,0 669,1 688,0 752,1 809,0 837,1 868,0 958,1 976,0 989,1 1077,0 1170,1 1233,0 1288,1 1355,0 1424,1 1480,0 1558,1 1607,0 1657,1 1707,0 1772,1 1857,0 1910,1 1977,0 1983,1 2016,0 2112,1 2167,0 2205,1 2256,0 2327,1 2348,0 2440,1 2492,0 2576,1 2610,0 2626,1 2701,0 2774,1 2803,0 2810,1 2814,0 2875,1 2924,0 3016,1 3082,0 3116,1 3136,0 3188,1 3222,0 3275,1 3322,0 3369,1 3379,0 3468,1 3554,0 3573,1 3657,0 3659,1 3702,0 3705,1 3793,0 3887,1 3979,0 3995,1 4088,0 4115,1 4180,0 4243,1 4310,0 4405,1 4472,0 4502,1 4556,0 4643,1 4715,0 4735,1 4801,0 4879,1 4917,0 4983,1 5007,0 5087,1 5180,0 5192,1 5204,0 5218,1 5265,0 5329,1 5392,0 5437,1 5524,0 5616,1 5685,0 5703,1 5770,0 5857,1 5922,0 5949,1 6008,0 6098,1 6156,0 6192,1 6193,0 6272,1 6298,0 6397,1 6473,0 6508,1 6565,0 6635,1 6695,0 6786,1 6790,0 6813,1 6897,0 6902,1 6994,0 7032,1 7072,0 7094,1 7180,0 7191,1 7215,0 7268,1 7305,0 7322,1 7415,0 7485,1 7506,0 7565,1 7617,0 7695,1 7745,0 7763,1 7843,0 7880,1 7910,0 7965,1 7980,0 8054,1 8137,0 8186,1 8271,0 8301,1 8351,0 8407,1 8498,0 8588,1 8622,0 8630,1 8687,0 8767,1 8815,0 8889,1 8918,0 8968,1 8990,0 9044,1 9131,0 9154,1 9221,0 9262,1 9281,0 9300,1 9381,0 9429,1 9488,0 9588,1 9655,0 9725,1 9819,0 9853,1 9879,0 9935,1 9946,0 10042,1 10097,0 10148,1 10198,0 10205,1 10241,0 10275,1 10319,0 10387,1 10394,0 10422,1 10502,0 10543,1 10606,0 10688,1 10751,0 10764,1 10766,0 10781,1 10822,0 10876,1 10877,0 10957,1 11041,0 11128,1 11168,0 11170,1 11237,0 11286,1 11371,0 11428,1 11481,0 11506,1 11518,0 11612,1 11635,0 11684,1 11728,0 11778,1 11807,0 11903,1 11946,0 12031,1 12036,0 12050,1 12115,0 12159,1 12215,0 12305,1 12365,0 12442,1 12513,0 12565,1 12657,0 12704,1 12793,0 12859,1 12935,0 12979,1 13029,0 13099,1 13110,0 13200,1 13286,0 13360,1 13370,0 13450,1 13528,0 13542,1 13601,0 13678,1 13768,0 13806,1 13845,0 13858,1 13924,0 13996,1 14017,0 14052,1 14141,0 14216,1 14291,0 14377,1 14430,0 14517,1 14586,0 14598,1 14637,0 14696,1 14772,0 14826,1 14920,0 15018,1 15064,0 15066,1 15120,0 15179,1 15270,0 15284,1 15341,0 15405,1 15470,0 15500,1 15501,0 15518,1 15550,0 15588,1 15633,0 15722,1 15803,0 15876,1 15911,0 15914,1 15948,0 15972,1 16012,0 16063,1 16102,0 16198,1 16287,0 16355,1 16438,0 16441,1 16517,0 16549,1 16563,0 16579,1 16671,0 16745,1 16755,0 16834,1 16891,0 16949,1 16958,0 16979,1 16986,0 17020,1 17112,0 17199,1 17243,0 17337,1 17418,0 17445,1 17468,0 17557,1 17627,0 17663,1 17722,0 17789,1 17820,0 17836,1 17934,0 18012,1 18089,0 18150,1 18196,0 18257,1 18275,0 18360,1 18390,0 18441,1 18506,0 18525,1 18622,0 18626,1 18638,0 18645,1 18733,0 18741,1 18805,0 18896,1 18992,0 19037,1 19051,0 19105,1 19146,0 19186,1 19213,0 19227,1 19310,0 19348,1 19432,0 19437,1 19478,0 19553,1 19638,0 19639,1 19735,0 19801,1 19891,0 19961,1 19962,0 19967,1 19996,0 20078,1 20079,0 20149,1 20185,0 20217,1 20261,0 20305,1 20346,0 20380,1 20381,0 20399,1 20474,0 20566,1 20640,0 20733,1 20812,0 20882,1 20930,0 21022,1 21038,0 21084,1 21178,0 21232,1 21259,0 21292,1 21376,0 21451,1 21493,0 21506,1 21540,0 21553,1 21597,0 21683,1 21746,0 21769,1 21838,0 21860,1 21933,0 21955,1 21961,0 22023,1 22074,0 22168,1 22198,0 22261,1 22307,0 22312,1 22323,0 22372,1 22442,0 22510,1 22548,0 22627,1 22635,0 22668,1 22732,0 22796,1 22867,0 22896,1 22966,0 23001,1 23053,0 23136,1 23160,0 23202,1 23237,0 23267,1 23349,0 23413,1 23484,0 23506,1 23600,0 23628,1 23726,0 23785,1 23857,0 23892,1 23897,0 23955,1 24012,0 24038,1 24060,0 24158,1 24217,0 24243,1 24295,0 24350,1 24439,0 24529,1 24558,0 24651,1 24720,0 24741,1 24788,0 24846,1 24867,0 24959,1 25051,0 25127,1 25221,0 25264,1 25285,0 25334,1 25365,0 25379,1 25383,0 25482,1 25581,0 25671,1 25765,0 25787,1 25791,0 25844,1 25938,0 25964,1 25992,0 26083,1 26140,0 26141,1 26163,0 26168,1 26220,0 26303,1 26394,0 26429,1 26505,0 26508,1 26604,0 26622,1 26639,0 26691,1 26698,0 26763,1 26772,0 26780,1 26869,0 26945,1 26979,0 26990,1 27063,0 27117,1 27192,0 27227,1 27272,0 27358,1 27380,0 27405,1 27478,0 27558,1 27577,0 27670,1 27718,0 27768,1 27804,0 27842,1 27859,0 27882,1 27899,0 27934,1 27987,0 28043,1 28112,0 28170,1 28225,0 28256,1 28279,0 28362,1 28384,0 28454,1 28484,0 28489,1 28496,0 28526,1 28569,0 28611,1 28616,0 28668,1 28671,0 28723,1 28801,0 28884,1 28891,0 28893,1 28942,0 29013,1 29085,0 29090,1 29162,0 29207,1 29259,0 29291,1 29374,0 29458,1 29528,0 29608,1 29634,0 29640,1 29725,0 29782,1 29796,0 29797,1 29833,0 29867,1 29899,0 29989,1 30076,0 30116,1 30131,0 30147,1 30217,0 30315,1 30364,0 30458,1 30487,0 30534,1 30627,0 30655,1 30751,0 30827,1 30878,0 30971,1 30990,0 31076,1 31142,0 31157,1 31231,0 31305,1 31390,0 31422,1 31484,0 31515,1 31522,0 31573,1 31665,0 31762,1 31850,0 31932,1 31972,0 32065,1 32122,0 32196,1 32257,0 32340,1 32366,0 32450,1 32453,0 32459,1 32468,0 32473,1 32531,0 32559,1 32655,0 32691,1 32767,0 32800,1 32881,0 32943,1 32995,0 33020,1 33101,0 33138,1 33149,0 33152,1 33203,0 33239,1 33323,0 33403,1 33406,0 33493,1 33570,0 33620,1 33671,0 33710,1 33751,0 33788,1 33870,0 33875,1 33961,0 33966,1 33984,0 34056,1 34110,0 34130,1 34210,0 34271,1 34316,0 34346,1 34429,0 34445,1 34507,0 34532,1 34590,0 34682,1 34686,0 34714,1 34731,0 34765,1 34836,0 34914,1 35001,0 35090,1 35100,0 35134,1 35163,0 35240,1 35269,0 35300,1 35364,0 35426,1 35436,0 35469,1 35525,0 35572,1 35636,0 35734,1 35768,0 35800,1 35865,0 35873,1 35955,0 36038,1 36080,0 36091,1 36126,0 36188,1 36275,0 36321,1 36370,0 36419,1 36469,0 36504,1 36519,0 36617,1 36635,0 36666,1 36704,0 36720,1 36782,0 36875,1 36898,0 36904,1 36978,0 37005,1 37052,0 37068,1 37132,0 37182,1 37274,0 37317,1 37337,0 37407,1 37491,0 37534,1 37603,0 37632,1 37636,0 37638,1 37654,0 37746,1 37814,0 37856,1 37875,0 37956,1 37995,0 38084,1 38165,0 38217,1 38249,0 38255,1 38331,0 38407,1 38500,0 38596,1 38637,0 38722,1 38794,0 38841,1 38879,0 38948,1 39026,0 39027,1 39111,0 39181,1 39225,0 39293,1 39353,0 39412,1 39503,0 39553,1 39582,0 39648,1 39666,0 39762,1 39827,0 39912,1 39978,0 40073,1 40124,0 40217,1 40312,0 40378,1 40405,0 40413,1 40462,0 40547,1 40642,0 40688,1 40775,0 40837,1 40901,0 40971,1 40975,0 41065,1 41100,0 41129,1 41206,0 41265,1 41298,0 41359,1 41393,0 41457,1 41459,0 41554,1 41623,0 41680,1 41727,0 41823,1 41907,0 41912,1 41936,0 42008,1 42060,0 42127,1 42140,0 42232,1 42249,0 42323,1 42324,0 42325,1 42359,0 42370,1 42374,0 42386,1 42399,0 42471,1 42564,0 42604,1 42685,0 42725,1 42728,0 42816,1 42848,0 42905,1 42932,0 42984,1 43034,0 43129,1 43144,0 43158,1 43204,0 43228,1 43275,0 43339,1 43354,0 43361,1 43412,0 43509,1 43577,0 43664,1 43689,0 43765,1 43771,0 43860,1 43928,0 44006,1 44044,0 44110,1 44127,0 44132,1 44145,0 44224,1 44274,0 44291,1 44390,0 44469,1 44549,0 44611,1 44666,0 44720,1 44741,0 44773,1 44873,0 44917,1 44944,0 44945,1 44956,0 44984,1 45033,0 45124,1 45179,0 45196,1 45256,0 45291,1 45391,0 45459,1 45536,0 45590,1 45593,0 45662,1 45692,0 45757,1 45840,0 45897,1 45908,0 45952,1 46047,0 46135,1 46154,0 46224,1 46287,0 46307,1 46365,0 46388,1 46472,0 46538,1 46620,0 46712,1 46758,0 46776,1 46810,0 46873,1 46915,0 47009,1 47013,0 47075,1 47104,0 47179,1 47278,0 47347,1 47378,0 47426,1 47436,0 47493,1 47498,0 47566,1 47617,0 47622,1 47692,0 47764,1 47826,0 47922,1 47967,0 48034,1 48133,0 48225,1 48285,0 48321,1 48405,0 48493,1 48547,0 48601,1 48677,0 48774,1 48848,0 48872,1 48924,0 48988,1 49010,0 49077,1 49174,0 49213,1 49223,0 49300,1 49303,0 49369,1 49425,0 49496,1 49553,0 49607,1 49672,0 49741,1 49838,0 49885,1 49959,0 49993,1 50059,0 50131,1 50150,0 50186,1 50237,0 50312,1 50396,0 50430,1 50493,0 50520,1 50558,0 50602,1 50642,0 50688,1 50761,0 50826,1 50860,0 50922,1 50977,0 51028,1 51124,0 51134,1 51229,0 51290,1 51297,0 51363,1 51408,0 51434,1 51511,0 51537,1 end initlist b39 0,0 25,1 100,0 186,1 272,0 290,1 378,0 400,1 416,0 477,1 529,0 609,1 653,0 712,1 764,0 861,1 878,0 968,1 1057,0 1153,1 1174,0 1206,1 1239,0 1261,1 1270,0 1362,1 1372,0 1436,1 1440,0 1526,1 1583,0 1623,1 1707,0 1796,1 1831,0 1924,1 1976,0 2073,1 2079,0 2174,1 2185,0 2284,1 2341,0 2371,1 2462,0 2562,1 2620,0 2672,1 2730,0 2821,1 2863,0 2940,1 2986,0 3062,1 3147,0 3173,1 3266,0 3286,1 3297,0 3347,1 3354,0 3436,1 3487,0 3501,1 3583,0 3640,1 3651,0 3661,1 3720,0 3740,1 3809,0 3848,1 3864,0 3945,1 3999,0 4069,1 4168,0 4260,1 4265,0 4316,1 4345,0 4438,1 4536,0 4613,1 4684,0 4756,1 4790,0 4839,1 4937,0 4993,1 5086,0 5125,1 5168,0 5184,1 5251,0 5311,1 5401,0 5433,1 5461,0 5533,1 5610,0 5708,1 5751,0 5813,1 5886,0 5971,1 6067,0 6145,1 6166,0 6221,1 6229,0 6254,1 6289,0 6343,1 6382,0 6443,1 6503,0 6534,1 6556,0 6645,1 6739,0 6770,1 6826,0 6857,1 6934,0 6986,1 7066,0 7149,1 7243,0 7253,1 7256,0 7291,1 7338,0 7375,1 7391,0 7466,1 7472,0 7564,1 7580,0 7621,1 7625,0 7696,1 7762,0 7835,1 7859,0 7867,1 7869,0 7902,1 7922,0 7948,1 8030,0 8102,1 8103,0 8112,1 8170,0 8215,1 8227,0 8314,1 8340,0 8428,1 8473,0 8556,1 8585,0 8612,1 8615,0 8688,1 8774,0 8862,1 8879,0 8908,1 8947,0 9021,1 9078,0 9111,1 9207,0 9302,1 9363,0 9412,1 9478,0 9551,1 9641,0 9670,1 9676,0 9774,1 9818,0 9828,1 9853,0 9949,1 9997,0 10020,1 10102,0 10112,1 10125,0 10143,1 10180,0 10263,1 10328,0 10352,1 10417,0 10428,1 10485,0 10577,1 10627,0 10683,1 10740,0 10787,1 10825,0 10856,1 10872,0 10887,1 10939,0 11020,1 11038,0 11138,1 11181,0 11187,1 11277,0 11326,1 11349,0 11437,1 11535,0 11538,1 11592,0 11667,1 11752,0 11803,1 11892,0 11913,1 11989,0 12016,1 12052,0 12152,1 12153,0 12167,1 12202,0 12205,1 12256,0 12274,1 12346,0 12409,1 12448,0 12458,1 12526,0 12625,1 12724,0 12806,1 12881,0 12885,1 12909,0 12944,1 12991,0 13079,1 13118,0 13183,1 13185,0 13237,1 13300,0 13364,1 13404,0 13502,1 13508,0 13512,1 13526,0 13610,1 13693,0 13698,1 13771,0 13825,1 13826,0 13908,1 13929,0 13946,1 13991,0 14027,1 14086,0 14109,1 14133,0 14182,1 14221,0 14244,1 14258,0 14334,1 14405,0 14434,1 14445,0 14503,1 14569,0 14590,1 14605,0 14675,1 14715,0 14735,1 14831,0 14837,1 14915,0 14970,1 15015,0 15055,1 15069,0 15162,1 15183,0 15208,1 15269,0 15295,1 15378,0 15442,1 15450,0 15453,1 15525,0 15581,1 15594,0 15628,1 15631,0 15682,1 15693,0 15768,1 15820,0 15902,1 15936,0 15976,1 15992,0 16079,1 16174,0 16195,1 16270,0 16351,1 16450,0 16483,1 16534,0 16553,1 16642,0 16727,1 16780,0 16824,1 16834,0 16933,1 16959,0 16960,1 16997,0 17031,1 17051,0 17096,1 17155,0 17250,1 17348,0 17433,1 17492,0 17522,1 17610,0 17691,1 17696,0 17725,1 17772,0 17791,1 17865,0 17957,1 17971,0 17998,1 18026,0 18118,1 18121,0 18194,1 18220,0 18274,1 18315,0 18414,1 18447,0 18489,1 18521,0 18532,1 18599,0 18623,1 18718,0 18770,1 18796,0 18849,1 18938,0 19022,1 19048,0 19050,1 19093,0 19161,1 19168,0 19214,1 19301,0 19319,1 19397,0 19492,1 19543,0 19613,1 19617,0 19685,1 19712,0 19760,1 19847,0 19914,1 19960,0 19971,1 19989,0 20082,1 20115,0 20146,1 20217,0 20289,1 20335,0 20403,1 20405,0 20483,1 20541,0 20626,1 20677,0 20690,1 20712,0 20714,1 20808,0 20894,1 20951,0 21018,1 21060,0 21076,1 21130,0 21150,1 21250,0 21267,1 21333,0 21355,1 21363,0 21422,1 21471,0 21511,1 21591,0 21600,1 21695,0 21722,1 21804,0 21806,1 21861,0 21868,1 21911,0 21967,1 21986,0 22047,1 22072,0 22139,1 22146,0 22235,1 22241,0 22312,1 22372,0 22404,1 22423,0 22425,1 22486,0 22545,1 22641,0 22707,1 22743,0 22759,1 22831,0 22903,1 22909,0 22924,1 22946,0 23007,1 23010,0 23070,1 23080,0 23098,1 23165,0 23184,1 23220,0 23229,1 23280,0 23320,1 23398,0 23452,1 23470,0 23518,1 23531,0 23594,1 23668,0 23711,1 23788,0 23824,1 23874,0 23876,1 23975,0 23984,1 24075,0 24105,1 24177,0 24209,1 24291,0 24342,1 24374,0 24456,1 24475,0 24563,1 24660,0 24682,1 24746,0 24766,1 24810,0 24888,1 24951,0 25025,1 25108,0 25135,1 25234,0 25323,1 25334,0 25399,1 25436,0 25473,1 25564,0 25574,1 25665,0 25758,1 25836,0 25928,1 25981,0 26050,1 26066,0 26100,1 26145,0 26149,1 26188,0 26220,1 26286,0 26357,1 26445,0 26481,1 26537,0 26599,1 26688,0 26719,1 26765,0 26800,1 26822,0 26920,1 26986,0 27048,1 27058,0 27106,1 27197,0 27230,1 27274,0 27293,1 27316,0 27390,1 27440,0 27491,1 27540,0 27544,1 27565,0 27638,1 27673,0 27692,1 27785,0 27789,1 27872,0 27894,1 27938,0 28035,1 28047,0 28060,1 28069,0 28103,1 28164,0 28217,1 28283,0 28304,1 28378,0 28397,1 28464,0 28531,1 28544,0 28620,1 28641,0 28702,1 28720,0 28805,1 28883,0 28920,1 28936,0 28949,1 28989,0 29069,1 29156,0 29181,1 29202,0 29254,1 29257,0 29314,1 29379,0 29438,1 29450,0 29541,1 29603,0 29649,1 29666,0 29739,1 29762,0 29855,1 29906,0 29951,1 29974,0 30073,1 30076,0 30175,1 30191,0 30247,1 30316,0 30358,1 30389,0 30478,1 30486,0 30548,1 30637,0 30640,1 30686,0 30696,1 30793,0 30858,1 30869,0 30956,1 31010,0 31070,1 31110,0 31210,1 31307,0 31388,1 31465,0 31538,1 31637,0 31666,1 31717,0 31816,1 31888,0 31961,1 32032,0 32098,1 32126,0 32197,1 32261,0 32307,1 32354,0 32451,1 32522,0 32592,1 32601,0 32694,1 32709,0 32752,1 32835,0 32890,1 32910,0 32924,1 33021,0 33023,1 33118,0 33137,1 33207,0 33297,1 33361,0 33447,1 33465,0 33530,1 33606,0 33634,1 33673,0 33694,1 33760,0 33786,1 33859,0 33931,1 34014,0 34079,1 34132,0 34146,1 34175,0 34180,1 34190,0 34226,1 34234,0 34327,1 34424,0 34518,1 34538,0 34609,1 34691,0 34783,1 34826,0 34922,1 34964,0 34974,1 35059,0 35145,1 35212,0 35252,1 35260,0 35354,1 35450,0 35473,1 35484,0 35535,1 35619,0 35684,1 35765,0 35815,1 35816,0 35876,1 35904,0 35973,1 36042,0 36133,1 36173,0 36246,1 36292,0 36356,1 36414,0 36470,1 36498,0 36596,1 36684,0 36778,1 36782,0 36816,1 36878,0 36959,1 37055,0 37153,1 37172,0 37235,1 37310,0 37382,1 37466,0 37555,1 37582,0 37661,1 37761,0 37787,1 37837,0 37905,1 38001,0 38018,1 38021,0 38095,1 38098,0 38193,1 38271,0 38333,1 38418,0 38439,1 38504,0 38573,1 38664,0 38708,1 38796,0 38849,1 38927,0 38999,1 39033,0 39097,1 39190,0 39211,1 39236,0 39261,1 39357,0 39446,1 39448,0 39478,1 39534,0 39547,1 39620,0 39649,1 39707,0 39763,1 39855,0 39897,1 39898,0 39945,1 39958,0 39967,1 39992,0 40042,1 40053,0 40115,1 40205,0 40247,1 40264,0 40273,1 40302,0 40310,1 40390,0 40445,1 40458,0 40500,1 40575,0 40666,1 40688,0 40741,1 40810,0 40844,1 40910,0 40939,1 40940,0 41016,1 41086,0 41174,1 41262,0 41292,1 41351,0 41425,1 41511,0 41530,1 41560,0 41652,1 41658,0 41697,1 41782,0 41848,1 41879,0 41907,1 42005,0 42026,1 42116,0 42169,1 42240,0 42323,1 42347,0 42437,1 42464,0 42520,1 42568,0 42663,1 42706,0 42715,1 42811,0 42878,1 42883,0 42910,1 42970,0 43060,1 43148,0 43245,1 43311,0 43387,1 43431,0 43515,1 43562,0 43636,1 43658,0 43687,1 43732,0 43791,1 43814,0 43864,1 43908,0 43924,1 43968,0 44010,1 44056,0 44109,1 44150,0 44240,1 44290,0 44331,1 44363,0 44385,1 44456,0 44461,1 44522,0 44584,1 44616,0 44689,1 44726,0 44743,1 44837,0 44896,1 44947,0 44972,1 45045,0 45065,1 45096,0 45142,1 45143,0 45241,1 45339,0 45378,1 45399,0 45455,1 45540,0 45565,1 45595,0 45695,1 45734,0 45815,1 45895,0 45934,1 45953,0 46051,1 46066,0 46130,1 46153,0 46247,1 46309,0 46329,1 46418,0 46490,1 46581,0 46666,1 46706,0 46758,1 46815,0 46910,1 46982,0 47036,1 47075,0 47090,1 47152,0 47191,1 47229,0 47274,1 47358,0 47452,1 47465,0 47512,1 47571,0 47596,1 47670,0 47730,1 47802,0 47846,1 47934,0 47979,1 48014,0 48027,1 48034,0 48132,1 48176,0 48245,1 48332,0 48431,1 48483,0 48533,1 48573,0 48597,1 48634,0 48663,1 48725,0 48787,1 48810,0 48883,1 48892,0 48988,1 49037,0 49050,1 49121,0 49123,1 49153,0 49156,1 49162,0 49181,1 49246,0 49334,1 49346,0 49382,1 49426,0 49491,1 49519,0 49557,1 49616,0 49690,1 49714,0 49793,1 49835,0 49909,1 49986,0 50086,1 50139,0 50203,1 50233,0 50329,1 50399,0 50404,1 50460,0 50534,1 50579,0 50655,1 50747,0 50829,1 50868,0 50877,1 50903,0 50963,1 50992,0 51088,1 51119,0 51134,1 51172,0 51213,1 end initlist b40 0,0 86,1 111,0 173,1 251,0 322,1 413,0 433,1 441,0 472,1 477,0 519,1 567,0 604,1 671,0 691,1 764,0 815,1 889,0 954,1 995,0 1001,1 1023,0 1029,1 1086,0 1160,1 1188,0 1267,1 1289,0 1359,1 1399,0 1465,1 1526,0 1602,1 1686,0 1709,1 1728,0 1751,1 1805,0 1819,1 1849,0 1919,1 1962,0 2053,1 2149,0 2170,1 2205,0 2254,1 2289,0 2299,1 2326,0 2381,1 2414,0 2514,1 2525,0 2624,1 2634,0 2656,1 2734,0 2816,1 2854,0 2911,1 3007,0 3056,1 3149,0 3203,1 3222,0 3233,1 3309,0 3317,1 3377,0 3386,1 3396,0 3409,1 3446,0 3513,1 3597,0 3658,1 3703,0 3771,1 3836,0 3842,1 3933,0 3998,1 4062,0 4154,1 4162,0 4219,1 4296,0 4383,1 4456,0 4553,1 4637,0 4689,1 4710,0 4779,1 4828,0 4923,1 4981,0 5075,1 5102,0 5174,1 5178,0 5186,1 5212,0 5290,1 5331,0 5374,1 5415,0 5515,1 5546,0 5619,1 5689,0 5737,1 5788,0 5852,1 5870,0 5953,1 6045,0 6095,1 6132,0 6214,1 6233,0 6277,1 6288,0 6326,1 6415,0 6473,1 6493,0 6544,1 6578,0 6612,1 6687,0 6768,1 6831,0 6897,1 6903,0 6994,1 7005,0 7090,1 7128,0 7185,1 7266,0 7307,1 7366,0 7435,1 7444,0 7517,1 7569,0 7645,1 7740,0 7793,1 7825,0 7858,1 7942,0 8002,1 8037,0 8047,1 8128,0 8181,1 8183,0 8225,1 8311,0 8333,1 8366,0 8463,1 8556,0 8605,1 8689,0 8771,1 8860,0 8889,1 8925,0 8998,1 9024,0 9033,1 9056,0 9141,1 9229,0 9297,1 9362,0 9431,1 9493,0 9548,1 9632,0 9663,1 9730,0 9808,1 9893,0 9930,1 10028,0 10092,1 10134,0 10172,1 10261,0 10268,1 10360,0 10433,1 10504,0 10572,1 10664,0 10712,1 10769,0 10799,1 10834,0 10869,1 10965,0 11053,1 11131,0 11194,1 11215,0 11314,1 11390,0 11403,1 11500,0 11573,1 11657,0 11712,1 11752,0 11842,1 11913,0 11931,1 12006,0 12007,1 12094,0 12171,1 12173,0 12239,1 12266,0 12284,1 12338,0 12374,1 12430,0 12433,1 12527,0 12627,1 12705,0 12742,1 12841,0 12907,1 12924,0 12983,1 13042,0 13113,1 13193,0 13243,1 13284,0 13301,1 13302,0 13327,1 13365,0 13405,1 13435,0 13438,1 13471,0 13481,1 13531,0 13614,1 13671,0 13742,1 13744,0 13828,1 13912,0 14006,1 14041,0 14136,1 14236,0 14251,1 14307,0 14329,1 14392,0 14434,1 14449,0 14513,1 14570,0 14626,1 14633,0 14639,1 14665,0 14714,1 14783,0 14815,1 14844,0 14940,1 14949,0 14975,1 15003,0 15076,1 15152,0 15161,1 15214,0 15307,1 15318,0 15340,1 15351,0 15424,1 15485,0 15498,1 15534,0 15553,1 15620,0 15681,1 15682,0 15741,1 15797,0 15817,1 15901,0 15957,1 16016,0 16097,1 16163,0 16255,1 16343,0 16438,1 16474,0 16527,1 16541,0 16628,1 16674,0 16699,1 16730,0 16812,1 16908,0 17006,1 17016,0 17079,1 17142,0 17156,1 17179,0 17233,1 17259,0 17346,1 17432,0 17442,1 17488,0 17542,1 17550,0 17597,1 17608,0 17706,1 17760,0 17835,1 17864,0 17906,1 17912,0 18006,1 18032,0 18044,1 18142,0 18191,1 18274,0 18292,1 18374,0 18453,1 18492,0 18588,1 18681,0 18743,1 18771,0 18796,1 18847,0 18933,1 18994,0 19079,1 19150,0 19154,1 19155,0 19167,1 19184,0 19220,1 19239,0 19329,1 19366,0 19385,1 19423,0 19445,1 19462,0 19492,1 19549,0 19646,1 19668,0 19758,1 19844,0 19855,1 19868,0 19965,1 20049,0 20118,1 20173,0 20243,1 20334,0 20340,1 20384,0 20450,1 20537,0 20637,1 20733,0 20766,1 20828,0 20877,1 20928,0 20984,1 21076,0 21167,1 21182,0 21229,1 21286,0 21328,1 21360,0 21421,1 21520,0 21566,1 21615,0 21681,1 21749,0 21761,1 21779,0 21838,1 21903,0 21951,1 22049,0 22124,1 22203,0 22301,1 22401,0 22461,1 22546,0 22605,1 22620,0 22673,1 22733,0 22810,1 22875,0 22902,1 22924,0 22981,1 23030,0 23096,1 23102,0 23201,1 23278,0 23348,1 23448,0 23480,1 23488,0 23520,1 23603,0 23640,1 23681,0 23698,1 23798,0 23884,1 23914,0 23975,1 24035,0 24041,1 24129,0 24145,1 24171,0 24187,1 24233,0 24305,1 24375,0 24389,1 24406,0 24410,1 24414,0 24512,1 24577,0 24650,1 24707,0 24796,1 24852,0 24854,1 24893,0 24960,1 25059,0 25121,1 25210,0 25236,1 25322,0 25405,1 25434,0 25501,1 25503,0 25541,1 25592,0 25637,1 25657,0 25693,1 25729,0 25765,1 25864,0 25949,1 25988,0 26063,1 26161,0 26188,1 26231,0 26238,1 26270,0 26329,1 26398,0 26448,1 26491,0 26525,1 26539,0 26576,1 26639,0 26686,1 26740,0 26811,1 26887,0 26944,1 26959,0 26970,1 27006,0 27104,1 27184,0 27249,1 27319,0 27417,1 27439,0 27473,1 27484,0 27558,1 27644,0 27744,1 27763,0 27853,1 27899,0 27999,1 28054,0 28126,1 28215,0 28239,1 28282,0 28304,1 28323,0 28333,1 28425,0 28503,1 28560,0 28571,1 28657,0 28753,1 28784,0 28804,1 28902,0 28936,1 28996,0 29088,1 29182,0 29273,1 29286,0 29313,1 29350,0 29408,1 29425,0 29497,1 29509,0 29574,1 29611,0 29646,1 29682,0 29747,1 29753,0 29803,1 29878,0 29947,1 30009,0 30093,1 30105,0 30111,1 30146,0 30176,1 30193,0 30259,1 30272,0 30291,1 30346,0 30433,1 30445,0 30495,1 30582,0 30669,1 30733,0 30766,1 30803,0 30814,1 30829,0 30892,1 30978,0 31028,1 31070,0 31104,1 31152,0 31247,1 31312,0 31377,1 31403,0 31480,1 31548,0 31555,1 31646,0 31743,1 31766,0 31785,1 31837,0 31874,1 31875,0 31915,1 31998,0 32054,1 32057,0 32157,1 32206,0 32232,1 32306,0 32383,1 32408,0 32433,1 32478,0 32553,1 32649,0 32724,1 32731,0 32819,1 32895,0 32912,1 32941,0 32996,1 33029,0 33053,1 33072,0 33104,1 33142,0 33197,1 33234,0 33290,1 33339,0 33409,1 33448,0 33538,1 33591,0 33628,1 33661,0 33720,1 33810,0 33859,1 33917,0 33971,1 33986,0 34036,1 34061,0 34074,1 34143,0 34169,1 34258,0 34320,1 34395,0 34415,1 34431,0 34531,1 34563,0 34574,1 34658,0 34704,1 34716,0 34765,1 34820,0 34856,1 34871,0 34908,1 34975,0 35052,1 35122,0 35147,1 35178,0 35217,1 35254,0 35286,1 35335,0 35433,1 35461,0 35530,1 35554,0 35602,1 35647,0 35678,1 35746,0 35835,1 35929,0 35995,1 36059,0 36128,1 36157,0 36207,1 36294,0 36335,1 36363,0 36457,1 36489,0 36511,1 36530,0 36568,1 36640,0 36653,1 36752,0 36796,1 36811,0 36873,1 36959,0 37033,1 37076,0 37176,1 37266,0 37323,1 37348,0 37355,1 37425,0 37487,1 37527,0 37587,1 37601,0 37667,1 37753,0 37770,1 37816,0 37831,1 37890,0 37939,1 38020,0 38068,1 38096,0 38147,1 38233,0 38284,1 38315,0 38385,1 38413,0 38454,1 38499,0 38596,1 38650,0 38734,1 38808,0 38845,1 38945,0 39017,1 39020,0 39083,1 39090,0 39093,1 39127,0 39223,1 39278,0 39338,1 39388,0 39414,1 39505,0 39532,1 39569,0 39592,1 39639,0 39702,1 39759,0 39814,1 39845,0 39917,1 39932,0 39955,1 39979,0 39984,1 40028,0 40099,1 40169,0 40196,1 40239,0 40296,1 40381,0 40407,1 40491,0 40540,1 40639,0 40667,1 40670,0 40703,1 40801,0 40838,1 40883,0 40932,1 41023,0 41039,1 41077,0 41161,1 41183,0 41228,1 41276,0 41319,1 41390,0 41395,1 41475,0 41516,1 41554,0 41611,1 41631,0 41639,1 41717,0 41778,1 41835,0 41895,1 41917,0 42016,1 42023,0 42091,1 42138,0 42185,1 42224,0 42298,1 42367,0 42418,1 42493,0 42494,1 42556,0 42565,1 42646,0 42654,1 42683,0 42753,1 42797,0 42887,1 42962,0 42984,1 43006,0 43068,1 43156,0 43209,1 43255,0 43288,1 43358,0 43392,1 43434,0 43482,1 43537,0 43562,1 43631,0 43661,1 43710,0 43776,1 43845,0 43904,1 43950,0 44037,1 44073,0 44122,1 44157,0 44249,1 44345,0 44435,1 44498,0 44511,1 44603,0 44700,1 44703,0 44784,1 44805,0 44826,1 44916,0 44990,1 45039,0 45048,1 45081,0 45166,1 45224,0 45290,1 45359,0 45376,1 45460,0 45543,1 45585,0 45593,1 45663,0 45668,1 45697,0 45716,1 45741,0 45791,1 45811,0 45815,1 45878,0 45915,1 45922,0 45953,1 46036,0 46083,1 46153,0 46177,1 46220,0 46283,1 46366,0 46381,1 46433,0 46477,1 46505,0 46590,1 46674,0 46683,1 46749,0 46824,1 46831,0 46910,1 46918,0 46976,1 47040,0 47096,1 47117,0 47131,1 47165,0 47256,1 47283,0 47287,1 47335,0 47376,1 47452,0 47507,1 47588,0 47630,1 47636,0 47652,1 47690,0 47788,1 47876,0 47943,1 47967,0 47986,1 48064,0 48159,1 48168,0 48195,1 48292,0 48319,1 48406,0 48427,1 48521,0 48578,1 48615,0 48627,1 48713,0 48745,1 48810,0 48880,1 48903,0 48972,1 49046,0 49131,1 49183,0 49224,1 49324,0 49355,1 49394,0 49465,1 49558,0 49616,1 49678,0 49778,1 49863,0 49959,1 50056,0 50120,1 50215,0 50304,1 50401,0 50453,1 50528,0 50582,1 50664,0 50692,1 50721,0 50788,1 50797,0 50872,1 50914,0 51004,1 51056,0 51118,1 51194,0 51217,1 51247,0 51279,1 51352,0 51370,1 51448,0 51475,1 51552,0 51637,1 51728,0 51760,1 51784,0 51827,1 51847,0 51885,1 end initlist b41 0,0 45,1 94,0 161,1 195,0 263,1 299,0 377,1 428,0 488,1 504,0 541,1 565,0 606,1 690,0 770,1 808,0 908,1 1008,0 1061,1 1131,0 1196,1 1260,0 1271,1 1368,0 1418,1 1436,0 1516,1 1524,0 1589,1 1630,0 1705,1 1714,0 1750,1 1821,0 1892,1 1902,0 1911,1 1958,0 2011,1 2072,0 2091,1 2174,0 2199,1 2228,0 2237,1 2292,0 2307,1 2319,0 2405,1 2447,0 2525,1 2552,0 2635,1 2699,0 2705,1 2776,0 2830,1 2851,0 2926,1 2984,0 3030,1 3036,0 3094,1 3179,0 3246,1 3304,0 3381,1 3415,0 3426,1 3515,0 3519,1 3531,0 3618,1 3630,0 3680,1 3775,0 3787,1 3840,0 3885,1 3954,0 4043,1 4122,0 4130,1 4213,0 4238,1 4268,0 4306,1 4403,0 4478,1 4483,0 4563,1 4632,0 4682,1 4771,0 4821,1 4910,0 4981,1 5012,0 5018,1 5056,0 5106,1 5121,0 5181,1 5230,0 5262,1 5342,0 5389,1 5394,0 5462,1 5522,0 5572,1 5616,0 5706,1 5760,0 5828,1 5851,0 5879,1 5911,0 6010,1 6026,0 6114,1 6206,0 6225,1 6255,0 6302,1 6306,0 6345,1 6424,0 6456,1 6476,0 6508,1 6531,0 6609,1 6657,0 6670,1 6715,0 6746,1 6820,0 6822,1 6870,0 6873,1 6887,0 6926,1 6950,0 6992,1 7046,0 7092,1 7176,0 7235,1 7293,0 7343,1 7409,0 7470,1 7536,0 7620,1 7720,0 7810,1 7829,0 7908,1 7919,0 7993,1 7999,0 8090,1 8120,0 8121,1 8161,0 8260,1 8322,0 8385,1 8472,0 8542,1 8631,0 8634,1 8677,0 8729,1 8765,0 8772,1 8798,0 8873,1 8886,0 8982,1 9010,0 9060,1 9108,0 9168,1 9246,0 9269,1 9313,0 9332,1 9417,0 9472,1 9474,0 9534,1 9604,0 9638,1 9683,0 9767,1 9776,0 9869,1 9933,0 9968,1 10050,0 10102,1 10138,0 10220,1 10258,0 10352,1 10412,0 10442,1 10462,0 10542,1 10628,0 10690,1 10712,0 10738,1 10800,0 10900,1 10934,0 10958,1 11049,0 11067,1 11093,0 11184,1 11236,0 11284,1 11381,0 11475,1 11565,0 11581,1 11597,0 11656,1 11705,0 11781,1 11856,0 11946,1 11994,0 12037,1 12069,0 12102,1 12113,0 12212,1 12227,0 12292,1 12322,0 12364,1 12438,0 12460,1 12557,0 12657,1 12685,0 12723,1 12784,0 12871,1 12930,0 12984,1 13049,0 13122,1 13204,0 13303,1 13350,0 13352,1 13388,0 13407,1 13460,0 13524,1 13604,0 13635,1 13682,0 13748,1 13770,0 13795,1 13857,0 13900,1 13972,0 14043,1 14050,0 14102,1 14170,0 14261,1 14361,0 14445,1 14515,0 14604,1 14622,0 14681,1 14769,0 14780,1 14796,0 14872,1 14969,0 15058,1 15116,0 15133,1 15184,0 15256,1 15310,0 15326,1 15403,0 15408,1 15475,0 15551,1 15645,0 15653,1 15680,0 15703,1 15775,0 15846,1 15853,0 15857,1 15859,0 15919,1 16010,0 16099,1 16152,0 16185,1 16267,0 16300,1 16320,0 16397,1 16428,0 16486,1 16540,0 16633,1 16705,0 16792,1 16833,0 16859,1 16912,0 16932,1 16980,0 17046,1 17051,0 17100,1 17194,0 17218,1 17306,0 17358,1 17436,0 17468,1 17559,0 17562,1 17627,0 17669,1 17734,0 17754,1 17772,0 17872,1 17949,0 18009,1 18065,0 18079,1 18089,0 18183,1 18220,0 18225,1 18285,0 18315,1 18320,0 18415,1 18479,0 18505,1 18530,0 18584,1 18600,0 18692,1 18696,0 18699,1 18785,0 18798,1 18879,0 18892,1 18949,0 19002,1 19067,0 19091,1 19123,0 19223,1 19276,0 19359,1 19397,0 19436,1 19443,0 19468,1 19525,0 19579,1 19600,0 19606,1 19680,0 19707,1 19778,0 19873,1 19942,0 20020,1 20031,0 20050,1 20052,0 20111,1 20166,0 20247,1 20293,0 20298,1 20371,0 20414,1 20463,0 20561,1 20644,0 20738,1 20791,0 20873,1 20967,0 20980,1 21024,0 21084,1 21162,0 21262,1 21318,0 21412,1 21477,0 21486,1 21571,0 21620,1 21665,0 21678,1 21763,0 21770,1 21787,0 21853,1 21899,0 21947,1 21999,0 22082,1 22157,0 22243,1 22250,0 22272,1 22356,0 22415,1 22491,0 22544,1 22546,0 22597,1 22657,0 22737,1 22758,0 22824,1 22908,0 22958,1 23018,0 23077,1 23171,0 23206,1 23259,0 23276,1 23311,0 23385,1 23388,0 23446,1 23512,0 23571,1 23619,0 23650,1 23687,0 23717,1 23809,0 23853,1 23930,0 23935,1 23969,0 23985,1 24082,0 24139,1 24174,0 24254,1 24345,0 24386,1 24450,0 24514,1 24547,0 24644,1 24662,0 24706,1 24751,0 24760,1 24845,0 24866,1 24896,0 24968,1 25000,0 25090,1 25102,0 25149,1 25248,0 25310,1 25369,0 25387,1 25414,0 25484,1 25570,0 25580,1 25593,0 25678,1 25754,0 25805,1 25891,0 25982,1 25997,0 26069,1 26099,0 26145,1 26186,0 26248,1 26264,0 26337,1 26357,0 26360,1 26381,0 26444,1 26491,0 26509,1 26524,0 26530,1 26564,0 26618,1 26674,0 26691,1 26780,0 26798,1 26854,0 26904,1 26944,0 26952,1 26984,0 27021,1 27031,0 27063,1 27115,0 27171,1 27190,0 27196,1 27251,0 27315,1 27323,0 27411,1 27471,0 27510,1 27593,0 27673,1 27678,0 27743,1 27765,0 27797,1 27852,0 27897,1 27936,0 28019,1 28077,0 28102,1 28133,0 28189,1 28195,0 28258,1 28283,0 28327,1 28375,0 28386,1 28405,0 28502,1 28531,0 28540,1 28599,0 28621,1 28661,0 28672,1 28702,0 28778,1 28850,0 28907,1 28982,0 29080,1 29170,0 29175,1 29270,0 29330,1 29337,0 29353,1 29393,0 29483,1 29526,0 29538,1 29629,0 29631,1 29721,0 29727,1 29738,0 29766,1 29850,0 29924,1 29932,0 29965,1 29989,0 29993,1 30053,0 30066,1 30119,0 30184,1 30265,0 30324,1 30349,0 30427,1 30503,0 30519,1 30548,0 30557,1 30570,0 30613,1 30698,0 30798,1 30843,0 30915,1 30922,0 30970,1 31002,0 31044,1 31065,0 31076,1 31114,0 31178,1 31230,0 31303,1 31396,0 31476,1 31490,0 31559,1 31621,0 31623,1 31631,0 31663,1 31679,0 31752,1 31845,0 31864,1 31938,0 31982,1 32071,0 32143,1 32184,0 32283,1 32314,0 32384,1 32402,0 32419,1 32478,0 32486,1 32576,0 32644,1 32690,0 32788,1 32820,0 32870,1 32902,0 32933,1 32970,0 33010,1 33104,0 33123,1 33180,0 33229,1 33292,0 33344,1 33392,0 33473,1 33516,0 33573,1 33664,0 33677,1 33738,0 33786,1 33875,0 33933,1 33936,0 33937,1 33994,0 34074,1 34100,0 34125,1 34206,0 34247,1 34312,0 34328,1 34329,0 34341,1 34402,0 34439,1 34491,0 34554,1 34615,0 34679,1 34747,0 34845,1 34932,0 34935,1 34991,0 35079,1 35111,0 35139,1 35148,0 35232,1 35327,0 35380,1 35421,0 35440,1 35463,0 35558,1 35595,0 35610,1 35655,0 35728,1 35788,0 35864,1 35936,0 35961,1 36021,0 36035,1 36120,0 36203,1 36206,0 36276,1 36368,0 36434,1 36456,0 36469,1 36520,0 36592,1 36650,0 36658,1 36718,0 36818,1 36878,0 36947,1 36970,0 37011,1 37021,0 37077,1 37117,0 37202,1 37277,0 37303,1 37312,0 37339,1 37417,0 37418,1 37492,0 37555,1 37591,0 37686,1 37697,0 37787,1 37873,0 37938,1 37996,0 38000,1 38065,0 38121,1 38204,0 38231,1 38242,0 38266,1 38286,0 38335,1 38346,0 38347,1 38354,0 38454,1 38541,0 38575,1 38638,0 38702,1 38759,0 38847,1 38854,0 38912,1 39001,0 39035,1 39073,0 39122,1 39127,0 39216,1 39237,0 39323,1 39325,0 39399,1 39427,0 39505,1 39574,0 39634,1 39687,0 39732,1 39818,0 39821,1 39919,0 39923,1 39934,0 39945,1 40028,0 40044,1 40064,0 40161,1 40259,0 40345,1 40432,0 40513,1 40516,0 40529,1 40581,0 40617,1 40632,0 40712,1 40723,0 40790,1 40886,0 40951,1 40959,0 41035,1 41048,0 41072,1 41157,0 41193,1 41214,0 41263,1 41330,0 41426,1 41510,0 41515,1 41556,0 41613,1 41639,0 41693,1 41776,0 41826,1 41885,0 41886,1 41890,0 41977,1 42001,0 42021,1 42111,0 42199,1 42287,0 42345,1 42351,0 42418,1 42515,0 42522,1 42590,0 42654,1 42656,0 42730,1 42810,0 42889,1 42899,0 42999,1 43022,0 43117,1 43145,0 43161,1 43177,0 43230,1 43236,0 43250,1 43330,0 43339,1 43431,0 43488,1 43500,0 43508,1 43585,0 43665,1 43700,0 43733,1 43734,0 43747,1 43829,0 43870,1 43923,0 44002,1 44072,0 44163,1 44195,0 44211,1 44237,0 44243,1 44290,0 44386,1 44485,0 44572,1 44668,0 44732,1 44832,0 44892,1 44965,0 45062,1 45097,0 45158,1 45214,0 45243,1 45322,0 45370,1 45448,0 45532,1 45570,0 45618,1 45629,0 45688,1 45710,0 45798,1 45804,0 45888,1 45942,0 46000,1 46051,0 46060,1 46140,0 46233,1 46262,0 46293,1 46387,0 46436,1 46522,0 46552,1 46618,0 46687,1 46716,0 46767,1 46791,0 46873,1 46901,0 46929,1 46990,0 47002,1 47016,0 47037,1 47098,0 47182,1 47205,0 47243,1 47284,0 47302,1 47370,0 47377,1 47379,0 47452,1 47474,0 47564,1 47664,0 47715,1 47766,0 47821,1 47866,0 47912,1 47948,0 48002,1 48072,0 48123,1 48151,0 48177,1 48256,0 48320,1 48389,0 48418,1 48499,0 48564,1 48571,0 48583,1 48615,0 48644,1 48686,0 48689,1 48738,0 48823,1 48858,0 48861,1 48895,0 48952,1 48962,0 49004,1 49062,0 49148,1 49217,0 49308,1 49309,0 49381,1 49476,0 49488,1 49561,0 49660,1 49725,0 49730,1 49776,0 49782,1 49880,0 49960,1 end initlist b42 0,0 36,1 58,0 82,1 106,0 196,1 240,0 256,1 343,0 344,1 400,0 408,1 485,0 560,1 593,0 610,1 664,0 665,1 678,0 693,1 760,0 772,1 866,0 952,1 1045,0 1118,1 1144,0 1237,1 1290,0 1309,1 1315,0 1358,1 1391,0 1456,1 1538,0 1620,1 1638,0 1720,1 1742,0 1832,1 1849,0 1919,1 1975,0 2045,1 2056,0 2081,1 2122,0 2123,1 2159,0 2252,1 2300,0 2351,1 2445,0 2537,1 2575,0 2603,1 2653,0 2745,1 2821,0 2848,1 2880,0 2888,1 2911,0 3008,1 3058,0 3097,1 3197,0 3291,1 3373,0 3430,1 3447,0 3495,1 3500,0 3506,1 3550,0 3629,1 3714,0 3808,1 3858,0 3892,1 3921,0 3930,1 3982,0 4064,1 4118,0 4127,1 4198,0 4250,1 4307,0 4371,1 4442,0 4521,1 4557,0 4561,1 4605,0 4644,1 4683,0 4700,1 4712,0 4729,1 4817,0 4832,1 4926,0 5007,1 5091,0 5111,1 5173,0 5183,1 5226,0 5272,1 5366,0 5419,1 5493,0 5511,1 5566,0 5660,1 5712,0 5762,1 5801,0 5884,1 5914,0 5993,1 6074,0 6152,1 6153,0 6222,1 6230,0 6305,1 6361,0 6379,1 6453,0 6498,1 6537,0 6583,1 6641,0 6667,1 6697,0 6752,1 6771,0 6782,1 6828,0 6836,1 6936,0 6984,1 7058,0 7066,1 7099,0 7160,1 7221,0 7222,1 7315,0 7319,1 7383,0 7421,1 7451,0 7473,1 7496,0 7517,1 7561,0 7599,1 7647,0 7710,1 7791,0 7884,1 7923,0 7944,1 7945,0 7984,1 8009,0 8089,1 8138,0 8152,1 8234,0 8323,1 8373,0 8413,1 8423,0 8428,1 8495,0 8571,1 8609,0 8624,1 8690,0 8783,1 8813,0 8869,1 8888,0 8900,1 8959,0 9007,1 9076,0 9082,1 9133,0 9164,1 9250,0 9282,1 9336,0 9424,1 9438,0 9476,1 9576,0 9643,1 9740,0 9800,1 9858,0 9913,1 9934,0 10031,1 10086,0 10120,1 10163,0 10210,1 10245,0 10333,1 10379,0 10424,1 10510,0 10584,1 10679,0 10701,1 10734,0 10750,1 10843,0 10924,1 10957,0 11046,1 11144,0 11161,1 11257,0 11262,1 11301,0 11383,1 11409,0 11508,1 11600,0 11672,1 11714,0 11740,1 11810,0 11854,1 11892,0 11965,1 12018,0 12037,1 12108,0 12132,1 12134,0 12190,1 12240,0 12262,1 12287,0 12338,1 12360,0 12365,1 12449,0 12534,1 12633,0 12668,1 12751,0 12809,1 12904,0 12990,1 13064,0 13080,1 13162,0 13219,1 13253,0 13299,1 13399,0 13421,1 13517,0 13524,1 13541,0 13590,1 13612,0 13678,1 13695,0 13706,1 13804,0 13810,1 13897,0 13991,1 14015,0 14021,1 14075,0 14114,1 14160,0 14183,1 14210,0 14215,1 14262,0 14357,1 14454,0 14534,1 14548,0 14599,1 14674,0 14710,1 14783,0 14879,1 14952,0 14984,1 15023,0 15073,1 15161,0 15186,1 15227,0 15327,1 15351,0 15431,1 15490,0 15581,1 15640,0 15710,1 15798,0 15870,1 15953,0 16002,1 16053,0 16105,1 16184,0 16191,1 16209,0 16221,1 16273,0 16337,1 16393,0 16411,1 16440,0 16485,1 16493,0 16500,1 16551,0 16586,1 16653,0 16702,1 16707,0 16742,1 16771,0 16826,1 16896,0 16977,1 17015,0 17079,1 17163,0 17215,1 17293,0 17307,1 17378,0 17397,1 17487,0 17509,1 17545,0 17559,1 17566,0 17611,1 17633,0 17706,1 17740,0 17792,1 17824,0 17855,1 17926,0 17972,1 18064,0 18103,1 18193,0 18251,1 18299,0 18304,1 18399,0 18486,1 18544,0 18586,1 18607,0 18625,1 18692,0 18735,1 18745,0 18805,1 18860,0 18934,1 19004,0 19035,1 19047,0 19128,1 19209,0 19252,1 19334,0 19373,1 19388,0 19434,1 19492,0 19580,1 19611,0 19694,1 19728,0 19805,1 19873,0 19886,1 19973,0 19994,1 20026,0 20079,1 20101,0 20139,1 20180,0 20263,1 20295,0 20342,1 20434,0 20453,1 20468,0 20521,1 20557,0 20599,1 20683,0 20705,1 20801,0 20820,1 20865,0 20933,1 20965,0 21003,1 21029,0 21125,1 21214,0 21284,1 21330,0 21345,1 21394,0 21418,1 21426,0 21513,1 21526,0 21624,1 21711,0 21758,1 21785,0 21849,1 21877,0 21884,1 21961,0 22044,1 22075,0 22089,1 22133,0 22146,1 22159,0 22174,1 22232,0 22280,1 22353,0 22378,1 22453,0 22531,1 22589,0 22625,1 22710,0 22735,1 22820,0 22845,1 22935,0 22947,1 22967,0 22994,1 23010,0 23038,1 23081,0 23106,1 23166,0 23253,1 23293,0 23356,1 23414,0 23474,1 23514,0 23546,1 23587,0 23682,1 23755,0 23820,1 23858,0 23919,1 23936,0 23997,1 24010,0 24017,1 24082,0 24121,1 24221,0 24299,1 24384,0 24446,1 24462,0 24488,1 24523,0 24603,1 24655,0 24744,1 24806,0 24856,1 24925,0 25020,1 25085,0 25138,1 25209,0 25302,1 25379,0 25407,1 25421,0 25464,1 25533,0 25619,1 25631,0 25718,1 25755,0 25804,1 25889,0 25924,1 25946,0 25959,1 26034,0 26057,1 26106,0 26118,1 26181,0 26192,1 26222,0 26258,1 26281,0 26308,1 26347,0 26446,1 26478,0 26527,1 26531,0 26559,1 26609,0 26618,1 26642,0 26728,1 26771,0 26862,1 26936,0 26996,1 27056,0 27142,1 27206,0 27257,1 27275,0 27299,1 27386,0 27390,1 27407,0 27439,1 27518,0 27562,1 27618,0 27672,1 27740,0 27806,1 27885,0 27948,1 28023,0 28114,1 28132,0 28205,1 28218,0 28236,1 28325,0 28378,1 28417,0 28425,1 28437,0 28481,1 28522,0 28621,1 28709,0 28740,1 28767,0 28773,1 28780,0 28846,1 28944,0 28971,1 28993,0 29062,1 29063,0 29086,1 29155,0 29234,1 29255,0 29350,1 29364,0 29407,1 29484,0 29542,1 29569,0 29581,1 29651,0 29656,1 29711,0 29769,1 29863,0 29916,1 29951,0 29981,1 30025,0 30113,1 30121,0 30205,1 30229,0 30277,1 30306,0 30379,1 30400,0 30442,1 30533,0 30605,1 30646,0 30688,1 30714,0 30739,1 30775,0 30837,1 30885,0 30891,1 30896,0 30985,1 31065,0 31098,1 31099,0 31143,1 31146,0 31235,1 31322,0 31334,1 31372,0 31440,1 31531,0 31566,1 31610,0 31631,1 31705,0 31738,1 31757,0 31815,1 31888,0 31985,1 32049,0 32084,1 32170,0 32174,1 32252,0 32318,1 32328,0 32361,1 32419,0 32440,1 32474,0 32572,1 32576,0 32608,1 32630,0 32634,1 32681,0 32715,1 32792,0 32867,1 32920,0 32925,1 32990,0 33084,1 33176,0 33224,1 33317,0 33328,1 33408,0 33439,1 33527,0 33534,1 33569,0 33624,1 33717,0 33745,1 33768,0 33791,1 33799,0 33896,1 33991,0 34039,1 34108,0 34169,1 34236,0 34328,1 34374,0 34420,1 34455,0 34519,1 34595,0 34619,1 34688,0 34750,1 34787,0 34797,1 34805,0 34871,1 34931,0 34934,1 34984,0 35063,1 35139,0 35153,1 35250,0 35333,1 35426,0 35430,1 35438,0 35446,1 35531,0 35542,1 35585,0 35657,1 35723,0 35813,1 35819,0 35864,1 35957,0 35978,1 36051,0 36088,1 36165,0 36188,1 36283,0 36326,1 36333,0 36351,1 36405,0 36437,1 36447,0 36459,1 36467,0 36536,1 36548,0 36620,1 36687,0 36718,1 36758,0 36827,1 36887,0 36953,1 37014,0 37045,1 37113,0 37162,1 37174,0 37235,1 37239,0 37321,1 37400,0 37414,1 37476,0 37556,1 37590,0 37625,1 37709,0 37776,1 37801,0 37876,1 37938,0 37997,1 38004,0 38058,1 38096,0 38129,1 38142,0 38161,1 38194,0 38290,1 38338,0 38377,1 38391,0 38442,1 38532,0 38626,1 38639,0 38671,1 38679,0 38768,1 38838,0 38903,1 38905,0 39003,1 39075,0 39079,1 39154,0 39189,1 39252,0 39307,1 39329,0 39376,1 39441,0 39467,1 39523,0 39541,1 39565,0 39639,1 39704,0 39777,1 39863,0 39896,1 39978,0 40031,1 40091,0 40186,1 40268,0 40352,1 40427,0 40436,1 40450,0 40502,1 40555,0 40654,1 40751,0 40792,1 40834,0 40840,1 40915,0 40966,1 40991,0 41031,1 41069,0 41092,1 41136,0 41151,1 41241,0 41277,1 41289,0 41343,1 41361,0 41374,1 41454,0 41494,1 41527,0 41608,1 41702,0 41712,1 41741,0 41789,1 41822,0 41845,1 41942,0 42004,1 42073,0 42168,1 42181,0 42198,1 42209,0 42308,1 42362,0 42456,1 42487,0 42516,1 42570,0 42663,1 42702,0 42766,1 42855,0 42858,1 42860,0 42862,1 42901,0 42985,1 43051,0 43151,1 43196,0 43236,1 43318,0 43407,1 43487,0 43585,1 43644,0 43646,1 43677,0 43770,1 43833,0 43925,1 43957,0 44029,1 44099,0 44129,1 44169,0 44198,1 44268,0 44367,1 44385,0 44424,1 44504,0 44548,1 44632,0 44716,1 44717,0 44729,1 44765,0 44853,1 44912,0 44949,1 44981,0 45054,1 45084,0 45123,1 45131,0 45194,1 45270,0 45333,1 45351,0 45394,1 45470,0 45548,1 45574,0 45578,1 45634,0 45659,1 45712,0 45733,1 45767,0 45800,1 45883,0 45983,1 46063,0 46115,1 46207,0 46295,1 46304,0 46354,1 46387,0 46390,1 46470,0 46490,1 46529,0 46570,1 46640,0 46646,1 46687,0 46709,1 46808,0 46848,1 46897,0 46961,1 47012,0 47075,1 47130,0 47210,1 47265,0 47293,1 47351,0 47385,1 47429,0 47525,1 47549,0 47605,1 47650,0 47686,1 47714,0 47733,1 47800,0 47855,1 47881,0 47962,1 47993,0 48077,1 48176,0 48247,1 48293,0 48334,1 48418,0 48516,1 48547,0 48627,1 48708,0 48725,1 48775,0 48834,1 48923,0 48999,1 49057,0 49119,1 49158,0 49254,1 49347,0 49399,1 49486,0 49556,1 49608,0 49629,1 49684,0 49783,1 49823,0 49879,1 49955,0 50032,1 end initlist b43 0,0 45,1 48,0 84,1 105,0 130,1 179,0 273,1 294,0 328,1 385,0 456,1 459,0 559,1 561,0 657,1 720,0 740,1 816,0 851,1 871,0 915,1 929,0 933,1 990,0 1029,1 1112,0 1125,1 1195,0 1255,1 1325,0 1420,1 1479,0 1542,1 1619,0 1674,1 1677,0 1773,1 1864,0 1920,1 1976,0 2025,1 2089,0 2102,1 2119,0 2173,1 2258,0 2289,1 2387,0 2459,1 2492,0 2501,1 2502,0 2548,1 2594,0 2630,1 2646,0 2714,1 2725,0 2805,1 2861,0 2959,1 2986,0 3053,1 3099,0 3195,1 3267,0 3351,1 3372,0 3377,1 3433,0 3442,1 3452,0 3464,1 3483,0 3514,1 3588,0 3674,1 3713,0 3811,1 3886,0 3923,1 3991,0 4059,1 4104,0 4200,1 4287,0 4385,1 4466,0 4561,1 4582,0 4590,1 4612,0 4618,1 4687,0 4740,1 4766,0 4774,1 4846,0 4852,1 4916,0 4989,1 5081,0 5152,1 5235,0 5334,1 5377,0 5461,1 5523,0 5615,1 5632,0 5657,1 5732,0 5830,1 5922,0 5941,1 6037,0 6063,1 6097,0 6098,1 6139,0 6152,1 6220,0 6226,1 6307,0 6389,1 6472,0 6516,1 6525,0 6607,1 6694,0 6727,1 6744,0 6792,1 6804,0 6822,1 6839,0 6910,1 6971,0 6994,1 7059,0 7091,1 7120,0 7209,1 7283,0 7357,1 7428,0 7510,1 7604,0 7639,1 7685,0 7756,1 7829,0 7839,1 7932,0 8022,1 8117,0 8127,1 8129,0 8219,1 8270,0 8285,1 8353,0 8438,1 8465,0 8511,1 8561,0 8619,1 8703,0 8761,1 8834,0 8889,1 8900,0 8975,1 9054,0 9130,1 9190,0 9233,1 9272,0 9302,1 9315,0 9361,1 9365,0 9464,1 9509,0 9598,1 9678,0 9747,1 9785,0 9798,1 9836,0 9914,1 9934,0 10021,1 10107,0 10202,1 10292,0 10312,1 10408,0 10469,1 10534,0 10565,1 10611,0 10678,1 10776,0 10859,1 10914,0 10995,1 11092,0 11168,1 11268,0 11362,1 11409,0 11418,1 11512,0 11570,1 11612,0 11618,1 11662,0 11681,1 11719,0 11811,1 11904,0 11990,1 12018,0 12083,1 12095,0 12123,1 12208,0 12229,1 12309,0 12394,1 12470,0 12492,1 12563,0 12614,1 12652,0 12658,1 12680,0 12715,1 12814,0 12830,1 12886,0 12973,1 13046,0 13068,1 13115,0 13170,1 13220,0 13298,1 13327,0 13403,1 13495,0 13569,1 13662,0 13752,1 13760,0 13839,1 13898,0 13925,1 13959,0 14048,1 14088,0 14145,1 14228,0 14253,1 14305,0 14395,1 14473,0 14481,1 14542,0 14635,1 14695,0 14764,1 14785,0 14787,1 14843,0 14852,1 14951,0 14999,1 15059,0 15061,1 15098,0 15123,1 15177,0 15221,1 15225,0 15265,1 15322,0 15353,1 15387,0 15451,1 15465,0 15494,1 15525,0 15572,1 15632,0 15679,1 15734,0 15788,1 15831,0 15832,1 15851,0 15881,1 15968,0 16009,1 16081,0 16102,1 16139,0 16147,1 16161,0 16257,1 16308,0 16349,1 16418,0 16427,1 16523,0 16610,1 16678,0 16771,1 16792,0 16873,1 16914,0 16947,1 17028,0 17052,1 17075,0 17077,1 17118,0 17163,1 17247,0 17287,1 17343,0 17368,1 17373,0 17377,1 17463,0 17549,1 17624,0 17723,1 17781,0 17803,1 17821,0 17903,1 17975,0 18003,1 18098,0 18125,1 18174,0 18187,1 18210,0 18233,1 18284,0 18345,1 18348,0 18383,1 18445,0 18477,1 18516,0 18586,1 18600,0 18607,1 18629,0 18663,1 18742,0 18763,1 18850,0 18882,1 18941,0 19040,1 19092,0 19161,1 19236,0 19308,1 19311,0 19371,1 19375,0 19411,1 19444,0 19502,1 19507,0 19607,1 19653,0 19718,1 19813,0 19880,1 19912,0 19917,1 19967,0 19985,1 20069,0 20156,1 20165,0 20186,1 20190,0 20208,1 20235,0 20291,1 20336,0 20362,1 20414,0 20436,1 20465,0 20474,1 20479,0 20496,1 20538,0 20619,1 20657,0 20714,1 20781,0 20855,1 20863,0 20871,1 20944,0 21006,1 21072,0 21157,1 21169,0 21211,1 21276,0 21342,1 21351,0 21398,1 21420,0 21507,1 21551,0 21641,1 21650,0 21691,1 21715,0 21758,1 21764,0 21857,1 21869,0 21903,1 21963,0 22044,1 22111,0 22151,1 22170,0 22229,1 22291,0 22364,1 22371,0 22387,1 22437,0 22472,1 22518,0 22604,1 22645,0 22716,1 22744,0 22780,1 22846,0 22891,1 22933,0 22952,1 23051,0 23090,1 23131,0 23132,1 23171,0 23271,1 23339,0 23350,1 23405,0 23457,1 23478,0 23519,1 23586,0 23587,1 23591,0 23643,1 23666,0 23675,1 23766,0 23800,1 23852,0 23898,1 23958,0 24015,1 24095,0 24108,1 24196,0 24290,1 24300,0 24397,1 24411,0 24501,1 24593,0 24618,1 24702,0 24739,1 24821,0 24822,1 24828,0 24868,1 24923,0 24973,1 25063,0 25085,1 25131,0 25178,1 25273,0 25291,1 25346,0 25385,1 25475,0 25508,1 25549,0 25554,1 25646,0 25653,1 25712,0 25796,1 25868,0 25957,1 26034,0 26060,1 26152,0 26217,1 26279,0 26298,1 26350,0 26391,1 26471,0 26496,1 26571,0 26601,1 26632,0 26665,1 26755,0 26810,1 26905,0 26912,1 26997,0 27058,1 27123,0 27187,1 27246,0 27296,1 27388,0 27440,1 27513,0 27518,1 27610,0 27611,1 27697,0 27797,1 27809,0 27855,1 27899,0 27978,1 28061,0 28106,1 28156,0 28157,1 28216,0 28243,1 28337,0 28420,1 28458,0 28552,1 28589,0 28632,1 28662,0 28665,1 28738,0 28759,1 28815,0 28904,1 28928,0 28944,1 28991,0 29084,1 29183,0 29275,1 29327,0 29351,1 29384,0 29418,1 29501,0 29590,1 29630,0 29729,1 29732,0 29815,1 29896,0 29959,1 30011,0 30016,1 30088,0 30115,1 30178,0 30230,1 30292,0 30379,1 30428,0 30507,1 30598,0 30608,1 30683,0 30759,1 30779,0 30831,1 30882,0 30889,1 30925,0 30949,1 31000,0 31098,1 31192,0 31286,1 31318,0 31358,1 31444,0 31480,1 31535,0 31614,1 31692,0 31772,1 31791,0 31868,1 31913,0 31951,1 32008,0 32012,1 32023,0 32045,1 32086,0 32138,1 32149,0 32248,1 32299,0 32321,1 32398,0 32490,1 32498,0 32501,1 32546,0 32639,1 32719,0 32752,1 32763,0 32857,1 32878,0 32901,1 32957,0 33001,1 33089,0 33092,1 33104,0 33119,1 33127,0 33149,1 33213,0 33287,1 33330,0 33378,1 33462,0 33474,1 33498,0 33535,1 33593,0 33636,1 33716,0 33740,1 33748,0 33826,1 33847,0 33908,1 34007,0 34086,1 34147,0 34232,1 34277,0 34328,1 34341,0 34417,1 34472,0 34526,1 34591,0 34620,1 34638,0 34677,1 34708,0 34743,1 34833,0 34887,1 34952,0 34984,1 35046,0 35103,1 35143,0 35145,1 35238,0 35287,1 35291,0 35359,1 35405,0 35476,1 35529,0 35540,1 35557,0 35632,1 35677,0 35750,1 35780,0 35792,1 35836,0 35931,1 36017,0 36028,1 36121,0 36176,1 36183,0 36261,1 36339,0 36379,1 36422,0 36469,1 36486,0 36544,1 36607,0 36662,1 36722,0 36815,1 36836,0 36913,1 36954,0 36958,1 37035,0 37080,1 37147,0 37247,1 37339,0 37383,1 37419,0 37518,1 37523,0 37594,1 37625,0 37685,1 37740,0 37784,1 37792,0 37835,1 37917,0 37969,1 38013,0 38036,1 38090,0 38097,1 38103,0 38123,1 38221,0 38304,1 38368,0 38458,1 38512,0 38612,1 38617,0 38674,1 38697,0 38789,1 38887,0 38980,1 39013,0 39072,1 39130,0 39135,1 39177,0 39195,1 39274,0 39298,1 39360,0 39385,1 39482,0 39489,1 39539,0 39610,1 39611,0 39635,1 39716,0 39740,1 39836,0 39841,1 39886,0 39911,1 39942,0 39973,1 39976,0 40056,1 40130,0 40141,1 40168,0 40174,1 40264,0 40335,1 40338,0 40397,1 40433,0 40461,1 40504,0 40571,1 40588,0 40681,1 40732,0 40810,1 40883,0 40894,1 40937,0 40953,1 41029,0 41067,1 41083,0 41097,1 41182,0 41187,1 41217,0 41236,1 41323,0 41395,1 41427,0 41438,1 41493,0 41524,1 41603,0 41693,1 41767,0 41826,1 41905,0 42004,1 42040,0 42138,1 42189,0 42221,1 42247,0 42316,1 42350,0 42421,1 42509,0 42534,1 42551,0 42630,1 42708,0 42799,1 42860,0 42881,1 42953,0 42968,1 42994,0 43057,1 43134,0 43142,1 43173,0 43253,1 43343,0 43406,1 43459,0 43490,1 43501,0 43543,1 43632,0 43646,1 43661,0 43691,1 43706,0 43779,1 43793,0 43871,1 43940,0 43989,1 43996,0 44083,1 44157,0 44246,1 44277,0 44289,1 44388,0 44462,1 44511,0 44546,1 44593,0 44621,1 44718,0 44755,1 44808,0 44897,1 44962,0 45031,1 45109,0 45207,1 45280,0 45306,1 45393,0 45469,1 45490,0 45552,1 45621,0 45708,1 45775,0 45835,1 45865,0 45934,1 45936,0 45953,1 46016,0 46114,1 46169,0 46255,1 46281,0 46320,1 46399,0 46451,1 46534,0 46565,1 46607,0 46687,1 46763,0 46860,1 46920,0 46958,1 46978,0 46994,1 47082,0 47161,1 47163,0 47225,1 47237,0 47318,1 47398,0 47478,1 47530,0 47584,1 47598,0 47656,1 47678,0 47720,1 47815,0 47869,1 47918,0 47921,1 48005,0 48040,1 48049,0 48081,1 48087,0 48104,1 48117,0 48164,1 48191,0 48220,1 48312,0 48351,1 48359,0 48418,1 48443,0 48454,1 48476,0 48496,1 48522,0 48524,1 48615,0 48691,1 48697,0 48733,1 48779,0 48857,1 48936,0 49018,1 49062,0 49083,1 49113,0 49194,1 49247,0 49292,1 49354,0 49439,1 49473,0 49479,1 49528,0 49585,1 49608,0 49705,1 49717,0 49760,1 49819,0 49835,1 49883,0 49935,1 49987,0 50035,1 50093,0 50131,1 50174,0 50177,1 50233,0 50288,1 50310,0 50336,1 end initlist b44 0,0 10,1 40,0 99,1 108,0 176,1 177,0 223,1 307,0 378,1 435,0 493,1 539,0 552,1 556,0 639,1 728,0 816,1 900,0 949,1 1028,0 1125,1 1173,0 1180,1 1239,0 1243,1 1249,0 1345,1 1371,0 1411,1 1431,0 1480,1 1501,0 1553,1 1557,0 1617,1 1649,0 1729,1 1826,0 1883,1 1956,0 2038,1 2110,0 2133,1 2154,0 2252,1 2331,0 2387,1 2462,0 2504,1 2507,0 2599,1 2602,0 2655,1 2722,0 2805,1 2879,0 2881,1 2922,0 2939,1 2996,0 3061,1 3154,0 3180,1 3217,0 3314,1 3404,0 3457,1 3538,0 3557,1 3627,0 3646,1 3707,0 3712,1 3730,0 3818,1 3897,0 3994,1 4030,0 4048,1 4126,0 4205,1 4223,0 4279,1 4372,0 4391,1 4420,0 4480,1 4569,0 4611,1 4655,0 4731,1 4830,0 4875,1 4893,0 4910,1 4939,0 4998,1 5056,0 5075,1 5110,0 5132,1 5187,0 5200,1 5256,0 5295,1 5371,0 5394,1 5405,0 5490,1 5509,0 5590,1 5650,0 5710,1 5791,0 5876,1 5926,0 6013,1 6037,0 6120,1 6199,0 6275,1 6303,0 6313,1 6392,0 6485,1 6553,0 6615,1 6708,0 6723,1 6790,0 6821,1 6888,0 6937,1 6945,0 7027,1 7030,0 7064,1 7157,0 7249,1 7294,0 7363,1 7381,0 7459,1 7537,0 7611,1 7672,0 7741,1 7802,0 7831,1 7907,0 7980,1 8052,0 8139,1 8146,0 8233,1 8245,0 8336,1 8368,0 8463,1 8486,0 8559,1 8605,0 8640,1 8648,0 8737,1 8789,0 8795,1 8870,0 8900,1 8903,0 8978,1 9074,0 9124,1 9133,0 9193,1 9242,0 9297,1 9314,0 9327,1 9363,0 9428,1 9518,0 9536,1 9589,0 9661,1 9741,0 9784,1 9838,0 9842,1 9843,0 9928,1 9934,0 10032,1 10094,0 10161,1 10255,0 10312,1 10346,0 10419,1 10426,0 10468,1 10551,0 10622,1 10653,0 10701,1 10706,0 10767,1 10855,0 10947,1 11037,0 11090,1 11180,0 11236,1 11269,0 11366,1 11422,0 11502,1 11562,0 11587,1 11673,0 11757,1 11772,0 11856,1 11867,0 11937,1 11996,0 12035,1 12111,0 12153,1 12207,0 12219,1 12260,0 12276,1 12342,0 12385,1 12472,0 12519,1 12613,0 12697,1 12756,0 12844,1 12938,0 13008,1 13089,0 13164,1 13176,0 13257,1 13324,0 13378,1 13472,0 13564,1 13648,0 13660,1 13753,0 13768,1 13780,0 13787,1 13887,0 13927,1 13938,0 14005,1 14102,0 14129,1 14151,0 14172,1 14255,0 14303,1 14306,0 14405,1 14505,0 14552,1 14644,0 14659,1 14677,0 14734,1 14812,0 14822,1 14904,0 14970,1 14995,0 15033,1 15061,0 15094,1 15116,0 15148,1 15184,0 15231,1 15244,0 15253,1 15313,0 15340,1 15356,0 15448,1 15479,0 15570,1 15665,0 15696,1 15766,0 15864,1 15877,0 15920,1 15932,0 15991,1 16005,0 16014,1 16045,0 16128,1 16131,0 16166,1 16211,0 16294,1 16328,0 16416,1 16488,0 16533,1 16601,0 16617,1 16624,0 16642,1 16646,0 16722,1 16756,0 16786,1 16790,0 16812,1 16830,0 16869,1 16933,0 16961,1 17051,0 17069,1 17114,0 17208,1 17256,0 17305,1 17358,0 17427,1 17527,0 17529,1 17615,0 17630,1 17717,0 17759,1 17828,0 17869,1 17967,0 17987,1 18086,0 18118,1 18199,0 18246,1 18258,0 18302,1 18397,0 18425,1 18506,0 18573,1 18667,0 18686,1 18725,0 18729,1 18760,0 18787,1 18867,0 18906,1 18995,0 19020,1 19066,0 19162,1 19163,0 19230,1 19232,0 19317,1 19322,0 19375,1 19471,0 19569,1 19615,0 19712,1 19730,0 19773,1 19852,0 19945,1 20042,0 20132,1 20195,0 20253,1 20284,0 20286,1 20334,0 20384,1 20441,0 20518,1 20540,0 20557,1 20583,0 20682,1 20724,0 20817,1 20847,0 20875,1 20934,0 21024,1 21053,0 21107,1 21171,0 21251,1 21334,0 21389,1 21446,0 21467,1 21561,0 21652,1 21721,0 21724,1 21753,0 21815,1 21844,0 21936,1 21989,0 22072,1 22151,0 22184,1 22271,0 22282,1 22293,0 22357,1 22402,0 22415,1 22488,0 22584,1 22614,0 22640,1 22708,0 22806,1 22875,0 22970,1 23023,0 23095,1 23125,0 23177,1 23196,0 23261,1 23352,0 23386,1 23437,0 23439,1 23456,0 23533,1 23615,0 23651,1 23743,0 23806,1 23862,0 23927,1 23929,0 23981,1 24055,0 24075,1 24170,0 24246,1 24318,0 24340,1 24367,0 24412,1 24455,0 24498,1 24502,0 24548,1 24619,0 24646,1 24730,0 24805,1 24848,0 24915,1 24949,0 25008,1 25011,0 25090,1 25112,0 25152,1 25156,0 25167,1 25187,0 25243,1 25286,0 25298,1 25343,0 25398,1 25479,0 25532,1 25559,0 25657,1 25743,0 25768,1 25805,0 25869,1 25926,0 25935,1 25949,0 25955,1 25956,0 25988,1 26070,0 26138,1 26176,0 26200,1 26254,0 26298,1 26325,0 26339,1 26351,0 26385,1 26439,0 26486,1 26499,0 26510,1 26550,0 26636,1 26695,0 26740,1 26830,0 26889,1 26985,0 27009,1 27093,0 27116,1 27171,0 27173,1 27176,0 27239,1 27266,0 27309,1 27338,0 27376,1 27442,0 27542,1 27574,0 27669,1 27740,0 27742,1 27781,0 27874,1 27885,0 27918,1 27945,0 28005,1 28082,0 28113,1 28198,0 28271,1 28282,0 28342,1 28351,0 28376,1 28407,0 28479,1 28575,0 28673,1 28692,0 28775,1 28820,0 28837,1 28867,0 28956,1 28996,0 29008,1 29041,0 29087,1 29172,0 29245,1 29310,0 29379,1 29442,0 29518,1 29606,0 29684,1 29691,0 29742,1 29806,0 29902,1 29968,0 30044,1 30117,0 30140,1 30208,0 30276,1 30288,0 30321,1 30394,0 30477,1 30510,0 30605,1 30701,0 30721,1 30732,0 30789,1 30852,0 30874,1 30937,0 30958,1 31002,0 31068,1 31143,0 31227,1 31307,0 31355,1 31387,0 31472,1 31552,0 31622,1 31673,0 31712,1 31714,0 31813,1 31821,0 31825,1 31901,0 31913,1 31921,0 32007,1 32035,0 32082,1 32095,0 32195,1 32272,0 32343,1 32413,0 32448,1 32543,0 32636,1 32709,0 32734,1 32832,0 32861,1 32950,0 33050,1 33118,0 33133,1 33209,0 33223,1 33281,0 33298,1 33393,0 33417,1 33445,0 33495,1 33502,0 33513,1 33595,0 33653,1 33681,0 33755,1 33851,0 33917,1 34016,0 34050,1 34064,0 34124,1 34179,0 34189,1 34259,0 34268,1 34321,0 34368,1 34440,0 34464,1 34527,0 34619,1 34621,0 34718,1 34724,0 34787,1 34840,0 34850,1 34906,0 34981,1 35037,0 35125,1 35159,0 35225,1 35239,0 35317,1 35346,0 35349,1 35430,0 35524,1 35599,0 35650,1 35657,0 35683,1 35745,0 35811,1 35820,0 35901,1 35923,0 35993,1 36010,0 36041,1 36072,0 36172,1 36217,0 36274,1 36289,0 36324,1 36386,0 36462,1 36464,0 36470,1 36505,0 36588,1 36602,0 36614,1 36649,0 36659,1 36690,0 36789,1 36802,0 36819,1 36881,0 36955,1 36995,0 37041,1 37110,0 37118,1 37132,0 37181,1 37258,0 37304,1 37348,0 37419,1 37462,0 37529,1 37626,0 37652,1 37696,0 37715,1 37721,0 37737,1 37806,0 37813,1 37894,0 37922,1 37963,0 37969,1 38036,0 38111,1 38208,0 38287,1 38379,0 38394,1 38424,0 38500,1 38566,0 38607,1 38640,0 38709,1 38755,0 38824,1 38879,0 38950,1 39003,0 39096,1 39193,0 39201,1 39244,0 39317,1 39385,0 39433,1 39513,0 39514,1 39530,0 39556,1 39578,0 39632,1 39654,0 39696,1 39730,0 39825,1 39845,0 39931,1 39984,0 40076,1 40141,0 40211,1 40236,0 40251,1 40268,0 40307,1 40350,0 40374,1 40459,0 40477,1 40479,0 40548,1 40642,0 40718,1 40763,0 40825,1 40894,0 40968,1 41022,0 41049,1 41077,0 41084,1 41183,0 41185,1 41223,0 41285,1 41364,0 41396,1 41466,0 41515,1 41519,0 41549,1 41611,0 41649,1 41700,0 41704,1 41781,0 41847,1 41870,0 41888,1 41953,0 42037,1 42117,0 42173,1 42258,0 42323,1 42368,0 42423,1 42480,0 42497,1 42581,0 42594,1 42610,0 42642,1 42731,0 42734,1 42785,0 42879,1 42970,0 42994,1 43046,0 43135,1 43234,0 43241,1 43321,0 43377,1 43471,0 43539,1 43627,0 43727,1 43757,0 43856,1 43868,0 43957,1 43967,0 44031,1 44086,0 44185,1 44195,0 44204,1 44273,0 44303,1 44380,0 44435,1 44498,0 44504,1 44582,0 44589,1 44609,0 44689,1 44701,0 44757,1 44777,0 44835,1 44908,0 44933,1 44946,0 45013,1 45057,0 45139,1 45168,0 45261,1 45325,0 45388,1 45438,0 45523,1 45582,0 45669,1 45755,0 45823,1 45900,0 45912,1 45939,0 45980,1 46051,0 46064,1 46135,0 46191,1 46252,0 46275,1 46334,0 46363,1 46414,0 46426,1 46433,0 46460,1 46472,0 46494,1 46523,0 46572,1 46644,0 46723,1 46816,0 46862,1 46908,0 46996,1 47065,0 47093,1 47177,0 47222,1 47279,0 47324,1 47383,0 47395,1 47464,0 47471,1 47527,0 47602,1 47650,0 47722,1 47819,0 47828,1 47847,0 47909,1 47988,0 48059,1 48070,0 48072,1 48166,0 48251,1 48271,0 48297,1 48352,0 48443,1 48520,0 48537,1 48618,0 48663,1 48681,0 48732,1 48811,0 48899,1 48929,0 48978,1 49016,0 49107,1 49142,0 49191,1 49210,0 49244,1 49344,0 49401,1 49478,0 49549,1 49550,0 49636,1 49674,0 49755,1 49841,0 49933,1 49993,0 50036,1 50062,0 50140,1 50180,0 50214,1 50296,0 50361,1 50408,0 50456,1 50527,0 50625,1 50680,0 50692,1 50761,0 50855,1 50870,0 50903,1 50936,0 51036,1 51068,0 51116,1 51186,0 51208,1 51263,0 51279,1 51366,0 51413,1 end initlist b45 0,0 13,1 89,0 93,1 94,0 149,1 216,0 283,1 382,0 464,1 563,0 659,1 730,0 811,1 880,0 905,1 974,0 1003,1 1040,0 1084,1 1160,0 1223,1 1250,0 1308,1 1334,0 1389,1 1410,0 1476,1 1567,0 1665,1 1673,0 1695,1 1720,0 1756,1 1832,0 1850,1 1931,0 2025,1 2073,0 2119,1 2160,0 2175,1 2263,0 2356,1 2434,0 2532,1 2631,0 2710,1 2730,0 2774,1 2863,0 2933,1 2991,0 3012,1 3082,0 3171,1 3238,0 3330,1 3387,0 3430,1 3479,0 3567,1 3648,0 3742,1 3747,0 3795,1 3819,0 3906,1 4002,0 4014,1 4099,0 4167,1 4181,0 4189,1 4237,0 4241,1 4259,0 4355,1 4436,0 4469,1 4540,0 4631,1 4685,0 4718,1 4799,0 4801,1 4812,0 4848,1 4903,0 4957,1 4996,0 5081,1 5083,0 5131,1 5190,0 5265,1 5352,0 5439,1 5450,0 5462,1 5520,0 5548,1 5593,0 5613,1 5692,0 5743,1 5800,0 5818,1 5878,0 5888,1 5959,0 6035,1 6108,0 6181,1 6219,0 6266,1 6343,0 6381,1 6467,0 6544,1 6584,0 6663,1 6744,0 6768,1 6846,0 6867,1 6892,0 6950,1 7022,0 7062,1 7096,0 7127,1 7198,0 7291,1 7325,0 7400,1 7481,0 7500,1 7504,0 7548,1 7585,0 7622,1 7705,0 7799,1 7885,0 7946,1 8035,0 8133,1 8146,0 8179,1 8273,0 8305,1 8404,0 8464,1 8467,0 8535,1 8577,0 8649,1 8653,0 8710,1 8797,0 8816,1 8860,0 8881,1 8920,0 8980,1 9026,0 9079,1 9165,0 9237,1 9262,0 9267,1 9364,0 9378,1 9444,0 9506,1 9515,0 9613,1 9638,0 9660,1 9690,0 9758,1 9828,0 9857,1 9917,0 9944,1 10028,0 10097,1 10146,0 10189,1 10279,0 10378,1 10471,0 10472,1 10497,0 10564,1 10662,0 10690,1 10712,0 10718,1 10778,0 10816,1 10845,0 10940,1 10976,0 11052,1 11108,0 11168,1 11195,0 11288,1 11324,0 11393,1 11409,0 11505,1 11506,0 11524,1 11617,0 11655,1 11686,0 11774,1 11788,0 11815,1 11904,0 11984,1 12007,0 12100,1 12167,0 12199,1 12296,0 12308,1 12383,0 12448,1 12486,0 12508,1 12590,0 12661,1 12714,0 12765,1 12824,0 12898,1 12903,0 12966,1 13051,0 13150,1 13227,0 13327,1 13353,0 13417,1 13452,0 13476,1 13508,0 13519,1 13540,0 13544,1 13555,0 13573,1 13578,0 13640,1 13710,0 13803,1 13812,0 13906,1 13948,0 13952,1 14003,0 14103,1 14185,0 14187,1 14275,0 14325,1 14347,0 14364,1 14463,0 14530,1 14606,0 14672,1 14707,0 14752,1 14839,0 14931,1 15000,0 15043,1 15067,0 15128,1 15169,0 15258,1 15324,0 15384,1 15402,0 15485,1 15517,0 15603,1 15700,0 15790,1 15883,0 15949,1 15990,0 16036,1 16124,0 16178,1 16254,0 16342,1 16358,0 16395,1 16419,0 16503,1 16534,0 16569,1 16595,0 16674,1 16749,0 16764,1 16797,0 16888,1 16927,0 16984,1 16986,0 17029,1 17049,0 17146,1 17179,0 17242,1 17325,0 17329,1 17424,0 17524,1 17588,0 17605,1 17622,0 17659,1 17702,0 17738,1 17831,0 17927,1 17951,0 17997,1 18024,0 18111,1 18146,0 18231,1 18266,0 18306,1 18310,0 18321,1 18323,0 18341,1 18414,0 18483,1 18541,0 18636,1 18688,0 18716,1 18799,0 18875,1 18968,0 18986,1 19044,0 19123,1 19177,0 19224,1 19243,0 19337,1 19390,0 19468,1 19485,0 19552,1 19588,0 19623,1 19641,0 19698,1 19778,0 19821,1 19840,0 19846,1 19943,0 20023,1 20107,0 20207,1 20238,0 20260,1 20270,0 20303,1 20372,0 20403,1 20424,0 20493,1 20520,0 20564,1 20587,0 20674,1 20719,0 20725,1 20742,0 20840,1 20898,0 20973,1 21043,0 21143,1 21179,0 21186,1 21203,0 21301,1 21383,0 21391,1 21456,0 21507,1 21605,0 21660,1 21748,0 21768,1 21859,0 21954,1 21987,0 22087,1 22109,0 22189,1 22195,0 22290,1 22369,0 22397,1 22432,0 22489,1 22571,0 22665,1 22677,0 22726,1 22781,0 22834,1 22919,0 22986,1 23006,0 23010,1 23055,0 23144,1 23147,0 23157,1 23207,0 23260,1 23347,0 23441,1 23461,0 23464,1 23507,0 23580,1 23629,0 23688,1 23770,0 23848,1 23926,0 23928,1 23974,0 24063,1 24151,0 24204,1 24281,0 24354,1 24433,0 24524,1 24542,0 24554,1 24614,0 24697,1 24785,0 24831,1 24869,0 24902,1 24939,0 24983,1 25011,0 25104,1 25138,0 25156,1 25194,0 25257,1 25318,0 25404,1 25411,0 25479,1 25498,0 25530,1 25593,0 25646,1 25734,0 25804,1 25833,0 25866,1 25943,0 25984,1 25993,0 26077,1 26150,0 26240,1 26259,0 26359,1 26428,0 26488,1 26498,0 26550,1 26554,0 26606,1 26614,0 26630,1 26673,0 26708,1 26745,0 26841,1 26873,0 26882,1 26897,0 26913,1 26944,0 26983,1 27042,0 27050,1 27073,0 27123,1 27203,0 27212,1 27261,0 27284,1 27376,0 27422,1 27480,0 27573,1 27645,0 27648,1 27676,0 27708,1 27737,0 27814,1 27825,0 27908,1 27993,0 28077,1 28121,0 28136,1 28137,0 28231,1 28256,0 28300,1 28367,0 28446,1 28537,0 28558,1 28620,0 28649,1 28659,0 28728,1 28748,0 28761,1 28800,0 28831,1 28832,0 28868,1 28917,0 28971,1 29057,0 29087,1 29187,0 29228,1 29273,0 29346,1 29366,0 29450,1 29487,0 29570,1 29642,0 29685,1 29762,0 29764,1 29787,0 29851,1 29881,0 29912,1 29946,0 30009,1 30074,0 30123,1 30190,0 30195,1 30278,0 30333,1 30371,0 30409,1 30428,0 30439,1 30513,0 30578,1 30619,0 30709,1 30713,0 30730,1 30763,0 30834,1 30910,0 30996,1 31082,0 31112,1 31207,0 31231,1 31246,0 31337,1 31421,0 31462,1 31495,0 31567,1 31626,0 31638,1 31641,0 31708,1 31780,0 31847,1 31872,0 31963,1 31990,0 32005,1 32066,0 32082,1 32158,0 32184,1 32194,0 32207,1 32298,0 32381,1 32473,0 32507,1 32559,0 32574,1 32603,0 32632,1 32659,0 32731,1 32771,0 32854,1 32928,0 32961,1 33059,0 33076,1 33159,0 33229,1 33297,0 33304,1 33318,0 33367,1 33463,0 33543,1 33571,0 33660,1 33702,0 33764,1 33844,0 33913,1 33930,0 34024,1 34091,0 34110,1 34161,0 34184,1 34232,0 34328,1 34349,0 34380,1 34471,0 34517,1 34597,0 34681,1 34708,0 34765,1 34849,0 34850,1 34948,0 34993,1 35060,0 35061,1 35069,0 35156,1 35242,0 35302,1 35336,0 35403,1 35448,0 35478,1 35484,0 35489,1 35508,0 35576,1 35626,0 35638,1 35670,0 35675,1 35687,0 35767,1 35808,0 35847,1 35914,0 35982,1 36005,0 36078,1 36150,0 36170,1 36251,0 36293,1 36384,0 36392,1 36453,0 36486,1 36554,0 36634,1 36713,0 36809,1 36857,0 36924,1 36952,0 37006,1 37084,0 37126,1 37199,0 37274,1 37280,0 37310,1 37338,0 37394,1 37400,0 37473,1 37570,0 37588,1 37680,0 37773,1 37824,0 37826,1 37918,0 37959,1 38056,0 38080,1 38137,0 38235,1 38266,0 38277,1 38330,0 38354,1 38429,0 38488,1 38581,0 38611,1 38640,0 38683,1 38773,0 38798,1 38818,0 38885,1 38896,0 38968,1 38995,0 39001,1 39004,0 39086,1 39116,0 39170,1 39212,0 39276,1 39352,0 39394,1 39442,0 39462,1 39472,0 39506,1 39581,0 39614,1 39653,0 39655,1 39710,0 39808,1 39834,0 39915,1 39956,0 39991,1 40012,0 40090,1 40148,0 40198,1 40248,0 40348,1 40351,0 40405,1 40465,0 40544,1 40573,0 40630,1 40672,0 40683,1 40747,0 40752,1 40819,0 40868,1 40907,0 40915,1 40928,0 40945,1 41035,0 41112,1 41119,0 41211,1 41282,0 41348,1 41380,0 41411,1 41415,0 41501,1 41557,0 41606,1 41643,0 41743,1 41840,0 41899,1 41950,0 42017,1 42107,0 42190,1 42212,0 42277,1 42303,0 42346,1 42446,0 42456,1 42543,0 42620,1 42641,0 42660,1 42675,0 42774,1 42820,0 42827,1 42923,0 42930,1 42939,0 42977,1 43036,0 43103,1 43155,0 43169,1 43228,0 43288,1 43308,0 43358,1 43367,0 43446,1 43461,0 43526,1 43550,0 43631,1 43691,0 43741,1 43772,0 43773,1 43823,0 43901,1 44000,0 44100,1 44161,0 44206,1 44245,0 44254,1 44279,0 44314,1 44317,0 44378,1 44468,0 44505,1 44524,0 44540,1 44627,0 44674,1 44691,0 44772,1 44773,0 44871,1 44912,0 44916,1 44950,0 44985,1 45062,0 45082,1 45167,0 45187,1 45202,0 45297,1 45325,0 45346,1 45445,0 45539,1 45603,0 45619,1 45699,0 45776,1 45819,0 45850,1 45904,0 45972,1 46048,0 46075,1 46130,0 46162,1 46208,0 46296,1 46310,0 46380,1 46406,0 46475,1 46504,0 46524,1 46608,0 46698,1 46738,0 46784,1 46785,0 46817,1 46859,0 46917,1 46983,0 47019,1 47037,0 47059,1 47072,0 47127,1 47184,0 47225,1 47274,0 47281,1 47298,0 47376,1 47460,0 47517,1 47525,0 47593,1 47656,0 47730,1 47790,0 47826,1 47921,0 47955,1 48048,0 48097,1 48179,0 48225,1 48240,0 48307,1 48385,0 48484,1 48544,0 48592,1 48597,0 48646,1 48686,0 48762,1 48861,0 48945,1 48967,0 48978,1 49057,0 49151,1 49162,0 49237,1 49287,0 49344,1 49428,0 49464,1 49515,0 49549,1 49613,0 49685,1 49755,0 49767,1 49779,0 49786,1 49847,0 49868,1 49917,0 49923,1 49943,0 50035,1 50066,0 50135,1 50163,0 50177,1 50274,0 50299,1 50361,0 50382,1 50454,0 50511,1 50532,0 50614,1 50657,0 50658,1 50719,0 50763,1 50854,0 50943,1 50998,0 51023,1 51035,0 51068,1 end initlist b46 0,0 23,1 110,0 135,1 153,0 224,1 245,0 282,1 283,0 321,1 391,0 428,1 454,0 545,1 635,0 719,1 746,0 759,1 795,0 798,1 847,0 868,1 923,0 945,1 991,0 1026,1 1122,0 1212,1 1282,0 1301,1 1380,0 1459,1 1543,0 1627,1 1725,0 1745,1 1751,0 1822,1 1868,0 1890,1 1892,0 1987,1 2082,0 2118,1 2210,0 2303,1 2376,0 2412,1 2446,0 2522,1 2613,0 2695,1 2711,0 2722,1 2812,0 2830,1 2887,0 2973,1 2997,0 3007,1 3107,0 3126,1 3143,0 3184,1 3272,0 3316,1 3370,0 3404,1 3433,0 3476,1 3558,0 3619,1 3625,0 3676,1 3764,0 3766,1 3784,0 3820,1 3824,0 3864,1 3929,0 3932,1 3967,0 4022,1 4089,0 4171,1 4217,0 4312,1 4332,0 4352,1 4368,0 4447,1 4478,0 4499,1 4581,0 4621,1 4693,0 4744,1 4760,0 4803,1 4902,0 4992,1 5006,0 5101,1 5189,0 5268,1 5330,0 5336,1 5380,0 5416,1 5449,0 5453,1 5536,0 5556,1 5653,0 5722,1 5747,0 5810,1 5829,0 5910,1 5960,0 5987,1 6064,0 6082,1 6110,0 6206,1 6235,0 6265,1 6286,0 6344,1 6355,0 6426,1 6466,0 6526,1 6550,0 6629,1 6708,0 6790,1 6885,0 6969,1 7037,0 7052,1 7115,0 7174,1 7199,0 7238,1 7256,0 7293,1 7313,0 7370,1 7465,0 7487,1 7555,0 7650,1 7695,0 7743,1 7772,0 7835,1 7876,0 7959,1 8024,0 8089,1 8095,0 8176,1 8212,0 8267,1 8280,0 8302,1 8341,0 8427,1 8511,0 8562,1 8567,0 8613,1 8654,0 8673,1 8715,0 8810,1 8903,0 8918,1 8921,0 9002,1 9057,0 9120,1 9200,0 9227,1 9228,0 9293,1 9315,0 9406,1 9415,0 9497,1 9580,0 9598,1 9612,0 9701,1 9715,0 9781,1 9788,0 9867,1 9933,0 9959,1 9999,0 10094,1 10096,0 10182,1 10217,0 10290,1 10388,0 10450,1 10496,0 10515,1 10529,0 10594,1 10681,0 10706,1 10740,0 10820,1 10871,0 10897,1 10908,0 10933,1 10956,0 11019,1 11119,0 11217,1 11287,0 11345,1 11362,0 11452,1 11536,0 11597,1 11605,0 11615,1 11674,0 11695,1 11749,0 11798,1 11855,0 11896,1 11962,0 12048,1 12064,0 12118,1 12187,0 12232,1 12280,0 12380,1 12476,0 12574,1 12583,0 12587,1 12678,0 12754,1 12784,0 12836,1 12846,0 12912,1 12933,0 12949,1 12963,0 13044,1 13129,0 13221,1 13235,0 13318,1 13352,0 13427,1 13496,0 13574,1 13649,0 13701,1 13794,0 13892,1 13973,0 14059,1 14066,0 14095,1 14131,0 14171,1 14264,0 14347,1 14392,0 14441,1 14456,0 14486,1 14505,0 14553,1 14637,0 14638,1 14641,0 14699,1 14796,0 14867,1 14921,0 15002,1 15087,0 15147,1 15198,0 15210,1 15241,0 15295,1 15359,0 15456,1 15518,0 15564,1 15644,0 15673,1 15725,0 15773,1 15777,0 15850,1 15925,0 15968,1 16011,0 16038,1 16110,0 16132,1 16183,0 16283,1 16288,0 16381,1 16411,0 16471,1 16490,0 16518,1 16567,0 16623,1 16681,0 16745,1 16762,0 16816,1 16832,0 16931,1 16985,0 17079,1 17097,0 17099,1 17189,0 17256,1 17290,0 17366,1 17458,0 17467,1 17513,0 17601,1 17612,0 17668,1 17717,0 17749,1 17777,0 17810,1 17900,0 17929,1 17983,0 18072,1 18089,0 18187,1 18282,0 18376,1 18475,0 18505,1 18581,0 18669,1 18682,0 18706,1 18715,0 18746,1 18837,0 18935,1 19022,0 19116,1 19144,0 19199,1 19298,0 19368,1 19385,0 19386,1 19401,0 19424,1 19440,0 19486,1 19498,0 19567,1 19605,0 19634,1 19691,0 19717,1 19788,0 19856,1 19955,0 19976,1 20001,0 20017,1 20076,0 20122,1 20204,0 20273,1 20282,0 20311,1 20402,0 20429,1 20499,0 20594,1 20647,0 20709,1 20776,0 20790,1 20817,0 20874,1 20933,0 20940,1 21028,0 21062,1 21127,0 21215,1 21284,0 21371,1 21375,0 21446,1 21505,0 21518,1 21528,0 21540,1 21574,0 21656,1 21671,0 21709,1 21739,0 21819,1 21882,0 21955,1 22046,0 22118,1 22185,0 22217,1 22301,0 22399,1 22417,0 22495,1 22573,0 22590,1 22670,0 22734,1 22742,0 22839,1 22895,0 22987,1 23066,0 23116,1 23143,0 23216,1 23255,0 23330,1 23372,0 23429,1 23496,0 23568,1 23653,0 23713,1 23733,0 23819,1 23837,0 23900,1 23980,0 23993,1 24093,0 24178,1 24202,0 24223,1 24312,0 24335,1 24382,0 24450,1 24456,0 24491,1 24500,0 24530,1 24615,0 24630,1 24724,0 24731,1 24808,0 24852,1 24879,0 24899,1 24939,0 24968,1 25042,0 25108,1 25157,0 25210,1 25305,0 25320,1 25329,0 25370,1 25390,0 25440,1 25480,0 25572,1 25672,0 25757,1 25783,0 25877,1 25890,0 25931,1 25951,0 25962,1 25963,0 26018,1 26087,0 26107,1 26153,0 26170,1 26267,0 26353,1 26366,0 26393,1 26406,0 26416,1 26434,0 26467,1 26489,0 26533,1 26576,0 26580,1 26680,0 26713,1 26770,0 26778,1 26794,0 26834,1 26838,0 26879,1 26959,0 27031,1 27085,0 27156,1 27240,0 27256,1 27292,0 27360,1 27408,0 27459,1 27488,0 27533,1 27605,0 27614,1 27669,0 27721,1 27722,0 27754,1 27828,0 27885,1 27905,0 27934,1 27999,0 28046,1 28105,0 28169,1 28206,0 28262,1 28273,0 28337,1 28403,0 28439,1 28494,0 28556,1 28616,0 28660,1 28730,0 28782,1 28870,0 28929,1 28981,0 29056,1 29148,0 29186,1 29284,0 29355,1 29380,0 29409,1 29432,0 29498,1 29575,0 29640,1 29713,0 29760,1 29855,0 29900,1 29939,0 30032,1 30118,0 30129,1 30146,0 30232,1 30306,0 30375,1 30435,0 30493,1 30515,0 30588,1 30651,0 30713,1 30737,0 30781,1 30875,0 30951,1 30965,0 30972,1 30995,0 31086,1 31118,0 31164,1 31207,0 31236,1 31291,0 31311,1 31326,0 31418,1 31438,0 31526,1 31610,0 31635,1 31726,0 31782,1 31860,0 31930,1 31947,0 31999,1 32018,0 32061,1 32095,0 32165,1 32220,0 32275,1 32360,0 32426,1 32439,0 32472,1 32474,0 32527,1 32538,0 32628,1 32716,0 32769,1 32799,0 32843,1 32858,0 32886,1 32900,0 32914,1 32961,0 32998,1 33035,0 33063,1 33099,0 33136,1 33223,0 33243,1 33330,0 33359,1 33435,0 33508,1 33574,0 33619,1 33632,0 33679,1 33735,0 33752,1 33805,0 33865,1 33951,0 34046,1 34125,0 34145,1 34206,0 34257,1 34290,0 34299,1 34318,0 34418,1 34499,0 34556,1 34633,0 34678,1 34761,0 34801,1 34851,0 34937,1 35011,0 35093,1 35187,0 35283,1 35342,0 35439,1 35496,0 35596,1 35651,0 35712,1 35762,0 35784,1 35871,0 35896,1 35923,0 35969,1 36025,0 36026,1 36092,0 36101,1 36140,0 36164,1 36169,0 36199,1 36220,0 36316,1 36337,0 36408,1 36493,0 36578,1 36587,0 36597,1 36645,0 36744,1 36787,0 36865,1 36915,0 36967,1 37044,0 37097,1 37176,0 37227,1 37302,0 37351,1 37426,0 37454,1 37476,0 37559,1 37571,0 37622,1 37663,0 37726,1 37790,0 37815,1 37915,0 37951,1 38010,0 38109,1 38132,0 38170,1 38235,0 38292,1 38337,0 38351,1 38381,0 38448,1 38478,0 38489,1 38492,0 38494,1 38501,0 38553,1 38559,0 38642,1 38664,0 38737,1 38814,0 38881,1 38915,0 38994,1 39010,0 39046,1 39114,0 39156,1 39173,0 39257,1 39338,0 39340,1 39354,0 39448,1 39479,0 39563,1 39631,0 39668,1 39678,0 39763,1 39801,0 39844,1 39932,0 40011,1 40076,0 40125,1 40214,0 40237,1 40324,0 40357,1 40389,0 40463,1 40549,0 40601,1 40602,0 40618,1 40672,0 40769,1 40839,0 40917,1 41011,0 41012,1 41041,0 41141,1 41185,0 41245,1 41314,0 41366,1 41436,0 41506,1 41553,0 41567,1 41634,0 41688,1 41752,0 41809,1 41870,0 41959,1 42054,0 42057,1 42066,0 42115,1 42200,0 42289,1 42316,0 42333,1 42420,0 42480,1 42562,0 42566,1 42629,0 42674,1 42723,0 42797,1 42819,0 42919,1 42954,0 42976,1 43034,0 43108,1 43191,0 43259,1 43281,0 43364,1 43377,0 43440,1 43479,0 43483,1 43547,0 43586,1 43652,0 43669,1 43742,0 43770,1 43837,0 43924,1 43995,0 44065,1 44164,0 44196,1 44244,0 44335,1 44412,0 44488,1 44588,0 44650,1 44681,0 44744,1 44817,0 44892,1 44931,0 44935,1 45030,0 45109,1 45167,0 45243,1 45248,0 45276,1 45354,0 45426,1 45464,0 45472,1 45537,0 45567,1 45641,0 45697,1 45757,0 45774,1 45788,0 45838,1 45890,0 45912,1 45937,0 45948,1 45976,0 45986,1 45989,0 46000,1 46054,0 46085,1 46129,0 46131,1 46177,0 46208,1 46307,0 46391,1 46416,0 46483,1 46554,0 46575,1 46607,0 46663,1 46738,0 46781,1 46793,0 46839,1 46881,0 46947,1 46957,0 47017,1 47094,0 47116,1 47119,0 47132,1 47169,0 47244,1 47319,0 47345,1 47410,0 47504,1 47549,0 47633,1 47666,0 47693,1 47770,0 47816,1 47885,0 47940,1 47980,0 48010,1 48018,0 48065,1 48123,0 48185,1 48265,0 48281,1 48302,0 48386,1 48478,0 48532,1 48550,0 48614,1 48680,0 48748,1 48773,0 48812,1 48900,0 48912,1 48923,0 49016,1 49045,0 49144,1 49232,0 49240,1 49283,0 49353,1 49374,0 49471,1 49493,0 49539,1 49564,0 49591,1 49595,0 49606,1 49704,0 49725,1 49797,0 49880,1 49898,0 49899,1 49940,0 49960,1 49969,0 50053,1 50102,0 50127,1 50182,0 50240,1 50312,0 50322,1 50368,0 50386,1 50475,0 50504,1 50569,0 50593,1 end initlist b47 0,0 4,1 27,0 106,1 190,0 219,1 260,0 322,1 332,0 377,1 467,0 544,1 558,0 588,1 679,0 754,1 841,0 863,1 921,0 943,1 1041,0 1046,1 1068,0 1151,1 1210,0 1217,1 1301,0 1327,1 1336,0 1419,1 1489,0 1560,1 1586,0 1609,1 1637,0 1677,1 1729,0 1732,1 1767,0 1786,1 1791,0 1870,1 1931,0 1990,1 2036,0 2082,1 2135,0 2149,1 2161,0 2230,1 2309,0 2390,1 2425,0 2507,1 2565,0 2581,1 2663,0 2700,1 2716,0 2758,1 2781,0 2799,1 2847,0 2862,1 2948,0 2957,1 3051,0 3105,1 3130,0 3172,1 3247,0 3316,1 3339,0 3416,1 3437,0 3452,1 3484,0 3513,1 3583,0 3611,1 3660,0 3669,1 3749,0 3838,1 3913,0 3935,1 4011,0 4082,1 4153,0 4212,1 4241,0 4313,1 4364,0 4435,1 4496,0 4570,1 4633,0 4674,1 4773,0 4832,1 4858,0 4915,1 4947,0 5023,1 5055,0 5089,1 5157,0 5215,1 5249,0 5263,1 5287,0 5356,1 5389,0 5395,1 5438,0 5530,1 5593,0 5598,1 5682,0 5741,1 5781,0 5799,1 5832,0 5851,1 5921,0 5933,1 5946,0 5984,1 6063,0 6074,1 6106,0 6113,1 6164,0 6202,1 6239,0 6321,1 6387,0 6463,1 6544,0 6632,1 6635,0 6660,1 6674,0 6739,1 6756,0 6785,1 6873,0 6954,1 7049,0 7109,1 7185,0 7280,1 7363,0 7394,1 7491,0 7567,1 7604,0 7626,1 7629,0 7725,1 7732,0 7748,1 7774,0 7808,1 7835,0 7853,1 7889,0 7939,1 8037,0 8045,1 8096,0 8098,1 8173,0 8215,1 8284,0 8378,1 8425,0 8490,1 8535,0 8591,1 8604,0 8691,1 8779,0 8866,1 8943,0 9021,1 9026,0 9117,1 9172,0 9194,1 9224,0 9245,1 9255,0 9273,1 9304,0 9349,1 9366,0 9438,1 9462,0 9483,1 9529,0 9591,1 9605,0 9620,1 9700,0 9718,1 9814,0 9900,1 9944,0 9999,1 10090,0 10113,1 10194,0 10239,1 10300,0 10362,1 10405,0 10420,1 10453,0 10512,1 10587,0 10675,1 10721,0 10817,1 10825,0 10878,1 10956,0 10992,1 11002,0 11012,1 11104,0 11120,1 11165,0 11257,1 11293,0 11335,1 11429,0 11431,1 11445,0 11533,1 11534,0 11610,1 11707,0 11773,1 11835,0 11901,1 11946,0 12016,1 12116,0 12183,1 12282,0 12293,1 12366,0 12466,1 12493,0 12529,1 12622,0 12640,1 12715,0 12733,1 12803,0 12816,1 12864,0 12919,1 12962,0 13027,1 13029,0 13030,1 13034,0 13054,1 13069,0 13123,1 13209,0 13256,1 13303,0 13342,1 13421,0 13442,1 13536,0 13561,1 13630,0 13659,1 13714,0 13746,1 13807,0 13867,1 13964,0 14015,1 14074,0 14166,1 14167,0 14168,1 14223,0 14274,1 14331,0 14357,1 14439,0 14443,1 14499,0 14566,1 14592,0 14641,1 14657,0 14755,1 14821,0 14906,1 14969,0 15013,1 15097,0 15107,1 15122,0 15139,1 15216,0 15271,1 15307,0 15382,1 15456,0 15497,1 15559,0 15568,1 15664,0 15710,1 15745,0 15812,1 15912,0 15969,1 16026,0 16094,1 16179,0 16198,1 16238,0 16290,1 16320,0 16374,1 16409,0 16479,1 16503,0 16576,1 16676,0 16695,1 16788,0 16809,1 16817,0 16885,1 16895,0 16955,1 17009,0 17019,1 17114,0 17134,1 17234,0 17272,1 17364,0 17446,1 17520,0 17522,1 17600,0 17676,1 17760,0 17860,1 17893,0 17988,1 18076,0 18110,1 18126,0 18149,1 18210,0 18215,1 18230,0 18320,1 18374,0 18393,1 18439,0 18533,1 18587,0 18649,1 18711,0 18804,1 18860,0 18916,1 18962,0 18995,1 19054,0 19074,1 19173,0 19236,1 19332,0 19350,1 19361,0 19427,1 19512,0 19577,1 19632,0 19703,1 19727,0 19738,1 19838,0 19899,1 19946,0 20024,1 20028,0 20077,1 20111,0 20118,1 20148,0 20211,1 20305,0 20313,1 20350,0 20390,1 20407,0 20467,1 20494,0 20505,1 20525,0 20565,1 20572,0 20648,1 20652,0 20694,1 20763,0 20849,1 20881,0 20911,1 21011,0 21081,1 21086,0 21097,1 21146,0 21226,1 21320,0 21365,1 21404,0 21498,1 21548,0 21578,1 21599,0 21607,1 21668,0 21754,1 21799,0 21889,1 21894,0 21950,1 21970,0 22016,1 22075,0 22091,1 22177,0 22251,1 22268,0 22353,1 22370,0 22396,1 22421,0 22509,1 22531,0 22555,1 22629,0 22646,1 22673,0 22721,1 22782,0 22869,1 22884,0 22892,1 22954,0 22972,1 23060,0 23129,1 23130,0 23153,1 23205,0 23239,1 23316,0 23383,1 23411,0 23444,1 23517,0 23599,1 23628,0 23689,1 23731,0 23810,1 23859,0 23884,1 23885,0 23906,1 23961,0 24005,1 24063,0 24119,1 24212,0 24254,1 24321,0 24359,1 24432,0 24513,1 24561,0 24616,1 24644,0 24732,1 24776,0 24829,1 24853,0 24879,1 24926,0 25015,1 25017,0 25059,1 25069,0 25129,1 25192,0 25249,1 25348,0 25351,1 25418,0 25455,1 25481,0 25549,1 25643,0 25740,1 25814,0 25911,1 25918,0 25966,1 25984,0 26006,1 26087,0 26175,1 26207,0 26285,1 26337,0 26341,1 26409,0 26416,1 26439,0 26508,1 26595,0 26619,1 26700,0 26768,1 26831,0 26912,1 26988,0 27088,1 27108,0 27175,1 27230,0 27310,1 27406,0 27455,1 27519,0 27536,1 27619,0 27636,1 27719,0 27796,1 27815,0 27875,1 27934,0 27958,1 27989,0 28046,1 28047,0 28120,1 28129,0 28211,1 28214,0 28295,1 28296,0 28381,1 28411,0 28420,1 28488,0 28586,1 28678,0 28707,1 28805,0 28896,1 28986,0 29015,1 29033,0 29129,1 29130,0 29151,1 29195,0 29268,1 29327,0 29343,1 29369,0 29371,1 29454,0 29509,1 29571,0 29659,1 29685,0 29735,1 29808,0 29857,1 29905,0 29976,1 29999,0 30054,1 30153,0 30178,1 30236,0 30273,1 30342,0 30351,1 30370,0 30405,1 30456,0 30460,1 30468,0 30512,1 30533,0 30607,1 30637,0 30687,1 30700,0 30703,1 30776,0 30800,1 30829,0 30846,1 30913,0 30984,1 31064,0 31152,1 31232,0 31266,1 31284,0 31380,1 31382,0 31403,1 31463,0 31482,1 31516,0 31572,1 31628,0 31659,1 31701,0 31733,1 31802,0 31895,1 31954,0 31976,1 32074,0 32119,1 32149,0 32150,1 32238,0 32277,1 32308,0 32350,1 32354,0 32396,1 32495,0 32508,1 32595,0 32694,1 32713,0 32750,1 32789,0 32828,1 32832,0 32887,1 32964,0 32973,1 33055,0 33087,1 33143,0 33199,1 33257,0 33330,1 33394,0 33463,1 33493,0 33498,1 33522,0 33537,1 33557,0 33632,1 33701,0 33715,1 33779,0 33878,1 33887,0 33912,1 33941,0 34040,1 34063,0 34107,1 34146,0 34176,1 34264,0 34320,1 34413,0 34490,1 34552,0 34565,1 34574,0 34632,1 34687,0 34725,1 34820,0 34904,1 34940,0 34989,1 34997,0 35071,1 35166,0 35247,1 35271,0 35304,1 35374,0 35456,1 35554,0 35626,1 35724,0 35741,1 35747,0 35845,1 35907,0 35976,1 36012,0 36099,1 36136,0 36181,1 36226,0 36285,1 36336,0 36361,1 36394,0 36462,1 36525,0 36608,1 36619,0 36681,1 36720,0 36761,1 36848,0 36878,1 36940,0 36946,1 36975,0 37024,1 37097,0 37134,1 37226,0 37270,1 37328,0 37395,1 37438,0 37477,1 37528,0 37605,1 37699,0 37793,1 37876,0 37970,1 38000,0 38017,1 38082,0 38095,1 38173,0 38244,1 38256,0 38351,1 38377,0 38388,1 38487,0 38520,1 38542,0 38554,1 38569,0 38636,1 38643,0 38647,1 38717,0 38767,1 38795,0 38893,1 38984,0 39060,1 39123,0 39133,1 39167,0 39218,1 39227,0 39323,1 39366,0 39410,1 39441,0 39477,1 39478,0 39573,1 39607,0 39627,1 39698,0 39752,1 39797,0 39815,1 39845,0 39920,1 39921,0 40000,1 40034,0 40087,1 40174,0 40235,1 40299,0 40303,1 40399,0 40475,1 40497,0 40515,1 40573,0 40614,1 40628,0 40629,1 40700,0 40718,1 40746,0 40774,1 40800,0 40893,1 40896,0 40947,1 40965,0 41041,1 41059,0 41139,1 41155,0 41199,1 41284,0 41288,1 41372,0 41466,1 41536,0 41591,1 41611,0 41652,1 41726,0 41808,1 41908,0 41976,1 42074,0 42132,1 42145,0 42245,1 42312,0 42388,1 42421,0 42445,1 42529,0 42559,1 42575,0 42580,1 42643,0 42647,1 42746,0 42766,1 42789,0 42819,1 42904,0 42962,1 42967,0 43016,1 43089,0 43151,1 43244,0 43250,1 43264,0 43327,1 43422,0 43484,1 43542,0 43596,1 43616,0 43658,1 43702,0 43781,1 43863,0 43951,1 43980,0 44034,1 44057,0 44075,1 44084,0 44161,1 44164,0 44199,1 44226,0 44284,1 44380,0 44467,1 44552,0 44618,1 44630,0 44720,1 44764,0 44844,1 44914,0 44937,1 44990,0 44993,1 45052,0 45115,1 45143,0 45224,1 45292,0 45382,1 45390,0 45482,1 45545,0 45554,1 45646,0 45741,1 45841,0 45940,1 45989,0 46068,1 46149,0 46225,1 46251,0 46317,1 46361,0 46429,1 46439,0 46443,1 46528,0 46531,1 46630,0 46673,1 46685,0 46770,1 46847,0 46859,1 46919,0 47015,1 47039,0 47134,1 47185,0 47231,1 47244,0 47301,1 47358,0 47434,1 47441,0 47471,1 47567,0 47614,1 47623,0 47639,1 47727,0 47756,1 47842,0 47876,1 47965,0 48004,1 48048,0 48064,1 48155,0 48200,1 48297,0 48348,1 48398,0 48418,1 48484,0 48528,1 48602,0 48670,1 48725,0 48732,1 48789,0 48840,1 48845,0 48847,1 48886,0 48956,1 49024,0 49049,1 49098,0 49148,1 49170,0 49203,1 49270,0 49339,1 49361,0 49412,1 49509,0 49552,1 49613,0 49711,1 49810,0 49837,1 49936,0 50016,1 50095,0 50127,1 end initlist b48 0,0 67,1 119,0 162,1 248,0 309,1 321,0 349,1 407,0 470,1 508,0 529,1 530,0 612,1 702,0 778,1 810,0 885,1 897,0 909,1 974,0 1012,1 1100,0 1174,1 1200,0 1277,1 1304,0 1347,1 1384,0 1466,1 1522,0 1552,1 1578,0 1611,1 1706,0 1763,1 1787,0 1853,1 1894,0 1919,1 1990,0 2055,1 2130,0 2159,1 2233,0 2294,1 2374,0 2426,1 2525,0 2570,1 2669,0 2673,1 2768,0 2814,1 2834,0 2894,1 2990,0 3075,1 3128,0 3202,1 3250,0 3332,1 3416,0 3428,1 3514,0 3521,1 3528,0 3623,1 3706,0 3736,1 3811,0 3845,1 3878,0 3935,1 4027,0 4123,1 4175,0 4244,1 4310,0 4397,1 4450,0 4455,1 4484,0 4500,1 4574,0 4673,1 4720,0 4723,1 4784,0 4820,1 4902,0 4954,1 5018,0 5019,1 5107,0 5194,1 5236,0 5246,1 5326,0 5399,1 5406,0 5430,1 5508,0 5559,1 5597,0 5694,1 5745,0 5764,1 5767,0 5821,1 5873,0 5921,1 5952,0 6002,1 6083,0 6142,1 6213,0 6290,1 6346,0 6373,1 6383,0 6483,1 6502,0 6542,1 6607,0 6639,1 6643,0 6647,1 6736,0 6818,1 6826,0 6862,1 6873,0 6963,1 6966,0 6975,1 7058,0 7067,1 7141,0 7181,1 7232,0 7268,1 7331,0 7411,1 7427,0 7441,1 7463,0 7468,1 7518,0 7604,1 7680,0 7750,1 7820,0 7896,1 7996,0 8027,1 8114,0 8183,1 8263,0 8333,1 8337,0 8363,1 8412,0 8487,1 8538,0 8575,1 8589,0 8676,1 8726,0 8732,1 8786,0 8877,1 8976,0 9060,1 9126,0 9209,1 9276,0 9282,1 9380,0 9413,1 9502,0 9513,1 9595,0 9630,1 9637,0 9722,1 9807,0 9878,1 9973,0 9989,1 10025,0 10112,1 10119,0 10218,1 10260,0 10336,1 10337,0 10357,1 10434,0 10491,1 10523,0 10539,1 10570,0 10628,1 10692,0 10735,1 10813,0 10888,1 10917,0 10938,1 11033,0 11097,1 11127,0 11207,1 11298,0 11393,1 11395,0 11400,1 11443,0 11468,1 11565,0 11653,1 11680,0 11701,1 11723,0 11730,1 11775,0 11869,1 11960,0 12006,1 12078,0 12099,1 12176,0 12264,1 12272,0 12282,1 12365,0 12417,1 12420,0 12441,1 12499,0 12579,1 12635,0 12657,1 12667,0 12749,1 12847,0 12864,1 12935,0 13030,1 13125,0 13161,1 13209,0 13229,1 13291,0 13322,1 13407,0 13467,1 13495,0 13563,1 13599,0 13672,1 13746,0 13823,1 13916,0 14014,1 14040,0 14089,1 14117,0 14128,1 14173,0 14213,1 14232,0 14287,1 14364,0 14443,1 14452,0 14454,1 14466,0 14507,1 14571,0 14632,1 14682,0 14710,1 14808,0 14854,1 14889,0 14927,1 14973,0 14986,1 15073,0 15124,1 15155,0 15191,1 15243,0 15321,1 15376,0 15407,1 15484,0 15508,1 15605,0 15652,1 15714,0 15795,1 15804,0 15808,1 15846,0 15867,1 15959,0 15963,1 15997,0 16075,1 16174,0 16178,1 16275,0 16370,1 16397,0 16408,1 16414,0 16468,1 16492,0 16567,1 16580,0 16665,1 16702,0 16757,1 16793,0 16817,1 16895,0 16965,1 17053,0 17119,1 17128,0 17143,1 17238,0 17322,1 17377,0 17378,1 17410,0 17414,1 17482,0 17510,1 17538,0 17595,1 17678,0 17696,1 17791,0 17829,1 17853,0 17890,1 17984,0 18032,1 18085,0 18095,1 18176,0 18270,1 18302,0 18382,1 18390,0 18430,1 18530,0 18583,1 18612,0 18703,1 18779,0 18786,1 18818,0 18915,1 18938,0 19016,1 19037,0 19072,1 19104,0 19148,1 19184,0 19282,1 19352,0 19418,1 19432,0 19529,1 19584,0 19608,1 19630,0 19702,1 19782,0 19874,1 19971,0 19990,1 20049,0 20068,1 20123,0 20215,1 20238,0 20280,1 20377,0 20390,1 20474,0 20573,1 20626,0 20714,1 20727,0 20782,1 20870,0 20904,1 20942,0 20957,1 21047,0 21083,1 21177,0 21186,1 21260,0 21280,1 21354,0 21366,1 21440,0 21460,1 21521,0 21586,1 21646,0 21710,1 21739,0 21836,1 21885,0 21974,1 22032,0 22092,1 22118,0 22155,1 22195,0 22289,1 22290,0 22297,1 22366,0 22458,1 22480,0 22508,1 22549,0 22564,1 22632,0 22692,1 22741,0 22749,1 22789,0 22814,1 22837,0 22906,1 22909,0 22970,1 23065,0 23115,1 23202,0 23206,1 23233,0 23332,1 23419,0 23439,1 23484,0 23522,1 23598,0 23655,1 23698,0 23715,1 23765,0 23814,1 23872,0 23888,1 23981,0 23999,1 24082,0 24143,1 24180,0 24191,1 24236,0 24318,1 24328,0 24338,1 24414,0 24463,1 24512,0 24600,1 24669,0 24729,1 24775,0 24855,1 24928,0 24973,1 25036,0 25116,1 25180,0 25211,1 25251,0 25281,1 25293,0 25390,1 25472,0 25533,1 25614,0 25694,1 25759,0 25849,1 25888,0 25985,1 26035,0 26133,1 26139,0 26183,1 26243,0 26293,1 26360,0 26428,1 26443,0 26495,1 26537,0 26598,1 26661,0 26732,1 26815,0 26870,1 26962,0 26991,1 27012,0 27055,1 27085,0 27153,1 27183,0 27186,1 27255,0 27310,1 27358,0 27453,1 27548,0 27636,1 27646,0 27736,1 27768,0 27833,1 27875,0 27955,1 28042,0 28079,1 28150,0 28205,1 28251,0 28261,1 28285,0 28324,1 28356,0 28409,1 28500,0 28534,1 28605,0 28643,1 28681,0 28706,1 28798,0 28887,1 28950,0 29017,1 29084,0 29145,1 29223,0 29314,1 29387,0 29421,1 29499,0 29581,1 29592,0 29670,1 29738,0 29756,1 29855,0 29872,1 29937,0 29954,1 30017,0 30068,1 30077,0 30094,1 30181,0 30203,1 30268,0 30323,1 30417,0 30493,1 30589,0 30664,1 30753,0 30845,1 30932,0 30994,1 31002,0 31088,1 31159,0 31213,1 31259,0 31275,1 31277,0 31332,1 31373,0 31444,1 31544,0 31582,1 31593,0 31658,1 31691,0 31777,1 31791,0 31838,1 31842,0 31916,1 32014,0 32037,1 32121,0 32183,1 32282,0 32358,1 32360,0 32377,1 32393,0 32397,1 32479,0 32545,1 32554,0 32573,1 32578,0 32668,1 32754,0 32765,1 32852,0 32896,1 32969,0 33069,1 33158,0 33225,1 33313,0 33369,1 33435,0 33507,1 33575,0 33651,1 33748,0 33768,1 33786,0 33815,1 33829,0 33899,1 33972,0 34014,1 34019,0 34100,1 34189,0 34223,1 34268,0 34351,1 34425,0 34459,1 34559,0 34626,1 34663,0 34756,1 34836,0 34909,1 34928,0 34989,1 35026,0 35042,1 35133,0 35207,1 35305,0 35404,1 35431,0 35499,1 35536,0 35599,1 35648,0 35674,1 35714,0 35797,1 35881,0 35923,1 35947,0 36004,1 36058,0 36059,1 36127,0 36176,1 36199,0 36245,1 36255,0 36338,1 36345,0 36404,1 36452,0 36485,1 36542,0 36564,1 36616,0 36625,1 36692,0 36709,1 36746,0 36801,1 36885,0 36914,1 36959,0 36999,1 37067,0 37126,1 37225,0 37233,1 37309,0 37346,1 37383,0 37442,1 37519,0 37599,1 37626,0 37715,1 37814,0 37870,1 37950,0 37959,1 38007,0 38051,1 38135,0 38218,1 38254,0 38264,1 38347,0 38395,1 38445,0 38492,1 38525,0 38544,1 38545,0 38627,1 38665,0 38707,1 38778,0 38854,1 38926,0 39018,1 39111,0 39202,1 39283,0 39337,1 39399,0 39410,1 39459,0 39527,1 39542,0 39603,1 39638,0 39704,1 39771,0 39838,1 39928,0 40025,1 40042,0 40056,1 40148,0 40213,1 40215,0 40242,1 40283,0 40380,1 40409,0 40498,1 40584,0 40677,1 40749,0 40778,1 40849,0 40905,1 40962,0 40994,1 41002,0 41007,1 41041,0 41075,1 41153,0 41246,1 41323,0 41368,1 41399,0 41466,1 41500,0 41550,1 41637,0 41664,1 41682,0 41734,1 41746,0 41769,1 41828,0 41831,1 41852,0 41895,1 41941,0 42033,1 42109,0 42141,1 42165,0 42248,1 42336,0 42378,1 42458,0 42537,1 42592,0 42674,1 42733,0 42812,1 42839,0 42840,1 42878,0 42910,1 42946,0 43046,1 43065,0 43139,1 43150,0 43174,1 43269,0 43306,1 43346,0 43440,1 43470,0 43549,1 43583,0 43674,1 43721,0 43749,1 43769,0 43817,1 43909,0 43985,1 44026,0 44090,1 44128,0 44151,1 44222,0 44305,1 44335,0 44421,1 44445,0 44446,1 44484,0 44514,1 44596,0 44673,1 44699,0 44710,1 44736,0 44796,1 44815,0 44837,1 44846,0 44933,1 45024,0 45060,1 45133,0 45194,1 45232,0 45305,1 45364,0 45374,1 45424,0 45512,1 45591,0 45670,1 45730,0 45814,1 45865,0 45885,1 45971,0 46059,1 46104,0 46112,1 46183,0 46214,1 46248,0 46260,1 46316,0 46402,1 46428,0 46444,1 46446,0 46486,1 46489,0 46548,1 46582,0 46621,1 46712,0 46796,1 46890,0 46942,1 46959,0 47018,1 47054,0 47114,1 47198,0 47242,1 47342,0 47351,1 47390,0 47413,1 47513,0 47518,1 47567,0 47588,1 47623,0 47624,1 47658,0 47743,1 47808,0 47833,1 47894,0 47972,1 47984,0 48002,1 48053,0 48122,1 48134,0 48226,1 48292,0 48294,1 48310,0 48391,1 48441,0 48536,1 48549,0 48576,1 48610,0 48620,1 48629,0 48683,1 48716,0 48722,1 48820,0 48839,1 48922,0 48928,1 48947,0 48973,1 49049,0 49066,1 49121,0 49142,1 49181,0 49262,1 49294,0 49387,1 49446,0 49465,1 49503,0 49584,1 49642,0 49725,1 49773,0 49846,1 49889,0 49908,1 49918,0 50009,1 50074,0 50168,1 50263,0 50265,1 50313,0 50357,1 50406,0 50458,1 50465,0 50474,1 50536,0 50591,1 50626,0 50664,1 50719,0 50814,1 50876,0 50955,1 50970,0 51064,1 51087,0 51122,1 51204,0 51268,1 51275,0 51286,1 51289,0 51370,1 51376,0 51452,1 51509,0 51528,1 51613,0 51701,1 51790,0 51863,1 51962,0 51985,1 end initlist b49 0,0 81,1 105,0 182,1 262,0 311,1 400,0 439,1 509,0 551,1 626,0 664,1 719,0 803,1 837,0 918,1 960,0 984,1 1032,0 1057,1 1152,0 1194,1 1292,0 1306,1 1351,0 1446,1 1522,0 1619,1 1670,0 1756,1 1817,0 1848,1 1944,0 2020,1 2041,0 2092,1 2125,0 2217,1 2291,0 2385,1 2478,0 2523,1 2585,0 2603,1 2651,0 2678,1 2745,0 2793,1 2862,0 2958,1 2974,0 2995,1 3041,0 3099,1 3100,0 3146,1 3192,0 3287,1 3367,0 3435,1 3465,0 3467,1 3531,0 3600,1 3609,0 3696,1 3729,0 3788,1 3795,0 3831,1 3866,0 3914,1 3953,0 4043,1 4066,0 4086,1 4128,0 4156,1 4205,0 4290,1 4340,0 4426,1 4463,0 4490,1 4572,0 4598,1 4647,0 4717,1 4796,0 4836,1 4933,0 4946,1 5015,0 5022,1 5072,0 5096,1 5133,0 5162,1 5170,0 5257,1 5325,0 5375,1 5394,0 5406,1 5462,0 5496,1 5559,0 5630,1 5686,0 5691,1 5757,0 5810,1 5878,0 5915,1 5945,0 6004,1 6101,0 6146,1 6163,0 6194,1 6273,0 6293,1 6351,0 6368,1 6418,0 6482,1 6485,0 6490,1 6579,0 6582,1 6662,0 6692,1 6704,0 6753,1 6833,0 6851,1 6858,0 6891,1 6922,0 6958,1 7052,0 7134,1 7206,0 7211,1 7289,0 7383,1 7391,0 7461,1 7514,0 7567,1 7569,0 7647,1 7666,0 7757,1 7769,0 7843,1 7859,0 7913,1 7931,0 8028,1 8052,0 8134,1 8135,0 8194,1 8205,0 8303,1 8363,0 8400,1 8442,0 8444,1 8450,0 8523,1 8526,0 8583,1 8673,0 8728,1 8807,0 8868,1 8945,0 8987,1 9029,0 9062,1 9113,0 9203,1 9219,0 9263,1 9363,0 9439,1 9467,0 9472,1 9540,0 9587,1 9622,0 9661,1 9719,0 9772,1 9822,0 9872,1 9902,0 9931,1 10026,0 10037,1 10043,0 10106,1 10201,0 10221,1 10237,0 10328,1 10397,0 10492,1 10509,0 10586,1 10656,0 10744,1 10806,0 10862,1 10944,0 10985,1 11062,0 11159,1 11164,0 11263,1 11278,0 11285,1 11326,0 11362,1 11455,0 11506,1 11527,0 11584,1 11603,0 11656,1 11719,0 11786,1 11872,0 11947,1 12014,0 12072,1 12172,0 12239,1 12284,0 12294,1 12310,0 12328,1 12339,0 12355,1 12364,0 12411,1 12500,0 12558,1 12596,0 12640,1 12737,0 12833,1 12842,0 12932,1 12984,0 13030,1 13129,0 13198,1 13202,0 13228,1 13323,0 13341,1 13351,0 13388,1 13448,0 13451,1 13539,0 13546,1 13566,0 13598,1 13685,0 13716,1 13798,0 13867,1 13951,0 13995,1 14041,0 14072,1 14148,0 14247,1 14248,0 14251,1 14293,0 14318,1 14336,0 14417,1 14457,0 14506,1 14534,0 14560,1 14652,0 14696,1 14743,0 14826,1 14870,0 14930,1 14939,0 14973,1 15064,0 15162,1 15195,0 15236,1 15322,0 15362,1 15378,0 15431,1 15525,0 15591,1 15619,0 15714,1 15776,0 15792,1 15891,0 15930,1 15986,0 16086,1 16132,0 16199,1 16281,0 16332,1 16407,0 16453,1 16474,0 16516,1 16533,0 16535,1 16560,0 16651,1 16661,0 16761,1 16780,0 16831,1 16859,0 16863,1 16922,0 17008,1 17068,0 17129,1 17229,0 17271,1 17281,0 17289,1 17301,0 17396,1 17414,0 17416,1 17420,0 17515,1 17606,0 17622,1 17636,0 17720,1 17785,0 17857,1 17895,0 17935,1 17958,0 17981,1 18034,0 18072,1 18127,0 18175,1 18264,0 18316,1 18359,0 18380,1 18382,0 18463,1 18466,0 18509,1 18564,0 18663,1 18728,0 18809,1 18909,0 18963,1 19012,0 19099,1 19107,0 19156,1 19241,0 19314,1 19360,0 19385,1 19412,0 19455,1 19520,0 19539,1 19580,0 19601,1 19675,0 19712,1 19804,0 19899,1 19903,0 19993,1 20087,0 20133,1 20171,0 20230,1 20294,0 20382,1 20439,0 20534,1 20619,0 20697,1 20728,0 20731,1 20820,0 20913,1 20951,0 20984,1 21055,0 21068,1 21165,0 21258,1 21325,0 21417,1 21432,0 21515,1 21592,0 21692,1 21762,0 21773,1 21827,0 21840,1 21920,0 21993,1 22056,0 22095,1 22193,0 22217,1 22249,0 22299,1 22384,0 22463,1 22557,0 22576,1 22636,0 22656,1 22707,0 22747,1 22775,0 22816,1 22885,0 22889,1 22983,0 23056,1 23077,0 23083,1 23176,0 23218,1 23313,0 23325,1 23401,0 23469,1 23477,0 23566,1 23594,0 23691,1 23694,0 23749,1 23845,0 23903,1 23994,0 24051,1 24093,0 24114,1 24161,0 24200,1 24264,0 24351,1 24379,0 24470,1 24560,0 24605,1 24680,0 24711,1 24792,0 24806,1 24827,0 24833,1 24891,0 24975,1 25014,0 25071,1 25141,0 25235,1 25331,0 25343,1 25386,0 25396,1 25492,0 25507,1 25548,0 25573,1 25659,0 25727,1 25803,0 25839,1 25880,0 25911,1 25926,0 25965,1 26022,0 26040,1 26087,0 26158,1 26204,0 26229,1 26326,0 26375,1 26400,0 26487,1 26550,0 26631,1 26636,0 26735,1 26826,0 26898,1 26992,0 27039,1 27099,0 27111,1 27141,0 27153,1 27192,0 27215,1 27303,0 27322,1 27345,0 27421,1 27431,0 27483,1 27493,0 27571,1 27621,0 27704,1 27760,0 27810,1 27839,0 27901,1 27966,0 28065,1 28140,0 28224,1 28278,0 28345,1 28358,0 28415,1 28453,0 28549,1 28612,0 28635,1 28638,0 28695,1 28725,0 28728,1 28762,0 28805,1 28901,0 28908,1 28924,0 28940,1 28978,0 28990,1 29083,0 29182,1 29198,0 29266,1 29333,0 29410,1 29475,0 29536,1 29586,0 29680,1 29691,0 29779,1 29839,0 29894,1 29922,0 29940,1 30028,0 30053,1 30070,0 30086,1 30092,0 30190,1 30201,0 30233,1 30276,0 30347,1 30381,0 30451,1 30466,0 30480,1 30526,0 30544,1 30586,0 30661,1 30711,0 30716,1 30772,0 30822,1 30857,0 30902,1 30927,0 30998,1 31007,0 31107,1 31135,0 31170,1 31248,0 31268,1 31270,0 31287,1 31372,0 31420,1 31454,0 31475,1 31552,0 31597,1 31619,0 31715,1 31805,0 31811,1 31825,0 31880,1 31884,0 31900,1 31945,0 32008,1 32026,0 32090,1 32091,0 32111,1 32208,0 32225,1 32235,0 32238,1 32324,0 32352,1 32406,0 32408,1 32427,0 32488,1 32535,0 32546,1 32636,0 32710,1 32779,0 32807,1 32855,0 32888,1 32915,0 32981,1 33030,0 33109,1 33168,0 33242,1 33262,0 33337,1 33377,0 33443,1 33445,0 33489,1 33526,0 33541,1 33588,0 33676,1 33690,0 33785,1 33806,0 33824,1 33888,0 33954,1 33961,0 34039,1 34040,0 34125,1 34145,0 34228,1 34324,0 34338,1 34374,0 34435,1 34451,0 34496,1 34562,0 34635,1 34682,0 34754,1 34801,0 34875,1 34918,0 34926,1 34977,0 34993,1 35031,0 35112,1 35192,0 35211,1 35265,0 35279,1 35325,0 35365,1 35444,0 35535,1 35545,0 35592,1 35677,0 35741,1 35760,0 35860,1 35913,0 35998,1 36035,0 36072,1 36108,0 36126,1 36158,0 36192,1 36229,0 36319,1 36387,0 36417,1 36461,0 36539,1 36622,0 36691,1 36789,0 36884,1 36964,0 36988,1 37067,0 37152,1 37200,0 37294,1 37338,0 37361,1 37383,0 37441,1 37509,0 37516,1 37581,0 37674,1 37763,0 37837,1 37923,0 37980,1 38031,0 38034,1 38120,0 38167,1 38202,0 38300,1 38400,0 38429,1 38522,0 38603,1 38696,0 38708,1 38736,0 38827,1 38921,0 39000,1 39063,0 39086,1 39137,0 39222,1 39256,0 39299,1 39326,0 39340,1 39345,0 39381,1 39453,0 39528,1 39605,0 39705,1 39723,0 39818,1 39880,0 39883,1 39899,0 39917,1 39922,0 39948,1 40028,0 40033,1 40072,0 40125,1 40149,0 40229,1 40274,0 40337,1 40386,0 40479,1 40490,0 40520,1 40522,0 40530,1 40549,0 40551,1 40613,0 40706,1 40750,0 40802,1 40884,0 40910,1 40948,0 40962,1 41059,0 41125,1 41185,0 41255,1 41258,0 41341,1 41379,0 41398,1 41466,0 41471,1 41552,0 41644,1 41669,0 41757,1 41854,0 41933,1 41984,0 42075,1 42105,0 42130,1 42163,0 42165,1 42181,0 42273,1 42298,0 42343,1 42412,0 42501,1 42574,0 42672,1 42694,0 42699,1 42750,0 42784,1 42862,0 42870,1 42929,0 42942,1 42999,0 43033,1 43058,0 43078,1 43135,0 43181,1 43269,0 43361,1 43423,0 43496,1 43516,0 43565,1 43579,0 43626,1 43666,0 43687,1 43782,0 43876,1 43963,0 44014,1 44026,0 44082,1 44143,0 44188,1 44287,0 44370,1 44442,0 44443,1 44519,0 44608,1 44613,0 44680,1 44758,0 44809,1 44826,0 44918,1 44963,0 44986,1 45053,0 45063,1 45151,0 45198,1 45215,0 45262,1 45357,0 45435,1 45458,0 45530,1 45601,0 45661,1 45710,0 45719,1 45818,0 45834,1 45854,0 45891,1 45895,0 45914,1 45937,0 45967,1 45979,0 45983,1 46030,0 46050,1 46057,0 46099,1 46189,0 46279,1 46289,0 46340,1 46408,0 46442,1 46457,0 46509,1 46607,0 46689,1 46694,0 46749,1 46802,0 46862,1 46916,0 46994,1 47093,0 47187,1 47253,0 47306,1 47402,0 47494,1 47588,0 47658,1 47669,0 47719,1 47782,0 47814,1 47902,0 47955,1 48045,0 48083,1 48156,0 48218,1 48278,0 48342,1 48382,0 48383,1 48407,0 48483,1 48546,0 48625,1 48631,0 48723,1 48725,0 48739,1 48818,0 48880,1 48900,0 48934,1 48939,0 49020,1 49052,0 49053,1 49116,0 49169,1 49239,0 49246,1 49274,0 49315,1 49351,0 49362,1 49363,0 49427,1 49476,0 49530,1 49575,0 49620,1 49634,0 49709,1 49787,0 49801,1 49835,0 49914,1 49947,0 50032,1 50117,0 50133,1 50229,0 50265,1 50357,0 50421,1 50512,0 50543,1 end initlist b50 0,0 95,1 163,0 227,1 242,0 243,1 324,0 393,1 400,0 455,1 480,0 571,1 643,0 698,1 706,0 770,1 848,0 906,1 977,0 1070,1 1116,0 1144,1 1168,0 1268,1 1313,0 1397,1 1401,0 1451,1 1486,0 1534,1 1633,0 1661,1 1749,0 1764,1 1800,0 1888,1 1929,0 1960,1 2021,0 2070,1 2139,0 2146,1 2152,0 2208,1 2243,0 2296,1 2320,0 2345,1 2416,0 2496,1 2582,0 2669,1 2763,0 2821,1 2826,0 2850,1 2949,0 3020,1 3104,0 3108,1 3207,0 3232,1 3317,0 3396,1 3405,0 3418,1 3460,0 3515,1 3576,0 3603,1 3683,0 3783,1 3877,0 3913,1 4001,0 4084,1 4129,0 4157,1 4164,0 4264,1 4348,0 4386,1 4476,0 4544,1 4633,0 4655,1 4677,0 4689,1 4712,0 4729,1 4746,0 4809,1 4901,0 4968,1 5028,0 5047,1 5123,0 5181,1 5227,0 5286,1 5386,0 5410,1 5418,0 5510,1 5597,0 5647,1 5715,0 5729,1 5799,0 5852,1 5919,0 5958,1 5987,0 5992,1 6001,0 6009,1 6025,0 6061,1 6062,0 6119,1 6166,0 6169,1 6182,0 6219,1 6227,0 6249,1 6252,0 6318,1 6365,0 6369,1 6460,0 6485,1 6504,0 6520,1 6532,0 6559,1 6561,0 6598,1 6673,0 6747,1 6764,0 6850,1 6863,0 6944,1 7016,0 7056,1 7131,0 7172,1 7239,0 7280,1 7306,0 7318,1 7404,0 7415,1 7513,0 7524,1 7525,0 7620,1 7710,0 7749,1 7783,0 7837,1 7879,0 7899,1 7908,0 7960,1 8019,0 8055,1 8064,0 8144,1 8180,0 8212,1 8263,0 8299,1 8399,0 8423,1 8429,0 8439,1 8504,0 8554,1 8632,0 8689,1 8710,0 8769,1 8815,0 8838,1 8929,0 8976,1 8984,0 9078,1 9116,0 9209,1 9285,0 9293,1 9347,0 9423,1 9487,0 9488,1 9494,0 9503,1 9555,0 9567,1 9654,0 9677,1 9696,0 9751,1 9816,0 9902,1 9938,0 9964,1 9971,0 10059,1 10129,0 10146,1 10197,0 10259,1 10315,0 10410,1 10464,0 10554,1 10644,0 10670,1 10723,0 10805,1 10852,0 10891,1 10904,0 10974,1 10992,0 11016,1 11032,0 11045,1 11110,0 11175,1 11242,0 11335,1 11370,0 11470,1 11490,0 11520,1 11542,0 11566,1 11647,0 11728,1 11797,0 11836,1 11916,0 11939,1 12016,0 12056,1 12107,0 12127,1 12194,0 12287,1 12355,0 12449,1 12500,0 12552,1 12569,0 12581,1 12636,0 12644,1 12712,0 12765,1 12851,0 12911,1 12970,0 12988,1 13058,0 13083,1 13115,0 13194,1 13234,0 13288,1 13361,0 13421,1 13464,0 13550,1 13587,0 13589,1 13621,0 13712,1 13788,0 13882,1 13956,0 13991,1 14086,0 14110,1 14170,0 14238,1 14260,0 14348,1 14429,0 14441,1 14538,0 14558,1 14577,0 14667,1 14683,0 14722,1 14815,0 14855,1 14913,0 15009,1 15015,0 15047,1 15089,0 15173,1 15176,0 15237,1 15279,0 15339,1 15356,0 15423,1 15523,0 15565,1 15576,0 15653,1 15695,0 15704,1 15736,0 15825,1 15851,0 15872,1 15950,0 16023,1 16040,0 16123,1 16126,0 16174,1 16214,0 16287,1 16316,0 16317,1 16390,0 16442,1 16447,0 16532,1 16561,0 16652,1 16688,0 16774,1 16818,0 16873,1 16904,0 16925,1 17003,0 17054,1 17064,0 17081,1 17152,0 17155,1 17230,0 17232,1 17261,0 17335,1 17346,0 17371,1 17455,0 17518,1 17538,0 17579,1 17615,0 17651,1 17717,0 17786,1 17836,0 17895,1 17989,0 18047,1 18122,0 18156,1 18243,0 18266,1 18283,0 18349,1 18439,0 18531,1 18609,0 18705,1 18802,0 18821,1 18827,0 18847,1 18940,0 18989,1 19009,0 19091,1 19110,0 19189,1 19231,0 19284,1 19300,0 19356,1 19372,0 19420,1 19489,0 19580,1 19609,0 19702,1 19716,0 19742,1 19834,0 19880,1 19962,0 20038,1 20104,0 20169,1 20223,0 20258,1 20329,0 20403,1 20480,0 20531,1 20615,0 20625,1 20695,0 20730,1 20770,0 20790,1 20853,0 20866,1 20965,0 20986,1 21050,0 21062,1 21160,0 21212,1 21265,0 21326,1 21370,0 21450,1 21506,0 21563,1 21605,0 21701,1 21705,0 21735,1 21829,0 21851,1 21895,0 21959,1 21998,0 22070,1 22072,0 22096,1 22160,0 22171,1 22219,0 22240,1 22326,0 22425,1 22480,0 22504,1 22599,0 22662,1 22696,0 22750,1 22786,0 22788,1 22855,0 22857,1 22893,0 22970,1 23027,0 23115,1 23172,0 23246,1 23342,0 23424,1 23500,0 23556,1 23628,0 23691,1 23742,0 23784,1 23861,0 23942,1 24004,0 24025,1 24061,0 24093,1 24168,0 24173,1 24215,0 24308,1 24406,0 24440,1 24442,0 24488,1 24537,0 24614,1 24636,0 24653,1 24677,0 24683,1 24725,0 24771,1 24849,0 24905,1 24937,0 25036,1 25132,0 25147,1 25202,0 25217,1 25271,0 25284,1 25323,0 25403,1 25464,0 25524,1 25534,0 25597,1 25648,0 25706,1 25782,0 25789,1 25883,0 25907,1 25981,0 26077,1 26162,0 26225,1 26262,0 26338,1 26402,0 26493,1 26583,0 26663,1 26698,0 26704,1 26707,0 26777,1 26870,0 26882,1 26928,0 27025,1 27050,0 27055,1 27125,0 27157,1 27201,0 27246,1 27297,0 27397,1 27464,0 27482,1 27516,0 27517,1 27616,0 27638,1 27688,0 27776,1 27858,0 27910,1 27950,0 28010,1 28071,0 28118,1 28176,0 28226,1 28265,0 28331,1 28409,0 28501,1 28563,0 28644,1 28695,0 28791,1 28838,0 28920,1 29018,0 29051,1 29143,0 29194,1 29264,0 29296,1 29383,0 29392,1 29420,0 29466,1 29532,0 29557,1 29649,0 29691,1 29755,0 29779,1 29848,0 29893,1 29973,0 30044,1 30063,0 30079,1 30101,0 30165,1 30249,0 30288,1 30362,0 30453,1 30515,0 30604,1 30652,0 30662,1 30682,0 30728,1 30739,0 30834,1 30904,0 30988,1 31071,0 31168,1 31230,0 31299,1 31324,0 31349,1 31392,0 31468,1 31503,0 31535,1 31575,0 31625,1 31718,0 31801,1 31866,0 31949,1 32031,0 32057,1 32102,0 32176,1 32223,0 32305,1 32375,0 32420,1 32470,0 32522,1 32537,0 32620,1 32652,0 32656,1 32658,0 32698,1 32742,0 32815,1 32898,0 32912,1 32916,0 32961,1 33005,0 33012,1 33019,0 33091,1 33100,0 33110,1 33150,0 33224,1 33240,0 33296,1 33382,0 33482,1 33540,0 33583,1 33613,0 33671,1 33771,0 33858,1 33955,0 34016,1 34097,0 34136,1 34161,0 34255,1 34301,0 34386,1 34461,0 34465,1 34537,0 34566,1 34652,0 34715,1 34719,0 34765,1 34787,0 34857,1 34860,0 34887,1 34909,0 35005,1 35008,0 35052,1 35119,0 35201,1 35219,0 35220,1 35272,0 35372,1 35403,0 35483,1 35565,0 35588,1 35649,0 35662,1 35758,0 35804,1 35899,0 35936,1 35951,0 36028,1 36064,0 36071,1 36126,0 36200,1 36268,0 36301,1 36318,0 36351,1 36400,0 36443,1 36445,0 36514,1 36567,0 36638,1 36724,0 36785,1 36864,0 36900,1 36971,0 37011,1 37034,0 37115,1 37175,0 37266,1 37361,0 37454,1 37552,0 37645,1 37712,0 37714,1 37759,0 37778,1 37814,0 37852,1 37922,0 37958,1 37996,0 38065,1 38141,0 38173,1 38240,0 38322,1 38367,0 38391,1 38433,0 38477,1 38563,0 38617,1 38693,0 38713,1 38799,0 38854,1 38895,0 38906,1 38964,0 39030,1 39089,0 39120,1 39141,0 39235,1 39244,0 39260,1 39274,0 39283,1 39303,0 39332,1 39361,0 39430,1 39522,0 39607,1 39635,0 39679,1 39738,0 39762,1 39826,0 39884,1 39948,0 39974,1 39985,0 40061,1 40125,0 40171,1 40240,0 40256,1 40345,0 40432,1 40494,0 40568,1 40596,0 40662,1 40757,0 40783,1 40816,0 40823,1 40871,0 40930,1 41017,0 41046,1 41114,0 41143,1 41198,0 41209,1 41238,0 41265,1 41331,0 41377,1 41380,0 41422,1 41477,0 41535,1 41552,0 41638,1 41672,0 41681,1 41718,0 41778,1 41801,0 41885,1 41904,0 41993,1 42021,0 42071,1 42147,0 42213,1 42265,0 42313,1 42403,0 42503,1 42559,0 42573,1 42611,0 42642,1 42712,0 42789,1 42883,0 42935,1 42960,0 43050,1 43078,0 43098,1 43133,0 43229,1 43275,0 43349,1 43390,0 43455,1 43510,0 43532,1 43626,0 43676,1 43776,0 43826,1 43843,0 43868,1 43915,0 43998,1 44038,0 44071,1 44082,0 44106,1 44180,0 44271,1 44296,0 44355,1 44373,0 44391,1 44401,0 44472,1 44557,0 44564,1 44622,0 44694,1 44709,0 44806,1 44906,0 44929,1 44934,0 44967,1 45049,0 45133,1 45195,0 45244,1 45332,0 45358,1 45403,0 45489,1 45581,0 45604,1 45695,0 45730,1 45790,0 45825,1 45844,0 45900,1 45953,0 45963,1 46003,0 46017,1 46018,0 46057,1 46086,0 46105,1 46197,0 46270,1 46281,0 46287,1 46351,0 46367,1 46396,0 46472,1 46507,0 46594,1 46631,0 46700,1 46719,0 46797,1 46850,0 46861,1 46959,0 46967,1 46973,0 47069,1 47151,0 47215,1 47261,0 47330,1 47343,0 47382,1 47391,0 47417,1 47489,0 47562,1 47613,0 47672,1 47767,0 47774,1 47799,0 47810,1 47852,0 47864,1 47952,0 47980,1 47993,0 48048,1 48140,0 48185,1 48239,0 48299,1 48340,0 48416,1 48437,0 48462,1 48539,0 48633,1 48703,0 48785,1 48817,0 48900,1 48994,0 49023,1 49028,0 49098,1 49103,0 49170,1 49214,0 49248,1 49310,0 49387,1 49423,0 49512,1 49551,0 49617,1 49651,0 49746,1 49775,0 49865,1 49874,0 49929,1 49931,0 49953,1 50037,0 50062,1 50141,0 50167,1 50173,0 50214,1 50312,0 50393,1 50450,0 50542,1 50570,0 50636,1 50668,0 50760,1 end initlist b51 0,0 38,1 81,0 121,1 182,0 232,1 307,0 367,1 382,0 429,1 456,0 535,1 542,0 639,1 715,0 805,1 828,0 902,1 960,0 975,1 1011,0 1030,1 1053,0 1058,1 1121,0 1197,1 1250,0 1339,1 1377,0 1416,1 1455,0 1502,1 1581,0 1674,1 1728,0 1786,1 1817,0 1907,1 1953,0 1968,1 2044,0 2133,1 2207,0 2288,1 2330,0 2372,1 2420,0 2426,1 2432,0 2522,1 2569,0 2615,1 2654,0 2754,1 2846,0 2893,1 2901,0 2988,1 3028,0 3029,1 3054,0 3067,1 3107,0 3136,1 3197,0 3279,1 3309,0 3320,1 3357,0 3416,1 3428,0 3478,1 3516,0 3580,1 3605,0 3620,1 3717,0 3769,1 3846,0 3854,1 3935,0 3945,1 3988,0 4062,1 4091,0 4146,1 4215,0 4308,1 4342,0 4397,1 4478,0 4574,1 4575,0 4636,1 4734,0 4789,1 4853,0 4925,1 4996,0 5013,1 5051,0 5092,1 5184,0 5282,1 5296,0 5338,1 5431,0 5488,1 5526,0 5582,1 5602,0 5676,1 5690,0 5716,1 5772,0 5784,1 5815,0 5886,1 5950,0 6010,1 6037,0 6123,1 6144,0 6210,1 6255,0 6265,1 6267,0 6293,1 6338,0 6362,1 6444,0 6514,1 6603,0 6641,1 6715,0 6787,1 6885,0 6955,1 6970,0 7003,1 7097,0 7148,1 7230,0 7254,1 7290,0 7368,1 7451,0 7455,1 7519,0 7561,1 7616,0 7701,1 7706,0 7749,1 7782,0 7828,1 7851,0 7939,1 8009,0 8098,1 8178,0 8261,1 8324,0 8331,1 8425,0 8506,1 8601,0 8695,1 8789,0 8812,1 8829,0 8923,1 8949,0 8993,1 9038,0 9106,1 9198,0 9222,1 9259,0 9335,1 9384,0 9431,1 9438,0 9451,1 9491,0 9583,1 9671,0 9689,1 9734,0 9764,1 9862,0 9872,1 9908,0 9965,1 9996,0 10048,1 10088,0 10169,1 10234,0 10309,1 10314,0 10384,1 10450,0 10508,1 10555,0 10609,1 10619,0 10639,1 10647,0 10684,1 10695,0 10754,1 10776,0 10871,1 10943,0 11029,1 11099,0 11187,1 11229,0 11235,1 11329,0 11417,1 11475,0 11532,1 11621,0 11656,1 11659,0 11701,1 11752,0 11840,1 11939,0 11949,1 11973,0 12049,1 12094,0 12162,1 12177,0 12195,1 12196,0 12243,1 12268,0 12330,1 12379,0 12433,1 12527,0 12627,1 12639,0 12699,1 12739,0 12767,1 12846,0 12855,1 12913,0 12966,1 13040,0 13058,1 13096,0 13193,1 13199,0 13232,1 13239,0 13327,1 13422,0 13458,1 13542,0 13570,1 13598,0 13620,1 13690,0 13755,1 13846,0 13931,1 13977,0 14067,1 14128,0 14202,1 14208,0 14226,1 14227,0 14243,1 14261,0 14302,1 14362,0 14404,1 14434,0 14518,1 14570,0 14602,1 14656,0 14726,1 14783,0 14876,1 14884,0 14983,1 15005,0 15012,1 15022,0 15121,1 15189,0 15211,1 15264,0 15355,1 15440,0 15525,1 15580,0 15581,1 15605,0 15621,1 15657,0 15672,1 15723,0 15729,1 15776,0 15823,1 15855,0 15861,1 15874,0 15926,1 16011,0 16074,1 16104,0 16165,1 16228,0 16294,1 16381,0 16400,1 16456,0 16481,1 16507,0 16527,1 16614,0 16707,1 16775,0 16779,1 16798,0 16837,1 16894,0 16912,1 16954,0 16970,1 16980,0 16984,1 17005,0 17093,1 17163,0 17222,1 17267,0 17331,1 17421,0 17507,1 17517,0 17595,1 17660,0 17710,1 17800,0 17833,1 17899,0 17964,1 17975,0 18066,1 18138,0 18149,1 18234,0 18253,1 18274,0 18344,1 18371,0 18386,1 18464,0 18495,1 18589,0 18626,1 18673,0 18679,1 18727,0 18827,1 18922,0 18970,1 18996,0 19048,1 19056,0 19096,1 19138,0 19215,1 19264,0 19324,1 19377,0 19414,1 19490,0 19556,1 19591,0 19603,1 19669,0 19677,1 19718,0 19766,1 19769,0 19790,1 19809,0 19899,1 19983,0 20018,1 20045,0 20083,1 20106,0 20182,1 20234,0 20251,1 20282,0 20329,1 20395,0 20487,1 20502,0 20556,1 20616,0 20631,1 20715,0 20787,1 20870,0 20880,1 20886,0 20933,1 21033,0 21059,1 21142,0 21189,1 21231,0 21249,1 21304,0 21380,1 21402,0 21491,1 21566,0 21601,1 21650,0 21726,1 21789,0 21855,1 21935,0 21989,1 22047,0 22075,1 22131,0 22175,1 22191,0 22236,1 22308,0 22394,1 22395,0 22427,1 22430,0 22487,1 22504,0 22565,1 22606,0 22692,1 22771,0 22821,1 22920,0 22974,1 23045,0 23063,1 23107,0 23117,1 23205,0 23274,1 23341,0 23423,1 23474,0 23515,1 23527,0 23576,1 23653,0 23663,1 23703,0 23756,1 23845,0 23929,1 23955,0 24052,1 24070,0 24170,1 24256,0 24304,1 24398,0 24424,1 24433,0 24498,1 24526,0 24593,1 24686,0 24763,1 24853,0 24938,1 25026,0 25098,1 25167,0 25257,1 25272,0 25354,1 25426,0 25461,1 25464,0 25551,1 25640,0 25687,1 25709,0 25752,1 25761,0 25769,1 25779,0 25781,1 25875,0 25961,1 25988,0 26054,1 26113,0 26209,1 26270,0 26279,1 26287,0 26308,1 26315,0 26403,1 26420,0 26432,1 26530,0 26567,1 26635,0 26706,1 26743,0 26831,1 26896,0 26967,1 26971,0 26987,1 27044,0 27086,1 27167,0 27168,1 27202,0 27220,1 27306,0 27331,1 27349,0 27381,1 27469,0 27532,1 27546,0 27590,1 27653,0 27672,1 27769,0 27771,1 27861,0 27933,1 27968,0 28063,1 28116,0 28172,1 28269,0 28346,1 28402,0 28427,1 28448,0 28547,1 28647,0 28738,1 28830,0 28866,1 28916,0 28923,1 28933,0 28940,1 28958,0 29005,1 29105,0 29186,1 29250,0 29321,1 29379,0 29458,1 29498,0 29584,1 29601,0 29673,1 29677,0 29745,1 29804,0 29809,1 29893,0 29993,1 29997,0 30041,1 30141,0 30180,1 30256,0 30272,1 30306,0 30324,1 30351,0 30385,1 30477,0 30536,1 30558,0 30638,1 30680,0 30760,1 30857,0 30946,1 30962,0 30980,1 31003,0 31072,1 31103,0 31143,1 31237,0 31254,1 31255,0 31312,1 31376,0 31393,1 31452,0 31551,1 31571,0 31605,1 31614,0 31655,1 31715,0 31718,1 31773,0 31798,1 31813,0 31819,1 31863,0 31907,1 31981,0 31985,1 32003,0 32102,1 32140,0 32165,1 32199,0 32206,1 32296,0 32304,1 32395,0 32461,1 32522,0 32528,1 32620,0 32643,1 32700,0 32797,1 32869,0 32944,1 32963,0 33063,1 33066,0 33091,1 33126,0 33159,1 33200,0 33228,1 33237,0 33247,1 33312,0 33406,1 33420,0 33461,1 33490,0 33568,1 33651,0 33672,1 33730,0 33822,1 33848,0 33929,1 34029,0 34058,1 34135,0 34139,1 34179,0 34211,1 34249,0 34345,1 34348,0 34437,1 34485,0 34503,1 34536,0 34559,1 34654,0 34658,1 34713,0 34745,1 34816,0 34821,1 34866,0 34965,1 35050,0 35071,1 35135,0 35197,1 35283,0 35382,1 35412,0 35433,1 35526,0 35602,1 35624,0 35690,1 35781,0 35863,1 35905,0 35982,1 36070,0 36081,1 36177,0 36240,1 36313,0 36352,1 36440,0 36479,1 36533,0 36578,1 36644,0 36666,1 36732,0 36815,1 36833,0 36837,1 36862,0 36960,1 37002,0 37061,1 37149,0 37201,1 37213,0 37290,1 37377,0 37468,1 37533,0 37616,1 37636,0 37729,1 37769,0 37817,1 37870,0 37919,1 38009,0 38046,1 38140,0 38141,1 38231,0 38248,1 38331,0 38370,1 38384,0 38470,1 38549,0 38634,1 38670,0 38727,1 38813,0 38849,1 38878,0 38941,1 38954,0 38962,1 38986,0 39068,1 39108,0 39203,1 39297,0 39321,1 39398,0 39438,1 39456,0 39521,1 39579,0 39631,1 39710,0 39800,1 39877,0 39938,1 39977,0 40064,1 40121,0 40145,1 40179,0 40215,1 40232,0 40275,1 40327,0 40371,1 40383,0 40473,1 40560,0 40652,1 40656,0 40694,1 40751,0 40753,1 40811,0 40887,1 40933,0 40980,1 40983,0 41083,1 41118,0 41151,1 41161,0 41195,1 41216,0 41307,1 41360,0 41451,1 41502,0 41553,1 41588,0 41604,1 41625,0 41680,1 41718,0 41720,1 41776,0 41854,1 41884,0 41892,1 41913,0 41984,1 42027,0 42083,1 42086,0 42103,1 42127,0 42174,1 42273,0 42340,1 42399,0 42457,1 42487,0 42556,1 42591,0 42671,1 42748,0 42780,1 42816,0 42907,1 42952,0 42988,1 43041,0 43141,1 43207,0 43251,1 43313,0 43380,1 43410,0 43479,1 43574,0 43607,1 43665,0 43677,1 43706,0 43762,1 43817,0 43901,1 43932,0 43975,1 44011,0 44017,1 44038,0 44123,1 44200,0 44242,1 44249,0 44294,1 44394,0 44467,1 44473,0 44545,1 44569,0 44664,1 44722,0 44765,1 44782,0 44878,1 44893,0 44927,1 44974,0 45026,1 45084,0 45110,1 45132,0 45180,1 45215,0 45261,1 45293,0 45365,1 45448,0 45512,1 45583,0 45597,1 45622,0 45651,1 45658,0 45743,1 45749,0 45772,1 45822,0 45897,1 45911,0 45953,1 46050,0 46126,1 46164,0 46254,1 46276,0 46342,1 46386,0 46433,1 46524,0 46624,1 46711,0 46794,1 46838,0 46911,1 46924,0 46941,1 47012,0 47105,1 47128,0 47150,1 47217,0 47311,1 47337,0 47387,1 47462,0 47492,1 47559,0 47583,1 47651,0 47699,1 47748,0 47824,1 47832,0 47865,1 47879,0 47945,1 48039,0 48113,1 48184,0 48216,1 48240,0 48323,1 48423,0 48504,1 48563,0 48579,1 48675,0 48681,1 48719,0 48814,1 48851,0 48877,1 48891,0 48991,1 48997,0 49063,1 49065,0 49071,1 49133,0 49135,1 49197,0 49282,1 49309,0 49397,1 49496,0 49508,1 49522,0 49585,1 49643,0 49741,1 49766,0 49825,1 49899,0 49923,1 49988,0 50003,1 50055,0 50093,1 50123,0 50125,1 50145,0 50203,1 50279,0 50355,1 50358,0 50393,1 50481,0 50530,1 end initlist b52 0,0 56,1 116,0 192,1 199,0 263,1 274,0 319,1 395,0 469,1 541,0 550,1 592,0 611,1 615,0 715,1 804,0 873,1 969,0 972,1 1036,0 1121,1 1176,0 1191,1 1229,0 1250,1 1299,0 1359,1 1450,0 1506,1 1531,0 1539,1 1564,0 1579,1 1621,0 1627,1 1711,0 1808,1 1823,0 1878,1 1956,0 1968,1 2053,0 2093,1 2107,0 2121,1 2188,0 2287,1 2327,0 2413,1 2425,0 2483,1 2527,0 2591,1 2675,0 2749,1 2776,0 2820,1 2904,0 2997,1 3041,0 3099,1 3197,0 3282,1 3312,0 3371,1 3392,0 3453,1 3544,0 3550,1 3554,0 3557,1 3560,0 3628,1 3697,0 3797,1 3832,0 3915,1 3936,0 3937,1 3976,0 4030,1 4096,0 4177,1 4271,0 4273,1 4295,0 4318,1 4410,0 4498,1 4542,0 4611,1 4654,0 4688,1 4717,0 4774,1 4837,0 4885,1 4938,0 5023,1 5090,0 5100,1 5131,0 5218,1 5282,0 5306,1 5312,0 5320,1 5401,0 5428,1 5439,0 5457,1 5557,0 5630,1 5691,0 5754,1 5807,0 5819,1 5856,0 5939,1 5969,0 5978,1 5980,0 6066,1 6068,0 6109,1 6201,0 6213,1 6216,0 6257,1 6341,0 6420,1 6444,0 6449,1 6503,0 6587,1 6680,0 6719,1 6803,0 6840,1 6877,0 6956,1 7026,0 7098,1 7177,0 7258,1 7339,0 7434,1 7495,0 7594,1 7596,0 7675,1 7745,0 7761,1 7762,0 7807,1 7878,0 7976,1 8065,0 8143,1 8160,0 8239,1 8252,0 8301,1 8383,0 8482,1 8545,0 8632,1 8690,0 8728,1 8758,0 8797,1 8866,0 8935,1 9023,0 9078,1 9136,0 9173,1 9238,0 9318,1 9375,0 9457,1 9488,0 9576,1 9656,0 9681,1 9724,0 9788,1 9841,0 9867,1 9940,0 9962,1 9992,0 10015,1 10091,0 10135,1 10162,0 10256,1 10295,0 10320,1 10374,0 10473,1 10535,0 10554,1 10563,0 10661,1 10685,0 10711,1 10723,0 10780,1 10797,0 10852,1 10855,0 10871,1 10943,0 11019,1 11066,0 11105,1 11139,0 11213,1 11286,0 11326,1 11373,0 11467,1 11468,0 11528,1 11529,0 11564,1 11586,0 11683,1 11768,0 11850,1 11860,0 11950,1 11991,0 11999,1 12015,0 12022,1 12122,0 12200,1 12298,0 12361,1 12374,0 12455,1 12547,0 12588,1 12677,0 12758,1 12777,0 12876,1 12909,0 12941,1 12983,0 13023,1 13101,0 13190,1 13229,0 13279,1 13360,0 13429,1 13460,0 13548,1 13628,0 13727,1 13786,0 13882,1 13916,0 14000,1 14058,0 14114,1 14147,0 14189,1 14215,0 14302,1 14354,0 14396,1 14397,0 14432,1 14437,0 14519,1 14541,0 14595,1 14657,0 14670,1 14746,0 14801,1 14858,0 14910,1 14951,0 15002,1 15017,0 15091,1 15189,0 15288,1 15304,0 15385,1 15407,0 15499,1 15573,0 15666,1 15736,0 15829,1 15886,0 15951,1 16008,0 16089,1 16091,0 16190,1 16209,0 16301,1 16338,0 16355,1 16381,0 16384,1 16402,0 16426,1 16522,0 16609,1 16703,0 16799,1 16865,0 16947,1 17014,0 17050,1 17095,0 17165,1 17216,0 17302,1 17368,0 17388,1 17434,0 17453,1 17481,0 17523,1 17606,0 17632,1 17716,0 17808,1 17900,0 17966,1 17975,0 18073,1 18159,0 18252,1 18348,0 18407,1 18451,0 18538,1 18632,0 18648,1 18706,0 18778,1 18803,0 18869,1 18873,0 18899,1 18918,0 18923,1 18970,0 18985,1 19056,0 19154,1 19208,0 19258,1 19259,0 19332,1 19381,0 19408,1 19441,0 19482,1 19572,0 19612,1 19678,0 19726,1 19756,0 19789,1 19885,0 19962,1 19971,0 20029,1 20112,0 20202,1 20242,0 20288,1 20308,0 20314,1 20349,0 20446,1 20500,0 20502,1 20525,0 20609,1 20673,0 20709,1 20726,0 20823,1 20844,0 20939,1 21037,0 21050,1 21102,0 21160,1 21194,0 21235,1 21331,0 21374,1 21434,0 21458,1 21526,0 21541,1 21580,0 21583,1 21584,0 21669,1 21745,0 21771,1 21853,0 21901,1 21940,0 21977,1 22072,0 22165,1 22260,0 22264,1 22336,0 22430,1 22490,0 22499,1 22529,0 22557,1 22615,0 22689,1 22708,0 22738,1 22794,0 22818,1 22907,0 22946,1 22966,0 23063,1 23126,0 23176,1 23235,0 23250,1 23259,0 23314,1 23395,0 23396,1 23470,0 23543,1 23639,0 23728,1 23755,0 23807,1 23835,0 23867,1 23904,0 23938,1 23952,0 23991,1 24034,0 24036,1 24086,0 24166,1 24206,0 24209,1 24253,0 24340,1 24362,0 24434,1 24436,0 24450,1 24512,0 24541,1 24632,0 24724,1 24761,0 24802,1 24850,0 24883,1 24967,0 25041,1 25139,0 25161,1 25230,0 25245,1 25324,0 25369,1 25422,0 25442,1 25463,0 25465,1 25556,0 25589,1 25675,0 25764,1 25826,0 25923,1 25926,0 25979,1 26031,0 26067,1 26098,0 26178,1 26210,0 26295,1 26352,0 26398,1 26425,0 26498,1 26559,0 26607,1 26689,0 26756,1 26828,0 26909,1 26979,0 27040,1 27088,0 27155,1 27216,0 27228,1 27283,0 27380,1 27456,0 27479,1 27488,0 27582,1 27661,0 27734,1 27798,0 27854,1 27892,0 27932,1 27946,0 28010,1 28089,0 28158,1 28198,0 28280,1 28306,0 28343,1 28412,0 28503,1 28579,0 28660,1 28738,0 28813,1 28885,0 28903,1 28926,0 28959,1 29026,0 29032,1 29063,0 29071,1 29082,0 29126,1 29137,0 29176,1 29226,0 29241,1 29315,0 29408,1 29455,0 29464,1 29538,0 29590,1 29631,0 29691,1 29743,0 29745,1 29820,0 29851,1 29922,0 30003,1 30022,0 30111,1 30132,0 30181,1 30263,0 30284,1 30316,0 30317,1 30340,0 30415,1 30459,0 30530,1 30599,0 30638,1 30643,0 30723,1 30738,0 30801,1 30848,0 30932,1 30937,0 31010,1 31058,0 31154,1 31222,0 31315,1 31372,0 31457,1 31496,0 31577,1 31646,0 31668,1 31696,0 31711,1 31747,0 31847,1 31946,0 32039,1 32123,0 32221,1 32243,0 32287,1 32377,0 32406,1 32424,0 32437,1 32504,0 32511,1 32531,0 32592,1 32687,0 32782,1 32803,0 32901,1 32978,0 32986,1 33036,0 33093,1 33095,0 33181,1 33227,0 33284,1 33314,0 33333,1 33378,0 33452,1 33541,0 33609,1 33665,0 33752,1 33784,0 33808,1 33872,0 33944,1 33963,0 34004,1 34068,0 34101,1 34129,0 34144,1 34177,0 34237,1 34249,0 34320,1 34370,0 34374,1 34423,0 34462,1 34491,0 34506,1 34510,0 34527,1 34589,0 34629,1 34640,0 34691,1 34704,0 34711,1 34761,0 34833,1 34852,0 34896,1 34900,0 34975,1 35010,0 35085,1 35154,0 35243,1 35320,0 35344,1 35393,0 35436,1 35525,0 35551,1 35599,0 35632,1 35676,0 35697,1 35741,0 35752,1 35808,0 35900,1 35944,0 35982,1 36053,0 36145,1 36245,0 36288,1 36386,0 36414,1 36499,0 36530,1 36624,0 36636,1 36708,0 36744,1 36793,0 36837,1 36870,0 36900,1 36936,0 37015,1 37052,0 37100,1 37103,0 37117,1 37145,0 37226,1 37259,0 37301,1 37328,0 37362,1 37400,0 37489,1 37508,0 37548,1 37648,0 37723,1 37739,0 37743,1 37756,0 37833,1 37845,0 37863,1 37864,0 37950,1 38036,0 38126,1 38140,0 38151,1 38156,0 38212,1 38255,0 38309,1 38355,0 38411,1 38433,0 38476,1 38540,0 38606,1 38698,0 38700,1 38742,0 38809,1 38836,0 38897,1 38992,0 39028,1 39065,0 39145,1 39168,0 39225,1 39232,0 39322,1 39405,0 39406,1 39453,0 39457,1 39494,0 39590,1 39646,0 39653,1 39712,0 39803,1 39870,0 39949,1 39963,0 40008,1 40058,0 40091,1 40108,0 40175,1 40221,0 40282,1 40338,0 40413,1 40509,0 40530,1 40557,0 40590,1 40595,0 40690,1 40700,0 40736,1 40779,0 40838,1 40871,0 40896,1 40966,0 41032,1 41131,0 41212,1 41278,0 41350,1 41363,0 41459,1 41507,0 41569,1 41664,0 41674,1 41680,0 41730,1 41773,0 41804,1 41860,0 41878,1 41883,0 41906,1 41971,0 41982,1 42054,0 42082,1 42107,0 42194,1 42274,0 42352,1 42390,0 42416,1 42461,0 42536,1 42619,0 42630,1 42717,0 42721,1 42725,0 42779,1 42797,0 42814,1 42854,0 42857,1 42878,0 42932,1 42986,0 42991,1 43084,0 43111,1 43152,0 43167,1 43257,0 43324,1 43329,0 43429,1 43503,0 43581,1 43610,0 43643,1 43646,0 43725,1 43731,0 43784,1 43874,0 43951,1 44038,0 44048,1 44051,0 44087,1 44116,0 44173,1 44207,0 44245,1 44253,0 44353,1 44413,0 44475,1 44544,0 44612,1 44710,0 44767,1 44851,0 44936,1 45008,0 45095,1 45190,0 45232,1 45274,0 45362,1 45435,0 45482,1 45563,0 45610,1 45663,0 45700,1 45778,0 45864,1 45946,0 45975,1 46071,0 46075,1 46164,0 46249,1 46283,0 46361,1 46423,0 46492,1 46493,0 46498,1 46571,0 46609,1 46620,0 46700,1 46775,0 46855,1 46871,0 46880,1 46946,0 47011,1 47101,0 47185,1 47279,0 47342,1 47424,0 47443,1 47516,0 47614,1 47699,0 47708,1 47761,0 47855,1 47860,0 47920,1 47946,0 47979,1 48072,0 48155,1 48210,0 48260,1 48301,0 48320,1 48328,0 48342,1 48368,0 48468,1 48505,0 48558,1 48600,0 48675,1 48754,0 48780,1 48871,0 48966,1 49033,0 49058,1 49134,0 49204,1 49209,0 49212,1 49213,0 49230,1 49280,0 49317,1 49338,0 49349,1 49403,0 49468,1 49478,0 49560,1 49565,0 49603,1 49697,0 49722,1 49805,0 49841,1 49897,0 49961,1 50045,0 50061,1 50079,0 50083,1 50090,0 50175,1 50246,0 50272,1 50276,0 50296,1 50339,0 50435,1 50520,0 50597,1 50632,0 50724,1 50765,0 50806,1 50837,0 50905,1 50950,0 51003,1 end initlist b53 0,0 100,1 122,0 215,1 303,0 305,1 321,0 372,1 398,0 496,1 511,0 585,1 627,0 686,1 774,0 823,1 881,0 909,1 948,0 1003,1 1020,0 1109,1 1188,0 1243,1 1284,0 1338,1 1393,0 1456,1 1515,0 1600,1 1665,0 1751,1 1848,0 1884,1 1949,0 2027,1 2074,0 2151,1 2236,0 2296,1 2386,0 2432,1 2501,0 2583,1 2644,0 2721,1 2817,0 2851,1 2926,0 3017,1 3034,0 3094,1 3155,0 3187,1 3217,0 3295,1 3336,0 3418,1 3460,0 3507,1 3549,0 3583,1 3679,0 3728,1 3827,0 3884,1 3967,0 4053,1 4122,0 4150,1 4175,0 4216,1 4243,0 4331,1 4371,0 4440,1 4527,0 4551,1 4555,0 4628,1 4657,0 4658,1 4707,0 4792,1 4855,0 4941,1 4960,0 4966,1 4967,0 4987,1 5041,0 5076,1 5116,0 5117,1 5130,0 5163,1 5194,0 5211,1 5307,0 5331,1 5379,0 5415,1 5481,0 5549,1 5647,0 5713,1 5798,0 5881,1 5924,0 6019,1 6049,0 6149,1 6176,0 6213,1 6305,0 6326,1 6373,0 6398,1 6469,0 6512,1 6576,0 6612,1 6664,0 6737,1 6742,0 6760,1 6810,0 6818,1 6864,0 6872,1 6884,0 6947,1 6986,0 6990,1 7077,0 7123,1 7126,0 7134,1 7145,0 7188,1 7208,0 7231,1 7234,0 7278,1 7302,0 7353,1 7404,0 7473,1 7568,0 7621,1 7684,0 7761,1 7833,0 7908,1 7943,0 7950,1 8016,0 8018,1 8026,0 8073,1 8165,0 8189,1 8208,0 8249,1 8342,0 8399,1 8458,0 8544,1 8557,0 8582,1 8664,0 8719,1 8744,0 8777,1 8810,0 8821,1 8894,0 8961,1 8997,0 9074,1 9121,0 9149,1 9224,0 9322,1 9336,0 9372,1 9424,0 9456,1 9477,0 9569,1 9633,0 9684,1 9742,0 9841,1 9908,0 9957,1 10034,0 10056,1 10125,0 10219,1 10234,0 10317,1 10322,0 10345,1 10417,0 10506,1 10521,0 10608,1 10651,0 10729,1 10775,0 10849,1 10850,0 10867,1 10916,0 11004,1 11030,0 11098,1 11104,0 11171,1 11258,0 11274,1 11314,0 11370,1 11405,0 11482,1 11492,0 11516,1 11541,0 11587,1 11663,0 11718,1 11729,0 11766,1 11776,0 11860,1 11923,0 12015,1 12045,0 12094,1 12162,0 12164,1 12185,0 12235,1 12303,0 12399,1 12402,0 12497,1 12554,0 12593,1 12683,0 12757,1 12825,0 12869,1 12965,0 13014,1 13015,0 13087,1 13128,0 13155,1 13206,0 13216,1 13259,0 13289,1 13317,0 13360,1 13362,0 13395,1 13397,0 13482,1 13571,0 13574,1 13627,0 13673,1 13692,0 13727,1 13749,0 13825,1 13869,0 13947,1 14028,0 14046,1 14055,0 14150,1 14235,0 14283,1 14372,0 14425,1 14448,0 14495,1 14565,0 14602,1 14610,0 14680,1 14681,0 14727,1 14813,0 14842,1 14866,0 14948,1 14954,0 14955,1 15026,0 15049,1 15057,0 15085,1 15157,0 15179,1 15192,0 15278,1 15326,0 15370,1 15453,0 15485,1 15527,0 15572,1 15599,0 15650,1 15694,0 15718,1 15804,0 15888,1 15902,0 15920,1 15927,0 16018,1 16114,0 16117,1 16187,0 16232,1 16305,0 16307,1 16355,0 16368,1 16463,0 16489,1 16545,0 16645,1 16707,0 16800,1 16869,0 16935,1 16965,0 17010,1 17097,0 17136,1 17224,0 17246,1 17300,0 17398,1 17401,0 17420,1 17453,0 17536,1 17563,0 17572,1 17648,0 17672,1 17730,0 17793,1 17862,0 17935,1 17976,0 17981,1 17982,0 18024,1 18122,0 18164,1 18219,0 18254,1 18320,0 18406,1 18468,0 18499,1 18584,0 18657,1 18715,0 18787,1 18833,0 18897,1 18927,0 19026,1 19110,0 19187,1 19225,0 19269,1 19297,0 19386,1 19471,0 19530,1 19591,0 19664,1 19677,0 19694,1 19794,0 19796,1 19801,0 19850,1 19894,0 19911,1 20004,0 20020,1 20056,0 20119,1 20185,0 20227,1 20246,0 20260,1 20305,0 20402,1 20489,0 20520,1 20528,0 20529,1 20534,0 20599,1 20684,0 20757,1 20838,0 20894,1 20900,0 20929,1 20932,0 20990,1 21065,0 21110,1 21125,0 21129,1 21170,0 21267,1 21295,0 21313,1 21318,0 21397,1 21440,0 21463,1 21539,0 21580,1 21627,0 21727,1 21827,0 21876,1 21933,0 21964,1 21998,0 22035,1 22073,0 22118,1 22203,0 22285,1 22364,0 22452,1 22501,0 22589,1 22661,0 22710,1 22792,0 22816,1 22824,0 22828,1 22858,0 22955,1 22987,0 23056,1 23118,0 23192,1 23241,0 23257,1 23277,0 23373,1 23463,0 23485,1 23524,0 23602,1 23672,0 23741,1 23758,0 23851,1 23867,0 23967,1 24062,0 24075,1 24136,0 24157,1 24177,0 24220,1 24263,0 24348,1 24423,0 24424,1 24461,0 24557,1 24586,0 24603,1 24662,0 24749,1 24823,0 24888,1 24941,0 24943,1 24974,0 24995,1 25020,0 25058,1 25135,0 25208,1 25242,0 25293,1 25306,0 25365,1 25433,0 25517,1 25594,0 25636,1 25685,0 25785,1 25843,0 25903,1 25951,0 25997,1 26085,0 26155,1 26190,0 26262,1 26328,0 26407,1 26428,0 26479,1 26550,0 26605,1 26665,0 26668,1 26681,0 26770,1 26821,0 26862,1 26867,0 26963,1 27030,0 27122,1 27189,0 27288,1 27302,0 27331,1 27388,0 27408,1 27421,0 27472,1 27478,0 27490,1 27574,0 27640,1 27723,0 27816,1 27880,0 27946,1 28009,0 28029,1 28039,0 28104,1 28107,0 28163,1 28186,0 28197,1 28266,0 28294,1 28388,0 28414,1 28455,0 28547,1 28593,0 28688,1 28771,0 28871,1 28957,0 29032,1 29058,0 29151,1 29202,0 29232,1 29278,0 29300,1 29397,0 29466,1 29551,0 29561,1 29583,0 29651,1 29750,0 29789,1 29815,0 29882,1 29889,0 29955,1 29965,0 30051,1 30072,0 30087,1 30117,0 30131,1 30151,0 30166,1 30211,0 30242,1 30285,0 30332,1 30341,0 30407,1 30450,0 30505,1 30514,0 30602,1 30675,0 30707,1 30804,0 30896,1 30983,0 31077,1 31149,0 31236,1 31295,0 31305,1 31383,0 31401,1 31499,0 31511,1 31558,0 31562,1 31648,0 31689,1 31749,0 31827,1 31896,0 31919,1 31926,0 32004,1 32054,0 32123,1 32124,0 32178,1 32253,0 32331,1 32333,0 32345,1 32383,0 32452,1 32503,0 32528,1 32580,0 32680,1 32704,0 32792,1 32824,0 32903,1 32949,0 32993,1 33027,0 33111,1 33189,0 33193,1 33249,0 33336,1 33421,0 33442,1 33452,0 33549,1 33553,0 33635,1 33670,0 33683,1 33730,0 33811,1 33850,0 33930,1 34017,0 34107,1 34128,0 34172,1 34185,0 34227,1 34310,0 34368,1 34399,0 34470,1 34557,0 34582,1 34606,0 34668,1 34759,0 34805,1 34812,0 34891,1 34921,0 34983,1 35026,0 35089,1 35137,0 35158,1 35190,0 35251,1 35327,0 35423,1 35504,0 35572,1 35661,0 35735,1 35761,0 35802,1 35885,0 35928,1 35949,0 36002,1 36100,0 36163,1 36213,0 36241,1 36334,0 36349,1 36356,0 36404,1 36425,0 36456,1 36515,0 36581,1 36620,0 36672,1 36716,0 36789,1 36884,0 36971,1 37067,0 37097,1 37176,0 37255,1 37297,0 37367,1 37461,0 37499,1 37509,0 37587,1 37629,0 37681,1 37723,0 37757,1 37812,0 37814,1 37822,0 37864,1 37898,0 37906,1 37986,0 38080,1 38103,0 38117,1 38131,0 38213,1 38252,0 38290,1 38360,0 38370,1 38443,0 38509,1 38532,0 38615,1 38695,0 38710,1 38755,0 38813,1 38882,0 38968,1 39041,0 39073,1 39097,0 39169,1 39248,0 39338,1 39339,0 39425,1 39457,0 39522,1 39578,0 39643,1 39678,0 39693,1 39779,0 39851,1 39922,0 39982,1 40070,0 40091,1 40157,0 40179,1 40230,0 40234,1 40307,0 40391,1 40399,0 40427,1 40451,0 40499,1 40598,0 40651,1 40706,0 40712,1 40760,0 40828,1 40848,0 40941,1 41004,0 41017,1 41110,0 41144,1 41147,0 41150,1 41241,0 41276,1 41332,0 41352,1 41429,0 41458,1 41550,0 41563,1 41567,0 41601,1 41672,0 41748,1 41822,0 41839,1 41899,0 41962,1 42044,0 42109,1 42110,0 42177,1 42247,0 42347,1 42425,0 42441,1 42504,0 42553,1 42614,0 42653,1 42661,0 42732,1 42831,0 42886,1 42939,0 42960,1 43029,0 43066,1 43153,0 43248,1 43287,0 43326,1 43357,0 43364,1 43461,0 43534,1 43591,0 43640,1 43683,0 43742,1 43765,0 43829,1 43926,0 43987,1 44006,0 44061,1 44075,0 44151,1 44223,0 44271,1 44337,0 44417,1 44470,0 44485,1 44502,0 44578,1 44643,0 44651,1 44659,0 44716,1 44809,0 44873,1 44967,0 44968,1 45062,0 45151,1 45207,0 45252,1 45261,0 45308,1 45343,0 45350,1 45439,0 45501,1 45517,0 45570,1 45667,0 45739,1 45788,0 45846,1 45858,0 45891,1 45972,0 45991,1 46032,0 46079,1 46160,0 46212,1 46215,0 46279,1 46311,0 46379,1 46463,0 46530,1 46620,0 46684,1 46735,0 46755,1 46764,0 46837,1 46872,0 46886,1 46985,0 47008,1 47079,0 47130,1 47136,0 47203,1 47264,0 47319,1 47379,0 47407,1 47420,0 47479,1 47544,0 47594,1 47602,0 47637,1 47705,0 47765,1 47831,0 47872,1 47889,0 47950,1 48018,0 48048,1 48126,0 48213,1 48264,0 48312,1 48316,0 48322,1 48358,0 48432,1 48456,0 48556,1 48593,0 48601,1 48684,0 48717,1 48800,0 48819,1 48890,0 48990,1 49010,0 49078,1 49157,0 49178,1 49237,0 49322,1 49365,0 49390,1 49489,0 49568,1 49649,0 49743,1 49773,0 49815,1 49884,0 49969,1 49979,0 50069,1 50132,0 50148,1 50231,0 50307,1 50326,0 50417,1 50443,0 50534,1 50612,0 50630,1 50693,0 50722,1 50768,0 50831,1 50896,0 50952,1 51030,0 51044,1 end initlist b54 0,0 32,1 33,0 113,1 143,0 163,1 249,0 269,1 271,0 327,1 398,0 436,1 482,0 530,1 534,0 587,1 610,0 641,1 689,0 722,1 777,0 840,1 871,0 902,1 942,0 973,1 982,0 1044,1 1045,0 1066,1 1125,0 1144,1 1175,0 1191,1 1245,0 1281,1 1307,0 1395,1 1470,0 1487,1 1513,0 1598,1 1674,0 1699,1 1755,0 1781,1 1788,0 1879,1 1922,0 1929,1 2003,0 2034,1 2077,0 2111,1 2120,0 2197,1 2210,0 2221,1 2286,0 2385,1 2431,0 2528,1 2547,0 2573,1 2582,0 2665,1 2736,0 2832,1 2925,0 2977,1 3053,0 3124,1 3214,0 3245,1 3310,0 3396,1 3496,0 3540,1 3542,0 3573,1 3672,0 3721,1 3739,0 3825,1 3873,0 3961,1 3995,0 4079,1 4149,0 4216,1 4312,0 4329,1 4355,0 4447,1 4529,0 4593,1 4638,0 4722,1 4735,0 4811,1 4911,0 4970,1 5070,0 5072,1 5156,0 5189,1 5243,0 5294,1 5353,0 5392,1 5449,0 5528,1 5583,0 5600,1 5664,0 5702,1 5787,0 5887,1 5982,0 6063,1 6090,0 6104,1 6115,0 6174,1 6215,0 6315,1 6385,0 6450,1 6503,0 6555,1 6641,0 6740,1 6756,0 6799,1 6891,0 6961,1 6974,0 7049,1 7117,0 7147,1 7233,0 7272,1 7359,0 7364,1 7383,0 7436,1 7452,0 7518,1 7565,0 7620,1 7647,0 7680,1 7699,0 7713,1 7741,0 7761,1 7796,0 7880,1 7967,0 8035,1 8054,0 8122,1 8165,0 8187,1 8208,0 8267,1 8290,0 8357,1 8396,0 8432,1 8479,0 8503,1 8590,0 8614,1 8705,0 8778,1 8839,0 8860,1 8865,0 8888,1 8973,0 9070,1 9113,0 9128,1 9198,0 9232,1 9325,0 9385,1 9485,0 9566,1 9662,0 9681,1 9684,0 9724,1 9734,0 9781,1 9850,0 9866,1 9937,0 9967,1 10062,0 10063,1 10156,0 10240,1 10301,0 10343,1 10430,0 10492,1 10501,0 10579,1 10639,0 10726,1 10789,0 10886,1 10969,0 10995,1 11046,0 11137,1 11210,0 11287,1 11365,0 11451,1 11485,0 11558,1 11589,0 11631,1 11641,0 11715,1 11762,0 11803,1 11855,0 11881,1 11971,0 11986,1 11999,0 12074,1 12136,0 12163,1 12176,0 12197,1 12250,0 12298,1 12380,0 12460,1 12501,0 12591,1 12616,0 12619,1 12680,0 12732,1 12797,0 12820,1 12904,0 12980,1 13077,0 13136,1 13170,0 13233,1 13241,0 13283,1 13376,0 13424,1 13452,0 13508,1 13592,0 13682,1 13697,0 13790,1 13809,0 13888,1 13901,0 13905,1 13933,0 13942,1 14026,0 14119,1 14147,0 14174,1 14192,0 14274,1 14367,0 14402,1 14486,0 14569,1 14603,0 14701,1 14757,0 14806,1 14886,0 14906,1 14958,0 14965,1 14970,0 15008,1 15078,0 15109,1 15169,0 15224,1 15323,0 15404,1 15471,0 15506,1 15604,0 15642,1 15652,0 15744,1 15785,0 15867,1 15936,0 16030,1 16108,0 16157,1 16192,0 16243,1 16317,0 16405,1 16407,0 16409,1 16465,0 16557,1 16606,0 16684,1 16727,0 16745,1 16749,0 16751,1 16755,0 16818,1 16878,0 16941,1 17034,0 17131,1 17178,0 17192,1 17281,0 17359,1 17440,0 17532,1 17625,0 17702,1 17800,0 17855,1 17954,0 17995,1 18041,0 18095,1 18175,0 18180,1 18244,0 18288,1 18325,0 18373,1 18378,0 18416,1 18506,0 18526,1 18626,0 18685,1 18782,0 18821,1 18841,0 18877,1 18966,0 19053,1 19064,0 19118,1 19150,0 19242,1 19263,0 19347,1 19413,0 19469,1 19490,0 19541,1 19572,0 19612,1 19683,0 19714,1 19774,0 19829,1 19915,0 19937,1 19975,0 20061,1 20071,0 20103,1 20104,0 20163,1 20168,0 20257,1 20300,0 20304,1 20375,0 20447,1 20472,0 20477,1 20574,0 20577,1 20581,0 20609,1 20665,0 20730,1 20773,0 20803,1 20881,0 20910,1 20986,0 21006,1 21037,0 21134,1 21186,0 21285,1 21376,0 21474,1 21502,0 21590,1 21620,0 21695,1 21756,0 21771,1 21819,0 21830,1 21907,0 21925,1 21960,0 22046,1 22110,0 22153,1 22165,0 22193,1 22271,0 22291,1 22329,0 22416,1 22477,0 22574,1 22595,0 22625,1 22669,0 22745,1 22793,0 22833,1 22908,0 22973,1 23049,0 23088,1 23101,0 23112,1 23206,0 23248,1 23286,0 23321,1 23361,0 23412,1 23505,0 23542,1 23634,0 23651,1 23674,0 23677,1 23759,0 23824,1 23915,0 23984,1 24071,0 24092,1 24137,0 24147,1 24225,0 24325,1 24360,0 24374,1 24427,0 24483,1 24581,0 24623,1 24627,0 24674,1 24750,0 24809,1 24843,0 24932,1 25015,0 25114,1 25152,0 25202,1 25294,0 25356,1 25394,0 25457,1 25550,0 25629,1 25642,0 25722,1 25787,0 25852,1 25903,0 25919,1 25994,0 25996,1 26029,0 26091,1 26167,0 26192,1 26212,0 26255,1 26283,0 26284,1 26328,0 26345,1 26442,0 26453,1 26533,0 26632,1 26688,0 26761,1 26822,0 26894,1 26923,0 26930,1 26944,0 27034,1 27049,0 27136,1 27145,0 27231,1 27262,0 27349,1 27393,0 27478,1 27573,0 27613,1 27701,0 27716,1 27800,0 27810,1 27902,0 27988,1 28067,0 28165,1 28257,0 28327,1 28416,0 28474,1 28517,0 28599,1 28639,0 28652,1 28661,0 28708,1 28806,0 28849,1 28878,0 28938,1 28983,0 29080,1 29095,0 29160,1 29166,0 29207,1 29296,0 29382,1 29423,0 29449,1 29498,0 29588,1 29672,0 29673,1 29697,0 29797,1 29850,0 29855,1 29890,0 29914,1 29945,0 30044,1 30091,0 30180,1 30276,0 30319,1 30344,0 30356,1 30362,0 30419,1 30469,0 30510,1 30581,0 30598,1 30614,0 30656,1 30734,0 30806,1 30851,0 30880,1 30908,0 30938,1 31020,0 31052,1 31107,0 31132,1 31154,0 31213,1 31216,0 31221,1 31320,0 31361,1 31376,0 31420,1 31471,0 31560,1 31650,0 31736,1 31801,0 31892,1 31983,0 32068,1 32161,0 32195,1 32224,0 32308,1 32352,0 32419,1 32457,0 32479,1 32522,0 32603,1 32646,0 32716,1 32720,0 32766,1 32799,0 32868,1 32874,0 32959,1 32969,0 33003,1 33039,0 33042,1 33118,0 33194,1 33210,0 33261,1 33329,0 33404,1 33419,0 33488,1 33519,0 33584,1 33656,0 33731,1 33788,0 33885,1 33944,0 33996,1 34014,0 34075,1 34171,0 34269,1 34271,0 34294,1 34337,0 34398,1 34435,0 34516,1 34568,0 34601,1 34637,0 34721,1 34722,0 34790,1 34845,0 34867,1 34934,0 35029,1 35035,0 35044,1 35051,0 35061,1 35152,0 35213,1 35267,0 35330,1 35390,0 35454,1 35486,0 35496,1 35582,0 35637,1 35661,0 35711,1 35722,0 35810,1 35830,0 35889,1 35941,0 36017,1 36094,0 36112,1 36113,0 36149,1 36214,0 36277,1 36309,0 36387,1 36388,0 36438,1 36535,0 36632,1 36719,0 36781,1 36845,0 36851,1 36923,0 36985,1 36994,0 37079,1 37080,0 37133,1 37174,0 37193,1 37246,0 37322,1 37418,0 37485,1 37502,0 37532,1 37567,0 37654,1 37745,0 37799,1 37827,0 37905,1 37920,0 37964,1 38060,0 38109,1 38191,0 38265,1 38296,0 38336,1 38424,0 38439,1 38493,0 38509,1 38553,0 38577,1 38623,0 38682,1 38713,0 38806,1 38864,0 38962,1 38993,0 39023,1 39056,0 39075,1 39138,0 39219,1 39309,0 39312,1 39404,0 39431,1 39447,0 39489,1 39583,0 39585,1 39673,0 39715,1 39807,0 39890,1 39985,0 39990,1 40032,0 40072,1 40117,0 40148,1 40194,0 40282,1 40317,0 40336,1 40379,0 40478,1 40525,0 40564,1 40574,0 40636,1 40682,0 40693,1 40786,0 40863,1 40910,0 40975,1 41014,0 41094,1 41171,0 41190,1 41219,0 41251,1 41323,0 41391,1 41455,0 41504,1 41575,0 41610,1 41613,0 41691,1 41706,0 41721,1 41820,0 41821,1 41825,0 41914,1 41966,0 42022,1 42077,0 42164,1 42220,0 42307,1 42311,0 42362,1 42403,0 42442,1 42462,0 42508,1 42561,0 42596,1 42601,0 42701,1 42793,0 42841,1 42933,0 42939,1 43004,0 43104,1 43165,0 43215,1 43233,0 43252,1 43293,0 43379,1 43384,0 43400,1 43444,0 43521,1 43591,0 43677,1 43754,0 43824,1 43839,0 43924,1 44019,0 44044,1 44144,0 44209,1 44282,0 44368,1 44373,0 44400,1 44409,0 44413,1 44471,0 44539,1 44586,0 44653,1 44730,0 44818,1 44918,0 45011,1 45104,0 45128,1 45172,0 45188,1 45277,0 45289,1 45386,0 45470,1 45493,0 45559,1 45576,0 45595,1 45606,0 45699,1 45787,0 45788,1 45802,0 45819,1 45872,0 45890,1 45926,0 45999,1 46072,0 46090,1 46179,0 46211,1 46262,0 46289,1 46300,0 46364,1 46369,0 46423,1 46440,0 46481,1 46504,0 46548,1 46557,0 46641,1 46736,0 46790,1 46817,0 46823,1 46882,0 46947,1 46952,0 46983,1 47059,0 47110,1 47149,0 47173,1 47217,0 47256,1 47307,0 47355,1 47442,0 47463,1 47484,0 47583,1 47606,0 47663,1 47691,0 47706,1 47707,0 47750,1 47830,0 47888,1 47925,0 47994,1 48051,0 48117,1 48215,0 48247,1 48327,0 48359,1 48443,0 48516,1 48592,0 48608,1 48621,0 48649,1 48684,0 48742,1 48823,0 48905,1 48957,0 48969,1 49067,0 49107,1 49180,0 49257,1 49306,0 49330,1 49424,0 49444,1 49539,0 49588,1 49635,0 49692,1 49760,0 49822,1 49852,0 49870,1 49945,0 50016,1 50033,0 50052,1 50146,0 50206,1 50277,0 50284,1 50301,0 50371,1 50404,0 50422,1 50505,0 50529,1 50581,0 50607,1 50649,0 50723,1 50776,0 50807,1 50885,0 50969,1 51004,0 51055,1 51077,0 51116,1 51142,0 51149,1 51180,0 51220,1 51318,0 51362,1 end initlist b55 0,0 83,1 129,0 204,1 244,0 335,1 377,0 452,1 497,0 583,1 643,0 661,1 754,0 804,1 807,0 824,1 852,0 933,1 982,0 986,1 1007,0 1103,1 1154,0 1188,1 1191,0 1223,1 1268,0 1362,1 1405,0 1483,1 1557,0 1591,1 1670,0 1769,1 1777,0 1803,1 1858,0 1913,1 1986,0 2033,1 2053,0 2120,1 2122,0 2127,1 2160,0 2240,1 2307,0 2400,1 2402,0 2436,1 2488,0 2518,1 2538,0 2563,1 2621,0 2643,1 2718,0 2783,1 2876,0 2892,1 2991,0 3026,1 3082,0 3134,1 3136,0 3177,1 3234,0 3250,1 3270,0 3351,1 3353,0 3432,1 3465,0 3504,1 3566,0 3588,1 3681,0 3729,1 3757,0 3820,1 3911,0 3922,1 4010,0 4073,1 4135,0 4138,1 4228,0 4241,1 4305,0 4355,1 4374,0 4394,1 4419,0 4456,1 4552,0 4646,1 4671,0 4712,1 4764,0 4837,1 4876,0 4892,1 4924,0 4946,1 5033,0 5088,1 5114,0 5196,1 5291,0 5295,1 5355,0 5440,1 5462,0 5495,1 5510,0 5535,1 5608,0 5701,1 5714,0 5750,1 5770,0 5869,1 5895,0 5963,1 6017,0 6116,1 6197,0 6230,1 6232,0 6247,1 6280,0 6305,1 6335,0 6383,1 6480,0 6511,1 6581,0 6673,1 6688,0 6759,1 6810,0 6842,1 6932,0 6995,1 7063,0 7128,1 7139,0 7154,1 7179,0 7250,1 7323,0 7330,1 7348,0 7381,1 7411,0 7493,1 7542,0 7625,1 7689,0 7712,1 7724,0 7804,1 7892,0 7974,1 8016,0 8020,1 8049,0 8129,1 8199,0 8265,1 8290,0 8309,1 8322,0 8353,1 8388,0 8390,1 8403,0 8430,1 8437,0 8530,1 8609,0 8649,1 8739,0 8836,1 8917,0 9007,1 9052,0 9117,1 9128,0 9226,1 9239,0 9308,1 9377,0 9443,1 9467,0 9495,1 9569,0 9668,1 9724,0 9819,1 9897,0 9946,1 9969,0 10061,1 10143,0 10205,1 10243,0 10330,1 10398,0 10423,1 10481,0 10483,1 10537,0 10560,1 10584,0 10629,1 10655,0 10727,1 10786,0 10865,1 10924,0 10930,1 11023,0 11059,1 11062,0 11142,1 11237,0 11321,1 11377,0 11459,1 11547,0 11607,1 11637,0 11688,1 11749,0 11806,1 11848,0 11850,1 11897,0 11950,1 12030,0 12086,1 12175,0 12246,1 12318,0 12404,1 12444,0 12508,1 12567,0 12637,1 12684,0 12700,1 12772,0 12818,1 12825,0 12907,1 12975,0 13037,1 13063,0 13131,1 13163,0 13211,1 13239,0 13275,1 13305,0 13317,1 13370,0 13449,1 13503,0 13581,1 13672,0 13752,1 13850,0 13878,1 13934,0 13999,1 14038,0 14079,1 14112,0 14202,1 14296,0 14328,1 14405,0 14429,1 14438,0 14515,1 14581,0 14615,1 14632,0 14724,1 14811,0 14851,1 14947,0 14991,1 15065,0 15116,1 15130,0 15182,1 15251,0 15343,1 15418,0 15422,1 15521,0 15592,1 15622,0 15689,1 15695,0 15709,1 15714,0 15786,1 15849,0 15878,1 15901,0 15915,1 15963,0 15999,1 16077,0 16110,1 16134,0 16214,1 16225,0 16317,1 16396,0 16433,1 16466,0 16497,1 16547,0 16562,1 16661,0 16688,1 16778,0 16865,1 16905,0 16996,1 17014,0 17080,1 17133,0 17162,1 17202,0 17287,1 17339,0 17385,1 17432,0 17477,1 17480,0 17536,1 17567,0 17607,1 17706,0 17802,1 17842,0 17856,1 17948,0 18025,1 18086,0 18176,1 18197,0 18249,1 18267,0 18364,1 18428,0 18485,1 18565,0 18652,1 18713,0 18787,1 18864,0 18894,1 18916,0 18917,1 18990,0 19034,1 19096,0 19143,1 19203,0 19243,1 19245,0 19304,1 19337,0 19396,1 19399,0 19487,1 19490,0 19575,1 19662,0 19667,1 19752,0 19794,1 19827,0 19874,1 19906,0 19928,1 19954,0 20001,1 20023,0 20063,1 20161,0 20261,1 20303,0 20382,1 20407,0 20412,1 20418,0 20468,1 20488,0 20579,1 20672,0 20758,1 20815,0 20898,1 20961,0 21039,1 21072,0 21140,1 21226,0 21233,1 21314,0 21378,1 21459,0 21489,1 21581,0 21663,1 21727,0 21770,1 21815,0 21898,1 21965,0 22057,1 22100,0 22135,1 22157,0 22243,1 22283,0 22380,1 22465,0 22503,1 22591,0 22664,1 22684,0 22725,1 22821,0 22858,1 22891,0 22959,1 23037,0 23102,1 23163,0 23238,1 23256,0 23331,1 23378,0 23466,1 23502,0 23524,1 23598,0 23619,1 23638,0 23666,1 23715,0 23794,1 23868,0 23906,1 23974,0 23988,1 24027,0 24096,1 24180,0 24228,1 24247,0 24331,1 24353,0 24373,1 24437,0 24438,1 24487,0 24555,1 24560,0 24561,1 24606,0 24641,1 24711,0 24732,1 24816,0 24821,1 24860,0 24869,1 24920,0 25011,1 25021,0 25100,1 25116,0 25117,1 25143,0 25191,1 25209,0 25251,1 25343,0 25373,1 25431,0 25459,1 25504,0 25568,1 25591,0 25638,1 25657,0 25691,1 25726,0 25783,1 25819,0 25878,1 25890,0 25953,1 25991,0 26081,1 26124,0 26220,1 26249,0 26250,1 26251,0 26279,1 26347,0 26390,1 26409,0 26429,1 26459,0 26499,1 26538,0 26546,1 26563,0 26579,1 26617,0 26705,1 26800,0 26833,1 26911,0 26977,1 27011,0 27027,1 27090,0 27178,1 27187,0 27222,1 27243,0 27341,1 27359,0 27416,1 27428,0 27470,1 27539,0 27543,1 27551,0 27648,1 27726,0 27782,1 27805,0 27832,1 27901,0 27997,1 28010,0 28054,1 28089,0 28151,1 28239,0 28272,1 28368,0 28412,1 28487,0 28521,1 28583,0 28661,1 28662,0 28674,1 28764,0 28805,1 28827,0 28915,1 29012,0 29077,1 29093,0 29127,1 29169,0 29233,1 29265,0 29278,1 29378,0 29406,1 29488,0 29535,1 29635,0 29674,1 29692,0 29734,1 29798,0 29898,1 29992,0 30032,1 30035,0 30058,1 30152,0 30216,1 30227,0 30284,1 30355,0 30415,1 30488,0 30576,1 30658,0 30741,1 30765,0 30818,1 30882,0 30973,1 31059,0 31123,1 31211,0 31287,1 31332,0 31371,1 31389,0 31394,1 31492,0 31581,1 31638,0 31732,1 31755,0 31786,1 31823,0 31839,1 31848,0 31878,1 31946,0 32007,1 32089,0 32140,1 32167,0 32188,1 32212,0 32233,1 32309,0 32353,1 32448,0 32530,1 32625,0 32705,1 32745,0 32812,1 32875,0 32898,1 32936,0 32983,1 33063,0 33091,1 33155,0 33235,1 33320,0 33393,1 33469,0 33488,1 33570,0 33574,1 33656,0 33662,1 33675,0 33677,1 33697,0 33791,1 33832,0 33903,1 33922,0 33956,1 33959,0 33961,1 33986,0 33995,1 34078,0 34083,1 34127,0 34197,1 34208,0 34254,1 34270,0 34323,1 34329,0 34349,1 34400,0 34496,1 34568,0 34658,1 34739,0 34793,1 34844,0 34908,1 34998,0 35040,1 35097,0 35110,1 35130,0 35154,1 35170,0 35176,1 35196,0 35231,1 35308,0 35333,1 35366,0 35422,1 35459,0 35469,1 35506,0 35512,1 35596,0 35632,1 35642,0 35725,1 35779,0 35834,1 35891,0 35960,1 36033,0 36119,1 36200,0 36244,1 36263,0 36267,1 36312,0 36341,1 36372,0 36454,1 36503,0 36590,1 36680,0 36700,1 36749,0 36849,1 36874,0 36921,1 36929,0 36954,1 37011,0 37049,1 37072,0 37129,1 37176,0 37265,1 37331,0 37352,1 37397,0 37455,1 37496,0 37596,1 37636,0 37735,1 37738,0 37804,1 37896,0 37987,1 38027,0 38066,1 38136,0 38210,1 38243,0 38260,1 38345,0 38431,1 38432,0 38492,1 38565,0 38661,1 38757,0 38776,1 38869,0 38879,1 38908,0 38917,1 38937,0 38972,1 39029,0 39088,1 39163,0 39166,1 39261,0 39300,1 39322,0 39395,1 39492,0 39552,1 39557,0 39561,1 39564,0 39643,1 39712,0 39803,1 39849,0 39911,1 39953,0 40041,1 40094,0 40189,1 40228,0 40310,1 40367,0 40465,1 40516,0 40583,1 40611,0 40635,1 40648,0 40687,1 40706,0 40806,1 40843,0 40930,1 40978,0 41062,1 41087,0 41127,1 41206,0 41278,1 41280,0 41353,1 41391,0 41469,1 41514,0 41532,1 41600,0 41687,1 41779,0 41834,1 41843,0 41893,1 41895,0 41989,1 42045,0 42086,1 42092,0 42106,1 42167,0 42219,1 42306,0 42317,1 42405,0 42482,1 42490,0 42520,1 42547,0 42592,1 42646,0 42684,1 42704,0 42743,1 42788,0 42843,1 42845,0 42897,1 42962,0 42981,1 43031,0 43042,1 43066,0 43103,1 43149,0 43207,1 43303,0 43351,1 43367,0 43419,1 43483,0 43526,1 43542,0 43601,1 43603,0 43700,1 43760,0 43789,1 43842,0 43897,1 43934,0 43963,1 43974,0 43982,1 44021,0 44053,1 44144,0 44244,1 44289,0 44385,1 44463,0 44492,1 44536,0 44573,1 44659,0 44754,1 44850,0 44945,1 45010,0 45059,1 45064,0 45127,1 45155,0 45214,1 45227,0 45325,1 45416,0 45500,1 45548,0 45634,1 45727,0 45810,1 45826,0 45908,1 45990,0 46015,1 46051,0 46084,1 46089,0 46145,1 46245,0 46300,1 46399,0 46483,1 46523,0 46531,1 46610,0 46638,1 46664,0 46696,1 46743,0 46843,1 46930,0 47018,1 47029,0 47097,1 47140,0 47233,1 47265,0 47335,1 47402,0 47417,1 47498,0 47517,1 47613,0 47667,1 47738,0 47748,1 47781,0 47852,1 47898,0 47956,1 47992,0 48015,1 48029,0 48078,1 48149,0 48203,1 48292,0 48300,1 48352,0 48370,1 48395,0 48426,1 48433,0 48498,1 48559,0 48642,1 48656,0 48722,1 48756,0 48816,1 48827,0 48902,1 48956,0 48999,1 49042,0 49071,1 49106,0 49178,1 49234,0 49329,1 49410,0 49467,1 49522,0 49547,1 49580,0 49671,1 49688,0 49754,1 49761,0 49827,1 49886,0 49953,1 50052,0 50120,1 50162,0 50222,1 50247,0 50336,1 50381,0 50460,1 50484,0 50514,1 50581,0 50616,1 end initlist b56 0,0 91,1 190,0 194,1 261,0 318,1 353,0 377,1 384,0 457,1 492,0 551,1 567,0 620,1 663,0 750,1 818,0 913,1 987,0 1036,1 1113,0 1143,1 1168,0 1249,1 1303,0 1332,1 1357,0 1436,1 1454,0 1509,1 1513,0 1519,1 1612,0 1648,1 1736,0 1769,1 1787,0 1805,1 1897,0 1974,1 2000,0 2001,1 2067,0 2118,1 2193,0 2276,1 2292,0 2391,1 2398,0 2427,1 2505,0 2596,1 2638,0 2641,1 2682,0 2754,1 2836,0 2929,1 2955,0 2989,1 3082,0 3084,1 3092,0 3115,1 3181,0 3220,1 3274,0 3296,1 3344,0 3362,1 3407,0 3422,1 3438,0 3493,1 3544,0 3560,1 3574,0 3650,1 3748,0 3773,1 3814,0 3913,1 3949,0 3963,1 3972,0 4035,1 4064,0 4067,1 4143,0 4211,1 4284,0 4359,1 4436,0 4530,1 4569,0 4626,1 4709,0 4768,1 4851,0 4862,1 4892,0 4978,1 5051,0 5123,1 5167,0 5219,1 5221,0 5254,1 5324,0 5339,1 5347,0 5400,1 5458,0 5538,1 5540,0 5621,1 5639,0 5704,1 5782,0 5831,1 5877,0 5884,1 5903,0 5929,1 5993,0 6014,1 6017,0 6060,1 6099,0 6183,1 6268,0 6276,1 6331,0 6373,1 6461,0 6561,1 6568,0 6610,1 6621,0 6688,1 6716,0 6728,1 6765,0 6865,1 6939,0 6992,1 7002,0 7028,1 7119,0 7129,1 7200,0 7241,1 7302,0 7351,1 7366,0 7370,1 7437,0 7520,1 7595,0 7654,1 7713,0 7721,1 7817,0 7896,1 7904,0 7956,1 7967,0 8063,1 8143,0 8168,1 8224,0 8310,1 8330,0 8394,1 8424,0 8471,1 8550,0 8569,1 8581,0 8642,1 8652,0 8732,1 8776,0 8797,1 8878,0 8927,1 8933,0 9023,1 9051,0 9068,1 9091,0 9098,1 9119,0 9155,1 9216,0 9275,1 9331,0 9355,1 9400,0 9432,1 9468,0 9530,1 9623,0 9689,1 9739,0 9754,1 9825,0 9850,1 9898,0 9938,1 9951,0 9992,1 10021,0 10085,1 10151,0 10156,1 10237,0 10253,1 10289,0 10309,1 10387,0 10444,1 10502,0 10574,1 10665,0 10704,1 10741,0 10764,1 10771,0 10784,1 10847,0 10875,1 10971,0 11065,1 11154,0 11176,1 11179,0 11258,1 11265,0 11288,1 11297,0 11375,1 11436,0 11455,1 11545,0 11637,1 11705,0 11737,1 11763,0 11858,1 11876,0 11899,1 11902,0 11983,1 12030,0 12061,1 12077,0 12107,1 12181,0 12261,1 12345,0 12400,1 12493,0 12522,1 12559,0 12616,1 12660,0 12676,1 12757,0 12828,1 12891,0 12941,1 13020,0 13096,1 13126,0 13163,1 13230,0 13276,1 13357,0 13387,1 13429,0 13487,1 13508,0 13573,1 13633,0 13723,1 13771,0 13810,1 13837,0 13847,1 13870,0 13905,1 13967,0 13976,1 14000,0 14027,1 14063,0 14074,1 14119,0 14122,1 14135,0 14228,1 14240,0 14246,1 14288,0 14306,1 14364,0 14379,1 14389,0 14473,1 14502,0 14561,1 14593,0 14638,1 14645,0 14698,1 14796,0 14862,1 14876,0 14927,1 14928,0 14944,1 14959,0 15026,1 15048,0 15089,1 15186,0 15276,1 15354,0 15402,1 15419,0 15467,1 15567,0 15600,1 15624,0 15650,1 15660,0 15702,1 15791,0 15876,1 15903,0 15953,1 15988,0 16067,1 16164,0 16167,1 16264,0 16298,1 16332,0 16400,1 16417,0 16453,1 16487,0 16533,1 16602,0 16676,1 16752,0 16851,1 16884,0 16908,1 16999,0 17034,1 17134,0 17217,1 17250,0 17267,1 17341,0 17364,1 17384,0 17411,1 17469,0 17478,1 17532,0 17616,1 17686,0 17773,1 17864,0 17946,1 18037,0 18099,1 18131,0 18139,1 18177,0 18202,1 18276,0 18365,1 18440,0 18474,1 18477,0 18521,1 18549,0 18601,1 18648,0 18669,1 18695,0 18727,1 18769,0 18846,1 18880,0 18979,1 18996,0 19031,1 19109,0 19158,1 19231,0 19253,1 19277,0 19356,1 19443,0 19476,1 19572,0 19632,1 19667,0 19734,1 19812,0 19853,1 19915,0 19937,1 20037,0 20076,1 20124,0 20189,1 20190,0 20218,1 20313,0 20396,1 20420,0 20500,1 20526,0 20591,1 20602,0 20664,1 20728,0 20758,1 20843,0 20866,1 20877,0 20879,1 20905,0 20998,1 21081,0 21132,1 21164,0 21204,1 21302,0 21383,1 21424,0 21497,1 21533,0 21560,1 21634,0 21677,1 21724,0 21774,1 21775,0 21834,1 21891,0 21929,1 21952,0 21959,1 21967,0 22054,1 22139,0 22154,1 22203,0 22247,1 22320,0 22328,1 22423,0 22475,1 22543,0 22610,1 22614,0 22644,1 22680,0 22710,1 22790,0 22864,1 22896,0 22926,1 22967,0 23034,1 23130,0 23205,1 23213,0 23257,1 23323,0 23390,1 23440,0 23536,1 23616,0 23684,1 23750,0 23840,1 23922,0 23965,1 23981,0 24011,1 24093,0 24122,1 24199,0 24291,1 24383,0 24456,1 24514,0 24577,1 24614,0 24668,1 24702,0 24770,1 24793,0 24825,1 24925,0 24997,1 25013,0 25091,1 25106,0 25167,1 25213,0 25274,1 25356,0 25431,1 25439,0 25476,1 25478,0 25536,1 25586,0 25657,1 25744,0 25799,1 25896,0 25898,1 25922,0 25926,1 26006,0 26084,1 26165,0 26210,1 26249,0 26268,1 26322,0 26346,1 26393,0 26488,1 26585,0 26587,1 26638,0 26642,1 26734,0 26815,1 26887,0 26933,1 26999,0 27050,1 27085,0 27181,1 27259,0 27323,1 27397,0 27424,1 27441,0 27520,1 27597,0 27653,1 27732,0 27768,1 27770,0 27847,1 27882,0 27912,1 27986,0 28041,1 28067,0 28137,1 28184,0 28224,1 28239,0 28255,1 28316,0 28352,1 28443,0 28451,1 28548,0 28589,1 28600,0 28685,1 28741,0 28834,1 28923,0 28956,1 29039,0 29110,1 29142,0 29221,1 29228,0 29235,1 29306,0 29364,1 29432,0 29479,1 29481,0 29571,1 29633,0 29693,1 29722,0 29783,1 29841,0 29937,1 30029,0 30031,1 30099,0 30172,1 30206,0 30214,1 30286,0 30322,1 30355,0 30430,1 30443,0 30478,1 30490,0 30555,1 30563,0 30597,1 30600,0 30659,1 30740,0 30762,1 30785,0 30840,1 30883,0 30964,1 30991,0 31011,1 31043,0 31044,1 31086,0 31111,1 31162,0 31204,1 31228,0 31261,1 31293,0 31329,1 31416,0 31516,1 31522,0 31582,1 31618,0 31703,1 31778,0 31839,1 31920,0 31978,1 32007,0 32025,1 32035,0 32037,1 32137,0 32164,1 32250,0 32334,1 32392,0 32431,1 32480,0 32536,1 32601,0 32624,1 32628,0 32661,1 32755,0 32782,1 32875,0 32949,1 33019,0 33056,1 33139,0 33187,1 33243,0 33326,1 33346,0 33446,1 33497,0 33541,1 33583,0 33584,1 33654,0 33659,1 33689,0 33695,1 33705,0 33707,1 33783,0 33830,1 33919,0 33998,1 34094,0 34129,1 34217,0 34223,1 34302,0 34366,1 34455,0 34485,1 34526,0 34543,1 34582,0 34651,1 34728,0 34812,1 34904,0 34937,1 34992,0 35057,1 35143,0 35215,1 35256,0 35321,1 35400,0 35432,1 35450,0 35517,1 35565,0 35589,1 35637,0 35682,1 35718,0 35723,1 35782,0 35841,1 35933,0 35968,1 36040,0 36136,1 36161,0 36172,1 36236,0 36304,1 36349,0 36411,1 36461,0 36507,1 36515,0 36562,1 36650,0 36688,1 36690,0 36755,1 36839,0 36896,1 36965,0 37038,1 37059,0 37104,1 37136,0 37140,1 37198,0 37241,1 37302,0 37399,1 37427,0 37446,1 37453,0 37471,1 37518,0 37602,1 37698,0 37790,1 37850,0 37909,1 37944,0 38001,1 38050,0 38091,1 38191,0 38222,1 38230,0 38263,1 38289,0 38350,1 38376,0 38456,1 38488,0 38572,1 38647,0 38721,1 38776,0 38835,1 38910,0 38924,1 38954,0 39014,1 39030,0 39036,1 39124,0 39140,1 39146,0 39211,1 39255,0 39281,1 39367,0 39382,1 39386,0 39437,1 39511,0 39534,1 39618,0 39680,1 39724,0 39803,1 39852,0 39896,1 39942,0 39999,1 40018,0 40082,1 40122,0 40179,1 40213,0 40297,1 40369,0 40465,1 40479,0 40523,1 40558,0 40648,1 40718,0 40737,1 40801,0 40855,1 40925,0 40928,1 41010,0 41052,1 41142,0 41191,1 41284,0 41286,1 41381,0 41478,1 41511,0 41578,1 41662,0 41708,1 41748,0 41802,1 41895,0 41960,1 41976,0 41984,1 42028,0 42094,1 42162,0 42189,1 42287,0 42380,1 42446,0 42535,1 42566,0 42606,1 42687,0 42754,1 42816,0 42861,1 42955,0 43035,1 43112,0 43212,1 43230,0 43285,1 43300,0 43321,1 43326,0 43340,1 43388,0 43463,1 43563,0 43632,1 43678,0 43706,1 43800,0 43870,1 43893,0 43975,1 44028,0 44120,1 44163,0 44233,1 44314,0 44409,1 44429,0 44478,1 44572,0 44605,1 44698,0 44728,1 44797,0 44859,1 44954,0 44988,1 45087,0 45174,1 45255,0 45258,1 45308,0 45319,1 45369,0 45404,1 45424,0 45448,1 45541,0 45612,1 45709,0 45800,1 45861,0 45913,1 45977,0 46029,1 46087,0 46180,1 46235,0 46238,1 46336,0 46361,1 46372,0 46407,1 46444,0 46455,1 46503,0 46553,1 46578,0 46656,1 46741,0 46818,1 46852,0 46944,1 47041,0 47131,1 47227,0 47292,1 47370,0 47389,1 47410,0 47501,1 47551,0 47624,1 47670,0 47746,1 47787,0 47871,1 47895,0 47959,1 47992,0 48081,1 48120,0 48176,1 48271,0 48303,1 48364,0 48429,1 48456,0 48531,1 48623,0 48707,1 48804,0 48883,1 48921,0 48940,1 49010,0 49091,1 49092,0 49154,1 49202,0 49294,1 49324,0 49348,1 49384,0 49449,1 49461,0 49477,1 49509,0 49601,1 49634,0 49638,1 49730,0 49822,1 49871,0 49917,1 49932,0 49954,1 49978,0 50009,1 50033,0 50077,1 50157,0 50185,1 50253,0 50266,1 50302,0 50349,1 50420,0 50500,1 end initlist b57 0,0 26,1 62,0 155,1 192,0 207,1 234,0 322,1 378,0 411,1 483,0 567,1 618,0 689,1 761,0 803,1 849,0 892,1 968,0 1062,1 1143,0 1200,1 1284,0 1291,1 1359,0 1380,1 1400,0 1405,1 1411,0 1502,1 1516,0 1541,1 1549,0 1554,1 1593,0 1675,1 1708,0 1753,1 1758,0 1827,1 1915,0 1937,1 2035,0 2116,1 2119,0 2142,1 2149,0 2190,1 2205,0 2244,1 2317,0 2326,1 2364,0 2416,1 2512,0 2544,1 2587,0 2598,1 2692,0 2702,1 2730,0 2782,1 2814,0 2869,1 2954,0 2975,1 3010,0 3098,1 3125,0 3209,1 3275,0 3350,1 3428,0 3502,1 3515,0 3579,1 3669,0 3689,1 3728,0 3767,1 3850,0 3861,1 3890,0 3988,1 4022,0 4053,1 4084,0 4122,1 4179,0 4180,1 4280,0 4298,1 4367,0 4371,1 4451,0 4479,1 4572,0 4622,1 4659,0 4675,1 4704,0 4714,1 4737,0 4778,1 4844,0 4860,1 4912,0 5012,1 5057,0 5060,1 5087,0 5120,1 5160,0 5218,1 5249,0 5269,1 5282,0 5305,1 5334,0 5391,1 5443,0 5456,1 5535,0 5540,1 5554,0 5608,1 5656,0 5676,1 5733,0 5795,1 5881,0 5887,1 5949,0 6022,1 6040,0 6101,1 6157,0 6165,1 6177,0 6219,1 6237,0 6278,1 6352,0 6416,1 6439,0 6471,1 6515,0 6531,1 6628,0 6647,1 6672,0 6750,1 6758,0 6791,1 6833,0 6842,1 6914,0 7005,1 7085,0 7141,1 7143,0 7242,1 7341,0 7408,1 7434,0 7486,1 7488,0 7502,1 7505,0 7537,1 7578,0 7597,1 7653,0 7703,1 7761,0 7768,1 7829,0 7916,1 8010,0 8038,1 8129,0 8168,1 8223,0 8251,1 8335,0 8359,1 8382,0 8397,1 8484,0 8569,1 8632,0 8707,1 8757,0 8850,1 8907,0 8997,1 9004,0 9056,1 9082,0 9086,1 9164,0 9214,1 9228,0 9265,1 9281,0 9357,1 9403,0 9421,1 9491,0 9571,1 9586,0 9602,1 9679,0 9756,1 9851,0 9951,1 10032,0 10056,1 10111,0 10172,1 10173,0 10235,1 10256,0 10313,1 10386,0 10460,1 10525,0 10609,1 10625,0 10721,1 10818,0 10821,1 10904,0 10952,1 11014,0 11111,1 11157,0 11239,1 11261,0 11332,1 11378,0 11470,1 11562,0 11595,1 11631,0 11685,1 11779,0 11789,1 11856,0 11917,1 11919,0 11929,1 11947,0 11960,1 12009,0 12098,1 12192,0 12207,1 12258,0 12358,1 12418,0 12485,1 12526,0 12543,1 12590,0 12626,1 12706,0 12733,1 12816,0 12908,1 13008,0 13050,1 13069,0 13081,1 13150,0 13151,1 13208,0 13257,1 13291,0 13382,1 13390,0 13435,1 13452,0 13480,1 13485,0 13572,1 13627,0 13710,1 13763,0 13824,1 13857,0 13935,1 13980,0 14014,1 14046,0 14085,1 14153,0 14201,1 14292,0 14327,1 14352,0 14392,1 14442,0 14537,1 14538,0 14567,1 14619,0 14661,1 14738,0 14784,1 14870,0 14889,1 14970,0 15059,1 15122,0 15165,1 15258,0 15267,1 15311,0 15348,1 15446,0 15449,1 15478,0 15545,1 15566,0 15597,1 15624,0 15668,1 15710,0 15802,1 15896,0 15966,1 15991,0 16066,1 16068,0 16080,1 16167,0 16260,1 16334,0 16346,1 16348,0 16399,1 16489,0 16571,1 16653,0 16655,1 16710,0 16720,1 16742,0 16831,1 16835,0 16884,1 16948,0 16984,1 17022,0 17109,1 17154,0 17176,1 17244,0 17298,1 17328,0 17329,1 17386,0 17399,1 17449,0 17528,1 17609,0 17630,1 17693,0 17778,1 17839,0 17926,1 17995,0 18019,1 18055,0 18123,1 18138,0 18146,1 18216,0 18257,1 18342,0 18393,1 18432,0 18500,1 18568,0 18620,1 18673,0 18730,1 18824,0 18846,1 18934,0 18991,1 19007,0 19040,1 19044,0 19103,1 19169,0 19202,1 19204,0 19277,1 19341,0 19389,1 19446,0 19503,1 19583,0 19670,1 19737,0 19744,1 19827,0 19869,1 19938,0 20000,1 20013,0 20071,1 20076,0 20089,1 20176,0 20203,1 20263,0 20321,1 20414,0 20510,1 20597,0 20688,1 20690,0 20761,1 20802,0 20854,1 20948,0 21044,1 21045,0 21053,1 21078,0 21116,1 21168,0 21235,1 21316,0 21363,1 21444,0 21475,1 21527,0 21597,1 21690,0 21712,1 21773,0 21828,1 21915,0 21920,1 21982,0 22023,1 22078,0 22152,1 22251,0 22272,1 22287,0 22366,1 22466,0 22546,1 22624,0 22717,1 22799,0 22834,1 22866,0 22951,1 23051,0 23082,1 23144,0 23211,1 23226,0 23313,1 23374,0 23454,1 23478,0 23560,1 23630,0 23657,1 23692,0 23790,1 23875,0 23964,1 24040,0 24130,1 24187,0 24244,1 24336,0 24357,1 24370,0 24410,1 24464,0 24516,1 24609,0 24614,1 24665,0 24737,1 24830,0 24920,1 24989,0 25035,1 25055,0 25067,1 25080,0 25160,1 25252,0 25288,1 25366,0 25383,1 25483,0 25523,1 25538,0 25562,1 25602,0 25661,1 25725,0 25754,1 25786,0 25865,1 25888,0 25955,1 26026,0 26061,1 26116,0 26128,1 26215,0 26294,1 26356,0 26427,1 26447,0 26451,1 26459,0 26489,1 26508,0 26576,1 26643,0 26712,1 26731,0 26831,1 26853,0 26910,1 26955,0 27046,1 27076,0 27163,1 27227,0 27301,1 27395,0 27410,1 27429,0 27432,1 27508,0 27564,1 27609,0 27612,1 27710,0 27733,1 27817,0 27883,1 27936,0 27986,1 28001,0 28068,1 28114,0 28170,1 28229,0 28301,1 28334,0 28402,1 28490,0 28576,1 28591,0 28640,1 28735,0 28793,1 28810,0 28846,1 28861,0 28940,1 29022,0 29094,1 29158,0 29197,1 29281,0 29322,1 29408,0 29431,1 29459,0 29492,1 29512,0 29568,1 29663,0 29699,1 29733,0 29814,1 29909,0 29995,1 30044,0 30134,1 30160,0 30191,1 30214,0 30293,1 30388,0 30390,1 30440,0 30503,1 30544,0 30616,1 30690,0 30701,1 30777,0 30836,1 30889,0 30916,1 30967,0 31020,1 31048,0 31122,1 31140,0 31176,1 31254,0 31261,1 31283,0 31314,1 31325,0 31347,1 31407,0 31450,1 31471,0 31508,1 31546,0 31584,1 31672,0 31766,1 31848,0 31858,1 31924,0 31958,1 32054,0 32091,1 32162,0 32183,1 32257,0 32322,1 32381,0 32478,1 32513,0 32582,1 32671,0 32684,1 32733,0 32802,1 32816,0 32864,1 32942,0 32982,1 33031,0 33121,1 33140,0 33187,1 33274,0 33367,1 33412,0 33470,1 33564,0 33565,1 33649,0 33700,1 33726,0 33809,1 33867,0 33952,1 33961,0 34031,1 34046,0 34146,1 34231,0 34290,1 34332,0 34405,1 34442,0 34496,1 34514,0 34537,1 34563,0 34607,1 34648,0 34743,1 34780,0 34838,1 34930,0 34999,1 35011,0 35086,1 35134,0 35156,1 35234,0 35291,1 35369,0 35375,1 35442,0 35489,1 35530,0 35610,1 35642,0 35687,1 35785,0 35799,1 35822,0 35892,1 35965,0 36024,1 36081,0 36151,1 36194,0 36284,1 36301,0 36336,1 36392,0 36438,1 36480,0 36557,1 36626,0 36665,1 36699,0 36717,1 36806,0 36874,1 36905,0 37004,1 37102,0 37167,1 37206,0 37259,1 37340,0 37425,1 37426,0 37479,1 37556,0 37573,1 37672,0 37706,1 37788,0 37821,1 37915,0 38002,1 38004,0 38032,1 38126,0 38150,1 38203,0 38254,1 38273,0 38335,1 38375,0 38450,1 38546,0 38644,1 38659,0 38669,1 38676,0 38722,1 38812,0 38856,1 38874,0 38912,1 38946,0 39017,1 39030,0 39060,1 39144,0 39169,1 39220,0 39291,1 39384,0 39438,1 39531,0 39537,1 39606,0 39662,1 39733,0 39788,1 39864,0 39892,1 39898,0 39939,1 40010,0 40077,1 40107,0 40177,1 40186,0 40255,1 40321,0 40381,1 40467,0 40555,1 40603,0 40697,1 40708,0 40730,1 40748,0 40779,1 40812,0 40910,1 40994,0 41022,1 41042,0 41116,1 41125,0 41144,1 41223,0 41292,1 41296,0 41330,1 41414,0 41423,1 41452,0 41545,1 41636,0 41722,1 41763,0 41815,1 41882,0 41909,1 41919,0 41940,1 41970,0 42065,1 42103,0 42179,1 42184,0 42238,1 42327,0 42356,1 42395,0 42416,1 42468,0 42523,1 42576,0 42594,1 42621,0 42671,1 42761,0 42849,1 42873,0 42905,1 42984,0 43040,1 43135,0 43168,1 43188,0 43227,1 43284,0 43301,1 43348,0 43398,1 43445,0 43500,1 43535,0 43553,1 43646,0 43671,1 43743,0 43776,1 43862,0 43863,1 43891,0 43957,1 43983,0 44002,1 44050,0 44109,1 44150,0 44236,1 44322,0 44341,1 44352,0 44394,1 44487,0 44565,1 44660,0 44759,1 44770,0 44823,1 44899,0 44935,1 45000,0 45031,1 45082,0 45159,1 45250,0 45338,1 45433,0 45491,1 45496,0 45508,1 45583,0 45612,1 45677,0 45769,1 45857,0 45948,1 46021,0 46062,1 46109,0 46155,1 46214,0 46276,1 46338,0 46357,1 46365,0 46372,1 46465,0 46547,1 46581,0 46595,1 46661,0 46683,1 46741,0 46838,1 46886,0 46979,1 47071,0 47087,1 47102,0 47175,1 47224,0 47279,1 47319,0 47388,1 47450,0 47489,1 47496,0 47564,1 47629,0 47717,1 47809,0 47832,1 47877,0 47893,1 47991,0 48052,1 48093,0 48179,1 48208,0 48263,1 48330,0 48345,1 48427,0 48463,1 48560,0 48602,1 48698,0 48707,1 48739,0 48760,1 48845,0 48868,1 48886,0 48980,1 49026,0 49079,1 49093,0 49148,1 49193,0 49256,1 49305,0 49373,1 49418,0 49497,1 49534,0 49570,1 49641,0 49723,1 49768,0 49769,1 49772,0 49820,1 49857,0 49935,1 49957,0 50047,1 50114,0 50140,1 50240,0 50244,1 50251,0 50281,1 50374,0 50375,1 50430,0 50495,1 50594,0 50648,1 50656,0 50665,1 50706,0 50740,1 50796,0 50840,1 50857,0 50860,1 50902,0 50996,1 end initlist b58 0,0 1,1 31,0 123,1 157,0 236,1 262,0 328,1 409,0 413,1 414,0 506,1 597,0 606,1 612,0 701,1 705,0 744,1 840,0 925,1 1001,0 1064,1 1143,0 1205,1 1257,0 1285,1 1371,0 1377,1 1442,0 1443,1 1467,0 1498,1 1587,0 1609,1 1700,0 1768,1 1828,0 1894,1 1994,0 2058,1 2103,0 2188,1 2243,0 2282,1 2332,0 2386,1 2424,0 2433,1 2479,0 2494,1 2559,0 2582,1 2635,0 2696,1 2725,0 2768,1 2816,0 2844,1 2846,0 2944,1 3008,0 3075,1 3169,0 3191,1 3239,0 3292,1 3327,0 3365,1 3426,0 3443,1 3500,0 3528,1 3574,0 3665,1 3688,0 3742,1 3836,0 3907,1 3971,0 3978,1 4000,0 4048,1 4110,0 4173,1 4204,0 4246,1 4331,0 4336,1 4402,0 4481,1 4537,0 4596,1 4686,0 4763,1 4779,0 4840,1 4937,0 5015,1 5068,0 5107,1 5199,0 5207,1 5221,0 5312,1 5387,0 5393,1 5469,0 5553,1 5620,0 5678,1 5778,0 5876,1 5945,0 6009,1 6106,0 6133,1 6140,0 6170,1 6239,0 6253,1 6291,0 6330,1 6377,0 6474,1 6509,0 6561,1 6610,0 6638,1 6649,0 6707,1 6747,0 6788,1 6838,0 6875,1 6963,0 7039,1 7065,0 7120,1 7179,0 7209,1 7268,0 7293,1 7328,0 7426,1 7451,0 7468,1 7520,0 7619,1 7661,0 7699,1 7718,0 7807,1 7874,0 7896,1 7917,0 7934,1 7943,0 7995,1 8047,0 8097,1 8127,0 8161,1 8218,0 8237,1 8244,0 8343,1 8345,0 8440,1 8472,0 8528,1 8595,0 8679,1 8751,0 8821,1 8826,0 8897,1 8922,0 8959,1 8971,0 8987,1 9019,0 9084,1 9127,0 9154,1 9178,0 9196,1 9211,0 9253,1 9262,0 9290,1 9304,0 9347,1 9413,0 9500,1 9552,0 9564,1 9607,0 9693,1 9786,0 9844,1 9867,0 9930,1 10002,0 10101,1 10104,0 10155,1 10244,0 10274,1 10317,0 10362,1 10430,0 10470,1 10492,0 10548,1 10642,0 10696,1 10771,0 10805,1 10885,0 10980,1 11005,0 11074,1 11088,0 11129,1 11197,0 11269,1 11321,0 11414,1 11457,0 11512,1 11576,0 11605,1 11654,0 11730,1 11784,0 11826,1 11922,0 12011,1 12063,0 12128,1 12213,0 12299,1 12333,0 12422,1 12514,0 12566,1 12582,0 12635,1 12636,0 12657,1 12693,0 12781,1 12832,0 12852,1 12920,0 12995,1 13073,0 13078,1 13089,0 13098,1 13191,0 13216,1 13257,0 13343,1 13349,0 13396,1 13487,0 13568,1 13580,0 13638,1 13646,0 13675,1 13704,0 13733,1 13758,0 13814,1 13891,0 13981,1 13992,0 14007,1 14063,0 14096,1 14099,0 14166,1 14198,0 14210,1 14224,0 14257,1 14308,0 14354,1 14398,0 14441,1 14478,0 14526,1 14590,0 14621,1 14656,0 14705,1 14752,0 14809,1 14880,0 14894,1 14929,0 14963,1 14984,0 15068,1 15126,0 15206,1 15281,0 15285,1 15369,0 15441,1 15454,0 15517,1 15575,0 15642,1 15651,0 15701,1 15778,0 15837,1 15893,0 15906,1 16004,0 16058,1 16096,0 16098,1 16188,0 16195,1 16223,0 16267,1 16278,0 16360,1 16371,0 16377,1 16381,0 16401,1 16419,0 16509,1 16527,0 16530,1 16607,0 16685,1 16686,0 16742,1 16785,0 16791,1 16869,0 16897,1 16901,0 16913,1 16985,0 17034,1 17084,0 17182,1 17206,0 17231,1 17331,0 17385,1 17417,0 17474,1 17571,0 17578,1 17626,0 17657,1 17673,0 17701,1 17770,0 17806,1 17888,0 17902,1 17933,0 18015,1 18101,0 18188,1 18220,0 18250,1 18339,0 18348,1 18351,0 18365,1 18370,0 18381,1 18469,0 18549,1 18582,0 18604,1 18680,0 18770,1 18863,0 18923,1 19022,0 19119,1 19179,0 19238,1 19336,0 19390,1 19457,0 19510,1 19570,0 19652,1 19674,0 19702,1 19721,0 19814,1 19879,0 19977,1 20076,0 20133,1 20206,0 20251,1 20335,0 20429,1 20523,0 20593,1 20606,0 20635,1 20699,0 20783,1 20800,0 20881,1 20915,0 20934,1 21022,0 21055,1 21142,0 21191,1 21268,0 21356,1 21408,0 21413,1 21460,0 21526,1 21622,0 21712,1 21766,0 21848,1 21912,0 21976,1 21993,0 22024,1 22117,0 22191,1 22247,0 22277,1 22338,0 22390,1 22426,0 22459,1 22535,0 22585,1 22636,0 22681,1 22760,0 22829,1 22894,0 22974,1 23029,0 23079,1 23118,0 23202,1 23215,0 23237,1 23336,0 23367,1 23411,0 23415,1 23509,0 23515,1 23600,0 23670,1 23706,0 23753,1 23811,0 23835,1 23924,0 23945,1 24019,0 24030,1 24121,0 24161,1 24198,0 24238,1 24296,0 24375,1 24441,0 24490,1 24589,0 24628,1 24705,0 24803,1 24831,0 24863,1 24902,0 24946,1 24964,0 25056,1 25154,0 25246,1 25264,0 25295,1 25316,0 25389,1 25463,0 25507,1 25516,0 25577,1 25647,0 25709,1 25745,0 25839,1 25918,0 26013,1 26032,0 26081,1 26142,0 26180,1 26248,0 26328,1 26419,0 26487,1 26519,0 26565,1 26567,0 26576,1 26578,0 26580,1 26652,0 26687,1 26702,0 26739,1 26785,0 26799,1 26834,0 26933,1 26993,0 27065,1 27146,0 27233,1 27299,0 27350,1 27437,0 27498,1 27532,0 27552,1 27561,0 27628,1 27718,0 27786,1 27792,0 27824,1 27875,0 27887,1 27950,0 28020,1 28062,0 28080,1 28121,0 28149,1 28243,0 28279,1 28363,0 28400,1 28457,0 28495,1 28506,0 28532,1 28586,0 28629,1 28675,0 28687,1 28693,0 28706,1 28707,0 28774,1 28836,0 28866,1 28892,0 28935,1 29021,0 29119,1 29176,0 29179,1 29251,0 29283,1 29373,0 29452,1 29481,0 29534,1 29615,0 29680,1 29763,0 29805,1 29867,0 29904,1 29991,0 30030,1 30076,0 30109,1 30194,0 30294,1 30301,0 30369,1 30419,0 30498,1 30527,0 30576,1 30600,0 30642,1 30727,0 30763,1 30854,0 30922,1 30956,0 31034,1 31087,0 31169,1 31251,0 31333,1 31348,0 31404,1 31417,0 31421,1 31498,0 31562,1 31647,0 31715,1 31747,0 31830,1 31848,0 31878,1 31951,0 32021,1 32087,0 32178,1 32264,0 32336,1 32368,0 32447,1 32547,0 32565,1 32631,0 32641,1 32729,0 32742,1 32803,0 32816,1 32829,0 32925,1 32969,0 33023,1 33075,0 33169,1 33261,0 33274,1 33297,0 33337,1 33436,0 33495,1 33523,0 33554,1 33642,0 33693,1 33750,0 33793,1 33828,0 33867,1 33967,0 34018,1 34079,0 34111,1 34200,0 34204,1 34234,0 34261,1 34285,0 34363,1 34374,0 34462,1 34524,0 34544,1 34610,0 34681,1 34705,0 34741,1 34754,0 34851,1 34867,0 34875,1 34949,0 35018,1 35054,0 35114,1 35193,0 35230,1 35236,0 35258,1 35299,0 35392,1 35474,0 35543,1 35573,0 35576,1 35669,0 35674,1 35706,0 35779,1 35854,0 35856,1 35900,0 35985,1 36047,0 36100,1 36187,0 36218,1 36250,0 36299,1 36396,0 36446,1 36489,0 36533,1 36570,0 36648,1 36748,0 36819,1 36915,0 36988,1 37039,0 37048,1 37107,0 37185,1 37188,0 37270,1 37305,0 37356,1 37388,0 37435,1 37529,0 37617,1 37627,0 37641,1 37653,0 37698,1 37735,0 37763,1 37781,0 37829,1 37911,0 37993,1 38040,0 38079,1 38166,0 38183,1 38270,0 38278,1 38301,0 38348,1 38366,0 38386,1 38471,0 38531,1 38567,0 38642,1 38667,0 38733,1 38798,0 38888,1 38944,0 39028,1 39095,0 39122,1 39205,0 39220,1 39279,0 39321,1 39402,0 39414,1 39492,0 39532,1 39558,0 39647,1 39678,0 39754,1 39798,0 39803,1 39831,0 39929,1 40029,0 40033,1 40060,0 40159,1 40250,0 40324,1 40385,0 40444,1 40536,0 40538,1 40594,0 40598,1 40674,0 40765,1 40819,0 40839,1 40869,0 40935,1 41023,0 41057,1 41070,0 41109,1 41112,0 41185,1 41198,0 41223,1 41247,0 41274,1 41369,0 41395,1 41477,0 41482,1 41554,0 41647,1 41664,0 41735,1 41773,0 41824,1 41834,0 41846,1 41885,0 41942,1 41986,0 41998,1 42086,0 42181,1 42205,0 42284,1 42378,0 42434,1 42460,0 42499,1 42530,0 42593,1 42644,0 42663,1 42742,0 42823,1 42899,0 42906,1 42999,0 43038,1 43067,0 43141,1 43193,0 43283,1 43319,0 43387,1 43485,0 43570,1 43606,0 43682,1 43776,0 43804,1 43864,0 43916,1 43952,0 43954,1 44041,0 44127,1 44179,0 44266,1 44317,0 44399,1 44405,0 44453,1 44537,0 44592,1 44650,0 44654,1 44702,0 44711,1 44716,0 44766,1 44780,0 44798,1 44856,0 44895,1 44902,0 44925,1 44969,0 44995,1 45044,0 45121,1 45218,0 45219,1 45231,0 45254,1 45304,0 45359,1 45414,0 45446,1 45518,0 45548,1 45574,0 45642,1 45727,0 45799,1 45853,0 45932,1 45967,0 46012,1 46075,0 46099,1 46168,0 46260,1 46352,0 46424,1 46437,0 46521,1 46605,0 46650,1 46708,0 46787,1 46815,0 46901,1 46905,0 46959,1 46983,0 47025,1 47050,0 47137,1 47204,0 47250,1 47325,0 47328,1 47411,0 47440,1 47473,0 47545,1 47606,0 47681,1 47685,0 47780,1 47812,0 47904,1 47905,0 47915,1 47950,0 48012,1 48078,0 48134,1 48219,0 48318,1 48337,0 48407,1 48430,0 48484,1 48497,0 48580,1 48642,0 48695,1 48778,0 48789,1 48799,0 48868,1 48892,0 48909,1 48935,0 49024,1 49097,0 49197,1 49208,0 49296,1 49379,0 49430,1 49527,0 49570,1 49597,0 49618,1 49696,0 49739,1 49818,0 49861,1 49923,0 49954,1 49968,0 50010,1 50110,0 50189,1 50267,0 50343,1 50442,0 50504,1 50573,0 50574,1 50660,0 50677,1 50689,0 50736,1 50811,0 50826,1 50901,0 50928,1 50978,0 51021,1 end initlist b59 0,0 33,1 96,0 134,1 206,0 265,1 343,0 369,1 421,0 441,1 457,0 508,1 599,0 618,1 651,0 716,1 776,0 820,1 917,0 1005,1 1023,0 1060,1 1073,0 1155,1 1242,0 1332,1 1401,0 1429,1 1510,0 1551,1 1597,0 1602,1 1689,0 1711,1 1735,0 1744,1 1750,0 1842,1 1847,0 1946,1 1976,0 2014,1 2065,0 2114,1 2119,0 2215,1 2289,0 2320,1 2388,0 2448,1 2481,0 2545,1 2561,0 2622,1 2715,0 2812,1 2871,0 2955,1 2977,0 3057,1 3064,0 3104,1 3139,0 3224,1 3291,0 3296,1 3328,0 3363,1 3460,0 3516,1 3561,0 3606,1 3670,0 3709,1 3792,0 3873,1 3924,0 4001,1 4068,0 4142,1 4153,0 4182,1 4229,0 4280,1 4341,0 4380,1 4405,0 4462,1 4499,0 4553,1 4588,0 4626,1 4654,0 4693,1 4707,0 4805,1 4833,0 4880,1 4972,0 5003,1 5013,0 5089,1 5164,0 5245,1 5338,0 5375,1 5452,0 5542,1 5619,0 5675,1 5768,0 5794,1 5809,0 5833,1 5915,0 5923,1 5953,0 5983,1 6054,0 6145,1 6229,0 6275,1 6359,0 6365,1 6396,0 6474,1 6531,0 6566,1 6623,0 6681,1 6776,0 6868,1 6913,0 7011,1 7036,0 7044,1 7076,0 7094,1 7120,0 7135,1 7157,0 7218,1 7308,0 7359,1 7458,0 7504,1 7591,0 7664,1 7682,0 7756,1 7802,0 7803,1 7902,0 7983,1 7991,0 8058,1 8078,0 8121,1 8129,0 8187,1 8223,0 8294,1 8335,0 8432,1 8477,0 8495,1 8573,0 8626,1 8692,0 8763,1 8817,0 8915,1 8998,0 9043,1 9106,0 9173,1 9242,0 9291,1 9379,0 9422,1 9495,0 9542,1 9631,0 9718,1 9807,0 9847,1 9903,0 9926,1 9974,0 10069,1 10115,0 10175,1 10224,0 10261,1 10293,0 10382,1 10420,0 10496,1 10566,0 10654,1 10713,0 10748,1 10812,0 10884,1 10968,0 11022,1 11092,0 11142,1 11241,0 11340,1 11415,0 11474,1 11481,0 11581,1 11647,0 11716,1 11795,0 11878,1 11976,0 12027,1 12111,0 12195,1 12247,0 12276,1 12371,0 12432,1 12442,0 12511,1 12581,0 12637,1 12698,0 12764,1 12797,0 12806,1 12887,0 12972,1 13061,0 13068,1 13104,0 13182,1 13220,0 13234,1 13280,0 13308,1 13321,0 13360,1 13428,0 13487,1 13507,0 13575,1 13635,0 13733,1 13775,0 13792,1 13823,0 13905,1 13960,0 14009,1 14077,0 14136,1 14207,0 14254,1 14273,0 14319,1 14382,0 14465,1 14501,0 14598,1 14622,0 14685,1 14725,0 14787,1 14788,0 14813,1 14868,0 14908,1 14950,0 15029,1 15072,0 15109,1 15141,0 15144,1 15173,0 15174,1 15215,0 15235,1 15265,0 15276,1 15341,0 15347,1 15350,0 15438,1 15445,0 15460,1 15533,0 15562,1 15597,0 15628,1 15684,0 15702,1 15735,0 15831,1 15865,0 15882,1 15967,0 15990,1 16016,0 16047,1 16141,0 16185,1 16214,0 16291,1 16343,0 16435,1 16515,0 16568,1 16607,0 16662,1 16680,0 16766,1 16808,0 16847,1 16892,0 16937,1 17009,0 17043,1 17113,0 17195,1 17232,0 17256,1 17343,0 17364,1 17409,0 17463,1 17498,0 17515,1 17585,0 17615,1 17682,0 17723,1 17794,0 17837,1 17844,0 17908,1 17917,0 17944,1 18011,0 18087,1 18172,0 18194,1 18249,0 18327,1 18344,0 18352,1 18378,0 18427,1 18489,0 18515,1 18523,0 18599,1 18694,0 18698,1 18723,0 18815,1 18898,0 18926,1 18971,0 19065,1 19110,0 19159,1 19204,0 19216,1 19253,0 19338,1 19402,0 19482,1 19486,0 19547,1 19594,0 19650,1 19701,0 19718,1 19745,0 19787,1 19814,0 19907,1 19932,0 20026,1 20112,0 20173,1 20249,0 20260,1 20307,0 20382,1 20468,0 20525,1 20603,0 20610,1 20662,0 20679,1 20700,0 20746,1 20821,0 20902,1 20947,0 21024,1 21108,0 21180,1 21208,0 21236,1 21298,0 21377,1 21462,0 21548,1 21615,0 21626,1 21726,0 21823,1 21875,0 21879,1 21948,0 22016,1 22076,0 22131,1 22203,0 22271,1 22340,0 22381,1 22405,0 22450,1 22499,0 22516,1 22583,0 22590,1 22648,0 22673,1 22741,0 22803,1 22829,0 22906,1 22975,0 23032,1 23082,0 23110,1 23150,0 23176,1 23220,0 23277,1 23285,0 23354,1 23368,0 23436,1 23518,0 23523,1 23590,0 23657,1 23700,0 23708,1 23781,0 23795,1 23835,0 23837,1 23877,0 23969,1 24001,0 24022,1 24053,0 24140,1 24142,0 24174,1 24228,0 24283,1 24355,0 24375,1 24399,0 24480,1 24502,0 24581,1 24625,0 24686,1 24707,0 24777,1 24789,0 24875,1 24940,0 24977,1 24984,0 25026,1 25068,0 25129,1 25131,0 25192,1 25264,0 25277,1 25342,0 25399,1 25489,0 25540,1 25620,0 25676,1 25744,0 25829,1 25870,0 25929,1 26007,0 26082,1 26152,0 26227,1 26244,0 26323,1 26327,0 26374,1 26385,0 26432,1 26452,0 26537,1 26623,0 26699,1 26794,0 26824,1 26825,0 26912,1 26932,0 26972,1 26976,0 26998,1 27007,0 27085,1 27158,0 27181,1 27233,0 27273,1 27359,0 27419,1 27445,0 27461,1 27477,0 27527,1 27549,0 27615,1 27654,0 27748,1 27801,0 27834,1 27901,0 27960,1 27964,0 28023,1 28104,0 28138,1 28156,0 28241,1 28242,0 28304,1 28305,0 28372,1 28379,0 28422,1 28452,0 28495,1 28524,0 28622,1 28655,0 28732,1 28785,0 28798,1 28849,0 28901,1 28983,0 29002,1 29047,0 29101,1 29154,0 29171,1 29267,0 29305,1 29370,0 29379,1 29397,0 29473,1 29513,0 29537,1 29546,0 29627,1 29720,0 29740,1 29764,0 29852,1 29949,0 30041,1 30113,0 30137,1 30199,0 30274,1 30304,0 30352,1 30437,0 30510,1 30552,0 30574,1 30639,0 30652,1 30657,0 30666,1 30688,0 30736,1 30748,0 30754,1 30793,0 30816,1 30852,0 30950,1 31017,0 31104,1 31198,0 31262,1 31353,0 31408,1 31473,0 31547,1 31583,0 31621,1 31718,0 31796,1 31896,0 31965,1 31978,0 32006,1 32079,0 32113,1 32191,0 32278,1 32339,0 32370,1 32418,0 32475,1 32500,0 32532,1 32624,0 32715,1 32722,0 32765,1 32829,0 32909,1 32995,0 33060,1 33108,0 33180,1 33252,0 33296,1 33325,0 33333,1 33362,0 33395,1 33397,0 33423,1 33471,0 33489,1 33553,0 33589,1 33683,0 33716,1 33717,0 33809,1 33844,0 33928,1 33981,0 34051,1 34056,0 34145,1 34233,0 34291,1 34303,0 34364,1 34453,0 34537,1 34570,0 34662,1 34681,0 34764,1 34820,0 34850,1 34939,0 35035,1 35114,0 35171,1 35228,0 35313,1 35377,0 35445,1 35531,0 35555,1 35596,0 35658,1 35673,0 35768,1 35833,0 35870,1 35877,0 35894,1 35978,0 36069,1 36077,0 36123,1 36124,0 36192,1 36202,0 36259,1 36334,0 36373,1 36437,0 36475,1 36568,0 36597,1 36657,0 36719,1 36753,0 36797,1 36819,0 36894,1 36914,0 37006,1 37024,0 37092,1 37099,0 37161,1 37181,0 37280,1 37325,0 37411,1 37458,0 37475,1 37479,0 37518,1 37533,0 37572,1 37600,0 37651,1 37653,0 37689,1 37715,0 37792,1 37841,0 37929,1 37951,0 38047,1 38119,0 38197,1 38280,0 38299,1 38391,0 38463,1 38556,0 38632,1 38642,0 38733,1 38819,0 38878,1 38920,0 38948,1 39014,0 39040,1 39071,0 39120,1 39165,0 39252,1 39332,0 39337,1 39432,0 39524,1 39587,0 39606,1 39702,0 39790,1 39859,0 39877,1 39928,0 39938,1 40033,0 40101,1 40153,0 40169,1 40186,0 40230,1 40264,0 40311,1 40314,0 40407,1 40439,0 40514,1 40516,0 40527,1 40571,0 40642,1 40711,0 40784,1 40849,0 40908,1 40942,0 40991,1 40999,0 41021,1 41114,0 41170,1 41191,0 41289,1 41310,0 41409,1 41505,0 41533,1 41579,0 41630,1 41683,0 41699,1 41748,0 41775,1 41842,0 41913,1 41987,0 42003,1 42031,0 42116,1 42181,0 42188,1 42235,0 42282,1 42363,0 42368,1 42377,0 42397,1 42469,0 42493,1 42583,0 42668,1 42726,0 42730,1 42768,0 42829,1 42835,0 42844,1 42893,0 42938,1 42995,0 43057,1 43079,0 43135,1 43205,0 43295,1 43366,0 43445,1 43528,0 43538,1 43563,0 43609,1 43654,0 43698,1 43751,0 43793,1 43818,0 43912,1 43963,0 43999,1 44063,0 44121,1 44209,0 44249,1 44338,0 44349,1 44390,0 44446,1 44529,0 44614,1 44714,0 44748,1 44775,0 44783,1 44801,0 44864,1 44904,0 44940,1 45030,0 45108,1 45186,0 45223,1 45302,0 45373,1 45456,0 45547,1 45559,0 45595,1 45640,0 45704,1 45706,0 45797,1 45805,0 45846,1 45893,0 45978,1 46037,0 46094,1 46168,0 46213,1 46258,0 46303,1 46392,0 46483,1 46511,0 46608,1 46616,0 46669,1 46697,0 46786,1 46808,0 46893,1 46905,0 46974,1 47036,0 47123,1 47195,0 47244,1 47285,0 47365,1 47456,0 47515,1 47560,0 47655,1 47751,0 47784,1 47866,0 47889,1 47987,0 48014,1 48024,0 48062,1 48120,0 48165,1 48184,0 48235,1 48334,0 48345,1 48361,0 48427,1 48492,0 48517,1 48557,0 48598,1 48615,0 48657,1 48732,0 48750,1 48824,0 48899,1 48919,0 48982,1 49039,0 49078,1 49121,0 49159,1 49184,0 49207,1 49214,0 49243,1 49331,0 49375,1 49443,0 49462,1 49470,0 49567,1 49654,0 49673,1 49766,0 49818,1 49869,0 49925,1 50007,0 50092,1 50184,0 50236,1 50322,0 50407,1 50433,0 50500,1 50574,0 50594,1 50616,0 50632,1 50724,0 50821,1 50897,0 50942,1 50953,0 50964,1 51036,0 51121,1 51213,0 51235,1 51250,0 51334,1 51359,0 51388,1 51473,0 51536,1 end initlist b60 0,0 15,1 34,0 39,1 58,0 122,1 151,0 184,1 200,0 210,1 220,0 241,1 261,0 279,1 289,0 334,1 348,0 377,1 391,0 431,1 509,0 567,1 611,0 657,1 757,0 828,1 922,0 927,1 961,0 971,1 974,0 989,1 1024,0 1031,1 1107,0 1143,1 1226,0 1314,1 1390,0 1422,1 1486,0 1516,1 1602,0 1618,1 1661,0 1760,1 1788,0 1865,1 1878,0 1970,1 2007,0 2089,1 2124,0 2147,1 2222,0 2242,1 2342,0 2365,1 2417,0 2422,1 2503,0 2534,1 2608,0 2685,1 2728,0 2758,1 2798,0 2800,1 2824,0 2912,1 2996,0 3014,1 3111,0 3151,1 3212,0 3288,1 3300,0 3329,1 3379,0 3440,1 3522,0 3534,1 3537,0 3539,1 3632,0 3673,1 3751,0 3798,1 3807,0 3827,1 3887,0 3943,1 3958,0 3993,1 4010,0 4077,1 4124,0 4210,1 4267,0 4364,1 4418,0 4513,1 4530,0 4625,1 4662,0 4665,1 4744,0 4841,1 4865,0 4914,1 4991,0 5090,1 5168,0 5192,1 5267,0 5349,1 5400,0 5446,1 5521,0 5526,1 5619,0 5682,1 5769,0 5786,1 5864,0 5885,1 5959,0 6010,1 6033,0 6082,1 6094,0 6132,1 6167,0 6171,1 6218,0 6317,1 6381,0 6405,1 6445,0 6492,1 6538,0 6566,1 6588,0 6639,1 6640,0 6720,1 6754,0 6842,1 6866,0 6910,1 6942,0 6943,1 7041,0 7074,1 7080,0 7135,1 7232,0 7262,1 7351,0 7401,1 7439,0 7463,1 7474,0 7514,1 7566,0 7583,1 7634,0 7655,1 7735,0 7766,1 7817,0 7872,1 7924,0 7930,1 8021,0 8092,1 8096,0 8129,1 8206,0 8296,1 8320,0 8412,1 8471,0 8560,1 8615,0 8680,1 8695,0 8707,1 8738,0 8837,1 8899,0 8993,1 9084,0 9099,1 9106,0 9159,1 9189,0 9205,1 9242,0 9318,1 9368,0 9380,1 9407,0 9429,1 9515,0 9540,1 9563,0 9606,1 9694,0 9738,1 9804,0 9873,1 9875,0 9898,1 9984,0 10020,1 10090,0 10106,1 10130,0 10143,1 10217,0 10246,1 10316,0 10415,1 10490,0 10524,1 10623,0 10712,1 10713,0 10725,1 10791,0 10830,1 10906,0 10971,1 11052,0 11143,1 11162,0 11254,1 11276,0 11332,1 11363,0 11418,1 11516,0 11551,1 11623,0 11706,1 11743,0 11843,1 11928,0 11982,1 12047,0 12102,1 12171,0 12186,1 12219,0 12220,1 12223,0 12229,1 12291,0 12292,1 12300,0 12316,1 12320,0 12337,1 12378,0 12380,1 12445,0 12467,1 12501,0 12544,1 12588,0 12658,1 12681,0 12768,1 12782,0 12807,1 12905,0 12910,1 12986,0 13047,1 13082,0 13121,1 13190,0 13235,1 13316,0 13414,1 13447,0 13467,1 13511,0 13529,1 13596,0 13658,1 13733,0 13830,1 13903,0 13905,1 13999,0 14062,1 14154,0 14190,1 14290,0 14329,1 14412,0 14439,1 14469,0 14477,1 14509,0 14534,1 14598,0 14698,1 14764,0 14815,1 14871,0 14909,1 14969,0 14974,1 15057,0 15127,1 15206,0 15287,1 15322,0 15391,1 15417,0 15506,1 15509,0 15565,1 15588,0 15638,1 15737,0 15826,1 15846,0 15917,1 15995,0 16047,1 16057,0 16111,1 16162,0 16184,1 16202,0 16264,1 16265,0 16356,1 16442,0 16491,1 16590,0 16602,1 16627,0 16660,1 16758,0 16763,1 16793,0 16850,1 16851,0 16907,1 16923,0 16993,1 17027,0 17114,1 17127,0 17171,1 17196,0 17295,1 17309,0 17399,1 17413,0 17509,1 17515,0 17523,1 17543,0 17565,1 17649,0 17672,1 17680,0 17730,1 17795,0 17868,1 17871,0 17922,1 18014,0 18052,1 18103,0 18153,1 18209,0 18291,1 18336,0 18407,1 18454,0 18491,1 18530,0 18584,1 18594,0 18678,1 18685,0 18717,1 18779,0 18787,1 18852,0 18890,1 18946,0 18961,1 19060,0 19139,1 19163,0 19213,1 19232,0 19322,1 19399,0 19431,1 19490,0 19572,1 19662,0 19672,1 19755,0 19777,1 19845,0 19923,1 19978,0 20002,1 20094,0 20135,1 20214,0 20270,1 20359,0 20419,1 20457,0 20549,1 20631,0 20714,1 20725,0 20782,1 20810,0 20860,1 20864,0 20946,1 21015,0 21066,1 21133,0 21191,1 21240,0 21320,1 21361,0 21375,1 21394,0 21485,1 21557,0 21645,1 21718,0 21768,1 21839,0 21920,1 21991,0 22059,1 22149,0 22161,1 22226,0 22278,1 22318,0 22370,1 22443,0 22450,1 22451,0 22541,1 22561,0 22570,1 22605,0 22623,1 22717,0 22814,1 22817,0 22891,1 22925,0 22952,1 22984,0 23048,1 23141,0 23204,1 23224,0 23264,1 23276,0 23374,1 23449,0 23483,1 23583,0 23650,1 23686,0 23710,1 23728,0 23741,1 23806,0 23874,1 23932,0 24003,1 24087,0 24100,1 24196,0 24223,1 24255,0 24260,1 24292,0 24317,1 24414,0 24499,1 24592,0 24649,1 24654,0 24677,1 24777,0 24815,1 24855,0 24903,1 24912,0 24913,1 24959,0 25033,1 25109,0 25122,1 25208,0 25277,1 25322,0 25402,1 25469,0 25519,1 25596,0 25627,1 25700,0 25719,1 25789,0 25874,1 25912,0 25973,1 26016,0 26054,1 26058,0 26115,1 26157,0 26248,1 26261,0 26353,1 26385,0 26457,1 26466,0 26485,1 26497,0 26511,1 26535,0 26540,1 26589,0 26670,1 26734,0 26801,1 26816,0 26882,1 26896,0 26935,1 27004,0 27049,1 27149,0 27178,1 27183,0 27243,1 27330,0 27363,1 27460,0 27465,1 27476,0 27551,1 27567,0 27640,1 27659,0 27724,1 27761,0 27839,1 27869,0 27898,1 27946,0 27977,1 28025,0 28084,1 28102,0 28157,1 28179,0 28254,1 28303,0 28385,1 28452,0 28502,1 28601,0 28612,1 28709,0 28805,1 28848,0 28918,1 29017,0 29071,1 29171,0 29226,1 29271,0 29272,1 29357,0 29448,1 29496,0 29586,1 29621,0 29684,1 29742,0 29802,1 29859,0 29933,1 29942,0 29993,1 30008,0 30061,1 30146,0 30205,1 30302,0 30341,1 30439,0 30452,1 30535,0 30609,1 30677,0 30724,1 30777,0 30838,1 30839,0 30902,1 30944,0 31022,1 31090,0 31111,1 31206,0 31225,1 31304,0 31361,1 31416,0 31478,1 31500,0 31508,1 31558,0 31598,1 31660,0 31695,1 31712,0 31797,1 31812,0 31904,1 31947,0 32028,1 32107,0 32183,1 32232,0 32275,1 32368,0 32385,1 32404,0 32485,1 32533,0 32588,1 32678,0 32694,1 32719,0 32772,1 32839,0 32844,1 32886,0 32966,1 33014,0 33111,1 33136,0 33137,1 33185,0 33256,1 33323,0 33423,1 33462,0 33479,1 33528,0 33558,1 33570,0 33662,1 33663,0 33686,1 33687,0 33754,1 33773,0 33789,1 33818,0 33826,1 33912,0 34003,1 34096,0 34159,1 34247,0 34304,1 34308,0 34378,1 34454,0 34459,1 34462,0 34498,1 34535,0 34624,1 34661,0 34749,1 34828,0 34897,1 34957,0 35046,1 35111,0 35127,1 35227,0 35275,1 35349,0 35388,1 35411,0 35434,1 35518,0 35613,1 35633,0 35691,1 35791,0 35831,1 35877,0 35925,1 35971,0 36063,1 36130,0 36184,1 36266,0 36269,1 36321,0 36396,1 36460,0 36498,1 36505,0 36556,1 36628,0 36663,1 36697,0 36715,1 36725,0 36782,1 36882,0 36911,1 36966,0 37056,1 37132,0 37197,1 37220,0 37262,1 37278,0 37322,1 37329,0 37412,1 37462,0 37501,1 37593,0 37672,1 37740,0 37816,1 37850,0 37949,1 38027,0 38041,1 38050,0 38145,1 38155,0 38228,1 38240,0 38241,1 38267,0 38330,1 38387,0 38417,1 38485,0 38564,1 38615,0 38676,1 38717,0 38807,1 38825,0 38900,1 38926,0 38950,1 38986,0 39028,1 39073,0 39096,1 39158,0 39174,1 39184,0 39228,1 39322,0 39398,1 39498,0 39567,1 39577,0 39647,1 39745,0 39809,1 39871,0 39932,1 39967,0 40050,1 40085,0 40156,1 40223,0 40255,1 40311,0 40411,1 40469,0 40523,1 40542,0 40611,1 40641,0 40734,1 40792,0 40871,1 40904,0 40908,1 40972,0 41061,1 41120,0 41191,1 41268,0 41292,1 41369,0 41439,1 41514,0 41587,1 41673,0 41707,1 41747,0 41822,1 41867,0 41911,1 41987,0 42063,1 42125,0 42205,1 42265,0 42286,1 42289,0 42299,1 42315,0 42389,1 42415,0 42485,1 42582,0 42595,1 42664,0 42747,1 42806,0 42851,1 42915,0 42961,1 42982,0 43044,1 43123,0 43211,1 43293,0 43368,1 43453,0 43475,1 43575,0 43671,1 43732,0 43759,1 43799,0 43897,1 43990,0 44004,1 44098,0 44114,1 44180,0 44183,1 44263,0 44339,1 44413,0 44430,1 44515,0 44527,1 44582,0 44635,1 44674,0 44734,1 44736,0 44748,1 44763,0 44861,1 44936,0 44997,1 45088,0 45117,1 45184,0 45265,1 45343,0 45432,1 45505,0 45583,1 45640,0 45695,1 45783,0 45878,1 45926,0 45949,1 46017,0 46093,1 46143,0 46187,1 46273,0 46339,1 46352,0 46356,1 46443,0 46519,1 46572,0 46628,1 46699,0 46794,1 46818,0 46892,1 46990,0 47040,1 47051,0 47055,1 47059,0 47153,1 47205,0 47297,1 47304,0 47375,1 47421,0 47445,1 47510,0 47518,1 47535,0 47542,1 47620,0 47654,1 47752,0 47765,1 47791,0 47868,1 47883,0 47940,1 47959,0 48040,1 48064,0 48096,1 48110,0 48154,1 48222,0 48260,1 48280,0 48356,1 48435,0 48523,1 48551,0 48597,1 48667,0 48747,1 48846,0 48847,1 48899,0 48954,1 49031,0 49076,1 49107,0 49198,1 49263,0 49295,1 49329,0 49396,1 49444,0 49538,1 49589,0 49670,1 49738,0 49767,1 49789,0 49822,1 49911,0 49930,1 49941,0 49944,1 49947,0 49950,1 50048,0 50050,1 50121,0 50143,1 50238,0 50309,1 50371,0 50464,1 50525,0 50598,1 50628,0 50694,1 50703,0 50709,1 end initlist b61 0,0 56,1 62,0 155,1 203,0 249,1 290,0 315,1 319,0 361,1 378,0 406,1 437,0 502,1 590,0 688,1 732,0 797,1 798,0 887,1 964,0 994,1 1060,0 1071,1 1096,0 1168,1 1218,0 1247,1 1341,0 1401,1 1498,0 1591,1 1681,0 1705,1 1735,0 1790,1 1857,0 1904,1 1914,0 2008,1 2067,0 2081,1 2119,0 2170,1 2223,0 2295,1 2378,0 2472,1 2539,0 2556,1 2603,0 2696,1 2749,0 2753,1 2815,0 2864,1 2959,0 3007,1 3009,0 3100,1 3129,0 3205,1 3301,0 3308,1 3405,0 3490,1 3520,0 3574,1 3619,0 3627,1 3725,0 3749,1 3805,0 3809,1 3887,0 3920,1 3931,0 3998,1 4049,0 4130,1 4150,0 4168,1 4185,0 4279,1 4313,0 4376,1 4458,0 4541,1 4610,0 4665,1 4670,0 4759,1 4762,0 4820,1 4882,0 4886,1 4955,0 4985,1 4990,0 5007,1 5058,0 5119,1 5146,0 5180,1 5242,0 5266,1 5350,0 5363,1 5451,0 5517,1 5587,0 5646,1 5733,0 5832,1 5833,0 5929,1 5988,0 6069,1 6117,0 6148,1 6207,0 6298,1 6336,0 6406,1 6473,0 6509,1 6524,0 6553,1 6567,0 6616,1 6630,0 6723,1 6794,0 6855,1 6868,0 6941,1 6997,0 7015,1 7063,0 7143,1 7165,0 7246,1 7311,0 7406,1 7413,0 7425,1 7448,0 7456,1 7499,0 7509,1 7579,0 7612,1 7696,0 7703,1 7749,0 7760,1 7779,0 7782,1 7793,0 7865,1 7902,0 7912,1 7986,0 8001,1 8076,0 8157,1 8183,0 8187,1 8195,0 8269,1 8348,0 8420,1 8462,0 8495,1 8575,0 8654,1 8744,0 8780,1 8860,0 8953,1 8979,0 8992,1 9079,0 9117,1 9122,0 9129,1 9221,0 9237,1 9256,0 9280,1 9315,0 9353,1 9437,0 9456,1 9475,0 9515,1 9534,0 9545,1 9637,0 9651,1 9677,0 9705,1 9790,0 9874,1 9880,0 9940,1 9994,0 10030,1 10080,0 10094,1 10173,0 10198,1 10290,0 10326,1 10420,0 10482,1 10527,0 10610,1 10651,0 10679,1 10693,0 10769,1 10790,0 10800,1 10848,0 10885,1 10953,0 10989,1 11023,0 11030,1 11118,0 11143,1 11166,0 11199,1 11234,0 11239,1 11336,0 11340,1 11395,0 11430,1 11465,0 11518,1 11523,0 11529,1 11624,0 11672,1 11743,0 11797,1 11863,0 11886,1 11946,0 11968,1 12025,0 12108,1 12171,0 12194,1 12269,0 12347,1 12405,0 12449,1 12512,0 12545,1 12628,0 12667,1 12719,0 12752,1 12800,0 12873,1 12885,0 12889,1 12904,0 12963,1 13045,0 13090,1 13168,0 13259,1 13317,0 13322,1 13408,0 13450,1 13485,0 13549,1 13604,0 13619,1 13660,0 13739,1 13781,0 13817,1 13849,0 13913,1 13995,0 14074,1 14151,0 14219,1 14279,0 14360,1 14432,0 14526,1 14575,0 14631,1 14637,0 14687,1 14714,0 14786,1 14848,0 14904,1 14946,0 15021,1 15103,0 15201,1 15221,0 15300,1 15333,0 15347,1 15361,0 15414,1 15425,0 15496,1 15539,0 15551,1 15635,0 15697,1 15698,0 15715,1 15752,0 15851,1 15950,0 16026,1 16098,0 16135,1 16190,0 16242,1 16284,0 16337,1 16375,0 16419,1 16466,0 16501,1 16544,0 16635,1 16652,0 16668,1 16716,0 16782,1 16855,0 16869,1 16960,0 16975,1 16986,0 17014,1 17109,0 17204,1 17234,0 17312,1 17363,0 17372,1 17418,0 17491,1 17525,0 17545,1 17569,0 17604,1 17634,0 17648,1 17737,0 17818,1 17819,0 17896,1 17968,0 18060,1 18109,0 18172,1 18225,0 18318,1 18368,0 18455,1 18501,0 18576,1 18676,0 18766,1 18865,0 18932,1 18933,0 18935,1 18978,0 19009,1 19033,0 19124,1 19160,0 19203,1 19268,0 19366,1 19370,0 19384,1 19449,0 19542,1 19562,0 19659,1 19696,0 19782,1 19809,0 19903,1 19948,0 20020,1 20094,0 20167,1 20247,0 20258,1 20332,0 20387,1 20433,0 20514,1 20608,0 20678,1 20764,0 20768,1 20841,0 20927,1 20980,0 21002,1 21048,0 21122,1 21181,0 21260,1 21293,0 21299,1 21335,0 21348,1 21417,0 21491,1 21537,0 21619,1 21645,0 21681,1 21752,0 21835,1 21856,0 21914,1 21974,0 21983,1 21992,0 22000,1 22065,0 22142,1 22239,0 22335,1 22371,0 22395,1 22448,0 22514,1 22578,0 22585,1 22628,0 22666,1 22756,0 22822,1 22915,0 22931,1 23009,0 23058,1 23140,0 23150,1 23171,0 23182,1 23198,0 23218,1 23268,0 23348,1 23376,0 23448,1 23484,0 23520,1 23541,0 23615,1 23618,0 23666,1 23708,0 23732,1 23789,0 23815,1 23884,0 23904,1 23940,0 23993,1 24022,0 24092,1 24168,0 24199,1 24254,0 24293,1 24335,0 24392,1 24419,0 24436,1 24463,0 24556,1 24625,0 24636,1 24677,0 24734,1 24798,0 24810,1 24863,0 24897,1 24934,0 24975,1 24979,0 24993,1 25013,0 25103,1 25125,0 25148,1 25184,0 25267,1 25285,0 25305,1 25391,0 25403,1 25464,0 25553,1 25640,0 25728,1 25796,0 25888,1 25986,0 26000,1 26074,0 26091,1 26093,0 26108,1 26199,0 26228,1 26278,0 26292,1 26392,0 26488,1 26562,0 26611,1 26649,0 26679,1 26715,0 26770,1 26817,0 26883,1 26912,0 26982,1 27052,0 27144,1 27159,0 27182,1 27261,0 27328,1 27405,0 27484,1 27519,0 27597,1 27679,0 27768,1 27821,0 27862,1 27949,0 27967,1 27981,0 28073,1 28149,0 28150,1 28221,0 28268,1 28286,0 28353,1 28387,0 28444,1 28480,0 28547,1 28589,0 28657,1 28684,0 28767,1 28817,0 28861,1 28872,0 28948,1 29020,0 29032,1 29062,0 29081,1 29119,0 29196,1 29210,0 29278,1 29352,0 29392,1 29478,0 29525,1 29587,0 29684,1 29781,0 29832,1 29925,0 30017,1 30115,0 30122,1 30181,0 30218,1 30284,0 30343,1 30438,0 30532,1 30542,0 30582,1 30607,0 30644,1 30673,0 30683,1 30779,0 30868,1 30950,0 31001,1 31032,0 31035,1 31133,0 31188,1 31243,0 31307,1 31385,0 31389,1 31418,0 31504,1 31539,0 31586,1 31654,0 31734,1 31741,0 31755,1 31849,0 31905,1 31911,0 31946,1 31987,0 32078,1 32149,0 32168,1 32202,0 32206,1 32294,0 32379,1 32446,0 32472,1 32560,0 32573,1 32575,0 32608,1 32628,0 32703,1 32730,0 32773,1 32788,0 32804,1 32846,0 32882,1 32926,0 32971,1 33067,0 33101,1 33118,0 33216,1 33280,0 33300,1 33328,0 33417,1 33469,0 33558,1 33641,0 33671,1 33742,0 33808,1 33874,0 33959,1 33963,0 34003,1 34035,0 34077,1 34093,0 34158,1 34173,0 34264,1 34346,0 34351,1 34408,0 34460,1 34549,0 34610,1 34611,0 34636,1 34732,0 34829,1 34872,0 34906,1 34971,0 34981,1 35022,0 35046,1 35060,0 35098,1 35164,0 35256,1 35275,0 35305,1 35341,0 35362,1 35374,0 35385,1 35484,0 35575,1 35661,0 35737,1 35781,0 35804,1 35837,0 35872,1 35922,0 35985,1 36020,0 36043,1 36086,0 36146,1 36157,0 36198,1 36294,0 36299,1 36334,0 36382,1 36431,0 36525,1 36555,0 36570,1 36600,0 36646,1 36653,0 36687,1 36771,0 36856,1 36915,0 36965,1 37045,0 37052,1 37067,0 37092,1 37098,0 37134,1 37164,0 37212,1 37291,0 37381,1 37450,0 37461,1 37500,0 37568,1 37590,0 37688,1 37778,0 37798,1 37825,0 37876,1 37971,0 38014,1 38021,0 38084,1 38095,0 38163,1 38180,0 38242,1 38321,0 38324,1 38419,0 38514,1 38554,0 38561,1 38623,0 38673,1 38744,0 38787,1 38860,0 38868,1 38923,0 39013,1 39059,0 39077,1 39085,0 39164,1 39197,0 39249,1 39290,0 39357,1 39395,0 39490,1 39524,0 39608,1 39676,0 39691,1 39758,0 39785,1 39796,0 39798,1 39817,0 39861,1 39922,0 39936,1 39943,0 39957,1 40042,0 40064,1 40117,0 40181,1 40273,0 40334,1 40426,0 40457,1 40510,0 40598,1 40662,0 40754,1 40826,0 40877,1 40883,0 40930,1 40954,0 41008,1 41081,0 41138,1 41189,0 41220,1 41314,0 41341,1 41358,0 41446,1 41470,0 41490,1 41537,0 41577,1 41611,0 41613,1 41614,0 41700,1 41786,0 41788,1 41808,0 41813,1 41820,0 41832,1 41908,0 41973,1 41994,0 42034,1 42092,0 42170,1 42201,0 42238,1 42309,0 42375,1 42422,0 42454,1 42483,0 42517,1 42599,0 42607,1 42628,0 42705,1 42725,0 42769,1 42803,0 42897,1 42977,0 43072,1 43103,0 43158,1 43217,0 43300,1 43331,0 43414,1 43428,0 43468,1 43557,0 43563,1 43574,0 43623,1 43716,0 43765,1 43796,0 43836,1 43903,0 43968,1 44037,0 44133,1 44152,0 44206,1 44304,0 44332,1 44360,0 44367,1 44426,0 44513,1 44601,0 44660,1 44724,0 44797,1 44852,0 44950,1 44992,0 44998,1 45077,0 45087,1 45127,0 45164,1 45204,0 45207,1 45277,0 45282,1 45291,0 45356,1 45431,0 45491,1 45508,0 45548,1 45553,0 45636,1 45652,0 45718,1 45729,0 45828,1 45860,0 45954,1 45978,0 46061,1 46098,0 46135,1 46174,0 46210,1 46262,0 46342,1 46418,0 46478,1 46564,0 46587,1 46621,0 46635,1 46706,0 46771,1 46807,0 46814,1 46861,0 46951,1 46960,0 47025,1 47086,0 47149,1 47178,0 47261,1 47269,0 47320,1 47355,0 47362,1 47403,0 47415,1 47500,0 47535,1 47536,0 47586,1 47616,0 47689,1 47748,0 47840,1 47894,0 47939,1 47989,0 48053,1 48056,0 48117,1 48134,0 48144,1 48153,0 48199,1 48290,0 48380,1 48464,0 48541,1 48577,0 48618,1 48623,0 48624,1 48644,0 48672,1 48702,0 48792,1 48817,0 48825,1 48860,0 48933,1 48936,0 48968,1 48975,0 49061,1 end initlist b62 0,0 4,1 42,0 104,1 175,0 266,1 355,0 391,1 397,0 449,1 464,0 496,1 545,0 573,1 659,0 683,1 728,0 775,1 816,0 856,1 947,0 991,1 1023,0 1025,1 1119,0 1135,1 1138,0 1208,1 1221,0 1253,1 1314,0 1327,1 1357,0 1421,1 1429,0 1446,1 1497,0 1513,1 1519,0 1573,1 1671,0 1686,1 1760,0 1795,1 1858,0 1927,1 2008,0 2093,1 2144,0 2217,1 2251,0 2325,1 2363,0 2450,1 2503,0 2578,1 2665,0 2686,1 2710,0 2761,1 2821,0 2914,1 2997,0 3023,1 3117,0 3214,1 3222,0 3282,1 3357,0 3387,1 3428,0 3480,1 3535,0 3609,1 3635,0 3717,1 3718,0 3815,1 3907,0 3979,1 4079,0 4161,1 4176,0 4213,1 4235,0 4250,1 4260,0 4322,1 4382,0 4384,1 4407,0 4429,1 4453,0 4458,1 4535,0 4616,1 4617,0 4710,1 4792,0 4842,1 4926,0 4982,1 5020,0 5089,1 5119,0 5193,1 5271,0 5275,1 5298,0 5370,1 5428,0 5469,1 5498,0 5591,1 5635,0 5677,1 5702,0 5714,1 5726,0 5818,1 5888,0 5945,1 5982,0 6077,1 6149,0 6233,1 6241,0 6261,1 6325,0 6335,1 6417,0 6425,1 6437,0 6447,1 6519,0 6559,1 6611,0 6638,1 6639,0 6664,1 6751,0 6809,1 6869,0 6920,1 6936,0 6971,1 7028,0 7074,1 7091,0 7120,1 7151,0 7206,1 7291,0 7364,1 7382,0 7478,1 7566,0 7643,1 7673,0 7681,1 7720,0 7739,1 7776,0 7841,1 7886,0 7966,1 7981,0 8067,1 8148,0 8229,1 8254,0 8319,1 8344,0 8365,1 8370,0 8382,1 8392,0 8442,1 8445,0 8489,1 8581,0 8640,1 8707,0 8804,1 8873,0 8958,1 8972,0 9056,1 9142,0 9221,1 9286,0 9362,1 9409,0 9444,1 9512,0 9575,1 9606,0 9668,1 9673,0 9755,1 9786,0 9819,1 9821,0 9875,1 9877,0 9916,1 9944,0 10021,1 10060,0 10070,1 10121,0 10162,1 10242,0 10335,1 10371,0 10399,1 10454,0 10548,1 10571,0 10591,1 10608,0 10613,1 10653,0 10676,1 10770,0 10838,1 10935,0 10992,1 11007,0 11104,1 11168,0 11232,1 11252,0 11271,1 11345,0 11358,1 11447,0 11531,1 11592,0 11623,1 11682,0 11747,1 11766,0 11809,1 11817,0 11823,1 11860,0 11942,1 12018,0 12022,1 12109,0 12129,1 12159,0 12200,1 12201,0 12257,1 12306,0 12350,1 12364,0 12430,1 12462,0 12530,1 12558,0 12571,1 12649,0 12700,1 12704,0 12745,1 12765,0 12781,1 12798,0 12825,1 12907,0 13006,1 13084,0 13120,1 13159,0 13180,1 13227,0 13321,1 13398,0 13408,1 13481,0 13530,1 13563,0 13610,1 13687,0 13770,1 13803,0 13858,1 13884,0 13913,1 13925,0 14025,1 14046,0 14121,1 14207,0 14241,1 14253,0 14332,1 14404,0 14456,1 14497,0 14509,1 14539,0 14579,1 14653,0 14734,1 14788,0 14799,1 14895,0 14923,1 15001,0 15009,1 15090,0 15094,1 15095,0 15146,1 15176,0 15213,1 15275,0 15356,1 15420,0 15434,1 15483,0 15495,1 15537,0 15606,1 15679,0 15696,1 15773,0 15850,1 15867,0 15914,1 15986,0 15992,1 16070,0 16122,1 16146,0 16241,1 16264,0 16331,1 16402,0 16417,1 16446,0 16506,1 16549,0 16589,1 16683,0 16766,1 16814,0 16885,1 16977,0 17013,1 17101,0 17129,1 17211,0 17290,1 17388,0 17404,1 17444,0 17481,1 17524,0 17560,1 17567,0 17613,1 17692,0 17765,1 17787,0 17884,1 17923,0 17975,1 17985,0 17996,1 18093,0 18144,1 18154,0 18221,1 18278,0 18356,1 18367,0 18467,1 18496,0 18562,1 18592,0 18675,1 18706,0 18780,1 18823,0 18873,1 18917,0 18984,1 19035,0 19131,1 19220,0 19272,1 19297,0 19344,1 19352,0 19389,1 19427,0 19504,1 19515,0 19582,1 19652,0 19731,1 19774,0 19779,1 19804,0 19820,1 19821,0 19881,1 19939,0 20000,1 20007,0 20027,1 20071,0 20157,1 20203,0 20222,1 20233,0 20294,1 20369,0 20417,1 20456,0 20476,1 20483,0 20519,1 20589,0 20631,1 20727,0 20824,1 20883,0 20921,1 20947,0 20950,1 21029,0 21067,1 21084,0 21159,1 21199,0 21223,1 21312,0 21400,1 21458,0 21546,1 21612,0 21660,1 21692,0 21710,1 21810,0 21817,1 21848,0 21865,1 21890,0 21894,1 21985,0 22051,1 22089,0 22133,1 22143,0 22212,1 22213,0 22296,1 22343,0 22408,1 22463,0 22516,1 22572,0 22656,1 22733,0 22801,1 22815,0 22867,1 22870,0 22878,1 22942,0 23013,1 23112,0 23173,1 23273,0 23282,1 23347,0 23424,1 23480,0 23549,1 23562,0 23623,1 23661,0 23663,1 23684,0 23750,1 23817,0 23847,1 23943,0 23952,1 24042,0 24072,1 24127,0 24185,1 24209,0 24273,1 24303,0 24327,1 24403,0 24430,1 24495,0 24572,1 24596,0 24664,1 24715,0 24773,1 24865,0 24921,1 24976,0 25005,1 25036,0 25085,1 25087,0 25171,1 25200,0 25231,1 25234,0 25277,1 25350,0 25379,1 25466,0 25546,1 25626,0 25663,1 25716,0 25805,1 25857,0 25948,1 26003,0 26058,1 26154,0 26181,1 26277,0 26349,1 26391,0 26434,1 26449,0 26545,1 26576,0 26640,1 26700,0 26702,1 26716,0 26730,1 26829,0 26889,1 26904,0 26906,1 26956,0 26989,1 27042,0 27126,1 27209,0 27288,1 27312,0 27329,1 27376,0 27445,1 27488,0 27558,1 27562,0 27605,1 27702,0 27779,1 27783,0 27878,1 27972,0 27974,1 27981,0 28055,1 28068,0 28127,1 28156,0 28246,1 28285,0 28321,1 28392,0 28461,1 28462,0 28512,1 28541,0 28543,1 28623,0 28665,1 28762,0 28775,1 28816,0 28836,1 28920,0 28981,1 28985,0 29011,1 29047,0 29089,1 29156,0 29161,1 29221,0 29226,1 29270,0 29338,1 29424,0 29519,1 29533,0 29556,1 29608,0 29678,1 29684,0 29691,1 29698,0 29781,1 29805,0 29838,1 29930,0 30004,1 30069,0 30144,1 30148,0 30200,1 30279,0 30336,1 30387,0 30477,1 30533,0 30574,1 30597,0 30640,1 30650,0 30659,1 30668,0 30717,1 30722,0 30769,1 30841,0 30880,1 30922,0 30925,1 31009,0 31088,1 31114,0 31208,1 31292,0 31347,1 31444,0 31539,1 31565,0 31566,1 31576,0 31663,1 31678,0 31682,1 31713,0 31757,1 31806,0 31845,1 31881,0 31969,1 32059,0 32102,1 32195,0 32284,1 32350,0 32378,1 32386,0 32430,1 32523,0 32543,1 32551,0 32599,1 32666,0 32758,1 32844,0 32940,1 33031,0 33067,1 33135,0 33159,1 33162,0 33251,1 33347,0 33440,1 33461,0 33465,1 33528,0 33614,1 33697,0 33771,1 33797,0 33881,1 33913,0 33986,1 34021,0 34110,1 34152,0 34209,1 34223,0 34285,1 34314,0 34362,1 34410,0 34425,1 34433,0 34489,1 34556,0 34622,1 34674,0 34749,1 34807,0 34846,1 34850,0 34899,1 34937,0 34942,1 34996,0 35024,1 35065,0 35134,1 35158,0 35201,1 35286,0 35316,1 35374,0 35411,1 35508,0 35602,1 35665,0 35723,1 35758,0 35810,1 35812,0 35886,1 35935,0 35936,1 35978,0 35995,1 36079,0 36108,1 36110,0 36168,1 36171,0 36237,1 36273,0 36274,1 36351,0 36355,1 36359,0 36379,1 36457,0 36554,1 36653,0 36657,1 36659,0 36733,1 36746,0 36755,1 36763,0 36811,1 36828,0 36875,1 36971,0 37019,1 37065,0 37119,1 37158,0 37205,1 37252,0 37261,1 37345,0 37399,1 37471,0 37494,1 37579,0 37636,1 37660,0 37664,1 37697,0 37705,1 37771,0 37825,1 37893,0 37922,1 37966,0 37995,1 38049,0 38113,1 38147,0 38179,1 38266,0 38293,1 38381,0 38442,1 38447,0 38498,1 38529,0 38603,1 38678,0 38747,1 38812,0 38853,1 38913,0 38955,1 38980,0 38991,1 39052,0 39133,1 39138,0 39177,1 39274,0 39301,1 39346,0 39444,1 39493,0 39553,1 39644,0 39680,1 39766,0 39787,1 39865,0 39948,1 39963,0 39989,1 40017,0 40087,1 40153,0 40156,1 40218,0 40227,1 40321,0 40382,1 40434,0 40467,1 40493,0 40551,1 40638,0 40643,1 40722,0 40788,1 40869,0 40887,1 40974,0 40996,1 41071,0 41088,1 41141,0 41151,1 41165,0 41263,1 41355,0 41453,1 41533,0 41575,1 41668,0 41676,1 41682,0 41713,1 41715,0 41716,1 41751,0 41797,1 41866,0 41888,1 41932,0 41990,1 42090,0 42164,1 42212,0 42303,1 42305,0 42323,1 42408,0 42456,1 42496,0 42534,1 42545,0 42626,1 42704,0 42757,1 42764,0 42842,1 42868,0 42935,1 43028,0 43048,1 43098,0 43155,1 43253,0 43289,1 43310,0 43319,1 43396,0 43420,1 43442,0 43497,1 43555,0 43592,1 43656,0 43719,1 43773,0 43791,1 43796,0 43876,1 43881,0 43895,1 43963,0 44018,1 44047,0 44053,1 44105,0 44154,1 44189,0 44228,1 44231,0 44318,1 44371,0 44467,1 44509,0 44515,1 44578,0 44667,1 44749,0 44757,1 44779,0 44832,1 44872,0 44966,1 45059,0 45086,1 45105,0 45108,1 45162,0 45233,1 45324,0 45401,1 45422,0 45446,1 45498,0 45598,1 45600,0 45607,1 45629,0 45655,1 45752,0 45840,1 45877,0 45879,1 45903,0 45914,1 46011,0 46074,1 46122,0 46207,1 46224,0 46266,1 46352,0 46401,1 46453,0 46553,1 46637,0 46712,1 46730,0 46761,1 46817,0 46866,1 46942,0 47037,1 47132,0 47205,1 47303,0 47390,1 47473,0 47553,1 47579,0 47635,1 47706,0 47792,1 47864,0 47883,1 47954,0 48027,1 48078,0 48085,1 48167,0 48183,1 48233,0 48235,1 48318,0 48358,1 48370,0 48455,1 48500,0 48561,1 48563,0 48571,1 48602,0 48661,1 48757,0 48807,1 end initlist b63 0,0 77,1 146,0 176,1 191,0 247,1 339,0 438,1 523,0 603,1 701,0 741,1 753,0 764,1 776,0 811,1 901,0 902,1 978,0 1041,1 1049,0 1073,1 1165,0 1203,1 1211,0 1275,1 1277,0 1282,1 1314,0 1338,1 1341,0 1415,1 1509,0 1578,1 1645,0 1697,1 1784,0 1791,1 1803,0 1860,1 1921,0 1946,1 1954,0 1976,1 1993,0 2088,1 2144,0 2190,1 2191,0 2255,1 2256,0 2327,1 2356,0 2420,1 2428,0 2482,1 2577,0 2671,1 2722,0 2790,1 2850,0 2868,1 2961,0 2978,1 3076,0 3174,1 3255,0 3291,1 3292,0 3350,1 3385,0 3400,1 3405,0 3450,1 3517,0 3549,1 3593,0 3656,1 3711,0 3784,1 3834,0 3934,1 4034,0 4073,1 4173,0 4213,1 4260,0 4357,1 4386,0 4478,1 4532,0 4548,1 4638,0 4734,1 4787,0 4866,1 4950,0 4998,1 5094,0 5183,1 5233,0 5250,1 5306,0 5393,1 5486,0 5534,1 5554,0 5653,1 5731,0 5767,1 5783,0 5790,1 5887,0 5921,1 5944,0 5948,1 6023,0 6069,1 6081,0 6103,1 6178,0 6234,1 6239,0 6291,1 6325,0 6393,1 6443,0 6480,1 6518,0 6524,1 6582,0 6621,1 6721,0 6812,1 6854,0 6872,1 6941,0 7006,1 7058,0 7138,1 7142,0 7220,1 7221,0 7225,1 7233,0 7294,1 7316,0 7363,1 7446,0 7448,1 7509,0 7578,1 7641,0 7646,1 7701,0 7710,1 7772,0 7861,1 7876,0 7919,1 7973,0 8033,1 8098,0 8102,1 8173,0 8200,1 8238,0 8330,1 8406,0 8480,1 8501,0 8570,1 8591,0 8685,1 8707,0 8744,1 8806,0 8899,1 8949,0 9010,1 9024,0 9087,1 9172,0 9207,1 9218,0 9280,1 9301,0 9321,1 9364,0 9404,1 9492,0 9586,1 9659,0 9675,1 9710,0 9789,1 9792,0 9793,1 9879,0 9959,1 9982,0 10031,1 10040,0 10076,1 10150,0 10247,1 10255,0 10346,1 10422,0 10467,1 10514,0 10592,1 10600,0 10619,1 10633,0 10635,1 10642,0 10721,1 10769,0 10811,1 10849,0 10856,1 10909,0 10977,1 11032,0 11100,1 11179,0 11184,1 11211,0 11249,1 11322,0 11387,1 11440,0 11519,1 11576,0 11633,1 11709,0 11724,1 11793,0 11851,1 11938,0 11948,1 12017,0 12105,1 12185,0 12221,1 12305,0 12377,1 12404,0 12471,1 12546,0 12551,1 12559,0 12574,1 12579,0 12664,1 12696,0 12775,1 12818,0 12874,1 12880,0 12971,1 13057,0 13155,1 13222,0 13230,1 13249,0 13332,1 13388,0 13456,1 13480,0 13551,1 13597,0 13654,1 13662,0 13675,1 13717,0 13807,1 13840,0 13902,1 13921,0 13983,1 14033,0 14046,1 14111,0 14179,1 14180,0 14208,1 14218,0 14243,1 14307,0 14319,1 14418,0 14455,1 14462,0 14500,1 14536,0 14593,1 14597,0 14694,1 14781,0 14856,1 14893,0 14924,1 15000,0 15031,1 15072,0 15150,1 15214,0 15252,1 15316,0 15412,1 15428,0 15525,1 15571,0 15639,1 15679,0 15715,1 15751,0 15843,1 15886,0 15932,1 16022,0 16068,1 16154,0 16195,1 16202,0 16225,1 16293,0 16345,1 16380,0 16384,1 16429,0 16475,1 16484,0 16570,1 16608,0 16677,1 16762,0 16800,1 16831,0 16913,1 16942,0 17010,1 17026,0 17045,1 17078,0 17121,1 17218,0 17273,1 17290,0 17390,1 17442,0 17498,1 17513,0 17605,1 17618,0 17652,1 17736,0 17757,1 17834,0 17872,1 17959,0 17975,1 18020,0 18112,1 18189,0 18286,1 18346,0 18361,1 18435,0 18535,1 18573,0 18651,1 18732,0 18831,1 18926,0 18929,1 18981,0 19067,1 19124,0 19196,1 19254,0 19286,1 19314,0 19380,1 19455,0 19495,1 19502,0 19556,1 19651,0 19666,1 19758,0 19767,1 19826,0 19897,1 19913,0 19932,1 20009,0 20056,1 20134,0 20200,1 20241,0 20338,1 20421,0 20450,1 20503,0 20558,1 20643,0 20656,1 20689,0 20759,1 20834,0 20932,1 20993,0 21026,1 21099,0 21160,1 21225,0 21229,1 21233,0 21246,1 21284,0 21353,1 21425,0 21437,1 21448,0 21486,1 21530,0 21585,1 21597,0 21648,1 21684,0 21780,1 21808,0 21870,1 21969,0 21989,1 21994,0 22070,1 22154,0 22214,1 22240,0 22305,1 22325,0 22337,1 22371,0 22403,1 22427,0 22524,1 22540,0 22552,1 22600,0 22619,1 22644,0 22668,1 22736,0 22809,1 22850,0 22915,1 22968,0 23016,1 23089,0 23095,1 23097,0 23122,1 23213,0 23270,1 23349,0 23403,1 23489,0 23544,1 23575,0 23581,1 23656,0 23730,1 23750,0 23823,1 23913,0 23947,1 23962,0 24007,1 24093,0 24173,1 24179,0 24198,1 24206,0 24282,1 24362,0 24455,1 24483,0 24495,1 24558,0 24650,1 24727,0 24762,1 24797,0 24863,1 24907,0 24999,1 25044,0 25057,1 25134,0 25159,1 25173,0 25246,1 25249,0 25322,1 25417,0 25497,1 25573,0 25605,1 25633,0 25687,1 25704,0 25707,1 25761,0 25771,1 25859,0 25947,1 26019,0 26090,1 26095,0 26116,1 26199,0 26242,1 26301,0 26374,1 26455,0 26464,1 26555,0 26563,1 26570,0 26595,1 26642,0 26651,1 26694,0 26779,1 26814,0 26841,1 26906,0 26942,1 27032,0 27115,1 27190,0 27262,1 27269,0 27297,1 27371,0 27432,1 27517,0 27602,1 27676,0 27772,1 27790,0 27864,1 27937,0 27984,1 28055,0 28111,1 28119,0 28209,1 28305,0 28353,1 28423,0 28483,1 28563,0 28629,1 28683,0 28705,1 28747,0 28752,1 28796,0 28869,1 28900,0 28909,1 28980,0 29052,1 29096,0 29139,1 29160,0 29164,1 29253,0 29324,1 29368,0 29430,1 29526,0 29619,1 29671,0 29731,1 29771,0 29812,1 29885,0 29979,1 30030,0 30114,1 30138,0 30164,1 30193,0 30196,1 30280,0 30292,1 30310,0 30378,1 30382,0 30451,1 30478,0 30545,1 30586,0 30633,1 30693,0 30750,1 30766,0 30808,1 30880,0 30918,1 30935,0 30988,1 30998,0 31020,1 31089,0 31180,1 31220,0 31253,1 31292,0 31333,1 31401,0 31450,1 31538,0 31539,1 31573,0 31663,1 31732,0 31756,1 31827,0 31895,1 31931,0 31961,1 32061,0 32091,1 32102,0 32103,1 32143,0 32229,1 32321,0 32342,1 32422,0 32428,1 32444,0 32499,1 32554,0 32603,1 32622,0 32644,1 32652,0 32698,1 32700,0 32713,1 32792,0 32800,1 32837,0 32895,1 32958,0 32988,1 33003,0 33009,1 33072,0 33074,1 33140,0 33204,1 33222,0 33270,1 33314,0 33332,1 33387,0 33419,1 33488,0 33506,1 33588,0 33624,1 33679,0 33716,1 33727,0 33749,1 33775,0 33835,1 33923,0 33989,1 34079,0 34138,1 34197,0 34236,1 34314,0 34343,1 34366,0 34401,1 34498,0 34520,1 34570,0 34664,1 34747,0 34767,1 34838,0 34862,1 34913,0 34935,1 34989,0 35064,1 35154,0 35253,1 35264,0 35349,1 35432,0 35487,1 35510,0 35599,1 35669,0 35735,1 35746,0 35797,1 35856,0 35892,1 35938,0 36000,1 36016,0 36079,1 36176,0 36245,1 36274,0 36311,1 36387,0 36411,1 36425,0 36448,1 36487,0 36539,1 36588,0 36598,1 36671,0 36720,1 36801,0 36883,1 36933,0 36966,1 37013,0 37041,1 37113,0 37156,1 37236,0 37248,1 37254,0 37284,1 37347,0 37385,1 37391,0 37456,1 37516,0 37540,1 37581,0 37660,1 37718,0 37816,1 37885,0 37964,1 37972,0 38034,1 38121,0 38209,1 38302,0 38391,1 38397,0 38433,1 38505,0 38587,1 38602,0 38656,1 38738,0 38772,1 38831,0 38919,1 38988,0 39004,1 39052,0 39100,1 39127,0 39187,1 39261,0 39347,1 39375,0 39452,1 39465,0 39467,1 39495,0 39555,1 39641,0 39707,1 39783,0 39871,1 39919,0 39996,1 40055,0 40129,1 40220,0 40260,1 40296,0 40357,1 40437,0 40490,1 40503,0 40591,1 40667,0 40674,1 40712,0 40721,1 40752,0 40847,1 40933,0 40972,1 41017,0 41106,1 41195,0 41216,1 41281,0 41346,1 41426,0 41441,1 41505,0 41543,1 41574,0 41634,1 41667,0 41675,1 41775,0 41872,1 41938,0 42026,1 42030,0 42074,1 42080,0 42129,1 42134,0 42160,1 42256,0 42316,1 42338,0 42415,1 42504,0 42599,1 42634,0 42675,1 42726,0 42824,1 42922,0 42926,1 42985,0 43032,1 43040,0 43102,1 43125,0 43202,1 43292,0 43386,1 43420,0 43455,1 43504,0 43576,1 43603,0 43702,1 43789,0 43847,1 43853,0 43883,1 43887,0 43963,1 44011,0 44084,1 44089,0 44121,1 44150,0 44221,1 44256,0 44279,1 44358,0 44380,1 44457,0 44548,1 44602,0 44650,1 44708,0 44788,1 44853,0 44952,1 45029,0 45101,1 45151,0 45166,1 45264,0 45339,1 45404,0 45490,1 45560,0 45589,1 45602,0 45647,1 45685,0 45731,1 45742,0 45802,1 45877,0 45940,1 45962,0 46032,1 46070,0 46107,1 46182,0 46222,1 46311,0 46323,1 46335,0 46350,1 46432,0 46473,1 46503,0 46519,1 46601,0 46647,1 46747,0 46764,1 46789,0 46867,1 46876,0 46909,1 46936,0 46938,1 47028,0 47103,1 47108,0 47186,1 47279,0 47321,1 47367,0 47379,1 47381,0 47456,1 47523,0 47537,1 47627,0 47707,1 47753,0 47812,1 47886,0 47956,1 47988,0 48018,1 48074,0 48086,1 48109,0 48111,1 48183,0 48238,1 48332,0 48333,1 48364,0 48451,1 48546,0 48567,1 48601,0 48639,1 48660,0 48698,1 48727,0 48821,1 48850,0 48885,1 48906,0 48963,1 48975,0 49060,1 49077,0 49126,1 49146,0 49211,1 49272,0 49273,1 49291,0 49296,1 49382,0 49463,1 49529,0 49552,1 49607,0 49685,1 49690,0 49701,1 49777,0 49819,1 49897,0 49928,1 49960,0 50029,1 50086,0 50150,1 end initlist cin 0, 0 60, 1 end outvalues s0 1, s1 1, s2 1, s3 1, s4 1, s5 1, s6 1, s7 1, s8 1, s9 1, s10 1, s11 1, s12 1, s13 1, s14 1, s15 1, s16 1, s17 1, s18 1, s19 1, s20 1, s21 1, s22 1, s23 1, s24 1, s25 1, s26 1, s27 1, s28 1, s29 1, s30 1, s31 1, s32 1, s33 1, s34 1, s35 1, s36 1, s37 1, s38 1, s39 1, s40 1, s41 1, s42 1, s43 1, s44 1, s45 1, s46 1, s47 1, s48 1, s49 1, s50 1, s51 1, s52 1, s53 1, s54 1, s55 1, s56 1, s57 1, s58 1, s59 1, s60 1, s61 1, s62 1, s63 1, , cout 1, end netlist // PGgen (g0,p0,a0,b0) xor2(p0,a0,b0)#5 and2(g0,a0,b0)#5 end netlist // PGgen (g1,p1,a1,b1) xor2(p1,a1,b1)#5 and2(g1,a1,b1)#5 end netlist // PGgen (g2,p2,a2,b2) xor2(p2,a2,b2)#5 and2(g2,a2,b2)#5 end netlist // PGgen (g3,p3,a3,b3) xor2(p3,a3,b3)#5 and2(g3,a3,b3)#5 end netlist // PGgen (g4,p4,a4,b4) xor2(p4,a4,b4)#5 and2(g4,a4,b4)#5 end netlist // PGgen (g5,p5,a5,b5) xor2(p5,a5,b5)#5 and2(g5,a5,b5)#5 end netlist // PGgen (g6,p6,a6,b6) xor2(p6,a6,b6)#5 and2(g6,a6,b6)#5 end netlist // PGgen (g7,p7,a7,b7) xor2(p7,a7,b7)#5 and2(g7,a7,b7)#5 end netlist // PGgen (g8,p8,a8,b8) xor2(p8,a8,b8)#5 and2(g8,a8,b8)#5 end netlist // PGgen (g9,p9,a9,b9) xor2(p9,a9,b9)#5 and2(g9,a9,b9)#5 end netlist // PGgen (g10,p10,a10,b10) xor2(p10,a10,b10)#5 and2(g10,a10,b10)#5 end netlist // PGgen (g11,p11,a11,b11) xor2(p11,a11,b11)#5 and2(g11,a11,b11)#5 end netlist // PGgen (g12,p12,a12,b12) xor2(p12,a12,b12)#5 and2(g12,a12,b12)#5 end netlist // PGgen (g13,p13,a13,b13) xor2(p13,a13,b13)#5 and2(g13,a13,b13)#5 end netlist // PGgen (g14,p14,a14,b14) xor2(p14,a14,b14)#5 and2(g14,a14,b14)#5 end netlist // PGgen (g15,p15,a15,b15) xor2(p15,a15,b15)#5 and2(g15,a15,b15)#5 end netlist // PGgen (g16,p16,a16,b16) xor2(p16,a16,b16)#5 and2(g16,a16,b16)#5 end netlist // PGgen (g17,p17,a17,b17) xor2(p17,a17,b17)#5 and2(g17,a17,b17)#5 end netlist // PGgen (g18,p18,a18,b18) xor2(p18,a18,b18)#5 and2(g18,a18,b18)#5 end netlist // PGgen (g19,p19,a19,b19) xor2(p19,a19,b19)#5 and2(g19,a19,b19)#5 end netlist // PGgen (g20,p20,a20,b20) xor2(p20,a20,b20)#5 and2(g20,a20,b20)#5 end netlist // PGgen (g21,p21,a21,b21) xor2(p21,a21,b21)#5 and2(g21,a21,b21)#5 end netlist // PGgen (g22,p22,a22,b22) xor2(p22,a22,b22)#5 and2(g22,a22,b22)#5 end netlist // PGgen (g23,p23,a23,b23) xor2(p23,a23,b23)#5 and2(g23,a23,b23)#5 end netlist // PGgen (g24,p24,a24,b24) xor2(p24,a24,b24)#5 and2(g24,a24,b24)#5 end netlist // PGgen (g25,p25,a25,b25) xor2(p25,a25,b25)#5 and2(g25,a25,b25)#5 end netlist // PGgen (g26,p26,a26,b26) xor2(p26,a26,b26)#5 and2(g26,a26,b26)#5 end netlist // PGgen (g27,p27,a27,b27) xor2(p27,a27,b27)#5 and2(g27,a27,b27)#5 end netlist // PGgen (g28,p28,a28,b28) xor2(p28,a28,b28)#5 and2(g28,a28,b28)#5 end netlist // PGgen (g29,p29,a29,b29) xor2(p29,a29,b29)#5 and2(g29,a29,b29)#5 end netlist // PGgen (g30,p30,a30,b30) xor2(p30,a30,b30)#5 and2(g30,a30,b30)#5 end netlist // PGgen (g31,p31,a31,b31) xor2(p31,a31,b31)#5 and2(g31,a31,b31)#5 end netlist // PGgen (g32,p32,a32,b32) xor2(p32,a32,b32)#5 and2(g32,a32,b32)#5 end netlist // PGgen (g33,p33,a33,b33) xor2(p33,a33,b33)#5 and2(g33,a33,b33)#5 end netlist // PGgen (g34,p34,a34,b34) xor2(p34,a34,b34)#5 and2(g34,a34,b34)#5 end netlist // PGgen (g35,p35,a35,b35) xor2(p35,a35,b35)#5 and2(g35,a35,b35)#5 end netlist // PGgen (g36,p36,a36,b36) xor2(p36,a36,b36)#5 and2(g36,a36,b36)#5 end netlist // PGgen (g37,p37,a37,b37) xor2(p37,a37,b37)#5 and2(g37,a37,b37)#5 end netlist // PGgen (g38,p38,a38,b38) xor2(p38,a38,b38)#5 and2(g38,a38,b38)#5 end netlist // PGgen (g39,p39,a39,b39) xor2(p39,a39,b39)#5 and2(g39,a39,b39)#5 end netlist // PGgen (g40,p40,a40,b40) xor2(p40,a40,b40)#5 and2(g40,a40,b40)#5 end netlist // PGgen (g41,p41,a41,b41) xor2(p41,a41,b41)#5 and2(g41,a41,b41)#5 end netlist // PGgen (g42,p42,a42,b42) xor2(p42,a42,b42)#5 and2(g42,a42,b42)#5 end netlist // PGgen (g43,p43,a43,b43) xor2(p43,a43,b43)#5 and2(g43,a43,b43)#5 end netlist // PGgen (g44,p44,a44,b44) xor2(p44,a44,b44)#5 and2(g44,a44,b44)#5 end netlist // PGgen (g45,p45,a45,b45) xor2(p45,a45,b45)#5 and2(g45,a45,b45)#5 end netlist // PGgen (g46,p46,a46,b46) xor2(p46,a46,b46)#5 and2(g46,a46,b46)#5 end netlist // PGgen (g47,p47,a47,b47) xor2(p47,a47,b47)#5 and2(g47,a47,b47)#5 end netlist // PGgen (g48,p48,a48,b48) xor2(p48,a48,b48)#5 and2(g48,a48,b48)#5 end netlist // PGgen (g49,p49,a49,b49) xor2(p49,a49,b49)#5 and2(g49,a49,b49)#5 end netlist // PGgen (g50,p50,a50,b50) xor2(p50,a50,b50)#5 and2(g50,a50,b50)#5 end netlist // PGgen (g51,p51,a51,b51) xor2(p51,a51,b51)#5 and2(g51,a51,b51)#5 end netlist // PGgen (g52,p52,a52,b52) xor2(p52,a52,b52)#5 and2(g52,a52,b52)#5 end netlist // PGgen (g53,p53,a53,b53) xor2(p53,a53,b53)#5 and2(g53,a53,b53)#5 end netlist // PGgen (g54,p54,a54,b54) xor2(p54,a54,b54)#5 and2(g54,a54,b54)#5 end netlist // PGgen (g55,p55,a55,b55) xor2(p55,a55,b55)#5 and2(g55,a55,b55)#5 end netlist // PGgen (g56,p56,a56,b56) xor2(p56,a56,b56)#5 and2(g56,a56,b56)#5 end netlist // PGgen (g57,p57,a57,b57) xor2(p57,a57,b57)#5 and2(g57,a57,b57)#5 end netlist // PGgen (g58,p58,a58,b58) xor2(p58,a58,b58)#5 and2(g58,a58,b58)#5 end netlist // PGgen (g59,p59,a59,b59) xor2(p59,a59,b59)#5 and2(g59,a59,b59)#5 end netlist // PGgen (g60,p60,a60,b60) xor2(p60,a60,b60)#5 and2(g60,a60,b60)#5 end netlist // PGgen (g61,p61,a61,b61) xor2(p61,a61,b61)#5 and2(g61,a61,b61)#5 end netlist // PGgen (g62,p62,a62,b62) xor2(p62,a62,b62)#5 and2(g62,a62,b62)#5 end netlist // PGgen (g63,p63,a63,b63) xor2(p63,a63,b63)#5 and2(g63,a63,b63)#5 end netlist // Gcombine (g_0_cin, g0, cin, p0 ) and2(w0g_0_cin, p0, cin )#5 or2( g_0_cin, w0g_0_cin, g0 )#5 end netlist // PGcombine (g_1_0,p_1_0,g1,p1,g0,p0) and2( w0g_1_0, p1, g0 )#5 or2( g_1_0, w0g_1_0, g1 )#5 and2( p_1_0, p1, p0)#5 end netlist // PGcombine (g_2_1,p_2_1,g2,p2,g1,p1) and2( w0g_2_1, p2, g1 )#5 or2( g_2_1, w0g_2_1, g2 )#5 and2( p_2_1, p2, p1)#5 end netlist // PGcombine (g_3_2,p_3_2,g3,p3,g2,p2) and2( w0g_3_2, p3, g2 )#5 or2( g_3_2, w0g_3_2, g3 )#5 and2( p_3_2, p3, p2)#5 end netlist // PGcombine (g_4_3,p_4_3,g4,p4,g3,p3) and2( w0g_4_3, p4, g3 )#5 or2( g_4_3, w0g_4_3, g4 )#5 and2( p_4_3, p4, p3)#5 end netlist // PGcombine (g_5_4,p_5_4,g5,p5,g4,p4) and2( w0g_5_4, p5, g4 )#5 or2( g_5_4, w0g_5_4, g5 )#5 and2( p_5_4, p5, p4)#5 end netlist // PGcombine (g_6_5,p_6_5,g6,p6,g5,p5) and2( w0g_6_5, p6, g5 )#5 or2( g_6_5, w0g_6_5, g6 )#5 and2( p_6_5, p6, p5)#5 end netlist // PGcombine (g_7_6,p_7_6,g7,p7,g6,p6) and2( w0g_7_6, p7, g6 )#5 or2( g_7_6, w0g_7_6, g7 )#5 and2( p_7_6, p7, p6)#5 end netlist // PGcombine (g_8_7,p_8_7,g8,p8,g7,p7) and2( w0g_8_7, p8, g7 )#5 or2( g_8_7, w0g_8_7, g8 )#5 and2( p_8_7, p8, p7)#5 end netlist // PGcombine (g_9_8,p_9_8,g9,p9,g8,p8) and2( w0g_9_8, p9, g8 )#5 or2( g_9_8, w0g_9_8, g9 )#5 and2( p_9_8, p9, p8)#5 end netlist // PGcombine (g_10_9,p_10_9,g10,p10,g9,p9) and2( w0g_10_9, p10, g9 )#5 or2( g_10_9, w0g_10_9, g10 )#5 and2( p_10_9, p10, p9)#5 end netlist // PGcombine (g_11_10,p_11_10,g11,p11,g10,p10) and2( w0g_11_10, p11, g10 )#5 or2( g_11_10, w0g_11_10, g11 )#5 and2( p_11_10, p11, p10)#5 end netlist // PGcombine (g_12_11,p_12_11,g12,p12,g11,p11) and2( w0g_12_11, p12, g11 )#5 or2( g_12_11, w0g_12_11, g12 )#5 and2( p_12_11, p12, p11)#5 end netlist // PGcombine (g_13_12,p_13_12,g13,p13,g12,p12) and2( w0g_13_12, p13, g12 )#5 or2( g_13_12, w0g_13_12, g13 )#5 and2( p_13_12, p13, p12)#5 end netlist // PGcombine (g_14_13,p_14_13,g14,p14,g13,p13) and2( w0g_14_13, p14, g13 )#5 or2( g_14_13, w0g_14_13, g14 )#5 and2( p_14_13, p14, p13)#5 end netlist // PGcombine (g_15_14,p_15_14,g15,p15,g14,p14) and2( w0g_15_14, p15, g14 )#5 or2( g_15_14, w0g_15_14, g15 )#5 and2( p_15_14, p15, p14)#5 end netlist // PGcombine (g_16_15,p_16_15,g16,p16,g15,p15) and2( w0g_16_15, p16, g15 )#5 or2( g_16_15, w0g_16_15, g16 )#5 and2( p_16_15, p16, p15)#5 end netlist // PGcombine (g_17_16,p_17_16,g17,p17,g16,p16) and2( w0g_17_16, p17, g16 )#5 or2( g_17_16, w0g_17_16, g17 )#5 and2( p_17_16, p17, p16)#5 end netlist // PGcombine (g_18_17,p_18_17,g18,p18,g17,p17) and2( w0g_18_17, p18, g17 )#5 or2( g_18_17, w0g_18_17, g18 )#5 and2( p_18_17, p18, p17)#5 end netlist // PGcombine (g_19_18,p_19_18,g19,p19,g18,p18) and2( w0g_19_18, p19, g18 )#5 or2( g_19_18, w0g_19_18, g19 )#5 and2( p_19_18, p19, p18)#5 end netlist // PGcombine (g_20_19,p_20_19,g20,p20,g19,p19) and2( w0g_20_19, p20, g19 )#5 or2( g_20_19, w0g_20_19, g20 )#5 and2( p_20_19, p20, p19)#5 end netlist // PGcombine (g_21_20,p_21_20,g21,p21,g20,p20) and2( w0g_21_20, p21, g20 )#5 or2( g_21_20, w0g_21_20, g21 )#5 and2( p_21_20, p21, p20)#5 end netlist // PGcombine (g_22_21,p_22_21,g22,p22,g21,p21) and2( w0g_22_21, p22, g21 )#5 or2( g_22_21, w0g_22_21, g22 )#5 and2( p_22_21, p22, p21)#5 end netlist // PGcombine (g_23_22,p_23_22,g23,p23,g22,p22) and2( w0g_23_22, p23, g22 )#5 or2( g_23_22, w0g_23_22, g23 )#5 and2( p_23_22, p23, p22)#5 end netlist // PGcombine (g_24_23,p_24_23,g24,p24,g23,p23) and2( w0g_24_23, p24, g23 )#5 or2( g_24_23, w0g_24_23, g24 )#5 and2( p_24_23, p24, p23)#5 end netlist // PGcombine (g_25_24,p_25_24,g25,p25,g24,p24) and2( w0g_25_24, p25, g24 )#5 or2( g_25_24, w0g_25_24, g25 )#5 and2( p_25_24, p25, p24)#5 end netlist // PGcombine (g_26_25,p_26_25,g26,p26,g25,p25) and2( w0g_26_25, p26, g25 )#5 or2( g_26_25, w0g_26_25, g26 )#5 and2( p_26_25, p26, p25)#5 end netlist // PGcombine (g_27_26,p_27_26,g27,p27,g26,p26) and2( w0g_27_26, p27, g26 )#5 or2( g_27_26, w0g_27_26, g27 )#5 and2( p_27_26, p27, p26)#5 end netlist // PGcombine (g_28_27,p_28_27,g28,p28,g27,p27) and2( w0g_28_27, p28, g27 )#5 or2( g_28_27, w0g_28_27, g28 )#5 and2( p_28_27, p28, p27)#5 end netlist // PGcombine (g_29_28,p_29_28,g29,p29,g28,p28) and2( w0g_29_28, p29, g28 )#5 or2( g_29_28, w0g_29_28, g29 )#5 and2( p_29_28, p29, p28)#5 end netlist // PGcombine (g_30_29,p_30_29,g30,p30,g29,p29) and2( w0g_30_29, p30, g29 )#5 or2( g_30_29, w0g_30_29, g30 )#5 and2( p_30_29, p30, p29)#5 end netlist // PGcombine (g_31_30,p_31_30,g31,p31,g30,p30) and2( w0g_31_30, p31, g30 )#5 or2( g_31_30, w0g_31_30, g31 )#5 and2( p_31_30, p31, p30)#5 end netlist // PGcombine (g_32_31,p_32_31,g32,p32,g31,p31) and2( w0g_32_31, p32, g31 )#5 or2( g_32_31, w0g_32_31, g32 )#5 and2( p_32_31, p32, p31)#5 end netlist // PGcombine (g_33_32,p_33_32,g33,p33,g32,p32) and2( w0g_33_32, p33, g32 )#5 or2( g_33_32, w0g_33_32, g33 )#5 and2( p_33_32, p33, p32)#5 end netlist // PGcombine (g_34_33,p_34_33,g34,p34,g33,p33) and2( w0g_34_33, p34, g33 )#5 or2( g_34_33, w0g_34_33, g34 )#5 and2( p_34_33, p34, p33)#5 end netlist // PGcombine (g_35_34,p_35_34,g35,p35,g34,p34) and2( w0g_35_34, p35, g34 )#5 or2( g_35_34, w0g_35_34, g35 )#5 and2( p_35_34, p35, p34)#5 end netlist // PGcombine (g_36_35,p_36_35,g36,p36,g35,p35) and2( w0g_36_35, p36, g35 )#5 or2( g_36_35, w0g_36_35, g36 )#5 and2( p_36_35, p36, p35)#5 end netlist // PGcombine (g_37_36,p_37_36,g37,p37,g36,p36) and2( w0g_37_36, p37, g36 )#5 or2( g_37_36, w0g_37_36, g37 )#5 and2( p_37_36, p37, p36)#5 end netlist // PGcombine (g_38_37,p_38_37,g38,p38,g37,p37) and2( w0g_38_37, p38, g37 )#5 or2( g_38_37, w0g_38_37, g38 )#5 and2( p_38_37, p38, p37)#5 end netlist // PGcombine (g_39_38,p_39_38,g39,p39,g38,p38) and2( w0g_39_38, p39, g38 )#5 or2( g_39_38, w0g_39_38, g39 )#5 and2( p_39_38, p39, p38)#5 end netlist // PGcombine (g_40_39,p_40_39,g40,p40,g39,p39) and2( w0g_40_39, p40, g39 )#5 or2( g_40_39, w0g_40_39, g40 )#5 and2( p_40_39, p40, p39)#5 end netlist // PGcombine (g_41_40,p_41_40,g41,p41,g40,p40) and2( w0g_41_40, p41, g40 )#5 or2( g_41_40, w0g_41_40, g41 )#5 and2( p_41_40, p41, p40)#5 end netlist // PGcombine (g_42_41,p_42_41,g42,p42,g41,p41) and2( w0g_42_41, p42, g41 )#5 or2( g_42_41, w0g_42_41, g42 )#5 and2( p_42_41, p42, p41)#5 end netlist // PGcombine (g_43_42,p_43_42,g43,p43,g42,p42) and2( w0g_43_42, p43, g42 )#5 or2( g_43_42, w0g_43_42, g43 )#5 and2( p_43_42, p43, p42)#5 end netlist // PGcombine (g_44_43,p_44_43,g44,p44,g43,p43) and2( w0g_44_43, p44, g43 )#5 or2( g_44_43, w0g_44_43, g44 )#5 and2( p_44_43, p44, p43)#5 end netlist // PGcombine (g_45_44,p_45_44,g45,p45,g44,p44) and2( w0g_45_44, p45, g44 )#5 or2( g_45_44, w0g_45_44, g45 )#5 and2( p_45_44, p45, p44)#5 end netlist // PGcombine (g_46_45,p_46_45,g46,p46,g45,p45) and2( w0g_46_45, p46, g45 )#5 or2( g_46_45, w0g_46_45, g46 )#5 and2( p_46_45, p46, p45)#5 end netlist // PGcombine (g_47_46,p_47_46,g47,p47,g46,p46) and2( w0g_47_46, p47, g46 )#5 or2( g_47_46, w0g_47_46, g47 )#5 and2( p_47_46, p47, p46)#5 end netlist // PGcombine (g_48_47,p_48_47,g48,p48,g47,p47) and2( w0g_48_47, p48, g47 )#5 or2( g_48_47, w0g_48_47, g48 )#5 and2( p_48_47, p48, p47)#5 end netlist // PGcombine (g_49_48,p_49_48,g49,p49,g48,p48) and2( w0g_49_48, p49, g48 )#5 or2( g_49_48, w0g_49_48, g49 )#5 and2( p_49_48, p49, p48)#5 end netlist // PGcombine (g_50_49,p_50_49,g50,p50,g49,p49) and2( w0g_50_49, p50, g49 )#5 or2( g_50_49, w0g_50_49, g50 )#5 and2( p_50_49, p50, p49)#5 end netlist // PGcombine (g_51_50,p_51_50,g51,p51,g50,p50) and2( w0g_51_50, p51, g50 )#5 or2( g_51_50, w0g_51_50, g51 )#5 and2( p_51_50, p51, p50)#5 end netlist // PGcombine (g_52_51,p_52_51,g52,p52,g51,p51) and2( w0g_52_51, p52, g51 )#5 or2( g_52_51, w0g_52_51, g52 )#5 and2( p_52_51, p52, p51)#5 end netlist // PGcombine (g_53_52,p_53_52,g53,p53,g52,p52) and2( w0g_53_52, p53, g52 )#5 or2( g_53_52, w0g_53_52, g53 )#5 and2( p_53_52, p53, p52)#5 end netlist // PGcombine (g_54_53,p_54_53,g54,p54,g53,p53) and2( w0g_54_53, p54, g53 )#5 or2( g_54_53, w0g_54_53, g54 )#5 and2( p_54_53, p54, p53)#5 end netlist // PGcombine (g_55_54,p_55_54,g55,p55,g54,p54) and2( w0g_55_54, p55, g54 )#5 or2( g_55_54, w0g_55_54, g55 )#5 and2( p_55_54, p55, p54)#5 end netlist // PGcombine (g_56_55,p_56_55,g56,p56,g55,p55) and2( w0g_56_55, p56, g55 )#5 or2( g_56_55, w0g_56_55, g56 )#5 and2( p_56_55, p56, p55)#5 end netlist // PGcombine (g_57_56,p_57_56,g57,p57,g56,p56) and2( w0g_57_56, p57, g56 )#5 or2( g_57_56, w0g_57_56, g57 )#5 and2( p_57_56, p57, p56)#5 end netlist // PGcombine (g_58_57,p_58_57,g58,p58,g57,p57) and2( w0g_58_57, p58, g57 )#5 or2( g_58_57, w0g_58_57, g58 )#5 and2( p_58_57, p58, p57)#5 end netlist // PGcombine (g_59_58,p_59_58,g59,p59,g58,p58) and2( w0g_59_58, p59, g58 )#5 or2( g_59_58, w0g_59_58, g59 )#5 and2( p_59_58, p59, p58)#5 end netlist // PGcombine (g_60_59,p_60_59,g60,p60,g59,p59) and2( w0g_60_59, p60, g59 )#5 or2( g_60_59, w0g_60_59, g60 )#5 and2( p_60_59, p60, p59)#5 end netlist // PGcombine (g_61_60,p_61_60,g61,p61,g60,p60) and2( w0g_61_60, p61, g60 )#5 or2( g_61_60, w0g_61_60, g61 )#5 and2( p_61_60, p61, p60)#5 end netlist // PGcombine (g_62_61,p_62_61,g62,p62,g61,p61) and2( w0g_62_61, p62, g61 )#5 or2( g_62_61, w0g_62_61, g62 )#5 and2( p_62_61, p62, p61)#5 end netlist // PGcombine (g_63_62,p_63_62,g63,p63,g62,p62) and2( w0g_63_62, p63, g62 )#5 or2( g_63_62, w0g_63_62, g63 )#5 and2( p_63_62, p63, p62)#5 end netlist // Gcombine (g_1_cin, g_1_0, cin, p_1_0 ) and2(w0g_1_cin, p_1_0, cin )#5 or2( g_1_cin, w0g_1_cin, g_1_0 )#5 end netlist // Gcombine (g_2_cin, g_2_1, g_0_cin, p_2_1 ) and2(w0g_2_cin, p_2_1, g_0_cin )#5 or2( g_2_cin, w0g_2_cin, g_2_1 )#5 end netlist // PGcombine (g_3_0,p_3_0,g_3_2,p_3_2,g_1_0,p_1_0) and2( w0g_3_0, p_3_2, g_1_0 )#5 or2( g_3_0, w0g_3_0, g_3_2 )#5 and2( p_3_0, p_3_2, p_1_0)#5 end netlist // PGcombine (g_4_1,p_4_1,g_4_3,p_4_3,g_2_1,p_2_1) and2( w0g_4_1, p_4_3, g_2_1 )#5 or2( g_4_1, w0g_4_1, g_4_3 )#5 and2( p_4_1, p_4_3, p_2_1)#5 end netlist // PGcombine (g_5_2,p_5_2,g_5_4,p_5_4,g_3_2,p_3_2) and2( w0g_5_2, p_5_4, g_3_2 )#5 or2( g_5_2, w0g_5_2, g_5_4 )#5 and2( p_5_2, p_5_4, p_3_2)#5 end netlist // PGcombine (g_6_3,p_6_3,g_6_5,p_6_5,g_4_3,p_4_3) and2( w0g_6_3, p_6_5, g_4_3 )#5 or2( g_6_3, w0g_6_3, g_6_5 )#5 and2( p_6_3, p_6_5, p_4_3)#5 end netlist // PGcombine (g_7_4,p_7_4,g_7_6,p_7_6,g_5_4,p_5_4) and2( w0g_7_4, p_7_6, g_5_4 )#5 or2( g_7_4, w0g_7_4, g_7_6 )#5 and2( p_7_4, p_7_6, p_5_4)#5 end netlist // PGcombine (g_8_5,p_8_5,g_8_7,p_8_7,g_6_5,p_6_5) and2( w0g_8_5, p_8_7, g_6_5 )#5 or2( g_8_5, w0g_8_5, g_8_7 )#5 and2( p_8_5, p_8_7, p_6_5)#5 end netlist // PGcombine (g_9_6,p_9_6,g_9_8,p_9_8,g_7_6,p_7_6) and2( w0g_9_6, p_9_8, g_7_6 )#5 or2( g_9_6, w0g_9_6, g_9_8 )#5 and2( p_9_6, p_9_8, p_7_6)#5 end netlist // PGcombine (g_10_7,p_10_7,g_10_9,p_10_9,g_8_7,p_8_7) and2( w0g_10_7, p_10_9, g_8_7 )#5 or2( g_10_7, w0g_10_7, g_10_9 )#5 and2( p_10_7, p_10_9, p_8_7)#5 end netlist // PGcombine (g_11_8,p_11_8,g_11_10,p_11_10,g_9_8,p_9_8) and2( w0g_11_8, p_11_10, g_9_8 )#5 or2( g_11_8, w0g_11_8, g_11_10 )#5 and2( p_11_8, p_11_10, p_9_8)#5 end netlist // PGcombine (g_12_9,p_12_9,g_12_11,p_12_11,g_10_9,p_10_9) and2( w0g_12_9, p_12_11, g_10_9 )#5 or2( g_12_9, w0g_12_9, g_12_11 )#5 and2( p_12_9, p_12_11, p_10_9)#5 end netlist // PGcombine (g_13_10,p_13_10,g_13_12,p_13_12,g_11_10,p_11_10) and2( w0g_13_10, p_13_12, g_11_10 )#5 or2( g_13_10, w0g_13_10, g_13_12 )#5 and2( p_13_10, p_13_12, p_11_10)#5 end netlist // PGcombine (g_14_11,p_14_11,g_14_13,p_14_13,g_12_11,p_12_11) and2( w0g_14_11, p_14_13, g_12_11 )#5 or2( g_14_11, w0g_14_11, g_14_13 )#5 and2( p_14_11, p_14_13, p_12_11)#5 end netlist // PGcombine (g_15_12,p_15_12,g_15_14,p_15_14,g_13_12,p_13_12) and2( w0g_15_12, p_15_14, g_13_12 )#5 or2( g_15_12, w0g_15_12, g_15_14 )#5 and2( p_15_12, p_15_14, p_13_12)#5 end netlist // PGcombine (g_16_13,p_16_13,g_16_15,p_16_15,g_14_13,p_14_13) and2( w0g_16_13, p_16_15, g_14_13 )#5 or2( g_16_13, w0g_16_13, g_16_15 )#5 and2( p_16_13, p_16_15, p_14_13)#5 end netlist // PGcombine (g_17_14,p_17_14,g_17_16,p_17_16,g_15_14,p_15_14) and2( w0g_17_14, p_17_16, g_15_14 )#5 or2( g_17_14, w0g_17_14, g_17_16 )#5 and2( p_17_14, p_17_16, p_15_14)#5 end netlist // PGcombine (g_18_15,p_18_15,g_18_17,p_18_17,g_16_15,p_16_15) and2( w0g_18_15, p_18_17, g_16_15 )#5 or2( g_18_15, w0g_18_15, g_18_17 )#5 and2( p_18_15, p_18_17, p_16_15)#5 end netlist // PGcombine (g_19_16,p_19_16,g_19_18,p_19_18,g_17_16,p_17_16) and2( w0g_19_16, p_19_18, g_17_16 )#5 or2( g_19_16, w0g_19_16, g_19_18 )#5 and2( p_19_16, p_19_18, p_17_16)#5 end netlist // PGcombine (g_20_17,p_20_17,g_20_19,p_20_19,g_18_17,p_18_17) and2( w0g_20_17, p_20_19, g_18_17 )#5 or2( g_20_17, w0g_20_17, g_20_19 )#5 and2( p_20_17, p_20_19, p_18_17)#5 end netlist // PGcombine (g_21_18,p_21_18,g_21_20,p_21_20,g_19_18,p_19_18) and2( w0g_21_18, p_21_20, g_19_18 )#5 or2( g_21_18, w0g_21_18, g_21_20 )#5 and2( p_21_18, p_21_20, p_19_18)#5 end netlist // PGcombine (g_22_19,p_22_19,g_22_21,p_22_21,g_20_19,p_20_19) and2( w0g_22_19, p_22_21, g_20_19 )#5 or2( g_22_19, w0g_22_19, g_22_21 )#5 and2( p_22_19, p_22_21, p_20_19)#5 end netlist // PGcombine (g_23_20,p_23_20,g_23_22,p_23_22,g_21_20,p_21_20) and2( w0g_23_20, p_23_22, g_21_20 )#5 or2( g_23_20, w0g_23_20, g_23_22 )#5 and2( p_23_20, p_23_22, p_21_20)#5 end netlist // PGcombine (g_24_21,p_24_21,g_24_23,p_24_23,g_22_21,p_22_21) and2( w0g_24_21, p_24_23, g_22_21 )#5 or2( g_24_21, w0g_24_21, g_24_23 )#5 and2( p_24_21, p_24_23, p_22_21)#5 end netlist // PGcombine (g_25_22,p_25_22,g_25_24,p_25_24,g_23_22,p_23_22) and2( w0g_25_22, p_25_24, g_23_22 )#5 or2( g_25_22, w0g_25_22, g_25_24 )#5 and2( p_25_22, p_25_24, p_23_22)#5 end netlist // PGcombine (g_26_23,p_26_23,g_26_25,p_26_25,g_24_23,p_24_23) and2( w0g_26_23, p_26_25, g_24_23 )#5 or2( g_26_23, w0g_26_23, g_26_25 )#5 and2( p_26_23, p_26_25, p_24_23)#5 end netlist // PGcombine (g_27_24,p_27_24,g_27_26,p_27_26,g_25_24,p_25_24) and2( w0g_27_24, p_27_26, g_25_24 )#5 or2( g_27_24, w0g_27_24, g_27_26 )#5 and2( p_27_24, p_27_26, p_25_24)#5 end netlist // PGcombine (g_28_25,p_28_25,g_28_27,p_28_27,g_26_25,p_26_25) and2( w0g_28_25, p_28_27, g_26_25 )#5 or2( g_28_25, w0g_28_25, g_28_27 )#5 and2( p_28_25, p_28_27, p_26_25)#5 end netlist // PGcombine (g_29_26,p_29_26,g_29_28,p_29_28,g_27_26,p_27_26) and2( w0g_29_26, p_29_28, g_27_26 )#5 or2( g_29_26, w0g_29_26, g_29_28 )#5 and2( p_29_26, p_29_28, p_27_26)#5 end netlist // PGcombine (g_30_27,p_30_27,g_30_29,p_30_29,g_28_27,p_28_27) and2( w0g_30_27, p_30_29, g_28_27 )#5 or2( g_30_27, w0g_30_27, g_30_29 )#5 and2( p_30_27, p_30_29, p_28_27)#5 end netlist // PGcombine (g_31_28,p_31_28,g_31_30,p_31_30,g_29_28,p_29_28) and2( w0g_31_28, p_31_30, g_29_28 )#5 or2( g_31_28, w0g_31_28, g_31_30 )#5 and2( p_31_28, p_31_30, p_29_28)#5 end netlist // PGcombine (g_32_29,p_32_29,g_32_31,p_32_31,g_30_29,p_30_29) and2( w0g_32_29, p_32_31, g_30_29 )#5 or2( g_32_29, w0g_32_29, g_32_31 )#5 and2( p_32_29, p_32_31, p_30_29)#5 end netlist // PGcombine (g_33_30,p_33_30,g_33_32,p_33_32,g_31_30,p_31_30) and2( w0g_33_30, p_33_32, g_31_30 )#5 or2( g_33_30, w0g_33_30, g_33_32 )#5 and2( p_33_30, p_33_32, p_31_30)#5 end netlist // PGcombine (g_34_31,p_34_31,g_34_33,p_34_33,g_32_31,p_32_31) and2( w0g_34_31, p_34_33, g_32_31 )#5 or2( g_34_31, w0g_34_31, g_34_33 )#5 and2( p_34_31, p_34_33, p_32_31)#5 end netlist // PGcombine (g_35_32,p_35_32,g_35_34,p_35_34,g_33_32,p_33_32) and2( w0g_35_32, p_35_34, g_33_32 )#5 or2( g_35_32, w0g_35_32, g_35_34 )#5 and2( p_35_32, p_35_34, p_33_32)#5 end netlist // PGcombine (g_36_33,p_36_33,g_36_35,p_36_35,g_34_33,p_34_33) and2( w0g_36_33, p_36_35, g_34_33 )#5 or2( g_36_33, w0g_36_33, g_36_35 )#5 and2( p_36_33, p_36_35, p_34_33)#5 end netlist // PGcombine (g_37_34,p_37_34,g_37_36,p_37_36,g_35_34,p_35_34) and2( w0g_37_34, p_37_36, g_35_34 )#5 or2( g_37_34, w0g_37_34, g_37_36 )#5 and2( p_37_34, p_37_36, p_35_34)#5 end netlist // PGcombine (g_38_35,p_38_35,g_38_37,p_38_37,g_36_35,p_36_35) and2( w0g_38_35, p_38_37, g_36_35 )#5 or2( g_38_35, w0g_38_35, g_38_37 )#5 and2( p_38_35, p_38_37, p_36_35)#5 end netlist // PGcombine (g_39_36,p_39_36,g_39_38,p_39_38,g_37_36,p_37_36) and2( w0g_39_36, p_39_38, g_37_36 )#5 or2( g_39_36, w0g_39_36, g_39_38 )#5 and2( p_39_36, p_39_38, p_37_36)#5 end netlist // PGcombine (g_40_37,p_40_37,g_40_39,p_40_39,g_38_37,p_38_37) and2( w0g_40_37, p_40_39, g_38_37 )#5 or2( g_40_37, w0g_40_37, g_40_39 )#5 and2( p_40_37, p_40_39, p_38_37)#5 end netlist // PGcombine (g_41_38,p_41_38,g_41_40,p_41_40,g_39_38,p_39_38) and2( w0g_41_38, p_41_40, g_39_38 )#5 or2( g_41_38, w0g_41_38, g_41_40 )#5 and2( p_41_38, p_41_40, p_39_38)#5 end netlist // PGcombine (g_42_39,p_42_39,g_42_41,p_42_41,g_40_39,p_40_39) and2( w0g_42_39, p_42_41, g_40_39 )#5 or2( g_42_39, w0g_42_39, g_42_41 )#5 and2( p_42_39, p_42_41, p_40_39)#5 end netlist // PGcombine (g_43_40,p_43_40,g_43_42,p_43_42,g_41_40,p_41_40) and2( w0g_43_40, p_43_42, g_41_40 )#5 or2( g_43_40, w0g_43_40, g_43_42 )#5 and2( p_43_40, p_43_42, p_41_40)#5 end netlist // PGcombine (g_44_41,p_44_41,g_44_43,p_44_43,g_42_41,p_42_41) and2( w0g_44_41, p_44_43, g_42_41 )#5 or2( g_44_41, w0g_44_41, g_44_43 )#5 and2( p_44_41, p_44_43, p_42_41)#5 end netlist // PGcombine (g_45_42,p_45_42,g_45_44,p_45_44,g_43_42,p_43_42) and2( w0g_45_42, p_45_44, g_43_42 )#5 or2( g_45_42, w0g_45_42, g_45_44 )#5 and2( p_45_42, p_45_44, p_43_42)#5 end netlist // PGcombine (g_46_43,p_46_43,g_46_45,p_46_45,g_44_43,p_44_43) and2( w0g_46_43, p_46_45, g_44_43 )#5 or2( g_46_43, w0g_46_43, g_46_45 )#5 and2( p_46_43, p_46_45, p_44_43)#5 end netlist // PGcombine (g_47_44,p_47_44,g_47_46,p_47_46,g_45_44,p_45_44) and2( w0g_47_44, p_47_46, g_45_44 )#5 or2( g_47_44, w0g_47_44, g_47_46 )#5 and2( p_47_44, p_47_46, p_45_44)#5 end netlist // PGcombine (g_48_45,p_48_45,g_48_47,p_48_47,g_46_45,p_46_45) and2( w0g_48_45, p_48_47, g_46_45 )#5 or2( g_48_45, w0g_48_45, g_48_47 )#5 and2( p_48_45, p_48_47, p_46_45)#5 end netlist // PGcombine (g_49_46,p_49_46,g_49_48,p_49_48,g_47_46,p_47_46) and2( w0g_49_46, p_49_48, g_47_46 )#5 or2( g_49_46, w0g_49_46, g_49_48 )#5 and2( p_49_46, p_49_48, p_47_46)#5 end netlist // PGcombine (g_50_47,p_50_47,g_50_49,p_50_49,g_48_47,p_48_47) and2( w0g_50_47, p_50_49, g_48_47 )#5 or2( g_50_47, w0g_50_47, g_50_49 )#5 and2( p_50_47, p_50_49, p_48_47)#5 end netlist // PGcombine (g_51_48,p_51_48,g_51_50,p_51_50,g_49_48,p_49_48) and2( w0g_51_48, p_51_50, g_49_48 )#5 or2( g_51_48, w0g_51_48, g_51_50 )#5 and2( p_51_48, p_51_50, p_49_48)#5 end netlist // PGcombine (g_52_49,p_52_49,g_52_51,p_52_51,g_50_49,p_50_49) and2( w0g_52_49, p_52_51, g_50_49 )#5 or2( g_52_49, w0g_52_49, g_52_51 )#5 and2( p_52_49, p_52_51, p_50_49)#5 end netlist // PGcombine (g_53_50,p_53_50,g_53_52,p_53_52,g_51_50,p_51_50) and2( w0g_53_50, p_53_52, g_51_50 )#5 or2( g_53_50, w0g_53_50, g_53_52 )#5 and2( p_53_50, p_53_52, p_51_50)#5 end netlist // PGcombine (g_54_51,p_54_51,g_54_53,p_54_53,g_52_51,p_52_51) and2( w0g_54_51, p_54_53, g_52_51 )#5 or2( g_54_51, w0g_54_51, g_54_53 )#5 and2( p_54_51, p_54_53, p_52_51)#5 end netlist // PGcombine (g_55_52,p_55_52,g_55_54,p_55_54,g_53_52,p_53_52) and2( w0g_55_52, p_55_54, g_53_52 )#5 or2( g_55_52, w0g_55_52, g_55_54 )#5 and2( p_55_52, p_55_54, p_53_52)#5 end netlist // PGcombine (g_56_53,p_56_53,g_56_55,p_56_55,g_54_53,p_54_53) and2( w0g_56_53, p_56_55, g_54_53 )#5 or2( g_56_53, w0g_56_53, g_56_55 )#5 and2( p_56_53, p_56_55, p_54_53)#5 end netlist // PGcombine (g_57_54,p_57_54,g_57_56,p_57_56,g_55_54,p_55_54) and2( w0g_57_54, p_57_56, g_55_54 )#5 or2( g_57_54, w0g_57_54, g_57_56 )#5 and2( p_57_54, p_57_56, p_55_54)#5 end netlist // PGcombine (g_58_55,p_58_55,g_58_57,p_58_57,g_56_55,p_56_55) and2( w0g_58_55, p_58_57, g_56_55 )#5 or2( g_58_55, w0g_58_55, g_58_57 )#5 and2( p_58_55, p_58_57, p_56_55)#5 end netlist // PGcombine (g_59_56,p_59_56,g_59_58,p_59_58,g_57_56,p_57_56) and2( w0g_59_56, p_59_58, g_57_56 )#5 or2( g_59_56, w0g_59_56, g_59_58 )#5 and2( p_59_56, p_59_58, p_57_56)#5 end netlist // PGcombine (g_60_57,p_60_57,g_60_59,p_60_59,g_58_57,p_58_57) and2( w0g_60_57, p_60_59, g_58_57 )#5 or2( g_60_57, w0g_60_57, g_60_59 )#5 and2( p_60_57, p_60_59, p_58_57)#5 end netlist // PGcombine (g_61_58,p_61_58,g_61_60,p_61_60,g_59_58,p_59_58) and2( w0g_61_58, p_61_60, g_59_58 )#5 or2( g_61_58, w0g_61_58, g_61_60 )#5 and2( p_61_58, p_61_60, p_59_58)#5 end netlist // PGcombine (g_62_59,p_62_59,g_62_61,p_62_61,g_60_59,p_60_59) and2( w0g_62_59, p_62_61, g_60_59 )#5 or2( g_62_59, w0g_62_59, g_62_61 )#5 and2( p_62_59, p_62_61, p_60_59)#5 end netlist // PGcombine (g_63_60,p_63_60,g_63_62,p_63_62,g_61_60,p_61_60) and2( w0g_63_60, p_63_62, g_61_60 )#5 or2( g_63_60, w0g_63_60, g_63_62 )#5 and2( p_63_60, p_63_62, p_61_60)#5 end netlist // Gcombine (g_3_cin, g_3_0, cin, p_3_0 ) and2(w0g_3_cin, p_3_0, cin )#5 or2( g_3_cin, w0g_3_cin, g_3_0 )#5 end netlist // Gcombine (g_4_cin, g_4_1, g_0_cin, p_4_1 ) and2(w0g_4_cin, p_4_1, g_0_cin )#5 or2( g_4_cin, w0g_4_cin, g_4_1 )#5 end netlist // Gcombine (g_5_cin, g_5_2, g_1_cin, p_5_2 ) and2(w0g_5_cin, p_5_2, g_1_cin )#5 or2( g_5_cin, w0g_5_cin, g_5_2 )#5 end netlist // Gcombine (g_6_cin, g_6_3, g_2_cin, p_6_3 ) and2(w0g_6_cin, p_6_3, g_2_cin )#5 or2( g_6_cin, w0g_6_cin, g_6_3 )#5 end netlist // PGcombine (g_7_0,p_7_0,g_7_4,p_7_4,g_3_0,p_3_0) and2( w0g_7_0, p_7_4, g_3_0 )#5 or2( g_7_0, w0g_7_0, g_7_4 )#5 and2( p_7_0, p_7_4, p_3_0)#5 end netlist // PGcombine (g_8_1,p_8_1,g_8_5,p_8_5,g_4_1,p_4_1) and2( w0g_8_1, p_8_5, g_4_1 )#5 or2( g_8_1, w0g_8_1, g_8_5 )#5 and2( p_8_1, p_8_5, p_4_1)#5 end netlist // PGcombine (g_9_2,p_9_2,g_9_6,p_9_6,g_5_2,p_5_2) and2( w0g_9_2, p_9_6, g_5_2 )#5 or2( g_9_2, w0g_9_2, g_9_6 )#5 and2( p_9_2, p_9_6, p_5_2)#5 end netlist // PGcombine (g_10_3,p_10_3,g_10_7,p_10_7,g_6_3,p_6_3) and2( w0g_10_3, p_10_7, g_6_3 )#5 or2( g_10_3, w0g_10_3, g_10_7 )#5 and2( p_10_3, p_10_7, p_6_3)#5 end netlist // PGcombine (g_11_4,p_11_4,g_11_8,p_11_8,g_7_4,p_7_4) and2( w0g_11_4, p_11_8, g_7_4 )#5 or2( g_11_4, w0g_11_4, g_11_8 )#5 and2( p_11_4, p_11_8, p_7_4)#5 end netlist // PGcombine (g_12_5,p_12_5,g_12_9,p_12_9,g_8_5,p_8_5) and2( w0g_12_5, p_12_9, g_8_5 )#5 or2( g_12_5, w0g_12_5, g_12_9 )#5 and2( p_12_5, p_12_9, p_8_5)#5 end netlist // PGcombine (g_13_6,p_13_6,g_13_10,p_13_10,g_9_6,p_9_6) and2( w0g_13_6, p_13_10, g_9_6 )#5 or2( g_13_6, w0g_13_6, g_13_10 )#5 and2( p_13_6, p_13_10, p_9_6)#5 end netlist // PGcombine (g_14_7,p_14_7,g_14_11,p_14_11,g_10_7,p_10_7) and2( w0g_14_7, p_14_11, g_10_7 )#5 or2( g_14_7, w0g_14_7, g_14_11 )#5 and2( p_14_7, p_14_11, p_10_7)#5 end netlist // PGcombine (g_15_8,p_15_8,g_15_12,p_15_12,g_11_8,p_11_8) and2( w0g_15_8, p_15_12, g_11_8 )#5 or2( g_15_8, w0g_15_8, g_15_12 )#5 and2( p_15_8, p_15_12, p_11_8)#5 end netlist // PGcombine (g_16_9,p_16_9,g_16_13,p_16_13,g_12_9,p_12_9) and2( w0g_16_9, p_16_13, g_12_9 )#5 or2( g_16_9, w0g_16_9, g_16_13 )#5 and2( p_16_9, p_16_13, p_12_9)#5 end netlist // PGcombine (g_17_10,p_17_10,g_17_14,p_17_14,g_13_10,p_13_10) and2( w0g_17_10, p_17_14, g_13_10 )#5 or2( g_17_10, w0g_17_10, g_17_14 )#5 and2( p_17_10, p_17_14, p_13_10)#5 end netlist // PGcombine (g_18_11,p_18_11,g_18_15,p_18_15,g_14_11,p_14_11) and2( w0g_18_11, p_18_15, g_14_11 )#5 or2( g_18_11, w0g_18_11, g_18_15 )#5 and2( p_18_11, p_18_15, p_14_11)#5 end netlist // PGcombine (g_19_12,p_19_12,g_19_16,p_19_16,g_15_12,p_15_12) and2( w0g_19_12, p_19_16, g_15_12 )#5 or2( g_19_12, w0g_19_12, g_19_16 )#5 and2( p_19_12, p_19_16, p_15_12)#5 end netlist // PGcombine (g_20_13,p_20_13,g_20_17,p_20_17,g_16_13,p_16_13) and2( w0g_20_13, p_20_17, g_16_13 )#5 or2( g_20_13, w0g_20_13, g_20_17 )#5 and2( p_20_13, p_20_17, p_16_13)#5 end netlist // PGcombine (g_21_14,p_21_14,g_21_18,p_21_18,g_17_14,p_17_14) and2( w0g_21_14, p_21_18, g_17_14 )#5 or2( g_21_14, w0g_21_14, g_21_18 )#5 and2( p_21_14, p_21_18, p_17_14)#5 end netlist // PGcombine (g_22_15,p_22_15,g_22_19,p_22_19,g_18_15,p_18_15) and2( w0g_22_15, p_22_19, g_18_15 )#5 or2( g_22_15, w0g_22_15, g_22_19 )#5 and2( p_22_15, p_22_19, p_18_15)#5 end netlist // PGcombine (g_23_16,p_23_16,g_23_20,p_23_20,g_19_16,p_19_16) and2( w0g_23_16, p_23_20, g_19_16 )#5 or2( g_23_16, w0g_23_16, g_23_20 )#5 and2( p_23_16, p_23_20, p_19_16)#5 end netlist // PGcombine (g_24_17,p_24_17,g_24_21,p_24_21,g_20_17,p_20_17) and2( w0g_24_17, p_24_21, g_20_17 )#5 or2( g_24_17, w0g_24_17, g_24_21 )#5 and2( p_24_17, p_24_21, p_20_17)#5 end netlist // PGcombine (g_25_18,p_25_18,g_25_22,p_25_22,g_21_18,p_21_18) and2( w0g_25_18, p_25_22, g_21_18 )#5 or2( g_25_18, w0g_25_18, g_25_22 )#5 and2( p_25_18, p_25_22, p_21_18)#5 end netlist // PGcombine (g_26_19,p_26_19,g_26_23,p_26_23,g_22_19,p_22_19) and2( w0g_26_19, p_26_23, g_22_19 )#5 or2( g_26_19, w0g_26_19, g_26_23 )#5 and2( p_26_19, p_26_23, p_22_19)#5 end netlist // PGcombine (g_27_20,p_27_20,g_27_24,p_27_24,g_23_20,p_23_20) and2( w0g_27_20, p_27_24, g_23_20 )#5 or2( g_27_20, w0g_27_20, g_27_24 )#5 and2( p_27_20, p_27_24, p_23_20)#5 end netlist // PGcombine (g_28_21,p_28_21,g_28_25,p_28_25,g_24_21,p_24_21) and2( w0g_28_21, p_28_25, g_24_21 )#5 or2( g_28_21, w0g_28_21, g_28_25 )#5 and2( p_28_21, p_28_25, p_24_21)#5 end netlist // PGcombine (g_29_22,p_29_22,g_29_26,p_29_26,g_25_22,p_25_22) and2( w0g_29_22, p_29_26, g_25_22 )#5 or2( g_29_22, w0g_29_22, g_29_26 )#5 and2( p_29_22, p_29_26, p_25_22)#5 end netlist // PGcombine (g_30_23,p_30_23,g_30_27,p_30_27,g_26_23,p_26_23) and2( w0g_30_23, p_30_27, g_26_23 )#5 or2( g_30_23, w0g_30_23, g_30_27 )#5 and2( p_30_23, p_30_27, p_26_23)#5 end netlist // PGcombine (g_31_24,p_31_24,g_31_28,p_31_28,g_27_24,p_27_24) and2( w0g_31_24, p_31_28, g_27_24 )#5 or2( g_31_24, w0g_31_24, g_31_28 )#5 and2( p_31_24, p_31_28, p_27_24)#5 end netlist // PGcombine (g_32_25,p_32_25,g_32_29,p_32_29,g_28_25,p_28_25) and2( w0g_32_25, p_32_29, g_28_25 )#5 or2( g_32_25, w0g_32_25, g_32_29 )#5 and2( p_32_25, p_32_29, p_28_25)#5 end netlist // PGcombine (g_33_26,p_33_26,g_33_30,p_33_30,g_29_26,p_29_26) and2( w0g_33_26, p_33_30, g_29_26 )#5 or2( g_33_26, w0g_33_26, g_33_30 )#5 and2( p_33_26, p_33_30, p_29_26)#5 end netlist // PGcombine (g_34_27,p_34_27,g_34_31,p_34_31,g_30_27,p_30_27) and2( w0g_34_27, p_34_31, g_30_27 )#5 or2( g_34_27, w0g_34_27, g_34_31 )#5 and2( p_34_27, p_34_31, p_30_27)#5 end netlist // PGcombine (g_35_28,p_35_28,g_35_32,p_35_32,g_31_28,p_31_28) and2( w0g_35_28, p_35_32, g_31_28 )#5 or2( g_35_28, w0g_35_28, g_35_32 )#5 and2( p_35_28, p_35_32, p_31_28)#5 end netlist // PGcombine (g_36_29,p_36_29,g_36_33,p_36_33,g_32_29,p_32_29) and2( w0g_36_29, p_36_33, g_32_29 )#5 or2( g_36_29, w0g_36_29, g_36_33 )#5 and2( p_36_29, p_36_33, p_32_29)#5 end netlist // PGcombine (g_37_30,p_37_30,g_37_34,p_37_34,g_33_30,p_33_30) and2( w0g_37_30, p_37_34, g_33_30 )#5 or2( g_37_30, w0g_37_30, g_37_34 )#5 and2( p_37_30, p_37_34, p_33_30)#5 end netlist // PGcombine (g_38_31,p_38_31,g_38_35,p_38_35,g_34_31,p_34_31) and2( w0g_38_31, p_38_35, g_34_31 )#5 or2( g_38_31, w0g_38_31, g_38_35 )#5 and2( p_38_31, p_38_35, p_34_31)#5 end netlist // PGcombine (g_39_32,p_39_32,g_39_36,p_39_36,g_35_32,p_35_32) and2( w0g_39_32, p_39_36, g_35_32 )#5 or2( g_39_32, w0g_39_32, g_39_36 )#5 and2( p_39_32, p_39_36, p_35_32)#5 end netlist // PGcombine (g_40_33,p_40_33,g_40_37,p_40_37,g_36_33,p_36_33) and2( w0g_40_33, p_40_37, g_36_33 )#5 or2( g_40_33, w0g_40_33, g_40_37 )#5 and2( p_40_33, p_40_37, p_36_33)#5 end netlist // PGcombine (g_41_34,p_41_34,g_41_38,p_41_38,g_37_34,p_37_34) and2( w0g_41_34, p_41_38, g_37_34 )#5 or2( g_41_34, w0g_41_34, g_41_38 )#5 and2( p_41_34, p_41_38, p_37_34)#5 end netlist // PGcombine (g_42_35,p_42_35,g_42_39,p_42_39,g_38_35,p_38_35) and2( w0g_42_35, p_42_39, g_38_35 )#5 or2( g_42_35, w0g_42_35, g_42_39 )#5 and2( p_42_35, p_42_39, p_38_35)#5 end netlist // PGcombine (g_43_36,p_43_36,g_43_40,p_43_40,g_39_36,p_39_36) and2( w0g_43_36, p_43_40, g_39_36 )#5 or2( g_43_36, w0g_43_36, g_43_40 )#5 and2( p_43_36, p_43_40, p_39_36)#5 end netlist // PGcombine (g_44_37,p_44_37,g_44_41,p_44_41,g_40_37,p_40_37) and2( w0g_44_37, p_44_41, g_40_37 )#5 or2( g_44_37, w0g_44_37, g_44_41 )#5 and2( p_44_37, p_44_41, p_40_37)#5 end netlist // PGcombine (g_45_38,p_45_38,g_45_42,p_45_42,g_41_38,p_41_38) and2( w0g_45_38, p_45_42, g_41_38 )#5 or2( g_45_38, w0g_45_38, g_45_42 )#5 and2( p_45_38, p_45_42, p_41_38)#5 end netlist // PGcombine (g_46_39,p_46_39,g_46_43,p_46_43,g_42_39,p_42_39) and2( w0g_46_39, p_46_43, g_42_39 )#5 or2( g_46_39, w0g_46_39, g_46_43 )#5 and2( p_46_39, p_46_43, p_42_39)#5 end netlist // PGcombine (g_47_40,p_47_40,g_47_44,p_47_44,g_43_40,p_43_40) and2( w0g_47_40, p_47_44, g_43_40 )#5 or2( g_47_40, w0g_47_40, g_47_44 )#5 and2( p_47_40, p_47_44, p_43_40)#5 end netlist // PGcombine (g_48_41,p_48_41,g_48_45,p_48_45,g_44_41,p_44_41) and2( w0g_48_41, p_48_45, g_44_41 )#5 or2( g_48_41, w0g_48_41, g_48_45 )#5 and2( p_48_41, p_48_45, p_44_41)#5 end netlist // PGcombine (g_49_42,p_49_42,g_49_46,p_49_46,g_45_42,p_45_42) and2( w0g_49_42, p_49_46, g_45_42 )#5 or2( g_49_42, w0g_49_42, g_49_46 )#5 and2( p_49_42, p_49_46, p_45_42)#5 end netlist // PGcombine (g_50_43,p_50_43,g_50_47,p_50_47,g_46_43,p_46_43) and2( w0g_50_43, p_50_47, g_46_43 )#5 or2( g_50_43, w0g_50_43, g_50_47 )#5 and2( p_50_43, p_50_47, p_46_43)#5 end netlist // PGcombine (g_51_44,p_51_44,g_51_48,p_51_48,g_47_44,p_47_44) and2( w0g_51_44, p_51_48, g_47_44 )#5 or2( g_51_44, w0g_51_44, g_51_48 )#5 and2( p_51_44, p_51_48, p_47_44)#5 end netlist // PGcombine (g_52_45,p_52_45,g_52_49,p_52_49,g_48_45,p_48_45) and2( w0g_52_45, p_52_49, g_48_45 )#5 or2( g_52_45, w0g_52_45, g_52_49 )#5 and2( p_52_45, p_52_49, p_48_45)#5 end netlist // PGcombine (g_53_46,p_53_46,g_53_50,p_53_50,g_49_46,p_49_46) and2( w0g_53_46, p_53_50, g_49_46 )#5 or2( g_53_46, w0g_53_46, g_53_50 )#5 and2( p_53_46, p_53_50, p_49_46)#5 end netlist // PGcombine (g_54_47,p_54_47,g_54_51,p_54_51,g_50_47,p_50_47) and2( w0g_54_47, p_54_51, g_50_47 )#5 or2( g_54_47, w0g_54_47, g_54_51 )#5 and2( p_54_47, p_54_51, p_50_47)#5 end netlist // PGcombine (g_55_48,p_55_48,g_55_52,p_55_52,g_51_48,p_51_48) and2( w0g_55_48, p_55_52, g_51_48 )#5 or2( g_55_48, w0g_55_48, g_55_52 )#5 and2( p_55_48, p_55_52, p_51_48)#5 end netlist // PGcombine (g_56_49,p_56_49,g_56_53,p_56_53,g_52_49,p_52_49) and2( w0g_56_49, p_56_53, g_52_49 )#5 or2( g_56_49, w0g_56_49, g_56_53 )#5 and2( p_56_49, p_56_53, p_52_49)#5 end netlist // PGcombine (g_57_50,p_57_50,g_57_54,p_57_54,g_53_50,p_53_50) and2( w0g_57_50, p_57_54, g_53_50 )#5 or2( g_57_50, w0g_57_50, g_57_54 )#5 and2( p_57_50, p_57_54, p_53_50)#5 end netlist // PGcombine (g_58_51,p_58_51,g_58_55,p_58_55,g_54_51,p_54_51) and2( w0g_58_51, p_58_55, g_54_51 )#5 or2( g_58_51, w0g_58_51, g_58_55 )#5 and2( p_58_51, p_58_55, p_54_51)#5 end netlist // PGcombine (g_59_52,p_59_52,g_59_56,p_59_56,g_55_52,p_55_52) and2( w0g_59_52, p_59_56, g_55_52 )#5 or2( g_59_52, w0g_59_52, g_59_56 )#5 and2( p_59_52, p_59_56, p_55_52)#5 end netlist // PGcombine (g_60_53,p_60_53,g_60_57,p_60_57,g_56_53,p_56_53) and2( w0g_60_53, p_60_57, g_56_53 )#5 or2( g_60_53, w0g_60_53, g_60_57 )#5 and2( p_60_53, p_60_57, p_56_53)#5 end netlist // PGcombine (g_61_54,p_61_54,g_61_58,p_61_58,g_57_54,p_57_54) and2( w0g_61_54, p_61_58, g_57_54 )#5 or2( g_61_54, w0g_61_54, g_61_58 )#5 and2( p_61_54, p_61_58, p_57_54)#5 end netlist // PGcombine (g_62_55,p_62_55,g_62_59,p_62_59,g_58_55,p_58_55) and2( w0g_62_55, p_62_59, g_58_55 )#5 or2( g_62_55, w0g_62_55, g_62_59 )#5 and2( p_62_55, p_62_59, p_58_55)#5 end netlist // PGcombine (g_63_56,p_63_56,g_63_60,p_63_60,g_59_56,p_59_56) and2( w0g_63_56, p_63_60, g_59_56 )#5 or2( g_63_56, w0g_63_56, g_63_60 )#5 and2( p_63_56, p_63_60, p_59_56)#5 end netlist // Gcombine (g_7_cin, g_7_0, cin, p_7_0 ) and2(w0g_7_cin, p_7_0, cin )#5 or2( g_7_cin, w0g_7_cin, g_7_0 )#5 end netlist // Gcombine (g_8_cin, g_8_1, g_0_cin, p_8_1 ) and2(w0g_8_cin, p_8_1, g_0_cin )#5 or2( g_8_cin, w0g_8_cin, g_8_1 )#5 end netlist // Gcombine (g_9_cin, g_9_2, g_1_cin, p_9_2 ) and2(w0g_9_cin, p_9_2, g_1_cin )#5 or2( g_9_cin, w0g_9_cin, g_9_2 )#5 end netlist // Gcombine (g_10_cin, g_10_3, g_2_cin, p_10_3 ) and2(w0g_10_cin, p_10_3, g_2_cin )#5 or2( g_10_cin, w0g_10_cin, g_10_3 )#5 end netlist // Gcombine (g_11_cin, g_11_4, g_3_cin, p_11_4 ) and2(w0g_11_cin, p_11_4, g_3_cin )#5 or2( g_11_cin, w0g_11_cin, g_11_4 )#5 end netlist // Gcombine (g_12_cin, g_12_5, g_4_cin, p_12_5 ) and2(w0g_12_cin, p_12_5, g_4_cin )#5 or2( g_12_cin, w0g_12_cin, g_12_5 )#5 end netlist // Gcombine (g_13_cin, g_13_6, g_5_cin, p_13_6 ) and2(w0g_13_cin, p_13_6, g_5_cin )#5 or2( g_13_cin, w0g_13_cin, g_13_6 )#5 end netlist // Gcombine (g_14_cin, g_14_7, g_6_cin, p_14_7 ) and2(w0g_14_cin, p_14_7, g_6_cin )#5 or2( g_14_cin, w0g_14_cin, g_14_7 )#5 end netlist // PGcombine (g_15_0,p_15_0,g_15_8,p_15_8,g_7_0,p_7_0) and2( w0g_15_0, p_15_8, g_7_0 )#5 or2( g_15_0, w0g_15_0, g_15_8 )#5 and2( p_15_0, p_15_8, p_7_0)#5 end netlist // PGcombine (g_16_1,p_16_1,g_16_9,p_16_9,g_8_1,p_8_1) and2( w0g_16_1, p_16_9, g_8_1 )#5 or2( g_16_1, w0g_16_1, g_16_9 )#5 and2( p_16_1, p_16_9, p_8_1)#5 end netlist // PGcombine (g_17_2,p_17_2,g_17_10,p_17_10,g_9_2,p_9_2) and2( w0g_17_2, p_17_10, g_9_2 )#5 or2( g_17_2, w0g_17_2, g_17_10 )#5 and2( p_17_2, p_17_10, p_9_2)#5 end netlist // PGcombine (g_18_3,p_18_3,g_18_11,p_18_11,g_10_3,p_10_3) and2( w0g_18_3, p_18_11, g_10_3 )#5 or2( g_18_3, w0g_18_3, g_18_11 )#5 and2( p_18_3, p_18_11, p_10_3)#5 end netlist // PGcombine (g_19_4,p_19_4,g_19_12,p_19_12,g_11_4,p_11_4) and2( w0g_19_4, p_19_12, g_11_4 )#5 or2( g_19_4, w0g_19_4, g_19_12 )#5 and2( p_19_4, p_19_12, p_11_4)#5 end netlist // PGcombine (g_20_5,p_20_5,g_20_13,p_20_13,g_12_5,p_12_5) and2( w0g_20_5, p_20_13, g_12_5 )#5 or2( g_20_5, w0g_20_5, g_20_13 )#5 and2( p_20_5, p_20_13, p_12_5)#5 end netlist // PGcombine (g_21_6,p_21_6,g_21_14,p_21_14,g_13_6,p_13_6) and2( w0g_21_6, p_21_14, g_13_6 )#5 or2( g_21_6, w0g_21_6, g_21_14 )#5 and2( p_21_6, p_21_14, p_13_6)#5 end netlist // PGcombine (g_22_7,p_22_7,g_22_15,p_22_15,g_14_7,p_14_7) and2( w0g_22_7, p_22_15, g_14_7 )#5 or2( g_22_7, w0g_22_7, g_22_15 )#5 and2( p_22_7, p_22_15, p_14_7)#5 end netlist // PGcombine (g_23_8,p_23_8,g_23_16,p_23_16,g_15_8,p_15_8) and2( w0g_23_8, p_23_16, g_15_8 )#5 or2( g_23_8, w0g_23_8, g_23_16 )#5 and2( p_23_8, p_23_16, p_15_8)#5 end netlist // PGcombine (g_24_9,p_24_9,g_24_17,p_24_17,g_16_9,p_16_9) and2( w0g_24_9, p_24_17, g_16_9 )#5 or2( g_24_9, w0g_24_9, g_24_17 )#5 and2( p_24_9, p_24_17, p_16_9)#5 end netlist // PGcombine (g_25_10,p_25_10,g_25_18,p_25_18,g_17_10,p_17_10) and2( w0g_25_10, p_25_18, g_17_10 )#5 or2( g_25_10, w0g_25_10, g_25_18 )#5 and2( p_25_10, p_25_18, p_17_10)#5 end netlist // PGcombine (g_26_11,p_26_11,g_26_19,p_26_19,g_18_11,p_18_11) and2( w0g_26_11, p_26_19, g_18_11 )#5 or2( g_26_11, w0g_26_11, g_26_19 )#5 and2( p_26_11, p_26_19, p_18_11)#5 end netlist // PGcombine (g_27_12,p_27_12,g_27_20,p_27_20,g_19_12,p_19_12) and2( w0g_27_12, p_27_20, g_19_12 )#5 or2( g_27_12, w0g_27_12, g_27_20 )#5 and2( p_27_12, p_27_20, p_19_12)#5 end netlist // PGcombine (g_28_13,p_28_13,g_28_21,p_28_21,g_20_13,p_20_13) and2( w0g_28_13, p_28_21, g_20_13 )#5 or2( g_28_13, w0g_28_13, g_28_21 )#5 and2( p_28_13, p_28_21, p_20_13)#5 end netlist // PGcombine (g_29_14,p_29_14,g_29_22,p_29_22,g_21_14,p_21_14) and2( w0g_29_14, p_29_22, g_21_14 )#5 or2( g_29_14, w0g_29_14, g_29_22 )#5 and2( p_29_14, p_29_22, p_21_14)#5 end netlist // PGcombine (g_30_15,p_30_15,g_30_23,p_30_23,g_22_15,p_22_15) and2( w0g_30_15, p_30_23, g_22_15 )#5 or2( g_30_15, w0g_30_15, g_30_23 )#5 and2( p_30_15, p_30_23, p_22_15)#5 end netlist // PGcombine (g_31_16,p_31_16,g_31_24,p_31_24,g_23_16,p_23_16) and2( w0g_31_16, p_31_24, g_23_16 )#5 or2( g_31_16, w0g_31_16, g_31_24 )#5 and2( p_31_16, p_31_24, p_23_16)#5 end netlist // PGcombine (g_32_17,p_32_17,g_32_25,p_32_25,g_24_17,p_24_17) and2( w0g_32_17, p_32_25, g_24_17 )#5 or2( g_32_17, w0g_32_17, g_32_25 )#5 and2( p_32_17, p_32_25, p_24_17)#5 end netlist // PGcombine (g_33_18,p_33_18,g_33_26,p_33_26,g_25_18,p_25_18) and2( w0g_33_18, p_33_26, g_25_18 )#5 or2( g_33_18, w0g_33_18, g_33_26 )#5 and2( p_33_18, p_33_26, p_25_18)#5 end netlist // PGcombine (g_34_19,p_34_19,g_34_27,p_34_27,g_26_19,p_26_19) and2( w0g_34_19, p_34_27, g_26_19 )#5 or2( g_34_19, w0g_34_19, g_34_27 )#5 and2( p_34_19, p_34_27, p_26_19)#5 end netlist // PGcombine (g_35_20,p_35_20,g_35_28,p_35_28,g_27_20,p_27_20) and2( w0g_35_20, p_35_28, g_27_20 )#5 or2( g_35_20, w0g_35_20, g_35_28 )#5 and2( p_35_20, p_35_28, p_27_20)#5 end netlist // PGcombine (g_36_21,p_36_21,g_36_29,p_36_29,g_28_21,p_28_21) and2( w0g_36_21, p_36_29, g_28_21 )#5 or2( g_36_21, w0g_36_21, g_36_29 )#5 and2( p_36_21, p_36_29, p_28_21)#5 end netlist // PGcombine (g_37_22,p_37_22,g_37_30,p_37_30,g_29_22,p_29_22) and2( w0g_37_22, p_37_30, g_29_22 )#5 or2( g_37_22, w0g_37_22, g_37_30 )#5 and2( p_37_22, p_37_30, p_29_22)#5 end netlist // PGcombine (g_38_23,p_38_23,g_38_31,p_38_31,g_30_23,p_30_23) and2( w0g_38_23, p_38_31, g_30_23 )#5 or2( g_38_23, w0g_38_23, g_38_31 )#5 and2( p_38_23, p_38_31, p_30_23)#5 end netlist // PGcombine (g_39_24,p_39_24,g_39_32,p_39_32,g_31_24,p_31_24) and2( w0g_39_24, p_39_32, g_31_24 )#5 or2( g_39_24, w0g_39_24, g_39_32 )#5 and2( p_39_24, p_39_32, p_31_24)#5 end netlist // PGcombine (g_40_25,p_40_25,g_40_33,p_40_33,g_32_25,p_32_25) and2( w0g_40_25, p_40_33, g_32_25 )#5 or2( g_40_25, w0g_40_25, g_40_33 )#5 and2( p_40_25, p_40_33, p_32_25)#5 end netlist // PGcombine (g_41_26,p_41_26,g_41_34,p_41_34,g_33_26,p_33_26) and2( w0g_41_26, p_41_34, g_33_26 )#5 or2( g_41_26, w0g_41_26, g_41_34 )#5 and2( p_41_26, p_41_34, p_33_26)#5 end netlist // PGcombine (g_42_27,p_42_27,g_42_35,p_42_35,g_34_27,p_34_27) and2( w0g_42_27, p_42_35, g_34_27 )#5 or2( g_42_27, w0g_42_27, g_42_35 )#5 and2( p_42_27, p_42_35, p_34_27)#5 end netlist // PGcombine (g_43_28,p_43_28,g_43_36,p_43_36,g_35_28,p_35_28) and2( w0g_43_28, p_43_36, g_35_28 )#5 or2( g_43_28, w0g_43_28, g_43_36 )#5 and2( p_43_28, p_43_36, p_35_28)#5 end netlist // PGcombine (g_44_29,p_44_29,g_44_37,p_44_37,g_36_29,p_36_29) and2( w0g_44_29, p_44_37, g_36_29 )#5 or2( g_44_29, w0g_44_29, g_44_37 )#5 and2( p_44_29, p_44_37, p_36_29)#5 end netlist // PGcombine (g_45_30,p_45_30,g_45_38,p_45_38,g_37_30,p_37_30) and2( w0g_45_30, p_45_38, g_37_30 )#5 or2( g_45_30, w0g_45_30, g_45_38 )#5 and2( p_45_30, p_45_38, p_37_30)#5 end netlist // PGcombine (g_46_31,p_46_31,g_46_39,p_46_39,g_38_31,p_38_31) and2( w0g_46_31, p_46_39, g_38_31 )#5 or2( g_46_31, w0g_46_31, g_46_39 )#5 and2( p_46_31, p_46_39, p_38_31)#5 end netlist // PGcombine (g_47_32,p_47_32,g_47_40,p_47_40,g_39_32,p_39_32) and2( w0g_47_32, p_47_40, g_39_32 )#5 or2( g_47_32, w0g_47_32, g_47_40 )#5 and2( p_47_32, p_47_40, p_39_32)#5 end netlist // PGcombine (g_48_33,p_48_33,g_48_41,p_48_41,g_40_33,p_40_33) and2( w0g_48_33, p_48_41, g_40_33 )#5 or2( g_48_33, w0g_48_33, g_48_41 )#5 and2( p_48_33, p_48_41, p_40_33)#5 end netlist // PGcombine (g_49_34,p_49_34,g_49_42,p_49_42,g_41_34,p_41_34) and2( w0g_49_34, p_49_42, g_41_34 )#5 or2( g_49_34, w0g_49_34, g_49_42 )#5 and2( p_49_34, p_49_42, p_41_34)#5 end netlist // PGcombine (g_50_35,p_50_35,g_50_43,p_50_43,g_42_35,p_42_35) and2( w0g_50_35, p_50_43, g_42_35 )#5 or2( g_50_35, w0g_50_35, g_50_43 )#5 and2( p_50_35, p_50_43, p_42_35)#5 end netlist // PGcombine (g_51_36,p_51_36,g_51_44,p_51_44,g_43_36,p_43_36) and2( w0g_51_36, p_51_44, g_43_36 )#5 or2( g_51_36, w0g_51_36, g_51_44 )#5 and2( p_51_36, p_51_44, p_43_36)#5 end netlist // PGcombine (g_52_37,p_52_37,g_52_45,p_52_45,g_44_37,p_44_37) and2( w0g_52_37, p_52_45, g_44_37 )#5 or2( g_52_37, w0g_52_37, g_52_45 )#5 and2( p_52_37, p_52_45, p_44_37)#5 end netlist // PGcombine (g_53_38,p_53_38,g_53_46,p_53_46,g_45_38,p_45_38) and2( w0g_53_38, p_53_46, g_45_38 )#5 or2( g_53_38, w0g_53_38, g_53_46 )#5 and2( p_53_38, p_53_46, p_45_38)#5 end netlist // PGcombine (g_54_39,p_54_39,g_54_47,p_54_47,g_46_39,p_46_39) and2( w0g_54_39, p_54_47, g_46_39 )#5 or2( g_54_39, w0g_54_39, g_54_47 )#5 and2( p_54_39, p_54_47, p_46_39)#5 end netlist // PGcombine (g_55_40,p_55_40,g_55_48,p_55_48,g_47_40,p_47_40) and2( w0g_55_40, p_55_48, g_47_40 )#5 or2( g_55_40, w0g_55_40, g_55_48 )#5 and2( p_55_40, p_55_48, p_47_40)#5 end netlist // PGcombine (g_56_41,p_56_41,g_56_49,p_56_49,g_48_41,p_48_41) and2( w0g_56_41, p_56_49, g_48_41 )#5 or2( g_56_41, w0g_56_41, g_56_49 )#5 and2( p_56_41, p_56_49, p_48_41)#5 end netlist // PGcombine (g_57_42,p_57_42,g_57_50,p_57_50,g_49_42,p_49_42) and2( w0g_57_42, p_57_50, g_49_42 )#5 or2( g_57_42, w0g_57_42, g_57_50 )#5 and2( p_57_42, p_57_50, p_49_42)#5 end netlist // PGcombine (g_58_43,p_58_43,g_58_51,p_58_51,g_50_43,p_50_43) and2( w0g_58_43, p_58_51, g_50_43 )#5 or2( g_58_43, w0g_58_43, g_58_51 )#5 and2( p_58_43, p_58_51, p_50_43)#5 end netlist // PGcombine (g_59_44,p_59_44,g_59_52,p_59_52,g_51_44,p_51_44) and2( w0g_59_44, p_59_52, g_51_44 )#5 or2( g_59_44, w0g_59_44, g_59_52 )#5 and2( p_59_44, p_59_52, p_51_44)#5 end netlist // PGcombine (g_60_45,p_60_45,g_60_53,p_60_53,g_52_45,p_52_45) and2( w0g_60_45, p_60_53, g_52_45 )#5 or2( g_60_45, w0g_60_45, g_60_53 )#5 and2( p_60_45, p_60_53, p_52_45)#5 end netlist // PGcombine (g_61_46,p_61_46,g_61_54,p_61_54,g_53_46,p_53_46) and2( w0g_61_46, p_61_54, g_53_46 )#5 or2( g_61_46, w0g_61_46, g_61_54 )#5 and2( p_61_46, p_61_54, p_53_46)#5 end netlist // PGcombine (g_62_47,p_62_47,g_62_55,p_62_55,g_54_47,p_54_47) and2( w0g_62_47, p_62_55, g_54_47 )#5 or2( g_62_47, w0g_62_47, g_62_55 )#5 and2( p_62_47, p_62_55, p_54_47)#5 end netlist // PGcombine (g_63_48,p_63_48,g_63_56,p_63_56,g_55_48,p_55_48) and2( w0g_63_48, p_63_56, g_55_48 )#5 or2( g_63_48, w0g_63_48, g_63_56 )#5 and2( p_63_48, p_63_56, p_55_48)#5 end netlist // Gcombine (g_15_cin, g_15_0, cin, p_15_0 ) and2(w0g_15_cin, p_15_0, cin )#5 or2( g_15_cin, w0g_15_cin, g_15_0 )#5 end netlist // Gcombine (g_16_cin, g_16_1, g_0_cin, p_16_1 ) and2(w0g_16_cin, p_16_1, g_0_cin )#5 or2( g_16_cin, w0g_16_cin, g_16_1 )#5 end netlist // Gcombine (g_17_cin, g_17_2, g_1_cin, p_17_2 ) and2(w0g_17_cin, p_17_2, g_1_cin )#5 or2( g_17_cin, w0g_17_cin, g_17_2 )#5 end netlist // Gcombine (g_18_cin, g_18_3, g_2_cin, p_18_3 ) and2(w0g_18_cin, p_18_3, g_2_cin )#5 or2( g_18_cin, w0g_18_cin, g_18_3 )#5 end netlist // Gcombine (g_19_cin, g_19_4, g_3_cin, p_19_4 ) and2(w0g_19_cin, p_19_4, g_3_cin )#5 or2( g_19_cin, w0g_19_cin, g_19_4 )#5 end netlist // Gcombine (g_20_cin, g_20_5, g_4_cin, p_20_5 ) and2(w0g_20_cin, p_20_5, g_4_cin )#5 or2( g_20_cin, w0g_20_cin, g_20_5 )#5 end netlist // Gcombine (g_21_cin, g_21_6, g_5_cin, p_21_6 ) and2(w0g_21_cin, p_21_6, g_5_cin )#5 or2( g_21_cin, w0g_21_cin, g_21_6 )#5 end netlist // Gcombine (g_22_cin, g_22_7, g_6_cin, p_22_7 ) and2(w0g_22_cin, p_22_7, g_6_cin )#5 or2( g_22_cin, w0g_22_cin, g_22_7 )#5 end netlist // Gcombine (g_23_cin, g_23_8, g_7_cin, p_23_8 ) and2(w0g_23_cin, p_23_8, g_7_cin )#5 or2( g_23_cin, w0g_23_cin, g_23_8 )#5 end netlist // Gcombine (g_24_cin, g_24_9, g_8_cin, p_24_9 ) and2(w0g_24_cin, p_24_9, g_8_cin )#5 or2( g_24_cin, w0g_24_cin, g_24_9 )#5 end netlist // Gcombine (g_25_cin, g_25_10, g_9_cin, p_25_10 ) and2(w0g_25_cin, p_25_10, g_9_cin )#5 or2( g_25_cin, w0g_25_cin, g_25_10 )#5 end netlist // Gcombine (g_26_cin, g_26_11, g_10_cin, p_26_11 ) and2(w0g_26_cin, p_26_11, g_10_cin )#5 or2( g_26_cin, w0g_26_cin, g_26_11 )#5 end netlist // Gcombine (g_27_cin, g_27_12, g_11_cin, p_27_12 ) and2(w0g_27_cin, p_27_12, g_11_cin )#5 or2( g_27_cin, w0g_27_cin, g_27_12 )#5 end netlist // Gcombine (g_28_cin, g_28_13, g_12_cin, p_28_13 ) and2(w0g_28_cin, p_28_13, g_12_cin )#5 or2( g_28_cin, w0g_28_cin, g_28_13 )#5 end netlist // Gcombine (g_29_cin, g_29_14, g_13_cin, p_29_14 ) and2(w0g_29_cin, p_29_14, g_13_cin )#5 or2( g_29_cin, w0g_29_cin, g_29_14 )#5 end netlist // Gcombine (g_30_cin, g_30_15, g_14_cin, p_30_15 ) and2(w0g_30_cin, p_30_15, g_14_cin )#5 or2( g_30_cin, w0g_30_cin, g_30_15 )#5 end netlist // PGcombine (g_31_0,p_31_0,g_31_16,p_31_16,g_15_0,p_15_0) and2( w0g_31_0, p_31_16, g_15_0 )#5 or2( g_31_0, w0g_31_0, g_31_16 )#5 and2( p_31_0, p_31_16, p_15_0)#5 end netlist // PGcombine (g_32_1,p_32_1,g_32_17,p_32_17,g_16_1,p_16_1) and2( w0g_32_1, p_32_17, g_16_1 )#5 or2( g_32_1, w0g_32_1, g_32_17 )#5 and2( p_32_1, p_32_17, p_16_1)#5 end netlist // PGcombine (g_33_2,p_33_2,g_33_18,p_33_18,g_17_2,p_17_2) and2( w0g_33_2, p_33_18, g_17_2 )#5 or2( g_33_2, w0g_33_2, g_33_18 )#5 and2( p_33_2, p_33_18, p_17_2)#5 end netlist // PGcombine (g_34_3,p_34_3,g_34_19,p_34_19,g_18_3,p_18_3) and2( w0g_34_3, p_34_19, g_18_3 )#5 or2( g_34_3, w0g_34_3, g_34_19 )#5 and2( p_34_3, p_34_19, p_18_3)#5 end netlist // PGcombine (g_35_4,p_35_4,g_35_20,p_35_20,g_19_4,p_19_4) and2( w0g_35_4, p_35_20, g_19_4 )#5 or2( g_35_4, w0g_35_4, g_35_20 )#5 and2( p_35_4, p_35_20, p_19_4)#5 end netlist // PGcombine (g_36_5,p_36_5,g_36_21,p_36_21,g_20_5,p_20_5) and2( w0g_36_5, p_36_21, g_20_5 )#5 or2( g_36_5, w0g_36_5, g_36_21 )#5 and2( p_36_5, p_36_21, p_20_5)#5 end netlist // PGcombine (g_37_6,p_37_6,g_37_22,p_37_22,g_21_6,p_21_6) and2( w0g_37_6, p_37_22, g_21_6 )#5 or2( g_37_6, w0g_37_6, g_37_22 )#5 and2( p_37_6, p_37_22, p_21_6)#5 end netlist // PGcombine (g_38_7,p_38_7,g_38_23,p_38_23,g_22_7,p_22_7) and2( w0g_38_7, p_38_23, g_22_7 )#5 or2( g_38_7, w0g_38_7, g_38_23 )#5 and2( p_38_7, p_38_23, p_22_7)#5 end netlist // PGcombine (g_39_8,p_39_8,g_39_24,p_39_24,g_23_8,p_23_8) and2( w0g_39_8, p_39_24, g_23_8 )#5 or2( g_39_8, w0g_39_8, g_39_24 )#5 and2( p_39_8, p_39_24, p_23_8)#5 end netlist // PGcombine (g_40_9,p_40_9,g_40_25,p_40_25,g_24_9,p_24_9) and2( w0g_40_9, p_40_25, g_24_9 )#5 or2( g_40_9, w0g_40_9, g_40_25 )#5 and2( p_40_9, p_40_25, p_24_9)#5 end netlist // PGcombine (g_41_10,p_41_10,g_41_26,p_41_26,g_25_10,p_25_10) and2( w0g_41_10, p_41_26, g_25_10 )#5 or2( g_41_10, w0g_41_10, g_41_26 )#5 and2( p_41_10, p_41_26, p_25_10)#5 end netlist // PGcombine (g_42_11,p_42_11,g_42_27,p_42_27,g_26_11,p_26_11) and2( w0g_42_11, p_42_27, g_26_11 )#5 or2( g_42_11, w0g_42_11, g_42_27 )#5 and2( p_42_11, p_42_27, p_26_11)#5 end netlist // PGcombine (g_43_12,p_43_12,g_43_28,p_43_28,g_27_12,p_27_12) and2( w0g_43_12, p_43_28, g_27_12 )#5 or2( g_43_12, w0g_43_12, g_43_28 )#5 and2( p_43_12, p_43_28, p_27_12)#5 end netlist // PGcombine (g_44_13,p_44_13,g_44_29,p_44_29,g_28_13,p_28_13) and2( w0g_44_13, p_44_29, g_28_13 )#5 or2( g_44_13, w0g_44_13, g_44_29 )#5 and2( p_44_13, p_44_29, p_28_13)#5 end netlist // PGcombine (g_45_14,p_45_14,g_45_30,p_45_30,g_29_14,p_29_14) and2( w0g_45_14, p_45_30, g_29_14 )#5 or2( g_45_14, w0g_45_14, g_45_30 )#5 and2( p_45_14, p_45_30, p_29_14)#5 end netlist // PGcombine (g_46_15,p_46_15,g_46_31,p_46_31,g_30_15,p_30_15) and2( w0g_46_15, p_46_31, g_30_15 )#5 or2( g_46_15, w0g_46_15, g_46_31 )#5 and2( p_46_15, p_46_31, p_30_15)#5 end netlist // PGcombine (g_47_16,p_47_16,g_47_32,p_47_32,g_31_16,p_31_16) and2( w0g_47_16, p_47_32, g_31_16 )#5 or2( g_47_16, w0g_47_16, g_47_32 )#5 and2( p_47_16, p_47_32, p_31_16)#5 end netlist // PGcombine (g_48_17,p_48_17,g_48_33,p_48_33,g_32_17,p_32_17) and2( w0g_48_17, p_48_33, g_32_17 )#5 or2( g_48_17, w0g_48_17, g_48_33 )#5 and2( p_48_17, p_48_33, p_32_17)#5 end netlist // PGcombine (g_49_18,p_49_18,g_49_34,p_49_34,g_33_18,p_33_18) and2( w0g_49_18, p_49_34, g_33_18 )#5 or2( g_49_18, w0g_49_18, g_49_34 )#5 and2( p_49_18, p_49_34, p_33_18)#5 end netlist // PGcombine (g_50_19,p_50_19,g_50_35,p_50_35,g_34_19,p_34_19) and2( w0g_50_19, p_50_35, g_34_19 )#5 or2( g_50_19, w0g_50_19, g_50_35 )#5 and2( p_50_19, p_50_35, p_34_19)#5 end netlist // PGcombine (g_51_20,p_51_20,g_51_36,p_51_36,g_35_20,p_35_20) and2( w0g_51_20, p_51_36, g_35_20 )#5 or2( g_51_20, w0g_51_20, g_51_36 )#5 and2( p_51_20, p_51_36, p_35_20)#5 end netlist // PGcombine (g_52_21,p_52_21,g_52_37,p_52_37,g_36_21,p_36_21) and2( w0g_52_21, p_52_37, g_36_21 )#5 or2( g_52_21, w0g_52_21, g_52_37 )#5 and2( p_52_21, p_52_37, p_36_21)#5 end netlist // PGcombine (g_53_22,p_53_22,g_53_38,p_53_38,g_37_22,p_37_22) and2( w0g_53_22, p_53_38, g_37_22 )#5 or2( g_53_22, w0g_53_22, g_53_38 )#5 and2( p_53_22, p_53_38, p_37_22)#5 end netlist // PGcombine (g_54_23,p_54_23,g_54_39,p_54_39,g_38_23,p_38_23) and2( w0g_54_23, p_54_39, g_38_23 )#5 or2( g_54_23, w0g_54_23, g_54_39 )#5 and2( p_54_23, p_54_39, p_38_23)#5 end netlist // PGcombine (g_55_24,p_55_24,g_55_40,p_55_40,g_39_24,p_39_24) and2( w0g_55_24, p_55_40, g_39_24 )#5 or2( g_55_24, w0g_55_24, g_55_40 )#5 and2( p_55_24, p_55_40, p_39_24)#5 end netlist // PGcombine (g_56_25,p_56_25,g_56_41,p_56_41,g_40_25,p_40_25) and2( w0g_56_25, p_56_41, g_40_25 )#5 or2( g_56_25, w0g_56_25, g_56_41 )#5 and2( p_56_25, p_56_41, p_40_25)#5 end netlist // PGcombine (g_57_26,p_57_26,g_57_42,p_57_42,g_41_26,p_41_26) and2( w0g_57_26, p_57_42, g_41_26 )#5 or2( g_57_26, w0g_57_26, g_57_42 )#5 and2( p_57_26, p_57_42, p_41_26)#5 end netlist // PGcombine (g_58_27,p_58_27,g_58_43,p_58_43,g_42_27,p_42_27) and2( w0g_58_27, p_58_43, g_42_27 )#5 or2( g_58_27, w0g_58_27, g_58_43 )#5 and2( p_58_27, p_58_43, p_42_27)#5 end netlist // PGcombine (g_59_28,p_59_28,g_59_44,p_59_44,g_43_28,p_43_28) and2( w0g_59_28, p_59_44, g_43_28 )#5 or2( g_59_28, w0g_59_28, g_59_44 )#5 and2( p_59_28, p_59_44, p_43_28)#5 end netlist // PGcombine (g_60_29,p_60_29,g_60_45,p_60_45,g_44_29,p_44_29) and2( w0g_60_29, p_60_45, g_44_29 )#5 or2( g_60_29, w0g_60_29, g_60_45 )#5 and2( p_60_29, p_60_45, p_44_29)#5 end netlist // PGcombine (g_61_30,p_61_30,g_61_46,p_61_46,g_45_30,p_45_30) and2( w0g_61_30, p_61_46, g_45_30 )#5 or2( g_61_30, w0g_61_30, g_61_46 )#5 and2( p_61_30, p_61_46, p_45_30)#5 end netlist // PGcombine (g_62_31,p_62_31,g_62_47,p_62_47,g_46_31,p_46_31) and2( w0g_62_31, p_62_47, g_46_31 )#5 or2( g_62_31, w0g_62_31, g_62_47 )#5 and2( p_62_31, p_62_47, p_46_31)#5 end netlist // PGcombine (g_63_32,p_63_32,g_63_48,p_63_48,g_47_32,p_47_32) and2( w0g_63_32, p_63_48, g_47_32 )#5 or2( g_63_32, w0g_63_32, g_63_48 )#5 and2( p_63_32, p_63_48, p_47_32)#5 end netlist // Gcombine (g_31_cin, g_31_0, cin, p_31_0 ) and2(w0g_31_cin, p_31_0, cin )#5 or2( g_31_cin, w0g_31_cin, g_31_0 )#5 end netlist // Gcombine (g_32_cin, g_32_1, g_0_cin, p_32_1 ) and2(w0g_32_cin, p_32_1, g_0_cin )#5 or2( g_32_cin, w0g_32_cin, g_32_1 )#5 end netlist // Gcombine (g_33_cin, g_33_2, g_1_cin, p_33_2 ) and2(w0g_33_cin, p_33_2, g_1_cin )#5 or2( g_33_cin, w0g_33_cin, g_33_2 )#5 end netlist // Gcombine (g_34_cin, g_34_3, g_2_cin, p_34_3 ) and2(w0g_34_cin, p_34_3, g_2_cin )#5 or2( g_34_cin, w0g_34_cin, g_34_3 )#5 end netlist // Gcombine (g_35_cin, g_35_4, g_3_cin, p_35_4 ) and2(w0g_35_cin, p_35_4, g_3_cin )#5 or2( g_35_cin, w0g_35_cin, g_35_4 )#5 end netlist // Gcombine (g_36_cin, g_36_5, g_4_cin, p_36_5 ) and2(w0g_36_cin, p_36_5, g_4_cin )#5 or2( g_36_cin, w0g_36_cin, g_36_5 )#5 end netlist // Gcombine (g_37_cin, g_37_6, g_5_cin, p_37_6 ) and2(w0g_37_cin, p_37_6, g_5_cin )#5 or2( g_37_cin, w0g_37_cin, g_37_6 )#5 end netlist // Gcombine (g_38_cin, g_38_7, g_6_cin, p_38_7 ) and2(w0g_38_cin, p_38_7, g_6_cin )#5 or2( g_38_cin, w0g_38_cin, g_38_7 )#5 end netlist // Gcombine (g_39_cin, g_39_8, g_7_cin, p_39_8 ) and2(w0g_39_cin, p_39_8, g_7_cin )#5 or2( g_39_cin, w0g_39_cin, g_39_8 )#5 end netlist // Gcombine (g_40_cin, g_40_9, g_8_cin, p_40_9 ) and2(w0g_40_cin, p_40_9, g_8_cin )#5 or2( g_40_cin, w0g_40_cin, g_40_9 )#5 end netlist // Gcombine (g_41_cin, g_41_10, g_9_cin, p_41_10 ) and2(w0g_41_cin, p_41_10, g_9_cin )#5 or2( g_41_cin, w0g_41_cin, g_41_10 )#5 end netlist // Gcombine (g_42_cin, g_42_11, g_10_cin, p_42_11 ) and2(w0g_42_cin, p_42_11, g_10_cin )#5 or2( g_42_cin, w0g_42_cin, g_42_11 )#5 end netlist // Gcombine (g_43_cin, g_43_12, g_11_cin, p_43_12 ) and2(w0g_43_cin, p_43_12, g_11_cin )#5 or2( g_43_cin, w0g_43_cin, g_43_12 )#5 end netlist // Gcombine (g_44_cin, g_44_13, g_12_cin, p_44_13 ) and2(w0g_44_cin, p_44_13, g_12_cin )#5 or2( g_44_cin, w0g_44_cin, g_44_13 )#5 end netlist // Gcombine (g_45_cin, g_45_14, g_13_cin, p_45_14 ) and2(w0g_45_cin, p_45_14, g_13_cin )#5 or2( g_45_cin, w0g_45_cin, g_45_14 )#5 end netlist // Gcombine (g_46_cin, g_46_15, g_14_cin, p_46_15 ) and2(w0g_46_cin, p_46_15, g_14_cin )#5 or2( g_46_cin, w0g_46_cin, g_46_15 )#5 end netlist // Gcombine (g_47_cin, g_47_16, g_15_cin, p_47_16 ) and2(w0g_47_cin, p_47_16, g_15_cin )#5 or2( g_47_cin, w0g_47_cin, g_47_16 )#5 end netlist // Gcombine (g_48_cin, g_48_17, g_16_cin, p_48_17 ) and2(w0g_48_cin, p_48_17, g_16_cin )#5 or2( g_48_cin, w0g_48_cin, g_48_17 )#5 end netlist // Gcombine (g_49_cin, g_49_18, g_17_cin, p_49_18 ) and2(w0g_49_cin, p_49_18, g_17_cin )#5 or2( g_49_cin, w0g_49_cin, g_49_18 )#5 end netlist // Gcombine (g_50_cin, g_50_19, g_18_cin, p_50_19 ) and2(w0g_50_cin, p_50_19, g_18_cin )#5 or2( g_50_cin, w0g_50_cin, g_50_19 )#5 end netlist // Gcombine (g_51_cin, g_51_20, g_19_cin, p_51_20 ) and2(w0g_51_cin, p_51_20, g_19_cin )#5 or2( g_51_cin, w0g_51_cin, g_51_20 )#5 end netlist // Gcombine (g_52_cin, g_52_21, g_20_cin, p_52_21 ) and2(w0g_52_cin, p_52_21, g_20_cin )#5 or2( g_52_cin, w0g_52_cin, g_52_21 )#5 end netlist // Gcombine (g_53_cin, g_53_22, g_21_cin, p_53_22 ) and2(w0g_53_cin, p_53_22, g_21_cin )#5 or2( g_53_cin, w0g_53_cin, g_53_22 )#5 end netlist // Gcombine (g_54_cin, g_54_23, g_22_cin, p_54_23 ) and2(w0g_54_cin, p_54_23, g_22_cin )#5 or2( g_54_cin, w0g_54_cin, g_54_23 )#5 end netlist // Gcombine (g_55_cin, g_55_24, g_23_cin, p_55_24 ) and2(w0g_55_cin, p_55_24, g_23_cin )#5 or2( g_55_cin, w0g_55_cin, g_55_24 )#5 end netlist // Gcombine (g_56_cin, g_56_25, g_24_cin, p_56_25 ) and2(w0g_56_cin, p_56_25, g_24_cin )#5 or2( g_56_cin, w0g_56_cin, g_56_25 )#5 end netlist // Gcombine (g_57_cin, g_57_26, g_25_cin, p_57_26 ) and2(w0g_57_cin, p_57_26, g_25_cin )#5 or2( g_57_cin, w0g_57_cin, g_57_26 )#5 end netlist // Gcombine (g_58_cin, g_58_27, g_26_cin, p_58_27 ) and2(w0g_58_cin, p_58_27, g_26_cin )#5 or2( g_58_cin, w0g_58_cin, g_58_27 )#5 end netlist // Gcombine (g_59_cin, g_59_28, g_27_cin, p_59_28 ) and2(w0g_59_cin, p_59_28, g_27_cin )#5 or2( g_59_cin, w0g_59_cin, g_59_28 )#5 end netlist // Gcombine (g_60_cin, g_60_29, g_28_cin, p_60_29 ) and2(w0g_60_cin, p_60_29, g_28_cin )#5 or2( g_60_cin, w0g_60_cin, g_60_29 )#5 end netlist // Gcombine (g_61_cin, g_61_30, g_29_cin, p_61_30 ) and2(w0g_61_cin, p_61_30, g_29_cin )#5 or2( g_61_cin, w0g_61_cin, g_61_30 )#5 end netlist // Gcombine (g_62_cin, g_62_31, g_30_cin, p_62_31 ) and2(w0g_62_cin, p_62_31, g_30_cin )#5 or2( g_62_cin, w0g_62_cin, g_62_31 )#5 end netlist // PGcombine (g_63_0,p_63_0,g_63_32,p_63_32,g_31_0,p_31_0) and2( w0g_63_0, p_63_32, g_31_0 )#5 or2( g_63_0, w0g_63_0, g_63_32 )#5 and2( p_63_0, p_63_32, p_31_0)#5 end netlist // Gcombine (cout, g_63_0, cin, p_63_0 ) and2(w0cout, p_63_0, cin )#5 or2( cout, w0cout, g_63_0 )#5 end netlist xor2( s0, p0,cin )#5 xor2( s1, p1,g_0_cin )#5 xor2( s2, p2,g_1_cin )#5 xor2( s3, p3,g_2_cin )#5 xor2( s4, p4,g_3_cin )#5 xor2( s5, p5,g_4_cin )#5 xor2( s6, p6,g_5_cin )#5 xor2( s7, p7,g_6_cin )#5 xor2( s8, p8,g_7_cin )#5 xor2( s9, p9,g_8_cin )#5 xor2( s10, p10,g_9_cin )#5 xor2( s11, p11,g_10_cin )#5 xor2( s12, p12,g_11_cin )#5 xor2( s13, p13,g_12_cin )#5 xor2( s14, p14,g_13_cin )#5 xor2( s15, p15,g_14_cin )#5 xor2( s16, p16,g_15_cin )#5 xor2( s17, p17,g_16_cin )#5 xor2( s18, p18,g_17_cin )#5 xor2( s19, p19,g_18_cin )#5 xor2( s20, p20,g_19_cin )#5 xor2( s21, p21,g_20_cin )#5 xor2( s22, p22,g_21_cin )#5 xor2( s23, p23,g_22_cin )#5 xor2( s24, p24,g_23_cin )#5 xor2( s25, p25,g_24_cin )#5 xor2( s26, p26,g_25_cin )#5 xor2( s27, p27,g_26_cin )#5 xor2( s28, p28,g_27_cin )#5 xor2( s29, p29,g_28_cin )#5 xor2( s30, p30,g_29_cin )#5 xor2( s31, p31,g_30_cin )#5 xor2( s32, p32,g_31_cin )#5 xor2( s33, p33,g_32_cin )#5 xor2( s34, p34,g_33_cin )#5 xor2( s35, p35,g_34_cin )#5 xor2( s36, p36,g_35_cin )#5 xor2( s37, p37,g_36_cin )#5 xor2( s38, p38,g_37_cin )#5 xor2( s39, p39,g_38_cin )#5 xor2( s40, p40,g_39_cin )#5 xor2( s41, p41,g_40_cin )#5 xor2( s42, p42,g_41_cin )#5 xor2( s43, p43,g_42_cin )#5 xor2( s44, p44,g_43_cin )#5 xor2( s45, p45,g_44_cin )#5 xor2( s46, p46,g_45_cin )#5 xor2( s47, p47,g_46_cin )#5 xor2( s48, p48,g_47_cin )#5 xor2( s49, p49,g_48_cin )#5 xor2( s50, p50,g_49_cin )#5 xor2( s51, p51,g_50_cin )#5 xor2( s52, p52,g_51_cin )#5 xor2( s53, p53,g_52_cin )#5 xor2( s54, p54,g_53_cin )#5 xor2( s55, p55,g_54_cin )#5 xor2( s56, p56,g_55_cin )#5 xor2( s57, p57,g_56_cin )#5 xor2( s58, p58,g_57_cin )#5 xor2( s59, p59,g_58_cin )#5 xor2( s60, p60,g_59_cin )#5 xor2( s61, p61,g_60_cin )#5 xor2( s62, p62,g_61_cin )#5 xor2( s63, p63,g_62_cin )#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/koggeStone32bit.net
// Lonestar Benchmark Suite for irregular applications that exhibit // amorphous data-parallelism. // // Center for Grid and Distributed Computing // The University of Texas at Austin // // Copyright (C) 2007, 2008, 2009 The University of Texas at Austin // // Licensed under the Eclipse Public License, Version 1.0 (the "License"); // you may not use this file except in compliance with the License. // You may obtain a copy of the License at // // http://www.eclipse.org/legal/epl-v10.html // // Unless required by applicable law or agreed to in writing, software // distributed under the License is distributed on an "AS IS" BASIS, // WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. // See the License for the specific language governing permissions and // limitations under the License. // // File: koggeStone32bit.net finish 100000 inputs cin, a0, a1, a2, a3, a4, a5, a6, a7, a8, a9, a10, a11, a12, a13, a14, a15, a16, a17, a18, a19, a20, a21, a22, a23, a24, a25, a26, a27, a28, a29, a30, a31, b0, b1, b2, b3, b4, b5, b6, b7, b8, b9, b10, b11, b12, b13, b14, b15, b16, b17, b18, b19, b20, b21, b22, b23, b24, b25, b26, b27, b28, b29, b30, b31 end outputs cout, s0, s1, s2, s3, s4, s5, s6, s7, s8, s9, s10, s11, s12, s13, s14, s15, s16, s17, s18, s19, s20, s21, s22, s23, s24, s25, s26, s27, s28, s29, s30, s31 end initlist a0 0,0 80,1 105,0 167,1 194,0 236,1 262,0 321,1 397,0 416,1 492,0 569,1 610,0 621,1 680,0 695,1 750,0 788,1 840,0 881,1 886,0 971,1 1016,0 1054,1 1076,0 1117,1 1141,0 1223,1 1256,0 1329,1 1331,0 1342,1 1351,0 1376,1 1400,0 1416,1 1479,0 1543,1 1584,0 1672,1 1710,0 1774,1 1814,0 1842,1 1930,0 1940,1 2039,0 2117,1 2192,0 2260,1 2308,0 2382,1 2433,0 2511,1 2605,0 2607,1 2704,0 2706,1 2730,0 2816,1 2916,0 3014,1 3104,0 3160,1 3259,0 3344,1 3406,0 3426,1 3504,0 3527,1 3583,0 3590,1 3596,0 3624,1 3633,0 3644,1 3661,0 3715,1 3750,0 3819,1 3912,0 3945,1 4035,0 4062,1 4088,0 4126,1 4224,0 4320,1 4381,0 4407,1 4507,0 4547,1 4606,0 4669,1 4690,0 4774,1 4826,0 4874,1 4972,0 5044,1 5084,0 5094,1 5175,0 5179,1 5224,0 5248,1 5312,0 5392,1 5475,0 5490,1 5543,0 5612,1 5635,0 5636,1 5675,0 5774,1 5866,0 5907,1 5909,0 5913,1 5958,0 5960,1 6042,0 6096,1 6099,0 6183,1 6222,0 6308,1 6339,0 6342,1 6402,0 6405,1 6430,0 6433,1 6470,0 6505,1 6519,0 6589,1 6623,0 6697,1 6754,0 6819,1 6887,0 6959,1 7041,0 7083,1 7094,0 7097,1 7098,0 7122,1 7210,0 7278,1 7283,0 7338,1 7429,0 7510,1 7514,0 7572,1 7586,0 7603,1 7698,0 7728,1 7788,0 7826,1 7843,0 7925,1 8007,0 8094,1 8140,0 8180,1 8188,0 8227,1 8305,0 8354,1 8377,0 8411,1 8451,0 8532,1 8562,0 8600,1 8664,0 8679,1 8682,0 8722,1 8760,0 8805,1 8864,0 8954,1 8983,0 9026,1 9111,0 9184,1 9266,0 9340,1 9434,0 9461,1 9503,0 9548,1 9589,0 9673,1 9677,0 9731,1 9792,0 9799,1 9846,0 9882,1 9959,0 10000,1 10055,0 10102,1 10197,0 10257,1 10316,0 10319,1 10417,0 10439,1 10441,0 10455,1 10521,0 10621,1 10645,0 10683,1 10709,0 10722,1 10739,0 10778,1 10864,0 10883,1 10955,0 11041,1 11116,0 11136,1 11223,0 11285,1 11309,0 11366,1 11383,0 11469,1 11527,0 11581,1 11645,0 11723,1 11727,0 11733,1 11782,0 11868,1 11909,0 11951,1 11952,0 12014,1 12065,0 12099,1 12113,0 12116,1 12208,0 12295,1 12391,0 12456,1 12471,0 12478,1 12543,0 12624,1 12672,0 12717,1 12721,0 12779,1 12829,0 12851,1 12867,0 12959,1 12984,0 13060,1 13131,0 13160,1 13260,0 13288,1 13341,0 13399,1 13447,0 13465,1 13545,0 13618,1 13676,0 13722,1 13795,0 13873,1 13877,0 13886,1 13973,0 14000,1 14078,0 14086,1 14165,0 14198,1 14231,0 14295,1 14389,0 14485,1 14527,0 14618,1 14685,0 14720,1 14801,0 14896,1 14973,0 15001,1 15071,0 15149,1 15165,0 15235,1 15318,0 15372,1 15445,0 15513,1 15559,0 15612,1 15614,0 15662,1 15670,0 15695,1 15702,0 15713,1 15765,0 15783,1 15803,0 15824,1 15842,0 15941,1 15969,0 16002,1 16071,0 16120,1 16169,0 16187,1 16283,0 16328,1 16340,0 16379,1 16446,0 16452,1 16496,0 16531,1 16606,0 16635,1 16703,0 16719,1 16749,0 16799,1 16877,0 16976,1 17047,0 17088,1 17104,0 17127,1 17205,0 17209,1 17267,0 17280,1 17332,0 17393,1 17437,0 17506,1 17546,0 17560,1 17604,0 17622,1 17705,0 17755,1 17766,0 17836,1 17923,0 18019,1 18045,0 18053,1 18060,0 18075,1 18107,0 18167,1 18267,0 18297,1 18320,0 18349,1 18406,0 18440,1 18533,0 18603,1 18652,0 18723,1 18809,0 18892,1 18978,0 19062,1 19127,0 19154,1 19232,0 19243,1 19272,0 19276,1 19365,0 19448,1 19539,0 19629,1 19691,0 19722,1 19747,0 19749,1 19775,0 19863,1 19901,0 19910,1 19968,0 20047,1 20076,0 20122,1 20155,0 20184,1 20207,0 20271,1 20289,0 20349,1 20392,0 20481,1 20541,0 20606,1 20668,0 20686,1 20726,0 20772,1 20832,0 20919,1 20948,0 20953,1 21025,0 21120,1 21137,0 21226,1 21286,0 21378,1 21393,0 21461,1 21518,0 21557,1 21597,0 21680,1 21687,0 21701,1 21759,0 21819,1 21883,0 21899,1 21913,0 21940,1 22020,0 22073,1 22154,0 22232,1 22317,0 22363,1 22403,0 22420,1 22513,0 22536,1 22578,0 22603,1 22698,0 22774,1 22811,0 22874,1 22927,0 22968,1 23060,0 23116,1 23182,0 23255,1 23307,0 23318,1 23416,0 23512,1 23518,0 23608,1 23641,0 23682,1 23763,0 23813,1 23899,0 23912,1 23960,0 24046,1 24093,0 24099,1 24124,0 24142,1 24242,0 24299,1 24390,0 24423,1 24515,0 24550,1 24648,0 24673,1 24744,0 24766,1 24838,0 24931,1 24933,0 24987,1 25080,0 25084,1 25090,0 25136,1 25202,0 25225,1 25290,0 25341,1 25348,0 25370,1 25434,0 25500,1 25571,0 25593,1 25671,0 25692,1 25741,0 25830,1 25854,0 25876,1 25955,0 26017,1 26064,0 26077,1 26090,0 26188,1 26211,0 26272,1 26326,0 26347,1 26382,0 26385,1 26479,0 26523,1 26609,0 26694,1 26768,0 26839,1 26934,0 27007,1 27107,0 27171,1 27241,0 27321,1 27350,0 27426,1 27448,0 27512,1 27605,0 27659,1 27682,0 27748,1 27763,0 27777,1 27784,0 27845,1 27884,0 27971,1 28036,0 28113,1 28183,0 28249,1 28250,0 28325,1 28363,0 28390,1 28449,0 28489,1 28523,0 28537,1 28548,0 28587,1 28625,0 28654,1 28738,0 28751,1 28783,0 28834,1 28849,0 28870,1 28965,0 28971,1 29033,0 29083,1 29170,0 29191,1 29286,0 29300,1 29396,0 29404,1 29456,0 29494,1 29554,0 29571,1 29612,0 29707,1 29709,0 29729,1 29816,0 29877,1 29938,0 29952,1 29982,0 29992,1 30063,0 30089,1 30153,0 30242,1 30258,0 30282,1 30283,0 30334,1 30356,0 30438,1 30524,0 30587,1 30685,0 30757,1 30815,0 30836,1 30888,0 30965,1 30966,0 30985,1 30998,0 31038,1 31040,0 31131,1 31211,0 31229,1 31296,0 31396,1 31407,0 31430,1 31475,0 31546,1 31547,0 31582,1 31606,0 31683,1 31726,0 31793,1 31825,0 31899,1 31944,0 32023,1 32066,0 32074,1 32079,0 32147,1 32174,0 32247,1 32261,0 32262,1 32361,0 32438,1 32465,0 32536,1 32581,0 32589,1 32611,0 32693,1 32780,0 32849,1 32891,0 32934,1 33032,0 33088,1 33090,0 33129,1 33220,0 33261,1 33295,0 33382,1 33478,0 33531,1 33599,0 33667,1 33759,0 33774,1 33781,0 33829,1 33844,0 33933,1 34027,0 34059,1 34081,0 34099,1 34136,0 34192,1 34209,0 34236,1 34294,0 34383,1 34386,0 34445,1 34500,0 34583,1 34604,0 34654,1 34685,0 34736,1 34828,0 34913,1 34920,0 34940,1 34984,0 35005,1 35056,0 35102,1 35160,0 35177,1 35233,0 35274,1 35286,0 35379,1 35454,0 35466,1 35468,0 35567,1 35633,0 35704,1 35737,0 35787,1 35827,0 35877,1 35956,0 36003,1 36072,0 36141,1 36240,0 36257,1 36331,0 36387,1 36410,0 36473,1 36522,0 36562,1 36597,0 36687,1 36774,0 36854,1 36925,0 36972,1 36979,0 37070,1 37104,0 37157,1 37205,0 37291,1 37296,0 37300,1 37341,0 37417,1 37424,0 37522,1 37589,0 37634,1 37676,0 37724,1 37799,0 37845,1 37856,0 37861,1 37942,0 37986,1 38019,0 38115,1 38207,0 38237,1 38316,0 38415,1 38498,0 38594,1 38642,0 38659,1 38748,0 38752,1 38812,0 38833,1 38891,0 38904,1 38954,0 39016,1 39047,0 39112,1 39124,0 39206,1 39232,0 39259,1 39267,0 39332,1 39356,0 39391,1 39478,0 39557,1 39597,0 39667,1 39675,0 39722,1 39747,0 39804,1 39814,0 39874,1 39955,0 40019,1 40091,0 40191,1 40215,0 40288,1 40316,0 40332,1 40347,0 40383,1 40427,0 40470,1 40525,0 40564,1 40644,0 40718,1 40734,0 40778,1 40795,0 40880,1 40976,0 41060,1 41099,0 41128,1 41162,0 41253,1 41313,0 41317,1 41323,0 41344,1 41384,0 41419,1 41511,0 41527,1 41532,0 41627,1 41682,0 41707,1 41722,0 41745,1 41765,0 41819,1 41884,0 41975,1 42075,0 42155,1 42182,0 42239,1 42333,0 42359,1 42400,0 42470,1 42569,0 42641,1 42660,0 42666,1 42707,0 42745,1 42759,0 42782,1 42792,0 42797,1 42853,0 42859,1 42928,0 42992,1 43088,0 43102,1 43134,0 43171,1 43245,0 43274,1 43320,0 43369,1 43416,0 43453,1 43479,0 43526,1 43553,0 43631,1 43731,0 43822,1 43823,0 43917,1 43970,0 43978,1 44017,0 44054,1 44077,0 44141,1 44154,0 44229,1 44314,0 44404,1 44495,0 44578,1 44666,0 44728,1 44751,0 44780,1 44782,0 44867,1 44933,0 45008,1 45047,0 45069,1 45094,0 45141,1 45211,0 45280,1 45283,0 45359,1 45457,0 45479,1 45538,0 45612,1 45613,0 45698,1 45723,0 45786,1 45833,0 45856,1 45858,0 45913,1 45950,0 46031,1 46074,0 46077,1 46157,0 46208,1 46248,0 46295,1 46354,0 46413,1 46449,0 46495,1 46579,0 46661,1 46732,0 46785,1 46820,0 46891,1 46965,0 46977,1 46983,0 47037,1 47052,0 47099,1 47107,0 47130,1 47166,0 47224,1 47322,0 47354,1 47400,0 47499,1 47518,0 47612,1 47678,0 47746,1 47800,0 47858,1 47907,0 47966,1 48064,0 48070,1 48160,0 48239,1 48310,0 48346,1 48348,0 48364,1 48450,0 48531,1 48542,0 48617,1 48657,0 48693,1 48771,0 48821,1 48902,0 48972,1 48977,0 49047,1 49075,0 49136,1 49156,0 49214,1 49275,0 49331,1 49335,0 49409,1 end initlist a1 0,0 82,1 163,0 239,1 240,0 267,1 312,0 329,1 335,0 379,1 419,0 489,1 561,0 590,1 676,0 736,1 832,0 871,1 876,0 930,1 961,0 1048,1 1145,0 1201,1 1246,0 1344,1 1443,0 1478,1 1556,0 1650,1 1714,0 1721,1 1793,0 1868,1 1886,0 1965,1 2057,0 2140,1 2147,0 2158,1 2169,0 2208,1 2259,0 2286,1 2303,0 2396,1 2453,0 2516,1 2545,0 2560,1 2593,0 2683,1 2752,0 2837,1 2881,0 2925,1 2998,0 3045,1 3105,0 3136,1 3181,0 3197,1 3254,0 3336,1 3368,0 3387,1 3474,0 3525,1 3615,0 3625,1 3673,0 3710,1 3747,0 3756,1 3797,0 3872,1 3938,0 4031,1 4059,0 4107,1 4153,0 4229,1 4314,0 4363,1 4399,0 4451,1 4513,0 4572,1 4584,0 4645,1 4702,0 4715,1 4746,0 4804,1 4851,0 4878,1 4910,0 5010,1 5104,0 5168,1 5187,0 5224,1 5308,0 5402,1 5490,0 5533,1 5537,0 5619,1 5669,0 5676,1 5726,0 5751,1 5845,0 5921,1 5974,0 6009,1 6058,0 6094,1 6103,0 6167,1 6210,0 6284,1 6300,0 6354,1 6453,0 6544,1 6609,0 6612,1 6658,0 6747,1 6831,0 6838,1 6858,0 6876,1 6882,0 6915,1 7006,0 7064,1 7091,0 7188,1 7288,0 7316,1 7397,0 7443,1 7512,0 7553,1 7650,0 7697,1 7775,0 7865,1 7903,0 7998,1 8095,0 8150,1 8216,0 8246,1 8270,0 8294,1 8361,0 8452,1 8520,0 8543,1 8589,0 8643,1 8709,0 8786,1 8798,0 8856,1 8913,0 9012,1 9081,0 9097,1 9150,0 9174,1 9246,0 9311,1 9367,0 9386,1 9451,0 9543,1 9582,0 9620,1 9660,0 9749,1 9756,0 9792,1 9849,0 9887,1 9950,0 9998,1 10045,0 10122,1 10148,0 10185,1 10187,0 10225,1 10229,0 10237,1 10254,0 10342,1 10436,0 10445,1 10529,0 10585,1 10641,0 10717,1 10795,0 10864,1 10945,0 10953,1 10974,0 10990,1 11028,0 11056,1 11137,0 11224,1 11271,0 11301,1 11365,0 11400,1 11434,0 11514,1 11533,0 11564,1 11601,0 11697,1 11739,0 11793,1 11859,0 11944,1 12027,0 12038,1 12058,0 12158,1 12213,0 12296,1 12386,0 12421,1 12485,0 12499,1 12524,0 12529,1 12575,0 12675,1 12692,0 12696,1 12789,0 12835,1 12924,0 13002,1 13017,0 13078,1 13141,0 13184,1 13187,0 13203,1 13249,0 13327,1 13378,0 13439,1 13535,0 13558,1 13585,0 13667,1 13700,0 13800,1 13891,0 13926,1 14013,0 14060,1 14101,0 14118,1 14177,0 14209,1 14263,0 14338,1 14366,0 14442,1 14500,0 14542,1 14578,0 14678,1 14679,0 14767,1 14793,0 14835,1 14915,0 14997,1 15009,0 15067,1 15146,0 15164,1 15222,0 15275,1 15327,0 15349,1 15425,0 15427,1 15437,0 15448,1 15519,0 15608,1 15702,0 15767,1 15804,0 15896,1 15977,0 16077,1 16103,0 16111,1 16156,0 16235,1 16327,0 16389,1 16407,0 16455,1 16511,0 16601,1 16649,0 16740,1 16817,0 16858,1 16861,0 16878,1 16929,0 16976,1 17024,0 17089,1 17148,0 17232,1 17332,0 17387,1 17479,0 17570,1 17608,0 17686,1 17695,0 17790,1 17870,0 17925,1 18009,0 18104,1 18149,0 18230,1 18325,0 18376,1 18463,0 18556,1 18616,0 18634,1 18684,0 18723,1 18805,0 18900,1 18931,0 18987,1 18997,0 19050,1 19073,0 19074,1 19157,0 19193,1 19256,0 19348,1 19434,0 19493,1 19566,0 19650,1 19743,0 19752,1 19848,0 19854,1 19879,0 19948,1 20001,0 20101,1 20193,0 20271,1 20279,0 20303,1 20395,0 20436,1 20444,0 20541,1 20600,0 20640,1 20641,0 20739,1 20751,0 20841,1 20843,0 20908,1 20924,0 20978,1 21012,0 21092,1 21110,0 21192,1 21254,0 21311,1 21375,0 21465,1 21519,0 21596,1 21679,0 21766,1 21818,0 21916,1 21994,0 22063,1 22147,0 22207,1 22237,0 22242,1 22259,0 22307,1 22388,0 22414,1 22434,0 22510,1 22577,0 22617,1 22671,0 22694,1 22757,0 22803,1 22890,0 22987,1 23055,0 23102,1 23108,0 23165,1 23177,0 23214,1 23225,0 23322,1 23391,0 23442,1 23484,0 23539,1 23607,0 23704,1 23793,0 23871,1 23889,0 23982,1 24035,0 24091,1 24176,0 24251,1 24348,0 24440,1 24459,0 24465,1 24554,0 24563,1 24564,0 24660,1 24672,0 24719,1 24804,0 24836,1 24882,0 24918,1 24923,0 24942,1 24971,0 25028,1 25111,0 25121,1 25192,0 25234,1 25283,0 25380,1 25384,0 25470,1 25483,0 25492,1 25536,0 25551,1 25595,0 25604,1 25620,0 25664,1 25687,0 25758,1 25841,0 25898,1 25906,0 25957,1 26042,0 26056,1 26142,0 26153,1 26213,0 26267,1 26290,0 26320,1 26335,0 26372,1 26385,0 26477,1 26491,0 26513,1 26562,0 26591,1 26684,0 26751,1 26842,0 26863,1 26909,0 26950,1 26972,0 27018,1 27026,0 27089,1 27134,0 27152,1 27228,0 27306,1 27349,0 27407,1 27408,0 27425,1 27462,0 27494,1 27584,0 27632,1 27639,0 27661,1 27745,0 27788,1 27881,0 27902,1 27952,0 27977,1 28071,0 28085,1 28133,0 28198,1 28257,0 28345,1 28433,0 28475,1 28552,0 28628,1 28685,0 28758,1 28781,0 28833,1 28922,0 28960,1 28994,0 29023,1 29029,0 29051,1 29107,0 29120,1 29179,0 29201,1 29268,0 29322,1 29397,0 29415,1 29458,0 29520,1 29608,0 29641,1 29727,0 29749,1 29826,0 29861,1 29889,0 29924,1 29945,0 29969,1 30015,0 30021,1 30026,0 30077,1 30136,0 30220,1 30241,0 30323,1 30332,0 30384,1 30475,0 30529,1 30548,0 30558,1 30582,0 30667,1 30679,0 30708,1 30709,0 30772,1 30837,0 30883,1 30976,0 31033,1 31091,0 31131,1 31189,0 31216,1 31309,0 31332,1 31367,0 31453,1 31523,0 31614,1 31710,0 31743,1 31822,0 31838,1 31905,0 31958,1 31999,0 32030,1 32111,0 32181,1 32261,0 32358,1 32367,0 32372,1 32408,0 32456,1 32515,0 32544,1 32572,0 32608,1 32666,0 32681,1 32739,0 32819,1 32857,0 32915,1 32988,0 33048,1 33131,0 33177,1 33190,0 33217,1 33235,0 33329,1 33338,0 33423,1 33432,0 33495,1 33529,0 33607,1 33701,0 33728,1 33810,0 33835,1 33923,0 33949,1 33975,0 34014,1 34066,0 34082,1 34087,0 34151,1 34232,0 34234,1 34242,0 34313,1 34413,0 34505,1 34557,0 34568,1 34636,0 34686,1 34702,0 34737,1 34814,0 34906,1 34933,0 34948,1 34983,0 35038,1 35053,0 35073,1 35160,0 35165,1 35173,0 35263,1 35302,0 35386,1 35415,0 35434,1 35527,0 35577,1 35677,0 35681,1 35763,0 35827,1 35918,0 35919,1 35983,0 36003,1 36095,0 36141,1 36180,0 36200,1 36244,0 36344,1 36420,0 36500,1 36533,0 36559,1 36584,0 36605,1 36685,0 36758,1 36830,0 36870,1 36871,0 36949,1 36993,0 37088,1 37125,0 37146,1 37158,0 37227,1 37250,0 37279,1 37305,0 37365,1 37382,0 37412,1 37483,0 37537,1 37575,0 37662,1 37715,0 37803,1 37872,0 37884,1 37911,0 37988,1 38080,0 38126,1 38193,0 38197,1 38235,0 38262,1 38294,0 38296,1 38327,0 38353,1 38426,0 38469,1 38505,0 38560,1 38601,0 38674,1 38734,0 38829,1 38921,0 38957,1 38968,0 39022,1 39116,0 39124,1 39220,0 39318,1 39363,0 39418,1 39462,0 39514,1 39576,0 39596,1 39691,0 39773,1 39817,0 39881,1 39893,0 39980,1 40067,0 40151,1 40186,0 40236,1 40240,0 40275,1 40342,0 40382,1 40389,0 40485,1 40579,0 40589,1 40629,0 40706,1 40788,0 40837,1 40867,0 40965,1 40970,0 41037,1 41095,0 41142,1 41161,0 41246,1 41329,0 41391,1 41483,0 41580,1 41624,0 41652,1 41688,0 41730,1 41803,0 41841,1 41934,0 42031,1 42059,0 42122,1 42174,0 42237,1 42241,0 42281,1 42289,0 42323,1 42352,0 42428,1 42445,0 42506,1 42527,0 42561,1 42642,0 42678,1 42766,0 42865,1 42906,0 43003,1 43007,0 43061,1 43108,0 43156,1 43203,0 43292,1 43301,0 43381,1 43454,0 43472,1 43567,0 43631,1 43724,0 43744,1 43782,0 43795,1 43868,0 43896,1 43948,0 44007,1 44042,0 44121,1 44177,0 44252,1 44309,0 44335,1 44397,0 44416,1 44505,0 44528,1 44626,0 44663,1 44701,0 44780,1 44840,0 44862,1 44897,0 44911,1 44959,0 44987,1 45037,0 45114,1 45141,0 45173,1 45206,0 45245,1 45248,0 45286,1 45339,0 45358,1 45450,0 45471,1 45481,0 45534,1 45617,0 45643,1 45650,0 45731,1 45736,0 45809,1 45895,0 45913,1 45963,0 45968,1 46045,0 46113,1 46126,0 46161,1 46231,0 46310,1 46404,0 46452,1 46493,0 46559,1 46613,0 46690,1 46722,0 46801,1 46874,0 46958,1 47009,0 47051,1 47060,0 47158,1 47208,0 47232,1 47243,0 47342,1 47374,0 47394,1 47403,0 47458,1 47513,0 47564,1 47568,0 47615,1 47626,0 47685,1 47772,0 47808,1 47813,0 47836,1 47854,0 47904,1 47955,0 48043,1 48066,0 48161,1 48237,0 48262,1 48274,0 48324,1 48403,0 48496,1 48590,0 48623,1 48630,0 48668,1 48747,0 48815,1 48843,0 48921,1 48997,0 49023,1 49035,0 49127,1 49195,0 49290,1 49334,0 49384,1 49482,0 49552,1 49615,0 49647,1 49732,0 49801,1 49805,0 49858,1 49923,0 50016,1 50058,0 50111,1 50126,0 50153,1 50158,0 50215,1 50306,0 50348,1 50445,0 50538,1 50568,0 50584,1 50628,0 50656,1 50751,0 50803,1 50864,0 50877,1 50934,0 50941,1 50989,0 51079,1 51082,0 51122,1 51164,0 51193,1 51205,0 51250,1 end initlist a2 0,0 99,1 187,0 201,1 211,0 283,1 378,0 457,1 514,0 590,1 670,0 701,1 755,0 818,1 914,0 938,1 1037,0 1078,1 1171,0 1247,1 1292,0 1345,1 1385,0 1466,1 1528,0 1541,1 1604,0 1633,1 1671,0 1762,1 1774,0 1857,1 1940,0 1962,1 2014,0 2034,1 2130,0 2212,1 2287,0 2363,1 2436,0 2494,1 2569,0 2582,1 2616,0 2650,1 2740,0 2753,1 2851,0 2870,1 2941,0 3037,1 3136,0 3152,1 3227,0 3302,1 3354,0 3395,1 3405,0 3475,1 3543,0 3557,1 3639,0 3703,1 3708,0 3772,1 3774,0 3864,1 3879,0 3941,1 3983,0 4077,1 4129,0 4169,1 4248,0 4332,1 4364,0 4393,1 4399,0 4457,1 4465,0 4548,1 4606,0 4610,1 4683,0 4763,1 4829,0 4844,1 4865,0 4891,1 4937,0 4947,1 4986,0 5031,1 5057,0 5130,1 5216,0 5303,1 5368,0 5386,1 5406,0 5411,1 5485,0 5488,1 5551,0 5612,1 5645,0 5708,1 5726,0 5794,1 5876,0 5891,1 5899,0 5982,1 6060,0 6088,1 6152,0 6232,1 6282,0 6361,1 6377,0 6457,1 6471,0 6478,1 6536,0 6584,1 6680,0 6725,1 6813,0 6818,1 6878,0 6916,1 6953,0 6985,1 7073,0 7140,1 7160,0 7260,1 7293,0 7348,1 7398,0 7420,1 7430,0 7477,1 7561,0 7648,1 7662,0 7711,1 7737,0 7792,1 7829,0 7921,1 7996,0 8056,1 8092,0 8102,1 8178,0 8267,1 8294,0 8352,1 8411,0 8425,1 8452,0 8525,1 8559,0 8602,1 8608,0 8692,1 8718,0 8803,1 8888,0 8911,1 8934,0 9008,1 9060,0 9074,1 9098,0 9135,1 9182,0 9257,1 9344,0 9366,1 9445,0 9461,1 9483,0 9503,1 9599,0 9636,1 9688,0 9724,1 9790,0 9844,1 9900,0 9929,1 9937,0 9942,1 10033,0 10094,1 10130,0 10217,1 10249,0 10321,1 10353,0 10396,1 10437,0 10452,1 10531,0 10630,1 10691,0 10717,1 10803,0 10885,1 10886,0 10939,1 11014,0 11038,1 11053,0 11125,1 11148,0 11224,1 11286,0 11312,1 11348,0 11361,1 11374,0 11447,1 11479,0 11517,1 11573,0 11586,1 11594,0 11654,1 11734,0 11770,1 11775,0 11788,1 11875,0 11924,1 12007,0 12099,1 12198,0 12265,1 12290,0 12340,1 12344,0 12359,1 12409,0 12427,1 12513,0 12593,1 12602,0 12663,1 12684,0 12749,1 12755,0 12791,1 12830,0 12909,1 12960,0 13048,1 13055,0 13144,1 13171,0 13183,1 13245,0 13281,1 13304,0 13356,1 13363,0 13408,1 13419,0 13440,1 13519,0 13602,1 13677,0 13753,1 13760,0 13781,1 13867,0 13898,1 13939,0 13991,1 14012,0 14076,1 14134,0 14225,1 14226,0 14293,1 14358,0 14394,1 14481,0 14537,1 14629,0 14679,1 14756,0 14833,1 14894,0 14987,1 15013,0 15064,1 15157,0 15239,1 15308,0 15356,1 15392,0 15471,1 15497,0 15572,1 15661,0 15707,1 15732,0 15807,1 15859,0 15927,1 15980,0 16037,1 16042,0 16114,1 16128,0 16157,1 16174,0 16225,1 16244,0 16287,1 16369,0 16381,1 16421,0 16491,1 16510,0 16550,1 16609,0 16625,1 16705,0 16756,1 16807,0 16900,1 16985,0 17031,1 17117,0 17171,1 17196,0 17245,1 17254,0 17330,1 17336,0 17347,1 17417,0 17418,1 17450,0 17518,1 17584,0 17590,1 17628,0 17683,1 17774,0 17810,1 17908,0 17978,1 18053,0 18110,1 18184,0 18266,1 18354,0 18408,1 18447,0 18500,1 18542,0 18582,1 18584,0 18632,1 18687,0 18776,1 18799,0 18858,1 18867,0 18909,1 18959,0 18986,1 19077,0 19177,1 19272,0 19296,1 19355,0 19384,1 19421,0 19447,1 19503,0 19536,1 19590,0 19598,1 19603,0 19702,1 19726,0 19758,1 19825,0 19884,1 19980,0 20019,1 20055,0 20119,1 20163,0 20190,1 20259,0 20316,1 20403,0 20478,1 20562,0 20596,1 20685,0 20775,1 20837,0 20912,1 20955,0 20988,1 21066,0 21077,1 21163,0 21221,1 21259,0 21313,1 21382,0 21430,1 21492,0 21586,1 21657,0 21716,1 21743,0 21787,1 21815,0 21875,1 21911,0 21951,1 22002,0 22008,1 22084,0 22166,1 22257,0 22275,1 22304,0 22367,1 22448,0 22452,1 22531,0 22545,1 22568,0 22591,1 22687,0 22774,1 22819,0 22858,1 22895,0 22976,1 22979,0 23058,1 23105,0 23108,1 23195,0 23202,1 23240,0 23308,1 23310,0 23371,1 23437,0 23514,1 23602,0 23606,1 23701,0 23738,1 23823,0 23833,1 23888,0 23971,1 24061,0 24156,1 24245,0 24284,1 24338,0 24360,1 24372,0 24378,1 24417,0 24498,1 24542,0 24623,1 24677,0 24706,1 24752,0 24826,1 24880,0 24909,1 24984,0 24986,1 25069,0 25136,1 25201,0 25229,1 25311,0 25358,1 25451,0 25503,1 25603,0 25699,1 25751,0 25776,1 25802,0 25855,1 25894,0 25937,1 26028,0 26067,1 26073,0 26095,1 26147,0 26209,1 26217,0 26284,1 26364,0 26384,1 26437,0 26476,1 26508,0 26599,1 26653,0 26657,1 26741,0 26773,1 26871,0 26896,1 26977,0 27071,1 27123,0 27205,1 27206,0 27299,1 27391,0 27406,1 27457,0 27514,1 27531,0 27583,1 27648,0 27674,1 27696,0 27739,1 27823,0 27837,1 27840,0 27874,1 27964,0 28023,1 28087,0 28111,1 28112,0 28203,1 28296,0 28321,1 28413,0 28486,1 28522,0 28621,1 28642,0 28699,1 28756,0 28842,1 28866,0 28956,1 28970,0 29007,1 29083,0 29136,1 29171,0 29221,1 29235,0 29296,1 29357,0 29428,1 29446,0 29468,1 29522,0 29560,1 29613,0 29632,1 29697,0 29720,1 29751,0 29795,1 29818,0 29844,1 29868,0 29933,1 30001,0 30019,1 30031,0 30074,1 30141,0 30198,1 30265,0 30331,1 30373,0 30454,1 30460,0 30476,1 30568,0 30603,1 30680,0 30683,1 30701,0 30709,1 30767,0 30844,1 30905,0 30954,1 31026,0 31074,1 31165,0 31248,1 31269,0 31365,1 31396,0 31419,1 31490,0 31510,1 31586,0 31590,1 31616,0 31691,1 31698,0 31767,1 31839,0 31901,1 31990,0 32022,1 32118,0 32176,1 32271,0 32309,1 32404,0 32481,1 32492,0 32544,1 32609,0 32643,1 32728,0 32774,1 32861,0 32937,1 33031,0 33095,1 33168,0 33255,1 33309,0 33356,1 33427,0 33459,1 33496,0 33581,1 33595,0 33645,1 33696,0 33771,1 33818,0 33894,1 33992,0 34045,1 34091,0 34122,1 34180,0 34243,1 34312,0 34337,1 34405,0 34457,1 34533,0 34555,1 34579,0 34666,1 34702,0 34750,1 34814,0 34912,1 34941,0 34988,1 34993,0 35027,1 35086,0 35094,1 35189,0 35200,1 35215,0 35285,1 35307,0 35324,1 35411,0 35413,1 35478,0 35574,1 35579,0 35646,1 35691,0 35693,1 35716,0 35802,1 35900,0 35961,1 35975,0 36041,1 36099,0 36116,1 36159,0 36208,1 36275,0 36302,1 36352,0 36406,1 36454,0 36471,1 36526,0 36578,1 36636,0 36640,1 36645,0 36652,1 36727,0 36819,1 36858,0 36860,1 36960,0 36976,1 36996,0 37013,1 37024,0 37092,1 37111,0 37157,1 37181,0 37226,1 37307,0 37364,1 37446,0 37503,1 37575,0 37639,1 37678,0 37723,1 37773,0 37781,1 37786,0 37853,1 37884,0 37934,1 37999,0 38087,1 38113,0 38162,1 38172,0 38203,1 38262,0 38279,1 38346,0 38363,1 38450,0 38474,1 38545,0 38643,1 38737,0 38755,1 38853,0 38941,1 38987,0 39016,1 39027,0 39058,1 39061,0 39085,1 39176,0 39189,1 39263,0 39338,1 39354,0 39375,1 39384,0 39484,1 39559,0 39601,1 39663,0 39734,1 39797,0 39825,1 39840,0 39849,1 39911,0 39996,1 40050,0 40051,1 40125,0 40205,1 40237,0 40327,1 40403,0 40461,1 40474,0 40571,1 40636,0 40704,1 40773,0 40860,1 40933,0 41011,1 41054,0 41103,1 41129,0 41196,1 41238,0 41280,1 41311,0 41336,1 41430,0 41521,1 41540,0 41625,1 41703,0 41751,1 41831,0 41899,1 41921,0 41960,1 41966,0 42011,1 42072,0 42171,1 42254,0 42317,1 42405,0 42492,1 42525,0 42570,1 42593,0 42604,1 42652,0 42721,1 42741,0 42819,1 42846,0 42860,1 42886,0 42929,1 42972,0 43010,1 43014,0 43070,1 43086,0 43097,1 43168,0 43190,1 43202,0 43243,1 43340,0 43352,1 43448,0 43534,1 43633,0 43709,1 43734,0 43804,1 43820,0 43859,1 43879,0 43886,1 43955,0 44007,1 44033,0 44130,1 44190,0 44201,1 44227,0 44238,1 44330,0 44396,1 44440,0 44499,1 44556,0 44558,1 44624,0 44653,1 44749,0 44754,1 44777,0 44784,1 44830,0 44863,1 44910,0 44955,1 44961,0 44984,1 44992,0 45013,1 45042,0 45138,1 45195,0 45221,1 45230,0 45295,1 45304,0 45329,1 45412,0 45427,1 45499,0 45569,1 45605,0 45611,1 45681,0 45781,1 45803,0 45857,1 45916,0 45963,1 45979,0 46011,1 46085,0 46184,1 46279,0 46365,1 46443,0 46459,1 46550,0 46604,1 46692,0 46791,1 46847,0 46911,1 46925,0 46963,1 47027,0 47049,1 47140,0 47189,1 47206,0 47304,1 47308,0 47328,1 47347,0 47356,1 47370,0 47418,1 47506,0 47602,1 47702,0 47727,1 47753,0 47792,1 47816,0 47821,1 47858,0 47874,1 47961,0 47993,1 48029,0 48094,1 48126,0 48226,1 48277,0 48344,1 48411,0 48427,1 48441,0 48475,1 48552,0 48600,1 48675,0 48693,1 48754,0 48823,1 48835,0 48888,1 48981,0 49009,1 49020,0 49099,1 49112,0 49127,1 49198,0 49216,1 49279,0 49377,1 49460,0 49462,1 49483,0 49537,1 49597,0 49673,1 49694,0 49749,1 49822,0 49884,1 49948,0 49976,1 49979,0 50074,1 50125,0 50169,1 50269,0 50360,1 end initlist a3 0,0 11,1 14,0 28,1 44,0 143,1 191,0 242,1 246,0 333,1 432,0 490,1 514,0 552,1 650,0 669,1 748,0 828,1 875,0 883,1 885,0 934,1 989,0 1083,1 1139,0 1188,1 1209,0 1278,1 1303,0 1361,1 1391,0 1430,1 1509,0 1551,1 1643,0 1743,1 1746,0 1812,1 1878,0 1924,1 1961,0 2051,1 2140,0 2149,1 2152,0 2159,1 2178,0 2187,1 2232,0 2238,1 2308,0 2387,1 2475,0 2549,1 2574,0 2630,1 2711,0 2798,1 2898,0 2933,1 2971,0 3025,1 3033,0 3125,1 3215,0 3291,1 3317,0 3379,1 3442,0 3452,1 3486,0 3565,1 3568,0 3586,1 3618,0 3628,1 3702,0 3782,1 3849,0 3850,1 3869,0 3899,1 3933,0 4009,1 4086,0 4145,1 4150,0 4195,1 4267,0 4315,1 4342,0 4372,1 4377,0 4426,1 4522,0 4608,1 4657,0 4698,1 4757,0 4825,1 4888,0 4978,1 5052,0 5123,1 5139,0 5157,1 5236,0 5243,1 5273,0 5371,1 5389,0 5469,1 5556,0 5644,1 5731,0 5732,1 5779,0 5847,1 5923,0 5961,1 5964,0 6047,1 6058,0 6127,1 6174,0 6199,1 6247,0 6271,1 6353,0 6419,1 6517,0 6530,1 6584,0 6629,1 6657,0 6737,1 6813,0 6856,1 6915,0 7005,1 7092,0 7180,1 7220,0 7250,1 7337,0 7338,1 7402,0 7466,1 7540,0 7593,1 7691,0 7736,1 7757,0 7823,1 7856,0 7913,1 7931,0 7987,1 8025,0 8086,1 8159,0 8194,1 8273,0 8365,1 8455,0 8504,1 8537,0 8556,1 8567,0 8652,1 8658,0 8687,1 8750,0 8816,1 8916,0 8949,1 9047,0 9072,1 9134,0 9178,1 9244,0 9337,1 9424,0 9453,1 9499,0 9532,1 9579,0 9642,1 9667,0 9756,1 9812,0 9866,1 9897,0 9963,1 10060,0 10126,1 10172,0 10216,1 10288,0 10360,1 10449,0 10482,1 10489,0 10585,1 10587,0 10595,1 10614,0 10694,1 10752,0 10809,1 10892,0 10954,1 10979,0 11006,1 11014,0 11043,1 11108,0 11181,1 11202,0 11213,1 11245,0 11283,1 11358,0 11394,1 11431,0 11476,1 11504,0 11556,1 11636,0 11723,1 11785,0 11837,1 11902,0 11917,1 12009,0 12046,1 12063,0 12137,1 12141,0 12169,1 12252,0 12278,1 12376,0 12378,1 12456,0 12493,1 12499,0 12554,1 12643,0 12673,1 12729,0 12770,1 12868,0 12898,1 12921,0 12989,1 13081,0 13168,1 13169,0 13262,1 13362,0 13439,1 13445,0 13478,1 13482,0 13544,1 13594,0 13628,1 13721,0 13723,1 13757,0 13814,1 13843,0 13866,1 13950,0 14001,1 14040,0 14064,1 14115,0 14201,1 14212,0 14260,1 14302,0 14388,1 14398,0 14471,1 14504,0 14522,1 14573,0 14628,1 14685,0 14754,1 14830,0 14929,1 15006,0 15039,1 15078,0 15137,1 15222,0 15238,1 15243,0 15289,1 15309,0 15385,1 15425,0 15454,1 15533,0 15614,1 15647,0 15685,1 15712,0 15751,1 15771,0 15803,1 15899,0 15924,1 15967,0 16036,1 16126,0 16135,1 16190,0 16286,1 16351,0 16427,1 16479,0 16524,1 16607,0 16689,1 16694,0 16710,1 16804,0 16865,1 16950,0 17041,1 17060,0 17095,1 17138,0 17212,1 17220,0 17271,1 17329,0 17426,1 17455,0 17502,1 17525,0 17574,1 17604,0 17655,1 17663,0 17714,1 17774,0 17872,1 17923,0 17974,1 17995,0 18048,1 18055,0 18109,1 18164,0 18183,1 18188,0 18212,1 18309,0 18348,1 18368,0 18379,1 18406,0 18485,1 18527,0 18624,1 18656,0 18713,1 18724,0 18785,1 18788,0 18888,1 18903,0 18944,1 18954,0 18958,1 19003,0 19072,1 19092,0 19121,1 19131,0 19201,1 19207,0 19281,1 19294,0 19316,1 19325,0 19415,1 19472,0 19504,1 19584,0 19641,1 19730,0 19738,1 19755,0 19767,1 19803,0 19846,1 19911,0 20003,1 20042,0 20139,1 20239,0 20337,1 20400,0 20496,1 20535,0 20569,1 20660,0 20752,1 20810,0 20819,1 20848,0 20947,1 20977,0 21062,1 21109,0 21150,1 21193,0 21267,1 21335,0 21348,1 21432,0 21474,1 21508,0 21590,1 21654,0 21658,1 21711,0 21759,1 21771,0 21833,1 21901,0 21997,1 22067,0 22140,1 22177,0 22182,1 22213,0 22234,1 22321,0 22386,1 22477,0 22542,1 22579,0 22661,1 22684,0 22700,1 22793,0 22797,1 22800,0 22803,1 22894,0 22944,1 22965,0 22985,1 23056,0 23148,1 23156,0 23254,1 23260,0 23328,1 23409,0 23420,1 23474,0 23561,1 23630,0 23644,1 23695,0 23790,1 23801,0 23821,1 23902,0 23985,1 24023,0 24042,1 24125,0 24156,1 24187,0 24209,1 24213,0 24250,1 24330,0 24347,1 24355,0 24359,1 24391,0 24428,1 24456,0 24505,1 24518,0 24596,1 24654,0 24754,1 24766,0 24862,1 24866,0 24958,1 24965,0 25029,1 25089,0 25134,1 25140,0 25222,1 25274,0 25292,1 25312,0 25356,1 25381,0 25386,1 25425,0 25441,1 25493,0 25591,1 25674,0 25680,1 25683,0 25689,1 25748,0 25830,1 25867,0 25959,1 26017,0 26037,1 26053,0 26097,1 26172,0 26250,1 26276,0 26361,1 26368,0 26390,1 26445,0 26518,1 26579,0 26656,1 26687,0 26742,1 26753,0 26797,1 26798,0 26865,1 26878,0 26899,1 26930,0 26933,1 26974,0 27064,1 27113,0 27152,1 27232,0 27273,1 27312,0 27317,1 27338,0 27349,1 27376,0 27426,1 27525,0 27585,1 27637,0 27736,1 27750,0 27769,1 27792,0 27804,1 27850,0 27852,1 27909,0 28005,1 28018,0 28026,1 28036,0 28079,1 28145,0 28160,1 28227,0 28252,1 28331,0 28425,1 28518,0 28552,1 28596,0 28653,1 28705,0 28713,1 28714,0 28769,1 28781,0 28798,1 28852,0 28893,1 28974,0 28997,1 29094,0 29184,1 29186,0 29234,1 29326,0 29329,1 29344,0 29410,1 29501,0 29592,1 29653,0 29712,1 29747,0 29846,1 29906,0 29913,1 29935,0 29983,1 30038,0 30093,1 30162,0 30193,1 30237,0 30332,1 30367,0 30407,1 30501,0 30573,1 30648,0 30666,1 30766,0 30819,1 30840,0 30867,1 30868,0 30928,1 30934,0 30996,1 31011,0 31091,1 31119,0 31187,1 31229,0 31316,1 31413,0 31462,1 31503,0 31562,1 31636,0 31722,1 31742,0 31747,1 31793,0 31804,1 31881,0 31930,1 31972,0 32066,1 32137,0 32233,1 32269,0 32270,1 32297,0 32335,1 32435,0 32469,1 32486,0 32500,1 32533,0 32543,1 32597,0 32620,1 32653,0 32672,1 32730,0 32789,1 32870,0 32877,1 32943,0 33009,1 33039,0 33117,1 33165,0 33187,1 33192,0 33225,1 33279,0 33369,1 33440,0 33442,1 33515,0 33557,1 33619,0 33700,1 33730,0 33803,1 33822,0 33867,1 33877,0 33933,1 34016,0 34017,1 34033,0 34122,1 34201,0 34282,1 34361,0 34459,1 34486,0 34525,1 34544,0 34622,1 34680,0 34730,1 34809,0 34895,1 34978,0 35031,1 35065,0 35085,1 35165,0 35183,1 35258,0 35347,1 35447,0 35454,1 35518,0 35607,1 35654,0 35713,1 35800,0 35864,1 35869,0 35886,1 35945,0 35969,1 36059,0 36091,1 36154,0 36167,1 36207,0 36246,1 36299,0 36316,1 36330,0 36374,1 36427,0 36449,1 36508,0 36530,1 36580,0 36664,1 36668,0 36697,1 36786,0 36877,1 36893,0 36910,1 37000,0 37091,1 37103,0 37144,1 37174,0 37175,1 37216,0 37244,1 37279,0 37319,1 37375,0 37426,1 37523,0 37536,1 37625,0 37631,1 37670,0 37724,1 37750,0 37813,1 37830,0 37851,1 37935,0 37993,1 38090,0 38124,1 38191,0 38206,1 38215,0 38281,1 38340,0 38420,1 38429,0 38521,1 38584,0 38605,1 38651,0 38674,1 38683,0 38764,1 38765,0 38789,1 38888,0 38982,1 39080,0 39161,1 39167,0 39223,1 39285,0 39300,1 39312,0 39367,1 39432,0 39474,1 39559,0 39618,1 39644,0 39661,1 39741,0 39810,1 39850,0 39925,1 39980,0 40069,1 40150,0 40248,1 40249,0 40325,1 40379,0 40467,1 40537,0 40595,1 40659,0 40683,1 40751,0 40811,1 40850,0 40925,1 40950,0 40966,1 40976,0 41031,1 41109,0 41195,1 41249,0 41294,1 41359,0 41370,1 41373,0 41421,1 41501,0 41508,1 41586,0 41632,1 41689,0 41752,1 41806,0 41892,1 41894,0 41904,1 41996,0 42017,1 42053,0 42099,1 42109,0 42137,1 42224,0 42291,1 42330,0 42409,1 42426,0 42470,1 42485,0 42537,1 42565,0 42619,1 42666,0 42765,1 42832,0 42876,1 42949,0 42974,1 43033,0 43067,1 43145,0 43227,1 43255,0 43265,1 43345,0 43374,1 43466,0 43467,1 43535,0 43615,1 43667,0 43749,1 43823,0 43838,1 43859,0 43875,1 43948,0 44038,1 44114,0 44157,1 44159,0 44239,1 44306,0 44383,1 44430,0 44447,1 44490,0 44565,1 44660,0 44681,1 44711,0 44722,1 44784,0 44797,1 44887,0 44977,1 45022,0 45046,1 45072,0 45136,1 45159,0 45237,1 45249,0 45267,1 45360,0 45369,1 45378,0 45453,1 45499,0 45549,1 45646,0 45736,1 45805,0 45903,1 45929,0 45970,1 46017,0 46098,1 46184,0 46186,1 46265,0 46280,1 46363,0 46433,1 46459,0 46507,1 46602,0 46638,1 46718,0 46775,1 46796,0 46872,1 46919,0 46928,1 46997,0 47046,1 47142,0 47237,1 47244,0 47279,1 47368,0 47378,1 47478,0 47542,1 47623,0 47641,1 47697,0 47711,1 47783,0 47862,1 47926,0 48013,1 48100,0 48105,1 48189,0 48215,1 48298,0 48347,1 48408,0 48494,1 48583,0 48664,1 48753,0 48761,1 48860,0 48883,1 48941,0 49008,1 49089,0 49136,1 49138,0 49237,1 49255,0 49308,1 49355,0 49444,1 49449,0 49531,1 49593,0 49606,1 49648,0 49677,1 end initlist a4 0,0 18,1 106,0 158,1 217,0 276,1 327,0 332,1 348,0 389,1 456,0 513,1 537,0 554,1 583,0 667,1 678,0 705,1 786,0 814,1 825,0 857,1 896,0 910,1 946,0 959,1 1031,0 1079,1 1108,0 1112,1 1166,0 1191,1 1228,0 1291,1 1369,0 1418,1 1468,0 1489,1 1524,0 1527,1 1626,0 1673,1 1761,0 1842,1 1845,0 1905,1 1918,0 1949,1 1984,0 2062,1 2116,0 2215,1 2217,0 2294,1 2381,0 2449,1 2540,0 2581,1 2649,0 2690,1 2764,0 2794,1 2829,0 2836,1 2859,0 2910,1 2929,0 3009,1 3031,0 3114,1 3119,0 3219,1 3226,0 3235,1 3325,0 3391,1 3480,0 3555,1 3575,0 3611,1 3683,0 3692,1 3706,0 3779,1 3836,0 3896,1 3984,0 4033,1 4085,0 4141,1 4162,0 4183,1 4239,0 4322,1 4338,0 4396,1 4475,0 4518,1 4535,0 4560,1 4607,0 4618,1 4662,0 4711,1 4769,0 4867,1 4964,0 5025,1 5086,0 5152,1 5234,0 5328,1 5332,0 5408,1 5487,0 5552,1 5553,0 5571,1 5666,0 5697,1 5741,0 5801,1 5848,0 5914,1 5932,0 5968,1 5997,0 6009,1 6021,0 6055,1 6088,0 6188,1 6197,0 6268,1 6324,0 6365,1 6383,0 6448,1 6483,0 6537,1 6548,0 6619,1 6669,0 6673,1 6686,0 6734,1 6791,0 6881,1 6954,0 7037,1 7063,0 7106,1 7188,0 7275,1 7365,0 7392,1 7443,0 7452,1 7533,0 7571,1 7573,0 7662,1 7743,0 7818,1 7900,0 7912,1 7951,0 8008,1 8092,0 8154,1 8199,0 8297,1 8345,0 8406,1 8470,0 8535,1 8564,0 8655,1 8714,0 8718,1 8776,0 8801,1 8855,0 8942,1 8989,0 9033,1 9046,0 9050,1 9118,0 9119,1 9213,0 9250,1 9306,0 9347,1 9417,0 9424,1 9460,0 9495,1 9593,0 9607,1 9660,0 9735,1 9797,0 9804,1 9848,0 9932,1 10009,0 10043,1 10130,0 10162,1 10248,0 10333,1 10414,0 10434,1 10501,0 10575,1 10643,0 10743,1 10817,0 10847,1 10886,0 10897,1 10926,0 10947,1 11021,0 11114,1 11161,0 11193,1 11222,0 11229,1 11299,0 11347,1 11383,0 11415,1 11512,0 11597,1 11683,0 11700,1 11793,0 11880,1 11908,0 11972,1 12001,0 12002,1 12017,0 12085,1 12144,0 12166,1 12243,0 12317,1 12342,0 12439,1 12502,0 12583,1 12635,0 12654,1 12657,0 12732,1 12808,0 12882,1 12917,0 12980,1 13068,0 13166,1 13232,0 13259,1 13331,0 13346,1 13413,0 13474,1 13545,0 13582,1 13595,0 13622,1 13672,0 13686,1 13723,0 13761,1 13852,0 13928,1 14006,0 14069,1 14072,0 14152,1 14250,0 14263,1 14351,0 14418,1 14436,0 14453,1 14469,0 14470,1 14525,0 14573,1 14631,0 14654,1 14690,0 14711,1 14781,0 14863,1 14937,0 14983,1 15025,0 15079,1 15161,0 15187,1 15254,0 15322,1 15333,0 15404,1 15486,0 15584,1 15662,0 15734,1 15778,0 15797,1 15820,0 15840,1 15851,0 15873,1 15952,0 16029,1 16071,0 16081,1 16149,0 16191,1 16262,0 16282,1 16324,0 16382,1 16419,0 16485,1 16519,0 16607,1 16693,0 16736,1 16760,0 16791,1 16808,0 16827,1 16837,0 16935,1 17007,0 17077,1 17117,0 17204,1 17286,0 17372,1 17439,0 17486,1 17506,0 17573,1 17595,0 17668,1 17724,0 17788,1 17847,0 17885,1 17917,0 18000,1 18055,0 18112,1 18198,0 18258,1 18301,0 18341,1 18361,0 18387,1 18483,0 18494,1 18537,0 18578,1 18650,0 18675,1 18688,0 18754,1 18853,0 18890,1 18975,0 18988,1 19054,0 19078,1 19138,0 19168,1 19187,0 19268,1 19322,0 19358,1 19444,0 19538,1 19562,0 19608,1 19702,0 19720,1 19788,0 19849,1 19903,0 19908,1 19966,0 20045,1 20093,0 20141,1 20175,0 20259,1 20348,0 20377,1 20410,0 20449,1 20542,0 20559,1 20617,0 20630,1 20712,0 20805,1 20828,0 20928,1 21003,0 21035,1 21105,0 21132,1 21164,0 21199,1 21284,0 21366,1 21396,0 21404,1 21444,0 21531,1 21583,0 21625,1 21699,0 21769,1 21867,0 21960,1 22060,0 22159,1 22189,0 22208,1 22235,0 22320,1 22386,0 22478,1 22576,0 22626,1 22682,0 22744,1 22834,0 22897,1 22900,0 22977,1 23058,0 23141,1 23235,0 23277,1 23303,0 23388,1 23478,0 23533,1 23629,0 23692,1 23780,0 23812,1 23845,0 23908,1 23921,0 24013,1 24024,0 24044,1 24052,0 24070,1 24092,0 24103,1 24177,0 24230,1 24241,0 24250,1 24277,0 24316,1 24380,0 24397,1 24419,0 24473,1 24565,0 24646,1 24692,0 24769,1 24826,0 24922,1 25018,0 25047,1 25048,0 25083,1 25181,0 25219,1 25253,0 25268,1 25314,0 25369,1 25420,0 25433,1 25498,0 25597,1 25668,0 25751,1 25827,0 25896,1 25969,0 25985,1 26058,0 26147,1 26180,0 26207,1 26246,0 26258,1 26335,0 26359,1 26413,0 26415,1 26473,0 26500,1 26600,0 26626,1 26708,0 26765,1 26845,0 26870,1 26884,0 26920,1 26991,0 26999,1 27043,0 27118,1 27128,0 27169,1 27185,0 27267,1 27287,0 27371,1 27440,0 27494,1 27520,0 27589,1 27621,0 27668,1 27723,0 27772,1 27778,0 27872,1 27932,0 27968,1 28017,0 28037,1 28090,0 28128,1 28158,0 28160,1 28218,0 28293,1 28362,0 28412,1 28486,0 28558,1 28562,0 28576,1 28649,0 28702,1 28784,0 28817,1 28832,0 28842,1 28906,0 28933,1 28942,0 29035,1 29066,0 29147,1 29200,0 29203,1 29222,0 29244,1 29253,0 29351,1 29370,0 29374,1 29448,0 29481,1 29533,0 29580,1 29585,0 29645,1 29679,0 29689,1 29742,0 29773,1 29819,0 29883,1 29899,0 29901,1 29946,0 29999,1 30001,0 30064,1 30118,0 30148,1 30191,0 30263,1 30284,0 30309,1 30323,0 30378,1 30471,0 30491,1 30551,0 30648,1 30696,0 30788,1 30840,0 30851,1 30886,0 30964,1 31015,0 31023,1 31100,0 31127,1 31184,0 31213,1 31231,0 31320,1 31374,0 31394,1 31418,0 31475,1 31478,0 31577,1 31628,0 31687,1 31771,0 31849,1 31880,0 31910,1 31921,0 32009,1 32066,0 32078,1 32106,0 32107,1 32186,0 32258,1 32301,0 32383,1 32444,0 32518,1 32566,0 32601,1 32659,0 32700,1 32749,0 32805,1 32815,0 32841,1 32877,0 32885,1 32933,0 33029,1 33109,0 33202,1 33247,0 33271,1 33291,0 33378,1 33413,0 33469,1 33500,0 33553,1 33648,0 33694,1 33711,0 33769,1 33863,0 33903,1 33910,0 33917,1 33954,0 33969,1 33996,0 34060,1 34157,0 34164,1 34264,0 34322,1 34394,0 34399,1 34435,0 34458,1 34511,0 34562,1 34623,0 34638,1 34647,0 34661,1 34761,0 34814,1 34914,0 34960,1 35032,0 35127,1 35128,0 35226,1 35308,0 35402,1 35444,0 35467,1 35506,0 35576,1 35649,0 35706,1 35711,0 35716,1 35723,0 35755,1 35763,0 35804,1 35808,0 35822,1 35823,0 35887,1 35935,0 35984,1 36067,0 36115,1 36185,0 36237,1 36269,0 36324,1 36342,0 36431,1 36512,0 36601,1 36619,0 36670,1 36748,0 36808,1 36868,0 36919,1 36953,0 36967,1 37039,0 37079,1 37164,0 37200,1 37242,0 37261,1 37316,0 37416,1 37487,0 37536,1 37549,0 37581,1 37592,0 37637,1 37641,0 37651,1 37673,0 37681,1 37684,0 37751,1 37824,0 37832,1 37884,0 37916,1 37945,0 38026,1 38069,0 38133,1 38183,0 38200,1 38250,0 38347,1 38422,0 38483,1 38493,0 38527,1 38531,0 38592,1 38663,0 38698,1 38776,0 38873,1 38882,0 38979,1 39035,0 39062,1 39083,0 39095,1 39116,0 39120,1 39192,0 39206,1 39214,0 39243,1 39315,0 39357,1 39399,0 39499,1 39569,0 39611,1 39669,0 39745,1 39756,0 39781,1 39792,0 39872,1 39879,0 39885,1 39951,0 39999,1 40059,0 40158,1 40228,0 40234,1 40246,0 40287,1 40321,0 40399,1 40464,0 40481,1 40486,0 40561,1 40644,0 40694,1 40709,0 40789,1 40816,0 40831,1 40846,0 40862,1 40869,0 40887,1 40985,0 41030,1 41125,0 41224,1 41234,0 41324,1 41409,0 41487,1 41540,0 41565,1 41583,0 41610,1 41613,0 41708,1 41723,0 41823,1 41921,0 41989,1 41997,0 42043,1 42143,0 42164,1 42219,0 42229,1 42251,0 42319,1 42371,0 42469,1 42544,0 42597,1 42640,0 42651,1 42731,0 42774,1 42844,0 42879,1 42890,0 42909,1 42934,0 43017,1 43064,0 43115,1 43125,0 43133,1 43159,0 43207,1 43295,0 43379,1 43479,0 43480,1 43514,0 43590,1 43650,0 43662,1 43754,0 43849,1 43867,0 43962,1 44013,0 44020,1 44109,0 44190,1 44229,0 44249,1 44334,0 44349,1 44369,0 44377,1 44417,0 44421,1 44440,0 44534,1 44570,0 44591,1 44641,0 44665,1 44705,0 44745,1 44774,0 44778,1 44844,0 44938,1 44965,0 45049,1 45131,0 45225,1 45283,0 45314,1 45372,0 45411,1 45457,0 45521,1 45537,0 45545,1 45571,0 45627,1 45676,0 45688,1 45693,0 45755,1 45839,0 45920,1 45930,0 46004,1 46104,0 46194,1 46233,0 46270,1 46342,0 46401,1 46439,0 46504,1 46592,0 46599,1 46626,0 46716,1 46773,0 46809,1 46900,0 46952,1 46969,0 47050,1 47056,0 47145,1 47163,0 47249,1 47303,0 47362,1 47444,0 47499,1 47525,0 47567,1 47595,0 47657,1 47727,0 47790,1 47827,0 47873,1 47967,0 48017,1 48038,0 48092,1 48138,0 48215,1 48314,0 48321,1 48324,0 48368,1 48373,0 48459,1 48530,0 48600,1 48624,0 48724,1 48734,0 48832,1 48884,0 48952,1 48968,0 49032,1 49039,0 49082,1 49095,0 49193,1 end initlist a5 0,0 97,1 125,0 211,1 288,0 304,1 403,0 448,1 456,0 475,1 554,0 602,1 622,0 692,1 777,0 860,1 864,0 899,1 968,0 991,1 1047,0 1083,1 1088,0 1162,1 1221,0 1235,1 1331,0 1340,1 1380,0 1409,1 1465,0 1486,1 1497,0 1548,1 1641,0 1728,1 1782,0 1873,1 1891,0 1917,1 1992,0 2058,1 2122,0 2127,1 2169,0 2250,1 2252,0 2268,1 2340,0 2432,1 2516,0 2600,1 2615,0 2715,1 2757,0 2779,1 2842,0 2919,1 2945,0 3031,1 3115,0 3138,1 3234,0 3288,1 3371,0 3465,1 3565,0 3634,1 3635,0 3655,1 3727,0 3750,1 3801,0 3883,1 3961,0 4014,1 4112,0 4137,1 4233,0 4314,1 4325,0 4359,1 4412,0 4512,1 4587,0 4640,1 4677,0 4706,1 4750,0 4816,1 4901,0 4930,1 5025,0 5082,1 5109,0 5199,1 5256,0 5289,1 5372,0 5439,1 5539,0 5598,1 5630,0 5657,1 5722,0 5745,1 5773,0 5840,1 5866,0 5939,1 5948,0 5977,1 5991,0 6079,1 6148,0 6239,1 6299,0 6311,1 6327,0 6415,1 6431,0 6469,1 6548,0 6572,1 6667,0 6693,1 6744,0 6784,1 6883,0 6928,1 6987,0 7017,1 7023,0 7083,1 7156,0 7193,1 7204,0 7234,1 7278,0 7316,1 7387,0 7468,1 7549,0 7630,1 7706,0 7751,1 7837,0 7871,1 7958,0 8053,1 8104,0 8170,1 8226,0 8322,1 8335,0 8391,1 8421,0 8453,1 8535,0 8635,1 8644,0 8650,1 8744,0 8774,1 8781,0 8811,1 8844,0 8909,1 8966,0 8995,1 9094,0 9110,1 9142,0 9202,1 9262,0 9308,1 9407,0 9434,1 9453,0 9481,1 9522,0 9562,1 9658,0 9734,1 9745,0 9749,1 9823,0 9918,1 9936,0 10001,1 10058,0 10106,1 10202,0 10220,1 10301,0 10387,1 10463,0 10480,1 10556,0 10561,1 10655,0 10719,1 10734,0 10783,1 10853,0 10931,1 11016,0 11116,1 11215,0 11309,1 11389,0 11463,1 11539,0 11592,1 11632,0 11674,1 11725,0 11767,1 11793,0 11813,1 11896,0 11927,1 11974,0 11997,1 12072,0 12170,1 12180,0 12199,1 12282,0 12322,1 12336,0 12426,1 12490,0 12586,1 12593,0 12687,1 12719,0 12753,1 12831,0 12922,1 12983,0 13009,1 13037,0 13065,1 13162,0 13212,1 13266,0 13344,1 13378,0 13436,1 13501,0 13522,1 13556,0 13646,1 13650,0 13706,1 13745,0 13819,1 13869,0 13884,1 13890,0 13936,1 13964,0 13983,1 14007,0 14022,1 14036,0 14071,1 14112,0 14171,1 14184,0 14282,1 14368,0 14410,1 14462,0 14543,1 14603,0 14633,1 14692,0 14746,1 14778,0 14843,1 14929,0 14971,1 14992,0 15025,1 15125,0 15209,1 15257,0 15294,1 15298,0 15326,1 15420,0 15445,1 15494,0 15564,1 15659,0 15689,1 15753,0 15808,1 15903,0 15995,1 16090,0 16107,1 16191,0 16288,1 16350,0 16353,1 16414,0 16461,1 16535,0 16626,1 16685,0 16708,1 16717,0 16817,1 16863,0 16928,1 16946,0 16954,1 17039,0 17135,1 17231,0 17321,1 17350,0 17384,1 17422,0 17506,1 17543,0 17615,1 17642,0 17664,1 17698,0 17782,1 17792,0 17795,1 17855,0 17869,1 17900,0 17921,1 17961,0 17967,1 18067,0 18096,1 18160,0 18241,1 18261,0 18314,1 18365,0 18406,1 18430,0 18472,1 18514,0 18608,1 18634,0 18689,1 18736,0 18830,1 18863,0 18902,1 18916,0 18983,1 18985,0 19025,1 19050,0 19119,1 19211,0 19248,1 19307,0 19401,1 19427,0 19481,1 19552,0 19611,1 19689,0 19719,1 19748,0 19847,1 19921,0 19957,1 20009,0 20106,1 20195,0 20295,1 20368,0 20398,1 20446,0 20498,1 20550,0 20637,1 20723,0 20807,1 20898,0 20930,1 21025,0 21122,1 21127,0 21198,1 21259,0 21309,1 21395,0 21453,1 21551,0 21639,1 21713,0 21743,1 21823,0 21875,1 21898,0 21918,1 21919,0 21965,1 22026,0 22058,1 22157,0 22239,1 22297,0 22334,1 22360,0 22436,1 22529,0 22557,1 22624,0 22702,1 22712,0 22747,1 22776,0 22864,1 22905,0 22987,1 23055,0 23131,1 23219,0 23295,1 23360,0 23364,1 23370,0 23407,1 23491,0 23551,1 23619,0 23656,1 23740,0 23742,1 23790,0 23886,1 23899,0 23990,1 24045,0 24108,1 24119,0 24207,1 24236,0 24279,1 24345,0 24419,1 24426,0 24503,1 24542,0 24573,1 24629,0 24689,1 24711,0 24765,1 24791,0 24809,1 24854,0 24901,1 24977,0 25019,1 25085,0 25094,1 25157,0 25160,1 25204,0 25250,1 25338,0 25361,1 25368,0 25415,1 25476,0 25494,1 25588,0 25636,1 25696,0 25704,1 25758,0 25775,1 25777,0 25819,1 25831,0 25892,1 25959,0 25974,1 25999,0 26059,1 26150,0 26248,1 26338,0 26390,1 26436,0 26529,1 26618,0 26676,1 26687,0 26721,1 26804,0 26830,1 26885,0 26949,1 27016,0 27060,1 27102,0 27119,1 27196,0 27252,1 27302,0 27311,1 27357,0 27448,1 27480,0 27551,1 27651,0 27669,1 27760,0 27765,1 27840,0 27940,1 27960,0 28000,1 28064,0 28069,1 28112,0 28122,1 28134,0 28195,1 28207,0 28264,1 28305,0 28318,1 28321,0 28394,1 28462,0 28549,1 28646,0 28732,1 28761,0 28797,1 28805,0 28863,1 28886,0 28951,1 29013,0 29106,1 29191,0 29195,1 29255,0 29274,1 29364,0 29381,1 29435,0 29465,1 29491,0 29553,1 29619,0 29667,1 29745,0 29838,1 29897,0 29949,1 29969,0 29973,1 30051,0 30145,1 30149,0 30235,1 30309,0 30382,1 30433,0 30450,1 30515,0 30538,1 30594,0 30595,1 30624,0 30715,1 30729,0 30774,1 30778,0 30862,1 30863,0 30929,1 31020,0 31022,1 31078,0 31085,1 31088,0 31093,1 31130,0 31171,1 31264,0 31303,1 31309,0 31370,1 31403,0 31500,1 31501,0 31530,1 31557,0 31575,1 31605,0 31668,1 31679,0 31703,1 31787,0 31846,1 31916,0 31941,1 32025,0 32043,1 32092,0 32130,1 32184,0 32191,1 32283,0 32382,1 32467,0 32534,1 32575,0 32592,1 32640,0 32681,1 32747,0 32806,1 32874,0 32906,1 32980,0 32992,1 33071,0 33169,1 33191,0 33213,1 33219,0 33220,1 33244,0 33282,1 33284,0 33344,1 33431,0 33508,1 33514,0 33596,1 33676,0 33720,1 33811,0 33873,1 33944,0 34013,1 34081,0 34138,1 34227,0 34316,1 34327,0 34402,1 34469,0 34567,1 34622,0 34631,1 34728,0 34747,1 34754,0 34837,1 34924,0 35007,1 35023,0 35113,1 35175,0 35247,1 35346,0 35395,1 35483,0 35555,1 35561,0 35632,1 35645,0 35709,1 35747,0 35832,1 35876,0 35926,1 35990,0 35991,1 36080,0 36095,1 36169,0 36184,1 36229,0 36235,1 36299,0 36370,1 36434,0 36467,1 36561,0 36587,1 36596,0 36627,1 36692,0 36790,1 36837,0 36876,1 36880,0 36890,1 36956,0 36961,1 36974,0 37074,1 37113,0 37180,1 37249,0 37253,1 37312,0 37381,1 37436,0 37498,1 37540,0 37576,1 37655,0 37684,1 37688,0 37745,1 37755,0 37811,1 37882,0 37922,1 38003,0 38068,1 38142,0 38166,1 38233,0 38247,1 38252,0 38263,1 38349,0 38442,1 38503,0 38554,1 38641,0 38665,1 38741,0 38752,1 38835,0 38910,1 38998,0 39041,1 39113,0 39173,1 39200,0 39286,1 39369,0 39396,1 39493,0 39506,1 39575,0 39605,1 39659,0 39700,1 39770,0 39786,1 39845,0 39893,1 39900,0 39969,1 39982,0 40055,1 40114,0 40200,1 40254,0 40341,1 40367,0 40381,1 40469,0 40521,1 40570,0 40574,1 40672,0 40769,1 40835,0 40837,1 40869,0 40943,1 40949,0 41031,1 41111,0 41128,1 41149,0 41225,1 41306,0 41339,1 41385,0 41430,1 41488,0 41560,1 41650,0 41746,1 41835,0 41880,1 41923,0 42017,1 42061,0 42142,1 42159,0 42246,1 42270,0 42291,1 42360,0 42442,1 42525,0 42595,1 42673,0 42758,1 42824,0 42881,1 42948,0 43021,1 43096,0 43192,1 43254,0 43333,1 43425,0 43429,1 43474,0 43556,1 43626,0 43644,1 43739,0 43829,1 43916,0 43933,1 43961,0 44028,1 44089,0 44093,1 44158,0 44208,1 44216,0 44254,1 44264,0 44355,1 44435,0 44484,1 44541,0 44568,1 44576,0 44626,1 44668,0 44689,1 44783,0 44876,1 44898,0 44941,1 44958,0 45026,1 45038,0 45065,1 45079,0 45156,1 45173,0 45187,1 45237,0 45283,1 45380,0 45424,1 45479,0 45493,1 45561,0 45660,1 45719,0 45809,1 45862,0 45881,1 45918,0 46008,1 46089,0 46154,1 46170,0 46192,1 46202,0 46241,1 46303,0 46310,1 46362,0 46447,1 46492,0 46497,1 46595,0 46687,1 46699,0 46737,1 46767,0 46776,1 46832,0 46895,1 46944,0 46978,1 47007,0 47057,1 47128,0 47164,1 47227,0 47269,1 47274,0 47326,1 47402,0 47470,1 47493,0 47570,1 47647,0 47677,1 47698,0 47765,1 47778,0 47846,1 47855,0 47935,1 48007,0 48061,1 48121,0 48164,1 48252,0 48323,1 48340,0 48378,1 48397,0 48449,1 48531,0 48542,1 48589,0 48593,1 48650,0 48683,1 48749,0 48769,1 48806,0 48873,1 48972,0 48977,1 48992,0 49068,1 49095,0 49141,1 49189,0 49228,1 49307,0 49315,1 49334,0 49405,1 49505,0 49603,1 49696,0 49772,1 49821,0 49843,1 49878,0 49920,1 50019,0 50047,1 50124,0 50187,1 50262,0 50270,1 50300,0 50321,1 50352,0 50372,1 50455,0 50460,1 50551,0 50583,1 50649,0 50676,1 50775,0 50786,1 50860,0 50877,1 50923,0 51001,1 51039,0 51071,1 51081,0 51093,1 51150,0 51234,1 51310,0 51363,1 51406,0 51438,1 51487,0 51580,1 51620,0 51657,1 51669,0 51761,1 end initlist a6 0,0 26,1 50,0 59,1 154,0 213,1 266,0 338,1 379,0 449,1 485,0 535,1 629,0 677,1 749,0 767,1 826,0 905,1 909,0 1003,1 1099,0 1153,1 1224,0 1315,1 1320,0 1379,1 1464,0 1547,1 1639,0 1684,1 1728,0 1777,1 1834,0 1851,1 1867,0 1937,1 1999,0 2048,1 2138,0 2178,1 2229,0 2303,1 2361,0 2373,1 2440,0 2522,1 2541,0 2575,1 2591,0 2645,1 2713,0 2768,1 2841,0 2926,1 2972,0 3013,1 3112,0 3207,1 3288,0 3363,1 3404,0 3445,1 3511,0 3521,1 3544,0 3594,1 3621,0 3677,1 3766,0 3775,1 3834,0 3896,1 3969,0 4007,1 4093,0 4117,1 4206,0 4224,1 4232,0 4332,1 4377,0 4447,1 4453,0 4519,1 4596,0 4657,1 4733,0 4795,1 4857,0 4862,1 4911,0 4991,1 5052,0 5104,1 5120,0 5150,1 5241,0 5308,1 5372,0 5466,1 5471,0 5509,1 5599,0 5657,1 5754,0 5795,1 5846,0 5932,1 5946,0 5982,1 6051,0 6124,1 6191,0 6235,1 6331,0 6336,1 6433,0 6435,1 6441,0 6487,1 6583,0 6601,1 6644,0 6735,1 6816,0 6857,1 6957,0 6971,1 7051,0 7123,1 7216,0 7239,1 7326,0 7394,1 7447,0 7484,1 7547,0 7640,1 7643,0 7735,1 7828,0 7862,1 7962,0 8020,1 8034,0 8106,1 8194,0 8229,1 8247,0 8322,1 8368,0 8369,1 8428,0 8515,1 8546,0 8556,1 8606,0 8683,1 8719,0 8751,1 8825,0 8897,1 8924,0 9012,1 9083,0 9103,1 9172,0 9195,1 9258,0 9352,1 9362,0 9455,1 9464,0 9503,1 9533,0 9592,1 9654,0 9668,1 9689,0 9763,1 9781,0 9811,1 9835,0 9848,1 9852,0 9868,1 9892,0 9952,1 9966,0 10019,1 10094,0 10186,1 10236,0 10298,1 10375,0 10421,1 10461,0 10539,1 10582,0 10609,1 10636,0 10721,1 10750,0 10781,1 10789,0 10791,1 10801,0 10843,1 10896,0 10936,1 10951,0 10953,1 11008,0 11088,1 11089,0 11177,1 11199,0 11209,1 11308,0 11317,1 11318,0 11335,1 11407,0 11456,1 11470,0 11568,1 11577,0 11616,1 11651,0 11682,1 11733,0 11749,1 11786,0 11847,1 11850,0 11857,1 11918,0 11938,1 12021,0 12077,1 12141,0 12229,1 12241,0 12299,1 12318,0 12381,1 12445,0 12456,1 12497,0 12594,1 12675,0 12715,1 12793,0 12841,1 12907,0 12910,1 12923,0 13022,1 13088,0 13166,1 13211,0 13242,1 13303,0 13335,1 13360,0 13428,1 13456,0 13476,1 13490,0 13527,1 13606,0 13661,1 13737,0 13814,1 13902,0 13981,1 14047,0 14108,1 14173,0 14256,1 14293,0 14368,1 14375,0 14400,1 14414,0 14462,1 14474,0 14490,1 14554,0 14592,1 14686,0 14782,1 14797,0 14819,1 14823,0 14920,1 14925,0 14983,1 15022,0 15056,1 15135,0 15215,1 15312,0 15405,1 15478,0 15518,1 15524,0 15548,1 15572,0 15672,1 15722,0 15788,1 15881,0 15917,1 15967,0 16014,1 16017,0 16098,1 16112,0 16140,1 16193,0 16270,1 16304,0 16315,1 16356,0 16440,1 16510,0 16583,1 16663,0 16706,1 16779,0 16804,1 16820,0 16889,1 16894,0 16902,1 16952,0 16966,1 17021,0 17063,1 17142,0 17240,1 17268,0 17279,1 17352,0 17361,1 17394,0 17427,1 17439,0 17457,1 17470,0 17567,1 17617,0 17691,1 17707,0 17762,1 17844,0 17886,1 17951,0 17962,1 18048,0 18142,1 18198,0 18252,1 18291,0 18353,1 18379,0 18462,1 18518,0 18559,1 18583,0 18608,1 18632,0 18639,1 18674,0 18771,1 18819,0 18895,1 18989,0 19017,1 19094,0 19135,1 19215,0 19236,1 19334,0 19376,1 19399,0 19419,1 19465,0 19466,1 19556,0 19607,1 19625,0 19664,1 19716,0 19729,1 19760,0 19836,1 19888,0 19890,1 19925,0 19957,1 20010,0 20016,1 20021,0 20112,1 20145,0 20195,1 20224,0 20244,1 20290,0 20371,1 20397,0 20449,1 20509,0 20510,1 20528,0 20609,1 20660,0 20725,1 20732,0 20771,1 20852,0 20866,1 20948,0 20962,1 21009,0 21012,1 21087,0 21131,1 21162,0 21231,1 21240,0 21280,1 21309,0 21350,1 21368,0 21371,1 21377,0 21452,1 21510,0 21547,1 21631,0 21704,1 21756,0 21784,1 21805,0 21885,1 21968,0 22019,1 22064,0 22102,1 22200,0 22222,1 22284,0 22327,1 22362,0 22369,1 22467,0 22553,1 22645,0 22687,1 22776,0 22814,1 22871,0 22969,1 23030,0 23063,1 23064,0 23067,1 23158,0 23219,1 23225,0 23304,1 23396,0 23453,1 23462,0 23559,1 23618,0 23637,1 23650,0 23690,1 23722,0 23788,1 23809,0 23898,1 23976,0 24011,1 24065,0 24121,1 24125,0 24191,1 24291,0 24350,1 24377,0 24471,1 24506,0 24571,1 24662,0 24707,1 24794,0 24861,1 24867,0 24877,1 24901,0 24965,1 25061,0 25104,1 25169,0 25221,1 25319,0 25373,1 25412,0 25463,1 25480,0 25533,1 25575,0 25623,1 25646,0 25668,1 25756,0 25800,1 25853,0 25898,1 25975,0 26011,1 26057,0 26106,1 26204,0 26236,1 26327,0 26381,1 26429,0 26466,1 26481,0 26513,1 26520,0 26541,1 26553,0 26638,1 26709,0 26792,1 26846,0 26935,1 27016,0 27108,1 27201,0 27248,1 27254,0 27304,1 27360,0 27407,1 27441,0 27482,1 27568,0 27575,1 27622,0 27662,1 27717,0 27810,1 27863,0 27910,1 28000,0 28092,1 28183,0 28256,1 28342,0 28404,1 28410,0 28504,1 28547,0 28574,1 28664,0 28721,1 28818,0 28886,1 28892,0 28982,1 28990,0 29013,1 29041,0 29106,1 29122,0 29211,1 29223,0 29270,1 29314,0 29393,1 29459,0 29479,1 29579,0 29634,1 29655,0 29748,1 29845,0 29872,1 29934,0 29966,1 30052,0 30105,1 30162,0 30243,1 30319,0 30359,1 30401,0 30410,1 30476,0 30561,1 30652,0 30654,1 30692,0 30719,1 30730,0 30772,1 30781,0 30857,1 30905,0 30988,1 31007,0 31024,1 31062,0 31149,1 31228,0 31246,1 31276,0 31354,1 31394,0 31429,1 31518,0 31571,1 31647,0 31724,1 31781,0 31826,1 31847,0 31869,1 31879,0 31956,1 32046,0 32118,1 32187,0 32237,1 32263,0 32296,1 32335,0 32411,1 32429,0 32479,1 32540,0 32621,1 32718,0 32791,1 32812,0 32893,1 32975,0 33024,1 33036,0 33131,1 33143,0 33153,1 33184,0 33266,1 33304,0 33317,1 33370,0 33413,1 33465,0 33557,1 33614,0 33672,1 33732,0 33759,1 33845,0 33902,1 33931,0 34000,1 34093,0 34140,1 34205,0 34234,1 34303,0 34325,1 34335,0 34422,1 34498,0 34561,1 34570,0 34649,1 34686,0 34767,1 34801,0 34866,1 34949,0 35029,1 35123,0 35167,1 35252,0 35291,1 35382,0 35422,1 35436,0 35441,1 35449,0 35467,1 35494,0 35500,1 35520,0 35577,1 35621,0 35695,1 35697,0 35702,1 35779,0 35858,1 35924,0 35974,1 36066,0 36154,1 36170,0 36171,1 36219,0 36268,1 36279,0 36349,1 36417,0 36506,1 36579,0 36606,1 36642,0 36669,1 36762,0 36840,1 36910,0 36945,1 36981,0 37007,1 37071,0 37161,1 37168,0 37178,1 37254,0 37295,1 37353,0 37403,1 37405,0 37498,1 37597,0 37606,1 37671,0 37683,1 37727,0 37743,1 37776,0 37795,1 37817,0 37895,1 37989,0 38066,1 38126,0 38213,1 38252,0 38294,1 38370,0 38410,1 38440,0 38536,1 38583,0 38648,1 38723,0 38729,1 38737,0 38796,1 38870,0 38903,1 38915,0 38974,1 39050,0 39119,1 39211,0 39241,1 39288,0 39360,1 39433,0 39527,1 39622,0 39646,1 39738,0 39740,1 39839,0 39871,1 39966,0 40044,1 40133,0 40219,1 40268,0 40359,1 40448,0 40478,1 40519,0 40562,1 40636,0 40657,1 40691,0 40714,1 40763,0 40811,1 40832,0 40928,1 41010,0 41014,1 41039,0 41042,1 41093,0 41097,1 41149,0 41242,1 41312,0 41328,1 41332,0 41395,1 41449,0 41500,1 41555,0 41623,1 41638,0 41669,1 41759,0 41839,1 41903,0 41999,1 42093,0 42193,1 42214,0 42300,1 42336,0 42351,1 42379,0 42398,1 42472,0 42546,1 42616,0 42637,1 42725,0 42742,1 42770,0 42805,1 42866,0 42946,1 42973,0 43013,1 43104,0 43196,1 43263,0 43326,1 43405,0 43498,1 43555,0 43598,1 43610,0 43611,1 43650,0 43652,1 43667,0 43747,1 43790,0 43820,1 43878,0 43975,1 44051,0 44064,1 44068,0 44114,1 44121,0 44174,1 44198,0 44261,1 44353,0 44360,1 44416,0 44435,1 44463,0 44478,1 44539,0 44556,1 44586,0 44643,1 44733,0 44764,1 44861,0 44948,1 45039,0 45041,1 45121,0 45206,1 45288,0 45379,1 45404,0 45498,1 45551,0 45609,1 45704,0 45740,1 45763,0 45790,1 45796,0 45817,1 45859,0 45873,1 45904,0 45985,1 46016,0 46076,1 46143,0 46222,1 46239,0 46327,1 46400,0 46435,1 46485,0 46529,1 46530,0 46575,1 46650,0 46749,1 46799,0 46899,1 46953,0 47044,1 47071,0 47122,1 47129,0 47180,1 47217,0 47231,1 47250,0 47276,1 47366,0 47430,1 47478,0 47511,1 47562,0 47636,1 47703,0 47795,1 47863,0 47911,1 48008,0 48097,1 48164,0 48243,1 48254,0 48308,1 48321,0 48337,1 48391,0 48428,1 48528,0 48589,1 48656,0 48721,1 48781,0 48839,1 48859,0 48910,1 48920,0 49009,1 49075,0 49083,1 49116,0 49184,1 49239,0 49296,1 49309,0 49380,1 49390,0 49487,1 49549,0 49576,1 49589,0 49591,1 49618,0 49659,1 49663,0 49730,1 49793,0 49832,1 49853,0 49914,1 49979,0 50073,1 50173,0 50199,1 50288,0 50387,1 50391,0 50458,1 50551,0 50634,1 50642,0 50708,1 50747,0 50792,1 end initlist a7 0,0 10,1 18,0 27,1 97,0 120,1 191,0 211,1 256,0 270,1 312,0 376,1 418,0 439,1 481,0 502,1 587,0 664,1 697,0 721,1 755,0 786,1 795,0 797,1 859,0 895,1 977,0 1011,1 1089,0 1144,1 1176,0 1269,1 1272,0 1368,1 1448,0 1468,1 1475,0 1541,1 1585,0 1658,1 1696,0 1737,1 1783,0 1821,1 1917,0 1956,1 1967,0 2037,1 2118,0 2160,1 2209,0 2288,1 2327,0 2385,1 2475,0 2572,1 2579,0 2594,1 2639,0 2714,1 2779,0 2818,1 2898,0 2957,1 3035,0 3091,1 3147,0 3164,1 3175,0 3239,1 3306,0 3388,1 3444,0 3456,1 3500,0 3565,1 3610,0 3640,1 3673,0 3696,1 3793,0 3796,1 3812,0 3897,1 3950,0 3964,1 4057,0 4099,1 4157,0 4253,1 4340,0 4390,1 4401,0 4501,1 4585,0 4624,1 4676,0 4763,1 4862,0 4909,1 4948,0 5036,1 5038,0 5135,1 5157,0 5253,1 5327,0 5344,1 5368,0 5389,1 5402,0 5457,1 5525,0 5598,1 5620,0 5624,1 5693,0 5732,1 5764,0 5813,1 5815,0 5825,1 5918,0 5921,1 6014,0 6035,1 6101,0 6185,1 6214,0 6273,1 6344,0 6401,1 6439,0 6468,1 6536,0 6597,1 6604,0 6618,1 6701,0 6784,1 6807,0 6839,1 6877,0 6969,1 7048,0 7125,1 7191,0 7208,1 7267,0 7327,1 7353,0 7378,1 7476,0 7545,1 7640,0 7734,1 7782,0 7879,1 7967,0 8040,1 8044,0 8051,1 8079,0 8090,1 8184,0 8279,1 8284,0 8296,1 8359,0 8397,1 8465,0 8481,1 8571,0 8642,1 8736,0 8738,1 8823,0 8882,1 8966,0 9015,1 9115,0 9133,1 9195,0 9225,1 9325,0 9382,1 9412,0 9430,1 9524,0 9575,1 9617,0 9646,1 9731,0 9772,1 9817,0 9854,1 9858,0 9938,1 10019,0 10043,1 10116,0 10126,1 10135,0 10182,1 10212,0 10216,1 10310,0 10353,1 10452,0 10468,1 10497,0 10556,1 10613,0 10616,1 10644,0 10659,1 10752,0 10755,1 10758,0 10766,1 10832,0 10918,1 11009,0 11026,1 11035,0 11066,1 11079,0 11145,1 11179,0 11253,1 11278,0 11324,1 11379,0 11436,1 11473,0 11556,1 11598,0 11676,1 11759,0 11782,1 11879,0 11923,1 11975,0 12013,1 12089,0 12124,1 12212,0 12290,1 12319,0 12362,1 12388,0 12444,1 12461,0 12543,1 12638,0 12708,1 12721,0 12736,1 12805,0 12815,1 12817,0 12859,1 12861,0 12943,1 13026,0 13060,1 13158,0 13228,1 13279,0 13310,1 13369,0 13378,1 13391,0 13409,1 13448,0 13526,1 13548,0 13612,1 13646,0 13728,1 13823,0 13880,1 13946,0 13964,1 14011,0 14041,1 14131,0 14132,1 14232,0 14312,1 14409,0 14435,1 14476,0 14513,1 14520,0 14589,1 14656,0 14711,1 14758,0 14804,1 14887,0 14924,1 14992,0 15043,1 15086,0 15169,1 15215,0 15259,1 15290,0 15294,1 15372,0 15469,1 15537,0 15546,1 15603,0 15636,1 15721,0 15737,1 15799,0 15845,1 15896,0 15957,1 16016,0 16034,1 16035,0 16121,1 16132,0 16229,1 16275,0 16336,1 16379,0 16428,1 16461,0 16516,1 16533,0 16589,1 16619,0 16701,1 16785,0 16803,1 16818,0 16902,1 16922,0 16935,1 16941,0 16991,1 17018,0 17050,1 17051,0 17077,1 17143,0 17226,1 17271,0 17285,1 17289,0 17314,1 17332,0 17339,1 17361,0 17380,1 17417,0 17479,1 17551,0 17576,1 17648,0 17656,1 17718,0 17787,1 17859,0 17944,1 17956,0 18006,1 18078,0 18131,1 18184,0 18254,1 18279,0 18305,1 18396,0 18454,1 18531,0 18554,1 18590,0 18682,1 18697,0 18712,1 18714,0 18769,1 18792,0 18805,1 18900,0 18915,1 18919,0 18950,1 19018,0 19101,1 19151,0 19206,1 19219,0 19236,1 19240,0 19306,1 19385,0 19460,1 19505,0 19580,1 19632,0 19687,1 19701,0 19750,1 19807,0 19880,1 19881,0 19912,1 19965,0 20052,1 20070,0 20099,1 20153,0 20248,1 20273,0 20299,1 20356,0 20396,1 20476,0 20543,1 20614,0 20674,1 20716,0 20724,1 20733,0 20784,1 20884,0 20957,1 21021,0 21060,1 21157,0 21252,1 21347,0 21369,1 21400,0 21480,1 21576,0 21656,1 21683,0 21771,1 21865,0 21953,1 21991,0 22087,1 22120,0 22187,1 22217,0 22304,1 22393,0 22415,1 22422,0 22521,1 22591,0 22613,1 22696,0 22735,1 22752,0 22805,1 22858,0 22914,1 22990,0 23084,1 23118,0 23214,1 23280,0 23356,1 23401,0 23467,1 23495,0 23523,1 23573,0 23593,1 23628,0 23698,1 23699,0 23797,1 23895,0 23966,1 24000,0 24088,1 24102,0 24156,1 24188,0 24268,1 24362,0 24439,1 24490,0 24512,1 24514,0 24555,1 24637,0 24713,1 24763,0 24764,1 24796,0 24810,1 24902,0 24988,1 25044,0 25137,1 25211,0 25254,1 25310,0 25384,1 25433,0 25475,1 25505,0 25549,1 25586,0 25651,1 25700,0 25778,1 25825,0 25852,1 25869,0 25875,1 25959,0 25993,1 26027,0 26103,1 26112,0 26150,1 26152,0 26229,1 26324,0 26421,1 26445,0 26505,1 26570,0 26622,1 26676,0 26768,1 26782,0 26809,1 26886,0 26956,1 27009,0 27024,1 27029,0 27055,1 27139,0 27166,1 27177,0 27181,1 27230,0 27289,1 27301,0 27325,1 27334,0 27398,1 27450,0 27490,1 27522,0 27566,1 27594,0 27636,1 27685,0 27760,1 27851,0 27936,1 28032,0 28042,1 28105,0 28169,1 28191,0 28278,1 28305,0 28325,1 28361,0 28454,1 28520,0 28619,1 28687,0 28757,1 28770,0 28800,1 28840,0 28908,1 28943,0 29021,1 29093,0 29100,1 29158,0 29203,1 29290,0 29357,1 29406,0 29416,1 29495,0 29524,1 29527,0 29589,1 29639,0 29723,1 29750,0 29803,1 29808,0 29851,1 29897,0 29960,1 30016,0 30065,1 30086,0 30118,1 30156,0 30181,1 30204,0 30284,1 30309,0 30350,1 30365,0 30401,1 30452,0 30538,1 30631,0 30652,1 30718,0 30774,1 30799,0 30876,1 30963,0 30971,1 31040,0 31050,1 31068,0 31148,1 31220,0 31259,1 31272,0 31326,1 31344,0 31405,1 31414,0 31452,1 31548,0 31635,1 31641,0 31722,1 31752,0 31817,1 31889,0 31934,1 31985,0 32037,1 32076,0 32141,1 32165,0 32171,1 32177,0 32272,1 32331,0 32383,1 32455,0 32491,1 32539,0 32568,1 32636,0 32668,1 32685,0 32770,1 32830,0 32854,1 32856,0 32876,1 32939,0 33019,1 33110,0 33169,1 33250,0 33348,1 33417,0 33449,1 33549,0 33577,1 33599,0 33612,1 33618,0 33632,1 33667,0 33746,1 33781,0 33786,1 33880,0 33890,1 33972,0 34014,1 34065,0 34150,1 34184,0 34257,1 34315,0 34412,1 34422,0 34455,1 34487,0 34555,1 34630,0 34718,1 34799,0 34849,1 34872,0 34940,1 35019,0 35119,1 35146,0 35223,1 35246,0 35268,1 35342,0 35359,1 35459,0 35462,1 35496,0 35592,1 35673,0 35761,1 35793,0 35851,1 35862,0 35962,1 36049,0 36130,1 36132,0 36174,1 36250,0 36291,1 36327,0 36382,1 36440,0 36507,1 36519,0 36524,1 36592,0 36649,1 36688,0 36704,1 36731,0 36784,1 36828,0 36892,1 36901,0 36988,1 36992,0 37087,1 37156,0 37186,1 37259,0 37341,1 37352,0 37378,1 37429,0 37524,1 37556,0 37588,1 37661,0 37736,1 37828,0 37850,1 37871,0 37888,1 37935,0 37983,1 38040,0 38122,1 38213,0 38302,1 38333,0 38428,1 38467,0 38551,1 38630,0 38641,1 38657,0 38684,1 38745,0 38837,1 38883,0 38928,1 39020,0 39111,1 39166,0 39229,1 39240,0 39273,1 39275,0 39306,1 39374,0 39402,1 39487,0 39555,1 39630,0 39687,1 39690,0 39699,1 39755,0 39837,1 39878,0 39897,1 39988,0 40077,1 40170,0 40218,1 40300,0 40304,1 40376,0 40470,1 40532,0 40591,1 40627,0 40701,1 40721,0 40779,1 40785,0 40837,1 40913,0 40937,1 41007,0 41070,1 41160,0 41165,1 41188,0 41209,1 41250,0 41338,1 41361,0 41379,1 41398,0 41407,1 41409,0 41445,1 41531,0 41559,1 41646,0 41741,1 41784,0 41860,1 41903,0 41914,1 41942,0 42027,1 42050,0 42083,1 42145,0 42201,1 42237,0 42322,1 42385,0 42409,1 42466,0 42473,1 42493,0 42538,1 42611,0 42693,1 42793,0 42891,1 42974,0 43039,1 43057,0 43156,1 43185,0 43250,1 43314,0 43411,1 43486,0 43557,1 43577,0 43636,1 43678,0 43762,1 43862,0 43888,1 43907,0 43916,1 43957,0 44029,1 44096,0 44116,1 44128,0 44226,1 44292,0 44362,1 44439,0 44522,1 44549,0 44592,1 44623,0 44701,1 44792,0 44815,1 44848,0 44923,1 44942,0 45041,1 45091,0 45178,1 45193,0 45271,1 45358,0 45383,1 45468,0 45527,1 45550,0 45580,1 45680,0 45681,1 45732,0 45775,1 45821,0 45828,1 45858,0 45930,1 46029,0 46127,1 46137,0 46217,1 46250,0 46344,1 46428,0 46491,1 46563,0 46655,1 46749,0 46817,1 46866,0 46886,1 46892,0 46969,1 46989,0 47030,1 47070,0 47077,1 47150,0 47247,1 47316,0 47326,1 47341,0 47423,1 47473,0 47556,1 47570,0 47591,1 47631,0 47684,1 47697,0 47792,1 47878,0 47939,1 47943,0 48001,1 48019,0 48066,1 48125,0 48195,1 48268,0 48337,1 48387,0 48449,1 48477,0 48571,1 48647,0 48747,1 48759,0 48826,1 48897,0 48975,1 49033,0 49040,1 49057,0 49155,1 49175,0 49235,1 49275,0 49333,1 49426,0 49471,1 49523,0 49545,1 49645,0 49651,1 49680,0 49778,1 49841,0 49846,1 49871,0 49885,1 49962,0 50003,1 50052,0 50109,1 50137,0 50236,1 50291,0 50306,1 50364,0 50398,1 end initlist a8 0,0 29,1 55,0 74,1 166,0 222,1 313,0 360,1 430,0 476,1 526,0 597,1 618,0 635,1 638,0 721,1 785,0 844,1 899,0 942,1 1030,0 1038,1 1061,0 1144,1 1212,0 1260,1 1281,0 1318,1 1373,0 1376,1 1381,0 1423,1 1511,0 1598,1 1665,0 1707,1 1765,0 1773,1 1840,0 1922,1 1983,0 2072,1 2107,0 2165,1 2260,0 2279,1 2292,0 2333,1 2344,0 2442,1 2494,0 2515,1 2544,0 2637,1 2648,0 2729,1 2793,0 2863,1 2891,0 2984,1 3006,0 3025,1 3106,0 3197,1 3220,0 3238,1 3337,0 3412,1 3472,0 3529,1 3608,0 3629,1 3675,0 3718,1 3763,0 3773,1 3824,0 3886,1 3963,0 4048,1 4081,0 4146,1 4180,0 4194,1 4213,0 4285,1 4293,0 4353,1 4362,0 4400,1 4424,0 4482,1 4510,0 4515,1 4542,0 4600,1 4647,0 4718,1 4727,0 4743,1 4777,0 4791,1 4849,0 4911,1 4985,0 5019,1 5073,0 5151,1 5227,0 5239,1 5276,0 5364,1 5421,0 5490,1 5566,0 5579,1 5676,0 5745,1 5784,0 5876,1 5936,0 5967,1 5990,0 6007,1 6084,0 6103,1 6177,0 6224,1 6290,0 6328,1 6416,0 6453,1 6523,0 6615,1 6675,0 6758,1 6850,0 6928,1 6972,0 7017,1 7061,0 7158,1 7204,0 7242,1 7336,0 7381,1 7400,0 7488,1 7492,0 7535,1 7578,0 7648,1 7729,0 7792,1 7837,0 7839,1 7861,0 7946,1 7962,0 8011,1 8014,0 8041,1 8138,0 8153,1 8221,0 8237,1 8297,0 8392,1 8446,0 8514,1 8539,0 8544,1 8548,0 8643,1 8668,0 8693,1 8746,0 8756,1 8839,0 8938,1 8997,0 9048,1 9115,0 9154,1 9195,0 9238,1 9282,0 9284,1 9363,0 9378,1 9402,0 9441,1 9540,0 9598,1 9639,0 9735,1 9771,0 9860,1 9923,0 9944,1 9973,0 10037,1 10115,0 10174,1 10198,0 10248,1 10286,0 10294,1 10340,0 10420,1 10520,0 10595,1 10689,0 10787,1 10880,0 10961,1 11009,0 11069,1 11138,0 11139,1 11155,0 11241,1 11341,0 11427,1 11483,0 11547,1 11625,0 11677,1 11757,0 11852,1 11915,0 11957,1 12014,0 12053,1 12104,0 12165,1 12199,0 12269,1 12311,0 12340,1 12408,0 12410,1 12439,0 12455,1 12466,0 12502,1 12550,0 12645,1 12681,0 12726,1 12742,0 12836,1 12898,0 12924,1 12950,0 12973,1 13032,0 13052,1 13096,0 13183,1 13222,0 13277,1 13287,0 13365,1 13465,0 13486,1 13563,0 13631,1 13657,0 13723,1 13774,0 13778,1 13858,0 13905,1 14000,0 14060,1 14159,0 14217,1 14263,0 14291,1 14386,0 14447,1 14465,0 14500,1 14511,0 14571,1 14634,0 14661,1 14692,0 14757,1 14778,0 14804,1 14805,0 14825,1 14867,0 14898,1 14941,0 15029,1 15079,0 15126,1 15185,0 15254,1 15326,0 15379,1 15433,0 15463,1 15558,0 15624,1 15698,0 15735,1 15743,0 15745,1 15797,0 15865,1 15883,0 15948,1 15984,0 16047,1 16081,0 16145,1 16223,0 16291,1 16295,0 16353,1 16423,0 16445,1 16454,0 16514,1 16603,0 16672,1 16684,0 16769,1 16780,0 16856,1 16914,0 16936,1 16961,0 17035,1 17079,0 17144,1 17222,0 17284,1 17303,0 17397,1 17493,0 17510,1 17598,0 17667,1 17765,0 17832,1 17889,0 17930,1 17997,0 18070,1 18090,0 18150,1 18168,0 18225,1 18294,0 18320,1 18324,0 18420,1 18428,0 18487,1 18531,0 18619,1 18651,0 18682,1 18687,0 18698,1 18781,0 18813,1 18814,0 18836,1 18898,0 18912,1 18968,0 18988,1 19020,0 19036,1 19108,0 19193,1 19270,0 19296,1 19383,0 19481,1 19534,0 19605,1 19690,0 19715,1 19793,0 19857,1 19914,0 19965,1 20016,0 20021,1 20031,0 20108,1 20139,0 20158,1 20167,0 20193,1 20213,0 20234,1 20296,0 20373,1 20459,0 20487,1 20500,0 20547,1 20570,0 20595,1 20652,0 20740,1 20769,0 20835,1 20882,0 20891,1 20899,0 20957,1 21014,0 21020,1 21066,0 21088,1 21100,0 21173,1 21224,0 21270,1 21345,0 21379,1 21392,0 21407,1 21441,0 21476,1 21522,0 21543,1 21554,0 21639,1 21696,0 21777,1 21858,0 21958,1 21991,0 22004,1 22017,0 22103,1 22113,0 22198,1 22255,0 22296,1 22384,0 22403,1 22503,0 22597,1 22691,0 22724,1 22733,0 22801,1 22854,0 22876,1 22962,0 23016,1 23109,0 23114,1 23169,0 23183,1 23255,0 23331,1 23427,0 23448,1 23483,0 23557,1 23568,0 23581,1 23582,0 23658,1 23736,0 23812,1 23894,0 23972,1 24016,0 24026,1 24036,0 24126,1 24201,0 24260,1 24328,0 24385,1 24484,0 24543,1 24588,0 24669,1 24711,0 24713,1 24752,0 24782,1 24860,0 24903,1 24948,0 24977,1 25019,0 25056,1 25095,0 25131,1 25194,0 25226,1 25312,0 25355,1 25363,0 25458,1 25537,0 25608,1 25663,0 25722,1 25750,0 25829,1 25928,0 26008,1 26072,0 26112,1 26190,0 26245,1 26317,0 26383,1 26410,0 26423,1 26516,0 26584,1 26684,0 26711,1 26799,0 26821,1 26826,0 26849,1 26890,0 26931,1 26939,0 26959,1 27017,0 27084,1 27091,0 27116,1 27170,0 27269,1 27362,0 27460,1 27467,0 27473,1 27566,0 27656,1 27662,0 27723,1 27782,0 27838,1 27857,0 27921,1 27956,0 28032,1 28090,0 28150,1 28182,0 28198,1 28216,0 28247,1 28280,0 28298,1 28339,0 28370,1 28466,0 28500,1 28580,0 28673,1 28744,0 28761,1 28779,0 28810,1 28845,0 28925,1 29018,0 29097,1 29171,0 29176,1 29203,0 29291,1 29339,0 29411,1 29412,0 29474,1 29534,0 29583,1 29590,0 29605,1 29637,0 29734,1 29819,0 29867,1 29962,0 29963,1 30039,0 30121,1 30167,0 30208,1 30235,0 30291,1 30312,0 30375,1 30403,0 30424,1 30517,0 30586,1 30624,0 30689,1 30728,0 30789,1 30806,0 30825,1 30896,0 30981,1 30999,0 31045,1 31124,0 31182,1 31238,0 31293,1 31390,0 31392,1 31482,0 31582,1 31613,0 31659,1 31664,0 31739,1 31754,0 31851,1 31938,0 31998,1 32062,0 32146,1 32212,0 32227,1 32274,0 32319,1 32339,0 32340,1 32426,0 32458,1 32527,0 32569,1 32654,0 32675,1 32703,0 32726,1 32822,0 32854,1 32917,0 32962,1 33025,0 33101,1 33127,0 33147,1 33210,0 33272,1 33307,0 33315,1 33397,0 33463,1 33473,0 33559,1 33582,0 33654,1 33716,0 33779,1 33807,0 33811,1 33831,0 33931,1 33960,0 34020,1 34103,0 34170,1 34223,0 34289,1 34361,0 34442,1 34526,0 34542,1 34634,0 34698,1 34764,0 34825,1 34921,0 34966,1 34990,0 35070,1 35089,0 35104,1 35110,0 35114,1 35150,0 35231,1 35240,0 35281,1 35295,0 35395,1 35466,0 35554,1 35646,0 35744,1 35798,0 35862,1 35941,0 36028,1 36032,0 36123,1 36149,0 36212,1 36300,0 36321,1 36415,0 36464,1 36480,0 36527,1 36583,0 36664,1 36714,0 36752,1 36844,0 36871,1 36881,0 36959,1 37027,0 37104,1 37166,0 37202,1 37251,0 37289,1 37305,0 37320,1 37412,0 37509,1 37572,0 37634,1 37700,0 37708,1 37749,0 37773,1 37873,0 37970,1 37993,0 38052,1 38117,0 38211,1 38235,0 38271,1 38305,0 38385,1 38479,0 38491,1 38576,0 38611,1 38646,0 38707,1 38731,0 38821,1 38844,0 38895,1 38971,0 38989,1 39070,0 39110,1 39207,0 39252,1 39317,0 39386,1 39402,0 39406,1 39464,0 39490,1 39556,0 39585,1 39615,0 39619,1 39633,0 39654,1 39701,0 39765,1 39837,0 39924,1 40024,0 40061,1 40135,0 40136,1 40146,0 40196,1 40235,0 40283,1 40367,0 40374,1 40468,0 40535,1 40619,0 40629,1 40716,0 40728,1 40780,0 40794,1 40890,0 40942,1 41028,0 41048,1 41080,0 41085,1 41121,0 41165,1 41168,0 41262,1 41344,0 41394,1 41440,0 41451,1 41550,0 41634,1 41643,0 41716,1 41725,0 41790,1 41833,0 41933,1 42005,0 42036,1 42115,0 42145,1 42177,0 42233,1 42246,0 42256,1 42273,0 42299,1 42307,0 42385,1 42439,0 42458,1 42507,0 42577,1 42643,0 42704,1 42718,0 42733,1 42816,0 42817,1 42827,0 42880,1 42944,0 42967,1 43040,0 43076,1 43090,0 43162,1 43246,0 43304,1 43306,0 43310,1 43337,0 43435,1 43499,0 43577,1 43607,0 43608,1 43675,0 43719,1 43802,0 43892,1 43976,0 43984,1 44042,0 44057,1 44117,0 44214,1 44285,0 44347,1 44375,0 44404,1 44419,0 44477,1 44561,0 44594,1 44617,0 44695,1 44756,0 44843,1 44881,0 44891,1 44956,0 44963,1 45048,0 45058,1 45122,0 45189,1 45206,0 45258,1 45331,0 45429,1 45508,0 45534,1 45624,0 45654,1 45727,0 45752,1 45789,0 45842,1 45937,0 45945,1 46040,0 46084,1 46141,0 46175,1 46184,0 46202,1 46269,0 46361,1 46364,0 46366,1 46418,0 46495,1 46588,0 46619,1 46649,0 46708,1 46727,0 46739,1 46797,0 46877,1 46892,0 46894,1 46941,0 47023,1 47048,0 47064,1 47068,0 47162,1 47240,0 47307,1 47323,0 47401,1 47409,0 47455,1 47551,0 47641,1 47646,0 47698,1 47716,0 47797,1 47848,0 47937,1 48022,0 48057,1 48109,0 48205,1 48243,0 48305,1 48354,0 48411,1 48428,0 48469,1 48528,0 48560,1 48650,0 48706,1 48726,0 48754,1 48770,0 48802,1 48843,0 48878,1 48892,0 48989,1 49071,0 49168,1 49267,0 49300,1 49372,0 49408,1 49488,0 49506,1 49534,0 49570,1 49644,0 49725,1 49743,0 49765,1 49865,0 49905,1 49995,0 50035,1 50100,0 50112,1 50151,0 50164,1 50249,0 50324,1 50397,0 50445,1 end initlist a9 0,0 30,1 66,0 67,1 69,0 93,1 157,0 190,1 285,0 353,1 448,0 538,1 625,0 643,1 735,0 741,1 795,0 895,1 961,0 1031,1 1046,0 1076,1 1136,0 1178,1 1248,0 1259,1 1270,0 1338,1 1419,0 1434,1 1474,0 1515,1 1579,0 1631,1 1697,0 1724,1 1822,0 1883,1 1906,0 2003,1 2021,0 2100,1 2121,0 2139,1 2173,0 2230,1 2246,0 2301,1 2314,0 2396,1 2465,0 2539,1 2548,0 2571,1 2659,0 2728,1 2729,0 2804,1 2820,0 2864,1 2932,0 2983,1 3030,0 3095,1 3116,0 3171,1 3239,0 3310,1 3358,0 3372,1 3437,0 3444,1 3528,0 3538,1 3610,0 3630,1 3681,0 3748,1 3773,0 3846,1 3901,0 3967,1 4014,0 4105,1 4118,0 4215,1 4223,0 4295,1 4330,0 4402,1 4426,0 4526,1 4578,0 4620,1 4648,0 4659,1 4718,0 4800,1 4809,0 4818,1 4844,0 4904,1 4919,0 5002,1 5075,0 5162,1 5262,0 5307,1 5400,0 5472,1 5498,0 5532,1 5567,0 5617,1 5628,0 5689,1 5710,0 5800,1 5840,0 5841,1 5867,0 5905,1 5906,0 5949,1 5983,0 6050,1 6124,0 6163,1 6179,0 6184,1 6253,0 6338,1 6416,0 6464,1 6524,0 6603,1 6665,0 6670,1 6711,0 6746,1 6814,0 6862,1 6910,0 6916,1 6954,0 7047,1 7135,0 7153,1 7182,0 7222,1 7258,0 7312,1 7327,0 7384,1 7460,0 7490,1 7571,0 7660,1 7733,0 7819,1 7843,0 7844,1 7873,0 7881,1 7973,0 8070,1 8130,0 8173,1 8200,0 8280,1 8354,0 8446,1 8466,0 8517,1 8556,0 8653,1 8675,0 8741,1 8753,0 8835,1 8839,0 8861,1 8932,0 8936,1 8995,0 9043,1 9070,0 9109,1 9198,0 9260,1 9285,0 9370,1 9432,0 9521,1 9546,0 9600,1 9642,0 9713,1 9807,0 9837,1 9898,0 9966,1 10059,0 10122,1 10160,0 10183,1 10241,0 10310,1 10348,0 10440,1 10531,0 10615,1 10689,0 10755,1 10766,0 10786,1 10880,0 10918,1 10930,0 11015,1 11041,0 11098,1 11183,0 11268,1 11275,0 11357,1 11455,0 11474,1 11543,0 11609,1 11707,0 11740,1 11789,0 11807,1 11864,0 11955,1 12036,0 12069,1 12098,0 12174,1 12254,0 12273,1 12284,0 12347,1 12408,0 12439,1 12514,0 12530,1 12626,0 12722,1 12811,0 12829,1 12911,0 12939,1 13012,0 13033,1 13074,0 13172,1 13177,0 13255,1 13299,0 13371,1 13405,0 13474,1 13543,0 13638,1 13686,0 13767,1 13797,0 13897,1 13974,0 14048,1 14059,0 14146,1 14156,0 14251,1 14289,0 14352,1 14428,0 14514,1 14586,0 14649,1 14730,0 14798,1 14896,0 14897,1 14912,0 14988,1 15045,0 15135,1 15166,0 15263,1 15330,0 15380,1 15427,0 15504,1 15550,0 15579,1 15679,0 15713,1 15766,0 15810,1 15832,0 15883,1 15891,0 15915,1 16011,0 16013,1 16040,0 16043,1 16104,0 16178,1 16226,0 16259,1 16288,0 16367,1 16384,0 16390,1 16437,0 16533,1 16551,0 16580,1 16639,0 16688,1 16730,0 16807,1 16865,0 16936,1 16963,0 17007,1 17057,0 17150,1 17249,0 17274,1 17349,0 17385,1 17485,0 17527,1 17558,0 17642,1 17666,0 17754,1 17771,0 17804,1 17898,0 17936,1 18035,0 18122,1 18123,0 18150,1 18208,0 18303,1 18322,0 18337,1 18381,0 18460,1 18558,0 18576,1 18620,0 18630,1 18653,0 18656,1 18702,0 18764,1 18768,0 18772,1 18846,0 18864,1 18881,0 18941,1 18994,0 19032,1 19095,0 19194,1 19281,0 19291,1 19327,0 19401,1 19467,0 19549,1 19619,0 19718,1 19811,0 19828,1 19927,0 19961,1 20003,0 20083,1 20159,0 20216,1 20272,0 20296,1 20348,0 20385,1 20469,0 20504,1 20531,0 20628,1 20652,0 20707,1 20730,0 20749,1 20829,0 20925,1 20929,0 21023,1 21074,0 21097,1 21105,0 21144,1 21198,0 21219,1 21231,0 21248,1 21333,0 21417,1 21472,0 21512,1 21558,0 21576,1 21643,0 21697,1 21716,0 21764,1 21832,0 21931,1 21937,0 22029,1 22125,0 22177,1 22265,0 22350,1 22431,0 22469,1 22501,0 22552,1 22624,0 22720,1 22729,0 22801,1 22901,0 22914,1 22975,0 22998,1 23015,0 23019,1 23085,0 23185,1 23195,0 23289,1 23360,0 23419,1 23437,0 23506,1 23577,0 23594,1 23674,0 23760,1 23776,0 23788,1 23877,0 23889,1 23958,0 23986,1 24068,0 24122,1 24175,0 24177,1 24180,0 24249,1 24288,0 24319,1 24355,0 24397,1 24424,0 24434,1 24508,0 24583,1 24677,0 24727,1 24808,0 24828,1 24880,0 24935,1 25017,0 25023,1 25112,0 25187,1 25246,0 25339,1 25404,0 25457,1 25475,0 25480,1 25529,0 25623,1 25638,0 25737,1 25779,0 25863,1 25914,0 25951,1 26005,0 26081,1 26127,0 26198,1 26298,0 26334,1 26434,0 26507,1 26562,0 26606,1 26609,0 26629,1 26721,0 26748,1 26795,0 26816,1 26866,0 26903,1 26943,0 26987,1 27043,0 27090,1 27140,0 27166,1 27191,0 27268,1 27270,0 27339,1 27416,0 27442,1 27446,0 27452,1 27481,0 27486,1 27567,0 27649,1 27686,0 27748,1 27772,0 27870,1 27965,0 28026,1 28071,0 28073,1 28091,0 28098,1 28194,0 28255,1 28335,0 28400,1 28500,0 28540,1 28550,0 28610,1 28646,0 28681,1 28767,0 28829,1 28900,0 28927,1 28996,0 29082,1 29137,0 29153,1 29184,0 29263,1 29270,0 29341,1 29345,0 29360,1 29369,0 29370,1 29387,0 29425,1 29514,0 29589,1 29678,0 29757,1 29812,0 29869,1 29903,0 29906,1 29955,0 30044,1 30099,0 30168,1 30243,0 30294,1 30298,0 30308,1 30402,0 30499,1 30585,0 30597,1 30682,0 30683,1 30702,0 30761,1 30815,0 30855,1 30868,0 30963,1 30998,0 31076,1 31088,0 31146,1 31155,0 31209,1 31218,0 31297,1 31366,0 31415,1 31486,0 31508,1 31588,0 31649,1 31731,0 31737,1 31814,0 31884,1 31940,0 31999,1 32062,0 32155,1 32177,0 32266,1 32363,0 32448,1 32498,0 32573,1 32608,0 32636,1 32697,0 32764,1 32862,0 32893,1 32945,0 33028,1 33121,0 33146,1 33148,0 33242,1 33309,0 33382,1 33441,0 33463,1 33500,0 33518,1 33534,0 33550,1 33625,0 33692,1 33755,0 33760,1 33798,0 33838,1 33869,0 33873,1 33943,0 34015,1 34061,0 34137,1 34163,0 34211,1 34307,0 34406,1 34500,0 34523,1 34539,0 34630,1 34709,0 34741,1 34822,0 34836,1 34892,0 34959,1 35026,0 35075,1 35128,0 35191,1 35249,0 35330,1 35358,0 35386,1 35445,0 35541,1 35561,0 35588,1 35591,0 35593,1 35654,0 35739,1 35815,0 35836,1 35851,0 35925,1 36017,0 36103,1 36115,0 36211,1 36299,0 36346,1 36379,0 36394,1 36476,0 36566,1 36664,0 36717,1 36814,0 36880,1 36970,0 37049,1 37089,0 37154,1 37227,0 37294,1 37371,0 37383,1 37386,0 37437,1 37449,0 37506,1 37525,0 37624,1 37723,0 37772,1 37779,0 37804,1 37859,0 37879,1 37979,0 37980,1 38056,0 38144,1 38183,0 38251,1 38349,0 38396,1 38419,0 38447,1 38542,0 38580,1 38635,0 38711,1 38763,0 38779,1 38849,0 38918,1 38988,0 39038,1 39093,0 39097,1 39196,0 39229,1 39285,0 39292,1 39303,0 39389,1 39396,0 39400,1 39430,0 39481,1 39538,0 39611,1 39617,0 39656,1 39684,0 39746,1 39812,0 39910,1 39934,0 39969,1 39978,0 40054,1 40077,0 40103,1 40188,0 40280,1 40376,0 40397,1 40436,0 40530,1 40605,0 40641,1 40674,0 40742,1 40771,0 40870,1 40934,0 40973,1 41022,0 41057,1 41097,0 41177,1 41262,0 41283,1 41327,0 41367,1 41392,0 41467,1 41535,0 41543,1 41628,0 41669,1 41691,0 41779,1 41809,0 41826,1 41869,0 41920,1 41951,0 42022,1 42027,0 42032,1 42104,0 42173,1 42175,0 42213,1 42291,0 42359,1 42448,0 42470,1 42480,0 42527,1 42559,0 42615,1 42693,0 42764,1 42844,0 42856,1 42886,0 42973,1 43049,0 43118,1 43207,0 43304,1 43334,0 43429,1 43505,0 43594,1 43660,0 43712,1 43804,0 43873,1 43957,0 44035,1 44063,0 44151,1 44236,0 44280,1 44352,0 44371,1 44453,0 44518,1 44589,0 44658,1 44709,0 44714,1 44777,0 44798,1 44854,0 44874,1 44891,0 44981,1 44990,0 45016,1 45084,0 45092,1 45094,0 45144,1 45238,0 45322,1 45354,0 45384,1 45447,0 45486,1 45492,0 45520,1 45604,0 45681,1 45734,0 45824,1 45835,0 45857,1 45863,0 45927,1 45981,0 46041,1 46058,0 46113,1 46189,0 46232,1 46275,0 46364,1 46440,0 46499,1 46544,0 46545,1 46571,0 46645,1 46723,0 46745,1 46781,0 46864,1 46928,0 47011,1 47082,0 47118,1 47155,0 47198,1 47202,0 47241,1 47293,0 47369,1 47415,0 47470,1 47514,0 47524,1 47539,0 47595,1 47632,0 47728,1 47730,0 47829,1 47894,0 47908,1 47966,0 48001,1 48034,0 48113,1 48114,0 48166,1 48216,0 48305,1 48323,0 48388,1 48404,0 48425,1 48477,0 48508,1 48557,0 48618,1 48683,0 48742,1 48756,0 48835,1 48878,0 48971,1 49046,0 49101,1 49114,0 49167,1 49186,0 49226,1 49264,0 49280,1 49361,0 49377,1 49451,0 49523,1 49590,0 49680,1 49691,0 49781,1 49866,0 49954,1 50039,0 50073,1 50142,0 50182,1 50254,0 50332,1 50419,0 50442,1 50470,0 50516,1 50561,0 50618,1 50683,0 50778,1 50779,0 50841,1 50865,0 50963,1 50980,0 50992,1 51017,0 51073,1 51169,0 51265,1 51360,0 51460,1 51521,0 51574,1 51601,0 51670,1 51701,0 51781,1 51817,0 51901,1 end initlist a10 0,0 96,1 151,0 191,1 205,0 291,1 333,0 361,1 381,0 437,1 470,0 481,1 510,0 607,1 698,0 744,1 775,0 853,1 894,0 897,1 954,0 1004,1 1042,0 1046,1 1090,0 1167,1 1180,0 1218,1 1247,0 1305,1 1373,0 1441,1 1469,0 1518,1 1569,0 1627,1 1668,0 1756,1 1802,0 1851,1 1939,0 1994,1 2004,0 2065,1 2158,0 2166,1 2236,0 2277,1 2300,0 2328,1 2412,0 2444,1 2514,0 2537,1 2544,0 2594,1 2654,0 2717,1 2757,0 2800,1 2801,0 2889,1 2916,0 2995,1 3057,0 3061,1 3062,0 3147,1 3185,0 3189,1 3238,0 3258,1 3310,0 3395,1 3457,0 3533,1 3619,0 3688,1 3786,0 3852,1 3921,0 3969,1 4019,0 4060,1 4116,0 4137,1 4235,0 4288,1 4326,0 4369,1 4396,0 4420,1 4438,0 4499,1 4501,0 4594,1 4687,0 4724,1 4821,0 4849,1 4907,0 4986,1 5072,0 5166,1 5174,0 5210,1 5262,0 5280,1 5341,0 5424,1 5459,0 5502,1 5577,0 5675,1 5728,0 5772,1 5866,0 5945,1 6022,0 6035,1 6043,0 6058,1 6103,0 6166,1 6203,0 6288,1 6289,0 6327,1 6335,0 6389,1 6444,0 6485,1 6534,0 6541,1 6615,0 6663,1 6745,0 6829,1 6864,0 6877,1 6912,0 6919,1 6947,0 6970,1 6976,0 7006,1 7077,0 7149,1 7185,0 7230,1 7300,0 7368,1 7386,0 7484,1 7582,0 7611,1 7651,0 7675,1 7734,0 7785,1 7885,0 7934,1 7955,0 8017,1 8082,0 8119,1 8167,0 8231,1 8288,0 8303,1 8381,0 8413,1 8499,0 8501,1 8519,0 8605,1 8625,0 8668,1 8699,0 8783,1 8862,0 8944,1 9002,0 9062,1 9080,0 9174,1 9207,0 9215,1 9258,0 9333,1 9341,0 9382,1 9418,0 9443,1 9505,0 9560,1 9567,0 9604,1 9619,0 9651,1 9685,0 9763,1 9836,0 9867,1 9962,0 10061,1 10146,0 10173,1 10240,0 10274,1 10370,0 10464,1 10551,0 10598,1 10602,0 10643,1 10658,0 10749,1 10805,0 10816,1 10895,0 10969,1 10977,0 11042,1 11130,0 11158,1 11214,0 11301,1 11342,0 11391,1 11470,0 11508,1 11591,0 11609,1 11675,0 11765,1 11846,0 11859,1 11935,0 12025,1 12103,0 12191,1 12280,0 12349,1 12370,0 12463,1 12555,0 12651,1 12684,0 12770,1 12864,0 12883,1 12890,0 12989,1 13074,0 13144,1 13244,0 13306,1 13365,0 13372,1 13423,0 13523,1 13620,0 13692,1 13721,0 13757,1 13830,0 13851,1 13938,0 14022,1 14093,0 14176,1 14185,0 14248,1 14254,0 14302,1 14330,0 14373,1 14379,0 14387,1 14423,0 14479,1 14550,0 14554,1 14629,0 14726,1 14756,0 14811,1 14831,0 14835,1 14918,0 14987,1 15061,0 15070,1 15166,0 15183,1 15215,0 15248,1 15267,0 15344,1 15393,0 15463,1 15488,0 15527,1 15611,0 15627,1 15700,0 15734,1 15768,0 15862,1 15863,0 15889,1 15962,0 15990,1 16020,0 16115,1 16134,0 16141,1 16153,0 16241,1 16305,0 16309,1 16352,0 16406,1 16474,0 16511,1 16531,0 16590,1 16687,0 16770,1 16826,0 16850,1 16869,0 16921,1 16981,0 17041,1 17132,0 17156,1 17250,0 17252,1 17345,0 17429,1 17467,0 17555,1 17633,0 17652,1 17711,0 17726,1 17744,0 17762,1 17805,0 17848,1 17905,0 17994,1 18008,0 18038,1 18094,0 18140,1 18187,0 18270,1 18350,0 18436,1 18452,0 18467,1 18546,0 18550,1 18574,0 18581,1 18654,0 18696,1 18732,0 18815,1 18863,0 18958,1 19055,0 19099,1 19178,0 19245,1 19320,0 19379,1 19452,0 19456,1 19515,0 19517,1 19607,0 19648,1 19712,0 19729,1 19735,0 19736,1 19762,0 19851,1 19876,0 19926,1 19960,0 19988,1 20082,0 20152,1 20251,0 20327,1 20400,0 20461,1 20475,0 20538,1 20578,0 20599,1 20648,0 20681,1 20765,0 20787,1 20794,0 20847,1 20905,0 20915,1 20974,0 21043,1 21107,0 21200,1 21293,0 21383,1 21477,0 21548,1 21641,0 21728,1 21819,0 21871,1 21875,0 21886,1 21954,0 21963,1 22050,0 22063,1 22147,0 22151,1 22156,0 22215,1 22247,0 22310,1 22333,0 22389,1 22456,0 22505,1 22540,0 22585,1 22671,0 22686,1 22737,0 22786,1 22838,0 22927,1 22974,0 23056,1 23151,0 23229,1 23326,0 23344,1 23364,0 23401,1 23414,0 23499,1 23537,0 23576,1 23605,0 23626,1 23661,0 23677,1 23739,0 23750,1 23835,0 23935,1 23955,0 23966,1 23985,0 24057,1 24086,0 24166,1 24212,0 24243,1 24307,0 24347,1 24383,0 24448,1 24484,0 24517,1 24574,0 24624,1 24638,0 24696,1 24787,0 24871,1 24874,0 24923,1 24987,0 25045,1 25063,0 25064,1 25161,0 25255,1 25320,0 25366,1 25407,0 25486,1 25506,0 25526,1 25544,0 25579,1 25629,0 25639,1 25696,0 25787,1 25847,0 25945,1 26022,0 26117,1 26150,0 26181,1 26189,0 26205,1 26277,0 26315,1 26322,0 26336,1 26348,0 26405,1 26467,0 26531,1 26566,0 26657,1 26679,0 26693,1 26761,0 26822,1 26886,0 26967,1 27012,0 27025,1 27085,0 27099,1 27141,0 27227,1 27323,0 27399,1 27419,0 27519,1 27568,0 27625,1 27703,0 27704,1 27744,0 27748,1 27796,0 27844,1 27925,0 27995,1 28038,0 28128,1 28162,0 28205,1 28281,0 28317,1 28410,0 28508,1 28585,0 28670,1 28759,0 28773,1 28784,0 28800,1 28893,0 28928,1 29018,0 29097,1 29136,0 29157,1 29180,0 29271,1 29281,0 29346,1 29397,0 29490,1 29524,0 29612,1 29709,0 29779,1 29824,0 29859,1 29869,0 29959,1 29998,0 30060,1 30077,0 30132,1 30151,0 30224,1 30253,0 30301,1 30321,0 30397,1 30430,0 30514,1 30545,0 30586,1 30657,0 30749,1 30824,0 30889,1 30988,0 31016,1 31054,0 31073,1 31134,0 31142,1 31196,0 31228,1 31270,0 31354,1 31417,0 31436,1 31455,0 31463,1 31523,0 31559,1 31613,0 31653,1 31688,0 31761,1 31770,0 31802,1 31849,0 31889,1 31910,0 31951,1 32015,0 32089,1 32156,0 32157,1 32196,0 32278,1 32362,0 32363,1 32366,0 32386,1 32392,0 32420,1 32506,0 32589,1 32682,0 32781,1 32849,0 32935,1 32952,0 32954,1 32970,0 33057,1 33148,0 33196,1 33241,0 33278,1 33331,0 33367,1 33375,0 33395,1 33427,0 33501,1 33546,0 33552,1 33628,0 33704,1 33717,0 33767,1 33803,0 33862,1 33864,0 33875,1 33913,0 33998,1 34044,0 34107,1 34145,0 34210,1 34307,0 34367,1 34449,0 34497,1 34559,0 34643,1 34740,0 34778,1 34854,0 34896,1 34899,0 34920,1 34986,0 35040,1 35050,0 35074,1 35154,0 35231,1 35308,0 35350,1 35396,0 35404,1 35466,0 35477,1 35508,0 35580,1 35585,0 35614,1 35643,0 35654,1 35704,0 35717,1 35773,0 35825,1 35900,0 35908,1 35951,0 36031,1 36045,0 36128,1 36200,0 36237,1 36275,0 36334,1 36369,0 36433,1 36515,0 36543,1 36626,0 36712,1 36717,0 36738,1 36782,0 36829,1 36835,0 36865,1 36892,0 36939,1 36942,0 36985,1 37021,0 37045,1 37125,0 37191,1 37272,0 37353,1 37396,0 37402,1 37437,0 37456,1 37490,0 37530,1 37626,0 37642,1 37703,0 37774,1 37797,0 37836,1 37878,0 37950,1 38001,0 38088,1 38155,0 38157,1 38237,0 38325,1 38367,0 38397,1 38430,0 38457,1 38553,0 38603,1 38636,0 38679,1 38730,0 38815,1 38843,0 38854,1 38930,0 38994,1 39026,0 39076,1 39103,0 39195,1 39272,0 39352,1 39421,0 39494,1 39514,0 39606,1 39699,0 39783,1 39873,0 39919,1 39993,0 40091,1 40160,0 40257,1 40290,0 40342,1 40386,0 40446,1 40497,0 40566,1 40656,0 40700,1 40748,0 40830,1 40888,0 40969,1 40980,0 41021,1 41048,0 41049,1 41088,0 41131,1 41190,0 41236,1 41296,0 41298,1 41396,0 41436,1 41509,0 41547,1 41611,0 41707,1 41728,0 41772,1 41842,0 41927,1 42020,0 42041,1 42115,0 42133,1 42171,0 42234,1 42287,0 42360,1 42373,0 42443,1 42501,0 42555,1 42563,0 42600,1 42638,0 42709,1 42744,0 42836,1 42842,0 42891,1 42936,0 42988,1 43062,0 43124,1 43167,0 43173,1 43273,0 43321,1 43390,0 43451,1 43496,0 43543,1 43560,0 43569,1 43570,0 43662,1 43716,0 43756,1 43759,0 43837,1 43855,0 43940,1 43986,0 44040,1 44091,0 44092,1 44119,0 44197,1 44217,0 44274,1 44369,0 44456,1 44540,0 44630,1 44697,0 44769,1 44831,0 44844,1 44858,0 44871,1 44954,0 45022,1 45075,0 45157,1 45168,0 45234,1 45270,0 45322,1 45418,0 45456,1 45490,0 45491,1 45552,0 45583,1 45602,0 45632,1 45665,0 45764,1 45829,0 45845,1 45846,0 45923,1 45999,0 46048,1 46077,0 46166,1 46185,0 46261,1 46272,0 46314,1 46401,0 46472,1 46546,0 46620,1 46717,0 46775,1 46866,0 46939,1 47007,0 47022,1 47095,0 47163,1 47187,0 47240,1 47277,0 47291,1 47380,0 47477,1 47544,0 47631,1 47719,0 47801,1 47828,0 47890,1 47903,0 47906,1 48000,0 48033,1 48058,0 48105,1 48121,0 48168,1 48238,0 48290,1 48382,0 48477,1 48479,0 48532,1 48617,0 48662,1 48696,0 48792,1 48851,0 48895,1 48931,0 48981,1 49004,0 49091,1 49143,0 49157,1 49234,0 49281,1 49282,0 49285,1 49355,0 49384,1 49478,0 49538,1 49562,0 49601,1 49615,0 49687,1 49706,0 49711,1 49749,0 49814,1 49838,0 49905,1 49961,0 50003,1 50102,0 50162,1 50227,0 50291,1 50376,0 50439,1 50531,0 50573,1 50615,0 50701,1 50749,0 50786,1 end initlist a11 0,0 15,1 45,0 117,1 153,0 242,1 322,0 350,1 438,0 446,1 500,0 539,1 570,0 617,1 707,0 770,1 811,0 860,1 940,0 1013,1 1073,0 1163,1 1210,0 1266,1 1340,0 1422,1 1502,0 1595,1 1690,0 1738,1 1825,0 1884,1 1886,0 1944,1 1996,0 2070,1 2142,0 2164,1 2227,0 2229,1 2250,0 2321,1 2394,0 2417,1 2458,0 2479,1 2555,0 2607,1 2631,0 2717,1 2724,0 2748,1 2762,0 2763,1 2855,0 2869,1 2879,0 2923,1 2949,0 2953,1 3019,0 3102,1 3138,0 3233,1 3325,0 3359,1 3363,0 3380,1 3382,0 3458,1 3540,0 3568,1 3575,0 3595,1 3618,0 3632,1 3659,0 3729,1 3792,0 3884,1 3951,0 3960,1 4013,0 4099,1 4169,0 4173,1 4178,0 4205,1 4305,0 4364,1 4393,0 4482,1 4514,0 4568,1 4581,0 4599,1 4628,0 4655,1 4677,0 4708,1 4802,0 4841,1 4929,0 4980,1 5027,0 5101,1 5173,0 5268,1 5338,0 5429,1 5466,0 5531,1 5619,0 5676,1 5678,0 5740,1 5822,0 5826,1 5828,0 5842,1 5890,0 5946,1 6016,0 6024,1 6039,0 6125,1 6198,0 6249,1 6300,0 6308,1 6363,0 6398,1 6435,0 6519,1 6535,0 6586,1 6665,0 6700,1 6705,0 6802,1 6876,0 6883,1 6932,0 6999,1 7028,0 7125,1 7207,0 7228,1 7234,0 7285,1 7339,0 7436,1 7467,0 7481,1 7522,0 7584,1 7643,0 7740,1 7743,0 7774,1 7789,0 7835,1 7838,0 7890,1 7978,0 7985,1 7987,0 8082,1 8138,0 8191,1 8219,0 8295,1 8305,0 8368,1 8395,0 8494,1 8562,0 8659,1 8685,0 8689,1 8740,0 8755,1 8803,0 8851,1 8866,0 8957,1 9011,0 9026,1 9125,0 9162,1 9236,0 9276,1 9359,0 9407,1 9463,0 9490,1 9578,0 9624,1 9680,0 9776,1 9840,0 9870,1 9903,0 9996,1 10079,0 10114,1 10125,0 10191,1 10228,0 10273,1 10333,0 10382,1 10397,0 10463,1 10477,0 10540,1 10582,0 10601,1 10633,0 10670,1 10760,0 10826,1 10827,0 10915,1 10950,0 11029,1 11124,0 11200,1 11282,0 11322,1 11325,0 11337,1 11371,0 11387,1 11475,0 11522,1 11591,0 11663,1 11685,0 11722,1 11819,0 11899,1 11972,0 12064,1 12122,0 12143,1 12209,0 12217,1 12245,0 12256,1 12315,0 12362,1 12383,0 12469,1 12562,0 12630,1 12695,0 12700,1 12797,0 12832,1 12839,0 12907,1 12992,0 13049,1 13142,0 13186,1 13190,0 13210,1 13297,0 13342,1 13383,0 13408,1 13424,0 13488,1 13511,0 13588,1 13651,0 13743,1 13746,0 13844,1 13879,0 13920,1 13936,0 14008,1 14098,0 14104,1 14132,0 14194,1 14202,0 14223,1 14225,0 14283,1 14368,0 14395,1 14427,0 14479,1 14495,0 14555,1 14565,0 14643,1 14672,0 14709,1 14751,0 14773,1 14777,0 14850,1 14878,0 14921,1 14951,0 15049,1 15085,0 15130,1 15184,0 15213,1 15284,0 15382,1 15455,0 15536,1 15634,0 15663,1 15704,0 15705,1 15792,0 15794,1 15879,0 15971,1 16064,0 16146,1 16157,0 16247,1 16256,0 16331,1 16358,0 16391,1 16411,0 16462,1 16511,0 16539,1 16623,0 16651,1 16709,0 16800,1 16866,0 16894,1 16957,0 16964,1 17023,0 17068,1 17107,0 17168,1 17257,0 17285,1 17307,0 17344,1 17440,0 17497,1 17587,0 17596,1 17634,0 17640,1 17641,0 17740,1 17789,0 17808,1 17896,0 17955,1 18035,0 18115,1 18130,0 18169,1 18242,0 18280,1 18346,0 18379,1 18464,0 18515,1 18611,0 18698,1 18704,0 18733,1 18800,0 18828,1 18862,0 18899,1 18903,0 18994,1 19080,0 19154,1 19178,0 19256,1 19266,0 19323,1 19373,0 19465,1 19537,0 19575,1 19627,0 19641,1 19660,0 19712,1 19750,0 19845,1 19944,0 19986,1 20079,0 20170,1 20208,0 20220,1 20306,0 20309,1 20368,0 20422,1 20437,0 20481,1 20573,0 20575,1 20653,0 20693,1 20710,0 20747,1 20748,0 20817,1 20882,0 20887,1 20967,0 20975,1 21045,0 21054,1 21082,0 21134,1 21197,0 21268,1 21349,0 21413,1 21425,0 21456,1 21503,0 21588,1 21591,0 21649,1 21666,0 21732,1 21779,0 21862,1 21939,0 22013,1 22022,0 22102,1 22103,0 22146,1 22211,0 22231,1 22252,0 22272,1 22324,0 22336,1 22365,0 22413,1 22442,0 22532,1 22583,0 22643,1 22654,0 22662,1 22756,0 22799,1 22857,0 22955,1 22976,0 23028,1 23055,0 23117,1 23169,0 23255,1 23305,0 23352,1 23358,0 23393,1 23493,0 23507,1 23560,0 23646,1 23734,0 23736,1 23824,0 23892,1 23967,0 24006,1 24009,0 24012,1 24092,0 24101,1 24112,0 24201,1 24226,0 24289,1 24314,0 24326,1 24347,0 24437,1 24506,0 24570,1 24660,0 24729,1 24802,0 24815,1 24825,0 24852,1 24869,0 24880,1 24889,0 24890,1 24957,0 25012,1 25103,0 25172,1 25257,0 25334,1 25340,0 25397,1 25469,0 25486,1 25513,0 25574,1 25585,0 25653,1 25675,0 25724,1 25770,0 25812,1 25905,0 25977,1 26023,0 26082,1 26102,0 26183,1 26276,0 26311,1 26343,0 26418,1 26469,0 26567,1 26570,0 26668,1 26670,0 26765,1 26830,0 26884,1 26943,0 27025,1 27105,0 27108,1 27166,0 27208,1 27301,0 27364,1 27456,0 27539,1 27561,0 27591,1 27611,0 27615,1 27642,0 27706,1 27707,0 27740,1 27772,0 27777,1 27859,0 27863,1 27903,0 27918,1 27955,0 27967,1 27999,0 28005,1 28086,0 28170,1 28196,0 28283,1 28356,0 28393,1 28422,0 28462,1 28523,0 28557,1 28599,0 28607,1 28698,0 28740,1 28832,0 28908,1 28993,0 29031,1 29055,0 29058,1 29105,0 29142,1 29166,0 29198,1 29260,0 29275,1 29297,0 29369,1 29465,0 29494,1 29518,0 29529,1 29602,0 29702,1 29708,0 29781,1 29846,0 29929,1 29940,0 30009,1 30094,0 30139,1 30151,0 30237,1 30300,0 30388,1 30441,0 30520,1 30607,0 30625,1 30630,0 30693,1 30762,0 30801,1 30894,0 30983,1 31001,0 31018,1 31044,0 31131,1 31181,0 31270,1 31323,0 31413,1 31458,0 31463,1 31531,0 31602,1 31665,0 31670,1 31744,0 31777,1 31779,0 31823,1 31854,0 31859,1 31892,0 31907,1 31980,0 32068,1 32089,0 32163,1 32178,0 32180,1 32203,0 32297,1 32313,0 32334,1 32415,0 32487,1 32528,0 32588,1 32668,0 32696,1 32732,0 32808,1 32859,0 32876,1 32939,0 32962,1 32988,0 33020,1 33030,0 33113,1 33122,0 33169,1 33211,0 33282,1 33304,0 33328,1 33354,0 33450,1 33473,0 33492,1 33501,0 33579,1 33642,0 33712,1 33751,0 33793,1 33816,0 33861,1 33902,0 33981,1 34059,0 34135,1 34142,0 34237,1 34333,0 34433,1 34439,0 34503,1 34536,0 34545,1 34594,0 34629,1 34656,0 34723,1 34728,0 34801,1 34891,0 34974,1 35019,0 35070,1 35144,0 35170,1 35241,0 35318,1 35381,0 35472,1 35509,0 35527,1 35551,0 35603,1 35611,0 35686,1 35739,0 35827,1 35843,0 35893,1 35924,0 35967,1 35971,0 36060,1 36147,0 36157,1 36199,0 36284,1 36383,0 36457,1 36479,0 36505,1 36570,0 36600,1 36631,0 36654,1 36704,0 36717,1 36736,0 36755,1 36825,0 36857,1 36941,0 36957,1 37009,0 37034,1 37046,0 37112,1 37142,0 37176,1 37183,0 37274,1 37306,0 37368,1 37467,0 37471,1 37554,0 37593,1 37680,0 37693,1 37709,0 37794,1 37819,0 37840,1 37920,0 37992,1 38054,0 38138,1 38224,0 38298,1 38341,0 38420,1 38464,0 38495,1 38588,0 38681,1 38697,0 38743,1 38822,0 38846,1 38851,0 38874,1 38894,0 38912,1 38918,0 38996,1 39056,0 39085,1 39172,0 39230,1 39267,0 39322,1 39376,0 39420,1 39512,0 39545,1 39548,0 39586,1 39638,0 39694,1 39785,0 39808,1 39830,0 39905,1 39940,0 39995,1 40056,0 40099,1 40132,0 40225,1 40236,0 40267,1 40362,0 40450,1 40526,0 40608,1 40682,0 40715,1 40805,0 40896,1 40967,0 40974,1 41030,0 41085,1 41125,0 41178,1 41206,0 41232,1 41300,0 41324,1 41341,0 41408,1 41470,0 41557,1 41633,0 41715,1 41763,0 41841,1 41933,0 42017,1 42081,0 42138,1 42234,0 42297,1 42330,0 42337,1 42418,0 42428,1 42520,0 42592,1 42683,0 42743,1 42812,0 42868,1 42925,0 43011,1 43026,0 43111,1 43184,0 43218,1 43223,0 43305,1 43397,0 43467,1 43537,0 43634,1 43641,0 43646,1 43687,0 43708,1 43727,0 43739,1 43805,0 43873,1 43943,0 43998,1 44068,0 44150,1 44164,0 44197,1 44242,0 44307,1 44339,0 44423,1 44504,0 44541,1 44625,0 44681,1 44721,0 44762,1 44835,0 44860,1 44931,0 44946,1 44987,0 45067,1 45096,0 45140,1 45204,0 45286,1 45298,0 45397,1 45401,0 45486,1 45498,0 45593,1 45660,0 45760,1 45782,0 45832,1 45867,0 45909,1 45980,0 46077,1 46160,0 46223,1 46225,0 46245,1 46327,0 46404,1 46500,0 46596,1 46675,0 46717,1 46785,0 46799,1 46834,0 46901,1 46940,0 46970,1 47068,0 47118,1 47138,0 47162,1 47206,0 47282,1 47315,0 47371,1 47395,0 47424,1 47435,0 47498,1 47577,0 47609,1 47683,0 47781,1 47831,0 47850,1 47856,0 47924,1 47932,0 47957,1 47977,0 48068,1 48082,0 48120,1 48205,0 48296,1 48311,0 48378,1 48401,0 48473,1 48518,0 48545,1 48641,0 48671,1 48716,0 48777,1 48795,0 48891,1 48962,0 48986,1 49049,0 49139,1 49208,0 49297,1 49353,0 49394,1 49464,0 49478,1 49516,0 49542,1 49570,0 49628,1 49672,0 49685,1 end initlist a12 0,0 56,1 130,0 136,1 201,0 222,1 274,0 300,1 320,0 420,1 493,0 578,1 621,0 630,1 703,0 745,1 828,0 907,1 912,0 1012,1 1102,0 1109,1 1172,0 1207,1 1284,0 1304,1 1358,0 1429,1 1527,0 1585,1 1609,0 1677,1 1687,0 1787,1 1808,0 1855,1 1890,0 1906,1 1925,0 1934,1 1946,0 1959,1 2019,0 2099,1 2170,0 2255,1 2343,0 2398,1 2463,0 2553,1 2615,0 2698,1 2710,0 2807,1 2881,0 2973,1 3010,0 3086,1 3131,0 3212,1 3270,0 3360,1 3393,0 3422,1 3435,0 3470,1 3486,0 3554,1 3569,0 3628,1 3660,0 3672,1 3720,0 3799,1 3819,0 3907,1 3957,0 3996,1 4080,0 4172,1 4222,0 4226,1 4281,0 4332,1 4395,0 4436,1 4453,0 4550,1 4631,0 4713,1 4752,0 4818,1 4860,0 4918,1 4936,0 4946,1 5024,0 5120,1 5152,0 5158,1 5211,0 5300,1 5388,0 5399,1 5407,0 5462,1 5465,0 5550,1 5551,0 5632,1 5654,0 5700,1 5745,0 5803,1 5858,0 5869,1 5967,0 6027,1 6116,0 6185,1 6188,0 6272,1 6295,0 6392,1 6473,0 6474,1 6526,0 6573,1 6612,0 6640,1 6740,0 6824,1 6826,0 6877,1 6916,0 6950,1 7028,0 7089,1 7100,0 7105,1 7147,0 7161,1 7169,0 7234,1 7250,0 7296,1 7359,0 7387,1 7473,0 7573,1 7594,0 7603,1 7689,0 7754,1 7762,0 7776,1 7790,0 7842,1 7908,0 7981,1 8069,0 8103,1 8139,0 8178,1 8268,0 8302,1 8327,0 8408,1 8435,0 8451,1 8503,0 8520,1 8540,0 8579,1 8658,0 8669,1 8681,0 8725,1 8787,0 8849,1 8943,0 8994,1 9029,0 9099,1 9116,0 9154,1 9210,0 9249,1 9289,0 9317,1 9328,0 9387,1 9438,0 9468,1 9492,0 9522,1 9561,0 9612,1 9692,0 9696,1 9785,0 9843,1 9896,0 9936,1 10028,0 10115,1 10178,0 10219,1 10222,0 10295,1 10341,0 10342,1 10389,0 10451,1 10545,0 10550,1 10597,0 10649,1 10653,0 10710,1 10757,0 10813,1 10841,0 10934,1 10942,0 11024,1 11042,0 11112,1 11183,0 11213,1 11251,0 11333,1 11430,0 11520,1 11526,0 11565,1 11584,0 11681,1 11743,0 11794,1 11885,0 11942,1 12032,0 12081,1 12088,0 12151,1 12242,0 12283,1 12297,0 12351,1 12381,0 12477,1 12562,0 12647,1 12712,0 12764,1 12862,0 12920,1 13000,0 13022,1 13096,0 13143,1 13155,0 13220,1 13243,0 13265,1 13339,0 13404,1 13433,0 13464,1 13480,0 13521,1 13548,0 13587,1 13678,0 13689,1 13716,0 13795,1 13820,0 13859,1 13867,0 13923,1 13942,0 14019,1 14039,0 14080,1 14175,0 14202,1 14271,0 14318,1 14360,0 14393,1 14452,0 14526,1 14608,0 14614,1 14685,0 14715,1 14733,0 14803,1 14873,0 14906,1 14997,0 15044,1 15047,0 15120,1 15169,0 15190,1 15214,0 15277,1 15287,0 15367,1 15374,0 15443,1 15506,0 15579,1 15597,0 15670,1 15753,0 15773,1 15792,0 15803,1 15820,0 15851,1 15914,0 15980,1 16022,0 16087,1 16156,0 16173,1 16267,0 16339,1 16385,0 16398,1 16434,0 16524,1 16580,0 16661,1 16685,0 16762,1 16792,0 16803,1 16885,0 16921,1 16960,0 16994,1 17059,0 17087,1 17111,0 17142,1 17196,0 17203,1 17280,0 17374,1 17389,0 17439,1 17491,0 17546,1 17615,0 17621,1 17643,0 17732,1 17801,0 17898,1 17941,0 18039,1 18114,0 18206,1 18240,0 18330,1 18359,0 18380,1 18438,0 18535,1 18568,0 18631,1 18666,0 18682,1 18767,0 18858,1 18924,0 18969,1 18982,0 19057,1 19130,0 19190,1 19215,0 19245,1 19316,0 19319,1 19367,0 19424,1 19486,0 19512,1 19519,0 19580,1 19607,0 19695,1 19763,0 19774,1 19864,0 19894,1 19994,0 20009,1 20055,0 20147,1 20188,0 20269,1 20361,0 20372,1 20442,0 20448,1 20497,0 20529,1 20594,0 20606,1 20658,0 20755,1 20845,0 20880,1 20972,0 21014,1 21023,0 21089,1 21145,0 21227,1 21298,0 21331,1 21380,0 21461,1 21559,0 21602,1 21627,0 21637,1 21641,0 21716,1 21736,0 21744,1 21778,0 21861,1 21895,0 21902,1 21950,0 21967,1 22048,0 22147,1 22229,0 22313,1 22393,0 22442,1 22491,0 22548,1 22551,0 22631,1 22663,0 22688,1 22701,0 22771,1 22868,0 22912,1 22916,0 22935,1 22973,0 23014,1 23081,0 23137,1 23158,0 23248,1 23279,0 23293,1 23335,0 23355,1 23442,0 23491,1 23586,0 23621,1 23710,0 23796,1 23870,0 23931,1 24019,0 24028,1 24112,0 24138,1 24143,0 24146,1 24209,0 24293,1 24344,0 24422,1 24511,0 24587,1 24596,0 24681,1 24716,0 24717,1 24813,0 24851,1 24915,0 24919,1 24931,0 25020,1 25109,0 25131,1 25167,0 25235,1 25296,0 25309,1 25372,0 25463,1 25476,0 25503,1 25509,0 25549,1 25568,0 25580,1 25628,0 25655,1 25746,0 25780,1 25841,0 25909,1 25985,0 26069,1 26102,0 26130,1 26209,0 26278,1 26376,0 26412,1 26488,0 26575,1 26587,0 26628,1 26697,0 26790,1 26810,0 26828,1 26909,0 26994,1 27080,0 27127,1 27174,0 27215,1 27258,0 27322,1 27353,0 27390,1 27457,0 27511,1 27551,0 27636,1 27664,0 27675,1 27772,0 27785,1 27828,0 27870,1 27960,0 27971,1 28054,0 28071,1 28135,0 28193,1 28240,0 28300,1 28366,0 28409,1 28498,0 28567,1 28606,0 28622,1 28629,0 28704,1 28782,0 28865,1 28919,0 28988,1 29003,0 29074,1 29138,0 29222,1 29243,0 29249,1 29303,0 29307,1 29355,0 29401,1 29405,0 29472,1 29558,0 29563,1 29580,0 29622,1 29631,0 29642,1 29668,0 29714,1 29769,0 29862,1 29864,0 29874,1 29891,0 29900,1 29984,0 30070,1 30096,0 30145,1 30195,0 30292,1 30344,0 30387,1 30478,0 30499,1 30501,0 30565,1 30602,0 30621,1 30672,0 30709,1 30800,0 30846,1 30913,0 31009,1 31025,0 31104,1 31113,0 31194,1 31293,0 31356,1 31402,0 31415,1 31417,0 31423,1 31516,0 31551,1 31630,0 31699,1 31759,0 31796,1 31893,0 31927,1 31973,0 32006,1 32080,0 32116,1 32152,0 32173,1 32223,0 32259,1 32354,0 32440,1 32505,0 32514,1 32604,0 32677,1 32745,0 32805,1 32814,0 32828,1 32903,0 32975,1 32989,0 33033,1 33046,0 33117,1 33152,0 33160,1 33181,0 33199,1 33213,0 33282,1 33339,0 33433,1 33485,0 33567,1 33609,0 33644,1 33648,0 33688,1 33763,0 33772,1 33863,0 33957,1 34008,0 34016,1 34069,0 34076,1 34081,0 34109,1 34162,0 34253,1 34321,0 34409,1 34475,0 34518,1 34540,0 34631,1 34664,0 34749,1 34764,0 34811,1 34870,0 34889,1 34911,0 34914,1 34984,0 35065,1 35160,0 35229,1 35250,0 35289,1 35332,0 35348,1 35444,0 35502,1 35584,0 35660,1 35725,0 35745,1 35753,0 35788,1 35815,0 35853,1 35861,0 35881,1 35978,0 35991,1 36079,0 36137,1 36168,0 36189,1 36223,0 36275,1 36358,0 36425,1 36510,0 36575,1 36619,0 36702,1 36778,0 36832,1 36886,0 36941,1 36965,0 37009,1 37073,0 37125,1 37175,0 37221,1 37257,0 37259,1 37321,0 37358,1 37387,0 37486,1 37564,0 37591,1 37676,0 37736,1 37764,0 37833,1 37834,0 37868,1 37909,0 37961,1 37967,0 38029,1 38037,0 38086,1 38104,0 38187,1 38275,0 38321,1 38325,0 38382,1 38404,0 38453,1 38510,0 38555,1 38571,0 38656,1 38704,0 38769,1 38809,0 38840,1 38860,0 38954,1 38982,0 39045,1 39115,0 39151,1 39182,0 39202,1 39210,0 39248,1 39348,0 39423,1 39433,0 39446,1 39468,0 39509,1 39606,0 39635,1 39641,0 39644,1 39744,0 39821,1 39843,0 39902,1 39982,0 39984,1 40017,0 40108,1 40152,0 40203,1 40248,0 40335,1 40342,0 40383,1 40481,0 40522,1 40599,0 40600,1 40654,0 40724,1 40752,0 40833,1 40856,0 40892,1 40902,0 40988,1 41016,0 41034,1 41098,0 41101,1 41139,0 41159,1 41216,0 41294,1 41338,0 41397,1 41479,0 41501,1 41529,0 41542,1 41642,0 41704,1 41773,0 41803,1 41814,0 41873,1 41902,0 41981,1 42003,0 42081,1 42123,0 42130,1 42177,0 42221,1 42316,0 42365,1 42398,0 42428,1 42458,0 42556,1 42564,0 42591,1 42678,0 42721,1 42765,0 42810,1 42858,0 42957,1 43039,0 43109,1 43195,0 43216,1 43229,0 43291,1 43316,0 43330,1 43395,0 43435,1 43520,0 43587,1 43641,0 43670,1 43702,0 43776,1 43793,0 43852,1 43895,0 43924,1 43959,0 43967,1 44036,0 44040,1 44043,0 44088,1 44141,0 44200,1 44220,0 44235,1 44276,0 44376,1 44433,0 44466,1 44474,0 44477,1 44554,0 44642,1 44726,0 44770,1 44859,0 44959,1 45011,0 45029,1 45122,0 45137,1 45218,0 45221,1 45320,0 45399,1 45480,0 45521,1 45557,0 45620,1 45705,0 45709,1 45808,0 45830,1 45866,0 45931,1 46007,0 46035,1 46076,0 46157,1 46211,0 46283,1 46352,0 46372,1 46445,0 46482,1 46567,0 46659,1 46663,0 46756,1 46813,0 46853,1 46854,0 46937,1 47010,0 47016,1 47066,0 47129,1 47224,0 47249,1 47337,0 47416,1 47501,0 47568,1 47634,0 47658,1 47746,0 47752,1 47801,0 47817,1 47861,0 47938,1 48004,0 48009,1 48044,0 48122,1 48160,0 48224,1 48285,0 48344,1 48364,0 48385,1 48449,0 48535,1 48570,0 48609,1 48663,0 48743,1 48750,0 48777,1 48791,0 48867,1 48924,0 49006,1 49045,0 49140,1 49184,0 49205,1 49268,0 49275,1 49313,0 49328,1 49369,0 49454,1 end initlist a13 0,0 37,1 116,0 210,1 274,0 337,1 389,0 419,1 454,0 519,1 603,0 690,1 729,0 780,1 823,0 875,1 935,0 952,1 1050,0 1059,1 1159,0 1205,1 1246,0 1320,1 1388,0 1441,1 1497,0 1502,1 1560,0 1652,1 1666,0 1707,1 1805,0 1831,1 1909,0 1956,1 2049,0 2114,1 2208,0 2308,1 2310,0 2397,1 2439,0 2513,1 2572,0 2657,1 2748,0 2764,1 2852,0 2905,1 2941,0 3025,1 3041,0 3064,1 3164,0 3173,1 3242,0 3251,1 3303,0 3348,1 3349,0 3357,1 3383,0 3435,1 3502,0 3594,1 3609,0 3617,1 3644,0 3721,1 3776,0 3816,1 3846,0 3939,1 3955,0 3978,1 4047,0 4123,1 4147,0 4188,1 4227,0 4307,1 4368,0 4467,1 4517,0 4617,1 4631,0 4706,1 4731,0 4825,1 4901,0 4941,1 5012,0 5100,1 5102,0 5155,1 5206,0 5260,1 5324,0 5381,1 5382,0 5406,1 5438,0 5513,1 5543,0 5607,1 5700,0 5758,1 5775,0 5851,1 5868,0 5882,1 5936,0 5956,1 6007,0 6082,1 6142,0 6150,1 6171,0 6257,1 6271,0 6304,1 6346,0 6354,1 6392,0 6408,1 6462,0 6497,1 6594,0 6658,1 6734,0 6750,1 6768,0 6787,1 6887,0 6921,1 7009,0 7018,1 7094,0 7129,1 7184,0 7185,1 7283,0 7331,1 7360,0 7407,1 7447,0 7486,1 7546,0 7573,1 7578,0 7671,1 7675,0 7709,1 7788,0 7799,1 7894,0 7984,1 8019,0 8053,1 8058,0 8111,1 8143,0 8216,1 8271,0 8306,1 8375,0 8398,1 8452,0 8550,1 8589,0 8609,1 8619,0 8684,1 8734,0 8773,1 8792,0 8886,1 8971,0 9020,1 9094,0 9108,1 9120,0 9199,1 9251,0 9272,1 9296,0 9338,1 9400,0 9476,1 9498,0 9521,1 9545,0 9637,1 9716,0 9738,1 9777,0 9779,1 9879,0 9941,1 9965,0 9985,1 10007,0 10092,1 10160,0 10215,1 10252,0 10348,1 10440,0 10525,1 10566,0 10623,1 10713,0 10797,1 10840,0 10892,1 10920,0 10962,1 11053,0 11097,1 11122,0 11138,1 11193,0 11199,1 11234,0 11261,1 11273,0 11332,1 11360,0 11440,1 11496,0 11537,1 11608,0 11642,1 11674,0 11752,1 11797,0 11889,1 11906,0 11920,1 12016,0 12097,1 12098,0 12156,1 12199,0 12285,1 12289,0 12360,1 12373,0 12440,1 12505,0 12548,1 12638,0 12692,1 12769,0 12833,1 12897,0 12927,1 12957,0 13051,1 13118,0 13176,1 13178,0 13209,1 13273,0 13315,1 13406,0 13426,1 13503,0 13535,1 13616,0 13628,1 13714,0 13764,1 13806,0 13871,1 13965,0 13999,1 14038,0 14106,1 14117,0 14167,1 14228,0 14248,1 14332,0 14355,1 14394,0 14401,1 14478,0 14497,1 14533,0 14546,1 14601,0 14628,1 14668,0 14694,1 14734,0 14785,1 14865,0 14931,1 15026,0 15080,1 15151,0 15156,1 15207,0 15258,1 15293,0 15374,1 15423,0 15462,1 15471,0 15480,1 15516,0 15518,1 15540,0 15617,1 15672,0 15719,1 15817,0 15897,1 15911,0 16010,1 16031,0 16091,1 16159,0 16239,1 16334,0 16374,1 16444,0 16503,1 16541,0 16637,1 16657,0 16744,1 16777,0 16833,1 16843,0 16887,1 16956,0 17056,1 17116,0 17203,1 17271,0 17320,1 17339,0 17348,1 17424,0 17482,1 17513,0 17517,1 17597,0 17667,1 17767,0 17838,1 17924,0 17995,1 18007,0 18091,1 18123,0 18148,1 18215,0 18245,1 18296,0 18368,1 18408,0 18427,1 18473,0 18525,1 18535,0 18543,1 18573,0 18660,1 18734,0 18755,1 18827,0 18846,1 18933,0 19003,1 19028,0 19093,1 19166,0 19168,1 19207,0 19274,1 19366,0 19429,1 19478,0 19501,1 19527,0 19611,1 19645,0 19700,1 19798,0 19896,1 19994,0 20016,1 20024,0 20078,1 20158,0 20222,1 20299,0 20396,1 20493,0 20497,1 20567,0 20640,1 20726,0 20746,1 20804,0 20881,1 20888,0 20902,1 20990,0 21007,1 21088,0 21117,1 21126,0 21146,1 21233,0 21271,1 21280,0 21356,1 21453,0 21475,1 21503,0 21550,1 21642,0 21735,1 21760,0 21809,1 21850,0 21880,1 21972,0 22058,1 22157,0 22171,1 22199,0 22294,1 22333,0 22373,1 22385,0 22405,1 22483,0 22484,1 22521,0 22568,1 22653,0 22655,1 22752,0 22782,1 22847,0 22849,1 22854,0 22859,1 22957,0 22959,1 23035,0 23070,1 23139,0 23167,1 23210,0 23300,1 23336,0 23357,1 23361,0 23436,1 23515,0 23534,1 23633,0 23673,1 23731,0 23806,1 23888,0 23916,1 23989,0 23994,1 24094,0 24122,1 24207,0 24250,1 24323,0 24326,1 24334,0 24375,1 24384,0 24430,1 24503,0 24541,1 24545,0 24633,1 24714,0 24732,1 24783,0 24843,1 24869,0 24902,1 24971,0 25038,1 25060,0 25147,1 25149,0 25196,1 25255,0 25342,1 25351,0 25385,1 25474,0 25565,1 25603,0 25662,1 25711,0 25803,1 25806,0 25884,1 25928,0 25932,1 25964,0 25967,1 26035,0 26119,1 26128,0 26155,1 26184,0 26250,1 26328,0 26368,1 26377,0 26435,1 26471,0 26482,1 26578,0 26590,1 26613,0 26685,1 26705,0 26755,1 26785,0 26871,1 26909,0 26973,1 26986,0 27079,1 27103,0 27156,1 27227,0 27327,1 27328,0 27339,1 27419,0 27505,1 27512,0 27581,1 27637,0 27726,1 27728,0 27765,1 27852,0 27853,1 27927,0 28012,1 28058,0 28082,1 28134,0 28187,1 28230,0 28252,1 28254,0 28296,1 28321,0 28392,1 28422,0 28438,1 28443,0 28486,1 28563,0 28594,1 28663,0 28669,1 28746,0 28756,1 28761,0 28774,1 28801,0 28827,1 28835,0 28895,1 28960,0 28983,1 29065,0 29098,1 29196,0 29271,1 29359,0 29423,1 29459,0 29480,1 29542,0 29580,1 29644,0 29669,1 29757,0 29847,1 29873,0 29891,1 29972,0 30021,1 30116,0 30175,1 30251,0 30348,1 30402,0 30489,1 30550,0 30637,1 30664,0 30700,1 30708,0 30714,1 30754,0 30830,1 30833,0 30894,1 30908,0 30980,1 31046,0 31142,1 31204,0 31241,1 31302,0 31382,1 31393,0 31457,1 31534,0 31577,1 31590,0 31610,1 31684,0 31737,1 31827,0 31925,1 32002,0 32012,1 32108,0 32206,1 32237,0 32238,1 32330,0 32372,1 32415,0 32445,1 32486,0 32559,1 32602,0 32702,1 32714,0 32800,1 32818,0 32918,1 33014,0 33048,1 33097,0 33159,1 33208,0 33253,1 33323,0 33396,1 33459,0 33543,1 33641,0 33686,1 33745,0 33767,1 33817,0 33891,1 33971,0 34017,1 34082,0 34097,1 34124,0 34196,1 34267,0 34273,1 34281,0 34329,1 34367,0 34464,1 34483,0 34489,1 34538,0 34616,1 34619,0 34655,1 34711,0 34794,1 34863,0 34888,1 34893,0 34903,1 35000,0 35027,1 35110,0 35130,1 35177,0 35247,1 35248,0 35329,1 35349,0 35430,1 35512,0 35573,1 35639,0 35672,1 35698,0 35749,1 35832,0 35876,1 35971,0 35984,1 35997,0 36090,1 36110,0 36208,1 36214,0 36294,1 36306,0 36325,1 36359,0 36436,1 36469,0 36547,1 36593,0 36595,1 36645,0 36734,1 36803,0 36896,1 36969,0 36987,1 37007,0 37061,1 37153,0 37171,1 37261,0 37284,1 37367,0 37446,1 37541,0 37585,1 37669,0 37760,1 37770,0 37772,1 37817,0 37857,1 37956,0 37977,1 38044,0 38144,1 38145,0 38221,1 38265,0 38269,1 38286,0 38365,1 38456,0 38476,1 38507,0 38567,1 38658,0 38693,1 38715,0 38793,1 38870,0 38894,1 38914,0 38915,1 38926,0 39005,1 39091,0 39106,1 39172,0 39232,1 39320,0 39400,1 39445,0 39527,1 39612,0 39673,1 39771,0 39827,1 39866,0 39944,1 39957,0 40045,1 40083,0 40163,1 40165,0 40187,1 40204,0 40270,1 40362,0 40424,1 40503,0 40557,1 40643,0 40691,1 40715,0 40799,1 40873,0 40959,1 40999,0 41035,1 41131,0 41163,1 41249,0 41344,1 41360,0 41438,1 41496,0 41576,1 41632,0 41676,1 41769,0 41802,1 41820,0 41896,1 41934,0 42033,1 42052,0 42110,1 42174,0 42263,1 42349,0 42411,1 42439,0 42442,1 42539,0 42541,1 42632,0 42730,1 42756,0 42825,1 42883,0 42918,1 42969,0 43001,1 43039,0 43079,1 43124,0 43207,1 43222,0 43314,1 43320,0 43360,1 43391,0 43490,1 43570,0 43660,1 43741,0 43820,1 43920,0 43935,1 43948,0 44007,1 44008,0 44054,1 44139,0 44201,1 44298,0 44316,1 44343,0 44397,1 44455,0 44474,1 44506,0 44517,1 44553,0 44572,1 44654,0 44724,1 44771,0 44846,1 44859,0 44938,1 44942,0 44968,1 45011,0 45100,1 45168,0 45238,1 45279,0 45361,1 45380,0 45461,1 45505,0 45576,1 45635,0 45639,1 45677,0 45760,1 45774,0 45827,1 45841,0 45929,1 45958,0 46009,1 46082,0 46150,1 46165,0 46209,1 46211,0 46227,1 46272,0 46286,1 46333,0 46413,1 46473,0 46500,1 46529,0 46541,1 46573,0 46634,1 46674,0 46681,1 46683,0 46781,1 46864,0 46875,1 46914,0 46924,1 46994,0 46996,1 47078,0 47154,1 47239,0 47253,1 47307,0 47406,1 47436,0 47466,1 47493,0 47587,1 47638,0 47661,1 47736,0 47739,1 47825,0 47868,1 47914,0 47960,1 47990,0 48043,1 48142,0 48162,1 48182,0 48189,1 48259,0 48273,1 48280,0 48310,1 48383,0 48432,1 48501,0 48505,1 48557,0 48625,1 48700,0 48748,1 48830,0 48868,1 48932,0 48999,1 49014,0 49091,1 49191,0 49268,1 49302,0 49385,1 49407,0 49430,1 49522,0 49581,1 49627,0 49679,1 49777,0 49849,1 49923,0 49972,1 50007,0 50014,1 50112,0 50130,1 50149,0 50153,1 50232,0 50293,1 50323,0 50333,1 50414,0 50454,1 50476,0 50565,1 end initlist a14 0,0 18,1 26,0 72,1 166,0 239,1 285,0 334,1 370,0 448,1 517,0 535,1 630,0 641,1 653,0 702,1 775,0 793,1 871,0 964,1 985,0 1002,1 1045,0 1121,1 1189,0 1218,1 1290,0 1361,1 1448,0 1539,1 1621,0 1683,1 1735,0 1768,1 1832,0 1882,1 1929,0 1932,1 1946,0 2037,1 2057,0 2086,1 2116,0 2177,1 2261,0 2304,1 2308,0 2386,1 2418,0 2442,1 2462,0 2537,1 2595,0 2614,1 2693,0 2769,1 2795,0 2801,1 2866,0 2965,1 3039,0 3078,1 3105,0 3140,1 3172,0 3244,1 3271,0 3307,1 3343,0 3423,1 3457,0 3469,1 3471,0 3555,1 3620,0 3656,1 3747,0 3796,1 3812,0 3907,1 3944,0 4026,1 4114,0 4210,1 4304,0 4384,1 4387,0 4398,1 4452,0 4462,1 4472,0 4549,1 4591,0 4603,1 4671,0 4755,1 4835,0 4919,1 5014,0 5053,1 5149,0 5171,1 5233,0 5258,1 5297,0 5376,1 5448,0 5541,1 5548,0 5564,1 5655,0 5658,1 5699,0 5734,1 5771,0 5827,1 5874,0 5951,1 6031,0 6076,1 6163,0 6210,1 6297,0 6396,1 6438,0 6529,1 6579,0 6647,1 6674,0 6741,1 6804,0 6844,1 6863,0 6885,1 6907,0 6913,1 6960,0 6991,1 7000,0 7003,1 7042,0 7094,1 7192,0 7261,1 7312,0 7351,1 7359,0 7403,1 7468,0 7544,1 7557,0 7613,1 7620,0 7630,1 7703,0 7755,1 7772,0 7820,1 7845,0 7907,1 7956,0 8044,1 8087,0 8102,1 8116,0 8152,1 8198,0 8244,1 8262,0 8268,1 8321,0 8367,1 8420,0 8427,1 8435,0 8455,1 8534,0 8629,1 8656,0 8752,1 8825,0 8897,1 8990,0 9053,1 9153,0 9243,1 9320,0 9400,1 9482,0 9549,1 9594,0 9607,1 9617,0 9710,1 9759,0 9822,1 9880,0 9921,1 9966,0 9976,1 10007,0 10051,1 10084,0 10115,1 10128,0 10180,1 10181,0 10189,1 10278,0 10283,1 10382,0 10432,1 10470,0 10501,1 10599,0 10687,1 10719,0 10800,1 10893,0 10913,1 10954,0 10982,1 10987,0 11068,1 11104,0 11174,1 11184,0 11239,1 11318,0 11347,1 11402,0 11464,1 11469,0 11567,1 11579,0 11581,1 11652,0 11689,1 11757,0 11758,1 11773,0 11777,1 11826,0 11883,1 11973,0 12070,1 12076,0 12172,1 12264,0 12281,1 12293,0 12349,1 12413,0 12424,1 12437,0 12466,1 12543,0 12552,1 12606,0 12672,1 12707,0 12788,1 12806,0 12897,1 12945,0 12980,1 13019,0 13116,1 13181,0 13281,1 13331,0 13363,1 13438,0 13451,1 13507,0 13601,1 13660,0 13755,1 13803,0 13875,1 13936,0 14031,1 14073,0 14099,1 14102,0 14173,1 14190,0 14199,1 14292,0 14308,1 14319,0 14347,1 14371,0 14434,1 14470,0 14567,1 14618,0 14663,1 14709,0 14788,1 14840,0 14907,1 14984,0 15067,1 15112,0 15180,1 15225,0 15249,1 15327,0 15418,1 15495,0 15580,1 15621,0 15661,1 15745,0 15799,1 15879,0 15902,1 15957,0 16055,1 16081,0 16096,1 16189,0 16257,1 16341,0 16359,1 16412,0 16502,1 16574,0 16591,1 16619,0 16640,1 16699,0 16787,1 16823,0 16856,1 16894,0 16965,1 17031,0 17097,1 17190,0 17253,1 17335,0 17409,1 17419,0 17464,1 17492,0 17536,1 17628,0 17726,1 17793,0 17814,1 17817,0 17831,1 17925,0 17991,1 18024,0 18095,1 18115,0 18153,1 18222,0 18241,1 18295,0 18368,1 18441,0 18522,1 18560,0 18585,1 18631,0 18647,1 18669,0 18680,1 18724,0 18739,1 18749,0 18779,1 18821,0 18882,1 18979,0 19063,1 19068,0 19090,1 19114,0 19140,1 19158,0 19210,1 19270,0 19362,1 19456,0 19478,1 19563,0 19595,1 19619,0 19664,1 19732,0 19801,1 19833,0 19931,1 19956,0 19963,1 20041,0 20080,1 20082,0 20121,1 20167,0 20177,1 20218,0 20318,1 20369,0 20430,1 20441,0 20459,1 20519,0 20572,1 20598,0 20652,1 20707,0 20720,1 20807,0 20877,1 20936,0 21010,1 21074,0 21077,1 21089,0 21162,1 21179,0 21205,1 21277,0 21377,1 21446,0 21540,1 21607,0 21648,1 21697,0 21791,1 21839,0 21888,1 21951,0 22036,1 22132,0 22184,1 22186,0 22219,1 22285,0 22328,1 22338,0 22391,1 22465,0 22488,1 22573,0 22595,1 22635,0 22666,1 22703,0 22756,1 22824,0 22904,1 22980,0 23058,1 23129,0 23199,1 23202,0 23299,1 23369,0 23405,1 23442,0 23497,1 23590,0 23644,1 23647,0 23707,1 23721,0 23781,1 23826,0 23837,1 23849,0 23911,1 23940,0 24029,1 24082,0 24092,1 24160,0 24192,1 24255,0 24287,1 24315,0 24351,1 24437,0 24510,1 24603,0 24612,1 24654,0 24666,1 24726,0 24804,1 24842,0 24911,1 24996,0 25059,1 25107,0 25125,1 25192,0 25279,1 25298,0 25364,1 25411,0 25502,1 25554,0 25601,1 25645,0 25646,1 25734,0 25782,1 25799,0 25892,1 25932,0 25995,1 26000,0 26060,1 26090,0 26167,1 26198,0 26210,1 26239,0 26244,1 26277,0 26345,1 26427,0 26495,1 26573,0 26621,1 26666,0 26710,1 26732,0 26787,1 26801,0 26815,1 26860,0 26959,1 26984,0 26994,1 27081,0 27135,1 27179,0 27242,1 27302,0 27383,1 27471,0 27475,1 27543,0 27573,1 27648,0 27690,1 27729,0 27777,1 27830,0 27866,1 27910,0 27928,1 27932,0 27985,1 28014,0 28022,1 28103,0 28151,1 28242,0 28249,1 28333,0 28401,1 28464,0 28558,1 28595,0 28662,1 28693,0 28729,1 28800,0 28830,1 28862,0 28863,1 28895,0 28942,1 29003,0 29019,1 29065,0 29067,1 29075,0 29114,1 29170,0 29255,1 29298,0 29303,1 29329,0 29417,1 29454,0 29543,1 29579,0 29650,1 29746,0 29842,1 29941,0 29987,1 30068,0 30142,1 30224,0 30266,1 30302,0 30354,1 30422,0 30445,1 30496,0 30561,1 30608,0 30660,1 30721,0 30788,1 30792,0 30840,1 30904,0 30958,1 31056,0 31058,1 31158,0 31231,1 31316,0 31404,1 31405,0 31425,1 31478,0 31512,1 31522,0 31550,1 31636,0 31732,1 31795,0 31894,1 31925,0 31996,1 32001,0 32064,1 32079,0 32139,1 32208,0 32251,1 32336,0 32414,1 32511,0 32554,1 32579,0 32648,1 32689,0 32721,1 32776,0 32796,1 32838,0 32872,1 32900,0 32970,1 32987,0 33036,1 33066,0 33076,1 33133,0 33169,1 33197,0 33250,1 33343,0 33422,1 33465,0 33560,1 33565,0 33584,1 33628,0 33629,1 33671,0 33715,1 33759,0 33809,1 33858,0 33951,1 33971,0 34065,1 34163,0 34257,1 34321,0 34388,1 34463,0 34464,1 34528,0 34584,1 34623,0 34649,1 34722,0 34767,1 34782,0 34823,1 34848,0 34889,1 34963,0 35039,1 35102,0 35155,1 35166,0 35207,1 35295,0 35334,1 35414,0 35489,1 35513,0 35613,1 35688,0 35746,1 35796,0 35802,1 35810,0 35909,1 35980,0 35999,1 36053,0 36128,1 36156,0 36175,1 36198,0 36295,1 36359,0 36441,1 36525,0 36564,1 36637,0 36687,1 36721,0 36791,1 36822,0 36873,1 36880,0 36978,1 37044,0 37094,1 37105,0 37124,1 37141,0 37179,1 37193,0 37204,1 37298,0 37354,1 37448,0 37530,1 37559,0 37604,1 37641,0 37714,1 37808,0 37898,1 37927,0 37969,1 38063,0 38112,1 38150,0 38228,1 38251,0 38311,1 38404,0 38440,1 38518,0 38568,1 38579,0 38605,1 38650,0 38678,1 38700,0 38703,1 38793,0 38805,1 38825,0 38854,1 38949,0 38996,1 39038,0 39075,1 39170,0 39261,1 39344,0 39354,1 39356,0 39454,1 39462,0 39480,1 39485,0 39524,1 39573,0 39637,1 39679,0 39720,1 39760,0 39855,1 39900,0 39916,1 39977,0 40026,1 40064,0 40144,1 40162,0 40242,1 40245,0 40330,1 40403,0 40503,1 40566,0 40593,1 40644,0 40733,1 40813,0 40881,1 40927,0 40936,1 40972,0 41046,1 41100,0 41155,1 41251,0 41312,1 41316,0 41372,1 41434,0 41436,1 41503,0 41572,1 41641,0 41728,1 41746,0 41784,1 41861,0 41878,1 41938,0 42033,1 42050,0 42052,1 42074,0 42132,1 42199,0 42240,1 42307,0 42312,1 42411,0 42476,1 42575,0 42658,1 42668,0 42755,1 42787,0 42840,1 42881,0 42960,1 43039,0 43124,1 43155,0 43169,1 43186,0 43194,1 43201,0 43220,1 43255,0 43329,1 43355,0 43446,1 43463,0 43543,1 43579,0 43663,1 43763,0 43824,1 43900,0 43998,1 44056,0 44146,1 44211,0 44283,1 44343,0 44377,1 44392,0 44443,1 44516,0 44546,1 44621,0 44643,1 44658,0 44721,1 44768,0 44843,1 44935,0 44960,1 44986,0 45021,1 45067,0 45118,1 45188,0 45220,1 45319,0 45335,1 45376,0 45476,1 45551,0 45639,1 45721,0 45817,1 45878,0 45910,1 46006,0 46042,1 46093,0 46118,1 46184,0 46242,1 46294,0 46367,1 46454,0 46539,1 46587,0 46610,1 46611,0 46674,1 46738,0 46739,1 46760,0 46809,1 46822,0 46898,1 46934,0 46970,1 46975,0 47011,1 47071,0 47144,1 47218,0 47305,1 47389,0 47449,1 47524,0 47549,1 47609,0 47616,1 47671,0 47741,1 47752,0 47827,1 47848,0 47889,1 47967,0 48065,1 48111,0 48158,1 48253,0 48275,1 48327,0 48330,1 48343,0 48351,1 48449,0 48462,1 48463,0 48514,1 48560,0 48652,1 48679,0 48742,1 48779,0 48815,1 48868,0 48909,1 48946,0 48988,1 49013,0 49053,1 49059,0 49159,1 49200,0 49283,1 49320,0 49388,1 49417,0 49504,1 49595,0 49611,1 49689,0 49724,1 49734,0 49797,1 49860,0 49960,1 50053,0 50084,1 50105,0 50114,1 50206,0 50261,1 50337,0 50417,1 50467,0 50526,1 50572,0 50601,1 end initlist a15 0,0 27,1 116,0 180,1 251,0 329,1 371,0 436,1 508,0 545,1 568,0 610,1 613,0 690,1 744,0 791,1 825,0 891,1 968,0 1042,1 1120,0 1190,1 1275,0 1329,1 1389,0 1477,1 1572,0 1599,1 1679,0 1689,1 1740,0 1755,1 1774,0 1836,1 1843,0 1896,1 1948,0 1957,1 2035,0 2118,1 2185,0 2193,1 2259,0 2339,1 2387,0 2435,1 2436,0 2513,1 2611,0 2696,1 2759,0 2761,1 2817,0 2917,1 2920,0 2926,1 2980,0 3077,1 3157,0 3164,1 3252,0 3310,1 3373,0 3430,1 3529,0 3556,1 3607,0 3631,1 3700,0 3720,1 3735,0 3753,1 3787,0 3800,1 3859,0 3937,1 3993,0 4042,1 4113,0 4120,1 4201,0 4274,1 4314,0 4372,1 4389,0 4470,1 4480,0 4540,1 4561,0 4567,1 4625,0 4685,1 4689,0 4743,1 4837,0 4901,1 4996,0 5080,1 5106,0 5123,1 5128,0 5201,1 5236,0 5297,1 5394,0 5395,1 5474,0 5542,1 5624,0 5650,1 5686,0 5743,1 5780,0 5792,1 5854,0 5884,1 5975,0 6011,1 6072,0 6115,1 6116,0 6184,1 6250,0 6345,1 6380,0 6400,1 6440,0 6450,1 6472,0 6498,1 6590,0 6671,1 6769,0 6788,1 6844,0 6908,1 6949,0 7024,1 7106,0 7169,1 7217,0 7251,1 7257,0 7264,1 7335,0 7368,1 7445,0 7518,1 7576,0 7605,1 7609,0 7674,1 7748,0 7750,1 7762,0 7781,1 7791,0 7810,1 7860,0 7894,1 7899,0 7900,1 7927,0 8005,1 8044,0 8134,1 8208,0 8253,1 8281,0 8336,1 8405,0 8457,1 8543,0 8635,1 8666,0 8761,1 8841,0 8862,1 8906,0 8943,1 9043,0 9087,1 9133,0 9228,1 9260,0 9287,1 9371,0 9385,1 9412,0 9416,1 9465,0 9539,1 9544,0 9631,1 9699,0 9735,1 9795,0 9876,1 9894,0 9940,1 10037,0 10118,1 10123,0 10191,1 10239,0 10286,1 10377,0 10469,1 10502,0 10561,1 10625,0 10686,1 10779,0 10857,1 10928,0 10949,1 11010,0 11069,1 11113,0 11210,1 11284,0 11290,1 11346,0 11430,1 11441,0 11481,1 11576,0 11580,1 11654,0 11724,1 11800,0 11900,1 11982,0 12010,1 12051,0 12105,1 12114,0 12203,1 12220,0 12305,1 12340,0 12437,1 12515,0 12610,1 12659,0 12664,1 12704,0 12737,1 12798,0 12837,1 12876,0 12894,1 12981,0 13072,1 13142,0 13146,1 13186,0 13269,1 13274,0 13327,1 13421,0 13455,1 13504,0 13560,1 13564,0 13614,1 13696,0 13702,1 13732,0 13802,1 13803,0 13840,1 13866,0 13937,1 14019,0 14020,1 14106,0 14160,1 14209,0 14210,1 14283,0 14308,1 14399,0 14448,1 14531,0 14582,1 14643,0 14665,1 14763,0 14839,1 14863,0 14946,1 14954,0 14956,1 15024,0 15031,1 15117,0 15154,1 15220,0 15241,1 15274,0 15350,1 15381,0 15446,1 15514,0 15554,1 15653,0 15726,1 15785,0 15839,1 15915,0 15984,1 16034,0 16046,1 16069,0 16075,1 16099,0 16171,1 16190,0 16264,1 16319,0 16340,1 16351,0 16426,1 16462,0 16463,1 16496,0 16573,1 16622,0 16632,1 16716,0 16724,1 16741,0 16745,1 16760,0 16842,1 16912,0 16988,1 17061,0 17100,1 17113,0 17202,1 17277,0 17320,1 17347,0 17368,1 17415,0 17480,1 17544,0 17576,1 17585,0 17634,1 17716,0 17774,1 17871,0 17922,1 17958,0 18001,1 18029,0 18043,1 18064,0 18082,1 18099,0 18114,1 18206,0 18298,1 18332,0 18401,1 18497,0 18562,1 18582,0 18663,1 18666,0 18694,1 18760,0 18767,1 18811,0 18823,1 18914,0 18928,1 18951,0 19024,1 19116,0 19146,1 19239,0 19327,1 19346,0 19420,1 19423,0 19424,1 19470,0 19510,1 19537,0 19616,1 19623,0 19642,1 19704,0 19755,1 19838,0 19938,1 19947,0 20019,1 20023,0 20061,1 20091,0 20156,1 20230,0 20247,1 20308,0 20379,1 20380,0 20465,1 20507,0 20515,1 20558,0 20588,1 20644,0 20725,1 20813,0 20870,1 20872,0 20902,1 20904,0 20911,1 20914,0 20935,1 20980,0 21003,1 21013,0 21064,1 21108,0 21111,1 21119,0 21132,1 21196,0 21226,1 21268,0 21298,1 21354,0 21382,1 21414,0 21427,1 21487,0 21524,1 21593,0 21692,1 21731,0 21807,1 21818,0 21846,1 21895,0 21914,1 21920,0 21993,1 22036,0 22046,1 22125,0 22191,1 22194,0 22220,1 22266,0 22279,1 22316,0 22395,1 22485,0 22566,1 22634,0 22691,1 22753,0 22759,1 22840,0 22851,1 22913,0 22977,1 23077,0 23096,1 23119,0 23193,1 23236,0 23319,1 23369,0 23433,1 23519,0 23561,1 23627,0 23643,1 23699,0 23706,1 23797,0 23816,1 23884,0 23978,1 24035,0 24087,1 24095,0 24139,1 24150,0 24246,1 24269,0 24294,1 24367,0 24393,1 24397,0 24483,1 24517,0 24579,1 24608,0 24678,1 24768,0 24777,1 24834,0 24912,1 24922,0 24960,1 24962,0 25037,1 25119,0 25146,1 25215,0 25312,1 25375,0 25470,1 25505,0 25509,1 25515,0 25539,1 25545,0 25586,1 25658,0 25757,1 25761,0 25812,1 25836,0 25911,1 25991,0 26045,1 26057,0 26090,1 26129,0 26141,1 26240,0 26290,1 26368,0 26375,1 26398,0 26461,1 26516,0 26563,1 26571,0 26609,1 26656,0 26754,1 26769,0 26819,1 26910,0 27008,1 27054,0 27080,1 27162,0 27230,1 27330,0 27396,1 27441,0 27522,1 27531,0 27594,1 27679,0 27723,1 27736,0 27818,1 27856,0 27932,1 27956,0 27965,1 27976,0 28076,1 28161,0 28256,1 28327,0 28348,1 28404,0 28423,1 28516,0 28607,1 28652,0 28710,1 28770,0 28864,1 28946,0 28948,1 29025,0 29103,1 29163,0 29242,1 29287,0 29387,1 29441,0 29454,1 29524,0 29580,1 29643,0 29710,1 29777,0 29795,1 29872,0 29959,1 30052,0 30071,1 30147,0 30155,1 30160,0 30212,1 30255,0 30351,1 30375,0 30440,1 30472,0 30553,1 30599,0 30619,1 30660,0 30757,1 30806,0 30904,1 30960,0 30963,1 31002,0 31059,1 31142,0 31156,1 31177,0 31201,1 31211,0 31296,1 31329,0 31406,1 31422,0 31500,1 31575,0 31633,1 31635,0 31733,1 31818,0 31917,1 31941,0 31993,1 32065,0 32086,1 32103,0 32195,1 32227,0 32327,1 32422,0 32446,1 32514,0 32528,1 32593,0 32626,1 32711,0 32775,1 32863,0 32954,1 33012,0 33082,1 33117,0 33156,1 33185,0 33195,1 33239,0 33240,1 33253,0 33282,1 33373,0 33440,1 33540,0 33570,1 33645,0 33720,1 33768,0 33846,1 33851,0 33945,1 34014,0 34077,1 34171,0 34245,1 34305,0 34387,1 34451,0 34488,1 34500,0 34529,1 34607,0 34650,1 34685,0 34770,1 34777,0 34798,1 34871,0 34948,1 34982,0 34993,1 35003,0 35004,1 35007,0 35057,1 35131,0 35216,1 35280,0 35377,1 35410,0 35452,1 35492,0 35574,1 35609,0 35619,1 35665,0 35700,1 35725,0 35823,1 35908,0 35976,1 36060,0 36116,1 36159,0 36251,1 36330,0 36420,1 36462,0 36532,1 36560,0 36567,1 36606,0 36642,1 36720,0 36750,1 36850,0 36874,1 36957,0 36990,1 37055,0 37129,1 37168,0 37247,1 37256,0 37263,1 37345,0 37438,1 37448,0 37515,1 37607,0 37703,1 37764,0 37849,1 37876,0 37950,1 38029,0 38033,1 38064,0 38097,1 38107,0 38157,1 38206,0 38207,1 38226,0 38322,1 38371,0 38396,1 38425,0 38474,1 38532,0 38615,1 38683,0 38733,1 38819,0 38862,1 38873,0 38957,1 38997,0 39052,1 39094,0 39167,1 39222,0 39234,1 39246,0 39278,1 39357,0 39402,1 39442,0 39462,1 39493,0 39556,1 39595,0 39600,1 39608,0 39639,1 39706,0 39752,1 39851,0 39873,1 39940,0 40037,1 40066,0 40163,1 40192,0 40267,1 40322,0 40336,1 40398,0 40402,1 40425,0 40518,1 40556,0 40586,1 40630,0 40695,1 40701,0 40726,1 40814,0 40902,1 40953,0 41010,1 41106,0 41149,1 41216,0 41247,1 41287,0 41352,1 41400,0 41405,1 41432,0 41526,1 41600,0 41616,1 41677,0 41725,1 41734,0 41735,1 41794,0 41881,1 41939,0 42020,1 42103,0 42175,1 42223,0 42243,1 42318,0 42330,1 42399,0 42400,1 42440,0 42528,1 42569,0 42595,1 42644,0 42677,1 42775,0 42801,1 42874,0 42963,1 42991,0 42995,1 43038,0 43093,1 43103,0 43176,1 43200,0 43283,1 43346,0 43374,1 43460,0 43535,1 43614,0 43622,1 43700,0 43757,1 43834,0 43854,1 43896,0 43912,1 43986,0 44066,1 44111,0 44135,1 44179,0 44190,1 44224,0 44241,1 44339,0 44391,1 44472,0 44538,1 44569,0 44591,1 44609,0 44619,1 44682,0 44724,1 44779,0 44812,1 44829,0 44865,1 44924,0 44988,1 45041,0 45097,1 45170,0 45181,1 45241,0 45327,1 45411,0 45502,1 45569,0 45648,1 45685,0 45761,1 45777,0 45847,1 45939,0 45942,1 45944,0 46027,1 46045,0 46122,1 46194,0 46233,1 46269,0 46367,1 46403,0 46469,1 46534,0 46561,1 46648,0 46711,1 46786,0 46860,1 46912,0 46977,1 47037,0 47135,1 47155,0 47252,1 47339,0 47395,1 47476,0 47520,1 47557,0 47614,1 47635,0 47731,1 47746,0 47808,1 47866,0 47932,1 48001,0 48006,1 48036,0 48120,1 48129,0 48212,1 48264,0 48326,1 48350,0 48406,1 48501,0 48566,1 48622,0 48704,1 48763,0 48858,1 48880,0 48937,1 48944,0 48950,1 49021,0 49090,1 49176,0 49208,1 49244,0 49261,1 49295,0 49394,1 49456,0 49492,1 49569,0 49623,1 49716,0 49725,1 49810,0 49903,1 50002,0 50035,1 50043,0 50049,1 50143,0 50175,1 50195,0 50224,1 50297,0 50340,1 50397,0 50455,1 end initlist a16 0,0 96,1 180,0 194,1 227,0 238,1 309,0 334,1 351,0 391,1 469,0 480,1 533,0 591,1 685,0 712,1 780,0 861,1 889,0 893,1 952,0 1048,1 1095,0 1151,1 1205,0 1256,1 1259,0 1310,1 1377,0 1472,1 1548,0 1645,1 1660,0 1760,1 1838,0 1914,1 1987,0 2024,1 2028,0 2114,1 2154,0 2178,1 2214,0 2293,1 2348,0 2394,1 2453,0 2486,1 2510,0 2604,1 2682,0 2773,1 2779,0 2785,1 2862,0 2894,1 2942,0 2985,1 3054,0 3129,1 3185,0 3189,1 3242,0 3324,1 3374,0 3421,1 3423,0 3472,1 3525,0 3596,1 3645,0 3706,1 3784,0 3843,1 3844,0 3934,1 3990,0 4024,1 4092,0 4109,1 4195,0 4225,1 4315,0 4393,1 4431,0 4531,1 4619,0 4622,1 4681,0 4720,1 4762,0 4823,1 4891,0 4923,1 4965,0 5000,1 5013,0 5034,1 5036,0 5099,1 5188,0 5235,1 5266,0 5306,1 5381,0 5432,1 5532,0 5627,1 5631,0 5713,1 5729,0 5772,1 5867,0 5936,1 5966,0 6053,1 6079,0 6143,1 6167,0 6241,1 6251,0 6268,1 6284,0 6368,1 6410,0 6480,1 6544,0 6626,1 6669,0 6721,1 6765,0 6835,1 6839,0 6900,1 6938,0 7033,1 7106,0 7142,1 7155,0 7238,1 7292,0 7388,1 7418,0 7427,1 7433,0 7470,1 7526,0 7561,1 7621,0 7636,1 7638,0 7645,1 7682,0 7728,1 7803,0 7851,1 7894,0 7989,1 8088,0 8101,1 8148,0 8191,1 8204,0 8252,1 8295,0 8303,1 8328,0 8420,1 8431,0 8437,1 8514,0 8558,1 8653,0 8705,1 8731,0 8770,1 8790,0 8850,1 8923,0 9023,1 9067,0 9088,1 9104,0 9202,1 9235,0 9332,1 9347,0 9390,1 9457,0 9528,1 9628,0 9691,1 9763,0 9859,1 9879,0 9895,1 9940,0 9989,1 10004,0 10006,1 10039,0 10120,1 10148,0 10238,1 10279,0 10312,1 10408,0 10426,1 10439,0 10469,1 10481,0 10519,1 10576,0 10655,1 10731,0 10804,1 10835,0 10890,1 10895,0 10994,1 11029,0 11096,1 11167,0 11243,1 11274,0 11373,1 11451,0 11547,1 11563,0 11629,1 11720,0 11757,1 11808,0 11818,1 11824,0 11827,1 11868,0 11965,1 12044,0 12082,1 12142,0 12204,1 12212,0 12276,1 12328,0 12330,1 12370,0 12402,1 12468,0 12532,1 12588,0 12673,1 12702,0 12753,1 12793,0 12875,1 12891,0 12894,1 12985,0 13069,1 13128,0 13172,1 13262,0 13340,1 13360,0 13391,1 13479,0 13524,1 13574,0 13624,1 13684,0 13760,1 13823,0 13892,1 13902,0 13976,1 14003,0 14068,1 14165,0 14188,1 14263,0 14324,1 14359,0 14454,1 14467,0 14567,1 14568,0 14620,1 14688,0 14748,1 14845,0 14925,1 14931,0 14970,1 15047,0 15083,1 15162,0 15203,1 15207,0 15289,1 15312,0 15373,1 15427,0 15516,1 15582,0 15596,1 15679,0 15714,1 15742,0 15802,1 15843,0 15899,1 15978,0 16033,1 16117,0 16196,1 16203,0 16281,1 16330,0 16410,1 16449,0 16506,1 16542,0 16556,1 16656,0 16738,1 16770,0 16775,1 16865,0 16905,1 16973,0 17063,1 17132,0 17204,1 17222,0 17266,1 17345,0 17442,1 17483,0 17504,1 17535,0 17541,1 17626,0 17674,1 17682,0 17770,1 17857,0 17927,1 17968,0 18015,1 18100,0 18135,1 18234,0 18241,1 18313,0 18349,1 18435,0 18496,1 18506,0 18550,1 18596,0 18674,1 18766,0 18824,1 18849,0 18906,1 18959,0 19010,1 19098,0 19105,1 19180,0 19194,1 19242,0 19308,1 19382,0 19398,1 19496,0 19537,1 19573,0 19622,1 19674,0 19707,1 19726,0 19763,1 19814,0 19854,1 19889,0 19894,1 19946,0 19987,1 20005,0 20056,1 20142,0 20223,1 20246,0 20327,1 20417,0 20489,1 20514,0 20563,1 20635,0 20649,1 20668,0 20712,1 20728,0 20762,1 20807,0 20894,1 20927,0 20954,1 21004,0 21007,1 21086,0 21112,1 21144,0 21154,1 21232,0 21275,1 21290,0 21325,1 21402,0 21466,1 21528,0 21598,1 21667,0 21740,1 21790,0 21838,1 21923,0 21981,1 22058,0 22144,1 22152,0 22176,1 22271,0 22280,1 22295,0 22305,1 22375,0 22443,1 22509,0 22535,1 22631,0 22658,1 22750,0 22792,1 22837,0 22890,1 22892,0 22900,1 22982,0 23032,1 23057,0 23139,1 23152,0 23239,1 23296,0 23379,1 23428,0 23445,1 23517,0 23546,1 23617,0 23663,1 23747,0 23822,1 23829,0 23845,1 23905,0 23961,1 24017,0 24044,1 24125,0 24130,1 24182,0 24201,1 24213,0 24219,1 24266,0 24358,1 24436,0 24459,1 24522,0 24607,1 24662,0 24738,1 24777,0 24837,1 24900,0 24948,1 25038,0 25132,1 25216,0 25232,1 25242,0 25327,1 25423,0 25523,1 25539,0 25555,1 25579,0 25617,1 25646,0 25682,1 25711,0 25792,1 25874,0 25891,1 25968,0 25985,1 26009,0 26060,1 26154,0 26231,1 26255,0 26258,1 26327,0 26334,1 26399,0 26435,1 26534,0 26627,1 26703,0 26794,1 26833,0 26835,1 26926,0 26929,1 26989,0 27008,1 27064,0 27121,1 27164,0 27210,1 27282,0 27310,1 27325,0 27397,1 27449,0 27477,1 27572,0 27586,1 27634,0 27730,1 27743,0 27749,1 27782,0 27838,1 27916,0 27965,1 28056,0 28061,1 28158,0 28175,1 28234,0 28320,1 28365,0 28367,1 28408,0 28429,1 28527,0 28539,1 28573,0 28598,1 28641,0 28648,1 28692,0 28699,1 28747,0 28838,1 28889,0 28989,1 29028,0 29061,1 29135,0 29143,1 29160,0 29207,1 29225,0 29287,1 29299,0 29353,1 29389,0 29430,1 29454,0 29507,1 29586,0 29657,1 29755,0 29796,1 29882,0 29894,1 29939,0 29953,1 30027,0 30036,1 30085,0 30150,1 30208,0 30288,1 30340,0 30360,1 30424,0 30511,1 30544,0 30616,1 30708,0 30733,1 30826,0 30867,1 30965,0 30994,1 31032,0 31039,1 31091,0 31168,1 31241,0 31273,1 31346,0 31443,1 31512,0 31587,1 31687,0 31705,1 31741,0 31831,1 31875,0 31927,1 31951,0 32019,1 32061,0 32103,1 32137,0 32173,1 32211,0 32265,1 32343,0 32371,1 32456,0 32466,1 32485,0 32527,1 32550,0 32637,1 32667,0 32674,1 32725,0 32791,1 32840,0 32857,1 32878,0 32881,1 32962,0 32972,1 33055,0 33084,1 33085,0 33119,1 33140,0 33166,1 33249,0 33257,1 33305,0 33382,1 33394,0 33413,1 33419,0 33500,1 33575,0 33635,1 33678,0 33772,1 33870,0 33941,1 34020,0 34095,1 34137,0 34166,1 34172,0 34255,1 34284,0 34338,1 34398,0 34450,1 34538,0 34607,1 34636,0 34688,1 34735,0 34787,1 34834,0 34928,1 34965,0 35040,1 35096,0 35114,1 35122,0 35217,1 35226,0 35326,1 35403,0 35422,1 35511,0 35547,1 35637,0 35718,1 35724,0 35758,1 35794,0 35828,1 35899,0 35907,1 35924,0 36003,1 36022,0 36062,1 36081,0 36127,1 36141,0 36173,1 36226,0 36285,1 36307,0 36403,1 36421,0 36490,1 36511,0 36530,1 36621,0 36705,1 36771,0 36805,1 36851,0 36949,1 37002,0 37070,1 37154,0 37218,1 37294,0 37347,1 37360,0 37403,1 37473,0 37523,1 37594,0 37645,1 37688,0 37707,1 37756,0 37773,1 37846,0 37919,1 37959,0 38029,1 38111,0 38127,1 38156,0 38172,1 38188,0 38279,1 38369,0 38438,1 38486,0 38560,1 38598,0 38655,1 38716,0 38772,1 38850,0 38920,1 39006,0 39028,1 39123,0 39180,1 39280,0 39332,1 39367,0 39403,1 39432,0 39525,1 39551,0 39588,1 39601,0 39608,1 39672,0 39771,1 39787,0 39870,1 39942,0 39986,1 40001,0 40042,1 40101,0 40169,1 40269,0 40315,1 40406,0 40468,1 40542,0 40575,1 40577,0 40645,1 40659,0 40695,1 40713,0 40769,1 40781,0 40818,1 40846,0 40865,1 40909,0 40934,1 40954,0 41042,1 41137,0 41195,1 41273,0 41327,1 41404,0 41454,1 41464,0 41535,1 41610,0 41696,1 41704,0 41742,1 41807,0 41834,1 41879,0 41978,1 42017,0 42083,1 42115,0 42134,1 42223,0 42237,1 42303,0 42335,1 42340,0 42377,1 42423,0 42493,1 42559,0 42574,1 42604,0 42628,1 42684,0 42746,1 42769,0 42812,1 42833,0 42933,1 43033,0 43077,1 43134,0 43197,1 43283,0 43356,1 43411,0 43460,1 43516,0 43528,1 43620,0 43704,1 43764,0 43856,1 43876,0 43937,1 43960,0 43964,1 44053,0 44114,1 44142,0 44171,1 44176,0 44273,1 44293,0 44348,1 44364,0 44445,1 44530,0 44597,1 44634,0 44668,1 44730,0 44823,1 44870,0 44883,1 44918,0 44956,1 44985,0 45032,1 45084,0 45087,1 45160,0 45203,1 45261,0 45350,1 45391,0 45431,1 45496,0 45565,1 45637,0 45687,1 45707,0 45763,1 45805,0 45904,1 45911,0 45945,1 45950,0 46014,1 46087,0 46122,1 46147,0 46243,1 46261,0 46303,1 46319,0 46386,1 46473,0 46567,1 46581,0 46677,1 46759,0 46820,1 46909,0 46958,1 47047,0 47062,1 47081,0 47085,1 47154,0 47185,1 47193,0 47255,1 47264,0 47359,1 47407,0 47433,1 47509,0 47595,1 47680,0 47693,1 47772,0 47831,1 47874,0 47938,1 48009,0 48029,1 48108,0 48111,1 48158,0 48222,1 48251,0 48253,1 48349,0 48403,1 48500,0 48524,1 48540,0 48598,1 48671,0 48697,1 48758,0 48827,1 48903,0 48955,1 49021,0 49121,1 49150,0 49158,1 49213,0 49246,1 49339,0 49433,1 49483,0 49557,1 49567,0 49652,1 49701,0 49746,1 49839,0 49840,1 49939,0 50021,1 50086,0 50154,1 50188,0 50240,1 50268,0 50294,1 50348,0 50362,1 50422,0 50506,1 50585,0 50670,1 50684,0 50766,1 50809,0 50887,1 end initlist a17 0,0 45,1 108,0 114,1 178,0 248,1 295,0 329,1 362,0 446,1 524,0 613,1 614,0 664,1 739,0 752,1 847,0 901,1 920,0 953,1 963,0 992,1 1003,0 1032,1 1048,0 1113,1 1174,0 1259,1 1345,0 1432,1 1453,0 1537,1 1632,0 1685,1 1717,0 1803,1 1808,0 1833,1 1876,0 1932,1 1969,0 2058,1 2139,0 2234,1 2321,0 2341,1 2345,0 2421,1 2456,0 2457,1 2466,0 2516,1 2593,0 2652,1 2706,0 2779,1 2798,0 2864,1 2949,0 3030,1 3080,0 3088,1 3165,0 3259,1 3359,0 3386,1 3416,0 3437,1 3463,0 3535,1 3581,0 3638,1 3667,0 3683,1 3745,0 3765,1 3825,0 3906,1 3934,0 3941,1 3992,0 3997,1 4073,0 4076,1 4154,0 4244,1 4246,0 4272,1 4352,0 4353,1 4439,0 4516,1 4537,0 4632,1 4654,0 4676,1 4682,0 4688,1 4751,0 4798,1 4854,0 4863,1 4879,0 4937,1 4967,0 5045,1 5119,0 5155,1 5205,0 5303,1 5362,0 5377,1 5390,0 5429,1 5516,0 5534,1 5542,0 5605,1 5608,0 5683,1 5780,0 5787,1 5793,0 5858,1 5952,0 6033,1 6079,0 6176,1 6271,0 6279,1 6344,0 6407,1 6438,0 6506,1 6524,0 6623,1 6660,0 6699,1 6780,0 6805,1 6879,0 6970,1 7020,0 7057,1 7126,0 7153,1 7180,0 7193,1 7202,0 7257,1 7305,0 7307,1 7350,0 7412,1 7417,0 7464,1 7492,0 7549,1 7552,0 7630,1 7708,0 7793,1 7794,0 7853,1 7899,0 7908,1 7980,0 8080,1 8142,0 8230,1 8250,0 8300,1 8309,0 8361,1 8433,0 8439,1 8519,0 8586,1 8666,0 8737,1 8793,0 8795,1 8891,0 8961,1 9018,0 9118,1 9157,0 9219,1 9264,0 9341,1 9433,0 9496,1 9574,0 9612,1 9698,0 9751,1 9802,0 9881,1 9892,0 9980,1 10016,0 10018,1 10057,0 10117,1 10198,0 10255,1 10316,0 10330,1 10335,0 10402,1 10452,0 10508,1 10531,0 10555,1 10581,0 10592,1 10629,0 10662,1 10685,0 10754,1 10813,0 10892,1 10911,0 10920,1 10992,0 11055,1 11133,0 11225,1 11264,0 11287,1 11369,0 11426,1 11472,0 11513,1 11577,0 11638,1 11738,0 11751,1 11819,0 11919,1 11985,0 11999,1 12081,0 12099,1 12161,0 12173,1 12221,0 12279,1 12358,0 12392,1 12460,0 12501,1 12595,0 12680,1 12685,0 12693,1 12739,0 12818,1 12899,0 12979,1 13067,0 13125,1 13169,0 13256,1 13309,0 13346,1 13400,0 13433,1 13449,0 13462,1 13538,0 13571,1 13633,0 13694,1 13710,0 13754,1 13813,0 13833,1 13887,0 13965,1 13994,0 14036,1 14046,0 14141,1 14167,0 14178,1 14251,0 14328,1 14351,0 14421,1 14440,0 14496,1 14583,0 14674,1 14695,0 14795,1 14818,0 14835,1 14913,0 14923,1 14942,0 14966,1 14992,0 15006,1 15069,0 15117,1 15159,0 15251,1 15255,0 15266,1 15300,0 15350,1 15424,0 15441,1 15538,0 15584,1 15605,0 15656,1 15728,0 15735,1 15829,0 15839,1 15867,0 15870,1 15888,0 15898,1 15947,0 16022,1 16075,0 16088,1 16162,0 16255,1 16319,0 16391,1 16490,0 16575,1 16622,0 16660,1 16750,0 16822,1 16864,0 16877,1 16892,0 16932,1 16975,0 16997,1 17084,0 17180,1 17270,0 17348,1 17439,0 17458,1 17482,0 17496,1 17511,0 17528,1 17557,0 17574,1 17649,0 17744,1 17753,0 17771,1 17810,0 17860,1 17898,0 17972,1 17996,0 18047,1 18079,0 18173,1 18193,0 18214,1 18246,0 18277,1 18359,0 18382,1 18441,0 18494,1 18589,0 18631,1 18675,0 18689,1 18694,0 18773,1 18837,0 18892,1 18925,0 19010,1 19065,0 19097,1 19146,0 19204,1 19254,0 19269,1 19369,0 19402,1 19448,0 19512,1 19543,0 19640,1 19680,0 19739,1 19789,0 19796,1 19884,0 19950,1 19962,0 19968,1 20062,0 20159,1 20203,0 20230,1 20301,0 20326,1 20340,0 20372,1 20407,0 20428,1 20455,0 20500,1 20529,0 20561,1 20638,0 20657,1 20731,0 20794,1 20808,0 20884,1 20936,0 20992,1 21015,0 21061,1 21113,0 21198,1 21275,0 21311,1 21343,0 21429,1 21521,0 21615,1 21685,0 21725,1 21802,0 21900,1 21999,0 22072,1 22078,0 22162,1 22180,0 22212,1 22307,0 22353,1 22399,0 22476,1 22532,0 22630,1 22675,0 22727,1 22776,0 22804,1 22829,0 22841,1 22853,0 22939,1 22945,0 23015,1 23054,0 23150,1 23174,0 23183,1 23235,0 23287,1 23354,0 23449,1 23519,0 23538,1 23632,0 23731,1 23753,0 23852,1 23869,0 23965,1 23983,0 24066,1 24086,0 24149,1 24222,0 24233,1 24275,0 24284,1 24373,0 24433,1 24483,0 24529,1 24590,0 24637,1 24716,0 24746,1 24824,0 24913,1 24921,0 24967,1 25045,0 25068,1 25154,0 25247,1 25249,0 25336,1 25375,0 25446,1 25491,0 25549,1 25581,0 25613,1 25616,0 25663,1 25747,0 25799,1 25893,0 25968,1 26056,0 26142,1 26173,0 26270,1 26308,0 26333,1 26421,0 26472,1 26489,0 26578,1 26611,0 26620,1 26654,0 26691,1 26738,0 26769,1 26773,0 26857,1 26882,0 26978,1 27024,0 27071,1 27150,0 27174,1 27268,0 27286,1 27288,0 27326,1 27416,0 27462,1 27465,0 27501,1 27509,0 27597,1 27600,0 27634,1 27640,0 27652,1 27738,0 27745,1 27786,0 27794,1 27829,0 27836,1 27931,0 27990,1 28024,0 28066,1 28157,0 28255,1 28353,0 28368,1 28426,0 28441,1 28511,0 28578,1 28598,0 28621,1 28664,0 28760,1 28813,0 28841,1 28888,0 28955,1 29017,0 29104,1 29165,0 29246,1 29300,0 29312,1 29411,0 29492,1 29500,0 29517,1 29557,0 29657,1 29695,0 29725,1 29772,0 29785,1 29808,0 29839,1 29858,0 29869,1 29939,0 29981,1 29983,0 29986,1 30017,0 30068,1 30096,0 30196,1 30283,0 30332,1 30349,0 30436,1 30536,0 30615,1 30639,0 30720,1 30725,0 30772,1 30780,0 30789,1 30838,0 30935,1 30993,0 31059,1 31154,0 31231,1 31262,0 31362,1 31413,0 31493,1 31508,0 31585,1 31634,0 31640,1 31682,0 31768,1 31847,0 31921,1 31971,0 32049,1 32143,0 32228,1 32267,0 32326,1 32328,0 32345,1 32429,0 32489,1 32546,0 32584,1 32675,0 32766,1 32819,0 32884,1 32906,0 32997,1 33081,0 33085,1 33181,0 33231,1 33296,0 33392,1 33426,0 33443,1 33517,0 33549,1 33609,0 33625,1 33673,0 33756,1 33835,0 33924,1 33967,0 33998,1 34006,0 34106,1 34148,0 34248,1 34291,0 34348,1 34431,0 34455,1 34528,0 34546,1 34586,0 34595,1 34643,0 34734,1 34768,0 34791,1 34818,0 34867,1 34888,0 34894,1 34991,0 35022,1 35094,0 35103,1 35195,0 35198,1 35259,0 35272,1 35335,0 35348,1 35444,0 35520,1 35544,0 35619,1 35644,0 35675,1 35714,0 35794,1 35847,0 35928,1 35987,0 36073,1 36142,0 36162,1 36205,0 36296,1 36371,0 36455,1 36462,0 36527,1 36585,0 36622,1 36675,0 36729,1 36803,0 36823,1 36913,0 36956,1 37010,0 37108,1 37109,0 37129,1 37162,0 37175,1 37249,0 37252,1 37312,0 37339,1 37430,0 37471,1 37571,0 37650,1 37715,0 37763,1 37805,0 37879,1 37979,0 38060,1 38113,0 38184,1 38203,0 38241,1 38318,0 38329,1 38415,0 38418,1 38481,0 38521,1 38524,0 38576,1 38645,0 38743,1 38769,0 38806,1 38821,0 38844,1 38860,0 38900,1 38998,0 39008,1 39043,0 39062,1 39066,0 39102,1 39114,0 39157,1 39199,0 39221,1 39262,0 39289,1 39304,0 39401,1 39473,0 39539,1 39553,0 39602,1 39633,0 39701,1 39755,0 39816,1 39864,0 39872,1 39875,0 39931,1 39992,0 40092,1 40145,0 40238,1 40246,0 40330,1 40337,0 40373,1 40455,0 40459,1 40490,0 40509,1 40545,0 40612,1 40676,0 40699,1 40744,0 40804,1 40819,0 40879,1 40882,0 40923,1 40994,0 41035,1 41080,0 41097,1 41151,0 41228,1 41248,0 41310,1 41390,0 41414,1 41510,0 41517,1 41531,0 41557,1 41595,0 41650,1 41670,0 41687,1 41747,0 41814,1 41896,0 41927,1 41985,0 42010,1 42092,0 42171,1 42197,0 42210,1 42295,0 42296,1 42389,0 42472,1 42517,0 42543,1 42621,0 42668,1 42726,0 42818,1 42897,0 42942,1 43023,0 43041,1 43062,0 43108,1 43134,0 43200,1 43204,0 43293,1 43302,0 43374,1 43460,0 43468,1 43561,0 43614,1 43672,0 43689,1 43700,0 43721,1 43723,0 43772,1 43811,0 43838,1 43910,0 43923,1 43934,0 43969,1 43977,0 44022,1 44049,0 44148,1 44231,0 44275,1 44366,0 44414,1 44503,0 44537,1 44567,0 44582,1 44673,0 44686,1 44725,0 44801,1 44816,0 44853,1 44909,0 44979,1 45001,0 45016,1 45116,0 45212,1 45213,0 45244,1 45281,0 45310,1 45342,0 45378,1 45385,0 45435,1 45507,0 45600,1 45602,0 45679,1 45686,0 45775,1 45787,0 45863,1 45904,0 45931,1 45957,0 46038,1 46134,0 46173,1 46218,0 46258,1 46280,0 46307,1 46390,0 46439,1 46534,0 46598,1 46623,0 46628,1 46697,0 46770,1 46838,0 46907,1 46936,0 46997,1 47067,0 47087,1 47146,0 47233,1 47326,0 47379,1 47465,0 47556,1 47645,0 47688,1 47735,0 47773,1 47839,0 47844,1 47902,0 47930,1 48017,0 48098,1 48163,0 48164,1 48259,0 48265,1 48353,0 48432,1 48443,0 48479,1 48490,0 48538,1 48558,0 48621,1 48717,0 48740,1 48812,0 48910,1 48912,0 48917,1 48930,0 49020,1 49083,0 49181,1 49278,0 49306,1 49320,0 49354,1 49394,0 49414,1 49437,0 49515,1 49554,0 49581,1 end initlist a18 0,0 75,1 169,0 221,1 240,0 251,1 320,0 371,1 429,0 459,1 536,0 583,1 610,0 645,1 695,0 708,1 742,0 772,1 848,0 934,1 972,0 1030,1 1038,0 1088,1 1163,0 1185,1 1217,0 1227,1 1323,0 1349,1 1439,0 1480,1 1499,0 1527,1 1573,0 1578,1 1613,0 1670,1 1720,0 1781,1 1784,0 1796,1 1851,0 1879,1 1908,0 1946,1 1978,0 1991,1 2075,0 2098,1 2103,0 2196,1 2205,0 2234,1 2324,0 2391,1 2449,0 2461,1 2537,0 2578,1 2583,0 2590,1 2634,0 2726,1 2766,0 2810,1 2883,0 2982,1 3004,0 3100,1 3191,0 3216,1 3223,0 3315,1 3398,0 3433,1 3528,0 3600,1 3628,0 3684,1 3764,0 3788,1 3790,0 3888,1 3907,0 3980,1 4048,0 4107,1 4112,0 4114,1 4136,0 4210,1 4296,0 4330,1 4387,0 4399,1 4435,0 4508,1 4571,0 4654,1 4667,0 4707,1 4749,0 4829,1 4879,0 4954,1 4978,0 5051,1 5076,0 5169,1 5251,0 5285,1 5301,0 5353,1 5419,0 5428,1 5475,0 5480,1 5493,0 5566,1 5625,0 5694,1 5788,0 5885,1 5907,0 5980,1 6041,0 6071,1 6149,0 6155,1 6211,0 6300,1 6397,0 6410,1 6416,0 6507,1 6549,0 6591,1 6653,0 6698,1 6758,0 6795,1 6871,0 6918,1 7012,0 7085,1 7153,0 7177,1 7245,0 7328,1 7421,0 7479,1 7494,0 7539,1 7588,0 7650,1 7663,0 7714,1 7766,0 7823,1 7832,0 7894,1 7945,0 7947,1 7949,0 8025,1 8108,0 8170,1 8184,0 8185,1 8284,0 8366,1 8431,0 8459,1 8546,0 8549,1 8635,0 8711,1 8801,0 8805,1 8905,0 8915,1 8952,0 9042,1 9112,0 9197,1 9209,0 9306,1 9382,0 9461,1 9523,0 9599,1 9624,0 9640,1 9726,0 9729,1 9752,0 9833,1 9892,0 9934,1 9994,0 10026,1 10063,0 10163,1 10220,0 10282,1 10370,0 10438,1 10491,0 10495,1 10563,0 10602,1 10627,0 10705,1 10760,0 10775,1 10840,0 10887,1 10920,0 10982,1 11004,0 11071,1 11075,0 11091,1 11145,0 11242,1 11298,0 11312,1 11354,0 11420,1 11495,0 11559,1 11634,0 11706,1 11716,0 11738,1 11789,0 11811,1 11857,0 11882,1 11965,0 12055,1 12145,0 12182,1 12207,0 12305,1 12375,0 12430,1 12468,0 12518,1 12615,0 12622,1 12695,0 12779,1 12815,0 12866,1 12930,0 12953,1 12955,0 12958,1 13056,0 13132,1 13166,0 13248,1 13292,0 13385,1 13388,0 13410,1 13465,0 13518,1 13588,0 13660,1 13750,0 13797,1 13888,0 13891,1 13979,0 14043,1 14053,0 14078,1 14143,0 14177,1 14241,0 14305,1 14360,0 14386,1 14388,0 14462,1 14522,0 14531,1 14561,0 14652,1 14695,0 14734,1 14820,0 14858,1 14895,0 14919,1 14927,0 14972,1 15047,0 15122,1 15175,0 15212,1 15236,0 15299,1 15310,0 15359,1 15397,0 15405,1 15409,0 15431,1 15445,0 15449,1 15510,0 15559,1 15582,0 15609,1 15702,0 15703,1 15728,0 15743,1 15755,0 15785,1 15833,0 15887,1 15944,0 15966,1 16014,0 16078,1 16159,0 16198,1 16270,0 16330,1 16397,0 16431,1 16480,0 16536,1 16582,0 16666,1 16691,0 16771,1 16821,0 16846,1 16929,0 17006,1 17010,0 17108,1 17178,0 17246,1 17325,0 17373,1 17413,0 17474,1 17486,0 17560,1 17564,0 17607,1 17662,0 17741,1 17780,0 17822,1 17850,0 17916,1 17952,0 17989,1 18033,0 18057,1 18081,0 18106,1 18172,0 18218,1 18261,0 18293,1 18371,0 18424,1 18486,0 18496,1 18570,0 18576,1 18642,0 18684,1 18749,0 18791,1 18841,0 18928,1 19019,0 19041,1 19100,0 19109,1 19124,0 19214,1 19244,0 19303,1 19396,0 19421,1 19426,0 19496,1 19513,0 19546,1 19604,0 19668,1 19688,0 19697,1 19709,0 19730,1 19814,0 19862,1 19928,0 19962,1 19981,0 19988,1 20068,0 20076,1 20096,0 20196,1 20209,0 20289,1 20330,0 20389,1 20449,0 20509,1 20539,0 20548,1 20639,0 20725,1 20804,0 20860,1 20955,0 21016,1 21068,0 21131,1 21204,0 21281,1 21288,0 21310,1 21391,0 21403,1 21473,0 21490,1 21492,0 21554,1 21566,0 21617,1 21646,0 21744,1 21769,0 21809,1 21897,0 21935,1 21936,0 21997,1 22028,0 22073,1 22082,0 22156,1 22244,0 22287,1 22349,0 22405,1 22496,0 22520,1 22545,0 22606,1 22635,0 22687,1 22737,0 22779,1 22877,0 22883,1 22925,0 23013,1 23112,0 23127,1 23162,0 23195,1 23215,0 23245,1 23340,0 23412,1 23423,0 23437,1 23528,0 23534,1 23584,0 23628,1 23659,0 23732,1 23757,0 23789,1 23840,0 23909,1 23949,0 24034,1 24036,0 24127,1 24186,0 24220,1 24233,0 24320,1 24326,0 24388,1 24407,0 24441,1 24516,0 24527,1 24549,0 24551,1 24557,0 24611,1 24639,0 24647,1 24658,0 24746,1 24785,0 24827,1 24894,0 24973,1 24996,0 25082,1 25120,0 25170,1 25203,0 25301,1 25398,0 25455,1 25520,0 25571,1 25650,0 25707,1 25740,0 25825,1 25919,0 25972,1 25977,0 25980,1 26056,0 26132,1 26153,0 26190,1 26231,0 26245,1 26261,0 26315,1 26324,0 26341,1 26367,0 26435,1 26449,0 26532,1 26564,0 26638,1 26726,0 26780,1 26840,0 26928,1 27016,0 27052,1 27078,0 27178,1 27274,0 27356,1 27359,0 27399,1 27485,0 27495,1 27559,0 27586,1 27620,0 27639,1 27658,0 27757,1 27813,0 27861,1 27949,0 27978,1 28037,0 28059,1 28069,0 28136,1 28207,0 28280,1 28305,0 28359,1 28367,0 28380,1 28411,0 28432,1 28453,0 28524,1 28531,0 28563,1 28649,0 28739,1 28790,0 28793,1 28876,0 28971,1 29032,0 29062,1 29071,0 29101,1 29193,0 29234,1 29257,0 29344,1 29365,0 29427,1 29505,0 29553,1 29641,0 29693,1 29702,0 29798,1 29875,0 29894,1 29938,0 29948,1 29954,0 30053,1 30061,0 30123,1 30221,0 30274,1 30362,0 30435,1 30518,0 30570,1 30601,0 30673,1 30684,0 30695,1 30749,0 30787,1 30792,0 30803,1 30845,0 30856,1 30926,0 30936,1 30944,0 31004,1 31026,0 31093,1 31182,0 31260,1 31352,0 31388,1 31445,0 31470,1 31497,0 31525,1 31564,0 31588,1 31660,0 31672,1 31726,0 31818,1 31840,0 31917,1 31977,0 31982,1 32065,0 32101,1 32151,0 32243,1 32288,0 32383,1 32402,0 32494,1 32575,0 32634,1 32704,0 32716,1 32723,0 32823,1 32877,0 32917,1 32928,0 33028,1 33038,0 33111,1 33172,0 33261,1 33330,0 33416,1 33515,0 33546,1 33565,0 33595,1 33600,0 33682,1 33721,0 33768,1 33794,0 33892,1 33969,0 33981,1 33990,0 34054,1 34127,0 34226,1 34236,0 34288,1 34347,0 34401,1 34409,0 34456,1 34516,0 34534,1 34588,0 34649,1 34673,0 34699,1 34746,0 34765,1 34820,0 34869,1 34870,0 34956,1 34979,0 34987,1 35069,0 35149,1 35248,0 35311,1 35347,0 35436,1 35483,0 35530,1 35542,0 35607,1 35627,0 35716,1 35750,0 35838,1 35858,0 35868,1 35901,0 35996,1 36000,0 36053,1 36098,0 36197,1 36213,0 36290,1 36370,0 36439,1 36447,0 36532,1 36541,0 36639,1 36699,0 36793,1 36858,0 36874,1 36952,0 36991,1 37044,0 37079,1 37155,0 37165,1 37225,0 37323,1 37417,0 37474,1 37536,0 37591,1 37655,0 37755,1 37831,0 37884,1 37984,0 38072,1 38146,0 38238,1 38338,0 38346,1 38435,0 38514,1 38606,0 38700,1 38764,0 38827,1 38909,0 38995,1 39082,0 39158,1 39193,0 39225,1 39228,0 39280,1 39300,0 39333,1 39374,0 39430,1 39478,0 39557,1 39598,0 39632,1 39709,0 39733,1 39830,0 39927,1 39968,0 39988,1 40028,0 40040,1 40125,0 40209,1 40254,0 40278,1 40314,0 40411,1 40431,0 40527,1 40539,0 40618,1 40628,0 40656,1 40738,0 40838,1 40893,0 40952,1 40995,0 41071,1 41149,0 41192,1 41276,0 41283,1 41349,0 41385,1 41445,0 41536,1 41612,0 41683,1 41694,0 41775,1 41814,0 41836,1 41857,0 41912,1 41991,0 42074,1 42174,0 42269,1 42353,0 42374,1 42403,0 42408,1 42448,0 42496,1 42579,0 42650,1 42693,0 42702,1 42763,0 42830,1 42834,0 42884,1 42954,0 43010,1 43083,0 43095,1 43156,0 43177,1 43273,0 43370,1 43463,0 43522,1 43541,0 43545,1 43592,0 43681,1 43702,0 43782,1 43834,0 43887,1 43959,0 44022,1 44083,0 44147,1 44235,0 44309,1 44387,0 44389,1 44473,0 44557,1 44563,0 44569,1 44665,0 44688,1 44773,0 44827,1 44874,0 44960,1 45005,0 45085,1 45088,0 45132,1 45143,0 45188,1 45277,0 45360,1 45451,0 45453,1 45497,0 45535,1 45627,0 45691,1 45779,0 45873,1 45911,0 45934,1 45979,0 46030,1 46100,0 46167,1 46238,0 46245,1 46313,0 46393,1 46423,0 46496,1 46539,0 46614,1 46626,0 46705,1 46750,0 46840,1 46940,0 46942,1 47022,0 47059,1 47159,0 47245,1 47312,0 47347,1 47392,0 47403,1 47499,0 47525,1 47547,0 47626,1 47694,0 47700,1 47705,0 47706,1 47744,0 47779,1 47846,0 47856,1 47923,0 47979,1 47980,0 48069,1 48126,0 48156,1 48189,0 48228,1 48293,0 48369,1 48381,0 48400,1 48489,0 48543,1 48608,0 48698,1 48726,0 48742,1 48754,0 48791,1 48796,0 48803,1 48885,0 48959,1 49020,0 49073,1 49161,0 49246,1 49254,0 49344,1 49405,0 49435,1 49526,0 49609,1 49666,0 49755,1 49832,0 49887,1 49980,0 50052,1 50107,0 50197,1 50286,0 50327,1 50412,0 50423,1 50487,0 50504,1 50513,0 50580,1 end initlist a19 0,0 40,1 96,0 120,1 138,0 168,1 196,0 278,1 353,0 377,1 465,0 521,1 546,0 578,1 634,0 703,1 771,0 773,1 845,0 906,1 954,0 1053,1 1128,0 1164,1 1228,0 1301,1 1316,0 1411,1 1422,0 1503,1 1509,0 1544,1 1553,0 1588,1 1640,0 1723,1 1794,0 1853,1 1892,0 1945,1 2011,0 2045,1 2143,0 2214,1 2297,0 2374,1 2471,0 2484,1 2547,0 2562,1 2576,0 2605,1 2607,0 2659,1 2728,0 2734,1 2777,0 2789,1 2887,0 2934,1 3024,0 3056,1 3091,0 3106,1 3206,0 3260,1 3328,0 3425,1 3485,0 3559,1 3560,0 3637,1 3659,0 3732,1 3741,0 3785,1 3866,0 3909,1 3927,0 4012,1 4037,0 4066,1 4127,0 4180,1 4272,0 4314,1 4357,0 4444,1 4493,0 4528,1 4550,0 4586,1 4666,0 4687,1 4716,0 4813,1 4887,0 4932,1 4970,0 5060,1 5067,0 5085,1 5101,0 5120,1 5134,0 5196,1 5209,0 5228,1 5293,0 5318,1 5398,0 5447,1 5540,0 5576,1 5638,0 5657,1 5714,0 5731,1 5810,0 5866,1 5895,0 5965,1 6036,0 6115,1 6143,0 6227,1 6233,0 6249,1 6267,0 6286,1 6376,0 6390,1 6435,0 6526,1 6530,0 6538,1 6601,0 6692,1 6714,0 6780,1 6844,0 6914,1 6970,0 7002,1 7030,0 7077,1 7085,0 7111,1 7141,0 7212,1 7222,0 7245,1 7270,0 7299,1 7314,0 7332,1 7364,0 7432,1 7446,0 7546,1 7588,0 7610,1 7682,0 7724,1 7787,0 7809,1 7866,0 7957,1 8036,0 8047,1 8123,0 8150,1 8215,0 8254,1 8306,0 8384,1 8461,0 8540,1 8546,0 8616,1 8688,0 8699,1 8747,0 8832,1 8861,0 8889,1 8940,0 8957,1 8991,0 9082,1 9087,0 9155,1 9249,0 9289,1 9337,0 9388,1 9471,0 9507,1 9516,0 9523,1 9616,0 9708,1 9791,0 9869,1 9956,0 10040,1 10041,0 10053,1 10152,0 10251,1 10309,0 10361,1 10408,0 10441,1 10481,0 10506,1 10575,0 10660,1 10664,0 10763,1 10788,0 10833,1 10838,0 10920,1 10987,0 11086,1 11100,0 11172,1 11177,0 11245,1 11291,0 11315,1 11368,0 11436,1 11473,0 11530,1 11612,0 11691,1 11752,0 11844,1 11859,0 11950,1 12026,0 12102,1 12108,0 12196,1 12199,0 12200,1 12271,0 12317,1 12350,0 12434,1 12449,0 12524,1 12540,0 12544,1 12588,0 12596,1 12678,0 12719,1 12799,0 12876,1 12897,0 12983,1 13006,0 13061,1 13145,0 13160,1 13191,0 13259,1 13348,0 13426,1 13441,0 13522,1 13525,0 13594,1 13603,0 13657,1 13745,0 13810,1 13869,0 13955,1 13956,0 14024,1 14030,0 14126,1 14136,0 14233,1 14273,0 14359,1 14450,0 14460,1 14516,0 14614,1 14643,0 14668,1 14703,0 14763,1 14812,0 14851,1 14918,0 14982,1 15004,0 15081,1 15176,0 15264,1 15335,0 15428,1 15482,0 15571,1 15583,0 15657,1 15678,0 15721,1 15768,0 15860,1 15900,0 15999,1 16062,0 16088,1 16177,0 16215,1 16299,0 16364,1 16409,0 16414,1 16483,0 16565,1 16612,0 16654,1 16672,0 16756,1 16850,0 16915,1 16938,0 16959,1 17012,0 17042,1 17104,0 17185,1 17233,0 17242,1 17271,0 17317,1 17339,0 17370,1 17389,0 17449,1 17488,0 17568,1 17648,0 17665,1 17682,0 17700,1 17707,0 17804,1 17871,0 17885,1 17959,0 18057,1 18115,0 18205,1 18296,0 18384,1 18417,0 18444,1 18489,0 18499,1 18505,0 18564,1 18570,0 18627,1 18714,0 18740,1 18808,0 18895,1 18978,0 19054,1 19071,0 19123,1 19151,0 19224,1 19282,0 19289,1 19352,0 19383,1 19463,0 19545,1 19563,0 19641,1 19668,0 19679,1 19704,0 19741,1 19809,0 19903,1 19965,0 20009,1 20062,0 20149,1 20225,0 20271,1 20356,0 20446,1 20519,0 20541,1 20547,0 20623,1 20723,0 20762,1 20849,0 20928,1 20981,0 21077,1 21113,0 21164,1 21251,0 21284,1 21368,0 21386,1 21393,0 21434,1 21480,0 21500,1 21539,0 21629,1 21654,0 21699,1 21785,0 21879,1 21952,0 22042,1 22127,0 22225,1 22298,0 22321,1 22358,0 22446,1 22453,0 22472,1 22507,0 22562,1 22600,0 22629,1 22695,0 22792,1 22878,0 22906,1 22933,0 22995,1 23020,0 23089,1 23115,0 23194,1 23249,0 23309,1 23408,0 23417,1 23434,0 23437,1 23537,0 23626,1 23713,0 23732,1 23765,0 23797,1 23878,0 23923,1 23932,0 24016,1 24019,0 24076,1 24121,0 24189,1 24287,0 24350,1 24374,0 24403,1 24502,0 24595,1 24643,0 24714,1 24728,0 24792,1 24874,0 24969,1 24987,0 25028,1 25081,0 25174,1 25243,0 25276,1 25359,0 25448,1 25509,0 25600,1 25677,0 25741,1 25778,0 25810,1 25897,0 25973,1 26011,0 26060,1 26143,0 26217,1 26310,0 26313,1 26357,0 26370,1 26371,0 26407,1 26430,0 26522,1 26545,0 26546,1 26610,0 26619,1 26689,0 26786,1 26815,0 26825,1 26919,0 26920,1 27000,0 27021,1 27045,0 27060,1 27149,0 27218,1 27292,0 27320,1 27375,0 27470,1 27519,0 27523,1 27561,0 27623,1 27701,0 27762,1 27836,0 27865,1 27929,0 28018,1 28042,0 28140,1 28193,0 28208,1 28285,0 28376,1 28475,0 28481,1 28518,0 28562,1 28662,0 28714,1 28734,0 28798,1 28868,0 28907,1 28935,0 28990,1 29042,0 29047,1 29147,0 29208,1 29222,0 29312,1 29357,0 29427,1 29504,0 29573,1 29595,0 29695,1 29751,0 29779,1 29820,0 29825,1 29906,0 29950,1 30050,0 30150,1 30187,0 30197,1 30256,0 30340,1 30368,0 30369,1 30390,0 30428,1 30445,0 30473,1 30551,0 30555,1 30639,0 30691,1 30765,0 30806,1 30845,0 30934,1 30969,0 30994,1 31076,0 31119,1 31218,0 31223,1 31306,0 31343,1 31441,0 31499,1 31524,0 31578,1 31601,0 31664,1 31757,0 31766,1 31778,0 31801,1 31877,0 31968,1 32002,0 32056,1 32144,0 32156,1 32160,0 32183,1 32185,0 32240,1 32303,0 32369,1 32380,0 32418,1 32474,0 32485,1 32544,0 32598,1 32618,0 32697,1 32757,0 32816,1 32834,0 32906,1 32983,0 33061,1 33064,0 33119,1 33211,0 33274,1 33275,0 33284,1 33332,0 33407,1 33471,0 33550,1 33601,0 33671,1 33752,0 33825,1 33852,0 33946,1 34046,0 34129,1 34214,0 34221,1 34254,0 34269,1 34282,0 34313,1 34333,0 34381,1 34466,0 34474,1 34543,0 34590,1 34652,0 34751,1 34845,0 34868,1 34942,0 35002,1 35039,0 35138,1 35232,0 35296,1 35336,0 35391,1 35468,0 35539,1 35568,0 35667,1 35737,0 35771,1 35841,0 35913,1 35957,0 36019,1 36119,0 36121,1 36183,0 36247,1 36278,0 36328,1 36375,0 36451,1 36514,0 36552,1 36614,0 36662,1 36664,0 36676,1 36755,0 36846,1 36898,0 36964,1 37050,0 37147,1 37210,0 37235,1 37293,0 37354,1 37384,0 37425,1 37472,0 37516,1 37595,0 37679,1 37769,0 37841,1 37908,0 37975,1 38043,0 38097,1 38161,0 38246,1 38263,0 38354,1 38395,0 38407,1 38471,0 38533,1 38550,0 38584,1 38683,0 38776,1 38855,0 38867,1 38929,0 39004,1 39094,0 39124,1 39168,0 39177,1 39228,0 39278,1 39304,0 39399,1 39408,0 39464,1 39470,0 39569,1 39637,0 39658,1 39732,0 39782,1 39844,0 39900,1 39989,0 40065,1 40067,0 40104,1 40183,0 40218,1 40280,0 40313,1 40335,0 40340,1 40368,0 40396,1 40419,0 40441,1 40451,0 40457,1 40502,0 40591,1 40631,0 40707,1 40780,0 40871,1 40899,0 40945,1 40995,0 41026,1 41056,0 41099,1 41106,0 41141,1 41201,0 41246,1 41251,0 41313,1 41341,0 41419,1 41501,0 41541,1 41564,0 41572,1 41607,0 41689,1 41710,0 41779,1 41877,0 41883,1 41936,0 41978,1 42018,0 42049,1 42085,0 42151,1 42199,0 42284,1 42380,0 42422,1 42448,0 42542,1 42580,0 42658,1 42735,0 42741,1 42840,0 42907,1 42924,0 43017,1 43065,0 43087,1 43104,0 43154,1 43248,0 43265,1 43285,0 43316,1 43347,0 43419,1 43470,0 43558,1 43639,0 43691,1 43751,0 43752,1 43806,0 43842,1 43934,0 43955,1 43976,0 44065,1 44141,0 44154,1 44167,0 44265,1 44313,0 44408,1 44477,0 44542,1 44588,0 44675,1 44770,0 44869,1 44901,0 44920,1 44927,0 44968,1 44983,0 45080,1 45160,0 45241,1 45305,0 45337,1 45363,0 45365,1 45443,0 45498,1 45578,0 45635,1 45697,0 45760,1 45777,0 45870,1 45929,0 45979,1 46062,0 46063,1 46068,0 46156,1 46250,0 46339,1 46412,0 46512,1 46517,0 46556,1 46634,0 46698,1 46777,0 46817,1 46880,0 46954,1 46988,0 47015,1 47076,0 47117,1 47119,0 47172,1 47242,0 47261,1 47294,0 47390,1 47450,0 47500,1 47503,0 47545,1 47590,0 47680,1 47757,0 47839,1 47927,0 48011,1 48050,0 48057,1 48083,0 48118,1 48131,0 48160,1 48189,0 48202,1 48231,0 48288,1 48310,0 48383,1 48446,0 48455,1 48463,0 48519,1 48585,0 48639,1 48721,0 48763,1 48817,0 48910,1 48919,0 48958,1 48967,0 48975,1 49072,0 49080,1 49082,0 49124,1 49153,0 49209,1 49289,0 49293,1 49389,0 49440,1 49524,0 49527,1 49605,0 49655,1 49684,0 49704,1 49778,0 49781,1 49876,0 49908,1 49963,0 50046,1 50097,0 50154,1 50227,0 50306,1 50356,0 50440,1 50466,0 50541,1 50565,0 50627,1 50701,0 50777,1 50826,0 50887,1 50935,0 50977,1 51054,0 51066,1 51124,0 51153,1 51198,0 51224,1 51271,0 51295,1 51317,0 51407,1 51496,0 51511,1 51550,0 51595,1 end initlist a20 0,0 48,1 124,0 174,1 253,0 312,1 357,0 424,1 479,0 515,1 558,0 608,1 674,0 683,1 741,0 820,1 836,0 898,1 944,0 959,1 987,0 1002,1 1034,0 1086,1 1106,0 1177,1 1236,0 1300,1 1306,0 1389,1 1450,0 1546,1 1579,0 1668,1 1722,0 1796,1 1881,0 1913,1 2009,0 2033,1 2087,0 2177,1 2231,0 2329,1 2413,0 2433,1 2475,0 2513,1 2575,0 2618,1 2693,0 2747,1 2815,0 2861,1 2879,0 2936,1 3012,0 3018,1 3043,0 3086,1 3167,0 3204,1 3219,0 3262,1 3278,0 3347,1 3419,0 3474,1 3498,0 3590,1 3677,0 3738,1 3758,0 3774,1 3786,0 3876,1 3949,0 4046,1 4109,0 4168,1 4224,0 4317,1 4384,0 4425,1 4524,0 4607,1 4658,0 4666,1 4684,0 4781,1 4795,0 4813,1 4903,0 4917,1 4922,0 4926,1 5022,0 5057,1 5083,0 5115,1 5189,0 5224,1 5277,0 5347,1 5428,0 5510,1 5521,0 5619,1 5705,0 5712,1 5772,0 5853,1 5900,0 5974,1 6045,0 6076,1 6091,0 6172,1 6241,0 6293,1 6335,0 6416,1 6488,0 6525,1 6534,0 6560,1 6570,0 6666,1 6677,0 6726,1 6743,0 6813,1 6867,0 6934,1 7000,0 7023,1 7087,0 7174,1 7188,0 7286,1 7341,0 7431,1 7451,0 7513,1 7515,0 7558,1 7573,0 7648,1 7735,0 7763,1 7805,0 7880,1 7894,0 7945,1 7983,0 8053,1 8102,0 8110,1 8177,0 8238,1 8284,0 8352,1 8387,0 8461,1 8501,0 8576,1 8594,0 8676,1 8751,0 8815,1 8880,0 8939,1 9029,0 9100,1 9169,0 9180,1 9189,0 9241,1 9264,0 9275,1 9337,0 9384,1 9476,0 9507,1 9548,0 9590,1 9630,0 9659,1 9699,0 9737,1 9784,0 9847,1 9883,0 9898,1 9917,0 9945,1 9984,0 9998,1 10078,0 10104,1 10198,0 10215,1 10297,0 10333,1 10391,0 10444,1 10481,0 10490,1 10496,0 10546,1 10567,0 10592,1 10623,0 10653,1 10655,0 10680,1 10779,0 10868,1 10966,0 11063,1 11071,0 11136,1 11174,0 11267,1 11304,0 11385,1 11412,0 11443,1 11521,0 11584,1 11667,0 11701,1 11733,0 11795,1 11877,0 11893,1 11971,0 12009,1 12082,0 12134,1 12227,0 12271,1 12363,0 12380,1 12421,0 12491,1 12576,0 12651,1 12692,0 12700,1 12781,0 12825,1 12829,0 12911,1 13002,0 13023,1 13111,0 13122,1 13205,0 13267,1 13318,0 13403,1 13484,0 13485,1 13493,0 13497,1 13583,0 13638,1 13726,0 13750,1 13791,0 13873,1 13942,0 14015,1 14036,0 14067,1 14163,0 14189,1 14235,0 14262,1 14314,0 14356,1 14434,0 14491,1 14519,0 14530,1 14615,0 14671,1 14709,0 14733,1 14770,0 14805,1 14879,0 14941,1 14970,0 14977,1 15072,0 15091,1 15148,0 15217,1 15256,0 15281,1 15335,0 15375,1 15422,0 15458,1 15545,0 15639,1 15717,0 15797,1 15800,0 15857,1 15947,0 15983,1 15995,0 16043,1 16142,0 16168,1 16212,0 16276,1 16340,0 16349,1 16448,0 16539,1 16639,0 16681,1 16731,0 16751,1 16823,0 16904,1 16924,0 16947,1 17007,0 17083,1 17087,0 17093,1 17094,0 17122,1 17171,0 17194,1 17261,0 17297,1 17393,0 17412,1 17488,0 17560,1 17638,0 17728,1 17752,0 17846,1 17928,0 18017,1 18070,0 18138,1 18226,0 18296,1 18343,0 18388,1 18402,0 18448,1 18501,0 18577,1 18590,0 18657,1 18698,0 18757,1 18774,0 18838,1 18927,0 18963,1 19036,0 19070,1 19159,0 19160,1 19219,0 19298,1 19362,0 19397,1 19419,0 19435,1 19448,0 19501,1 19596,0 19624,1 19708,0 19736,1 19792,0 19821,1 19904,0 19992,1 19994,0 20013,1 20040,0 20110,1 20131,0 20203,1 20294,0 20300,1 20307,0 20359,1 20363,0 20406,1 20463,0 20482,1 20533,0 20548,1 20633,0 20636,1 20698,0 20739,1 20775,0 20828,1 20925,0 20927,1 21005,0 21016,1 21076,0 21171,1 21191,0 21229,1 21248,0 21325,1 21417,0 21454,1 21513,0 21586,1 21624,0 21643,1 21665,0 21698,1 21757,0 21794,1 21800,0 21890,1 21891,0 21923,1 21932,0 21997,1 22038,0 22065,1 22106,0 22200,1 22209,0 22233,1 22313,0 22352,1 22448,0 22488,1 22536,0 22623,1 22701,0 22717,1 22785,0 22792,1 22807,0 22842,1 22863,0 22903,1 22916,0 22990,1 23090,0 23137,1 23148,0 23221,1 23302,0 23345,1 23407,0 23441,1 23463,0 23499,1 23590,0 23663,1 23741,0 23749,1 23827,0 23900,1 23906,0 23909,1 23986,0 24013,1 24087,0 24093,1 24128,0 24182,1 24189,0 24218,1 24267,0 24276,1 24349,0 24430,1 24460,0 24491,1 24508,0 24587,1 24648,0 24737,1 24814,0 24841,1 24909,0 24965,1 25003,0 25060,1 25118,0 25177,1 25181,0 25232,1 25274,0 25343,1 25398,0 25462,1 25522,0 25616,1 25628,0 25712,1 25806,0 25881,1 25981,0 26017,1 26092,0 26165,1 26234,0 26238,1 26305,0 26341,1 26385,0 26387,1 26458,0 26515,1 26587,0 26642,1 26654,0 26673,1 26745,0 26829,1 26928,0 26982,1 27059,0 27117,1 27202,0 27229,1 27281,0 27301,1 27358,0 27429,1 27471,0 27540,1 27618,0 27692,1 27728,0 27735,1 27805,0 27872,1 27902,0 27961,1 28045,0 28114,1 28211,0 28275,1 28280,0 28369,1 28387,0 28417,1 28516,0 28576,1 28588,0 28662,1 28678,0 28693,1 28756,0 28828,1 28871,0 28880,1 28894,0 28934,1 29019,0 29072,1 29165,0 29259,1 29275,0 29277,1 29301,0 29368,1 29432,0 29530,1 29557,0 29589,1 29687,0 29713,1 29791,0 29801,1 29859,0 29873,1 29887,0 29928,1 30010,0 30041,1 30049,0 30142,1 30224,0 30306,1 30346,0 30389,1 30486,0 30532,1 30628,0 30645,1 30745,0 30809,1 30866,0 30941,1 30980,0 31012,1 31102,0 31116,1 31146,0 31186,1 31223,0 31249,1 31338,0 31380,1 31422,0 31442,1 31461,0 31548,1 31605,0 31636,1 31685,0 31785,1 31790,0 31812,1 31820,0 31870,1 31878,0 31942,1 32042,0 32075,1 32161,0 32226,1 32230,0 32302,1 32396,0 32492,1 32554,0 32620,1 32667,0 32728,1 32780,0 32831,1 32836,0 32933,1 33013,0 33036,1 33069,0 33101,1 33125,0 33201,1 33225,0 33283,1 33378,0 33395,1 33448,0 33541,1 33553,0 33650,1 33683,0 33743,1 33776,0 33825,1 33920,0 33943,1 34002,0 34011,1 34109,0 34137,1 34209,0 34226,1 34294,0 34329,1 34335,0 34399,1 34486,0 34559,1 34621,0 34637,1 34676,0 34765,1 34811,0 34893,1 34920,0 34950,1 34994,0 35086,1 35138,0 35163,1 35203,0 35298,1 35380,0 35393,1 35492,0 35543,1 35640,0 35648,1 35710,0 35761,1 35823,0 35849,1 35939,0 35985,1 36000,0 36001,1 36033,0 36122,1 36215,0 36253,1 36340,0 36430,1 36457,0 36519,1 36594,0 36629,1 36636,0 36672,1 36737,0 36768,1 36857,0 36947,1 37036,0 37105,1 37106,0 37153,1 37191,0 37284,1 37349,0 37423,1 37464,0 37561,1 37659,0 37723,1 37775,0 37841,1 37927,0 37970,1 37988,0 38074,1 38083,0 38171,1 38172,0 38223,1 38320,0 38322,1 38355,0 38376,1 38468,0 38509,1 38539,0 38627,1 38724,0 38795,1 38869,0 38913,1 38996,0 39037,1 39125,0 39139,1 39192,0 39206,1 39214,0 39223,1 39285,0 39337,1 39398,0 39491,1 39507,0 39567,1 39636,0 39688,1 39711,0 39766,1 39825,0 39897,1 39997,0 40064,1 40143,0 40237,1 40332,0 40422,1 40490,0 40563,1 40577,0 40644,1 40649,0 40689,1 40764,0 40771,1 40830,0 40888,1 40963,0 41042,1 41065,0 41114,1 41144,0 41227,1 41277,0 41361,1 41451,0 41485,1 41581,0 41667,1 41698,0 41709,1 41772,0 41831,1 41927,0 42004,1 42056,0 42068,1 42156,0 42219,1 42279,0 42357,1 42422,0 42495,1 42497,0 42554,1 42638,0 42732,1 42793,0 42850,1 42888,0 42921,1 42949,0 43032,1 43113,0 43186,1 43214,0 43219,1 43232,0 43331,1 43411,0 43465,1 43510,0 43534,1 43628,0 43651,1 43718,0 43763,1 43862,0 43916,1 43918,0 43968,1 44002,0 44058,1 44090,0 44105,1 44129,0 44131,1 44144,0 44200,1 44238,0 44287,1 44346,0 44364,1 44450,0 44527,1 44556,0 44574,1 44606,0 44699,1 44796,0 44884,1 44951,0 44991,1 45068,0 45082,1 45149,0 45244,1 45303,0 45343,1 45387,0 45460,1 45464,0 45536,1 45633,0 45650,1 45713,0 45774,1 45813,0 45818,1 45911,0 45962,1 46027,0 46090,1 46134,0 46209,1 46297,0 46354,1 46415,0 46466,1 46518,0 46562,1 46659,0 46745,1 46776,0 46875,1 46911,0 46952,1 47019,0 47068,1 47071,0 47087,1 47131,0 47149,1 47160,0 47180,1 47249,0 47338,1 47397,0 47480,1 47575,0 47664,1 47724,0 47820,1 47859,0 47887,1 47940,0 47997,1 48071,0 48144,1 48172,0 48192,1 48276,0 48376,1 48442,0 48493,1 48564,0 48655,1 48742,0 48749,1 48774,0 48838,1 48881,0 48963,1 49047,0 49147,1 49218,0 49262,1 49314,0 49391,1 49393,0 49491,1 49538,0 49558,1 49574,0 49634,1 49674,0 49734,1 49753,0 49851,1 49863,0 49874,1 49917,0 49973,1 50009,0 50071,1 50137,0 50185,1 50257,0 50279,1 50311,0 50397,1 50464,0 50553,1 50605,0 50638,1 50693,0 50716,1 50799,0 50858,1 50859,0 50959,1 51022,0 51079,1 51158,0 51164,1 51202,0 51215,1 51307,0 51375,1 51435,0 51525,1 51614,0 51637,1 51662,0 51735,1 51802,0 51897,1 51984,0 52031,1 52034,0 52092,1 52148,0 52212,1 end initlist a21 0,0 97,1 158,0 219,1 246,0 323,1 382,0 469,1 567,0 603,1 627,0 674,1 693,0 773,1 861,0 929,1 931,0 1009,1 1046,0 1091,1 1095,0 1172,1 1268,0 1323,1 1370,0 1460,1 1526,0 1557,1 1594,0 1676,1 1731,0 1814,1 1829,0 1895,1 1905,0 1966,1 1985,0 1989,1 2084,0 2174,1 2262,0 2308,1 2377,0 2400,1 2465,0 2480,1 2550,0 2608,1 2708,0 2777,1 2810,0 2854,1 2868,0 2962,1 3004,0 3080,1 3115,0 3206,1 3276,0 3277,1 3283,0 3357,1 3416,0 3424,1 3503,0 3569,1 3598,0 3628,1 3665,0 3738,1 3748,0 3812,1 3880,0 3923,1 3942,0 4031,1 4130,0 4185,1 4236,0 4327,1 4397,0 4403,1 4488,0 4529,1 4607,0 4651,1 4684,0 4691,1 4762,0 4784,1 4878,0 4926,1 4956,0 5009,1 5028,0 5063,1 5144,0 5155,1 5185,0 5218,1 5245,0 5277,1 5313,0 5390,1 5417,0 5421,1 5517,0 5534,1 5632,0 5730,1 5816,0 5872,1 5878,0 5961,1 6045,0 6080,1 6095,0 6151,1 6192,0 6197,1 6296,0 6308,1 6372,0 6411,1 6442,0 6446,1 6517,0 6604,1 6652,0 6698,1 6749,0 6787,1 6818,0 6833,1 6879,0 6979,1 7074,0 7134,1 7182,0 7225,1 7263,0 7311,1 7360,0 7365,1 7452,0 7550,1 7617,0 7706,1 7746,0 7747,1 7789,0 7816,1 7905,0 7951,1 7981,0 8049,1 8098,0 8186,1 8225,0 8259,1 8330,0 8369,1 8437,0 8451,1 8484,0 8582,1 8607,0 8652,1 8697,0 8776,1 8866,0 8897,1 8967,0 9058,1 9099,0 9157,1 9165,0 9168,1 9179,0 9257,1 9349,0 9354,1 9366,0 9418,1 9500,0 9564,1 9601,0 9694,1 9769,0 9807,1 9810,0 9888,1 9955,0 9963,1 10016,0 10058,1 10099,0 10198,1 10264,0 10341,1 10392,0 10487,1 10557,0 10633,1 10715,0 10732,1 10809,0 10898,1 10932,0 10943,1 10954,0 11039,1 11065,0 11105,1 11195,0 11201,1 11228,0 11256,1 11289,0 11309,1 11315,0 11345,1 11431,0 11494,1 11571,0 11592,1 11614,0 11616,1 11658,0 11720,1 11772,0 11832,1 11883,0 11909,1 11990,0 12085,1 12180,0 12236,1 12268,0 12334,1 12345,0 12356,1 12438,0 12528,1 12624,0 12644,1 12684,0 12719,1 12760,0 12768,1 12832,0 12837,1 12892,0 12971,1 12975,0 13022,1 13091,0 13128,1 13177,0 13262,1 13345,0 13423,1 13489,0 13568,1 13648,0 13687,1 13785,0 13833,1 13893,0 13939,1 14006,0 14077,1 14095,0 14138,1 14164,0 14178,1 14275,0 14333,1 14401,0 14485,1 14542,0 14582,1 14681,0 14695,1 14777,0 14790,1 14832,0 14923,1 15007,0 15031,1 15093,0 15167,1 15196,0 15290,1 15366,0 15455,1 15549,0 15563,1 15627,0 15673,1 15757,0 15775,1 15782,0 15852,1 15921,0 15991,1 16023,0 16074,1 16077,0 16121,1 16166,0 16203,1 16211,0 16214,1 16267,0 16354,1 16438,0 16502,1 16590,0 16603,1 16676,0 16685,1 16782,0 16828,1 16883,0 16951,1 17012,0 17056,1 17127,0 17169,1 17268,0 17360,1 17411,0 17428,1 17432,0 17495,1 17548,0 17568,1 17612,0 17668,1 17734,0 17811,1 17900,0 17948,1 18037,0 18095,1 18133,0 18206,1 18218,0 18262,1 18355,0 18416,1 18505,0 18513,1 18567,0 18617,1 18717,0 18815,1 18821,0 18878,1 18879,0 18907,1 18967,0 18979,1 19059,0 19099,1 19143,0 19231,1 19265,0 19288,1 19347,0 19369,1 19373,0 19391,1 19433,0 19464,1 19521,0 19536,1 19635,0 19697,1 19728,0 19771,1 19861,0 19905,1 19970,0 20063,1 20151,0 20157,1 20223,0 20224,1 20255,0 20289,1 20341,0 20368,1 20389,0 20400,1 20474,0 20481,1 20535,0 20540,1 20613,0 20620,1 20711,0 20721,1 20776,0 20873,1 20889,0 20950,1 20958,0 21025,1 21116,0 21203,1 21219,0 21318,1 21360,0 21451,1 21495,0 21532,1 21546,0 21620,1 21699,0 21772,1 21776,0 21812,1 21843,0 21928,1 21935,0 21960,1 21966,0 22008,1 22049,0 22077,1 22105,0 22117,1 22180,0 22257,1 22281,0 22325,1 22355,0 22367,1 22460,0 22497,1 22540,0 22570,1 22571,0 22671,1 22716,0 22785,1 22788,0 22874,1 22928,0 22975,1 23059,0 23148,1 23230,0 23258,1 23268,0 23284,1 23329,0 23428,1 23429,0 23435,1 23465,0 23507,1 23572,0 23613,1 23688,0 23733,1 23813,0 23883,1 23896,0 23913,1 23929,0 23934,1 23989,0 24080,1 24123,0 24178,1 24233,0 24244,1 24264,0 24289,1 24369,0 24389,1 24409,0 24500,1 24525,0 24573,1 24632,0 24710,1 24783,0 24838,1 24884,0 24909,1 24952,0 25023,1 25068,0 25102,1 25195,0 25269,1 25336,0 25408,1 25413,0 25479,1 25542,0 25584,1 25663,0 25725,1 25778,0 25872,1 25959,0 25987,1 26032,0 26094,1 26105,0 26176,1 26186,0 26201,1 26252,0 26305,1 26341,0 26431,1 26494,0 26586,1 26588,0 26657,1 26730,0 26754,1 26787,0 26878,1 26887,0 26964,1 27014,0 27109,1 27126,0 27144,1 27159,0 27183,1 27230,0 27301,1 27341,0 27383,1 27405,0 27419,1 27421,0 27422,1 27429,0 27456,1 27501,0 27504,1 27568,0 27573,1 27657,0 27704,1 27804,0 27876,1 27921,0 27957,1 28048,0 28140,1 28210,0 28215,1 28248,0 28288,1 28370,0 28380,1 28476,0 28538,1 28634,0 28691,1 28760,0 28779,1 28802,0 28821,1 28907,0 28945,1 28950,0 29000,1 29012,0 29055,1 29133,0 29188,1 29205,0 29227,1 29320,0 29393,1 29472,0 29513,1 29519,0 29600,1 29663,0 29694,1 29773,0 29820,1 29870,0 29945,1 29949,0 29999,1 30041,0 30121,1 30125,0 30203,1 30287,0 30382,1 30434,0 30451,1 30500,0 30538,1 30541,0 30641,1 30736,0 30793,1 30800,0 30869,1 30915,0 30982,1 31042,0 31117,1 31178,0 31211,1 31250,0 31300,1 31389,0 31478,1 31506,0 31569,1 31575,0 31662,1 31723,0 31788,1 31820,0 31886,1 31955,0 32023,1 32110,0 32199,1 32293,0 32390,1 32481,0 32569,1 32602,0 32647,1 32687,0 32754,1 32833,0 32852,1 32901,0 32911,1 32927,0 32962,1 33000,0 33011,1 33104,0 33162,1 33216,0 33239,1 33260,0 33286,1 33352,0 33430,1 33494,0 33529,1 33531,0 33585,1 33592,0 33632,1 33726,0 33793,1 33833,0 33903,1 33982,0 34059,1 34067,0 34146,1 34183,0 34260,1 34334,0 34351,1 34379,0 34403,1 34459,0 34463,1 34522,0 34614,1 34621,0 34699,1 34705,0 34758,1 34818,0 34909,1 35009,0 35060,1 35112,0 35211,1 35237,0 35320,1 35412,0 35454,1 35551,0 35610,1 35680,0 35775,1 35795,0 35853,1 35868,0 35896,1 35914,0 35989,1 36002,0 36021,1 36096,0 36148,1 36176,0 36204,1 36278,0 36281,1 36290,0 36356,1 36391,0 36407,1 36428,0 36438,1 36471,0 36529,1 36544,0 36591,1 36654,0 36741,1 36765,0 36800,1 36848,0 36852,1 36885,0 36938,1 36965,0 36973,1 37013,0 37073,1 37168,0 37235,1 37281,0 37298,1 37328,0 37338,1 37373,0 37455,1 37486,0 37519,1 37566,0 37567,1 37661,0 37711,1 37726,0 37785,1 37815,0 37869,1 37874,0 37895,1 37987,0 38008,1 38031,0 38110,1 38150,0 38156,1 38249,0 38307,1 38362,0 38423,1 38431,0 38459,1 38502,0 38553,1 38615,0 38679,1 38754,0 38816,1 38902,0 38940,1 39031,0 39035,1 39044,0 39109,1 39119,0 39199,1 39249,0 39255,1 39303,0 39391,1 39405,0 39488,1 39507,0 39605,1 39613,0 39618,1 39634,0 39681,1 39774,0 39800,1 39849,0 39897,1 39949,0 40045,1 40137,0 40189,1 40275,0 40368,1 40466,0 40498,1 40562,0 40594,1 40692,0 40731,1 40815,0 40844,1 40885,0 40922,1 41003,0 41007,1 41021,0 41119,1 41160,0 41256,1 41333,0 41416,1 41426,0 41514,1 41577,0 41591,1 41665,0 41748,1 41820,0 41833,1 41924,0 42018,1 42068,0 42147,1 42237,0 42311,1 42313,0 42396,1 42445,0 42519,1 42584,0 42643,1 42659,0 42745,1 42762,0 42830,1 42901,0 42929,1 43004,0 43053,1 43073,0 43135,1 43225,0 43304,1 43370,0 43372,1 43426,0 43510,1 43527,0 43568,1 43602,0 43637,1 43681,0 43742,1 43786,0 43848,1 43937,0 43988,1 44066,0 44101,1 44148,0 44197,1 44219,0 44288,1 44380,0 44465,1 44503,0 44599,1 44626,0 44649,1 44726,0 44799,1 44844,0 44926,1 44957,0 45038,1 45088,0 45177,1 45236,0 45253,1 45301,0 45303,1 45403,0 45430,1 45475,0 45481,1 45577,0 45582,1 45648,0 45675,1 45699,0 45754,1 45833,0 45903,1 45971,0 46044,1 46064,0 46085,1 46137,0 46197,1 46250,0 46262,1 46273,0 46325,1 46373,0 46444,1 46494,0 46517,1 46600,0 46696,1 46707,0 46716,1 46771,0 46810,1 46825,0 46864,1 46868,0 46937,1 46942,0 46956,1 47021,0 47053,1 47081,0 47162,1 47243,0 47258,1 47355,0 47431,1 47482,0 47495,1 47575,0 47577,1 47656,0 47756,1 47841,0 47842,1 47924,0 48017,1 48108,0 48189,1 48269,0 48305,1 48345,0 48407,1 48475,0 48574,1 48667,0 48701,1 48760,0 48857,1 48932,0 48975,1 48993,0 49020,1 49115,0 49133,1 49188,0 49206,1 49228,0 49256,1 49341,0 49389,1 49426,0 49471,1 49475,0 49524,1 49601,0 49696,1 49748,0 49795,1 49872,0 49954,1 50031,0 50044,1 50105,0 50106,1 50166,0 50249,1 50269,0 50354,1 50432,0 50446,1 50487,0 50507,1 50557,0 50656,1 50702,0 50767,1 50805,0 50852,1 end initlist a22 0,0 69,1 108,0 129,1 141,0 228,1 235,0 252,1 299,0 397,1 495,0 542,1 627,0 720,1 784,0 877,1 947,0 980,1 990,0 994,1 1046,0 1083,1 1105,0 1161,1 1174,0 1224,1 1311,0 1314,1 1408,0 1457,1 1484,0 1503,1 1530,0 1607,1 1648,0 1742,1 1819,0 1821,1 1836,0 1869,1 1913,0 1954,1 1989,0 2019,1 2089,0 2116,1 2156,0 2229,1 2233,0 2297,1 2324,0 2378,1 2384,0 2410,1 2426,0 2483,1 2520,0 2550,1 2569,0 2616,1 2652,0 2682,1 2725,0 2799,1 2864,0 2930,1 2955,0 3004,1 3097,0 3148,1 3199,0 3299,1 3384,0 3433,1 3496,0 3521,1 3588,0 3601,1 3620,0 3690,1 3787,0 3887,1 3932,0 4014,1 4108,0 4186,1 4195,0 4245,1 4333,0 4352,1 4412,0 4422,1 4506,0 4524,1 4529,0 4578,1 4582,0 4591,1 4617,0 4630,1 4649,0 4743,1 4838,0 4872,1 4877,0 4932,1 5024,0 5080,1 5167,0 5202,1 5222,0 5225,1 5252,0 5298,1 5373,0 5406,1 5497,0 5558,1 5631,0 5728,1 5745,0 5830,1 5866,0 5955,1 6036,0 6096,1 6191,0 6253,1 6342,0 6413,1 6489,0 6584,1 6651,0 6659,1 6663,0 6675,1 6708,0 6760,1 6855,0 6946,1 6988,0 7017,1 7074,0 7127,1 7211,0 7294,1 7314,0 7358,1 7365,0 7441,1 7474,0 7501,1 7551,0 7649,1 7734,0 7818,1 7850,0 7928,1 7939,0 7991,1 8052,0 8105,1 8110,0 8194,1 8279,0 8292,1 8381,0 8480,1 8527,0 8554,1 8629,0 8663,1 8731,0 8775,1 8784,0 8821,1 8887,0 8897,1 8903,0 8982,1 9053,0 9066,1 9166,0 9229,1 9317,0 9319,1 9383,0 9401,1 9483,0 9583,1 9592,0 9640,1 9696,0 9704,1 9723,0 9806,1 9855,0 9892,1 9918,0 9953,1 9993,0 10023,1 10049,0 10074,1 10135,0 10143,1 10199,0 10224,1 10312,0 10392,1 10416,0 10444,1 10479,0 10563,1 10639,0 10683,1 10732,0 10765,1 10842,0 10915,1 10936,0 10954,1 10992,0 11076,1 11121,0 11173,1 11193,0 11227,1 11230,0 11303,1 11363,0 11413,1 11449,0 11458,1 11493,0 11575,1 11647,0 11696,1 11709,0 11738,1 11802,0 11871,1 11905,0 11920,1 11979,0 12051,1 12126,0 12216,1 12297,0 12334,1 12407,0 12416,1 12496,0 12531,1 12621,0 12654,1 12719,0 12775,1 12777,0 12858,1 12953,0 13035,1 13089,0 13137,1 13161,0 13233,1 13326,0 13382,1 13399,0 13418,1 13438,0 13469,1 13475,0 13507,1 13581,0 13662,1 13684,0 13732,1 13736,0 13800,1 13812,0 13850,1 13919,0 13927,1 13999,0 14031,1 14068,0 14162,1 14262,0 14293,1 14383,0 14406,1 14476,0 14560,1 14583,0 14589,1 14629,0 14649,1 14689,0 14722,1 14774,0 14852,1 14887,0 14982,1 15073,0 15173,1 15206,0 15277,1 15377,0 15378,1 15447,0 15527,1 15614,0 15617,1 15660,0 15757,1 15766,0 15790,1 15884,0 15968,1 16018,0 16108,1 16165,0 16170,1 16229,0 16326,1 16342,0 16394,1 16447,0 16458,1 16478,0 16512,1 16567,0 16640,1 16717,0 16728,1 16779,0 16831,1 16863,0 16955,1 17036,0 17078,1 17115,0 17121,1 17143,0 17198,1 17250,0 17346,1 17412,0 17452,1 17512,0 17608,1 17654,0 17660,1 17740,0 17744,1 17763,0 17826,1 17904,0 17965,1 17985,0 18070,1 18146,0 18219,1 18297,0 18386,1 18465,0 18483,1 18512,0 18548,1 18613,0 18696,1 18742,0 18763,1 18787,0 18803,1 18858,0 18950,1 18969,0 19013,1 19043,0 19129,1 19218,0 19279,1 19346,0 19391,1 19472,0 19516,1 19592,0 19613,1 19681,0 19697,1 19732,0 19762,1 19801,0 19818,1 19825,0 19909,1 19998,0 20066,1 20119,0 20185,1 20234,0 20283,1 20364,0 20379,1 20420,0 20449,1 20468,0 20510,1 20557,0 20609,1 20694,0 20729,1 20766,0 20831,1 20917,0 20920,1 21020,0 21033,1 21048,0 21119,1 21174,0 21273,1 21314,0 21318,1 21394,0 21485,1 21570,0 21668,1 21744,0 21812,1 21899,0 21964,1 21999,0 22012,1 22074,0 22104,1 22166,0 22172,1 22175,0 22204,1 22303,0 22331,1 22418,0 22420,1 22460,0 22541,1 22565,0 22571,1 22626,0 22638,1 22711,0 22787,1 22846,0 22894,1 22941,0 23035,1 23057,0 23151,1 23205,0 23261,1 23355,0 23409,1 23495,0 23581,1 23609,0 23636,1 23700,0 23774,1 23826,0 23858,1 23893,0 23974,1 23977,0 24019,1 24097,0 24142,1 24210,0 24263,1 24302,0 24320,1 24352,0 24443,1 24522,0 24591,1 24679,0 24710,1 24712,0 24755,1 24825,0 24886,1 24934,0 24963,1 25004,0 25060,1 25100,0 25171,1 25241,0 25341,1 25391,0 25437,1 25453,0 25502,1 25563,0 25603,1 25639,0 25690,1 25775,0 25823,1 25836,0 25930,1 25946,0 25967,1 26038,0 26070,1 26071,0 26158,1 26170,0 26269,1 26346,0 26348,1 26398,0 26426,1 26440,0 26441,1 26518,0 26604,1 26621,0 26624,1 26647,0 26739,1 26821,0 26909,1 26922,0 27008,1 27049,0 27068,1 27083,0 27146,1 27205,0 27239,1 27287,0 27324,1 27420,0 27509,1 27583,0 27599,1 27632,0 27640,1 27663,0 27715,1 27815,0 27871,1 27934,0 27985,1 28067,0 28155,1 28201,0 28215,1 28306,0 28391,1 28416,0 28439,1 28445,0 28512,1 28596,0 28622,1 28660,0 28716,1 28793,0 28869,1 28969,0 29025,1 29044,0 29141,1 29142,0 29184,1 29186,0 29217,1 29312,0 29341,1 29386,0 29466,1 29469,0 29540,1 29542,0 29566,1 29621,0 29690,1 29741,0 29822,1 29903,0 29915,1 29963,0 30004,1 30069,0 30081,1 30129,0 30215,1 30246,0 30271,1 30340,0 30380,1 30401,0 30421,1 30434,0 30523,1 30527,0 30624,1 30638,0 30710,1 30780,0 30813,1 30844,0 30871,1 30888,0 30910,1 30944,0 30995,1 31059,0 31123,1 31151,0 31240,1 31300,0 31374,1 31389,0 31397,1 31487,0 31558,1 31572,0 31590,1 31605,0 31638,1 31655,0 31751,1 31754,0 31843,1 31906,0 31965,1 32057,0 32146,1 32226,0 32300,1 32354,0 32356,1 32358,0 32374,1 32460,0 32496,1 32563,0 32584,1 32613,0 32634,1 32715,0 32741,1 32827,0 32881,1 32910,0 32965,1 32974,0 33018,1 33073,0 33106,1 33132,0 33212,1 33225,0 33274,1 33355,0 33370,1 33383,0 33451,1 33523,0 33622,1 33656,0 33697,1 33747,0 33768,1 33839,0 33844,1 33870,0 33886,1 33953,0 33983,1 34071,0 34128,1 34143,0 34218,1 34315,0 34364,1 34427,0 34469,1 34507,0 34530,1 34536,0 34584,1 34642,0 34646,1 34727,0 34738,1 34761,0 34813,1 34849,0 34936,1 35012,0 35054,1 35066,0 35078,1 35135,0 35161,1 35180,0 35192,1 35287,0 35372,1 35455,0 35467,1 35503,0 35509,1 35531,0 35591,1 35625,0 35716,1 35776,0 35865,1 35957,0 35962,1 35982,0 36022,1 36121,0 36208,1 36262,0 36335,1 36382,0 36482,1 36489,0 36535,1 36537,0 36610,1 36635,0 36651,1 36675,0 36717,1 36771,0 36824,1 36850,0 36853,1 36952,0 36968,1 36999,0 37022,1 37100,0 37163,1 37184,0 37278,1 37366,0 37387,1 37468,0 37491,1 37538,0 37584,1 37645,0 37696,1 37731,0 37782,1 37804,0 37829,1 37851,0 37852,1 37912,0 37961,1 37976,0 38041,1 38130,0 38196,1 38208,0 38267,1 38321,0 38333,1 38337,0 38425,1 38433,0 38517,1 38600,0 38692,1 38768,0 38864,1 38871,0 38947,1 38961,0 39001,1 39071,0 39125,1 39157,0 39165,1 39240,0 39308,1 39319,0 39334,1 39421,0 39467,1 39517,0 39519,1 39563,0 39604,1 39683,0 39725,1 39776,0 39789,1 39798,0 39850,1 39947,0 39951,1 40010,0 40066,1 40079,0 40095,1 40178,0 40207,1 40210,0 40235,1 40236,0 40303,1 40371,0 40415,1 40429,0 40434,1 40453,0 40456,1 40458,0 40472,1 40505,0 40551,1 40594,0 40668,1 40744,0 40764,1 40768,0 40845,1 40931,0 40983,1 40998,0 41096,1 41185,0 41191,1 41216,0 41273,1 41294,0 41334,1 41420,0 41500,1 41517,0 41581,1 41642,0 41687,1 41721,0 41740,1 41835,0 41857,1 41941,0 42011,1 42081,0 42162,1 42184,0 42202,1 42205,0 42274,1 42355,0 42435,1 42441,0 42494,1 42508,0 42602,1 42640,0 42720,1 42780,0 42866,1 42916,0 43000,1 43042,0 43111,1 43165,0 43254,1 43302,0 43312,1 43324,0 43368,1 43388,0 43478,1 43573,0 43640,1 43641,0 43721,1 43758,0 43796,1 43862,0 43887,1 43891,0 43946,1 43984,0 44044,1 44050,0 44126,1 44203,0 44241,1 44295,0 44311,1 44321,0 44401,1 44450,0 44485,1 44538,0 44630,1 44691,0 44722,1 44783,0 44857,1 44951,0 44978,1 45017,0 45066,1 45116,0 45134,1 45217,0 45235,1 45298,0 45339,1 45375,0 45404,1 45493,0 45583,1 45644,0 45744,1 45745,0 45772,1 45797,0 45875,1 45934,0 45957,1 46006,0 46011,1 46051,0 46147,1 46185,0 46246,1 46286,0 46323,1 46370,0 46403,1 46457,0 46501,1 46587,0 46679,1 46759,0 46822,1 46887,0 46895,1 46922,0 46956,1 47047,0 47099,1 47126,0 47223,1 47238,0 47259,1 47321,0 47363,1 47374,0 47467,1 47565,0 47623,1 47723,0 47727,1 47813,0 47837,1 47937,0 48033,1 48082,0 48175,1 48182,0 48266,1 48334,0 48410,1 48439,0 48476,1 48555,0 48654,1 48717,0 48817,1 48863,0 48897,1 48994,0 49082,1 49092,0 49154,1 49221,0 49317,1 49400,0 49499,1 49576,0 49633,1 49673,0 49696,1 end initlist a23 0,0 34,1 73,0 74,1 166,0 251,1 330,0 347,1 440,0 522,1 619,0 647,1 655,0 665,1 749,0 843,1 856,0 869,1 902,0 983,1 1073,0 1132,1 1170,0 1215,1 1300,0 1321,1 1384,0 1415,1 1451,0 1544,1 1561,0 1630,1 1727,0 1739,1 1830,0 1903,1 1940,0 1991,1 2065,0 2162,1 2217,0 2222,1 2263,0 2330,1 2400,0 2413,1 2493,0 2530,1 2556,0 2580,1 2611,0 2692,1 2776,0 2821,1 2907,0 3003,1 3046,0 3133,1 3156,0 3198,1 3267,0 3336,1 3430,0 3455,1 3504,0 3575,1 3580,0 3619,1 3679,0 3729,1 3769,0 3867,1 3962,0 3965,1 3988,0 4033,1 4121,0 4173,1 4191,0 4262,1 4291,0 4297,1 4362,0 4380,1 4478,0 4512,1 4611,0 4620,1 4643,0 4679,1 4758,0 4784,1 4833,0 4855,1 4912,0 4969,1 5030,0 5038,1 5083,0 5173,1 5209,0 5263,1 5326,0 5356,1 5430,0 5441,1 5531,0 5605,1 5614,0 5639,1 5678,0 5713,1 5785,0 5807,1 5861,0 5915,1 5938,0 5976,1 6047,0 6138,1 6191,0 6280,1 6345,0 6354,1 6367,0 6397,1 6406,0 6431,1 6470,0 6478,1 6570,0 6588,1 6662,0 6754,1 6842,0 6863,1 6946,0 7000,1 7046,0 7051,1 7092,0 7165,1 7245,0 7293,1 7338,0 7350,1 7384,0 7385,1 7425,0 7483,1 7569,0 7649,1 7652,0 7744,1 7761,0 7855,1 7931,0 7955,1 8012,0 8032,1 8072,0 8147,1 8199,0 8296,1 8386,0 8419,1 8491,0 8542,1 8563,0 8587,1 8623,0 8678,1 8738,0 8763,1 8776,0 8817,1 8831,0 8868,1 8929,0 8947,1 8981,0 9000,1 9037,0 9094,1 9191,0 9213,1 9240,0 9293,1 9310,0 9385,1 9473,0 9499,1 9570,0 9576,1 9589,0 9599,1 9621,0 9704,1 9729,0 9788,1 9791,0 9822,1 9860,0 9956,1 9997,0 10035,1 10069,0 10148,1 10206,0 10303,1 10385,0 10478,1 10570,0 10600,1 10646,0 10700,1 10786,0 10868,1 10909,0 10940,1 10949,0 10967,1 10996,0 11000,1 11018,0 11082,1 11182,0 11279,1 11345,0 11371,1 11452,0 11517,1 11571,0 11625,1 11653,0 11732,1 11776,0 11794,1 11840,0 11847,1 11890,0 11962,1 12007,0 12073,1 12093,0 12115,1 12166,0 12173,1 12200,0 12232,1 12278,0 12378,1 12415,0 12489,1 12509,0 12532,1 12580,0 12676,1 12767,0 12835,1 12889,0 12959,1 13016,0 13079,1 13124,0 13183,1 13235,0 13262,1 13290,0 13338,1 13424,0 13504,1 13513,0 13544,1 13617,0 13654,1 13711,0 13731,1 13830,0 13831,1 13859,0 13956,1 14054,0 14062,1 14127,0 14129,1 14185,0 14280,1 14307,0 14359,1 14381,0 14401,1 14445,0 14497,1 14540,0 14572,1 14581,0 14600,1 14668,0 14724,1 14755,0 14846,1 14900,0 14928,1 15025,0 15095,1 15169,0 15185,1 15284,0 15369,1 15462,0 15525,1 15532,0 15551,1 15585,0 15669,1 15756,0 15812,1 15869,0 15950,1 15972,0 16022,1 16082,0 16109,1 16169,0 16213,1 16287,0 16308,1 16406,0 16407,1 16505,0 16580,1 16645,0 16743,1 16822,0 16917,1 16995,0 17012,1 17040,0 17097,1 17119,0 17217,1 17269,0 17310,1 17317,0 17404,1 17435,0 17471,1 17501,0 17568,1 17574,0 17659,1 17683,0 17719,1 17782,0 17817,1 17865,0 17870,1 17904,0 17947,1 17972,0 18029,1 18075,0 18077,1 18155,0 18246,1 18332,0 18351,1 18380,0 18441,1 18533,0 18567,1 18588,0 18591,1 18618,0 18656,1 18680,0 18685,1 18730,0 18742,1 18785,0 18817,1 18819,0 18841,1 18878,0 18968,1 18969,0 18996,1 19065,0 19115,1 19165,0 19214,1 19251,0 19332,1 19365,0 19432,1 19468,0 19525,1 19533,0 19617,1 19626,0 19679,1 19773,0 19871,1 19909,0 20009,1 20036,0 20067,1 20165,0 20211,1 20311,0 20356,1 20388,0 20421,1 20512,0 20589,1 20591,0 20631,1 20707,0 20799,1 20815,0 20878,1 20887,0 20904,1 20990,0 21060,1 21155,0 21184,1 21259,0 21270,1 21364,0 21380,1 21465,0 21497,1 21539,0 21618,1 21634,0 21731,1 21829,0 21870,1 21882,0 21918,1 21977,0 22042,1 22125,0 22173,1 22188,0 22222,1 22313,0 22320,1 22414,0 22479,1 22553,0 22567,1 22636,0 22641,1 22667,0 22713,1 22803,0 22882,1 22942,0 23015,1 23076,0 23120,1 23177,0 23192,1 23215,0 23288,1 23318,0 23325,1 23345,0 23436,1 23493,0 23519,1 23558,0 23655,1 23692,0 23703,1 23734,0 23736,1 23753,0 23813,1 23851,0 23927,1 24013,0 24047,1 24141,0 24174,1 24272,0 24363,1 24444,0 24503,1 24530,0 24543,1 24587,0 24596,1 24621,0 24644,1 24660,0 24725,1 24784,0 24795,1 24845,0 24857,1 24860,0 24862,1 24869,0 24888,1 24933,0 24988,1 25040,0 25045,1 25079,0 25095,1 25194,0 25258,1 25341,0 25434,1 25512,0 25537,1 25594,0 25633,1 25653,0 25717,1 25746,0 25755,1 25844,0 25889,1 25955,0 26018,1 26109,0 26154,1 26179,0 26237,1 26321,0 26366,1 26402,0 26473,1 26504,0 26519,1 26594,0 26690,1 26747,0 26818,1 26861,0 26889,1 26986,0 27086,1 27093,0 27115,1 27213,0 27290,1 27367,0 27445,1 27452,0 27518,1 27575,0 27647,1 27692,0 27787,1 27839,0 27885,1 27915,0 27973,1 28042,0 28079,1 28149,0 28227,1 28232,0 28321,1 28323,0 28409,1 28418,0 28432,1 28457,0 28542,1 28626,0 28660,1 28727,0 28805,1 28903,0 28959,1 29018,0 29107,1 29110,0 29121,1 29183,0 29191,1 29269,0 29362,1 29458,0 29463,1 29529,0 29602,1 29631,0 29670,1 29680,0 29762,1 29797,0 29889,1 29915,0 29990,1 30002,0 30049,1 30132,0 30202,1 30237,0 30281,1 30332,0 30428,1 30464,0 30478,1 30557,0 30570,1 30625,0 30643,1 30719,0 30749,1 30801,0 30839,1 30875,0 30918,1 31017,0 31072,1 31147,0 31181,1 31205,0 31300,1 31324,0 31381,1 31444,0 31479,1 31484,0 31535,1 31545,0 31637,1 31651,0 31669,1 31758,0 31829,1 31900,0 31982,1 32045,0 32057,1 32064,0 32152,1 32187,0 32192,1 32199,0 32244,1 32290,0 32292,1 32369,0 32374,1 32428,0 32499,1 32592,0 32689,1 32782,0 32847,1 32862,0 32922,1 33009,0 33011,1 33027,0 33102,1 33103,0 33148,1 33229,0 33280,1 33289,0 33321,1 33339,0 33395,1 33464,0 33506,1 33521,0 33616,1 33700,0 33711,1 33738,0 33766,1 33790,0 33862,1 33897,0 33953,1 34038,0 34100,1 34199,0 34204,1 34292,0 34316,1 34322,0 34341,1 34381,0 34435,1 34529,0 34536,1 34574,0 34644,1 34730,0 34775,1 34824,0 34840,1 34939,0 34945,1 34974,0 35049,1 35068,0 35084,1 35180,0 35209,1 35293,0 35306,1 35314,0 35361,1 35403,0 35483,1 35533,0 35579,1 35625,0 35673,1 35715,0 35790,1 35809,0 35816,1 35823,0 35856,1 35944,0 36000,1 36047,0 36123,1 36190,0 36234,1 36314,0 36329,1 36384,0 36459,1 36518,0 36562,1 36591,0 36689,1 36769,0 36787,1 36801,0 36807,1 36857,0 36939,1 36940,0 36974,1 37036,0 37041,1 37072,0 37136,1 37143,0 37216,1 37290,0 37325,1 37369,0 37385,1 37407,0 37474,1 37523,0 37602,1 37701,0 37731,1 37830,0 37897,1 37944,0 37980,1 38041,0 38093,1 38102,0 38164,1 38210,0 38307,1 38367,0 38423,1 38464,0 38548,1 38628,0 38668,1 38715,0 38736,1 38789,0 38791,1 38850,0 38897,1 38978,0 39060,1 39159,0 39234,1 39260,0 39349,1 39362,0 39418,1 39458,0 39496,1 39497,0 39592,1 39653,0 39716,1 39778,0 39782,1 39832,0 39889,1 39916,0 39983,1 40051,0 40088,1 40169,0 40214,1 40282,0 40319,1 40417,0 40463,1 40485,0 40504,1 40546,0 40593,1 40646,0 40742,1 40834,0 40900,1 40971,0 41051,1 41057,0 41112,1 41177,0 41243,1 41324,0 41345,1 41427,0 41485,1 41501,0 41503,1 41596,0 41619,1 41702,0 41795,1 41821,0 41908,1 41972,0 42014,1 42070,0 42122,1 42201,0 42250,1 42324,0 42360,1 42441,0 42530,1 42629,0 42654,1 42664,0 42688,1 42752,0 42846,1 42922,0 42928,1 42976,0 42991,1 43090,0 43154,1 43158,0 43218,1 43313,0 43354,1 43413,0 43420,1 43458,0 43477,1 43564,0 43621,1 43648,0 43711,1 43789,0 43822,1 43845,0 43945,1 43969,0 43998,1 44022,0 44060,1 44115,0 44142,1 44188,0 44285,1 44346,0 44353,1 44384,0 44463,1 44499,0 44530,1 44601,0 44615,1 44715,0 44732,1 44776,0 44862,1 44895,0 44971,1 45071,0 45105,1 45130,0 45154,1 45172,0 45189,1 45268,0 45274,1 45344,0 45375,1 45401,0 45484,1 45549,0 45617,1 45704,0 45716,1 45780,0 45854,1 45893,0 45916,1 45970,0 46011,1 46072,0 46157,1 46184,0 46187,1 46215,0 46261,1 46290,0 46334,1 46387,0 46482,1 46498,0 46574,1 46658,0 46663,1 46682,0 46736,1 46776,0 46864,1 46875,0 46910,1 46988,0 47061,1 47145,0 47221,1 47248,0 47304,1 47311,0 47368,1 47443,0 47463,1 47466,0 47538,1 47585,0 47622,1 47713,0 47744,1 47843,0 47887,1 47930,0 47943,1 48001,0 48101,1 48109,0 48195,1 48251,0 48293,1 48386,0 48462,1 48487,0 48512,1 48583,0 48621,1 48649,0 48665,1 48742,0 48809,1 48897,0 48942,1 48964,0 48997,1 49088,0 49161,1 49222,0 49294,1 49359,0 49412,1 49445,0 49452,1 49533,0 49624,1 49633,0 49669,1 49701,0 49725,1 49770,0 49772,1 49827,0 49915,1 end initlist a24 0,0 89,1 153,0 156,1 244,0 328,1 336,0 362,1 408,0 507,1 599,0 613,1 620,0 657,1 738,0 748,1 771,0 837,1 859,0 928,1 931,0 973,1 1012,0 1078,1 1086,0 1124,1 1143,0 1159,1 1193,0 1286,1 1287,0 1300,1 1355,0 1422,1 1505,0 1578,1 1672,0 1701,1 1747,0 1825,1 1883,0 1981,1 2045,0 2046,1 2102,0 2158,1 2235,0 2306,1 2325,0 2410,1 2455,0 2542,1 2546,0 2609,1 2641,0 2711,1 2718,0 2811,1 2873,0 2884,1 2899,0 2904,1 2981,0 3058,1 3133,0 3214,1 3227,0 3294,1 3376,0 3416,1 3425,0 3471,1 3551,0 3616,1 3631,0 3688,1 3717,0 3718,1 3765,0 3823,1 3828,0 3903,1 3925,0 4022,1 4079,0 4145,1 4192,0 4290,1 4381,0 4473,1 4531,0 4581,1 4637,0 4725,1 4804,0 4840,1 4858,0 4940,1 4993,0 5064,1 5081,0 5163,1 5171,0 5222,1 5232,0 5300,1 5341,0 5380,1 5424,0 5492,1 5500,0 5586,1 5667,0 5753,1 5851,0 5896,1 5913,0 5990,1 6054,0 6097,1 6143,0 6171,1 6268,0 6329,1 6429,0 6436,1 6507,0 6536,1 6552,0 6636,1 6690,0 6696,1 6746,0 6753,1 6802,0 6819,1 6905,0 6909,1 6995,0 7009,1 7048,0 7089,1 7148,0 7152,1 7163,0 7218,1 7266,0 7327,1 7390,0 7423,1 7519,0 7565,1 7655,0 7686,1 7722,0 7820,1 7903,0 7977,1 8037,0 8038,1 8096,0 8137,1 8162,0 8195,1 8294,0 8364,1 8408,0 8432,1 8446,0 8489,1 8500,0 8511,1 8547,0 8559,1 8618,0 8674,1 8679,0 8711,1 8753,0 8766,1 8767,0 8773,1 8795,0 8889,1 8898,0 8934,1 9019,0 9088,1 9127,0 9188,1 9233,0 9267,1 9348,0 9442,1 9507,0 9529,1 9626,0 9651,1 9711,0 9811,1 9842,0 9923,1 9927,0 10024,1 10116,0 10182,1 10238,0 10292,1 10333,0 10334,1 10387,0 10445,1 10511,0 10561,1 10625,0 10703,1 10749,0 10753,1 10805,0 10825,1 10826,0 10834,1 10869,0 10894,1 10925,0 10953,1 11023,0 11069,1 11121,0 11203,1 11257,0 11279,1 11311,0 11397,1 11472,0 11503,1 11572,0 11632,1 11639,0 11650,1 11724,0 11767,1 11841,0 11867,1 11926,0 11943,1 12021,0 12111,1 12199,0 12238,1 12240,0 12269,1 12327,0 12386,1 12467,0 12503,1 12532,0 12628,1 12693,0 12720,1 12794,0 12843,1 12868,0 12921,1 12947,0 13005,1 13097,0 13148,1 13233,0 13310,1 13350,0 13438,1 13510,0 13592,1 13677,0 13690,1 13764,0 13860,1 13862,0 13938,1 14032,0 14096,1 14175,0 14221,1 14238,0 14314,1 14399,0 14498,1 14596,0 14650,1 14665,0 14684,1 14708,0 14729,1 14794,0 14888,1 14944,0 15021,1 15023,0 15068,1 15167,0 15244,1 15263,0 15265,1 15312,0 15388,1 15398,0 15496,1 15571,0 15588,1 15593,0 15624,1 15653,0 15749,1 15791,0 15841,1 15857,0 15953,1 15976,0 16066,1 16067,0 16137,1 16191,0 16234,1 16252,0 16328,1 16358,0 16425,1 16476,0 16544,1 16636,0 16677,1 16747,0 16756,1 16794,0 16833,1 16842,0 16934,1 16974,0 17040,1 17092,0 17176,1 17275,0 17327,1 17365,0 17436,1 17495,0 17546,1 17586,0 17650,1 17692,0 17742,1 17776,0 17807,1 17905,0 17951,1 18011,0 18106,1 18201,0 18214,1 18255,0 18305,1 18342,0 18432,1 18472,0 18507,1 18532,0 18572,1 18590,0 18615,1 18656,0 18726,1 18753,0 18825,1 18876,0 18902,1 18924,0 18999,1 19024,0 19025,1 19120,0 19123,1 19189,0 19276,1 19311,0 19342,1 19418,0 19450,1 19475,0 19478,1 19524,0 19551,1 19552,0 19564,1 19647,0 19719,1 19726,0 19729,1 19808,0 19897,1 19955,0 19961,1 19986,0 20065,1 20113,0 20160,1 20220,0 20309,1 20365,0 20390,1 20418,0 20478,1 20558,0 20622,1 20705,0 20723,1 20775,0 20840,1 20883,0 20980,1 21058,0 21093,1 21137,0 21235,1 21298,0 21355,1 21382,0 21461,1 21477,0 21519,1 21526,0 21590,1 21593,0 21640,1 21656,0 21738,1 21761,0 21818,1 21851,0 21852,1 21865,0 21914,1 21955,0 22023,1 22040,0 22054,1 22099,0 22195,1 22207,0 22293,1 22304,0 22354,1 22395,0 22403,1 22433,0 22531,1 22583,0 22671,1 22693,0 22731,1 22766,0 22865,1 22870,0 22872,1 22893,0 22969,1 23032,0 23103,1 23150,0 23197,1 23219,0 23230,1 23253,0 23275,1 23342,0 23411,1 23491,0 23591,1 23628,0 23698,1 23762,0 23844,1 23906,0 23940,1 24022,0 24058,1 24067,0 24131,1 24230,0 24285,1 24366,0 24368,1 24423,0 24522,1 24547,0 24572,1 24623,0 24640,1 24698,0 24773,1 24840,0 24872,1 24937,0 24965,1 25010,0 25017,1 25023,0 25067,1 25150,0 25203,1 25271,0 25309,1 25329,0 25344,1 25430,0 25457,1 25537,0 25583,1 25641,0 25679,1 25741,0 25780,1 25793,0 25878,1 25947,0 26003,1 26004,0 26077,1 26103,0 26150,1 26156,0 26236,1 26278,0 26290,1 26377,0 26455,1 26522,0 26558,1 26633,0 26730,1 26798,0 26873,1 26901,0 26932,1 26990,0 27061,1 27147,0 27200,1 27287,0 27313,1 27343,0 27438,1 27476,0 27490,1 27539,0 27601,1 27688,0 27775,1 27830,0 27836,1 27914,0 27921,1 28009,0 28013,1 28055,0 28089,1 28093,0 28173,1 28196,0 28203,1 28254,0 28298,1 28341,0 28391,1 28456,0 28538,1 28583,0 28666,1 28688,0 28754,1 28826,0 28913,1 28988,0 29019,1 29104,0 29131,1 29134,0 29144,1 29163,0 29261,1 29316,0 29323,1 29394,0 29486,1 29571,0 29618,1 29655,0 29751,1 29834,0 29930,1 29972,0 29993,1 30061,0 30123,1 30156,0 30208,1 30243,0 30283,1 30285,0 30342,1 30357,0 30405,1 30481,0 30536,1 30590,0 30632,1 30648,0 30710,1 30735,0 30763,1 30854,0 30921,1 30985,0 31043,1 31074,0 31160,1 31251,0 31347,1 31375,0 31380,1 31398,0 31408,1 31410,0 31444,1 31478,0 31517,1 31595,0 31670,1 31733,0 31794,1 31888,0 31962,1 32054,0 32130,1 32159,0 32226,1 32301,0 32355,1 32378,0 32409,1 32502,0 32581,1 32622,0 32709,1 32745,0 32764,1 32862,0 32945,1 33029,0 33052,1 33122,0 33188,1 33236,0 33305,1 33335,0 33382,1 33387,0 33468,1 33501,0 33554,1 33637,0 33677,1 33750,0 33848,1 33942,0 33948,1 34036,0 34049,1 34073,0 34125,1 34191,0 34230,1 34313,0 34335,1 34378,0 34398,1 34400,0 34468,1 34540,0 34590,1 34686,0 34701,1 34735,0 34773,1 34865,0 34925,1 35024,0 35029,1 35105,0 35128,1 35155,0 35164,1 35253,0 35278,1 35310,0 35361,1 35376,0 35400,1 35438,0 35506,1 35514,0 35572,1 35663,0 35739,1 35829,0 35897,1 35904,0 35915,1 35919,0 35980,1 36071,0 36149,1 36179,0 36187,1 36249,0 36259,1 36299,0 36356,1 36427,0 36478,1 36513,0 36608,1 36628,0 36715,1 36772,0 36849,1 36866,0 36871,1 36889,0 36908,1 36923,0 36998,1 37098,0 37107,1 37118,0 37209,1 37237,0 37257,1 37267,0 37268,1 37289,0 37332,1 37422,0 37495,1 37580,0 37640,1 37704,0 37755,1 37799,0 37887,1 37924,0 37999,1 38024,0 38121,1 38139,0 38164,1 38256,0 38261,1 38313,0 38349,1 38419,0 38434,1 38517,0 38538,1 38541,0 38623,1 38641,0 38722,1 38791,0 38829,1 38831,0 38841,1 38882,0 38958,1 38961,0 38998,1 39017,0 39028,1 39127,0 39202,1 39277,0 39356,1 39366,0 39388,1 39462,0 39484,1 39574,0 39672,1 39708,0 39752,1 39775,0 39866,1 39925,0 39954,1 39994,0 40055,1 40153,0 40169,1 40232,0 40309,1 40385,0 40473,1 40524,0 40543,1 40566,0 40596,1 40634,0 40720,1 40748,0 40840,1 40845,0 40929,1 41006,0 41030,1 41035,0 41127,1 41164,0 41252,1 41290,0 41298,1 41397,0 41412,1 41478,0 41502,1 41536,0 41628,1 41712,0 41748,1 41776,0 41865,1 41925,0 41957,1 42023,0 42046,1 42093,0 42111,1 42120,0 42196,1 42197,0 42260,1 42320,0 42349,1 42370,0 42395,1 42480,0 42502,1 42579,0 42584,1 42684,0 42711,1 42781,0 42825,1 42885,0 42913,1 42941,0 42981,1 43000,0 43089,1 43181,0 43216,1 43273,0 43360,1 43422,0 43432,1 43497,0 43534,1 43592,0 43644,1 43670,0 43723,1 43814,0 43895,1 43936,0 44013,1 44051,0 44075,1 44123,0 44171,1 44220,0 44278,1 44374,0 44452,1 44478,0 44568,1 44654,0 44719,1 44742,0 44755,1 44807,0 44875,1 44947,0 45005,1 45072,0 45100,1 45154,0 45236,1 45237,0 45293,1 45337,0 45373,1 45405,0 45444,1 45484,0 45550,1 45597,0 45661,1 45718,0 45750,1 45754,0 45842,1 45930,0 45964,1 46049,0 46078,1 46090,0 46189,1 46208,0 46210,1 46264,0 46270,1 46274,0 46335,1 46360,0 46379,1 46410,0 46487,1 46516,0 46532,1 46613,0 46618,1 46631,0 46703,1 46763,0 46843,1 46876,0 46910,1 46981,0 47041,1 47116,0 47168,1 47237,0 47239,1 47323,0 47347,1 47393,0 47469,1 47552,0 47568,1 47651,0 47667,1 47716,0 47783,1 47802,0 47882,1 47959,0 48005,1 48028,0 48048,1 48127,0 48206,1 48220,0 48227,1 48276,0 48299,1 48300,0 48340,1 48404,0 48460,1 48514,0 48568,1 48638,0 48718,1 48795,0 48856,1 48926,0 49010,1 49044,0 49067,1 49095,0 49170,1 49233,0 49264,1 49316,0 49348,1 49378,0 49403,1 49429,0 49460,1 49464,0 49490,1 49546,0 49572,1 end initlist a25 0,0 13,1 76,0 148,1 153,0 240,1 246,0 319,1 385,0 386,1 447,0 470,1 487,0 515,1 526,0 565,1 575,0 625,1 626,0 643,1 674,0 771,1 816,0 837,1 933,0 936,1 999,0 1050,1 1123,0 1169,1 1237,0 1299,1 1310,0 1351,1 1407,0 1479,1 1498,0 1508,1 1511,0 1537,1 1593,0 1652,1 1685,0 1718,1 1723,0 1819,1 1919,0 1934,1 1989,0 2058,1 2088,0 2128,1 2206,0 2250,1 2251,0 2342,1 2440,0 2491,1 2515,0 2562,1 2623,0 2656,1 2691,0 2697,1 2778,0 2816,1 2863,0 2938,1 2953,0 2998,1 3075,0 3147,1 3160,0 3248,1 3249,0 3322,1 3353,0 3391,1 3435,0 3448,1 3497,0 3583,1 3679,0 3687,1 3783,0 3847,1 3887,0 3936,1 4005,0 4085,1 4146,0 4157,1 4220,0 4312,1 4408,0 4495,1 4580,0 4679,1 4765,0 4857,1 4946,0 4956,1 5034,0 5074,1 5116,0 5203,1 5221,0 5253,1 5306,0 5369,1 5423,0 5478,1 5555,0 5577,1 5651,0 5708,1 5791,0 5867,1 5952,0 6010,1 6104,0 6110,1 6142,0 6202,1 6255,0 6268,1 6333,0 6382,1 6457,0 6479,1 6496,0 6578,1 6589,0 6608,1 6629,0 6642,1 6674,0 6693,1 6736,0 6744,1 6840,0 6849,1 6943,0 7015,1 7067,0 7115,1 7180,0 7279,1 7302,0 7326,1 7351,0 7354,1 7398,0 7399,1 7447,0 7451,1 7490,0 7585,1 7594,0 7645,1 7668,0 7678,1 7680,0 7690,1 7782,0 7873,1 7913,0 7963,1 7972,0 8056,1 8071,0 8155,1 8224,0 8295,1 8305,0 8369,1 8412,0 8475,1 8556,0 8638,1 8671,0 8697,1 8717,0 8805,1 8820,0 8825,1 8864,0 8904,1 8934,0 9006,1 9068,0 9091,1 9109,0 9162,1 9196,0 9223,1 9300,0 9334,1 9353,0 9433,1 9463,0 9558,1 9629,0 9675,1 9728,0 9773,1 9855,0 9910,1 9915,0 10006,1 10045,0 10053,1 10097,0 10122,1 10125,0 10173,1 10205,0 10285,1 10371,0 10379,1 10385,0 10462,1 10541,0 10569,1 10659,0 10703,1 10778,0 10799,1 10878,0 10970,1 10991,0 11027,1 11090,0 11098,1 11157,0 11252,1 11258,0 11274,1 11328,0 11415,1 11476,0 11521,1 11529,0 11567,1 11635,0 11661,1 11677,0 11697,1 11777,0 11800,1 11873,0 11942,1 11972,0 12054,1 12056,0 12068,1 12084,0 12179,1 12252,0 12263,1 12298,0 12372,1 12462,0 12536,1 12551,0 12593,1 12678,0 12777,1 12825,0 12892,1 12977,0 12999,1 13084,0 13174,1 13235,0 13309,1 13403,0 13446,1 13474,0 13492,1 13569,0 13582,1 13585,0 13628,1 13682,0 13755,1 13813,0 13878,1 13919,0 14000,1 14014,0 14020,1 14030,0 14061,1 14117,0 14145,1 14180,0 14239,1 14307,0 14339,1 14396,0 14428,1 14498,0 14583,1 14620,0 14704,1 14791,0 14812,1 14886,0 14900,1 14994,0 15072,1 15156,0 15188,1 15226,0 15295,1 15371,0 15376,1 15447,0 15504,1 15595,0 15667,1 15716,0 15720,1 15740,0 15769,1 15776,0 15822,1 15896,0 15936,1 15957,0 16018,1 16057,0 16120,1 16215,0 16225,1 16229,0 16252,1 16352,0 16372,1 16402,0 16442,1 16540,0 16543,1 16607,0 16619,1 16716,0 16739,1 16825,0 16913,1 16926,0 16929,1 17027,0 17037,1 17092,0 17150,1 17250,0 17312,1 17379,0 17442,1 17462,0 17478,1 17512,0 17532,1 17553,0 17605,1 17659,0 17681,1 17765,0 17818,1 17827,0 17905,1 17966,0 18058,1 18095,0 18168,1 18234,0 18288,1 18370,0 18429,1 18495,0 18554,1 18612,0 18701,1 18716,0 18784,1 18860,0 18943,1 19036,0 19099,1 19139,0 19198,1 19276,0 19364,1 19365,0 19388,1 19401,0 19460,1 19559,0 19588,1 19669,0 19760,1 19850,0 19895,1 19962,0 19995,1 20077,0 20143,1 20204,0 20279,1 20342,0 20358,1 20435,0 20510,1 20596,0 20623,1 20670,0 20717,1 20804,0 20833,1 20923,0 20981,1 21041,0 21093,1 21137,0 21151,1 21180,0 21253,1 21341,0 21435,1 21492,0 21548,1 21595,0 21606,1 21622,0 21633,1 21698,0 21716,1 21798,0 21831,1 21837,0 21871,1 21957,0 21991,1 22085,0 22091,1 22173,0 22257,1 22327,0 22391,1 22441,0 22533,1 22608,0 22618,1 22631,0 22706,1 22713,0 22795,1 22799,0 22806,1 22844,0 22858,1 22936,0 23008,1 23036,0 23083,1 23174,0 23212,1 23252,0 23253,1 23311,0 23400,1 23467,0 23542,1 23589,0 23635,1 23681,0 23718,1 23804,0 23831,1 23897,0 23972,1 24062,0 24162,1 24201,0 24218,1 24272,0 24357,1 24411,0 24450,1 24488,0 24526,1 24572,0 24639,1 24691,0 24764,1 24826,0 24875,1 24908,0 24915,1 24986,0 25008,1 25029,0 25090,1 25139,0 25189,1 25270,0 25344,1 25430,0 25503,1 25545,0 25593,1 25634,0 25722,1 25776,0 25800,1 25896,0 25988,1 25989,0 26053,1 26056,0 26082,1 26147,0 26178,1 26211,0 26260,1 26308,0 26362,1 26438,0 26500,1 26577,0 26595,1 26693,0 26699,1 26788,0 26829,1 26834,0 26905,1 26930,0 26936,1 27006,0 27065,1 27159,0 27161,1 27232,0 27244,1 27250,0 27328,1 27379,0 27476,1 27507,0 27555,1 27588,0 27636,1 27662,0 27738,1 27759,0 27772,1 27804,0 27839,1 27878,0 27942,1 27957,0 28044,1 28112,0 28150,1 28186,0 28196,1 28243,0 28273,1 28363,0 28436,1 28508,0 28599,1 28685,0 28712,1 28734,0 28831,1 28922,0 28955,1 29043,0 29107,1 29147,0 29190,1 29239,0 29305,1 29402,0 29499,1 29567,0 29657,1 29662,0 29741,1 29756,0 29769,1 29822,0 29826,1 29840,0 29887,1 29906,0 29969,1 29996,0 30049,1 30058,0 30064,1 30067,0 30126,1 30129,0 30205,1 30300,0 30307,1 30344,0 30365,1 30374,0 30442,1 30458,0 30534,1 30575,0 30591,1 30606,0 30663,1 30695,0 30756,1 30774,0 30834,1 30899,0 30961,1 30982,0 31070,1 31092,0 31164,1 31223,0 31317,1 31351,0 31367,1 31461,0 31558,1 31631,0 31693,1 31710,0 31745,1 31801,0 31887,1 31925,0 31990,1 32074,0 32159,1 32229,0 32262,1 32336,0 32385,1 32421,0 32422,1 32509,0 32550,1 32560,0 32587,1 32648,0 32736,1 32823,0 32824,1 32847,0 32881,1 32971,0 33066,1 33115,0 33120,1 33191,0 33228,1 33268,0 33338,1 33416,0 33461,1 33545,0 33602,1 33662,0 33744,1 33800,0 33900,1 33979,0 34004,1 34084,0 34090,1 34188,0 34278,1 34361,0 34376,1 34389,0 34407,1 34443,0 34521,1 34543,0 34607,1 34686,0 34775,1 34832,0 34843,1 34866,0 34899,1 34920,0 34984,1 35007,0 35058,1 35068,0 35084,1 35184,0 35199,1 35231,0 35253,1 35311,0 35321,1 35417,0 35465,1 35541,0 35546,1 35562,0 35637,1 35693,0 35777,1 35870,0 35938,1 35990,0 36023,1 36101,0 36122,1 36211,0 36301,1 36393,0 36402,1 36412,0 36507,1 36606,0 36678,1 36767,0 36809,1 36853,0 36899,1 36922,0 36971,1 37041,0 37122,1 37206,0 37272,1 37331,0 37402,1 37485,0 37553,1 37627,0 37694,1 37766,0 37831,1 37889,0 37954,1 37965,0 37994,1 38011,0 38026,1 38118,0 38145,1 38179,0 38180,1 38204,0 38297,1 38361,0 38412,1 38419,0 38519,1 38585,0 38610,1 38615,0 38679,1 38752,0 38795,1 38870,0 38883,1 38962,0 38969,1 39047,0 39105,1 39169,0 39211,1 39246,0 39247,1 39333,0 39337,1 39405,0 39408,1 39450,0 39465,1 39556,0 39633,1 39662,0 39746,1 39801,0 39889,1 39967,0 40044,1 40124,0 40198,1 40294,0 40348,1 40434,0 40462,1 40518,0 40521,1 40575,0 40649,1 40667,0 40699,1 40732,0 40790,1 40797,0 40840,1 40861,0 40882,1 40917,0 41005,1 41103,0 41188,1 41277,0 41318,1 41388,0 41422,1 41492,0 41521,1 41617,0 41643,1 41666,0 41694,1 41726,0 41800,1 41883,0 41921,1 41957,0 41974,1 42032,0 42048,1 42127,0 42155,1 42206,0 42273,1 42278,0 42335,1 42362,0 42376,1 42454,0 42473,1 42546,0 42574,1 42642,0 42700,1 42722,0 42771,1 42810,0 42856,1 42877,0 42970,1 43016,0 43107,1 43195,0 43256,1 43346,0 43408,1 43444,0 43446,1 43458,0 43549,1 43637,0 43659,1 43703,0 43732,1 43751,0 43769,1 43868,0 43951,1 43961,0 43997,1 44043,0 44117,1 44196,0 44281,1 44335,0 44406,1 44486,0 44505,1 44563,0 44596,1 44674,0 44756,1 44769,0 44799,1 44867,0 44875,1 44887,0 44911,1 44969,0 45049,1 45053,0 45118,1 45156,0 45165,1 45263,0 45285,1 45341,0 45425,1 45512,0 45549,1 45562,0 45658,1 45713,0 45801,1 45876,0 45894,1 45959,0 46029,1 46062,0 46151,1 46160,0 46173,1 46192,0 46216,1 46311,0 46322,1 46359,0 46398,1 46402,0 46485,1 46517,0 46542,1 46642,0 46649,1 46689,0 46732,1 46748,0 46756,1 46780,0 46786,1 46789,0 46865,1 46921,0 46970,1 47004,0 47083,1 47105,0 47173,1 47192,0 47282,1 47373,0 47378,1 47411,0 47419,1 47504,0 47510,1 47574,0 47620,1 47654,0 47689,1 47783,0 47863,1 47868,0 47957,1 47988,0 48024,1 48119,0 48153,1 48231,0 48320,1 48330,0 48333,1 48420,0 48421,1 48489,0 48515,1 48615,0 48689,1 48740,0 48790,1 48808,0 48868,1 48886,0 48901,1 48915,0 48976,1 49030,0 49049,1 49072,0 49123,1 49138,0 49171,1 49260,0 49359,1 49371,0 49404,1 49444,0 49497,1 49531,0 49608,1 49621,0 49694,1 49723,0 49758,1 49769,0 49858,1 end initlist a26 0,0 13,1 35,0 95,1 164,0 223,1 308,0 382,1 454,0 460,1 528,0 563,1 585,0 629,1 688,0 761,1 828,0 861,1 947,0 1037,1 1103,0 1115,1 1211,0 1246,1 1301,0 1359,1 1386,0 1426,1 1491,0 1587,1 1651,0 1704,1 1735,0 1807,1 1847,0 1934,1 2019,0 2051,1 2086,0 2133,1 2193,0 2234,1 2302,0 2385,1 2448,0 2457,1 2501,0 2546,1 2567,0 2636,1 2721,0 2818,1 2901,0 2965,1 2969,0 3028,1 3121,0 3130,1 3170,0 3248,1 3249,0 3255,1 3287,0 3337,1 3352,0 3355,1 3363,0 3381,1 3469,0 3513,1 3590,0 3608,1 3657,0 3701,1 3736,0 3752,1 3802,0 3867,1 3954,0 4002,1 4058,0 4156,1 4160,0 4214,1 4257,0 4264,1 4296,0 4341,1 4358,0 4381,1 4442,0 4502,1 4582,0 4656,1 4698,0 4796,1 4814,0 4874,1 4930,0 4952,1 4966,0 5040,1 5125,0 5205,1 5208,0 5304,1 5314,0 5397,1 5436,0 5445,1 5524,0 5602,1 5684,0 5693,1 5696,0 5698,1 5774,0 5857,1 5862,0 5956,1 6016,0 6028,1 6099,0 6100,1 6140,0 6228,1 6288,0 6330,1 6366,0 6454,1 6524,0 6609,1 6659,0 6664,1 6715,0 6789,1 6843,0 6879,1 6954,0 6969,1 7013,0 7084,1 7117,0 7166,1 7176,0 7226,1 7281,0 7347,1 7423,0 7487,1 7548,0 7582,1 7583,0 7605,1 7683,0 7765,1 7788,0 7811,1 7818,0 7917,1 7942,0 8015,1 8107,0 8179,1 8199,0 8238,1 8242,0 8264,1 8293,0 8342,1 8359,0 8414,1 8437,0 8486,1 8524,0 8600,1 8606,0 8644,1 8675,0 8721,1 8784,0 8810,1 8850,0 8948,1 9029,0 9054,1 9134,0 9219,1 9311,0 9378,1 9468,0 9544,1 9633,0 9711,1 9721,0 9726,1 9755,0 9844,1 9926,0 9950,1 9998,0 10019,1 10119,0 10183,1 10209,0 10296,1 10363,0 10450,1 10476,0 10562,1 10570,0 10621,1 10645,0 10667,1 10709,0 10796,1 10890,0 10984,1 11036,0 11080,1 11117,0 11123,1 11132,0 11160,1 11227,0 11252,1 11347,0 11359,1 11376,0 11475,1 11571,0 11615,1 11643,0 11739,1 11833,0 11908,1 11980,0 12014,1 12022,0 12109,1 12178,0 12278,1 12317,0 12342,1 12423,0 12424,1 12439,0 12496,1 12515,0 12615,1 12636,0 12681,1 12703,0 12726,1 12729,0 12827,1 12896,0 12963,1 12980,0 13080,1 13143,0 13171,1 13212,0 13273,1 13335,0 13413,1 13509,0 13518,1 13610,0 13654,1 13691,0 13737,1 13750,0 13844,1 13885,0 13909,1 13964,0 13998,1 14003,0 14086,1 14135,0 14233,1 14299,0 14340,1 14379,0 14436,1 14523,0 14529,1 14550,0 14556,1 14569,0 14664,1 14666,0 14734,1 14745,0 14752,1 14849,0 14905,1 14923,0 14970,1 15058,0 15113,1 15132,0 15173,1 15240,0 15307,1 15354,0 15442,1 15486,0 15564,1 15603,0 15650,1 15690,0 15726,1 15817,0 15842,1 15929,0 16003,1 16014,0 16034,1 16081,0 16177,1 16217,0 16222,1 16315,0 16344,1 16392,0 16464,1 16545,0 16613,1 16683,0 16747,1 16808,0 16822,1 16874,0 16901,1 16912,0 16914,1 16989,0 17043,1 17137,0 17183,1 17250,0 17259,1 17326,0 17371,1 17403,0 17409,1 17475,0 17574,1 17586,0 17661,1 17724,0 17824,1 17899,0 17952,1 17953,0 18008,1 18013,0 18113,1 18141,0 18223,1 18323,0 18338,1 18406,0 18486,1 18521,0 18576,1 18627,0 18662,1 18727,0 18798,1 18897,0 18921,1 18962,0 18963,1 18967,0 19033,1 19079,0 19126,1 19221,0 19277,1 19281,0 19349,1 19364,0 19394,1 19488,0 19519,1 19544,0 19644,1 19688,0 19732,1 19768,0 19787,1 19823,0 19911,1 19942,0 20010,1 20095,0 20116,1 20167,0 20202,1 20229,0 20284,1 20365,0 20453,1 20508,0 20606,1 20706,0 20755,1 20772,0 20785,1 20828,0 20907,1 20948,0 20955,1 20975,0 21009,1 21018,0 21039,1 21082,0 21128,1 21161,0 21175,1 21199,0 21297,1 21377,0 21378,1 21460,0 21537,1 21609,0 21678,1 21775,0 21832,1 21895,0 21942,1 21946,0 22013,1 22029,0 22046,1 22134,0 22219,1 22273,0 22348,1 22435,0 22457,1 22485,0 22526,1 22584,0 22660,1 22739,0 22785,1 22794,0 22875,1 22971,0 23063,1 23093,0 23111,1 23123,0 23205,1 23273,0 23330,1 23335,0 23344,1 23372,0 23382,1 23476,0 23482,1 23550,0 23556,1 23632,0 23724,1 23808,0 23825,1 23830,0 23849,1 23927,0 23966,1 23973,0 24002,1 24061,0 24114,1 24190,0 24271,1 24327,0 24336,1 24393,0 24425,1 24452,0 24515,1 24554,0 24625,1 24700,0 24759,1 24798,0 24804,1 24900,0 24994,1 25059,0 25068,1 25103,0 25183,1 25281,0 25357,1 25382,0 25468,1 25531,0 25549,1 25591,0 25663,1 25744,0 25750,1 25800,0 25813,1 25846,0 25937,1 25994,0 26018,1 26043,0 26064,1 26154,0 26197,1 26249,0 26270,1 26295,0 26320,1 26349,0 26425,1 26429,0 26483,1 26541,0 26631,1 26666,0 26671,1 26759,0 26783,1 26875,0 26923,1 27007,0 27018,1 27100,0 27199,1 27225,0 27302,1 27396,0 27407,1 27443,0 27482,1 27573,0 27596,1 27687,0 27733,1 27823,0 27881,1 27921,0 27941,1 28030,0 28089,1 28096,0 28150,1 28214,0 28312,1 28382,0 28456,1 28466,0 28562,1 28612,0 28708,1 28782,0 28814,1 28914,0 28954,1 28969,0 29069,1 29103,0 29115,1 29194,0 29249,1 29256,0 29269,1 29339,0 29415,1 29469,0 29470,1 29509,0 29517,1 29614,0 29616,1 29688,0 29728,1 29733,0 29798,1 29834,0 29875,1 29891,0 29953,1 29982,0 30009,1 30025,0 30064,1 30081,0 30150,1 30200,0 30295,1 30309,0 30383,1 30423,0 30494,1 30512,0 30513,1 30543,0 30566,1 30634,0 30668,1 30730,0 30735,1 30791,0 30794,1 30891,0 30981,1 30997,0 31015,1 31115,0 31191,1 31277,0 31285,1 31375,0 31384,1 31431,0 31470,1 31561,0 31563,1 31576,0 31631,1 31724,0 31740,1 31825,0 31903,1 31988,0 32016,1 32103,0 32136,1 32201,0 32225,1 32232,0 32234,1 32321,0 32394,1 32487,0 32530,1 32586,0 32606,1 32674,0 32723,1 32735,0 32779,1 32808,0 32869,1 32910,0 32954,1 32987,0 33033,1 33115,0 33137,1 33212,0 33304,1 33353,0 33357,1 33405,0 33422,1 33492,0 33515,1 33582,0 33677,1 33678,0 33681,1 33734,0 33770,1 33772,0 33853,1 33927,0 34015,1 34077,0 34082,1 34156,0 34168,1 34180,0 34225,1 34307,0 34395,1 34420,0 34510,1 34552,0 34642,1 34678,0 34711,1 34765,0 34831,1 34849,0 34942,1 34989,0 35042,1 35071,0 35083,1 35127,0 35132,1 35140,0 35231,1 35295,0 35319,1 35328,0 35416,1 35509,0 35601,1 35605,0 35677,1 35718,0 35785,1 35880,0 35884,1 35896,0 35908,1 35967,0 36001,1 36057,0 36152,1 36214,0 36280,1 36319,0 36412,1 36441,0 36466,1 36538,0 36614,1 36621,0 36679,1 36776,0 36798,1 36820,0 36863,1 36913,0 36987,1 37044,0 37105,1 37139,0 37180,1 37225,0 37264,1 37274,0 37370,1 37422,0 37424,1 37516,0 37587,1 37640,0 37719,1 37791,0 37861,1 37929,0 37989,1 38082,0 38090,1 38158,0 38247,1 38257,0 38334,1 38390,0 38489,1 38535,0 38629,1 38654,0 38695,1 38780,0 38873,1 38888,0 38939,1 38984,0 39024,1 39040,0 39118,1 39127,0 39209,1 39226,0 39308,1 39350,0 39361,1 39415,0 39472,1 39524,0 39537,1 39608,0 39667,1 39757,0 39779,1 39809,0 39871,1 39874,0 39966,1 39990,0 40063,1 40160,0 40222,1 40288,0 40358,1 40386,0 40462,1 40495,0 40563,1 40593,0 40609,1 40657,0 40658,1 40678,0 40752,1 40760,0 40799,1 40894,0 40941,1 40993,0 41020,1 41045,0 41102,1 41137,0 41174,1 41245,0 41265,1 41320,0 41334,1 41372,0 41426,1 41503,0 41520,1 41554,0 41599,1 41669,0 41673,1 41773,0 41851,1 41912,0 41924,1 41925,0 41988,1 42005,0 42044,1 42058,0 42146,1 42185,0 42190,1 42221,0 42263,1 42270,0 42296,1 42352,0 42374,1 42445,0 42537,1 42539,0 42569,1 42658,0 42675,1 42712,0 42719,1 42726,0 42739,1 42760,0 42832,1 42924,0 43001,1 43068,0 43075,1 43129,0 43132,1 43177,0 43180,1 43218,0 43268,1 43275,0 43371,1 43410,0 43422,1 43470,0 43528,1 43568,0 43575,1 43629,0 43644,1 43713,0 43792,1 43860,0 43892,1 43919,0 43932,1 44030,0 44056,1 44127,0 44153,1 44193,0 44203,1 44262,0 44328,1 44410,0 44497,1 44535,0 44602,1 44657,0 44757,1 44819,0 44828,1 44913,0 44959,1 44985,0 45048,1 45145,0 45161,1 45203,0 45238,1 45296,0 45318,1 45418,0 45421,1 45468,0 45501,1 45580,0 45675,1 45688,0 45696,1 45716,0 45788,1 45835,0 45864,1 45918,0 45961,1 45993,0 46044,1 46099,0 46114,1 46180,0 46250,1 46282,0 46316,1 46365,0 46443,1 46540,0 46610,1 46661,0 46694,1 46741,0 46807,1 46863,0 46923,1 46956,0 47014,1 47042,0 47130,1 47150,0 47187,1 47237,0 47303,1 47361,0 47447,1 47506,0 47566,1 47660,0 47718,1 47755,0 47759,1 47836,0 47925,1 47993,0 48053,1 48090,0 48186,1 48214,0 48278,1 48353,0 48359,1 48402,0 48469,1 48487,0 48565,1 48652,0 48669,1 48705,0 48736,1 48756,0 48843,1 48908,0 48948,1 48959,0 49047,1 49137,0 49159,1 49220,0 49224,1 49267,0 49348,1 49416,0 49429,1 49524,0 49616,1 49633,0 49654,1 end initlist a27 0,0 19,1 74,0 83,1 131,0 195,1 214,0 250,1 289,0 297,1 300,0 374,1 421,0 509,1 540,0 632,1 716,0 740,1 776,0 826,1 834,0 934,1 980,0 1026,1 1044,0 1063,1 1133,0 1141,1 1205,0 1279,1 1365,0 1384,1 1426,0 1515,1 1605,0 1646,1 1654,0 1723,1 1787,0 1847,1 1911,0 1937,1 2026,0 2061,1 2124,0 2198,1 2207,0 2211,1 2308,0 2396,1 2487,0 2558,1 2596,0 2615,1 2681,0 2748,1 2808,0 2854,1 2865,0 2892,1 2945,0 3039,1 3120,0 3143,1 3231,0 3323,1 3376,0 3429,1 3446,0 3468,1 3568,0 3651,1 3710,0 3790,1 3867,0 3897,1 3975,0 4066,1 4153,0 4227,1 4269,0 4356,1 4438,0 4520,1 4524,0 4546,1 4603,0 4638,1 4655,0 4745,1 4824,0 4838,1 4879,0 4922,1 5004,0 5081,1 5171,0 5249,1 5263,0 5311,1 5344,0 5407,1 5503,0 5555,1 5611,0 5637,1 5645,0 5735,1 5779,0 5817,1 5894,0 5935,1 5984,0 6065,1 6129,0 6165,1 6225,0 6241,1 6257,0 6275,1 6351,0 6389,1 6451,0 6462,1 6501,0 6504,1 6536,0 6633,1 6677,0 6700,1 6728,0 6734,1 6809,0 6853,1 6859,0 6919,1 7015,0 7105,1 7140,0 7215,1 7257,0 7273,1 7295,0 7345,1 7348,0 7378,1 7391,0 7408,1 7502,0 7562,1 7579,0 7667,1 7757,0 7832,1 7849,0 7859,1 7924,0 8014,1 8033,0 8133,1 8197,0 8254,1 8354,0 8420,1 8462,0 8542,1 8600,0 8691,1 8724,0 8726,1 8801,0 8813,1 8882,0 8895,1 8909,0 8953,1 9022,0 9115,1 9176,0 9201,1 9210,0 9275,1 9371,0 9445,1 9534,0 9624,1 9713,0 9762,1 9788,0 9874,1 9940,0 9990,1 10028,0 10075,1 10145,0 10168,1 10179,0 10193,1 10201,0 10288,1 10292,0 10391,1 10455,0 10526,1 10600,0 10698,1 10738,0 10815,1 10861,0 10960,1 10962,0 11057,1 11068,0 11107,1 11140,0 11202,1 11279,0 11362,1 11415,0 11488,1 11557,0 11575,1 11668,0 11732,1 11775,0 11849,1 11939,0 12031,1 12104,0 12150,1 12155,0 12247,1 12271,0 12313,1 12360,0 12376,1 12470,0 12471,1 12476,0 12502,1 12602,0 12659,1 12758,0 12783,1 12838,0 12843,1 12912,0 13004,1 13078,0 13087,1 13114,0 13207,1 13271,0 13310,1 13376,0 13408,1 13468,0 13547,1 13576,0 13671,1 13730,0 13795,1 13817,0 13842,1 13881,0 13981,1 14056,0 14148,1 14189,0 14191,1 14269,0 14305,1 14336,0 14371,1 14424,0 14454,1 14462,0 14528,1 14541,0 14552,1 14609,0 14620,1 14624,0 14634,1 14688,0 14738,1 14745,0 14750,1 14800,0 14899,1 14963,0 14979,1 15079,0 15124,1 15130,0 15149,1 15156,0 15203,1 15241,0 15334,1 15412,0 15418,1 15442,0 15497,1 15509,0 15581,1 15655,0 15666,1 15737,0 15780,1 15870,0 15896,1 15929,0 16029,1 16088,0 16127,1 16155,0 16182,1 16282,0 16370,1 16399,0 16459,1 16460,0 16533,1 16604,0 16654,1 16739,0 16835,1 16872,0 16904,1 16907,0 16965,1 17022,0 17045,1 17097,0 17099,1 17169,0 17239,1 17260,0 17305,1 17316,0 17373,1 17451,0 17453,1 17467,0 17486,1 17556,0 17649,1 17727,0 17813,1 17866,0 17966,1 17970,0 18050,1 18137,0 18199,1 18272,0 18369,1 18464,0 18473,1 18526,0 18585,1 18672,0 18724,1 18772,0 18813,1 18863,0 18895,1 18929,0 18939,1 18977,0 19068,1 19123,0 19213,1 19297,0 19365,1 19390,0 19445,1 19463,0 19540,1 19609,0 19660,1 19721,0 19769,1 19775,0 19790,1 19832,0 19849,1 19856,0 19888,1 19958,0 19974,1 19994,0 20025,1 20063,0 20145,1 20161,0 20163,1 20201,0 20233,1 20255,0 20307,1 20364,0 20389,1 20484,0 20568,1 20576,0 20641,1 20657,0 20690,1 20788,0 20813,1 20896,0 20968,1 20986,0 21047,1 21138,0 21157,1 21247,0 21293,1 21365,0 21427,1 21470,0 21495,1 21586,0 21606,1 21656,0 21740,1 21743,0 21806,1 21809,0 21813,1 21820,0 21875,1 21881,0 21957,1 22016,0 22039,1 22089,0 22091,1 22098,0 22160,1 22170,0 22234,1 22332,0 22364,1 22401,0 22441,1 22472,0 22520,1 22527,0 22602,1 22665,0 22667,1 22685,0 22749,1 22772,0 22863,1 22944,0 22999,1 23053,0 23126,1 23191,0 23281,1 23290,0 23378,1 23454,0 23458,1 23544,0 23595,1 23598,0 23658,1 23687,0 23752,1 23815,0 23831,1 23859,0 23868,1 23882,0 23947,1 24018,0 24094,1 24163,0 24234,1 24328,0 24402,1 24453,0 24487,1 24489,0 24542,1 24558,0 24612,1 24652,0 24678,1 24685,0 24770,1 24842,0 24900,1 24994,0 25068,1 25132,0 25203,1 25289,0 25380,1 25391,0 25439,1 25497,0 25517,1 25610,0 25641,1 25644,0 25669,1 25755,0 25812,1 25827,0 25907,1 25920,0 25943,1 26040,0 26113,1 26161,0 26225,1 26246,0 26293,1 26329,0 26362,1 26408,0 26492,1 26556,0 26577,1 26633,0 26703,1 26789,0 26877,1 26949,0 27026,1 27077,0 27146,1 27228,0 27229,1 27292,0 27369,1 27404,0 27502,1 27599,0 27696,1 27707,0 27742,1 27798,0 27888,1 27962,0 27974,1 28004,0 28070,1 28120,0 28140,1 28236,0 28304,1 28376,0 28396,1 28466,0 28490,1 28561,0 28571,1 28631,0 28654,1 28700,0 28781,1 28820,0 28857,1 28938,0 28990,1 29013,0 29096,1 29138,0 29196,1 29282,0 29358,1 29392,0 29473,1 29553,0 29647,1 29734,0 29776,1 29821,0 29896,1 29936,0 29973,1 30042,0 30081,1 30102,0 30140,1 30238,0 30259,1 30314,0 30411,1 30442,0 30520,1 30576,0 30632,1 30700,0 30711,1 30759,0 30830,1 30848,0 30932,1 30969,0 31000,1 31072,0 31142,1 31189,0 31261,1 31296,0 31371,1 31440,0 31506,1 31532,0 31621,1 31681,0 31751,1 31779,0 31799,1 31815,0 31875,1 31954,0 31975,1 32020,0 32090,1 32159,0 32228,1 32240,0 32282,1 32369,0 32406,1 32492,0 32495,1 32505,0 32570,1 32657,0 32734,1 32822,0 32859,1 32959,0 33047,1 33077,0 33122,1 33210,0 33285,1 33294,0 33362,1 33407,0 33473,1 33508,0 33534,1 33574,0 33657,1 33749,0 33760,1 33817,0 33916,1 33979,0 33985,1 34044,0 34076,1 34122,0 34195,1 34285,0 34322,1 34345,0 34392,1 34438,0 34460,1 34477,0 34573,1 34599,0 34614,1 34636,0 34638,1 34701,0 34793,1 34810,0 34832,1 34919,0 35013,1 35024,0 35059,1 35150,0 35220,1 35288,0 35302,1 35370,0 35441,1 35520,0 35576,1 35579,0 35598,1 35687,0 35747,1 35845,0 35864,1 35866,0 35949,1 36036,0 36050,1 36079,0 36145,1 36198,0 36251,1 36350,0 36402,1 36455,0 36506,1 36524,0 36597,1 36613,0 36632,1 36687,0 36742,1 36795,0 36871,1 36894,0 36908,1 36950,0 36970,1 37001,0 37032,1 37051,0 37059,1 37093,0 37170,1 37233,0 37243,1 37293,0 37383,1 37468,0 37503,1 37580,0 37582,1 37600,0 37685,1 37688,0 37775,1 37826,0 37874,1 37966,0 37990,1 38015,0 38085,1 38143,0 38190,1 38244,0 38304,1 38382,0 38407,1 38479,0 38536,1 38546,0 38623,1 38723,0 38744,1 38839,0 38887,1 38889,0 38945,1 39030,0 39117,1 39122,0 39152,1 39246,0 39339,1 39438,0 39507,1 39538,0 39619,1 39670,0 39681,1 39758,0 39760,1 39854,0 39879,1 39952,0 40032,1 40075,0 40116,1 40117,0 40140,1 40220,0 40254,1 40278,0 40361,1 40458,0 40510,1 40513,0 40544,1 40597,0 40613,1 40692,0 40766,1 40801,0 40896,1 40944,0 41003,1 41043,0 41044,1 41119,0 41158,1 41178,0 41237,1 41256,0 41269,1 41328,0 41414,1 41488,0 41543,1 41594,0 41631,1 41664,0 41683,1 41704,0 41719,1 41723,0 41805,1 41902,0 41929,1 41991,0 42039,1 42057,0 42151,1 42161,0 42172,1 42205,0 42286,1 42385,0 42484,1 42487,0 42581,1 42635,0 42692,1 42739,0 42810,1 42814,0 42880,1 42958,0 43045,1 43117,0 43165,1 43237,0 43278,1 43322,0 43422,1 43474,0 43553,1 43569,0 43658,1 43749,0 43761,1 43765,0 43777,1 43792,0 43821,1 43917,0 43962,1 43975,0 44034,1 44053,0 44098,1 44104,0 44128,1 44200,0 44244,1 44336,0 44379,1 44470,0 44476,1 44513,0 44590,1 44616,0 44648,1 44676,0 44767,1 44834,0 44843,1 44943,0 44968,1 45008,0 45022,1 45104,0 45125,1 45207,0 45297,1 45300,0 45391,1 45439,0 45473,1 45512,0 45513,1 45518,0 45593,1 45691,0 45695,1 45769,0 45821,1 45835,0 45899,1 45929,0 45950,1 46009,0 46048,1 46052,0 46068,1 46124,0 46193,1 46260,0 46355,1 46452,0 46468,1 46518,0 46540,1 46620,0 46691,1 46746,0 46805,1 46839,0 46871,1 46873,0 46888,1 46964,0 46980,1 47038,0 47054,1 47059,0 47075,1 47102,0 47167,1 47265,0 47332,1 47416,0 47479,1 47534,0 47626,1 47670,0 47726,1 47797,0 47893,1 47976,0 48071,1 48088,0 48111,1 48183,0 48252,1 48292,0 48341,1 48364,0 48367,1 48435,0 48485,1 48554,0 48627,1 48658,0 48671,1 48729,0 48746,1 48774,0 48844,1 48940,0 48943,1 49007,0 49014,1 49042,0 49076,1 49147,0 49167,1 49226,0 49321,1 49384,0 49447,1 49453,0 49549,1 49626,0 49635,1 49669,0 49742,1 49827,0 49840,1 49887,0 49889,1 49900,0 49901,1 49964,0 50023,1 50079,0 50090,1 50093,0 50105,1 50107,0 50137,1 50191,0 50268,1 50341,0 50359,1 50416,0 50498,1 end initlist a28 0,0 81,1 170,0 216,1 282,0 345,1 390,0 423,1 444,0 483,1 487,0 582,1 663,0 739,1 746,0 757,1 812,0 841,1 864,0 915,1 1011,0 1063,1 1135,0 1183,1 1226,0 1235,1 1291,0 1362,1 1421,0 1431,1 1518,0 1586,1 1664,0 1739,1 1824,0 1868,1 1893,0 1934,1 1990,0 2048,1 2148,0 2225,1 2258,0 2330,1 2380,0 2441,1 2459,0 2542,1 2551,0 2625,1 2641,0 2717,1 2762,0 2778,1 2873,0 2969,1 3054,0 3116,1 3138,0 3194,1 3210,0 3288,1 3299,0 3359,1 3452,0 3545,1 3592,0 3676,1 3727,0 3806,1 3904,0 3933,1 3995,0 4043,1 4074,0 4109,1 4145,0 4218,1 4260,0 4275,1 4287,0 4371,1 4400,0 4407,1 4465,0 4467,1 4487,0 4490,1 4518,0 4539,1 4584,0 4649,1 4693,0 4743,1 4820,0 4915,1 4968,0 5025,1 5049,0 5148,1 5217,0 5286,1 5323,0 5377,1 5387,0 5409,1 5415,0 5428,1 5528,0 5541,1 5630,0 5665,1 5731,0 5740,1 5839,0 5898,1 5982,0 6008,1 6106,0 6133,1 6187,0 6191,1 6283,0 6344,1 6410,0 6458,1 6473,0 6555,1 6654,0 6700,1 6713,0 6732,1 6782,0 6874,1 6947,0 7016,1 7044,0 7068,1 7159,0 7219,1 7226,0 7296,1 7391,0 7473,1 7498,0 7500,1 7505,0 7546,1 7616,0 7693,1 7768,0 7863,1 7939,0 7956,1 8050,0 8104,1 8152,0 8225,1 8304,0 8333,1 8359,0 8423,1 8451,0 8482,1 8511,0 8534,1 8583,0 8634,1 8691,0 8716,1 8763,0 8794,1 8854,0 8890,1 8980,0 9012,1 9085,0 9114,1 9184,0 9257,1 9266,0 9340,1 9372,0 9384,1 9462,0 9539,1 9584,0 9660,1 9717,0 9778,1 9781,0 9792,1 9818,0 9882,1 9943,0 9965,1 10058,0 10070,1 10112,0 10210,1 10216,0 10268,1 10324,0 10348,1 10362,0 10421,1 10474,0 10547,1 10596,0 10651,1 10726,0 10755,1 10841,0 10878,1 10924,0 11009,1 11015,0 11080,1 11084,0 11132,1 11181,0 11277,1 11361,0 11363,1 11366,0 11419,1 11476,0 11555,1 11654,0 11742,1 11745,0 11796,1 11841,0 11892,1 11949,0 11975,1 12005,0 12085,1 12111,0 12175,1 12243,0 12294,1 12326,0 12385,1 12458,0 12553,1 12562,0 12657,1 12722,0 12781,1 12862,0 12936,1 13034,0 13073,1 13107,0 13137,1 13144,0 13202,1 13292,0 13385,1 13438,0 13487,1 13555,0 13643,1 13657,0 13713,1 13793,0 13823,1 13834,0 13854,1 13886,0 13930,1 14003,0 14065,1 14117,0 14140,1 14157,0 14163,1 14227,0 14307,1 14378,0 14388,1 14414,0 14448,1 14500,0 14523,1 14589,0 14590,1 14612,0 14687,1 14739,0 14836,1 14863,0 14934,1 14959,0 15008,1 15035,0 15056,1 15081,0 15132,1 15203,0 15245,1 15278,0 15303,1 15386,0 15398,1 15484,0 15495,1 15573,0 15600,1 15697,0 15766,1 15865,0 15952,1 15958,0 15959,1 15991,0 16054,1 16104,0 16136,1 16224,0 16293,1 16331,0 16348,1 16379,0 16478,1 16535,0 16580,1 16667,0 16722,1 16745,0 16762,1 16857,0 16925,1 17019,0 17058,1 17144,0 17207,1 17265,0 17345,1 17413,0 17496,1 17546,0 17570,1 17667,0 17735,1 17819,0 17869,1 17926,0 17954,1 18050,0 18108,1 18179,0 18253,1 18311,0 18376,1 18395,0 18455,1 18479,0 18574,1 18672,0 18694,1 18757,0 18819,1 18847,0 18923,1 19023,0 19088,1 19101,0 19106,1 19170,0 19237,1 19264,0 19356,1 19445,0 19477,1 19567,0 19571,1 19646,0 19653,1 19668,0 19694,1 19703,0 19760,1 19822,0 19852,1 19876,0 19908,1 19972,0 20030,1 20069,0 20110,1 20197,0 20241,1 20331,0 20411,1 20458,0 20494,1 20564,0 20576,1 20641,0 20656,1 20728,0 20751,1 20759,0 20847,1 20943,0 20954,1 21003,0 21033,1 21058,0 21134,1 21187,0 21249,1 21328,0 21369,1 21402,0 21425,1 21508,0 21536,1 21588,0 21680,1 21759,0 21854,1 21874,0 21936,1 21998,0 22097,1 22176,0 22217,1 22236,0 22317,1 22336,0 22371,1 22456,0 22481,1 22580,0 22581,1 22588,0 22647,1 22702,0 22741,1 22791,0 22800,1 22821,0 22920,1 22954,0 23018,1 23035,0 23099,1 23113,0 23142,1 23199,0 23256,1 23333,0 23403,1 23439,0 23446,1 23546,0 23550,1 23637,0 23711,1 23737,0 23816,1 23902,0 23922,1 23926,0 23938,1 23991,0 24023,1 24104,0 24126,1 24147,0 24157,1 24256,0 24315,1 24346,0 24439,1 24464,0 24560,1 24611,0 24683,1 24757,0 24815,1 24840,0 24899,1 24963,0 24992,1 25059,0 25090,1 25163,0 25247,1 25256,0 25318,1 25368,0 25391,1 25444,0 25454,1 25502,0 25590,1 25643,0 25731,1 25752,0 25756,1 25776,0 25781,1 25871,0 25942,1 26012,0 26046,1 26135,0 26154,1 26184,0 26279,1 26290,0 26369,1 26412,0 26437,1 26528,0 26558,1 26637,0 26680,1 26768,0 26799,1 26863,0 26940,1 26985,0 27069,1 27134,0 27202,1 27293,0 27350,1 27434,0 27443,1 27451,0 27541,1 27596,0 27601,1 27657,0 27714,1 27744,0 27803,1 27834,0 27923,1 27954,0 27986,1 28007,0 28042,1 28066,0 28091,1 28181,0 28271,1 28369,0 28372,1 28387,0 28440,1 28449,0 28467,1 28491,0 28520,1 28527,0 28574,1 28611,0 28640,1 28690,0 28752,1 28755,0 28778,1 28828,0 28856,1 28924,0 28936,1 29024,0 29102,1 29189,0 29201,1 29261,0 29357,1 29433,0 29512,1 29576,0 29653,1 29675,0 29707,1 29769,0 29797,1 29813,0 29863,1 29929,0 29969,1 30002,0 30102,1 30117,0 30131,1 30152,0 30198,1 30282,0 30298,1 30359,0 30442,1 30519,0 30601,1 30674,0 30684,1 30688,0 30745,1 30750,0 30842,1 30892,0 30969,1 31059,0 31124,1 31147,0 31229,1 31297,0 31358,1 31410,0 31461,1 31469,0 31470,1 31567,0 31631,1 31691,0 31780,1 31869,0 31879,1 31934,0 32021,1 32032,0 32123,1 32223,0 32250,1 32350,0 32447,1 32451,0 32492,1 32571,0 32598,1 32609,0 32705,1 32794,0 32844,1 32909,0 32936,1 33015,0 33042,1 33046,0 33072,1 33122,0 33217,1 33242,0 33252,1 33307,0 33342,1 33399,0 33452,1 33490,0 33562,1 33644,0 33741,1 33746,0 33839,1 33935,0 33960,1 34025,0 34120,1 34126,0 34161,1 34175,0 34222,1 34318,0 34401,1 34407,0 34482,1 34551,0 34564,1 34664,0 34688,1 34698,0 34702,1 34777,0 34874,1 34901,0 34968,1 35039,0 35103,1 35113,0 35137,1 35161,0 35235,1 35325,0 35408,1 35499,0 35506,1 35537,0 35596,1 35692,0 35733,1 35766,0 35782,1 35820,0 35911,1 35983,0 36039,1 36115,0 36162,1 36259,0 36278,1 36375,0 36396,1 36471,0 36537,1 36591,0 36636,1 36734,0 36797,1 36826,0 36838,1 36840,0 36903,1 36940,0 36984,1 37015,0 37058,1 37110,0 37204,1 37259,0 37284,1 37325,0 37348,1 37412,0 37462,1 37504,0 37595,1 37662,0 37739,1 37827,0 37867,1 37923,0 37988,1 38074,0 38117,1 38155,0 38235,1 38295,0 38370,1 38460,0 38489,1 38565,0 38628,1 38663,0 38763,1 38839,0 38841,1 38936,0 38997,1 39073,0 39109,1 39124,0 39213,1 39246,0 39274,1 39364,0 39389,1 39463,0 39560,1 39643,0 39743,1 39778,0 39875,1 39921,0 39998,1 40035,0 40040,1 40048,0 40132,1 40225,0 40298,1 40358,0 40381,1 40391,0 40422,1 40472,0 40496,1 40549,0 40611,1 40706,0 40739,1 40742,0 40825,1 40920,0 40967,1 41052,0 41085,1 41097,0 41113,1 41153,0 41161,1 41245,0 41322,1 41386,0 41400,1 41457,0 41471,1 41504,0 41561,1 41596,0 41692,1 41717,0 41752,1 41809,0 41846,1 41856,0 41927,1 42023,0 42084,1 42087,0 42151,1 42153,0 42212,1 42231,0 42286,1 42303,0 42348,1 42358,0 42453,1 42476,0 42569,1 42639,0 42644,1 42705,0 42778,1 42822,0 42896,1 42955,0 43049,1 43057,0 43063,1 43124,0 43125,1 43207,0 43241,1 43335,0 43396,1 43445,0 43456,1 43554,0 43651,1 43677,0 43743,1 43837,0 43903,1 43949,0 43995,1 44052,0 44148,1 44224,0 44291,1 44385,0 44393,1 44484,0 44545,1 44569,0 44624,1 44629,0 44699,1 44716,0 44788,1 44796,0 44855,1 44865,0 44935,1 44941,0 44995,1 45065,0 45126,1 45167,0 45252,1 45332,0 45423,1 45448,0 45516,1 45571,0 45670,1 45753,0 45826,1 45851,0 45912,1 45991,0 46088,1 46125,0 46146,1 46204,0 46261,1 46320,0 46418,1 46497,0 46579,1 46672,0 46682,1 46700,0 46750,1 46815,0 46872,1 46908,0 46926,1 47014,0 47030,1 47100,0 47107,1 47191,0 47224,1 47309,0 47407,1 47492,0 47534,1 47574,0 47614,1 47665,0 47693,1 47751,0 47812,1 47899,0 47914,1 47917,0 47983,1 48007,0 48062,1 48089,0 48130,1 48203,0 48209,1 48226,0 48317,1 48405,0 48434,1 48515,0 48603,1 48609,0 48677,1 48737,0 48760,1 48802,0 48897,1 48930,0 48954,1 49022,0 49029,1 49051,0 49088,1 49134,0 49185,1 49208,0 49289,1 49340,0 49380,1 49409,0 49459,1 49470,0 49516,1 49580,0 49627,1 49712,0 49723,1 49729,0 49826,1 49849,0 49919,1 49926,0 49988,1 49990,0 50025,1 50050,0 50067,1 50115,0 50135,1 50194,0 50224,1 50263,0 50310,1 50319,0 50378,1 50443,0 50535,1 50565,0 50642,1 50718,0 50773,1 50802,0 50825,1 50865,0 50884,1 50945,0 51021,1 51057,0 51059,1 51110,0 51154,1 51189,0 51214,1 51230,0 51268,1 end initlist a29 0,0 60,1 88,0 142,1 236,0 315,1 327,0 333,1 357,0 374,1 425,0 508,1 569,0 605,1 619,0 680,1 774,0 862,1 955,0 1011,1 1040,0 1059,1 1081,0 1139,1 1175,0 1219,1 1270,0 1274,1 1374,0 1419,1 1433,0 1477,1 1557,0 1624,1 1664,0 1747,1 1755,0 1772,1 1830,0 1848,1 1855,0 1892,1 1945,0 1999,1 2027,0 2033,1 2124,0 2186,1 2260,0 2312,1 2338,0 2344,1 2423,0 2463,1 2509,0 2554,1 2572,0 2664,1 2709,0 2759,1 2843,0 2937,1 3019,0 3058,1 3105,0 3154,1 3190,0 3290,1 3374,0 3398,1 3449,0 3515,1 3576,0 3621,1 3638,0 3669,1 3755,0 3798,1 3853,0 3930,1 3932,0 4024,1 4073,0 4130,1 4142,0 4186,1 4271,0 4329,1 4423,0 4489,1 4492,0 4506,1 4605,0 4606,1 4635,0 4710,1 4734,0 4834,1 4848,0 4886,1 4954,0 4967,1 5019,0 5048,1 5070,0 5162,1 5214,0 5305,1 5327,0 5385,1 5455,0 5494,1 5584,0 5626,1 5699,0 5723,1 5732,0 5748,1 5813,0 5856,1 5865,0 5895,1 5933,0 5938,1 6037,0 6094,1 6159,0 6193,1 6211,0 6263,1 6332,0 6428,1 6505,0 6576,1 6622,0 6673,1 6729,0 6825,1 6918,0 7017,1 7073,0 7157,1 7195,0 7265,1 7309,0 7369,1 7399,0 7467,1 7501,0 7547,1 7634,0 7666,1 7683,0 7757,1 7788,0 7808,1 7834,0 7837,1 7889,0 7911,1 7972,0 8022,1 8042,0 8093,1 8177,0 8262,1 8299,0 8350,1 8368,0 8465,1 8476,0 8493,1 8502,0 8574,1 8604,0 8625,1 8686,0 8745,1 8831,0 8849,1 8876,0 8903,1 8945,0 9035,1 9053,0 9153,1 9187,0 9264,1 9340,0 9397,1 9469,0 9533,1 9596,0 9655,1 9712,0 9715,1 9806,0 9821,1 9865,0 9881,1 9906,0 9987,1 10079,0 10149,1 10177,0 10223,1 10282,0 10315,1 10327,0 10339,1 10412,0 10463,1 10485,0 10509,1 10549,0 10624,1 10662,0 10749,1 10841,0 10860,1 10907,0 10918,1 10992,0 11019,1 11105,0 11176,1 11211,0 11215,1 11260,0 11330,1 11358,0 11400,1 11405,0 11406,1 11454,0 11554,1 11570,0 11646,1 11711,0 11748,1 11804,0 11878,1 11898,0 11982,1 12002,0 12065,1 12073,0 12135,1 12235,0 12324,1 12422,0 12461,1 12462,0 12549,1 12604,0 12624,1 12691,0 12749,1 12841,0 12863,1 12906,0 12936,1 12954,0 13012,1 13073,0 13133,1 13225,0 13299,1 13301,0 13308,1 13358,0 13419,1 13463,0 13537,1 13549,0 13573,1 13659,0 13663,1 13669,0 13759,1 13808,0 13820,1 13877,0 13956,1 13978,0 14040,1 14058,0 14078,1 14130,0 14141,1 14161,0 14251,1 14322,0 14397,1 14482,0 14581,1 14592,0 14692,1 14735,0 14823,1 14851,0 14862,1 14887,0 14986,1 15030,0 15054,1 15094,0 15119,1 15124,0 15158,1 15169,0 15235,1 15303,0 15330,1 15424,0 15475,1 15557,0 15599,1 15662,0 15751,1 15840,0 15878,1 15928,0 16019,1 16061,0 16120,1 16214,0 16278,1 16324,0 16373,1 16378,0 16394,1 16469,0 16558,1 16561,0 16633,1 16693,0 16789,1 16876,0 16889,1 16937,0 16973,1 16989,0 17083,1 17122,0 17181,1 17243,0 17268,1 17363,0 17387,1 17439,0 17538,1 17565,0 17601,1 17605,0 17629,1 17693,0 17780,1 17797,0 17817,1 17874,0 17941,1 18006,0 18062,1 18063,0 18159,1 18164,0 18212,1 18292,0 18321,1 18416,0 18428,1 18443,0 18528,1 18626,0 18688,1 18691,0 18704,1 18801,0 18852,1 18950,0 19038,1 19052,0 19107,1 19185,0 19212,1 19258,0 19268,1 19272,0 19314,1 19333,0 19424,1 19512,0 19573,1 19643,0 19670,1 19694,0 19721,1 19739,0 19805,1 19811,0 19898,1 19976,0 20011,1 20092,0 20112,1 20119,0 20170,1 20233,0 20313,1 20391,0 20432,1 20433,0 20516,1 20533,0 20570,1 20648,0 20720,1 20725,0 20803,1 20891,0 20899,1 20902,0 20996,1 21048,0 21144,1 21170,0 21232,1 21241,0 21253,1 21311,0 21322,1 21342,0 21394,1 21404,0 21487,1 21497,0 21534,1 21549,0 21555,1 21638,0 21710,1 21737,0 21818,1 21894,0 21946,1 22031,0 22051,1 22070,0 22113,1 22119,0 22207,1 22297,0 22351,1 22390,0 22452,1 22530,0 22595,1 22665,0 22709,1 22720,0 22795,1 22879,0 22977,1 23009,0 23087,1 23147,0 23149,1 23235,0 23298,1 23388,0 23414,1 23449,0 23491,1 23506,0 23516,1 23525,0 23566,1 23649,0 23673,1 23750,0 23827,1 23890,0 23931,1 23999,0 24006,1 24044,0 24053,1 24070,0 24143,1 24209,0 24254,1 24265,0 24279,1 24308,0 24408,1 24468,0 24535,1 24541,0 24597,1 24602,0 24653,1 24689,0 24708,1 24744,0 24777,1 24791,0 24817,1 24909,0 24955,1 24992,0 25039,1 25044,0 25125,1 25203,0 25221,1 25296,0 25379,1 25394,0 25484,1 25563,0 25630,1 25705,0 25712,1 25727,0 25753,1 25825,0 25913,1 26008,0 26021,1 26111,0 26161,1 26247,0 26301,1 26345,0 26415,1 26455,0 26467,1 26512,0 26576,1 26657,0 26708,1 26741,0 26761,1 26795,0 26827,1 26838,0 26847,1 26870,0 26883,1 26887,0 26980,1 27014,0 27093,1 27144,0 27173,1 27217,0 27286,1 27311,0 27332,1 27431,0 27497,1 27550,0 27622,1 27659,0 27678,1 27699,0 27780,1 27797,0 27830,1 27911,0 28000,1 28090,0 28093,1 28145,0 28185,1 28215,0 28232,1 28283,0 28357,1 28389,0 28413,1 28466,0 28499,1 28535,0 28560,1 28568,0 28657,1 28743,0 28805,1 28874,0 28916,1 29000,0 29063,1 29077,0 29169,1 29217,0 29283,1 29311,0 29332,1 29413,0 29492,1 29538,0 29612,1 29669,0 29741,1 29811,0 29851,1 29908,0 29974,1 30032,0 30123,1 30138,0 30156,1 30228,0 30305,1 30324,0 30333,1 30343,0 30415,1 30457,0 30475,1 30573,0 30594,1 30623,0 30705,1 30737,0 30801,1 30841,0 30920,1 31009,0 31057,1 31074,0 31118,1 31177,0 31262,1 31299,0 31352,1 31359,0 31390,1 31398,0 31438,1 31447,0 31482,1 31538,0 31638,1 31705,0 31771,1 31781,0 31864,1 31904,0 31949,1 31978,0 32005,1 32025,0 32035,1 32108,0 32168,1 32268,0 32270,1 32301,0 32386,1 32408,0 32448,1 32494,0 32583,1 32666,0 32720,1 32794,0 32844,1 32888,0 32957,1 32988,0 33084,1 33092,0 33140,1 33168,0 33178,1 33198,0 33276,1 33295,0 33314,1 33401,0 33424,1 33505,0 33566,1 33624,0 33671,1 33719,0 33757,1 33793,0 33841,1 33905,0 33956,1 33981,0 34079,1 34170,0 34202,1 34221,0 34282,1 34379,0 34386,1 34456,0 34467,1 34489,0 34501,1 34511,0 34546,1 34644,0 34650,1 34711,0 34791,1 34832,0 34862,1 34870,0 34961,1 34968,0 34999,1 35009,0 35072,1 35165,0 35229,1 35325,0 35342,1 35397,0 35457,1 35553,0 35618,1 35712,0 35731,1 35732,0 35828,1 35925,0 35944,1 35960,0 36049,1 36074,0 36172,1 36272,0 36327,1 36399,0 36436,1 36518,0 36537,1 36574,0 36576,1 36596,0 36610,1 36655,0 36725,1 36739,0 36783,1 36881,0 36907,1 36996,0 37036,1 37037,0 37046,1 37052,0 37053,1 37065,0 37096,1 37133,0 37174,1 37202,0 37285,1 37298,0 37369,1 37457,0 37506,1 37594,0 37630,1 37661,0 37744,1 37786,0 37796,1 37827,0 37912,1 37967,0 37972,1 38045,0 38114,1 38177,0 38273,1 38310,0 38359,1 38374,0 38443,1 38444,0 38528,1 38628,0 38721,1 38799,0 38862,1 38915,0 38940,1 39024,0 39063,1 39097,0 39140,1 39169,0 39171,1 39239,0 39323,1 39330,0 39414,1 39434,0 39493,1 39571,0 39655,1 39704,0 39780,1 39799,0 39826,1 39860,0 39925,1 39955,0 39965,1 40059,0 40157,1 40205,0 40270,1 40329,0 40338,1 40385,0 40433,1 40513,0 40612,1 40620,0 40665,1 40728,0 40805,1 40863,0 40888,1 40966,0 40988,1 41032,0 41049,1 41103,0 41185,1 41242,0 41253,1 41352,0 41404,1 41430,0 41502,1 41566,0 41622,1 41709,0 41730,1 41769,0 41804,1 41832,0 41926,1 42006,0 42093,1 42179,0 42229,1 42276,0 42361,1 42432,0 42477,1 42520,0 42539,1 42548,0 42560,1 42595,0 42611,1 42613,0 42699,1 42723,0 42784,1 42809,0 42854,1 42899,0 42971,1 42983,0 43067,1 43102,0 43115,1 43207,0 43250,1 43251,0 43342,1 43432,0 43518,1 43551,0 43628,1 43696,0 43792,1 43807,0 43857,1 43943,0 44014,1 44077,0 44143,1 44174,0 44183,1 44252,0 44284,1 44336,0 44387,1 44422,0 44514,1 44520,0 44565,1 44592,0 44632,1 44724,0 44809,1 44823,0 44917,1 44979,0 45029,1 45089,0 45111,1 45135,0 45233,1 45252,0 45259,1 45263,0 45349,1 45368,0 45414,1 45503,0 45536,1 45550,0 45609,1 45696,0 45745,1 45772,0 45852,1 45858,0 45920,1 45949,0 46026,1 46060,0 46131,1 46195,0 46266,1 46361,0 46410,1 46506,0 46515,1 46560,0 46589,1 46591,0 46680,1 46690,0 46725,1 46736,0 46744,1 46820,0 46861,1 46910,0 46987,1 47044,0 47093,1 47171,0 47239,1 47246,0 47264,1 47346,0 47444,1 47485,0 47527,1 47533,0 47536,1 47570,0 47632,1 47642,0 47732,1 47764,0 47825,1 47828,0 47876,1 47972,0 48010,1 48040,0 48110,1 48186,0 48214,1 48216,0 48280,1 48292,0 48314,1 48350,0 48386,1 48482,0 48543,1 48546,0 48639,1 48692,0 48716,1 48725,0 48734,1 48791,0 48863,1 48931,0 48993,1 49051,0 49073,1 end initlist a30 0,0 28,1 54,0 126,1 127,0 219,1 299,0 395,1 486,0 544,1 628,0 651,1 685,0 715,1 734,0 793,1 881,0 968,1 1035,0 1093,1 1184,0 1186,1 1239,0 1287,1 1290,0 1359,1 1385,0 1416,1 1440,0 1518,1 1587,0 1641,1 1700,0 1748,1 1793,0 1860,1 1946,0 1956,1 1996,0 2035,1 2040,0 2089,1 2170,0 2234,1 2253,0 2262,1 2267,0 2367,1 2407,0 2421,1 2519,0 2558,1 2640,0 2672,1 2770,0 2866,1 2893,0 2947,1 2978,0 2984,1 3082,0 3122,1 3132,0 3229,1 3263,0 3296,1 3393,0 3469,1 3493,0 3556,1 3634,0 3703,1 3777,0 3812,1 3840,0 3872,1 3928,0 3968,1 4005,0 4074,1 4156,0 4175,1 4267,0 4364,1 4444,0 4453,1 4455,0 4536,1 4587,0 4631,1 4724,0 4792,1 4799,0 4887,1 4977,0 5023,1 5089,0 5126,1 5217,0 5259,1 5291,0 5323,1 5332,0 5416,1 5419,0 5492,1 5565,0 5654,1 5664,0 5695,1 5713,0 5721,1 5798,0 5870,1 5947,0 5996,1 6096,0 6192,1 6277,0 6335,1 6389,0 6419,1 6494,0 6563,1 6624,0 6633,1 6651,0 6721,1 6761,0 6834,1 6919,0 6999,1 7069,0 7169,1 7185,0 7274,1 7346,0 7432,1 7434,0 7451,1 7489,0 7573,1 7591,0 7617,1 7650,0 7687,1 7782,0 7881,1 7915,0 7939,1 7946,0 7959,1 7983,0 8018,1 8085,0 8120,1 8121,0 8180,1 8263,0 8355,1 8434,0 8495,1 8505,0 8506,1 8536,0 8566,1 8626,0 8643,1 8700,0 8746,1 8810,0 8820,1 8891,0 8899,1 8961,0 9056,1 9118,0 9121,1 9144,0 9186,1 9232,0 9326,1 9331,0 9353,1 9396,0 9410,1 9422,0 9433,1 9477,0 9505,1 9578,0 9589,1 9604,0 9605,1 9704,0 9754,1 9800,0 9854,1 9891,0 9988,1 10068,0 10105,1 10113,0 10153,1 10174,0 10267,1 10356,0 10406,1 10485,0 10546,1 10564,0 10650,1 10653,0 10662,1 10752,0 10830,1 10839,0 10894,1 10954,0 11053,1 11111,0 11197,1 11280,0 11316,1 11338,0 11350,1 11410,0 11503,1 11568,0 11575,1 11622,0 11716,1 11739,0 11797,1 11869,0 11896,1 11954,0 11955,1 11980,0 12010,1 12092,0 12167,1 12196,0 12261,1 12353,0 12439,1 12527,0 12544,1 12597,0 12634,1 12646,0 12685,1 12745,0 12829,1 12893,0 12989,1 13043,0 13049,1 13093,0 13098,1 13124,0 13203,1 13209,0 13299,1 13363,0 13376,1 13464,0 13547,1 13564,0 13591,1 13611,0 13625,1 13682,0 13691,1 13732,0 13801,1 13885,0 13977,1 14027,0 14035,1 14040,0 14051,1 14149,0 14220,1 14265,0 14305,1 14372,0 14443,1 14477,0 14504,1 14575,0 14583,1 14590,0 14598,1 14671,0 14714,1 14794,0 14826,1 14873,0 14940,1 15025,0 15103,1 15108,0 15116,1 15191,0 15243,1 15326,0 15380,1 15454,0 15529,1 15626,0 15675,1 15725,0 15763,1 15798,0 15839,1 15869,0 15940,1 15962,0 16052,1 16117,0 16137,1 16172,0 16188,1 16273,0 16366,1 16388,0 16471,1 16541,0 16625,1 16690,0 16693,1 16791,0 16809,1 16822,0 16844,1 16854,0 16936,1 16995,0 17075,1 17143,0 17148,1 17185,0 17209,1 17238,0 17268,1 17292,0 17390,1 17430,0 17443,1 17452,0 17503,1 17579,0 17643,1 17720,0 17748,1 17803,0 17849,1 17868,0 17957,1 18002,0 18028,1 18053,0 18066,1 18099,0 18130,1 18145,0 18240,1 18287,0 18333,1 18389,0 18412,1 18463,0 18477,1 18493,0 18555,1 18588,0 18653,1 18687,0 18715,1 18810,0 18899,1 18977,0 18993,1 19089,0 19135,1 19171,0 19194,1 19259,0 19325,1 19384,0 19483,1 19526,0 19559,1 19568,0 19586,1 19595,0 19648,1 19673,0 19690,1 19707,0 19779,1 19849,0 19867,1 19868,0 19922,1 19969,0 20031,1 20077,0 20083,1 20098,0 20177,1 20230,0 20297,1 20345,0 20367,1 20435,0 20522,1 20586,0 20596,1 20610,0 20662,1 20759,0 20764,1 20771,0 20843,1 20852,0 20899,1 20972,0 20991,1 21009,0 21101,1 21115,0 21206,1 21213,0 21288,1 21372,0 21410,1 21471,0 21488,1 21563,0 21645,1 21745,0 21766,1 21812,0 21875,1 21932,0 21992,1 22071,0 22086,1 22111,0 22188,1 22249,0 22282,1 22319,0 22399,1 22482,0 22536,1 22568,0 22585,1 22595,0 22674,1 22686,0 22691,1 22736,0 22738,1 22740,0 22764,1 22850,0 22865,1 22910,0 22920,1 22949,0 23032,1 23070,0 23075,1 23148,0 23176,1 23270,0 23356,1 23403,0 23492,1 23542,0 23634,1 23729,0 23778,1 23806,0 23895,1 23987,0 24018,1 24091,0 24113,1 24135,0 24167,1 24244,0 24270,1 24334,0 24372,1 24389,0 24428,1 24471,0 24490,1 24497,0 24499,1 24592,0 24604,1 24621,0 24669,1 24756,0 24849,1 24933,0 25023,1 25029,0 25095,1 25178,0 25187,1 25215,0 25249,1 25256,0 25288,1 25304,0 25376,1 25377,0 25468,1 25509,0 25537,1 25631,0 25646,1 25676,0 25759,1 25814,0 25896,1 25991,0 26043,1 26056,0 26144,1 26185,0 26238,1 26255,0 26278,1 26316,0 26406,1 26455,0 26545,1 26602,0 26633,1 26714,0 26736,1 26772,0 26828,1 26876,0 26944,1 26998,0 27077,1 27170,0 27229,1 27243,0 27328,1 27371,0 27441,1 27496,0 27578,1 27626,0 27660,1 27698,0 27746,1 27805,0 27868,1 27914,0 28012,1 28062,0 28136,1 28150,0 28177,1 28203,0 28205,1 28227,0 28278,1 28285,0 28309,1 28335,0 28405,1 28473,0 28554,1 28654,0 28743,1 28830,0 28927,1 28938,0 29013,1 29065,0 29140,1 29219,0 29226,1 29297,0 29339,1 29351,0 29414,1 29434,0 29469,1 29507,0 29593,1 29629,0 29658,1 29691,0 29742,1 29802,0 29829,1 29883,0 29894,1 29960,0 29977,1 30032,0 30043,1 30073,0 30090,1 30176,0 30187,1 30284,0 30353,1 30365,0 30396,1 30455,0 30540,1 30567,0 30579,1 30602,0 30656,1 30728,0 30774,1 30799,0 30861,1 30911,0 31011,1 31068,0 31121,1 31151,0 31206,1 31259,0 31260,1 31314,0 31378,1 31428,0 31450,1 31523,0 31526,1 31534,0 31601,1 31648,0 31702,1 31728,0 31766,1 31781,0 31794,1 31841,0 31858,1 31958,0 32010,1 32042,0 32112,1 32116,0 32162,1 32180,0 32212,1 32220,0 32300,1 32359,0 32441,1 32449,0 32525,1 32618,0 32699,1 32744,0 32803,1 32823,0 32867,1 32888,0 32908,1 32954,0 32973,1 33028,0 33108,1 33160,0 33260,1 33286,0 33288,1 33377,0 33459,1 33504,0 33587,1 33622,0 33703,1 33727,0 33816,1 33850,0 33911,1 33935,0 34034,1 34057,0 34064,1 34136,0 34171,1 34199,0 34289,1 34343,0 34440,1 34528,0 34564,1 34604,0 34659,1 34733,0 34790,1 34864,0 34924,1 34938,0 35010,1 35078,0 35134,1 35195,0 35204,1 35260,0 35284,1 35362,0 35387,1 35402,0 35497,1 35565,0 35611,1 35633,0 35672,1 35754,0 35795,1 35822,0 35899,1 35931,0 36015,1 36062,0 36113,1 36160,0 36181,1 36236,0 36273,1 36308,0 36343,1 36418,0 36468,1 36531,0 36536,1 36607,0 36687,1 36763,0 36783,1 36847,0 36860,1 36944,0 36970,1 37024,0 37093,1 37157,0 37183,1 37246,0 37291,1 37312,0 37340,1 37412,0 37451,1 37464,0 37562,1 37636,0 37657,1 37659,0 37663,1 37720,0 37779,1 37833,0 37916,1 37999,0 38064,1 38088,0 38138,1 38218,0 38290,1 38360,0 38363,1 38409,0 38422,1 38475,0 38531,1 38608,0 38630,1 38715,0 38718,1 38735,0 38810,1 38816,0 38854,1 38894,0 38920,1 38926,0 38927,1 38998,0 39052,1 39091,0 39144,1 39201,0 39262,1 39278,0 39285,1 39369,0 39451,1 39458,0 39504,1 39549,0 39630,1 39655,0 39675,1 39700,0 39713,1 39740,0 39822,1 39853,0 39929,1 39937,0 40002,1 40028,0 40048,1 40050,0 40056,1 40101,0 40123,1 40137,0 40166,1 40230,0 40321,1 40421,0 40484,1 40535,0 40548,1 40648,0 40653,1 40710,0 40746,1 40794,0 40864,1 40899,0 40932,1 40966,0 40988,1 40991,0 41075,1 41152,0 41180,1 41242,0 41337,1 41344,0 41422,1 41431,0 41465,1 41496,0 41556,1 41632,0 41723,1 41760,0 41801,1 41835,0 41927,1 41928,0 42015,1 42064,0 42126,1 42136,0 42221,1 42288,0 42331,1 42416,0 42421,1 42447,0 42524,1 42531,0 42536,1 42602,0 42630,1 42698,0 42720,1 42814,0 42816,1 42868,0 42946,1 43010,0 43033,1 43034,0 43116,1 43208,0 43235,1 43276,0 43309,1 43400,0 43475,1 43525,0 43589,1 43601,0 43673,1 43739,0 43740,1 43828,0 43849,1 43914,0 43980,1 43994,0 44088,1 44107,0 44167,1 44197,0 44281,1 44321,0 44391,1 44436,0 44450,1 44547,0 44569,1 44586,0 44635,1 44721,0 44791,1 44857,0 44949,1 44968,0 45061,1 45155,0 45195,1 45203,0 45295,1 45351,0 45382,1 45477,0 45556,1 45642,0 45680,1 45780,0 45822,1 45827,0 45860,1 45952,0 46023,1 46088,0 46107,1 46170,0 46172,1 46200,0 46275,1 46364,0 46412,1 46469,0 46559,1 46635,0 46661,1 46694,0 46794,1 46888,0 46892,1 46984,0 46994,1 47043,0 47062,1 47133,0 47191,1 47265,0 47345,1 47373,0 47420,1 47454,0 47466,1 47497,0 47596,1 47632,0 47643,1 47693,0 47777,1 47797,0 47849,1 47946,0 48046,1 48108,0 48205,1 48230,0 48248,1 48321,0 48366,1 48453,0 48542,1 48555,0 48643,1 48652,0 48695,1 48770,0 48836,1 48935,0 48995,1 49079,0 49113,1 49165,0 49231,1 end initlist a31 0,0 69,1 127,0 164,1 241,0 246,1 322,0 332,1 388,0 440,1 446,0 517,1 532,0 584,1 624,0 712,1 743,0 809,1 847,0 921,1 961,0 1039,1 1043,0 1087,1 1167,0 1177,1 1246,0 1270,1 1273,0 1278,1 1299,0 1364,1 1398,0 1405,1 1465,0 1565,1 1571,0 1589,1 1615,0 1701,1 1737,0 1772,1 1858,0 1863,1 1880,0 1980,1 2038,0 2102,1 2106,0 2149,1 2191,0 2231,1 2320,0 2394,1 2476,0 2500,1 2554,0 2618,1 2681,0 2707,1 2741,0 2770,1 2799,0 2804,1 2813,0 2857,1 2951,0 2968,1 3055,0 3059,1 3117,0 3203,1 3246,0 3266,1 3269,0 3313,1 3330,0 3403,1 3445,0 3481,1 3576,0 3660,1 3738,0 3818,1 3892,0 3929,1 3941,0 4003,1 4031,0 4106,1 4181,0 4237,1 4244,0 4258,1 4297,0 4320,1 4370,0 4447,1 4546,0 4570,1 4614,0 4618,1 4708,0 4773,1 4833,0 4839,1 4883,0 4897,1 4912,0 4985,1 5023,0 5038,1 5102,0 5196,1 5284,0 5320,1 5406,0 5411,1 5480,0 5559,1 5566,0 5575,1 5632,0 5688,1 5753,0 5803,1 5811,0 5845,1 5882,0 5954,1 6010,0 6093,1 6104,0 6197,1 6274,0 6367,1 6437,0 6512,1 6546,0 6553,1 6607,0 6675,1 6689,0 6785,1 6843,0 6861,1 6881,0 6973,1 7023,0 7045,1 7140,0 7162,1 7239,0 7294,1 7333,0 7345,1 7374,0 7446,1 7516,0 7604,1 7679,0 7720,1 7757,0 7764,1 7852,0 7919,1 7949,0 7997,1 8053,0 8110,1 8127,0 8222,1 8322,0 8326,1 8399,0 8448,1 8547,0 8639,1 8735,0 8761,1 8775,0 8800,1 8814,0 8862,1 8869,0 8934,1 8949,0 9003,1 9040,0 9123,1 9152,0 9163,1 9201,0 9277,1 9334,0 9378,1 9383,0 9431,1 9511,0 9602,1 9686,0 9747,1 9775,0 9816,1 9828,0 9875,1 9955,0 9978,1 10019,0 10094,1 10120,0 10176,1 10238,0 10312,1 10319,0 10327,1 10417,0 10512,1 10558,0 10638,1 10736,0 10764,1 10850,0 10911,1 11008,0 11104,1 11113,0 11213,1 11279,0 11331,1 11369,0 11449,1 11493,0 11528,1 11609,0 11648,1 11678,0 11776,1 11822,0 11898,1 11931,0 11955,1 11959,0 12001,1 12038,0 12112,1 12128,0 12222,1 12268,0 12357,1 12363,0 12398,1 12483,0 12550,1 12590,0 12648,1 12731,0 12786,1 12877,0 12909,1 12910,0 12985,1 13081,0 13140,1 13228,0 13317,1 13354,0 13405,1 13454,0 13500,1 13525,0 13531,1 13577,0 13617,1 13667,0 13751,1 13847,0 13885,1 13899,0 13985,1 14037,0 14101,1 14134,0 14139,1 14192,0 14199,1 14234,0 14264,1 14303,0 14356,1 14373,0 14435,1 14523,0 14568,1 14600,0 14676,1 14693,0 14746,1 14748,0 14821,1 14849,0 14938,1 14995,0 15025,1 15038,0 15105,1 15145,0 15216,1 15275,0 15314,1 15409,0 15469,1 15519,0 15558,1 15591,0 15671,1 15764,0 15802,1 15881,0 15911,1 15916,0 15932,1 15960,0 16039,1 16135,0 16226,1 16278,0 16372,1 16437,0 16531,1 16629,0 16727,1 16796,0 16886,1 16922,0 16975,1 16999,0 17058,1 17128,0 17164,1 17168,0 17171,1 17210,0 17212,1 17284,0 17350,1 17434,0 17456,1 17460,0 17478,1 17482,0 17555,1 17651,0 17731,1 17812,0 17863,1 17957,0 18028,1 18060,0 18079,1 18115,0 18179,1 18240,0 18247,1 18281,0 18293,1 18311,0 18391,1 18430,0 18522,1 18539,0 18589,1 18642,0 18740,1 18837,0 18912,1 18956,0 18957,1 19047,0 19142,1 19160,0 19225,1 19229,0 19265,1 19273,0 19305,1 19343,0 19366,1 19439,0 19470,1 19481,0 19503,1 19534,0 19551,1 19571,0 19627,1 19664,0 19740,1 19795,0 19817,1 19877,0 19931,1 19966,0 19996,1 20096,0 20155,1 20194,0 20195,1 20208,0 20290,1 20334,0 20354,1 20376,0 20377,1 20385,0 20471,1 20486,0 20556,1 20587,0 20624,1 20665,0 20674,1 20740,0 20829,1 20865,0 20917,1 21016,0 21113,1 21182,0 21185,1 21258,0 21313,1 21325,0 21405,1 21446,0 21532,1 21561,0 21564,1 21599,0 21689,1 21733,0 21775,1 21812,0 21890,1 21937,0 22035,1 22075,0 22145,1 22146,0 22160,1 22196,0 22224,1 22259,0 22338,1 22384,0 22429,1 22430,0 22448,1 22546,0 22634,1 22639,0 22721,1 22786,0 22843,1 22935,0 22993,1 23037,0 23112,1 23194,0 23285,1 23382,0 23463,1 23511,0 23543,1 23611,0 23643,1 23694,0 23780,1 23783,0 23813,1 23895,0 23928,1 23938,0 23982,1 24080,0 24118,1 24213,0 24236,1 24303,0 24359,1 24456,0 24497,1 24530,0 24546,1 24589,0 24596,1 24613,0 24692,1 24750,0 24754,1 24766,0 24841,1 24889,0 24929,1 25006,0 25089,1 25101,0 25120,1 25185,0 25234,1 25293,0 25373,1 25429,0 25455,1 25507,0 25551,1 25628,0 25653,1 25678,0 25680,1 25776,0 25778,1 25825,0 25881,1 25954,0 26054,1 26147,0 26209,1 26258,0 26331,1 26386,0 26417,1 26499,0 26587,1 26641,0 26701,1 26744,0 26811,1 26896,0 26937,1 26980,0 27071,1 27097,0 27106,1 27155,0 27171,1 27182,0 27199,1 27281,0 27283,1 27359,0 27446,1 27496,0 27511,1 27584,0 27681,1 27700,0 27773,1 27869,0 27959,1 27976,0 28047,1 28061,0 28080,1 28136,0 28164,1 28250,0 28277,1 28297,0 28303,1 28363,0 28394,1 28455,0 28548,1 28626,0 28677,1 28767,0 28772,1 28802,0 28884,1 28958,0 29003,1 29035,0 29097,1 29159,0 29241,1 29310,0 29361,1 29427,0 29527,1 29573,0 29666,1 29680,0 29741,1 29743,0 29833,1 29867,0 29946,1 29993,0 30072,1 30129,0 30209,1 30303,0 30324,1 30352,0 30384,1 30442,0 30514,1 30591,0 30629,1 30665,0 30672,1 30679,0 30689,1 30720,0 30804,1 30870,0 30907,1 30914,0 30941,1 31004,0 31039,1 31081,0 31152,1 31240,0 31313,1 31362,0 31392,1 31470,0 31494,1 31515,0 31548,1 31622,0 31699,1 31789,0 31878,1 31928,0 32026,1 32115,0 32140,1 32216,0 32239,1 32291,0 32303,1 32402,0 32410,1 32420,0 32465,1 32484,0 32545,1 32579,0 32625,1 32672,0 32681,1 32749,0 32831,1 32846,0 32898,1 32957,0 33046,1 33123,0 33124,1 33216,0 33234,1 33310,0 33357,1 33438,0 33535,1 33631,0 33698,1 33709,0 33743,1 33751,0 33817,1 33894,0 33983,1 34046,0 34097,1 34157,0 34239,1 34310,0 34405,1 34495,0 34558,1 34568,0 34668,1 34720,0 34774,1 34840,0 34901,1 34913,0 34954,1 34970,0 35016,1 35099,0 35152,1 35201,0 35299,1 35351,0 35364,1 35388,0 35466,1 35472,0 35504,1 35578,0 35641,1 35717,0 35816,1 35877,0 35886,1 35907,0 35964,1 36002,0 36039,1 36138,0 36218,1 36261,0 36286,1 36306,0 36383,1 36425,0 36504,1 36513,0 36550,1 36622,0 36704,1 36777,0 36827,1 36894,0 36985,1 37051,0 37082,1 37092,0 37153,1 37200,0 37233,1 37294,0 37295,1 37327,0 37427,1 37449,0 37487,1 37554,0 37623,1 37648,0 37695,1 37795,0 37893,1 37902,0 37925,1 37933,0 37981,1 38005,0 38023,1 38122,0 38131,1 38147,0 38242,1 38263,0 38319,1 38406,0 38490,1 38538,0 38601,1 38632,0 38703,1 38747,0 38807,1 38897,0 38921,1 38939,0 38985,1 39062,0 39083,1 39130,0 39189,1 39227,0 39266,1 39306,0 39364,1 39366,0 39416,1 39507,0 39518,1 39598,0 39640,1 39693,0 39773,1 39824,0 39877,1 39951,0 39964,1 40021,0 40092,1 40157,0 40195,1 40245,0 40320,1 40331,0 40334,1 40384,0 40483,1 40514,0 40523,1 40589,0 40665,1 40678,0 40708,1 40767,0 40849,1 40852,0 40864,1 40895,0 40962,1 41026,0 41065,1 41145,0 41152,1 41172,0 41188,1 41230,0 41249,1 41336,0 41405,1 41408,0 41475,1 41534,0 41599,1 41668,0 41710,1 41731,0 41770,1 41831,0 41883,1 41924,0 42005,1 42061,0 42142,1 42242,0 42303,1 42311,0 42396,1 42411,0 42502,1 42583,0 42631,1 42661,0 42665,1 42745,0 42838,1 42871,0 42955,1 43047,0 43139,1 43158,0 43160,1 43200,0 43295,1 43383,0 43399,1 43468,0 43553,1 43650,0 43724,1 43757,0 43766,1 43767,0 43866,1 43903,0 43963,1 44060,0 44111,1 44172,0 44264,1 44338,0 44344,1 44359,0 44428,1 44478,0 44482,1 44496,0 44566,1 44656,0 44717,1 44726,0 44788,1 44836,0 44927,1 44981,0 44999,1 45005,0 45065,1 45084,0 45095,1 45176,0 45231,1 45289,0 45385,1 45464,0 45514,1 45534,0 45628,1 45694,0 45730,1 45792,0 45854,1 45909,0 45950,1 45995,0 46024,1 46124,0 46198,1 46243,0 46288,1 46378,0 46418,1 46431,0 46510,1 46562,0 46662,1 46670,0 46733,1 46791,0 46807,1 46891,0 46911,1 46950,0 47050,1 47134,0 47182,1 47229,0 47319,1 47340,0 47429,1 47489,0 47540,1 47626,0 47689,1 47738,0 47814,1 47852,0 47894,1 47980,0 48022,1 48053,0 48105,1 48148,0 48234,1 48277,0 48315,1 48336,0 48358,1 48385,0 48387,1 48410,0 48485,1 48574,0 48581,1 48629,0 48722,1 48750,0 48833,1 48919,0 48971,1 49015,0 49080,1 49156,0 49217,1 49220,0 49258,1 49329,0 49338,1 49342,0 49406,1 49471,0 49556,1 49603,0 49616,1 49652,0 49751,1 49848,0 49935,1 49964,0 49983,1 49985,0 50010,1 50062,0 50083,1 50172,0 50199,1 50219,0 50226,1 50308,0 50391,1 50452,0 50524,1 50572,0 50583,1 50599,0 50631,1 50721,0 50821,1 end initlist b0 0,0 99,1 103,0 110,1 205,0 235,1 261,0 290,1 339,0 411,1 429,0 499,1 534,0 569,1 600,0 665,1 721,0 791,1 819,0 913,1 960,0 962,1 1053,0 1096,1 1125,0 1128,1 1216,0 1236,1 1291,0 1380,1 1464,0 1498,1 1589,0 1682,1 1719,0 1785,1 1798,0 1893,1 1913,0 1977,1 2044,0 2105,1 2138,0 2173,1 2269,0 2316,1 2394,0 2490,1 2565,0 2636,1 2699,0 2793,1 2859,0 2876,1 2950,0 2990,1 3047,0 3106,1 3180,0 3202,1 3299,0 3303,1 3366,0 3464,1 3534,0 3567,1 3641,0 3718,1 3798,0 3845,1 3937,0 3944,1 4026,0 4122,1 4165,0 4183,1 4215,0 4229,1 4263,0 4363,1 4447,0 4511,1 4561,0 4613,1 4647,0 4727,1 4767,0 4857,1 4920,0 4978,1 5015,0 5066,1 5129,0 5147,1 5164,0 5236,1 5304,0 5341,1 5380,0 5402,1 5488,0 5587,1 5656,0 5701,1 5727,0 5789,1 5806,0 5812,1 5839,0 5925,1 6019,0 6021,1 6086,0 6117,1 6174,0 6260,1 6282,0 6339,1 6365,0 6411,1 6438,0 6476,1 6529,0 6602,1 6627,0 6696,1 6775,0 6859,1 6931,0 6946,1 6966,0 6967,1 7030,0 7035,1 7079,0 7167,1 7261,0 7309,1 7312,0 7372,1 7431,0 7523,1 7532,0 7560,1 7653,0 7680,1 7713,0 7729,1 7824,0 7923,1 8009,0 8085,1 8172,0 8260,1 8324,0 8391,1 8422,0 8488,1 8539,0 8541,1 8612,0 8696,1 8756,0 8807,1 8838,0 8920,1 8973,0 8975,1 9041,0 9130,1 9169,0 9235,1 9244,0 9334,1 9348,0 9445,1 9486,0 9572,1 9638,0 9655,1 9700,0 9713,1 9782,0 9816,1 9848,0 9906,1 9917,0 9957,1 9965,0 10029,1 10040,0 10126,1 10161,0 10183,1 10274,0 10367,1 10391,0 10484,1 10566,0 10641,1 10717,0 10812,1 10826,0 10896,1 10960,0 11003,1 11032,0 11130,1 11166,0 11244,1 11248,0 11266,1 11289,0 11303,1 11380,0 11443,1 11494,0 11575,1 11614,0 11677,1 11754,0 11849,1 11948,0 11996,1 12056,0 12153,1 12204,0 12257,1 12297,0 12327,1 12398,0 12420,1 12475,0 12506,1 12535,0 12610,1 12671,0 12728,1 12782,0 12865,1 12875,0 12943,1 13027,0 13045,1 13066,0 13080,1 13113,0 13196,1 13283,0 13339,1 13368,0 13437,1 13471,0 13555,1 13598,0 13640,1 13676,0 13691,1 13734,0 13759,1 13835,0 13903,1 13968,0 13992,1 14006,0 14078,1 14090,0 14097,1 14115,0 14161,1 14186,0 14220,1 14316,0 14345,1 14372,0 14419,1 14484,0 14573,1 14595,0 14618,1 14679,0 14731,1 14830,0 14899,1 14948,0 14967,1 15026,0 15101,1 15191,0 15250,1 15328,0 15331,1 15415,0 15429,1 15490,0 15497,1 15510,0 15523,1 15548,0 15592,1 15603,0 15669,1 15746,0 15808,1 15835,0 15890,1 15939,0 15978,1 16034,0 16119,1 16171,0 16204,1 16300,0 16375,1 16415,0 16458,1 16491,0 16505,1 16593,0 16642,1 16688,0 16726,1 16785,0 16833,1 16845,0 16869,1 16959,0 17009,1 17071,0 17123,1 17154,0 17180,1 17218,0 17287,1 17353,0 17422,1 17502,0 17525,1 17552,0 17604,1 17622,0 17722,1 17803,0 17831,1 17838,0 17879,1 17897,0 17935,1 17946,0 17964,1 17975,0 17987,1 18053,0 18084,1 18135,0 18170,1 18242,0 18265,1 18269,0 18309,1 18313,0 18340,1 18392,0 18400,1 18428,0 18455,1 18545,0 18590,1 18603,0 18670,1 18753,0 18759,1 18856,0 18865,1 18931,0 18965,1 19064,0 19091,1 19101,0 19141,1 19216,0 19232,1 19327,0 19380,1 19381,0 19425,1 19516,0 19547,1 19628,0 19715,1 19814,0 19864,1 19906,0 19939,1 20027,0 20040,1 20077,0 20156,1 20231,0 20255,1 20310,0 20398,1 20433,0 20496,1 20558,0 20619,1 20697,0 20748,1 20770,0 20797,1 20808,0 20872,1 20915,0 20998,1 21025,0 21124,1 21151,0 21197,1 21280,0 21329,1 21368,0 21395,1 21433,0 21505,1 21545,0 21628,1 21657,0 21677,1 21765,0 21815,1 21878,0 21959,1 22048,0 22131,1 22180,0 22197,1 22265,0 22283,1 22324,0 22341,1 22379,0 22455,1 22518,0 22525,1 22611,0 22638,1 22711,0 22769,1 22864,0 22907,1 22938,0 22975,1 23055,0 23092,1 23105,0 23164,1 23230,0 23287,1 23303,0 23349,1 23350,0 23431,1 23490,0 23580,1 23669,0 23683,1 23751,0 23794,1 23804,0 23879,1 23917,0 23920,1 23973,0 24057,1 24123,0 24146,1 24222,0 24302,1 24321,0 24384,1 24440,0 24453,1 24518,0 24561,1 24612,0 24662,1 24667,0 24705,1 24725,0 24815,1 24824,0 24900,1 24962,0 25008,1 25091,0 25102,1 25146,0 25230,1 25271,0 25317,1 25359,0 25366,1 25395,0 25485,1 25533,0 25577,1 25589,0 25653,1 25746,0 25836,1 25886,0 25950,1 25956,0 26037,1 26136,0 26148,1 26224,0 26273,1 26360,0 26384,1 26471,0 26520,1 26620,0 26698,1 26785,0 26858,1 26934,0 26987,1 27025,0 27090,1 27116,0 27183,1 27272,0 27283,1 27335,0 27426,1 27502,0 27547,1 27637,0 27674,1 27725,0 27770,1 27771,0 27787,1 27796,0 27857,1 27934,0 27999,1 28040,0 28127,1 28146,0 28245,1 28337,0 28390,1 28421,0 28485,1 28510,0 28559,1 28581,0 28633,1 28655,0 28679,1 28774,0 28864,1 28889,0 28958,1 28992,0 29045,1 29118,0 29170,1 29198,0 29231,1 29324,0 29335,1 29385,0 29410,1 29445,0 29478,1 29541,0 29547,1 29606,0 29673,1 29765,0 29772,1 29842,0 29920,1 29976,0 30023,1 30072,0 30109,1 30122,0 30156,1 30195,0 30202,1 30215,0 30231,1 30272,0 30277,1 30344,0 30444,1 30462,0 30465,1 30557,0 30626,1 30720,0 30818,1 30900,0 30979,1 31055,0 31151,1 31165,0 31168,1 31237,0 31266,1 31328,0 31329,1 31367,0 31373,1 31382,0 31415,1 31511,0 31577,1 31612,0 31707,1 31745,0 31764,1 31788,0 31814,1 31890,0 31954,1 31973,0 32028,1 32040,0 32110,1 32140,0 32236,1 32280,0 32315,1 32411,0 32452,1 32532,0 32568,1 32655,0 32671,1 32678,0 32774,1 32801,0 32814,1 32904,0 32960,1 32982,0 32994,1 33081,0 33127,1 33227,0 33284,1 33327,0 33390,1 33484,0 33494,1 33545,0 33631,1 33727,0 33732,1 33747,0 33778,1 33857,0 33891,1 33918,0 34003,1 34086,0 34118,1 34180,0 34272,1 34317,0 34402,1 34410,0 34437,1 34441,0 34511,1 34596,0 34660,1 34698,0 34787,1 34788,0 34834,1 34922,0 34966,1 34981,0 35051,1 35134,0 35234,1 35282,0 35285,1 35318,0 35371,1 35457,0 35467,1 35468,0 35533,1 35622,0 35676,1 35717,0 35783,1 35814,0 35844,1 35935,0 35996,1 36084,0 36110,1 36154,0 36195,1 36255,0 36300,1 36382,0 36393,1 36418,0 36419,1 36465,0 36506,1 36568,0 36664,1 36726,0 36778,1 36781,0 36809,1 36865,0 36965,1 37058,0 37087,1 37179,0 37226,1 37324,0 37373,1 37449,0 37534,1 37630,0 37634,1 37726,0 37738,1 37788,0 37855,1 37900,0 37924,1 37965,0 38063,1 38090,0 38116,1 38176,0 38259,1 38355,0 38419,1 38469,0 38473,1 38528,0 38569,1 38617,0 38683,1 38739,0 38756,1 38782,0 38809,1 38833,0 38927,1 39022,0 39055,1 39077,0 39119,1 39208,0 39247,1 39295,0 39360,1 39436,0 39507,1 39515,0 39577,1 39651,0 39652,1 39663,0 39712,1 39720,0 39814,1 39910,0 39927,1 39978,0 39992,1 40031,0 40037,1 40093,0 40117,1 40153,0 40209,1 40280,0 40374,1 40425,0 40506,1 40543,0 40560,1 40616,0 40697,1 40761,0 40860,1 40897,0 40915,1 40957,0 41044,1 41131,0 41141,1 41197,0 41239,1 41297,0 41358,1 41458,0 41494,1 41501,0 41565,1 41567,0 41609,1 41669,0 41769,1 41807,0 41845,1 41924,0 41967,1 42062,0 42123,1 42174,0 42177,1 42202,0 42266,1 42302,0 42369,1 42383,0 42451,1 42456,0 42546,1 42553,0 42597,1 42679,0 42698,1 42783,0 42825,1 42871,0 42875,1 42902,0 42991,1 43012,0 43088,1 43091,0 43191,1 43196,0 43295,1 43343,0 43435,1 43517,0 43526,1 43616,0 43635,1 43670,0 43735,1 43772,0 43791,1 43817,0 43834,1 43900,0 43925,1 43973,0 44021,1 44067,0 44167,1 44197,0 44272,1 44281,0 44298,1 44372,0 44390,1 44482,0 44559,1 44650,0 44654,1 44663,0 44757,1 44853,0 44863,1 44902,0 44973,1 44979,0 44985,1 45011,0 45101,1 45190,0 45221,1 45252,0 45303,1 45350,0 45425,1 45517,0 45546,1 45566,0 45633,1 45675,0 45727,1 45759,0 45816,1 45915,0 45946,1 46030,0 46097,1 46170,0 46206,1 46228,0 46255,1 46335,0 46406,1 46447,0 46490,1 46512,0 46606,1 46614,0 46678,1 46747,0 46762,1 46848,0 46944,1 47007,0 47037,1 47054,0 47147,1 47246,0 47342,1 47383,0 47449,1 47473,0 47530,1 47616,0 47665,1 47681,0 47767,1 47848,0 47864,1 47876,0 47944,1 48010,0 48031,1 48052,0 48129,1 48227,0 48303,1 48384,0 48464,1 48540,0 48567,1 48663,0 48679,1 48700,0 48719,1 48790,0 48797,1 48812,0 48864,1 48898,0 48987,1 49022,0 49098,1 49167,0 49178,1 49233,0 49305,1 49309,0 49409,1 49410,0 49504,1 49511,0 49516,1 49589,0 49689,1 49755,0 49811,1 49817,0 49906,1 49991,0 50087,1 50129,0 50160,1 50245,0 50299,1 50333,0 50414,1 50493,0 50529,1 50559,0 50648,1 50715,0 50716,1 50773,0 50861,1 50907,0 50938,1 50969,0 51034,1 51106,0 51137,1 end initlist b1 0,0 85,1 184,0 217,1 270,0 318,1 406,0 476,1 535,0 559,1 648,0 711,1 758,0 774,1 841,0 849,1 923,0 963,1 971,0 1028,1 1117,0 1164,1 1233,0 1326,1 1372,0 1437,1 1470,0 1494,1 1593,0 1637,1 1728,0 1742,1 1825,0 1924,1 2023,0 2088,1 2135,0 2207,1 2264,0 2303,1 2305,0 2342,1 2344,0 2422,1 2459,0 2540,1 2621,0 2700,1 2744,0 2795,1 2801,0 2810,1 2837,0 2839,1 2898,0 2908,1 2954,0 3022,1 3060,0 3085,1 3102,0 3170,1 3264,0 3269,1 3325,0 3378,1 3455,0 3488,1 3575,0 3594,1 3687,0 3745,1 3770,0 3841,1 3902,0 3950,1 4020,0 4037,1 4091,0 4111,1 4180,0 4194,1 4267,0 4285,1 4335,0 4415,1 4460,0 4473,1 4502,0 4523,1 4536,0 4573,1 4590,0 4655,1 4728,0 4772,1 4858,0 4935,1 4996,0 5074,1 5156,0 5192,1 5228,0 5303,1 5310,0 5384,1 5442,0 5528,1 5561,0 5645,1 5676,0 5759,1 5781,0 5809,1 5831,0 5845,1 5858,0 5951,1 6009,0 6076,1 6091,0 6097,1 6123,0 6199,1 6273,0 6300,1 6313,0 6381,1 6398,0 6489,1 6492,0 6528,1 6608,0 6637,1 6679,0 6748,1 6823,0 6831,1 6922,0 6997,1 7013,0 7048,1 7070,0 7148,1 7177,0 7259,1 7332,0 7432,1 7450,0 7533,1 7569,0 7665,1 7687,0 7736,1 7830,0 7836,1 7927,0 7991,1 8024,0 8034,1 8109,0 8137,1 8191,0 8218,1 8224,0 8227,1 8247,0 8324,1 8398,0 8404,1 8478,0 8542,1 8548,0 8634,1 8686,0 8760,1 8840,0 8917,1 8981,0 8984,1 9050,0 9062,1 9156,0 9208,1 9262,0 9285,1 9348,0 9350,1 9426,0 9506,1 9597,0 9640,1 9709,0 9767,1 9836,0 9909,1 9983,0 9998,1 10091,0 10101,1 10136,0 10175,1 10224,0 10226,1 10247,0 10264,1 10350,0 10438,1 10533,0 10596,1 10626,0 10707,1 10807,0 10892,1 10932,0 11031,1 11043,0 11141,1 11163,0 11253,1 11343,0 11344,1 11443,0 11494,1 11586,0 11646,1 11662,0 11677,1 11704,0 11778,1 11808,0 11830,1 11924,0 11972,1 12027,0 12116,1 12144,0 12176,1 12276,0 12334,1 12344,0 12404,1 12498,0 12556,1 12645,0 12694,1 12787,0 12858,1 12944,0 13011,1 13096,0 13099,1 13195,0 13284,1 13291,0 13378,1 13430,0 13527,1 13552,0 13619,1 13655,0 13709,1 13716,0 13789,1 13800,0 13889,1 13984,0 14054,1 14147,0 14196,1 14231,0 14238,1 14265,0 14363,1 14397,0 14411,1 14427,0 14457,1 14497,0 14553,1 14622,0 14639,1 14652,0 14688,1 14757,0 14764,1 14851,0 14927,1 15024,0 15065,1 15091,0 15157,1 15187,0 15253,1 15292,0 15333,1 15383,0 15422,1 15494,0 15534,1 15541,0 15587,1 15667,0 15741,1 15815,0 15854,1 15917,0 16015,1 16020,0 16067,1 16073,0 16119,1 16169,0 16258,1 16270,0 16279,1 16293,0 16367,1 16456,0 16540,1 16625,0 16720,1 16753,0 16806,1 16893,0 16922,1 16954,0 16982,1 17030,0 17048,1 17060,0 17156,1 17215,0 17253,1 17309,0 17368,1 17405,0 17420,1 17493,0 17494,1 17541,0 17600,1 17661,0 17679,1 17718,0 17787,1 17852,0 17875,1 17916,0 17982,1 17983,0 18024,1 18054,0 18125,1 18143,0 18199,1 18255,0 18260,1 18279,0 18299,1 18347,0 18416,1 18477,0 18577,1 18656,0 18671,1 18693,0 18712,1 18713,0 18768,1 18773,0 18827,1 18900,0 18992,1 19024,0 19102,1 19161,0 19237,1 19270,0 19309,1 19359,0 19368,1 19444,0 19479,1 19481,0 19546,1 19579,0 19587,1 19630,0 19663,1 19670,0 19705,1 19731,0 19787,1 19857,0 19944,1 19968,0 19973,1 20051,0 20132,1 20185,0 20205,1 20285,0 20366,1 20384,0 20390,1 20450,0 20482,1 20555,0 20631,1 20636,0 20671,1 20743,0 20764,1 20828,0 20875,1 20879,0 20959,1 20974,0 21030,1 21049,0 21079,1 21087,0 21114,1 21189,0 21212,1 21261,0 21346,1 21387,0 21390,1 21485,0 21494,1 21503,0 21533,1 21584,0 21663,1 21697,0 21727,1 21789,0 21818,1 21906,0 21907,1 21915,0 22005,1 22027,0 22067,1 22077,0 22146,1 22245,0 22301,1 22346,0 22362,1 22460,0 22548,1 22637,0 22718,1 22802,0 22867,1 22882,0 22964,1 23028,0 23047,1 23089,0 23175,1 23271,0 23278,1 23298,0 23351,1 23352,0 23389,1 23422,0 23449,1 23527,0 23614,1 23675,0 23731,1 23733,0 23739,1 23804,0 23864,1 23882,0 23926,1 24014,0 24025,1 24063,0 24096,1 24195,0 24255,1 24333,0 24395,1 24399,0 24496,1 24594,0 24687,1 24725,0 24779,1 24833,0 24929,1 25003,0 25080,1 25156,0 25162,1 25219,0 25248,1 25339,0 25351,1 25354,0 25396,1 25421,0 25450,1 25501,0 25580,1 25595,0 25681,1 25768,0 25826,1 25838,0 25931,1 25945,0 25992,1 26046,0 26073,1 26155,0 26169,1 26202,0 26242,1 26341,0 26400,1 26497,0 26504,1 26592,0 26608,1 26655,0 26752,1 26808,0 26851,1 26936,0 27005,1 27056,0 27151,1 27236,0 27242,1 27284,0 27346,1 27347,0 27386,1 27427,0 27467,1 27565,0 27580,1 27643,0 27675,1 27745,0 27762,1 27775,0 27778,1 27820,0 27866,1 27883,0 27949,1 28046,0 28090,1 28139,0 28201,1 28226,0 28260,1 28308,0 28319,1 28350,0 28377,1 28420,0 28513,1 28556,0 28583,1 28595,0 28675,1 28708,0 28711,1 28738,0 28760,1 28801,0 28899,1 28972,0 29071,1 29108,0 29162,1 29194,0 29202,1 29213,0 29215,1 29243,0 29314,1 29338,0 29383,1 29424,0 29466,1 29503,0 29594,1 29638,0 29706,1 29762,0 29791,1 29797,0 29828,1 29895,0 29930,1 30011,0 30039,1 30113,0 30116,1 30138,0 30198,1 30234,0 30309,1 30397,0 30459,1 30522,0 30536,1 30613,0 30648,1 30700,0 30791,1 30804,0 30890,1 30894,0 30899,1 30950,0 30987,1 31048,0 31135,1 31190,0 31255,1 31304,0 31379,1 31380,0 31401,1 31481,0 31548,1 31580,0 31582,1 31591,0 31654,1 31707,0 31749,1 31831,0 31834,1 31850,0 31945,1 32040,0 32065,1 32082,0 32171,1 32228,0 32236,1 32322,0 32345,1 32390,0 32420,1 32467,0 32535,1 32597,0 32686,1 32723,0 32741,1 32746,0 32799,1 32811,0 32896,1 32968,0 33016,1 33055,0 33071,1 33111,0 33151,1 33208,0 33243,1 33295,0 33311,1 33358,0 33367,1 33387,0 33415,1 33458,0 33480,1 33501,0 33539,1 33562,0 33604,1 33672,0 33723,1 33788,0 33888,1 33953,0 33967,1 34009,0 34035,1 34079,0 34123,1 34219,0 34284,1 34299,0 34379,1 34434,0 34527,1 34551,0 34598,1 34667,0 34726,1 34771,0 34847,1 34936,0 34968,1 35033,0 35084,1 35148,0 35175,1 35184,0 35245,1 35317,0 35330,1 35342,0 35420,1 35490,0 35503,1 35534,0 35587,1 35600,0 35622,1 35672,0 35749,1 35830,0 35848,1 35880,0 35947,1 35953,0 36052,1 36054,0 36093,1 36103,0 36159,1 36204,0 36290,1 36381,0 36405,1 36447,0 36497,1 36547,0 36589,1 36594,0 36613,1 36713,0 36740,1 36790,0 36811,1 36843,0 36923,1 37001,0 37080,1 37164,0 37241,1 37335,0 37400,1 37430,0 37468,1 37555,0 37600,1 37655,0 37714,1 37778,0 37865,1 37884,0 37893,1 37951,0 37957,1 38036,0 38042,1 38051,0 38108,1 38199,0 38202,1 38291,0 38302,1 38332,0 38362,1 38429,0 38471,1 38539,0 38564,1 38659,0 38751,1 38774,0 38824,1 38907,0 38986,1 39031,0 39084,1 39106,0 39151,1 39222,0 39231,1 39234,0 39250,1 39319,0 39355,1 39426,0 39458,1 39527,0 39548,1 39616,0 39709,1 39714,0 39715,1 39717,0 39764,1 39774,0 39777,1 39835,0 39911,1 39921,0 40007,1 40008,0 40041,1 40115,0 40201,1 40286,0 40302,1 40346,0 40404,1 40409,0 40467,1 40533,0 40560,1 40578,0 40607,1 40643,0 40681,1 40761,0 40835,1 40839,0 40841,1 40918,0 41015,1 41062,0 41159,1 41204,0 41236,1 41304,0 41371,1 41453,0 41537,1 41562,0 41611,1 41616,0 41659,1 41712,0 41769,1 41845,0 41942,1 42016,0 42036,1 42074,0 42116,1 42149,0 42160,1 42250,0 42341,1 42394,0 42428,1 42461,0 42553,1 42620,0 42704,1 42711,0 42723,1 42809,0 42842,1 42895,0 42903,1 42913,0 42945,1 42986,0 43061,1 43132,0 43227,1 43233,0 43331,1 43370,0 43431,1 43508,0 43564,1 43663,0 43675,1 43749,0 43772,1 43827,0 43854,1 43866,0 43880,1 43891,0 43927,1 43984,0 44031,1 44044,0 44053,1 44057,0 44147,1 44217,0 44223,1 44239,0 44263,1 44361,0 44429,1 44441,0 44501,1 44504,0 44522,1 44613,0 44685,1 44697,0 44748,1 44749,0 44821,1 44843,0 44873,1 44960,0 44997,1 45019,0 45023,1 45026,0 45108,1 45158,0 45171,1 45260,0 45357,1 45436,0 45526,1 45626,0 45681,1 45745,0 45778,1 45846,0 45918,1 45982,0 46012,1 46018,0 46095,1 46107,0 46161,1 46242,0 46331,1 46426,0 46459,1 46551,0 46627,1 46710,0 46744,1 46801,0 46874,1 46880,0 46886,1 46944,0 47035,1 47128,0 47131,1 47224,0 47232,1 47248,0 47306,1 47334,0 47417,1 47496,0 47579,1 47599,0 47637,1 47652,0 47744,1 47824,0 47864,1 47884,0 47961,1 48026,0 48029,1 48069,0 48159,1 48240,0 48255,1 48348,0 48419,1 48428,0 48483,1 48537,0 48579,1 48673,0 48698,1 48773,0 48780,1 48866,0 48881,1 48978,0 49043,1 49134,0 49172,1 end initlist b2 0,0 59,1 63,0 136,1 168,0 238,1 285,0 357,1 427,0 527,1 541,0 635,1 692,0 709,1 777,0 801,1 883,0 925,1 947,0 1006,1 1023,0 1059,1 1120,0 1151,1 1196,0 1205,1 1238,0 1283,1 1381,0 1423,1 1507,0 1536,1 1570,0 1653,1 1659,0 1724,1 1750,0 1838,1 1846,0 1938,1 1982,0 2039,1 2061,0 2113,1 2189,0 2237,1 2239,0 2305,1 2308,0 2349,1 2380,0 2403,1 2432,0 2440,1 2521,0 2585,1 2606,0 2660,1 2684,0 2709,1 2714,0 2742,1 2796,0 2837,1 2880,0 2887,1 2931,0 3027,1 3096,0 3120,1 3195,0 3232,1 3255,0 3290,1 3374,0 3463,1 3511,0 3552,1 3646,0 3725,1 3824,0 3864,1 3929,0 3958,1 3966,0 4001,1 4003,0 4078,1 4140,0 4154,1 4184,0 4237,1 4327,0 4341,1 4363,0 4369,1 4398,0 4422,1 4485,0 4578,1 4597,0 4679,1 4688,0 4750,1 4757,0 4840,1 4910,0 4952,1 4973,0 5049,1 5080,0 5112,1 5206,0 5288,1 5332,0 5426,1 5507,0 5533,1 5590,0 5622,1 5629,0 5667,1 5739,0 5782,1 5785,0 5827,1 5858,0 5915,1 5956,0 6025,1 6064,0 6121,1 6161,0 6258,1 6328,0 6402,1 6464,0 6507,1 6522,0 6523,1 6524,0 6609,1 6671,0 6704,1 6709,0 6743,1 6752,0 6851,1 6888,0 6918,1 6959,0 6988,1 6993,0 7054,1 7098,0 7177,1 7265,0 7328,1 7342,0 7403,1 7418,0 7455,1 7530,0 7569,1 7595,0 7599,1 7656,0 7736,1 7808,0 7817,1 7874,0 7947,1 8011,0 8095,1 8103,0 8107,1 8180,0 8225,1 8286,0 8317,1 8343,0 8386,1 8469,0 8488,1 8542,0 8575,1 8583,0 8607,1 8644,0 8678,1 8697,0 8742,1 8787,0 8838,1 8839,0 8842,1 8929,0 8977,1 8992,0 9049,1 9122,0 9214,1 9218,0 9313,1 9376,0 9476,1 9507,0 9531,1 9614,0 9702,1 9739,0 9773,1 9826,0 9902,1 9999,0 10079,1 10110,0 10209,1 10241,0 10331,1 10381,0 10428,1 10479,0 10504,1 10567,0 10604,1 10634,0 10656,1 10716,0 10789,1 10838,0 10926,1 10928,0 10997,1 11048,0 11081,1 11139,0 11195,1 11238,0 11246,1 11263,0 11298,1 11349,0 11356,1 11365,0 11401,1 11471,0 11543,1 11628,0 11691,1 11705,0 11743,1 11799,0 11818,1 11862,0 11956,1 12038,0 12094,1 12108,0 12162,1 12244,0 12300,1 12396,0 12399,1 12431,0 12463,1 12490,0 12527,1 12557,0 12600,1 12670,0 12729,1 12731,0 12734,1 12814,0 12837,1 12845,0 12913,1 12948,0 12988,1 13006,0 13104,1 13155,0 13202,1 13236,0 13253,1 13292,0 13390,1 13445,0 13480,1 13533,0 13591,1 13681,0 13699,1 13709,0 13804,1 13826,0 13848,1 13947,0 14035,1 14068,0 14114,1 14165,0 14210,1 14300,0 14335,1 14352,0 14451,1 14508,0 14513,1 14591,0 14688,1 14712,0 14765,1 14861,0 14958,1 15053,0 15103,1 15114,0 15195,1 15288,0 15349,1 15363,0 15446,1 15532,0 15610,1 15616,0 15660,1 15713,0 15776,1 15871,0 15956,1 15969,0 16044,1 16142,0 16199,1 16225,0 16293,1 16347,0 16426,1 16453,0 16537,1 16565,0 16616,1 16644,0 16736,1 16799,0 16833,1 16903,0 16992,1 17078,0 17095,1 17192,0 17266,1 17360,0 17361,1 17379,0 17473,1 17483,0 17492,1 17573,0 17652,1 17747,0 17787,1 17865,0 17897,1 17988,0 18079,1 18139,0 18155,1 18203,0 18270,1 18335,0 18405,1 18493,0 18520,1 18587,0 18627,1 18637,0 18681,1 18737,0 18795,1 18804,0 18806,1 18861,0 18878,1 18973,0 18987,1 19026,0 19059,1 19135,0 19164,1 19234,0 19256,1 19289,0 19294,1 19324,0 19413,1 19448,0 19455,1 19494,0 19543,1 19556,0 19634,1 19636,0 19681,1 19724,0 19737,1 19824,0 19879,1 19957,0 19963,1 20025,0 20078,1 20092,0 20142,1 20194,0 20285,1 20332,0 20334,1 20409,0 20443,1 20449,0 20545,1 20592,0 20654,1 20728,0 20733,1 20778,0 20783,1 20826,0 20846,1 20889,0 20978,1 21067,0 21107,1 21109,0 21112,1 21117,0 21130,1 21205,0 21213,1 21223,0 21285,1 21308,0 21334,1 21366,0 21396,1 21432,0 21502,1 21538,0 21588,1 21660,0 21668,1 21700,0 21737,1 21772,0 21777,1 21869,0 21881,1 21904,0 21956,1 22047,0 22104,1 22109,0 22203,1 22244,0 22254,1 22265,0 22274,1 22322,0 22353,1 22452,0 22547,1 22563,0 22622,1 22629,0 22632,1 22635,0 22652,1 22659,0 22668,1 22755,0 22759,1 22811,0 22827,1 22836,0 22900,1 22915,0 22989,1 23020,0 23035,1 23112,0 23193,1 23291,0 23346,1 23417,0 23486,1 23523,0 23565,1 23608,0 23683,1 23755,0 23795,1 23893,0 23940,1 23967,0 23977,1 24070,0 24143,1 24177,0 24266,1 24328,0 24348,1 24398,0 24421,1 24469,0 24563,1 24632,0 24664,1 24714,0 24719,1 24791,0 24830,1 24929,0 25017,1 25087,0 25111,1 25159,0 25219,1 25275,0 25342,1 25407,0 25490,1 25544,0 25546,1 25619,0 25698,1 25791,0 25821,1 25865,0 25957,1 26010,0 26038,1 26093,0 26138,1 26176,0 26226,1 26275,0 26332,1 26410,0 26481,1 26534,0 26546,1 26612,0 26663,1 26724,0 26759,1 26839,0 26884,1 26970,0 27043,1 27109,0 27143,1 27168,0 27206,1 27237,0 27302,1 27324,0 27362,1 27429,0 27513,1 27553,0 27631,1 27639,0 27709,1 27730,0 27819,1 27888,0 27963,1 27986,0 28030,1 28091,0 28118,1 28133,0 28209,1 28296,0 28323,1 28418,0 28484,1 28488,0 28524,1 28578,0 28656,1 28702,0 28750,1 28824,0 28887,1 28959,0 28969,1 29056,0 29137,1 29171,0 29190,1 29215,0 29226,1 29297,0 29356,1 29367,0 29419,1 29482,0 29508,1 29559,0 29600,1 29634,0 29697,1 29763,0 29853,1 29903,0 29999,1 30008,0 30076,1 30170,0 30229,1 30282,0 30320,1 30391,0 30476,1 30507,0 30531,1 30615,0 30696,1 30735,0 30798,1 30831,0 30834,1 30931,0 30953,1 31034,0 31088,1 31176,0 31200,1 31243,0 31293,1 31328,0 31382,1 31473,0 31560,1 31569,0 31599,1 31640,0 31685,1 31760,0 31795,1 31806,0 31894,1 31902,0 31928,1 31960,0 32052,1 32097,0 32196,1 32296,0 32354,1 32425,0 32477,1 32488,0 32530,1 32547,0 32643,1 32732,0 32769,1 32813,0 32891,1 32973,0 32994,1 33020,0 33076,1 33083,0 33112,1 33194,0 33285,1 33306,0 33318,1 33379,0 33464,1 33556,0 33572,1 33583,0 33645,1 33685,0 33752,1 33849,0 33923,1 33926,0 33940,1 33980,0 34022,1 34103,0 34120,1 34187,0 34240,1 34288,0 34360,1 34430,0 34453,1 34521,0 34552,1 34569,0 34645,1 34745,0 34791,1 34881,0 34926,1 34962,0 34989,1 35027,0 35091,1 35169,0 35202,1 35245,0 35287,1 35333,0 35366,1 35466,0 35551,1 35586,0 35606,1 35617,0 35633,1 35639,0 35734,1 35754,0 35809,1 35811,0 35877,1 35922,0 35981,1 35988,0 36007,1 36065,0 36137,1 36236,0 36321,1 36391,0 36444,1 36446,0 36495,1 36511,0 36524,1 36597,0 36630,1 36665,0 36745,1 36798,0 36875,1 36917,0 37003,1 37047,0 37079,1 37122,0 37211,1 37302,0 37350,1 37411,0 37492,1 37511,0 37595,1 37680,0 37768,1 37810,0 37892,1 37929,0 37973,1 38047,0 38105,1 38129,0 38143,1 38145,0 38190,1 38257,0 38279,1 38349,0 38445,1 38468,0 38521,1 38567,0 38656,1 38677,0 38747,1 38755,0 38774,1 38863,0 38962,1 39060,0 39120,1 39139,0 39167,1 39194,0 39258,1 39266,0 39295,1 39310,0 39323,1 39412,0 39443,1 39521,0 39608,1 39690,0 39755,1 39801,0 39871,1 39951,0 39989,1 40089,0 40188,1 40219,0 40271,1 40275,0 40351,1 40378,0 40477,1 40479,0 40565,1 40598,0 40695,1 40763,0 40806,1 40860,0 40953,1 41048,0 41133,1 41191,0 41283,1 41324,0 41355,1 41416,0 41456,1 41499,0 41562,1 41599,0 41606,1 41662,0 41755,1 41847,0 41920,1 41979,0 41985,1 42036,0 42068,1 42114,0 42177,1 42195,0 42199,1 42244,0 42271,1 42309,0 42378,1 42453,0 42480,1 42532,0 42596,1 42599,0 42636,1 42681,0 42736,1 42768,0 42807,1 42811,0 42883,1 42978,0 43040,1 43052,0 43150,1 43154,0 43164,1 43218,0 43277,1 43324,0 43400,1 43455,0 43538,1 43583,0 43651,1 43689,0 43778,1 43859,0 43937,1 43974,0 44028,1 44098,0 44167,1 44241,0 44341,1 44415,0 44454,1 44501,0 44593,1 44616,0 44683,1 44720,0 44793,1 44809,0 44897,1 44989,0 45051,1 45132,0 45144,1 45225,0 45227,1 45314,0 45375,1 45472,0 45554,1 45634,0 45711,1 45740,0 45838,1 45890,0 45989,1 46016,0 46027,1 46100,0 46138,1 46150,0 46176,1 46269,0 46338,1 46360,0 46369,1 46423,0 46470,1 46493,0 46570,1 46598,0 46665,1 46757,0 46820,1 46838,0 46887,1 46916,0 47000,1 47067,0 47088,1 47142,0 47216,1 47277,0 47362,1 47452,0 47549,1 47644,0 47696,1 47714,0 47784,1 47835,0 47849,1 47857,0 47859,1 47934,0 47965,1 48056,0 48097,1 48152,0 48222,1 48238,0 48324,1 48354,0 48421,1 48513,0 48516,1 48549,0 48577,1 48636,0 48700,1 48747,0 48764,1 48817,0 48855,1 48939,0 48972,1 49003,0 49015,1 49046,0 49065,1 49135,0 49163,1 49201,0 49265,1 49334,0 49355,1 49388,0 49429,1 49450,0 49494,1 49578,0 49660,1 49693,0 49729,1 49775,0 49849,1 49852,0 49934,1 end initlist b3 0,0 40,1 63,0 86,1 119,0 212,1 251,0 287,1 367,0 432,1 448,0 511,1 594,0 682,1 686,0 782,1 823,0 868,1 898,0 942,1 1020,0 1110,1 1160,0 1246,1 1296,0 1364,1 1421,0 1506,1 1601,0 1635,1 1723,0 1730,1 1809,0 1882,1 1900,0 1947,1 2004,0 2092,1 2190,0 2206,1 2210,0 2214,1 2306,0 2398,1 2474,0 2483,1 2565,0 2621,1 2677,0 2690,1 2691,0 2705,1 2764,0 2854,1 2932,0 2959,1 2978,0 3078,1 3082,0 3119,1 3171,0 3175,1 3255,0 3273,1 3370,0 3449,1 3500,0 3529,1 3609,0 3661,1 3718,0 3781,1 3796,0 3818,1 3865,0 3919,1 3923,0 4011,1 4039,0 4138,1 4173,0 4231,1 4322,0 4346,1 4356,0 4414,1 4508,0 4592,1 4648,0 4684,1 4747,0 4778,1 4819,0 4913,1 4977,0 5003,1 5035,0 5058,1 5061,0 5092,1 5112,0 5163,1 5194,0 5284,1 5289,0 5323,1 5403,0 5442,1 5463,0 5466,1 5562,0 5575,1 5594,0 5645,1 5742,0 5779,1 5807,0 5860,1 5869,0 5908,1 5935,0 5982,1 6007,0 6037,1 6089,0 6148,1 6186,0 6249,1 6347,0 6413,1 6498,0 6594,1 6608,0 6622,1 6643,0 6709,1 6773,0 6868,1 6900,0 6966,1 6978,0 7052,1 7130,0 7155,1 7252,0 7350,1 7427,0 7460,1 7481,0 7554,1 7557,0 7574,1 7601,0 7676,1 7718,0 7750,1 7827,0 7845,1 7876,0 7913,1 7999,0 8046,1 8112,0 8162,1 8223,0 8252,1 8266,0 8288,1 8361,0 8435,1 8463,0 8512,1 8565,0 8572,1 8581,0 8672,1 8768,0 8822,1 8916,0 8938,1 8939,0 8989,1 9059,0 9066,1 9130,0 9176,1 9246,0 9346,1 9387,0 9400,1 9420,0 9430,1 9505,0 9553,1 9651,0 9685,1 9705,0 9767,1 9791,0 9885,1 9915,0 9930,1 10016,0 10025,1 10109,0 10188,1 10247,0 10295,1 10384,0 10410,1 10496,0 10505,1 10548,0 10552,1 10563,0 10606,1 10690,0 10767,1 10858,0 10924,1 10999,0 11018,1 11083,0 11109,1 11176,0 11233,1 11325,0 11342,1 11441,0 11485,1 11583,0 11635,1 11686,0 11699,1 11719,0 11793,1 11828,0 11829,1 11892,0 11957,1 11978,0 12010,1 12015,0 12084,1 12153,0 12234,1 12252,0 12346,1 12361,0 12405,1 12475,0 12526,1 12594,0 12673,1 12772,0 12864,1 12960,0 12970,1 13052,0 13094,1 13192,0 13278,1 13334,0 13408,1 13413,0 13494,1 13506,0 13540,1 13613,0 13628,1 13672,0 13705,1 13752,0 13779,1 13852,0 13930,1 13941,0 13991,1 14022,0 14048,1 14102,0 14158,1 14258,0 14312,1 14373,0 14458,1 14495,0 14502,1 14542,0 14587,1 14624,0 14680,1 14726,0 14785,1 14788,0 14885,1 14910,0 14949,1 15032,0 15113,1 15117,0 15202,1 15274,0 15349,1 15352,0 15446,1 15460,0 15505,1 15596,0 15685,1 15758,0 15823,1 15891,0 15964,1 16036,0 16097,1 16120,0 16195,1 16251,0 16292,1 16306,0 16323,1 16400,0 16464,1 16559,0 16564,1 16638,0 16651,1 16710,0 16791,1 16827,0 16921,1 17007,0 17022,1 17035,0 17119,1 17187,0 17198,1 17202,0 17215,1 17296,0 17315,1 17374,0 17408,1 17453,0 17488,1 17522,0 17543,1 17613,0 17704,1 17781,0 17852,1 17926,0 17966,1 17984,0 18056,1 18156,0 18167,1 18218,0 18271,1 18354,0 18430,1 18520,0 18544,1 18555,0 18603,1 18624,0 18707,1 18784,0 18845,1 18938,0 18991,1 19071,0 19114,1 19204,0 19299,1 19350,0 19392,1 19472,0 19521,1 19580,0 19622,1 19642,0 19696,1 19788,0 19870,1 19900,0 19962,1 20028,0 20041,1 20048,0 20056,1 20121,0 20160,1 20246,0 20264,1 20350,0 20362,1 20378,0 20393,1 20410,0 20451,1 20497,0 20520,1 20592,0 20615,1 20622,0 20681,1 20725,0 20766,1 20794,0 20878,1 20910,0 20938,1 21010,0 21079,1 21120,0 21208,1 21237,0 21278,1 21350,0 21417,1 21448,0 21481,1 21573,0 21613,1 21708,0 21746,1 21832,0 21874,1 21875,0 21929,1 22002,0 22102,1 22158,0 22189,1 22191,0 22248,1 22297,0 22304,1 22397,0 22454,1 22474,0 22557,1 22592,0 22673,1 22692,0 22777,1 22836,0 22896,1 22968,0 22997,1 23060,0 23106,1 23184,0 23280,1 23319,0 23404,1 23486,0 23512,1 23528,0 23565,1 23634,0 23681,1 23744,0 23824,1 23902,0 23959,1 23991,0 24001,1 24056,0 24128,1 24175,0 24214,1 24232,0 24299,1 24378,0 24431,1 24522,0 24531,1 24554,0 24613,1 24701,0 24727,1 24758,0 24765,1 24854,0 24867,1 24878,0 24904,1 24992,0 25053,1 25081,0 25086,1 25141,0 25211,1 25227,0 25317,1 25348,0 25425,1 25437,0 25465,1 25541,0 25578,1 25594,0 25648,1 25673,0 25675,1 25764,0 25791,1 25864,0 25918,1 26007,0 26076,1 26096,0 26106,1 26152,0 26234,1 26288,0 26305,1 26319,0 26373,1 26430,0 26488,1 26545,0 26585,1 26649,0 26677,1 26718,0 26788,1 26813,0 26859,1 26893,0 26908,1 26942,0 27035,1 27040,0 27122,1 27212,0 27249,1 27331,0 27406,1 27435,0 27522,1 27580,0 27658,1 27755,0 27774,1 27859,0 27895,1 27928,0 27947,1 27963,0 27979,1 28060,0 28132,1 28148,0 28237,1 28295,0 28353,1 28397,0 28403,1 28458,0 28551,1 28556,0 28652,1 28737,0 28751,1 28799,0 28871,1 28921,0 28989,1 29025,0 29062,1 29157,0 29252,1 29253,0 29283,1 29295,0 29355,1 29371,0 29428,1 29449,0 29456,1 29483,0 29493,1 29494,0 29524,1 29623,0 29665,1 29678,0 29758,1 29791,0 29816,1 29834,0 29893,1 29985,0 30019,1 30053,0 30145,1 30149,0 30241,1 30295,0 30365,1 30366,0 30420,1 30499,0 30537,1 30542,0 30625,1 30665,0 30673,1 30745,0 30754,1 30831,0 30862,1 30926,0 30940,1 30953,0 31023,1 31075,0 31099,1 31123,0 31174,1 31237,0 31274,1 31373,0 31433,1 31531,0 31571,1 31620,0 31701,1 31756,0 31796,1 31811,0 31854,1 31937,0 31948,1 31979,0 31994,1 32084,0 32126,1 32181,0 32205,1 32286,0 32300,1 32385,0 32407,1 32453,0 32541,1 32577,0 32595,1 32642,0 32646,1 32654,0 32723,1 32805,0 32870,1 32951,0 33041,1 33043,0 33073,1 33106,0 33120,1 33181,0 33239,1 33291,0 33329,1 33406,0 33443,1 33470,0 33483,1 33519,0 33522,1 33616,0 33685,1 33774,0 33872,1 33969,0 33981,1 34049,0 34055,1 34139,0 34200,1 34225,0 34229,1 34256,0 34329,1 34339,0 34358,1 34377,0 34415,1 34449,0 34535,1 34625,0 34648,1 34660,0 34754,1 34817,0 34905,1 34984,0 35012,1 35027,0 35110,1 35194,0 35262,1 35271,0 35308,1 35347,0 35418,1 35512,0 35586,1 35594,0 35664,1 35667,0 35730,1 35775,0 35806,1 35826,0 35829,1 35851,0 35910,1 35953,0 36019,1 36032,0 36088,1 36140,0 36168,1 36220,0 36291,1 36368,0 36390,1 36427,0 36435,1 36512,0 36595,1 36646,0 36714,1 36790,0 36870,1 36911,0 36978,1 37005,0 37072,1 37081,0 37125,1 37135,0 37215,1 37314,0 37413,1 37471,0 37518,1 37577,0 37676,1 37701,0 37784,1 37799,0 37851,1 37949,0 37984,1 38069,0 38084,1 38134,0 38223,1 38308,0 38328,1 38384,0 38437,1 38452,0 38512,1 38602,0 38658,1 38751,0 38769,1 38858,0 38862,1 38955,0 39034,1 39124,0 39131,1 39164,0 39254,1 39259,0 39312,1 39357,0 39360,1 39430,0 39515,1 39531,0 39537,1 39574,0 39674,1 39735,0 39808,1 39837,0 39889,1 39913,0 39979,1 40075,0 40140,1 40157,0 40194,1 40204,0 40269,1 40279,0 40365,1 40425,0 40444,1 40506,0 40560,1 40568,0 40605,1 40636,0 40724,1 40726,0 40754,1 40792,0 40814,1 40893,0 40991,1 41044,0 41050,1 41127,0 41131,1 41178,0 41278,1 41341,0 41350,1 41420,0 41481,1 41527,0 41622,1 41652,0 41653,1 41752,0 41766,1 41850,0 41886,1 41965,0 42035,1 42050,0 42054,1 42125,0 42171,1 42188,0 42250,1 42303,0 42400,1 42477,0 42498,1 42527,0 42603,1 42669,0 42765,1 42831,0 42925,1 42985,0 43021,1 43109,0 43178,1 43239,0 43278,1 43361,0 43436,1 43477,0 43535,1 43547,0 43607,1 43667,0 43727,1 43822,0 43842,1 43902,0 43976,1 43979,0 44064,1 44070,0 44092,1 44133,0 44193,1 44269,0 44315,1 44339,0 44347,1 44402,0 44461,1 44473,0 44500,1 44513,0 44561,1 44614,0 44678,1 44709,0 44793,1 44885,0 44949,1 44963,0 45035,1 45110,0 45206,1 45258,0 45301,1 45343,0 45414,1 45457,0 45503,1 45581,0 45594,1 45671,0 45687,1 45731,0 45825,1 45921,0 46008,1 46079,0 46161,1 46182,0 46244,1 46322,0 46417,1 46420,0 46485,1 46504,0 46517,1 46548,0 46552,1 46622,0 46626,1 46679,0 46724,1 46739,0 46743,1 46802,0 46889,1 46983,0 47058,1 47127,0 47136,1 47196,0 47213,1 47217,0 47228,1 47309,0 47373,1 47453,0 47530,1 47554,0 47608,1 47631,0 47711,1 47772,0 47813,1 47822,0 47899,1 47901,0 47923,1 47960,0 47985,1 48065,0 48155,1 48203,0 48253,1 48333,0 48383,1 48411,0 48477,1 48524,0 48610,1 48654,0 48742,1 48842,0 48930,1 49023,0 49029,1 49077,0 49154,1 49215,0 49295,1 49340,0 49413,1 49425,0 49513,1 49545,0 49604,1 49657,0 49684,1 49778,0 49816,1 49902,0 49947,1 49987,0 50012,1 50040,0 50130,1 50138,0 50193,1 50217,0 50262,1 50333,0 50336,1 50436,0 50456,1 end initlist b4 0,0 43,1 124,0 213,1 247,0 252,1 295,0 323,1 354,0 397,1 414,0 502,1 533,0 609,1 698,0 751,1 817,0 830,1 863,0 869,1 958,0 1012,1 1105,0 1191,1 1211,0 1306,1 1311,0 1349,1 1382,0 1386,1 1431,0 1484,1 1578,0 1673,1 1699,0 1791,1 1884,0 1918,1 1997,0 2071,1 2124,0 2153,1 2232,0 2265,1 2322,0 2405,1 2493,0 2532,1 2536,0 2583,1 2632,0 2712,1 2747,0 2824,1 2838,0 2861,1 2948,0 3048,1 3081,0 3181,1 3276,0 3279,1 3296,0 3332,1 3362,0 3455,1 3484,0 3511,1 3583,0 3636,1 3655,0 3748,1 3773,0 3814,1 3880,0 3943,1 3979,0 4023,1 4029,0 4101,1 4121,0 4141,1 4214,0 4309,1 4352,0 4380,1 4400,0 4456,1 4484,0 4541,1 4578,0 4622,1 4719,0 4760,1 4777,0 4844,1 4873,0 4914,1 4932,0 4966,1 5064,0 5074,1 5147,0 5214,1 5251,0 5345,1 5396,0 5457,1 5487,0 5580,1 5608,0 5629,1 5700,0 5748,1 5814,0 5842,1 5882,0 5916,1 5924,0 5970,1 6066,0 6084,1 6168,0 6227,1 6243,0 6310,1 6336,0 6429,1 6489,0 6532,1 6617,0 6634,1 6711,0 6732,1 6818,0 6910,1 6998,0 7095,1 7127,0 7153,1 7218,0 7276,1 7306,0 7346,1 7406,0 7434,1 7460,0 7480,1 7511,0 7531,1 7547,0 7639,1 7681,0 7690,1 7728,0 7733,1 7812,0 7814,1 7850,0 7915,1 7926,0 7933,1 8004,0 8009,1 8079,0 8172,1 8221,0 8229,1 8297,0 8388,1 8436,0 8536,1 8579,0 8637,1 8731,0 8732,1 8832,0 8838,1 8849,0 8936,1 8982,0 9013,1 9092,0 9138,1 9157,0 9173,1 9248,0 9266,1 9330,0 9335,1 9404,0 9502,1 9590,0 9634,1 9675,0 9741,1 9790,0 9882,1 9884,0 9939,1 10035,0 10094,1 10096,0 10116,1 10171,0 10179,1 10218,0 10255,1 10294,0 10375,1 10459,0 10468,1 10488,0 10496,1 10503,0 10591,1 10640,0 10720,1 10747,0 10810,1 10849,0 10921,1 10955,0 11007,1 11083,0 11124,1 11137,0 11187,1 11277,0 11373,1 11379,0 11417,1 11448,0 11505,1 11548,0 11591,1 11630,0 11699,1 11717,0 11755,1 11840,0 11933,1 11959,0 12028,1 12044,0 12122,1 12160,0 12190,1 12198,0 12223,1 12232,0 12326,1 12379,0 12387,1 12456,0 12457,1 12493,0 12518,1 12590,0 12661,1 12713,0 12802,1 12892,0 12915,1 12954,0 12968,1 13015,0 13106,1 13146,0 13149,1 13165,0 13210,1 13293,0 13337,1 13406,0 13472,1 13539,0 13557,1 13576,0 13650,1 13724,0 13816,1 13892,0 13946,1 14017,0 14044,1 14064,0 14090,1 14170,0 14268,1 14299,0 14322,1 14412,0 14456,1 14531,0 14563,1 14603,0 14657,1 14721,0 14794,1 14808,0 14893,1 14919,0 14928,1 15028,0 15125,1 15128,0 15198,1 15269,0 15290,1 15351,0 15352,1 15449,0 15463,1 15527,0 15604,1 15667,0 15698,1 15712,0 15810,1 15883,0 15957,1 16045,0 16081,1 16132,0 16180,1 16256,0 16331,1 16336,0 16424,1 16488,0 16522,1 16548,0 16557,1 16585,0 16636,1 16694,0 16714,1 16804,0 16871,1 16876,0 16909,1 16928,0 16947,1 16972,0 17058,1 17120,0 17164,1 17190,0 17199,1 17263,0 17339,1 17357,0 17436,1 17459,0 17523,1 17529,0 17542,1 17609,0 17690,1 17726,0 17755,1 17803,0 17874,1 17974,0 18022,1 18057,0 18133,1 18208,0 18306,1 18364,0 18393,1 18484,0 18494,1 18539,0 18568,1 18626,0 18710,1 18774,0 18800,1 18875,0 18901,1 18964,0 19062,1 19120,0 19171,1 19267,0 19280,1 19348,0 19376,1 19421,0 19488,1 19583,0 19654,1 19709,0 19789,1 19858,0 19880,1 19928,0 20021,1 20079,0 20171,1 20182,0 20267,1 20338,0 20362,1 20437,0 20501,1 20559,0 20636,1 20688,0 20779,1 20834,0 20857,1 20877,0 20975,1 21048,0 21055,1 21137,0 21138,1 21183,0 21282,1 21322,0 21325,1 21340,0 21439,1 21473,0 21541,1 21603,0 21610,1 21689,0 21781,1 21880,0 21949,1 21958,0 21972,1 22021,0 22022,1 22102,0 22141,1 22222,0 22308,1 22374,0 22469,1 22496,0 22505,1 22581,0 22679,1 22771,0 22784,1 22786,0 22849,1 22923,0 22956,1 22984,0 22997,1 23056,0 23117,1 23136,0 23235,1 23334,0 23393,1 23477,0 23497,1 23520,0 23600,1 23661,0 23696,1 23733,0 23743,1 23794,0 23867,1 23941,0 23977,1 24077,0 24111,1 24188,0 24255,1 24322,0 24362,1 24450,0 24464,1 24466,0 24544,1 24636,0 24641,1 24738,0 24818,1 24890,0 24953,1 25016,0 25022,1 25048,0 25126,1 25183,0 25205,1 25251,0 25253,1 25350,0 25377,1 25439,0 25514,1 25570,0 25596,1 25679,0 25740,1 25820,0 25903,1 25999,0 26045,1 26114,0 26204,1 26210,0 26285,1 26308,0 26358,1 26453,0 26522,1 26530,0 26608,1 26669,0 26708,1 26785,0 26816,1 26868,0 26948,1 26991,0 27069,1 27148,0 27183,1 27234,0 27274,1 27359,0 27404,1 27425,0 27434,1 27472,0 27565,1 27645,0 27743,1 27823,0 27899,1 27979,0 28053,1 28115,0 28185,1 28198,0 28204,1 28230,0 28287,1 28297,0 28311,1 28394,0 28429,1 28453,0 28488,1 28518,0 28541,1 28548,0 28647,1 28682,0 28742,1 28761,0 28800,1 28875,0 28959,1 29048,0 29148,1 29186,0 29194,1 29204,0 29207,1 29216,0 29277,1 29373,0 29469,1 29541,0 29635,1 29673,0 29725,1 29777,0 29794,1 29849,0 29947,1 30008,0 30077,1 30099,0 30136,1 30174,0 30201,1 30221,0 30248,1 30249,0 30300,1 30332,0 30365,1 30463,0 30485,1 30490,0 30532,1 30552,0 30615,1 30656,0 30693,1 30732,0 30832,1 30850,0 30936,1 31006,0 31026,1 31060,0 31101,1 31174,0 31218,1 31280,0 31295,1 31395,0 31404,1 31410,0 31435,1 31439,0 31495,1 31501,0 31594,1 31694,0 31747,1 31845,0 31892,1 31954,0 31977,1 32049,0 32097,1 32127,0 32203,1 32220,0 32310,1 32384,0 32464,1 32517,0 32541,1 32576,0 32650,1 32704,0 32706,1 32725,0 32767,1 32851,0 32884,1 32920,0 32940,1 33029,0 33116,1 33146,0 33240,1 33246,0 33322,1 33333,0 33337,1 33404,0 33476,1 33550,0 33563,1 33601,0 33678,1 33746,0 33752,1 33836,0 33930,1 33988,0 33991,1 34038,0 34137,1 34152,0 34212,1 34271,0 34354,1 34432,0 34518,1 34539,0 34548,1 34629,0 34668,1 34756,0 34774,1 34839,0 34914,1 35011,0 35029,1 35128,0 35166,1 35229,0 35288,1 35345,0 35374,1 35428,0 35457,1 35499,0 35578,1 35594,0 35607,1 35644,0 35731,1 35741,0 35787,1 35858,0 35958,1 35961,0 36013,1 36024,0 36039,1 36078,0 36114,1 36123,0 36135,1 36187,0 36244,1 36319,0 36340,1 36370,0 36418,1 36504,0 36520,1 36552,0 36644,1 36717,0 36741,1 36801,0 36805,1 36903,0 36907,1 36971,0 37053,1 37100,0 37190,1 37270,0 37283,1 37379,0 37408,1 37470,0 37479,1 37482,0 37502,1 37536,0 37612,1 37645,0 37701,1 37748,0 37834,1 37886,0 37905,1 37936,0 37989,1 38028,0 38076,1 38144,0 38147,1 38157,0 38253,1 38297,0 38382,1 38437,0 38478,1 38566,0 38602,1 38671,0 38687,1 38754,0 38763,1 38838,0 38933,1 38992,0 39056,1 39151,0 39220,1 39221,0 39271,1 39290,0 39381,1 39431,0 39495,1 39532,0 39545,1 39559,0 39623,1 39624,0 39666,1 39711,0 39782,1 39860,0 39937,1 39966,0 40047,1 40062,0 40124,1 40148,0 40152,1 40164,0 40214,1 40260,0 40339,1 40345,0 40373,1 40403,0 40423,1 40476,0 40497,1 40547,0 40551,1 40646,0 40742,1 40837,0 40865,1 40936,0 40979,1 41031,0 41123,1 41155,0 41196,1 41226,0 41283,1 41347,0 41379,1 41413,0 41503,1 41586,0 41646,1 41671,0 41755,1 41821,0 41882,1 41912,0 41977,1 42046,0 42048,1 42134,0 42157,1 42180,0 42258,1 42282,0 42314,1 42316,0 42345,1 42378,0 42398,1 42457,0 42540,1 42607,0 42671,1 42770,0 42857,1 42868,0 42896,1 42991,0 43019,1 43079,0 43113,1 43169,0 43214,1 43258,0 43340,1 43417,0 43456,1 43540,0 43631,1 43686,0 43755,1 43774,0 43793,1 43813,0 43848,1 43914,0 43994,1 44027,0 44097,1 44135,0 44224,1 44297,0 44331,1 44415,0 44439,1 44511,0 44588,1 44679,0 44689,1 44753,0 44772,1 44827,0 44833,1 44862,0 44864,1 44955,0 44997,1 45088,0 45099,1 45124,0 45153,1 45190,0 45282,1 45285,0 45361,1 45459,0 45515,1 45605,0 45705,1 45716,0 45758,1 45790,0 45804,1 45858,0 45878,1 45969,0 46004,1 46078,0 46119,1 46125,0 46166,1 46230,0 46321,1 46416,0 46504,1 46564,0 46589,1 46614,0 46638,1 46668,0 46743,1 46803,0 46806,1 46820,0 46862,1 46898,0 46912,1 46974,0 47025,1 47122,0 47217,1 47283,0 47324,1 47383,0 47385,1 47445,0 47477,1 47544,0 47574,1 47609,0 47627,1 47634,0 47678,1 47760,0 47780,1 47834,0 47917,1 47981,0 47997,1 48019,0 48104,1 48131,0 48149,1 48168,0 48226,1 48309,0 48407,1 48489,0 48588,1 48645,0 48732,1 48828,0 48832,1 48877,0 48921,1 48985,0 48997,1 49013,0 49093,1 49115,0 49196,1 49290,0 49337,1 49405,0 49503,1 49507,0 49509,1 49595,0 49615,1 49675,0 49739,1 49827,0 49833,1 49927,0 49988,1 49999,0 50076,1 50167,0 50177,1 50227,0 50272,1 50370,0 50458,1 50531,0 50614,1 50631,0 50670,1 end initlist b5 0,0 34,1 85,0 90,1 182,0 280,1 289,0 302,1 360,0 419,1 461,0 537,1 629,0 724,1 795,0 834,1 913,0 948,1 968,0 1027,1 1104,0 1187,1 1248,0 1264,1 1333,0 1403,1 1487,0 1568,1 1647,0 1708,1 1734,0 1752,1 1769,0 1815,1 1908,0 1970,1 1982,0 2069,1 2078,0 2116,1 2202,0 2236,1 2300,0 2380,1 2384,0 2400,1 2439,0 2441,1 2460,0 2466,1 2552,0 2573,1 2613,0 2622,1 2673,0 2698,1 2729,0 2746,1 2783,0 2814,1 2825,0 2886,1 2965,0 3053,1 3149,0 3213,1 3285,0 3295,1 3357,0 3365,1 3393,0 3458,1 3528,0 3625,1 3650,0 3717,1 3755,0 3843,1 3904,0 3913,1 3972,0 4043,1 4107,0 4192,1 4238,0 4307,1 4334,0 4395,1 4451,0 4476,1 4532,0 4565,1 4604,0 4665,1 4763,0 4808,1 4816,0 4866,1 4867,0 4963,1 5055,0 5153,1 5196,0 5258,1 5349,0 5429,1 5504,0 5600,1 5654,0 5689,1 5773,0 5865,1 5932,0 5991,1 6031,0 6044,1 6110,0 6172,1 6204,0 6213,1 6313,0 6358,1 6431,0 6530,1 6602,0 6611,1 6612,0 6671,1 6679,0 6711,1 6774,0 6850,1 6942,0 7006,1 7106,0 7197,1 7281,0 7378,1 7381,0 7425,1 7502,0 7542,1 7594,0 7688,1 7698,0 7765,1 7809,0 7857,1 7933,0 7949,1 8035,0 8127,1 8144,0 8241,1 8250,0 8270,1 8348,0 8432,1 8488,0 8543,1 8599,0 8670,1 8696,0 8792,1 8892,0 8948,1 9006,0 9095,1 9186,0 9192,1 9258,0 9269,1 9324,0 9352,1 9414,0 9476,1 9543,0 9551,1 9574,0 9640,1 9646,0 9670,1 9688,0 9727,1 9748,0 9818,1 9918,0 9967,1 10039,0 10058,1 10125,0 10141,1 10158,0 10252,1 10284,0 10297,1 10360,0 10449,1 10530,0 10573,1 10663,0 10717,1 10784,0 10881,1 10921,0 10956,1 10998,0 11060,1 11145,0 11183,1 11197,0 11289,1 11367,0 11448,1 11536,0 11627,1 11680,0 11692,1 11768,0 11844,1 11884,0 11905,1 11909,0 11934,1 11969,0 11997,1 12006,0 12036,1 12041,0 12134,1 12181,0 12209,1 12276,0 12306,1 12314,0 12395,1 12418,0 12518,1 12610,0 12672,1 12703,0 12709,1 12766,0 12809,1 12870,0 12915,1 12952,0 13032,1 13037,0 13103,1 13160,0 13191,1 13249,0 13293,1 13315,0 13411,1 13436,0 13524,1 13584,0 13642,1 13683,0 13697,1 13796,0 13841,1 13901,0 13994,1 14084,0 14149,1 14242,0 14274,1 14318,0 14346,1 14430,0 14432,1 14446,0 14492,1 14500,0 14596,1 14607,0 14642,1 14702,0 14802,1 14814,0 14890,1 14939,0 15004,1 15024,0 15071,1 15105,0 15188,1 15260,0 15355,1 15447,0 15480,1 15491,0 15502,1 15548,0 15565,1 15651,0 15678,1 15738,0 15837,1 15927,0 16011,1 16045,0 16066,1 16104,0 16173,1 16192,0 16223,1 16246,0 16316,1 16398,0 16476,1 16499,0 16526,1 16557,0 16562,1 16565,0 16632,1 16660,0 16724,1 16823,0 16856,1 16917,0 16968,1 16970,0 17024,1 17028,0 17036,1 17100,0 17126,1 17209,0 17306,1 17333,0 17426,1 17441,0 17460,1 17494,0 17528,1 17608,0 17652,1 17742,0 17744,1 17762,0 17795,1 17810,0 17878,1 17974,0 18028,1 18100,0 18116,1 18163,0 18256,1 18329,0 18409,1 18509,0 18586,1 18649,0 18711,1 18725,0 18757,1 18846,0 18875,1 18948,0 18994,1 19065,0 19066,1 19109,0 19202,1 19280,0 19329,1 19359,0 19405,1 19409,0 19448,1 19503,0 19579,1 19675,0 19770,1 19861,0 19905,1 19926,0 19952,1 20030,0 20082,1 20166,0 20183,1 20217,0 20310,1 20343,0 20376,1 20418,0 20444,1 20503,0 20593,1 20600,0 20654,1 20737,0 20835,1 20925,0 20978,1 21000,0 21006,1 21009,0 21080,1 21158,0 21166,1 21258,0 21259,1 21318,0 21359,1 21390,0 21414,1 21481,0 21517,1 21520,0 21600,1 21688,0 21746,1 21836,0 21852,1 21930,0 22014,1 22068,0 22080,1 22115,0 22155,1 22157,0 22167,1 22242,0 22283,1 22350,0 22363,1 22426,0 22441,1 22444,0 22467,1 22494,0 22547,1 22609,0 22647,1 22742,0 22788,1 22790,0 22878,1 22952,0 22975,1 23041,0 23084,1 23166,0 23219,1 23292,0 23330,1 23363,0 23419,1 23430,0 23524,1 23527,0 23565,1 23577,0 23636,1 23653,0 23655,1 23694,0 23766,1 23865,0 23959,1 24003,0 24013,1 24039,0 24104,1 24174,0 24273,1 24337,0 24340,1 24342,0 24436,1 24461,0 24528,1 24538,0 24568,1 24581,0 24677,1 24720,0 24788,1 24832,0 24910,1 24917,0 24984,1 25001,0 25031,1 25113,0 25203,1 25228,0 25301,1 25344,0 25369,1 25410,0 25507,1 25539,0 25551,1 25649,0 25740,1 25819,0 25881,1 25968,0 26009,1 26088,0 26137,1 26216,0 26231,1 26268,0 26364,1 26417,0 26487,1 26540,0 26580,1 26645,0 26679,1 26762,0 26857,1 26949,0 27021,1 27039,0 27048,1 27110,0 27203,1 27256,0 27311,1 27327,0 27426,1 27439,0 27481,1 27568,0 27636,1 27653,0 27709,1 27794,0 27891,1 27990,0 28066,1 28142,0 28222,1 28254,0 28269,1 28367,0 28465,1 28540,0 28579,1 28640,0 28721,1 28790,0 28800,1 28870,0 28925,1 28950,0 28984,1 28986,0 29021,1 29055,0 29112,1 29144,0 29162,1 29211,0 29255,1 29307,0 29347,1 29379,0 29469,1 29511,0 29526,1 29534,0 29580,1 29613,0 29648,1 29668,0 29751,1 29799,0 29835,1 29927,0 30007,1 30072,0 30145,1 30169,0 30250,1 30276,0 30373,1 30430,0 30494,1 30517,0 30534,1 30585,0 30627,1 30651,0 30748,1 30825,0 30899,1 30950,0 31050,1 31109,0 31180,1 31202,0 31238,1 31274,0 31279,1 31359,0 31406,1 31488,0 31528,1 31627,0 31692,1 31772,0 31783,1 31828,0 31863,1 31958,0 31960,1 32029,0 32073,1 32104,0 32181,1 32233,0 32304,1 32367,0 32442,1 32507,0 32521,1 32612,0 32639,1 32687,0 32702,1 32750,0 32821,1 32823,0 32846,1 32929,0 32978,1 33074,0 33173,1 33268,0 33306,1 33330,0 33364,1 33418,0 33486,1 33502,0 33550,1 33617,0 33661,1 33724,0 33749,1 33803,0 33804,1 33847,0 33882,1 33956,0 34050,1 34120,0 34189,1 34287,0 34331,1 34334,0 34406,1 34498,0 34585,1 34649,0 34714,1 34767,0 34771,1 34848,0 34905,1 34953,0 34973,1 35032,0 35123,1 35125,0 35178,1 35249,0 35325,1 35368,0 35402,1 35452,0 35476,1 35497,0 35506,1 35516,0 35520,1 35586,0 35646,1 35688,0 35768,1 35775,0 35837,1 35927,0 35938,1 35961,0 36003,1 36097,0 36116,1 36187,0 36238,1 36244,0 36270,1 36342,0 36394,1 36480,0 36548,1 36631,0 36697,1 36749,0 36757,1 36769,0 36867,1 36870,0 36875,1 36893,0 36986,1 37075,0 37078,1 37174,0 37264,1 37292,0 37357,1 37449,0 37501,1 37600,0 37678,1 37687,0 37772,1 37824,0 37866,1 37910,0 37971,1 38029,0 38076,1 38119,0 38189,1 38203,0 38271,1 38294,0 38351,1 38387,0 38434,1 38473,0 38496,1 38554,0 38609,1 38706,0 38767,1 38825,0 38851,1 38921,0 38937,1 38955,0 38993,1 39073,0 39162,1 39227,0 39294,1 39310,0 39343,1 39389,0 39438,1 39444,0 39509,1 39516,0 39605,1 39612,0 39686,1 39744,0 39828,1 39885,0 39923,1 40000,0 40003,1 40058,0 40152,1 40251,0 40327,1 40390,0 40399,1 40476,0 40558,1 40632,0 40670,1 40713,0 40794,1 40815,0 40833,1 40912,0 40993,1 41059,0 41063,1 41133,0 41191,1 41200,0 41242,1 41305,0 41376,1 41451,0 41486,1 41508,0 41541,1 41627,0 41630,1 41675,0 41719,1 41781,0 41822,1 41834,0 41934,1 41959,0 41981,1 41982,0 42003,1 42101,0 42195,1 42215,0 42252,1 42329,0 42380,1 42402,0 42474,1 42544,0 42545,1 42594,0 42670,1 42770,0 42813,1 42828,0 42920,1 42956,0 43011,1 43083,0 43106,1 43177,0 43201,1 43226,0 43266,1 43304,0 43366,1 43454,0 43504,1 43563,0 43607,1 43611,0 43674,1 43680,0 43701,1 43706,0 43778,1 43877,0 43935,1 44029,0 44051,1 44107,0 44192,1 44248,0 44312,1 44347,0 44371,1 44375,0 44458,1 44504,0 44540,1 44560,0 44588,1 44628,0 44670,1 44693,0 44770,1 44830,0 44894,1 44900,0 44921,1 44964,0 45043,1 45116,0 45121,1 45122,0 45170,1 45249,0 45318,1 45340,0 45431,1 45488,0 45569,1 45629,0 45718,1 45745,0 45778,1 45866,0 45891,1 45989,0 46058,1 46092,0 46096,1 46185,0 46186,1 46226,0 46265,1 46290,0 46348,1 46372,0 46442,1 46493,0 46508,1 46607,0 46675,1 46694,0 46725,1 46757,0 46819,1 46869,0 46950,1 46987,0 47082,1 47150,0 47206,1 47229,0 47268,1 47314,0 47351,1 47445,0 47497,1 47505,0 47558,1 47635,0 47675,1 47677,0 47769,1 47869,0 47878,1 47936,0 48002,1 48089,0 48137,1 48164,0 48253,1 48353,0 48436,1 48497,0 48596,1 48604,0 48620,1 48710,0 48728,1 48825,0 48891,1 48928,0 48990,1 49044,0 49047,1 49087,0 49177,1 49264,0 49272,1 49362,0 49370,1 49372,0 49442,1 49480,0 49487,1 49520,0 49620,1 49630,0 49662,1 49663,0 49674,1 49768,0 49831,1 49928,0 49935,1 49950,0 49989,1 50032,0 50046,1 50128,0 50227,1 50323,0 50408,1 50480,0 50491,1 50581,0 50626,1 50661,0 50729,1 50801,0 50825,1 50922,0 50923,1 50976,0 51035,1 51060,0 51130,1 51181,0 51243,1 51300,0 51350,1 51421,0 51452,1 end initlist b6 0,0 3,1 36,0 44,1 79,0 144,1 163,0 172,1 195,0 200,1 227,0 297,1 393,0 436,1 508,0 528,1 550,0 567,1 622,0 714,1 757,0 779,1 784,0 863,1 923,0 1011,1 1041,0 1067,1 1136,0 1174,1 1176,0 1182,1 1206,0 1264,1 1313,0 1326,1 1371,0 1413,1 1434,0 1462,1 1540,0 1565,1 1610,0 1693,1 1766,0 1805,1 1875,0 1894,1 1963,0 2031,1 2095,0 2122,1 2222,0 2302,1 2364,0 2462,1 2537,0 2577,1 2636,0 2694,1 2735,0 2777,1 2809,0 2906,1 2965,0 3037,1 3039,0 3071,1 3076,0 3148,1 3244,0 3303,1 3310,0 3345,1 3441,0 3479,1 3503,0 3544,1 3595,0 3631,1 3664,0 3763,1 3862,0 3953,1 4010,0 4096,1 4128,0 4202,1 4270,0 4304,1 4316,0 4402,1 4437,0 4481,1 4508,0 4586,1 4611,0 4663,1 4731,0 4826,1 4873,0 4921,1 4939,0 4977,1 5022,0 5114,1 5193,0 5251,1 5330,0 5420,1 5505,0 5598,1 5603,0 5658,1 5754,0 5814,1 5848,0 5923,1 5999,0 6072,1 6157,0 6203,1 6271,0 6285,1 6340,0 6394,1 6441,0 6465,1 6499,0 6577,1 6639,0 6735,1 6806,0 6866,1 6887,0 6891,1 6968,0 7065,1 7067,0 7073,1 7091,0 7163,1 7207,0 7248,1 7331,0 7354,1 7359,0 7459,1 7556,0 7570,1 7614,0 7645,1 7682,0 7707,1 7734,0 7809,1 7817,0 7831,1 7893,0 7924,1 7998,0 8010,1 8069,0 8120,1 8139,0 8189,1 8226,0 8305,1 8367,0 8455,1 8485,0 8557,1 8651,0 8744,1 8751,0 8776,1 8824,0 8834,1 8886,0 8907,1 8943,0 9002,1 9095,0 9195,1 9272,0 9344,1 9350,0 9357,1 9453,0 9553,1 9597,0 9622,1 9717,0 9811,1 9822,0 9841,1 9924,0 9954,1 9967,0 10006,1 10097,0 10164,1 10205,0 10293,1 10374,0 10451,1 10499,0 10503,1 10568,0 10590,1 10627,0 10661,1 10665,0 10761,1 10763,0 10774,1 10820,0 10915,1 10992,0 11072,1 11118,0 11205,1 11265,0 11326,1 11386,0 11467,1 11504,0 11552,1 11630,0 11650,1 11683,0 11714,1 11736,0 11769,1 11828,0 11857,1 11877,0 11923,1 11971,0 12056,1 12146,0 12161,1 12184,0 12221,1 12271,0 12310,1 12330,0 12338,1 12359,0 12439,1 12440,0 12456,1 12530,0 12539,1 12553,0 12601,1 12614,0 12677,1 12696,0 12768,1 12820,0 12874,1 12888,0 12976,1 13033,0 13102,1 13108,0 13136,1 13235,0 13271,1 13357,0 13371,1 13391,0 13441,1 13485,0 13581,1 13587,0 13594,1 13614,0 13618,1 13636,0 13677,1 13698,0 13772,1 13872,0 13953,1 13956,0 14022,1 14042,0 14064,1 14112,0 14145,1 14204,0 14205,1 14218,0 14304,1 14387,0 14398,1 14432,0 14509,1 14530,0 14611,1 14675,0 14742,1 14776,0 14787,1 14805,0 14869,1 14940,0 14991,1 15068,0 15076,1 15077,0 15172,1 15206,0 15231,1 15311,0 15335,1 15353,0 15359,1 15382,0 15456,1 15555,0 15618,1 15686,0 15745,1 15750,0 15753,1 15819,0 15907,1 15980,0 16032,1 16040,0 16080,1 16082,0 16091,1 16169,0 16206,1 16285,0 16375,1 16419,0 16491,1 16537,0 16604,1 16660,0 16667,1 16696,0 16785,1 16882,0 16924,1 16977,0 16979,1 17051,0 17099,1 17145,0 17224,1 17265,0 17319,1 17388,0 17404,1 17412,0 17453,1 17501,0 17515,1 17516,0 17611,1 17678,0 17738,1 17784,0 17796,1 17797,0 17862,1 17931,0 18011,1 18095,0 18185,1 18241,0 18303,1 18309,0 18377,1 18448,0 18460,1 18523,0 18613,1 18681,0 18736,1 18835,0 18882,1 18920,0 18947,1 18999,0 19000,1 19046,0 19051,1 19080,0 19120,1 19206,0 19291,1 19373,0 19387,1 19393,0 19458,1 19510,0 19574,1 19586,0 19634,1 19690,0 19770,1 19773,0 19782,1 19839,0 19869,1 19898,0 19917,1 19949,0 20005,1 20086,0 20169,1 20267,0 20323,1 20423,0 20440,1 20474,0 20543,1 20574,0 20654,1 20698,0 20727,1 20744,0 20757,1 20814,0 20881,1 20898,0 20940,1 20983,0 20998,1 21054,0 21061,1 21143,0 21190,1 21245,0 21272,1 21300,0 21400,1 21484,0 21489,1 21576,0 21586,1 21668,0 21762,1 21778,0 21836,1 21888,0 21915,1 21990,0 22001,1 22037,0 22096,1 22111,0 22142,1 22215,0 22306,1 22310,0 22321,1 22415,0 22485,1 22584,0 22658,1 22691,0 22725,1 22807,0 22842,1 22870,0 22942,1 22989,0 23088,1 23173,0 23240,1 23263,0 23313,1 23361,0 23403,1 23422,0 23449,1 23535,0 23635,1 23698,0 23776,1 23826,0 23873,1 23947,0 24011,1 24014,0 24076,1 24157,0 24185,1 24249,0 24253,1 24273,0 24297,1 24362,0 24446,1 24505,0 24528,1 24622,0 24661,1 24693,0 24781,1 24852,0 24914,1 24990,0 25046,1 25131,0 25218,1 25261,0 25332,1 25401,0 25466,1 25507,0 25566,1 25663,0 25697,1 25790,0 25834,1 25845,0 25892,1 25900,0 25941,1 26006,0 26073,1 26156,0 26231,1 26283,0 26294,1 26359,0 26404,1 26441,0 26443,1 26500,0 26557,1 26654,0 26724,1 26726,0 26791,1 26811,0 26852,1 26873,0 26946,1 26970,0 27070,1 27109,0 27119,1 27162,0 27229,1 27316,0 27318,1 27345,0 27427,1 27448,0 27531,1 27576,0 27642,1 27658,0 27752,1 27813,0 27845,1 27866,0 27951,1 27971,0 28051,1 28063,0 28092,1 28155,0 28211,1 28218,0 28306,1 28318,0 28322,1 28353,0 28436,1 28474,0 28538,1 28621,0 28691,1 28725,0 28792,1 28838,0 28863,1 28879,0 28955,1 29049,0 29064,1 29164,0 29171,1 29190,0 29225,1 29287,0 29379,1 29401,0 29484,1 29489,0 29563,1 29572,0 29573,1 29587,0 29681,1 29766,0 29860,1 29892,0 29923,1 30016,0 30052,1 30097,0 30141,1 30148,0 30179,1 30188,0 30238,1 30269,0 30344,1 30418,0 30475,1 30574,0 30629,1 30637,0 30716,1 30777,0 30873,1 30945,0 31003,1 31081,0 31104,1 31183,0 31209,1 31297,0 31395,1 31447,0 31535,1 31543,0 31592,1 31656,0 31747,1 31833,0 31857,1 31891,0 31961,1 32006,0 32104,1 32160,0 32250,1 32348,0 32377,1 32444,0 32481,1 32522,0 32587,1 32591,0 32639,1 32658,0 32736,1 32778,0 32794,1 32850,0 32886,1 32926,0 32982,1 33051,0 33123,1 33128,0 33186,1 33200,0 33217,1 33287,0 33343,1 33354,0 33446,1 33481,0 33531,1 33558,0 33654,1 33689,0 33777,1 33868,0 33875,1 33925,0 33997,1 34013,0 34064,1 34120,0 34132,1 34226,0 34298,1 34348,0 34355,1 34409,0 34481,1 34567,0 34588,1 34686,0 34694,1 34705,0 34728,1 34785,0 34793,1 34875,0 34960,1 35043,0 35134,1 35159,0 35233,1 35282,0 35359,1 35410,0 35496,1 35553,0 35567,1 35595,0 35632,1 35690,0 35702,1 35781,0 35844,1 35912,0 35957,1 35995,0 36049,1 36123,0 36220,1 36285,0 36331,1 36378,0 36460,1 36536,0 36577,1 36630,0 36633,1 36690,0 36725,1 36787,0 36835,1 36850,0 36876,1 36932,0 36999,1 37087,0 37166,1 37206,0 37277,1 37287,0 37381,1 37388,0 37393,1 37439,0 37458,1 37502,0 37564,1 37620,0 37655,1 37681,0 37741,1 37767,0 37850,1 37855,0 37868,1 37891,0 37947,1 38036,0 38052,1 38102,0 38166,1 38177,0 38182,1 38242,0 38318,1 38409,0 38417,1 38509,0 38588,1 38674,0 38740,1 38829,0 38909,1 38964,0 39026,1 39065,0 39126,1 39147,0 39238,1 39290,0 39335,1 39373,0 39447,1 39479,0 39519,1 39542,0 39619,1 39646,0 39647,1 39668,0 39703,1 39770,0 39840,1 39842,0 39905,1 39947,0 40026,1 40083,0 40137,1 40165,0 40240,1 40270,0 40351,1 40371,0 40451,1 40479,0 40503,1 40507,0 40538,1 40587,0 40646,1 40710,0 40713,1 40801,0 40882,1 40957,0 40994,1 41038,0 41057,1 41103,0 41202,1 41245,0 41246,1 41265,0 41280,1 41318,0 41418,1 41502,0 41554,1 41609,0 41664,1 41731,0 41776,1 41876,0 41928,1 41960,0 41992,1 42030,0 42053,1 42090,0 42136,1 42164,0 42255,1 42319,0 42371,1 42415,0 42439,1 42492,0 42523,1 42622,0 42634,1 42657,0 42687,1 42730,0 42794,1 42859,0 42943,1 42977,0 43072,1 43106,0 43165,1 43191,0 43277,1 43333,0 43392,1 43486,0 43586,1 43615,0 43621,1 43689,0 43769,1 43844,0 43910,1 43994,0 44081,1 44180,0 44280,1 44316,0 44412,1 44460,0 44529,1 44611,0 44641,1 44741,0 44834,1 44860,0 44940,1 44999,0 45031,1 45035,0 45060,1 45139,0 45207,1 45271,0 45352,1 45379,0 45424,1 45508,0 45601,1 45629,0 45648,1 45681,0 45736,1 45760,0 45846,1 45929,0 46020,1 46103,0 46156,1 46175,0 46188,1 46251,0 46268,1 46348,0 46408,1 46501,0 46530,1 46560,0 46643,1 46715,0 46787,1 46802,0 46873,1 46903,0 46928,1 46979,0 47077,1 47152,0 47191,1 47274,0 47354,1 47438,0 47465,1 47540,0 47552,1 47639,0 47710,1 47738,0 47739,1 47832,0 47925,1 48007,0 48058,1 48129,0 48134,1 48139,0 48160,1 48239,0 48285,1 48288,0 48385,1 48419,0 48456,1 48496,0 48582,1 48614,0 48714,1 48759,0 48856,1 48931,0 49024,1 49066,0 49126,1 49180,0 49226,1 49257,0 49293,1 49324,0 49346,1 49441,0 49505,1 49517,0 49564,1 49608,0 49614,1 49620,0 49673,1 49739,0 49778,1 49831,0 49835,1 49915,0 49943,1 49989,0 50080,1 50163,0 50248,1 50306,0 50344,1 50440,0 50488,1 50571,0 50649,1 end initlist b7 0,0 19,1 40,0 92,1 149,0 176,1 237,0 287,1 374,0 420,1 436,0 508,1 605,0 698,1 727,0 808,1 826,0 865,1 886,0 973,1 1071,0 1083,1 1171,0 1176,1 1196,0 1202,1 1298,0 1315,1 1409,0 1431,1 1477,0 1538,1 1574,0 1637,1 1644,0 1679,1 1717,0 1778,1 1836,0 1912,1 2005,0 2092,1 2098,0 2147,1 2236,0 2248,1 2322,0 2364,1 2376,0 2464,1 2540,0 2601,1 2700,0 2706,1 2712,0 2717,1 2780,0 2795,1 2817,0 2861,1 2934,0 2935,1 2998,0 3089,1 3125,0 3208,1 3272,0 3354,1 3431,0 3437,1 3463,0 3538,1 3575,0 3577,1 3640,0 3700,1 3773,0 3824,1 3846,0 3893,1 3947,0 4030,1 4074,0 4075,1 4080,0 4087,1 4156,0 4209,1 4230,0 4293,1 4362,0 4379,1 4422,0 4457,1 4461,0 4476,1 4544,0 4565,1 4578,0 4589,1 4602,0 4693,1 4741,0 4838,1 4923,0 4946,1 4996,0 5001,1 5052,0 5143,1 5171,0 5256,1 5337,0 5394,1 5472,0 5555,1 5594,0 5688,1 5734,0 5792,1 5805,0 5808,1 5905,0 5944,1 6007,0 6026,1 6028,0 6090,1 6140,0 6159,1 6256,0 6336,1 6399,0 6414,1 6461,0 6475,1 6515,0 6609,1 6671,0 6687,1 6738,0 6780,1 6810,0 6827,1 6922,0 6998,1 7020,0 7074,1 7131,0 7153,1 7201,0 7233,1 7246,0 7309,1 7331,0 7392,1 7478,0 7565,1 7578,0 7579,1 7647,0 7738,1 7797,0 7829,1 7901,0 7941,1 7953,0 7960,1 7972,0 8025,1 8030,0 8082,1 8089,0 8127,1 8214,0 8276,1 8354,0 8392,1 8437,0 8438,1 8448,0 8523,1 8595,0 8665,1 8688,0 8752,1 8790,0 8857,1 8922,0 8990,1 9042,0 9122,1 9152,0 9224,1 9319,0 9340,1 9388,0 9395,1 9410,0 9449,1 9504,0 9521,1 9547,0 9641,1 9716,0 9785,1 9867,0 9962,1 9993,0 10078,1 10156,0 10209,1 10222,0 10285,1 10355,0 10398,1 10431,0 10497,1 10506,0 10597,1 10640,0 10649,1 10679,0 10774,1 10832,0 10929,1 10960,0 11038,1 11062,0 11098,1 11103,0 11183,1 11199,0 11286,1 11309,0 11403,1 11445,0 11456,1 11510,0 11609,1 11702,0 11755,1 11854,0 11883,1 11944,0 11976,1 11986,0 12042,1 12061,0 12123,1 12193,0 12200,1 12249,0 12265,1 12302,0 12342,1 12425,0 12464,1 12547,0 12619,1 12621,0 12670,1 12768,0 12793,1 12833,0 12881,1 12975,0 12997,1 13075,0 13162,1 13249,0 13280,1 13351,0 13372,1 13394,0 13405,1 13468,0 13489,1 13560,0 13597,1 13620,0 13704,1 13791,0 13839,1 13905,0 13962,1 13975,0 14064,1 14156,0 14237,1 14276,0 14373,1 14398,0 14478,1 14506,0 14558,1 14653,0 14748,1 14835,0 14897,1 14983,0 15011,1 15046,0 15078,1 15137,0 15146,1 15185,0 15255,1 15276,0 15303,1 15314,0 15398,1 15474,0 15546,1 15592,0 15686,1 15703,0 15789,1 15860,0 15924,1 15988,0 16044,1 16065,0 16121,1 16156,0 16160,1 16168,0 16247,1 16292,0 16346,1 16421,0 16434,1 16515,0 16585,1 16589,0 16642,1 16711,0 16786,1 16849,0 16860,1 16879,0 16896,1 16973,0 17012,1 17112,0 17159,1 17251,0 17342,1 17359,0 17387,1 17406,0 17429,1 17496,0 17499,1 17571,0 17648,1 17698,0 17747,1 17793,0 17853,1 17906,0 17935,1 17966,0 18002,1 18079,0 18119,1 18187,0 18225,1 18267,0 18317,1 18339,0 18422,1 18484,0 18538,1 18637,0 18661,1 18714,0 18766,1 18857,0 18901,1 18944,0 19030,1 19046,0 19091,1 19137,0 19143,1 19163,0 19187,1 19221,0 19260,1 19334,0 19414,1 19439,0 19474,1 19508,0 19510,1 19518,0 19612,1 19655,0 19662,1 19743,0 19828,1 19886,0 19978,1 20005,0 20069,1 20079,0 20081,1 20137,0 20231,1 20283,0 20318,1 20390,0 20396,1 20433,0 20467,1 20527,0 20579,1 20648,0 20686,1 20772,0 20783,1 20814,0 20907,1 20988,0 21059,1 21133,0 21226,1 21268,0 21297,1 21387,0 21388,1 21447,0 21477,1 21549,0 21638,1 21701,0 21719,1 21774,0 21778,1 21832,0 21884,1 21954,0 21966,1 22003,0 22070,1 22146,0 22157,1 22179,0 22232,1 22305,0 22373,1 22390,0 22454,1 22510,0 22561,1 22641,0 22717,1 22805,0 22904,1 22945,0 22998,1 23085,0 23118,1 23166,0 23189,1 23268,0 23329,1 23331,0 23390,1 23421,0 23498,1 23571,0 23663,1 23685,0 23700,1 23750,0 23779,1 23823,0 23861,1 23946,0 23948,1 23970,0 24018,1 24070,0 24151,1 24189,0 24270,1 24326,0 24337,1 24428,0 24501,1 24511,0 24545,1 24563,0 24657,1 24680,0 24699,1 24705,0 24797,1 24815,0 24854,1 24865,0 24866,1 24870,0 24913,1 25004,0 25068,1 25109,0 25112,1 25129,0 25146,1 25174,0 25269,1 25292,0 25339,1 25354,0 25441,1 25516,0 25568,1 25588,0 25630,1 25671,0 25747,1 25838,0 25933,1 25972,0 26038,1 26133,0 26146,1 26149,0 26179,1 26275,0 26276,1 26277,0 26298,1 26374,0 26455,1 26496,0 26576,1 26644,0 26729,1 26808,0 26841,1 26929,0 27004,1 27100,0 27170,1 27213,0 27295,1 27388,0 27481,1 27549,0 27589,1 27689,0 27771,1 27817,0 27819,1 27878,0 27968,1 27975,0 28001,1 28095,0 28121,1 28178,0 28255,1 28336,0 28392,1 28457,0 28530,1 28549,0 28631,1 28671,0 28672,1 28679,0 28742,1 28836,0 28888,1 28937,0 28979,1 29059,0 29060,1 29130,0 29228,1 29281,0 29363,1 29393,0 29469,1 29559,0 29644,1 29741,0 29791,1 29857,0 29923,1 29961,0 30038,1 30120,0 30146,1 30221,0 30238,1 30334,0 30368,1 30383,0 30386,1 30400,0 30429,1 30482,0 30512,1 30561,0 30601,1 30684,0 30712,1 30812,0 30866,1 30886,0 30965,1 31037,0 31112,1 31190,0 31198,1 31206,0 31269,1 31320,0 31418,1 31457,0 31512,1 31550,0 31586,1 31685,0 31773,1 31783,0 31791,1 31857,0 31898,1 31929,0 32019,1 32023,0 32049,1 32128,0 32160,1 32173,0 32244,1 32318,0 32360,1 32374,0 32468,1 32552,0 32561,1 32564,0 32634,1 32640,0 32685,1 32706,0 32799,1 32850,0 32947,1 33025,0 33068,1 33125,0 33159,1 33228,0 33308,1 33315,0 33344,1 33416,0 33473,1 33502,0 33524,1 33583,0 33611,1 33686,0 33691,1 33717,0 33747,1 33823,0 33921,1 33922,0 33987,1 34067,0 34085,1 34153,0 34164,1 34167,0 34237,1 34275,0 34304,1 34322,0 34341,1 34360,0 34436,1 34514,0 34583,1 34611,0 34614,1 34665,0 34728,1 34787,0 34798,1 34878,0 34887,1 34946,0 35009,1 35040,0 35102,1 35146,0 35207,1 35216,0 35259,1 35287,0 35366,1 35431,0 35505,1 35551,0 35614,1 35653,0 35743,1 35802,0 35807,1 35814,0 35863,1 35864,0 35915,1 35989,0 36088,1 36126,0 36129,1 36227,0 36301,1 36369,0 36469,1 36551,0 36561,1 36640,0 36670,1 36676,0 36753,1 36764,0 36858,1 36926,0 36957,1 37043,0 37109,1 37154,0 37164,1 37264,0 37352,1 37368,0 37454,1 37518,0 37539,1 37599,0 37638,1 37701,0 37733,1 37757,0 37763,1 37853,0 37881,1 37946,0 38023,1 38031,0 38065,1 38161,0 38193,1 38264,0 38360,1 38396,0 38429,1 38465,0 38514,1 38524,0 38608,1 38631,0 38690,1 38695,0 38744,1 38818,0 38907,1 38949,0 39016,1 39063,0 39126,1 39161,0 39244,1 39307,0 39358,1 39393,0 39463,1 39473,0 39522,1 39575,0 39602,1 39624,0 39629,1 39670,0 39726,1 39738,0 39794,1 39836,0 39852,1 39872,0 39931,1 40005,0 40096,1 40191,0 40248,1 40338,0 40409,1 40493,0 40591,1 40605,0 40680,1 40723,0 40740,1 40799,0 40832,1 40901,0 40965,1 40977,0 40983,1 41006,0 41081,1 41131,0 41205,1 41295,0 41301,1 41308,0 41337,1 41405,0 41419,1 41505,0 41588,1 41663,0 41727,1 41793,0 41891,1 41990,0 42000,1 42096,0 42171,1 42260,0 42314,1 42339,0 42425,1 42519,0 42544,1 42585,0 42617,1 42696,0 42795,1 42830,0 42842,1 42868,0 42894,1 42968,0 43012,1 43026,0 43094,1 43124,0 43214,1 43247,0 43268,1 43284,0 43351,1 43353,0 43385,1 43471,0 43498,1 43540,0 43630,1 43647,0 43725,1 43784,0 43785,1 43851,0 43921,1 43935,0 43963,1 43982,0 43983,1 43992,0 44051,1 44134,0 44217,1 44221,0 44234,1 44324,0 44404,1 44441,0 44490,1 44573,0 44642,1 44719,0 44762,1 44823,0 44878,1 44936,0 44981,1 44995,0 45091,1 45174,0 45262,1 45270,0 45293,1 45307,0 45392,1 45464,0 45507,1 45600,0 45654,1 45720,0 45751,1 45760,0 45771,1 45835,0 45872,1 45939,0 46000,1 46071,0 46085,1 46146,0 46182,1 46217,0 46230,1 46294,0 46371,1 46396,0 46405,1 46483,0 46500,1 46544,0 46607,1 46614,0 46700,1 46795,0 46811,1 46878,0 46955,1 47005,0 47078,1 47166,0 47263,1 47288,0 47320,1 47370,0 47402,1 47493,0 47497,1 47523,0 47572,1 47603,0 47694,1 47780,0 47792,1 47804,0 47885,1 47977,0 47979,1 47997,0 48055,1 48148,0 48221,1 48295,0 48365,1 48451,0 48516,1 48518,0 48583,1 48617,0 48701,1 48749,0 48834,1 48906,0 48938,1 48947,0 49038,1 49074,0 49123,1 49195,0 49218,1 49307,0 49397,1 49399,0 49433,1 49477,0 49498,1 49540,0 49611,1 49707,0 49788,1 49877,0 49906,1 50005,0 50066,1 50104,0 50121,1 50176,0 50260,1 50294,0 50359,1 50410,0 50508,1 end initlist b8 0,0 21,1 41,0 96,1 124,0 152,1 236,0 329,1 354,0 388,1 402,0 501,1 529,0 613,1 670,0 737,1 742,0 835,1 857,0 923,1 1009,0 1017,1 1076,0 1099,1 1128,0 1137,1 1163,0 1251,1 1341,0 1403,1 1470,0 1528,1 1548,0 1571,1 1658,0 1724,1 1819,0 1896,1 1993,0 2066,1 2108,0 2174,1 2220,0 2306,1 2381,0 2419,1 2431,0 2476,1 2518,0 2612,1 2649,0 2694,1 2784,0 2813,1 2844,0 2881,1 2908,0 2937,1 2983,0 3065,1 3077,0 3155,1 3161,0 3247,1 3277,0 3278,1 3356,0 3373,1 3403,0 3458,1 3557,0 3600,1 3634,0 3641,1 3726,0 3798,1 3862,0 3913,1 4011,0 4022,1 4072,0 4130,1 4217,0 4242,1 4312,0 4332,1 4335,0 4410,1 4489,0 4507,1 4546,0 4589,1 4660,0 4708,1 4716,0 4729,1 4763,0 4786,1 4852,0 4866,1 4963,0 5015,1 5045,0 5134,1 5151,0 5180,1 5222,0 5300,1 5345,0 5394,1 5484,0 5508,1 5603,0 5678,1 5711,0 5743,1 5823,0 5892,1 5953,0 6045,1 6128,0 6132,1 6144,0 6226,1 6311,0 6338,1 6392,0 6419,1 6471,0 6565,1 6634,0 6689,1 6788,0 6837,1 6872,0 6972,1 7033,0 7119,1 7210,0 7299,1 7392,0 7467,1 7508,0 7588,1 7652,0 7672,1 7705,0 7716,1 7757,0 7804,1 7857,0 7888,1 7966,0 8009,1 8040,0 8050,1 8137,0 8220,1 8248,0 8302,1 8383,0 8396,1 8405,0 8485,1 8582,0 8681,1 8697,0 8768,1 8836,0 8893,1 8990,0 9015,1 9076,0 9095,1 9192,0 9206,1 9250,0 9271,1 9336,0 9423,1 9513,0 9579,1 9641,0 9671,1 9703,0 9750,1 9826,0 9870,1 9899,0 9978,1 9993,0 10085,1 10092,0 10117,1 10132,0 10137,1 10148,0 10172,1 10201,0 10281,1 10370,0 10405,1 10412,0 10474,1 10521,0 10537,1 10624,0 10656,1 10719,0 10764,1 10795,0 10841,1 10896,0 10974,1 11027,0 11059,1 11067,0 11075,1 11155,0 11165,1 11183,0 11243,1 11336,0 11344,1 11431,0 11529,1 11567,0 11569,1 11641,0 11722,1 11819,0 11916,1 11961,0 11996,1 12052,0 12116,1 12121,0 12208,1 12233,0 12272,1 12310,0 12359,1 12447,0 12521,1 12609,0 12679,1 12734,0 12779,1 12826,0 12864,1 12878,0 12944,1 12966,0 12970,1 13035,0 13090,1 13166,0 13174,1 13181,0 13255,1 13308,0 13361,1 13439,0 13492,1 13579,0 13613,1 13646,0 13715,1 13779,0 13835,1 13927,0 14023,1 14112,0 14157,1 14203,0 14227,1 14245,0 14258,1 14282,0 14379,1 14409,0 14493,1 14542,0 14550,1 14560,0 14633,1 14726,0 14761,1 14797,0 14844,1 14934,0 15000,1 15054,0 15062,1 15093,0 15139,1 15204,0 15231,1 15291,0 15364,1 15464,0 15470,1 15496,0 15560,1 15613,0 15637,1 15638,0 15684,1 15752,0 15846,1 15887,0 15932,1 15982,0 16063,1 16127,0 16134,1 16205,0 16238,1 16301,0 16385,1 16460,0 16494,1 16498,0 16572,1 16641,0 16721,1 16775,0 16788,1 16821,0 16854,1 16895,0 16978,1 16990,0 17008,1 17096,0 17183,1 17251,0 17255,1 17292,0 17323,1 17415,0 17422,1 17503,0 17580,1 17652,0 17722,1 17762,0 17784,1 17841,0 17914,1 17974,0 17992,1 18073,0 18125,1 18150,0 18247,1 18342,0 18358,1 18370,0 18397,1 18454,0 18550,1 18560,0 18618,1 18666,0 18703,1 18748,0 18808,1 18868,0 18904,1 18960,0 18988,1 19058,0 19084,1 19114,0 19179,1 19181,0 19232,1 19322,0 19372,1 19381,0 19466,1 19542,0 19626,1 19706,0 19794,1 19846,0 19924,1 19962,0 20016,1 20053,0 20124,1 20193,0 20234,1 20290,0 20310,1 20351,0 20379,1 20397,0 20432,1 20522,0 20545,1 20629,0 20707,1 20735,0 20773,1 20842,0 20865,1 20900,0 20910,1 20988,0 21038,1 21048,0 21103,1 21118,0 21197,1 21280,0 21282,1 21345,0 21435,1 21486,0 21544,1 21564,0 21597,1 21616,0 21659,1 21709,0 21773,1 21866,0 21925,1 21988,0 21995,1 22012,0 22023,1 22123,0 22136,1 22155,0 22211,1 22308,0 22408,1 22433,0 22505,1 22583,0 22682,1 22696,0 22704,1 22748,0 22825,1 22897,0 22986,1 23018,0 23029,1 23101,0 23190,1 23264,0 23338,1 23412,0 23436,1 23483,0 23501,1 23566,0 23644,1 23743,0 23789,1 23800,0 23889,1 23933,0 24007,1 24027,0 24121,1 24155,0 24245,1 24270,0 24301,1 24316,0 24346,1 24357,0 24421,1 24456,0 24473,1 24538,0 24623,1 24662,0 24712,1 24809,0 24841,1 24934,0 24957,1 24969,0 25050,1 25134,0 25153,1 25172,0 25181,1 25260,0 25268,1 25354,0 25404,1 25447,0 25545,1 25642,0 25669,1 25727,0 25797,1 25846,0 25857,1 25909,0 26006,1 26064,0 26113,1 26167,0 26173,1 26190,0 26244,1 26276,0 26330,1 26373,0 26426,1 26495,0 26539,1 26608,0 26648,1 26706,0 26739,1 26802,0 26843,1 26854,0 26939,1 27023,0 27098,1 27122,0 27138,1 27225,0 27323,1 27338,0 27395,1 27407,0 27506,1 27565,0 27587,1 27641,0 27664,1 27710,0 27786,1 27793,0 27813,1 27903,0 27972,1 28034,0 28059,1 28083,0 28109,1 28183,0 28210,1 28217,0 28308,1 28365,0 28412,1 28421,0 28461,1 28537,0 28615,1 28658,0 28689,1 28728,0 28749,1 28825,0 28827,1 28908,0 28917,1 28937,0 29008,1 29087,0 29138,1 29193,0 29255,1 29314,0 29402,1 29440,0 29523,1 29555,0 29629,1 29716,0 29764,1 29807,0 29898,1 29952,0 30020,1 30029,0 30115,1 30125,0 30206,1 30222,0 30284,1 30373,0 30374,1 30454,0 30493,1 30550,0 30632,1 30644,0 30659,1 30690,0 30702,1 30772,0 30870,1 30920,0 30950,1 30999,0 31004,1 31064,0 31085,1 31182,0 31274,1 31359,0 31429,1 31486,0 31505,1 31576,0 31655,1 31690,0 31731,1 31741,0 31761,1 31771,0 31811,1 31834,0 31930,1 31975,0 32034,1 32123,0 32171,1 32270,0 32295,1 32332,0 32333,1 32408,0 32479,1 32563,0 32594,1 32638,0 32642,1 32704,0 32730,1 32732,0 32811,1 32903,0 32994,1 32995,0 33007,1 33103,0 33123,1 33144,0 33179,1 33247,0 33313,1 33357,0 33438,1 33519,0 33591,1 33606,0 33656,1 33711,0 33778,1 33875,0 33894,1 33941,0 33988,1 34021,0 34095,1 34155,0 34254,1 34286,0 34385,1 34423,0 34508,1 34564,0 34612,1 34687,0 34726,1 34817,0 34876,1 34947,0 34971,1 35005,0 35091,1 35123,0 35130,1 35147,0 35148,1 35160,0 35171,1 35203,0 35232,1 35299,0 35313,1 35388,0 35405,1 35408,0 35422,1 35455,0 35480,1 35506,0 35583,1 35657,0 35714,1 35798,0 35847,1 35849,0 35903,1 35912,0 35944,1 35992,0 36058,1 36098,0 36158,1 36202,0 36241,1 36274,0 36303,1 36345,0 36434,1 36515,0 36596,1 36620,0 36712,1 36733,0 36796,1 36822,0 36854,1 36875,0 36965,1 37065,0 37133,1 37210,0 37300,1 37357,0 37378,1 37392,0 37485,1 37499,0 37593,1 37684,0 37740,1 37816,0 37899,1 37956,0 38006,1 38094,0 38133,1 38229,0 38246,1 38295,0 38378,1 38388,0 38448,1 38545,0 38590,1 38676,0 38704,1 38723,0 38759,1 38840,0 38844,1 38910,0 38970,1 39065,0 39106,1 39177,0 39191,1 39216,0 39284,1 39376,0 39404,1 39412,0 39441,1 39523,0 39609,1 39671,0 39702,1 39753,0 39831,1 39854,0 39953,1 40004,0 40069,1 40149,0 40232,1 40274,0 40349,1 40422,0 40518,1 40521,0 40538,1 40635,0 40637,1 40701,0 40756,1 40838,0 40898,1 40971,0 41054,1 41117,0 41119,1 41219,0 41287,1 41313,0 41392,1 41487,0 41543,1 41610,0 41635,1 41726,0 41811,1 41903,0 41974,1 41998,0 42022,1 42097,0 42144,1 42157,0 42180,1 42215,0 42236,1 42286,0 42340,1 42374,0 42449,1 42545,0 42593,1 42636,0 42706,1 42791,0 42832,1 42872,0 42953,1 43041,0 43129,1 43142,0 43146,1 43175,0 43197,1 43203,0 43273,1 43345,0 43433,1 43464,0 43521,1 43555,0 43584,1 43668,0 43716,1 43728,0 43826,1 43879,0 43887,1 43946,0 44014,1 44017,0 44065,1 44108,0 44140,1 44196,0 44204,1 44288,0 44325,1 44377,0 44466,1 44529,0 44539,1 44632,0 44675,1 44725,0 44812,1 44907,0 44955,1 45000,0 45022,1 45027,0 45092,1 45185,0 45251,1 45292,0 45363,1 45412,0 45500,1 45546,0 45590,1 45680,0 45690,1 45691,0 45704,1 45744,0 45751,1 45841,0 45907,1 45920,0 45942,1 45986,0 46013,1 46056,0 46063,1 46101,0 46139,1 46226,0 46252,1 46313,0 46381,1 46426,0 46436,1 46510,0 46577,1 46631,0 46723,1 46762,0 46769,1 46782,0 46799,1 46869,0 46907,1 46971,0 46988,1 47022,0 47053,1 47142,0 47240,1 47261,0 47346,1 47436,0 47491,1 47570,0 47649,1 47708,0 47778,1 47853,0 47858,1 47891,0 47964,1 48038,0 48101,1 48124,0 48205,1 48275,0 48345,1 48378,0 48433,1 48491,0 48524,1 48535,0 48635,1 48679,0 48777,1 48865,0 48957,1 49041,0 49116,1 49158,0 49199,1 49281,0 49347,1 49393,0 49488,1 49543,0 49618,1 49662,0 49674,1 49722,0 49810,1 49818,0 49879,1 49936,0 49970,1 50069,0 50140,1 50186,0 50218,1 50297,0 50321,1 50408,0 50422,1 50442,0 50478,1 50541,0 50558,1 50613,0 50689,1 50745,0 50790,1 50811,0 50871,1 50888,0 50926,1 50971,0 51005,1 51031,0 51118,1 51181,0 51205,1 51296,0 51327,1 51333,0 51403,1 end initlist b9 0,0 89,1 188,0 245,1 304,0 344,1 391,0 453,1 538,0 592,1 656,0 668,1 678,0 710,1 711,0 772,1 801,0 871,1 885,0 897,1 915,0 988,1 1030,0 1076,1 1097,0 1163,1 1192,0 1229,1 1296,0 1341,1 1370,0 1468,1 1492,0 1583,1 1587,0 1638,1 1719,0 1731,1 1813,0 1827,1 1881,0 1923,1 1961,0 2046,1 2070,0 2165,1 2261,0 2358,1 2458,0 2495,1 2556,0 2641,1 2708,0 2799,1 2871,0 2914,1 2936,0 2981,1 3072,0 3077,1 3102,0 3201,1 3298,0 3323,1 3408,0 3420,1 3451,0 3509,1 3594,0 3690,1 3784,0 3869,1 3919,0 3946,1 4023,0 4092,1 4133,0 4221,1 4291,0 4356,1 4375,0 4448,1 4469,0 4471,1 4530,0 4563,1 4594,0 4637,1 4709,0 4751,1 4820,0 4899,1 4982,0 5055,1 5076,0 5120,1 5129,0 5208,1 5272,0 5312,1 5372,0 5395,1 5475,0 5530,1 5619,0 5710,1 5792,0 5834,1 5892,0 5963,1 6052,0 6116,1 6184,0 6186,1 6216,0 6256,1 6323,0 6340,1 6382,0 6412,1 6481,0 6549,1 6583,0 6620,1 6695,0 6713,1 6735,0 6805,1 6898,0 6964,1 7029,0 7084,1 7093,0 7159,1 7180,0 7237,1 7269,0 7331,1 7379,0 7395,1 7486,0 7487,1 7525,0 7621,1 7699,0 7798,1 7888,0 7892,1 7953,0 8032,1 8114,0 8173,1 8222,0 8260,1 8263,0 8274,1 8327,0 8390,1 8394,0 8458,1 8542,0 8565,1 8662,0 8737,1 8829,0 8878,1 8932,0 8997,1 9059,0 9083,1 9104,0 9142,1 9231,0 9306,1 9358,0 9407,1 9410,0 9425,1 9443,0 9506,1 9598,0 9641,1 9705,0 9745,1 9755,0 9794,1 9834,0 9849,1 9875,0 9951,1 9972,0 9989,1 10072,0 10085,1 10143,0 10202,1 10218,0 10297,1 10337,0 10416,1 10425,0 10490,1 10507,0 10560,1 10621,0 10639,1 10724,0 10726,1 10744,0 10789,1 10811,0 10879,1 10918,0 10949,1 10988,0 11043,1 11063,0 11114,1 11172,0 11233,1 11249,0 11331,1 11346,0 11432,1 11433,0 11451,1 11517,0 11537,1 11635,0 11681,1 11739,0 11824,1 11828,0 11911,1 11979,0 12070,1 12103,0 12143,1 12224,0 12320,1 12323,0 12406,1 12467,0 12557,1 12617,0 12677,1 12733,0 12789,1 12852,0 12923,1 12988,0 13005,1 13103,0 13184,1 13270,0 13292,1 13317,0 13377,1 13428,0 13485,1 13550,0 13591,1 13683,0 13696,1 13784,0 13818,1 13838,0 13849,1 13861,0 13892,1 13992,0 14026,1 14067,0 14078,1 14111,0 14163,1 14164,0 14262,1 14299,0 14305,1 14388,0 14473,1 14563,0 14627,1 14666,0 14694,1 14722,0 14770,1 14793,0 14866,1 14871,0 14959,1 14997,0 15041,1 15093,0 15154,1 15193,0 15236,1 15303,0 15373,1 15463,0 15501,1 15534,0 15589,1 15595,0 15681,1 15726,0 15797,1 15812,0 15907,1 15913,0 16009,1 16066,0 16101,1 16170,0 16247,1 16279,0 16298,1 16390,0 16426,1 16489,0 16491,1 16522,0 16549,1 16598,0 16631,1 16717,0 16742,1 16806,0 16853,1 16891,0 16940,1 16983,0 17055,1 17126,0 17143,1 17211,0 17259,1 17267,0 17361,1 17399,0 17479,1 17515,0 17516,1 17579,0 17629,1 17642,0 17659,1 17689,0 17722,1 17747,0 17773,1 17852,0 17910,1 17963,0 18041,1 18080,0 18139,1 18154,0 18249,1 18255,0 18267,1 18276,0 18279,1 18363,0 18460,1 18537,0 18607,1 18685,0 18720,1 18737,0 18791,1 18866,0 18898,1 18954,0 18977,1 19065,0 19128,1 19143,0 19190,1 19252,0 19331,1 19359,0 19406,1 19441,0 19524,1 19549,0 19623,1 19714,0 19756,1 19831,0 19884,1 19892,0 19967,1 20047,0 20118,1 20214,0 20263,1 20358,0 20398,1 20484,0 20505,1 20567,0 20575,1 20620,0 20627,1 20693,0 20756,1 20779,0 20865,1 20929,0 20982,1 21052,0 21054,1 21143,0 21226,1 21277,0 21361,1 21461,0 21484,1 21529,0 21563,1 21636,0 21669,1 21675,0 21736,1 21807,0 21814,1 21845,0 21888,1 21958,0 22043,1 22067,0 22119,1 22132,0 22231,1 22257,0 22313,1 22333,0 22415,1 22511,0 22595,1 22681,0 22771,1 22782,0 22880,1 22927,0 22967,1 22984,0 23062,1 23067,0 23071,1 23121,0 23127,1 23177,0 23274,1 23344,0 23369,1 23453,0 23524,1 23608,0 23707,1 23718,0 23799,1 23826,0 23835,1 23877,0 23881,1 23952,0 24039,1 24048,0 24147,1 24149,0 24152,1 24240,0 24279,1 24360,0 24435,1 24453,0 24503,1 24576,0 24674,1 24737,0 24808,1 24900,0 24998,1 25059,0 25120,1 25195,0 25267,1 25352,0 25395,1 25425,0 25490,1 25543,0 25617,1 25641,0 25714,1 25731,0 25736,1 25756,0 25778,1 25800,0 25863,1 25927,0 26013,1 26051,0 26136,1 26151,0 26188,1 26241,0 26330,1 26416,0 26427,1 26459,0 26466,1 26531,0 26625,1 26685,0 26724,1 26743,0 26744,1 26792,0 26891,1 26938,0 27000,1 27067,0 27120,1 27181,0 27196,1 27235,0 27275,1 27355,0 27452,1 27551,0 27626,1 27713,0 27770,1 27814,0 27817,1 27819,0 27826,1 27895,0 27919,1 27988,0 27995,1 28083,0 28168,1 28181,0 28241,1 28246,0 28287,1 28364,0 28385,1 28411,0 28413,1 28496,0 28506,1 28580,0 28583,1 28679,0 28761,1 28802,0 28881,1 28891,0 28945,1 29007,0 29088,1 29140,0 29231,1 29301,0 29372,1 29446,0 29520,1 29521,0 29593,1 29614,0 29701,1 29720,0 29797,1 29815,0 29822,1 29882,0 29967,1 30064,0 30163,1 30242,0 30302,1 30331,0 30423,1 30424,0 30495,1 30522,0 30537,1 30574,0 30663,1 30720,0 30804,1 30852,0 30864,1 30962,0 31007,1 31052,0 31137,1 31146,0 31227,1 31257,0 31353,1 31355,0 31385,1 31459,0 31534,1 31594,0 31612,1 31642,0 31706,1 31735,0 31812,1 31842,0 31847,1 31877,0 31971,1 32011,0 32022,1 32109,0 32173,1 32206,0 32218,1 32229,0 32287,1 32292,0 32388,1 32432,0 32507,1 32527,0 32533,1 32553,0 32585,1 32616,0 32623,1 32641,0 32698,1 32712,0 32765,1 32785,0 32884,1 32964,0 32993,1 32999,0 33016,1 33095,0 33123,1 33211,0 33292,1 33349,0 33398,1 33477,0 33502,1 33584,0 33622,1 33638,0 33640,1 33642,0 33655,1 33658,0 33683,1 33695,0 33703,1 33747,0 33792,1 33797,0 33800,1 33859,0 33930,1 33952,0 34000,1 34057,0 34154,1 34249,0 34277,1 34323,0 34350,1 34387,0 34427,1 34451,0 34499,1 34591,0 34609,1 34686,0 34773,1 34782,0 34875,1 34955,0 35025,1 35120,0 35159,1 35189,0 35281,1 35372,0 35428,1 35448,0 35470,1 35491,0 35508,1 35540,0 35543,1 35559,0 35640,1 35668,0 35703,1 35723,0 35774,1 35791,0 35891,1 35930,0 36022,1 36041,0 36055,1 36073,0 36094,1 36156,0 36248,1 36321,0 36334,1 36389,0 36451,1 36464,0 36473,1 36537,0 36601,1 36665,0 36749,1 36827,0 36896,1 36936,0 36939,1 36994,0 37014,1 37030,0 37120,1 37199,0 37218,1 37265,0 37310,1 37323,0 37360,1 37413,0 37427,1 37444,0 37527,1 37623,0 37681,1 37707,0 37713,1 37720,0 37763,1 37784,0 37812,1 37906,0 37988,1 37996,0 38035,1 38131,0 38138,1 38236,0 38257,1 38322,0 38344,1 38391,0 38442,1 38458,0 38468,1 38550,0 38612,1 38686,0 38714,1 38717,0 38815,1 38892,0 38916,1 38927,0 38977,1 39048,0 39133,1 39146,0 39159,1 39243,0 39262,1 39284,0 39308,1 39353,0 39383,1 39479,0 39487,1 39513,0 39546,1 39643,0 39675,1 39733,0 39812,1 39880,0 39952,1 39969,0 40033,1 40080,0 40161,1 40173,0 40243,1 40324,0 40344,1 40387,0 40427,1 40507,0 40587,1 40665,0 40701,1 40729,0 40827,1 40899,0 40972,1 40994,0 41054,1 41103,0 41120,1 41128,0 41162,1 41191,0 41194,1 41273,0 41337,1 41421,0 41471,1 41541,0 41546,1 41600,0 41602,1 41671,0 41681,1 41753,0 41833,1 41931,0 41995,1 42082,0 42157,1 42182,0 42206,1 42295,0 42370,1 42452,0 42530,1 42539,0 42557,1 42566,0 42660,1 42759,0 42769,1 42830,0 42908,1 42970,0 43007,1 43019,0 43053,1 43084,0 43148,1 43238,0 43320,1 43412,0 43455,1 43515,0 43594,1 43688,0 43744,1 43834,0 43877,1 43924,0 43959,1 44003,0 44014,1 44078,0 44092,1 44095,0 44105,1 44169,0 44237,1 44248,0 44260,1 44339,0 44413,1 44464,0 44495,1 44560,0 44569,1 44638,0 44709,1 44760,0 44836,1 44886,0 44902,1 44914,0 44991,1 45003,0 45023,1 45077,0 45115,1 45199,0 45263,1 45279,0 45369,1 45373,0 45450,1 45496,0 45552,1 45638,0 45679,1 45707,0 45731,1 45804,0 45868,1 45934,0 45940,1 46021,0 46114,1 46153,0 46169,1 46265,0 46292,1 46366,0 46459,1 46468,0 46507,1 46573,0 46634,1 46679,0 46716,1 46731,0 46764,1 46777,0 46833,1 46855,0 46914,1 46980,0 47055,1 47114,0 47128,1 47135,0 47181,1 47264,0 47265,1 47302,0 47388,1 47478,0 47528,1 47551,0 47602,1 47683,0 47779,1 47825,0 47918,1 47968,0 48058,1 48075,0 48133,1 48158,0 48235,1 48320,0 48414,1 48477,0 48511,1 48607,0 48623,1 48694,0 48751,1 48846,0 48856,1 48908,0 48952,1 49031,0 49038,1 49041,0 49066,1 49148,0 49214,1 49217,0 49264,1 49344,0 49357,1 49363,0 49387,1 49428,0 49506,1 49565,0 49646,1 49664,0 49725,1 49817,0 49907,1 49939,0 50017,1 50090,0 50104,1 50135,0 50174,1 end initlist b10 0,0 8,1 76,0 99,1 166,0 209,1 265,0 336,1 407,0 439,1 501,0 579,1 590,0 606,1 679,0 757,1 794,0 799,1 857,0 948,1 1033,0 1085,1 1167,0 1224,1 1273,0 1289,1 1347,0 1397,1 1468,0 1537,1 1556,0 1613,1 1673,0 1720,1 1791,0 1797,1 1858,0 1871,1 1921,0 1980,1 2036,0 2134,1 2162,0 2247,1 2299,0 2336,1 2345,0 2396,1 2409,0 2419,1 2495,0 2544,1 2598,0 2656,1 2679,0 2721,1 2744,0 2802,1 2850,0 2903,1 2910,0 2929,1 2953,0 2979,1 3065,0 3082,1 3177,0 3202,1 3274,0 3371,1 3385,0 3445,1 3484,0 3582,1 3603,0 3679,1 3720,0 3803,1 3895,0 3962,1 4006,0 4092,1 4139,0 4167,1 4171,0 4194,1 4252,0 4253,1 4338,0 4404,1 4408,0 4426,1 4453,0 4465,1 4469,0 4509,1 4551,0 4630,1 4659,0 4746,1 4758,0 4780,1 4834,0 4917,1 5000,0 5023,1 5058,0 5063,1 5067,0 5157,1 5168,0 5209,1 5287,0 5315,1 5415,0 5453,1 5486,0 5500,1 5521,0 5618,1 5623,0 5629,1 5650,0 5727,1 5754,0 5829,1 5884,0 5889,1 5891,0 5944,1 6001,0 6065,1 6141,0 6192,1 6287,0 6351,1 6404,0 6460,1 6469,0 6561,1 6632,0 6729,1 6808,0 6897,1 6940,0 7032,1 7066,0 7068,1 7098,0 7152,1 7230,0 7274,1 7373,0 7469,1 7537,0 7584,1 7586,0 7661,1 7693,0 7741,1 7775,0 7796,1 7848,0 7882,1 7899,0 7964,1 8061,0 8085,1 8152,0 8154,1 8192,0 8253,1 8320,0 8351,1 8394,0 8465,1 8491,0 8517,1 8528,0 8609,1 8646,0 8676,1 8710,0 8780,1 8847,0 8937,1 8957,0 9005,1 9083,0 9141,1 9187,0 9234,1 9267,0 9314,1 9403,0 9474,1 9486,0 9543,1 9596,0 9604,1 9644,0 9645,1 9676,0 9765,1 9849,0 9909,1 9984,0 10057,1 10115,0 10149,1 10249,0 10327,1 10345,0 10362,1 10385,0 10476,1 10528,0 10609,1 10648,0 10693,1 10743,0 10819,1 10884,0 10912,1 10982,0 11035,1 11060,0 11078,1 11131,0 11192,1 11195,0 11240,1 11301,0 11369,1 11407,0 11418,1 11421,0 11476,1 11485,0 11561,1 11611,0 11655,1 11662,0 11725,1 11818,0 11907,1 11967,0 11991,1 12040,0 12084,1 12143,0 12219,1 12317,0 12362,1 12447,0 12520,1 12540,0 12570,1 12664,0 12682,1 12707,0 12798,1 12818,0 12909,1 12971,0 12981,1 12982,0 13020,1 13036,0 13047,1 13091,0 13165,1 13187,0 13198,1 13245,0 13305,1 13372,0 13413,1 13493,0 13513,1 13555,0 13646,1 13676,0 13692,1 13708,0 13803,1 13805,0 13903,1 13917,0 13921,1 13988,0 14025,1 14032,0 14054,1 14078,0 14174,1 14192,0 14274,1 14372,0 14397,1 14473,0 14557,1 14561,0 14629,1 14722,0 14732,1 14735,0 14805,1 14827,0 14923,1 14954,0 14984,1 15075,0 15161,1 15219,0 15243,1 15256,0 15309,1 15355,0 15396,1 15468,0 15489,1 15519,0 15547,1 15611,0 15684,1 15746,0 15792,1 15836,0 15851,1 15948,0 16003,1 16062,0 16148,1 16210,0 16219,1 16281,0 16365,1 16399,0 16443,1 16460,0 16484,1 16544,0 16628,1 16670,0 16721,1 16821,0 16842,1 16876,0 16889,1 16915,0 16929,1 16978,0 16986,1 17012,0 17110,1 17178,0 17217,1 17229,0 17267,1 17291,0 17370,1 17379,0 17457,1 17513,0 17606,1 17620,0 17647,1 17692,0 17761,1 17831,0 17929,1 17971,0 18016,1 18062,0 18084,1 18173,0 18218,1 18287,0 18334,1 18383,0 18429,1 18464,0 18537,1 18608,0 18649,1 18664,0 18682,1 18779,0 18798,1 18860,0 18887,1 18916,0 18935,1 18985,0 19040,1 19111,0 19124,1 19151,0 19153,1 19161,0 19235,1 19280,0 19365,1 19442,0 19497,1 19531,0 19552,1 19614,0 19645,1 19731,0 19796,1 19855,0 19943,1 20007,0 20056,1 20145,0 20231,1 20329,0 20352,1 20420,0 20515,1 20525,0 20623,1 20696,0 20729,1 20822,0 20891,1 20945,0 21010,1 21043,0 21062,1 21120,0 21165,1 21187,0 21277,1 21288,0 21302,1 21318,0 21397,1 21461,0 21470,1 21504,0 21537,1 21611,0 21685,1 21760,0 21856,1 21859,0 21916,1 21973,0 22042,1 22097,0 22109,1 22141,0 22164,1 22223,0 22241,1 22290,0 22324,1 22354,0 22376,1 22472,0 22539,1 22564,0 22645,1 22712,0 22714,1 22781,0 22857,1 22858,0 22859,1 22894,0 22948,1 23022,0 23039,1 23049,0 23098,1 23184,0 23186,1 23210,0 23253,1 23320,0 23395,1 23424,0 23425,1 23504,0 23542,1 23601,0 23657,1 23675,0 23744,1 23822,0 23885,1 23905,0 23936,1 24036,0 24065,1 24070,0 24165,1 24246,0 24324,1 24370,0 24402,1 24466,0 24467,1 24524,0 24611,1 24667,0 24692,1 24704,0 24720,1 24722,0 24771,1 24782,0 24798,1 24892,0 24897,1 24938,0 25035,1 25118,0 25186,1 25266,0 25345,1 25441,0 25528,1 25573,0 25583,1 25656,0 25691,1 25706,0 25802,1 25894,0 25955,1 26027,0 26123,1 26151,0 26194,1 26285,0 26327,1 26380,0 26395,1 26414,0 26450,1 26531,0 26535,1 26614,0 26626,1 26668,0 26723,1 26760,0 26818,1 26909,0 26923,1 26974,0 27063,1 27078,0 27116,1 27183,0 27225,1 27246,0 27328,1 27357,0 27411,1 27497,0 27555,1 27590,0 27680,1 27766,0 27847,1 27861,0 27887,1 27942,0 27953,1 27991,0 28007,1 28042,0 28139,1 28201,0 28263,1 28357,0 28398,1 28472,0 28514,1 28597,0 28656,1 28739,0 28837,1 28845,0 28936,1 28992,0 29047,1 29140,0 29208,1 29265,0 29266,1 29310,0 29326,1 29415,0 29487,1 29570,0 29647,1 29664,0 29731,1 29827,0 29871,1 29959,0 29992,1 30010,0 30072,1 30105,0 30177,1 30252,0 30285,1 30318,0 30338,1 30376,0 30451,1 30479,0 30555,1 30594,0 30645,1 30743,0 30755,1 30806,0 30885,1 30901,0 30913,1 30967,0 31049,1 31051,0 31055,1 31083,0 31150,1 31225,0 31235,1 31271,0 31350,1 31405,0 31479,1 31480,0 31580,1 31607,0 31634,1 31701,0 31705,1 31723,0 31798,1 31831,0 31855,1 31894,0 31975,1 31983,0 31996,1 32024,0 32122,1 32132,0 32140,1 32227,0 32282,1 32302,0 32318,1 32380,0 32384,1 32458,0 32536,1 32562,0 32634,1 32653,0 32654,1 32741,0 32822,1 32854,0 32911,1 33011,0 33080,1 33178,0 33275,1 33316,0 33412,1 33413,0 33485,1 33533,0 33563,1 33604,0 33634,1 33728,0 33820,1 33842,0 33902,1 33979,0 34029,1 34067,0 34149,1 34187,0 34227,1 34290,0 34383,1 34443,0 34534,1 34541,0 34578,1 34624,0 34638,1 34699,0 34718,1 34811,0 34817,1 34822,0 34914,1 34980,0 35024,1 35104,0 35178,1 35251,0 35329,1 35406,0 35452,1 35463,0 35547,1 35618,0 35624,1 35631,0 35632,1 35703,0 35760,1 35793,0 35821,1 35915,0 35947,1 36003,0 36004,1 36028,0 36085,1 36153,0 36233,1 36239,0 36322,1 36391,0 36421,1 36461,0 36491,1 36574,0 36621,1 36719,0 36721,1 36821,0 36875,1 36964,0 37005,1 37046,0 37120,1 37131,0 37153,1 37160,0 37212,1 37293,0 37306,1 37390,0 37479,1 37515,0 37593,1 37614,0 37705,1 37786,0 37807,1 37893,0 37965,1 38050,0 38088,1 38154,0 38223,1 38267,0 38285,1 38338,0 38407,1 38452,0 38499,1 38596,0 38606,1 38619,0 38653,1 38723,0 38737,1 38741,0 38820,1 38859,0 38867,1 38941,0 38975,1 39039,0 39138,1 39210,0 39228,1 39321,0 39322,1 39331,0 39337,1 39398,0 39476,1 39549,0 39564,1 39576,0 39621,1 39687,0 39689,1 39760,0 39776,1 39863,0 39910,1 39917,0 39938,1 39947,0 40043,1 40048,0 40093,1 40108,0 40129,1 40145,0 40229,1 40325,0 40416,1 40444,0 40542,1 40633,0 40661,1 40697,0 40796,1 40863,0 40935,1 41005,0 41103,1 41140,0 41198,1 41256,0 41328,1 41381,0 41409,1 41419,0 41421,1 41481,0 41581,1 41645,0 41646,1 41668,0 41703,1 41773,0 41838,1 41937,0 42023,1 42089,0 42107,1 42142,0 42194,1 42249,0 42343,1 42347,0 42422,1 42516,0 42605,1 42675,0 42688,1 42700,0 42732,1 42831,0 42892,1 42972,0 43020,1 43101,0 43155,1 43233,0 43293,1 43304,0 43315,1 43412,0 43481,1 43570,0 43646,1 43673,0 43761,1 43807,0 43824,1 43900,0 43909,1 43992,0 44054,1 44093,0 44119,1 44136,0 44200,1 44247,0 44251,1 44332,0 44379,1 44444,0 44519,1 44589,0 44605,1 44696,0 44698,1 44755,0 44815,1 44868,0 44883,1 44902,0 44909,1 44962,0 44995,1 45030,0 45046,1 45132,0 45182,1 45201,0 45224,1 45317,0 45340,1 45343,0 45392,1 45472,0 45496,1 45513,0 45606,1 45628,0 45663,1 45691,0 45777,1 45834,0 45922,1 45931,0 45973,1 45997,0 46019,1 46081,0 46091,1 46128,0 46223,1 46284,0 46380,1 46384,0 46405,1 46422,0 46507,1 46556,0 46647,1 46697,0 46721,1 46818,0 46839,1 46895,0 46994,1 47007,0 47030,1 47056,0 47125,1 47132,0 47171,1 47257,0 47308,1 47403,0 47469,1 47529,0 47549,1 47578,0 47622,1 47694,0 47702,1 47786,0 47798,1 47857,0 47952,1 48033,0 48065,1 48124,0 48188,1 48227,0 48319,1 48349,0 48395,1 48430,0 48489,1 48514,0 48573,1 48623,0 48702,1 48760,0 48780,1 48795,0 48877,1 48957,0 49024,1 49031,0 49123,1 49138,0 49236,1 49271,0 49297,1 49305,0 49316,1 49371,0 49443,1 49515,0 49609,1 end initlist b11 0,0 86,1 118,0 152,1 177,0 240,1 327,0 382,1 384,0 410,1 415,0 425,1 438,0 490,1 527,0 577,1 644,0 703,1 767,0 823,1 920,0 960,1 1045,0 1097,1 1115,0 1146,1 1217,0 1291,1 1318,0 1348,1 1413,0 1481,1 1581,0 1615,1 1688,0 1728,1 1751,0 1810,1 1838,0 1904,1 1924,0 1951,1 1982,0 1997,1 2081,0 2089,1 2188,0 2189,1 2192,0 2266,1 2346,0 2418,1 2477,0 2547,1 2573,0 2666,1 2676,0 2689,1 2739,0 2759,1 2838,0 2902,1 2979,0 3020,1 3026,0 3099,1 3156,0 3174,1 3176,0 3259,1 3284,0 3329,1 3391,0 3464,1 3488,0 3492,1 3494,0 3558,1 3604,0 3672,1 3692,0 3736,1 3798,0 3858,1 3945,0 4017,1 4111,0 4156,1 4249,0 4289,1 4352,0 4444,1 4497,0 4593,1 4673,0 4686,1 4734,0 4764,1 4779,0 4842,1 4907,0 4977,1 5015,0 5022,1 5110,0 5178,1 5242,0 5295,1 5301,0 5338,1 5402,0 5490,1 5541,0 5624,1 5677,0 5679,1 5748,0 5842,1 5906,0 5968,1 6028,0 6094,1 6193,0 6201,1 6205,0 6296,1 6350,0 6420,1 6505,0 6546,1 6591,0 6679,1 6728,0 6773,1 6826,0 6875,1 6880,0 6942,1 6972,0 7042,1 7055,0 7146,1 7160,0 7211,1 7267,0 7288,1 7356,0 7437,1 7462,0 7465,1 7490,0 7576,1 7647,0 7729,1 7774,0 7796,1 7853,0 7904,1 7983,0 8079,1 8142,0 8143,1 8198,0 8266,1 8339,0 8340,1 8435,0 8525,1 8596,0 8671,1 8741,0 8750,1 8763,0 8863,1 8877,0 8967,1 8991,0 9034,1 9119,0 9165,1 9241,0 9269,1 9325,0 9332,1 9341,0 9364,1 9453,0 9468,1 9522,0 9571,1 9629,0 9663,1 9671,0 9676,1 9740,0 9782,1 9863,0 9891,1 9929,0 9999,1 10078,0 10081,1 10179,0 10230,1 10269,0 10330,1 10398,0 10436,1 10455,0 10484,1 10504,0 10555,1 10597,0 10668,1 10694,0 10700,1 10769,0 10868,1 10929,0 10998,1 11010,0 11044,1 11060,0 11098,1 11196,0 11200,1 11214,0 11310,1 11371,0 11390,1 11435,0 11479,1 11570,0 11646,1 11698,0 11785,1 11842,0 11850,1 11944,0 12036,1 12079,0 12126,1 12162,0 12171,1 12203,0 12226,1 12268,0 12283,1 12380,0 12460,1 12544,0 12619,1 12630,0 12692,1 12719,0 12790,1 12858,0 12904,1 12943,0 12950,1 13018,0 13026,1 13033,0 13060,1 13124,0 13221,1 13307,0 13365,1 13400,0 13465,1 13475,0 13515,1 13558,0 13615,1 13649,0 13666,1 13730,0 13772,1 13805,0 13868,1 13927,0 13935,1 13994,0 14011,1 14110,0 14200,1 14214,0 14292,1 14383,0 14435,1 14477,0 14536,1 14546,0 14643,1 14653,0 14697,1 14711,0 14736,1 14758,0 14760,1 14791,0 14797,1 14817,0 14823,1 14854,0 14915,1 14994,0 15093,1 15172,0 15213,1 15292,0 15331,1 15403,0 15472,1 15520,0 15612,1 15645,0 15653,1 15736,0 15743,1 15837,0 15891,1 15919,0 15946,1 15989,0 16012,1 16019,0 16044,1 16126,0 16181,1 16206,0 16264,1 16324,0 16379,1 16424,0 16480,1 16534,0 16589,1 16596,0 16620,1 16707,0 16744,1 16811,0 16841,1 16898,0 16979,1 16988,0 17002,1 17028,0 17052,1 17077,0 17087,1 17135,0 17215,1 17266,0 17299,1 17332,0 17426,1 17440,0 17442,1 17470,0 17501,1 17554,0 17629,1 17707,0 17795,1 17867,0 17877,1 17951,0 17996,1 18062,0 18093,1 18190,0 18195,1 18200,0 18292,1 18342,0 18394,1 18415,0 18457,1 18498,0 18588,1 18644,0 18735,1 18831,0 18832,1 18846,0 18913,1 18936,0 19015,1 19018,0 19074,1 19109,0 19163,1 19187,0 19269,1 19315,0 19391,1 19426,0 19454,1 19551,0 19607,1 19649,0 19685,1 19775,0 19869,1 19923,0 20011,1 20053,0 20103,1 20154,0 20249,1 20329,0 20415,1 20434,0 20468,1 20519,0 20541,1 20617,0 20698,1 20764,0 20831,1 20867,0 20934,1 20971,0 21001,1 21054,0 21112,1 21128,0 21163,1 21178,0 21182,1 21193,0 21289,1 21304,0 21353,1 21425,0 21483,1 21504,0 21563,1 21646,0 21686,1 21714,0 21814,1 21843,0 21876,1 21909,0 21980,1 22013,0 22052,1 22076,0 22123,1 22189,0 22260,1 22346,0 22359,1 22418,0 22427,1 22438,0 22501,1 22591,0 22605,1 22687,0 22703,1 22784,0 22816,1 22817,0 22885,1 22952,0 22992,1 23064,0 23124,1 23221,0 23261,1 23313,0 23331,1 23428,0 23507,1 23603,0 23643,1 23727,0 23755,1 23805,0 23899,1 23982,0 23992,1 24084,0 24151,1 24234,0 24300,1 24357,0 24434,1 24534,0 24617,1 24660,0 24663,1 24707,0 24715,1 24739,0 24821,1 24917,0 24981,1 24984,0 25020,1 25094,0 25130,1 25136,0 25137,1 25140,0 25142,1 25177,0 25257,1 25265,0 25285,1 25365,0 25462,1 25508,0 25540,1 25557,0 25603,1 25619,0 25692,1 25780,0 25873,1 25944,0 26016,1 26053,0 26145,1 26206,0 26279,1 26356,0 26409,1 26497,0 26596,1 26622,0 26681,1 26754,0 26778,1 26785,0 26821,1 26887,0 26978,1 26999,0 27010,1 27107,0 27199,1 27220,0 27280,1 27311,0 27324,1 27356,0 27418,1 27514,0 27521,1 27579,0 27592,1 27688,0 27693,1 27735,0 27780,1 27858,0 27923,1 27932,0 27944,1 28028,0 28046,1 28076,0 28176,1 28272,0 28276,1 28336,0 28349,1 28389,0 28436,1 28451,0 28509,1 28595,0 28641,1 28701,0 28742,1 28793,0 28796,1 28891,0 28914,1 29010,0 29072,1 29093,0 29103,1 29197,0 29274,1 29297,0 29366,1 29401,0 29489,1 29491,0 29519,1 29594,0 29620,1 29659,0 29728,1 29808,0 29814,1 29866,0 29949,1 29998,0 30052,1 30142,0 30197,1 30282,0 30296,1 30371,0 30437,1 30438,0 30484,1 30554,0 30584,1 30648,0 30730,1 30778,0 30868,1 30957,0 30991,1 31081,0 31112,1 31197,0 31255,1 31327,0 31413,1 31435,0 31528,1 31579,0 31670,1 31722,0 31786,1 31827,0 31868,1 31943,0 32019,1 32102,0 32196,1 32238,0 32276,1 32376,0 32378,1 32398,0 32436,1 32475,0 32508,1 32567,0 32573,1 32624,0 32634,1 32692,0 32792,1 32793,0 32842,1 32911,0 32946,1 33012,0 33061,1 33079,0 33132,1 33210,0 33254,1 33261,0 33287,1 33289,0 33383,1 33416,0 33441,1 33457,0 33516,1 33606,0 33691,1 33693,0 33700,1 33713,0 33787,1 33827,0 33903,1 33933,0 33974,1 34071,0 34078,1 34091,0 34187,1 34259,0 34342,1 34432,0 34457,1 34539,0 34569,1 34605,0 34609,1 34670,0 34705,1 34755,0 34764,1 34815,0 34875,1 34887,0 34937,1 34993,0 35089,1 35112,0 35146,1 35158,0 35195,1 35279,0 35301,1 35313,0 35318,1 35407,0 35434,1 35459,0 35538,1 35584,0 35596,1 35637,0 35735,1 35784,0 35856,1 35931,0 35962,1 35968,0 36045,1 36141,0 36181,1 36239,0 36330,1 36357,0 36403,1 36502,0 36600,1 36638,0 36711,1 36754,0 36851,1 36923,0 36962,1 36994,0 37085,1 37153,0 37218,1 37237,0 37284,1 37332,0 37410,1 37417,0 37491,1 37515,0 37549,1 37632,0 37648,1 37745,0 37754,1 37844,0 37848,1 37866,0 37945,1 37953,0 38004,1 38074,0 38139,1 38202,0 38203,1 38234,0 38313,1 38363,0 38376,1 38405,0 38498,1 38550,0 38572,1 38631,0 38685,1 38769,0 38799,1 38861,0 38915,1 38962,0 39021,1 39056,0 39099,1 39156,0 39196,1 39218,0 39224,1 39307,0 39366,1 39376,0 39437,1 39459,0 39494,1 39529,0 39554,1 39582,0 39614,1 39677,0 39687,1 39695,0 39771,1 39817,0 39862,1 39869,0 39949,1 40029,0 40107,1 40184,0 40270,1 40310,0 40320,1 40413,0 40415,1 40416,0 40453,1 40516,0 40601,1 40699,0 40797,1 40803,0 40899,1 40969,0 41025,1 41108,0 41194,1 41209,0 41264,1 41269,0 41350,1 41439,0 41529,1 41563,0 41600,1 41672,0 41759,1 41764,0 41825,1 41892,0 41943,1 42005,0 42045,1 42079,0 42089,1 42182,0 42245,1 42272,0 42371,1 42442,0 42502,1 42592,0 42609,1 42642,0 42700,1 42793,0 42836,1 42899,0 42992,1 43088,0 43103,1 43121,0 43131,1 43155,0 43238,1 43315,0 43356,1 43365,0 43394,1 43432,0 43434,1 43460,0 43462,1 43515,0 43519,1 43576,0 43675,1 43758,0 43833,1 43904,0 43909,1 44000,0 44005,1 44058,0 44143,1 44151,0 44233,1 44252,0 44331,1 44355,0 44450,1 44467,0 44497,1 44569,0 44596,1 44610,0 44654,1 44673,0 44702,1 44754,0 44770,1 44802,0 44816,1 44879,0 44903,1 45001,0 45043,1 45123,0 45193,1 45225,0 45277,1 45341,0 45356,1 45442,0 45507,1 45588,0 45616,1 45705,0 45787,1 45882,0 45934,1 45969,0 45985,1 46061,0 46077,1 46114,0 46140,1 46211,0 46266,1 46331,0 46421,1 46445,0 46484,1 46545,0 46549,1 46586,0 46619,1 46708,0 46780,1 46783,0 46834,1 46842,0 46931,1 46966,0 47036,1 47124,0 47132,1 47138,0 47234,1 47328,0 47353,1 47355,0 47406,1 47458,0 47512,1 47536,0 47562,1 47623,0 47686,1 47734,0 47833,1 47886,0 47952,1 48034,0 48123,1 48195,0 48229,1 48253,0 48324,1 48406,0 48469,1 48511,0 48548,1 48565,0 48573,1 48658,0 48711,1 48785,0 48838,1 48901,0 48964,1 49030,0 49103,1 49197,0 49212,1 49236,0 49331,1 49344,0 49431,1 49528,0 49617,1 49697,0 49721,1 49771,0 49780,1 49798,0 49805,1 49873,0 49930,1 50028,0 50040,1 50085,0 50156,1 end initlist b12 0,0 95,1 129,0 202,1 207,0 274,1 345,0 387,1 438,0 533,1 577,0 612,1 653,0 656,1 664,0 723,1 808,0 841,1 906,0 977,1 993,0 1055,1 1099,0 1179,1 1180,0 1209,1 1289,0 1291,1 1390,0 1411,1 1427,0 1434,1 1501,0 1522,1 1580,0 1608,1 1652,0 1670,1 1754,0 1804,1 1869,0 1916,1 1989,0 2006,1 2010,0 2072,1 2140,0 2154,1 2177,0 2178,1 2189,0 2240,1 2294,0 2387,1 2412,0 2438,1 2445,0 2533,1 2556,0 2596,1 2612,0 2667,1 2753,0 2800,1 2805,0 2897,1 2942,0 2982,1 3023,0 3109,1 3176,0 3224,1 3233,0 3316,1 3326,0 3417,1 3439,0 3523,1 3605,0 3649,1 3670,0 3712,1 3750,0 3815,1 3878,0 3935,1 3952,0 4016,1 4027,0 4105,1 4121,0 4149,1 4238,0 4318,1 4390,0 4466,1 4549,0 4617,1 4626,0 4634,1 4642,0 4661,1 4674,0 4752,1 4839,0 4931,1 4947,0 4967,1 4985,0 5051,1 5088,0 5166,1 5239,0 5252,1 5337,0 5354,1 5440,0 5516,1 5579,0 5662,1 5736,0 5769,1 5796,0 5815,1 5822,0 5861,1 5945,0 6004,1 6046,0 6085,1 6100,0 6129,1 6210,0 6257,1 6328,0 6397,1 6484,0 6512,1 6552,0 6609,1 6681,0 6728,1 6822,0 6881,1 6882,0 6914,1 6919,0 6973,1 7073,0 7162,1 7215,0 7242,1 7314,0 7347,1 7429,0 7449,1 7528,0 7606,1 7648,0 7685,1 7742,0 7833,1 7836,0 7872,1 7879,0 7902,1 7930,0 8025,1 8104,0 8132,1 8213,0 8296,1 8369,0 8457,1 8497,0 8593,1 8597,0 8636,1 8676,0 8705,1 8744,0 8755,1 8820,0 8840,1 8907,0 8921,1 8950,0 9042,1 9078,0 9102,1 9138,0 9217,1 9289,0 9331,1 9355,0 9407,1 9426,0 9486,1 9502,0 9531,1 9595,0 9665,1 9735,0 9773,1 9851,0 9865,1 9929,0 10022,1 10110,0 10178,1 10204,0 10217,1 10257,0 10276,1 10321,0 10345,1 10394,0 10426,1 10475,0 10538,1 10603,0 10656,1 10692,0 10735,1 10757,0 10852,1 10878,0 10898,1 10961,0 10986,1 11061,0 11122,1 11151,0 11158,1 11174,0 11254,1 11286,0 11357,1 11369,0 11460,1 11556,0 11608,1 11688,0 11697,1 11760,0 11768,1 11836,0 11907,1 11924,0 11958,1 12013,0 12020,1 12047,0 12145,1 12243,0 12307,1 12404,0 12470,1 12523,0 12587,1 12608,0 12641,1 12677,0 12695,1 12751,0 12794,1 12873,0 12914,1 12915,0 12958,1 13015,0 13090,1 13106,0 13138,1 13155,0 13167,1 13197,0 13283,1 13328,0 13360,1 13385,0 13478,1 13517,0 13547,1 13562,0 13608,1 13631,0 13672,1 13772,0 13807,1 13905,0 13916,1 13999,0 14090,1 14147,0 14183,1 14213,0 14294,1 14295,0 14303,1 14362,0 14454,1 14515,0 14517,1 14518,0 14523,1 14572,0 14640,1 14680,0 14716,1 14732,0 14794,1 14862,0 14907,1 14921,0 14935,1 15020,0 15093,1 15110,0 15183,1 15226,0 15285,1 15344,0 15393,1 15406,0 15450,1 15532,0 15571,1 15580,0 15596,1 15663,0 15762,1 15854,0 15908,1 15951,0 16050,1 16104,0 16179,1 16202,0 16283,1 16284,0 16292,1 16368,0 16443,1 16486,0 16573,1 16672,0 16758,1 16796,0 16865,1 16962,0 17037,1 17068,0 17080,1 17138,0 17186,1 17251,0 17332,1 17390,0 17468,1 17553,0 17555,1 17584,0 17653,1 17707,0 17763,1 17805,0 17875,1 17904,0 17947,1 17971,0 17996,1 18036,0 18128,1 18223,0 18321,1 18354,0 18437,1 18533,0 18561,1 18636,0 18643,1 18651,0 18697,1 18794,0 18890,1 18956,0 18974,1 19071,0 19101,1 19162,0 19227,1 19240,0 19296,1 19346,0 19357,1 19395,0 19488,1 19577,0 19657,1 19660,0 19758,1 19786,0 19881,1 19913,0 19922,1 19997,0 20059,1 20139,0 20169,1 20184,0 20202,1 20290,0 20382,1 20458,0 20484,1 20501,0 20573,1 20649,0 20674,1 20700,0 20714,1 20808,0 20879,1 20911,0 20960,1 20981,0 21062,1 21067,0 21088,1 21152,0 21206,1 21259,0 21307,1 21334,0 21397,1 21400,0 21487,1 21576,0 21639,1 21716,0 21742,1 21831,0 21850,1 21892,0 21952,1 22024,0 22119,1 22192,0 22251,1 22346,0 22392,1 22483,0 22489,1 22579,0 22605,1 22650,0 22668,1 22759,0 22780,1 22805,0 22820,1 22894,0 22930,1 22945,0 22999,1 23082,0 23167,1 23219,0 23281,1 23348,0 23409,1 23453,0 23457,1 23496,0 23580,1 23662,0 23721,1 23743,0 23811,1 23814,0 23868,1 23951,0 24035,1 24085,0 24124,1 24208,0 24281,1 24283,0 24362,1 24431,0 24440,1 24511,0 24553,1 24563,0 24640,1 24680,0 24683,1 24755,0 24853,1 24903,0 24957,1 25016,0 25071,1 25102,0 25173,1 25198,0 25224,1 25263,0 25335,1 25355,0 25384,1 25478,0 25506,1 25512,0 25533,1 25623,0 25635,1 25726,0 25754,1 25787,0 25842,1 25891,0 25897,1 25931,0 26026,1 26054,0 26139,1 26173,0 26254,1 26310,0 26387,1 26444,0 26516,1 26566,0 26657,1 26754,0 26757,1 26806,0 26896,1 26948,0 26978,1 27065,0 27122,1 27192,0 27230,1 27268,0 27301,1 27367,0 27418,1 27471,0 27567,1 27658,0 27661,1 27755,0 27780,1 27864,0 27908,1 28007,0 28095,1 28100,0 28187,1 28217,0 28296,1 28310,0 28401,1 28450,0 28495,1 28519,0 28569,1 28616,0 28714,1 28807,0 28870,1 28907,0 28908,1 28918,0 28927,1 29003,0 29035,1 29092,0 29168,1 29265,0 29352,1 29396,0 29457,1 29510,0 29513,1 29567,0 29623,1 29721,0 29798,1 29869,0 29921,1 29936,0 29985,1 30040,0 30108,1 30129,0 30171,1 30271,0 30371,1 30401,0 30494,1 30510,0 30554,1 30640,0 30678,1 30746,0 30787,1 30795,0 30882,1 30933,0 30946,1 31000,0 31099,1 31168,0 31257,1 31292,0 31383,1 31460,0 31478,1 31532,0 31584,1 31681,0 31771,1 31789,0 31802,1 31898,0 31918,1 31933,0 31986,1 32027,0 32080,1 32089,0 32146,1 32238,0 32303,1 32369,0 32452,1 32482,0 32564,1 32654,0 32718,1 32758,0 32771,1 32864,0 32955,1 32961,0 32995,1 33003,0 33053,1 33084,0 33120,1 33158,0 33207,1 33295,0 33353,1 33386,0 33410,1 33448,0 33484,1 33498,0 33518,1 33603,0 33649,1 33730,0 33758,1 33838,0 33850,1 33940,0 34021,1 34082,0 34105,1 34185,0 34223,1 34278,0 34298,1 34316,0 34337,1 34343,0 34428,1 34494,0 34559,1 34605,0 34647,1 34659,0 34730,1 34732,0 34785,1 34803,0 34814,1 34866,0 34937,1 35022,0 35084,1 35096,0 35190,1 35281,0 35369,1 35458,0 35529,1 35542,0 35599,1 35691,0 35761,1 35833,0 35870,1 35874,0 35915,1 35990,0 36079,1 36123,0 36183,1 36198,0 36258,1 36284,0 36351,1 36373,0 36374,1 36401,0 36412,1 36422,0 36494,1 36570,0 36629,1 36696,0 36709,1 36762,0 36849,1 36899,0 36958,1 37018,0 37047,1 37097,0 37138,1 37140,0 37163,1 37261,0 37309,1 37361,0 37433,1 37460,0 37488,1 37512,0 37585,1 37615,0 37653,1 37675,0 37704,1 37751,0 37772,1 37848,0 37890,1 37906,0 37973,1 38070,0 38074,1 38110,0 38151,1 38167,0 38257,1 38300,0 38356,1 38403,0 38417,1 38504,0 38550,1 38591,0 38633,1 38659,0 38716,1 38718,0 38740,1 38778,0 38786,1 38833,0 38868,1 38895,0 38911,1 38928,0 39013,1 39100,0 39103,1 39151,0 39225,1 39262,0 39320,1 39360,0 39361,1 39381,0 39471,1 39567,0 39577,1 39662,0 39721,1 39748,0 39766,1 39811,0 39851,1 39889,0 39908,1 39929,0 39991,1 40011,0 40099,1 40117,0 40206,1 40283,0 40327,1 40333,0 40423,1 40501,0 40598,1 40621,0 40639,1 40739,0 40769,1 40842,0 40894,1 40936,0 40970,1 41068,0 41079,1 41097,0 41163,1 41224,0 41264,1 41358,0 41429,1 41479,0 41532,1 41585,0 41618,1 41629,0 41727,1 41789,0 41825,1 41912,0 41995,1 42056,0 42153,1 42172,0 42262,1 42270,0 42335,1 42431,0 42448,1 42546,0 42559,1 42625,0 42717,1 42759,0 42858,1 42889,0 42905,1 42950,0 42965,1 42988,0 42995,1 43082,0 43175,1 43220,0 43302,1 43329,0 43345,1 43354,0 43409,1 43449,0 43480,1 43580,0 43654,1 43708,0 43808,1 43903,0 43975,1 44038,0 44105,1 44178,0 44192,1 44255,0 44278,1 44290,0 44331,1 44378,0 44382,1 44472,0 44491,1 44521,0 44613,1 44686,0 44689,1 44699,0 44790,1 44798,0 44837,1 44898,0 44992,1 45032,0 45036,1 45135,0 45204,1 45280,0 45309,1 45407,0 45500,1 45596,0 45688,1 45766,0 45844,1 45872,0 45930,1 45938,0 46019,1 46038,0 46062,1 46075,0 46170,1 46186,0 46285,1 46323,0 46327,1 46419,0 46440,1 46515,0 46563,1 46580,0 46664,1 46760,0 46813,1 46845,0 46846,1 46869,0 46933,1 46941,0 47025,1 47030,0 47109,1 47143,0 47162,1 47214,0 47298,1 47300,0 47306,1 47373,0 47468,1 47504,0 47564,1 47573,0 47637,1 47707,0 47757,1 47852,0 47889,1 47953,0 48032,1 48072,0 48117,1 48135,0 48151,1 48178,0 48242,1 48244,0 48266,1 48323,0 48357,1 48424,0 48444,1 48530,0 48597,1 48609,0 48647,1 48691,0 48770,1 48862,0 48932,1 48941,0 48959,1 48977,0 49028,1 49120,0 49198,1 49218,0 49275,1 49296,0 49307,1 49353,0 49358,1 49436,0 49513,1 49554,0 49592,1 49605,0 49648,1 49657,0 49718,1 49779,0 49816,1 49896,0 49996,1 50094,0 50104,1 end initlist b13 0,0 34,1 113,0 139,1 202,0 212,1 294,0 351,1 410,0 481,1 542,0 607,1 695,0 714,1 769,0 860,1 915,0 937,1 1024,0 1053,1 1061,0 1080,1 1156,0 1180,1 1249,0 1257,1 1316,0 1388,1 1404,0 1422,1 1432,0 1460,1 1533,0 1561,1 1608,0 1661,1 1674,0 1745,1 1772,0 1848,1 1930,0 1963,1 2017,0 2066,1 2131,0 2144,1 2159,0 2228,1 2263,0 2283,1 2312,0 2401,1 2411,0 2466,1 2558,0 2642,1 2673,0 2737,1 2741,0 2747,1 2834,0 2882,1 2938,0 3032,1 3115,0 3161,1 3234,0 3314,1 3376,0 3427,1 3515,0 3596,1 3653,0 3682,1 3703,0 3733,1 3744,0 3791,1 3802,0 3877,1 3966,0 3969,1 4042,0 4125,1 4181,0 4274,1 4304,0 4354,1 4397,0 4464,1 4520,0 4581,1 4617,0 4711,1 4776,0 4869,1 4883,0 4963,1 5025,0 5028,1 5076,0 5157,1 5222,0 5223,1 5227,0 5294,1 5355,0 5386,1 5485,0 5486,1 5507,0 5539,1 5560,0 5576,1 5606,0 5679,1 5759,0 5791,1 5857,0 5942,1 6021,0 6034,1 6080,0 6148,1 6216,0 6285,1 6327,0 6379,1 6434,0 6479,1 6555,0 6605,1 6680,0 6684,1 6697,0 6767,1 6847,0 6852,1 6916,0 6967,1 7056,0 7075,1 7076,0 7111,1 7117,0 7144,1 7217,0 7270,1 7271,0 7320,1 7408,0 7476,1 7556,0 7636,1 7735,0 7772,1 7822,0 7830,1 7860,0 7897,1 7905,0 7991,1 8086,0 8169,1 8207,0 8273,1 8308,0 8386,1 8453,0 8511,1 8545,0 8575,1 8646,0 8719,1 8813,0 8820,1 8868,0 8873,1 8913,0 8986,1 9000,0 9068,1 9149,0 9153,1 9233,0 9307,1 9332,0 9380,1 9395,0 9470,1 9499,0 9557,1 9632,0 9679,1 9708,0 9776,1 9837,0 9917,1 9929,0 9970,1 9973,0 10059,1 10074,0 10163,1 10249,0 10265,1 10285,0 10362,1 10414,0 10514,1 10515,0 10566,1 10604,0 10634,1 10683,0 10746,1 10749,0 10816,1 10862,0 10908,1 10971,0 11047,1 11062,0 11099,1 11173,0 11242,1 11342,0 11382,1 11387,0 11398,1 11478,0 11511,1 11521,0 11529,1 11603,0 11686,1 11758,0 11830,1 11920,0 11957,1 12008,0 12070,1 12105,0 12130,1 12175,0 12186,1 12211,0 12233,1 12321,0 12325,1 12410,0 12490,1 12505,0 12546,1 12565,0 12638,1 12675,0 12721,1 12793,0 12836,1 12919,0 12966,1 13009,0 13044,1 13105,0 13106,1 13173,0 13207,1 13296,0 13309,1 13317,0 13351,1 13390,0 13447,1 13513,0 13594,1 13620,0 13668,1 13699,0 13736,1 13803,0 13814,1 13899,0 13934,1 14007,0 14017,1 14024,0 14086,1 14132,0 14141,1 14205,0 14275,1 14321,0 14402,1 14442,0 14499,1 14556,0 14591,1 14658,0 14744,1 14813,0 14894,1 14991,0 15021,1 15088,0 15112,1 15128,0 15145,1 15202,0 15205,1 15234,0 15247,1 15331,0 15389,1 15489,0 15507,1 15528,0 15618,1 15638,0 15658,1 15709,0 15785,1 15883,0 15949,1 16030,0 16113,1 16149,0 16215,1 16248,0 16329,1 16414,0 16442,1 16486,0 16571,1 16579,0 16581,1 16627,0 16658,1 16670,0 16672,1 16763,0 16805,1 16817,0 16832,1 16907,0 16939,1 16950,0 16988,1 17031,0 17055,1 17067,0 17128,1 17143,0 17161,1 17194,0 17234,1 17305,0 17392,1 17472,0 17557,1 17630,0 17687,1 17727,0 17771,1 17773,0 17821,1 17877,0 17886,1 17890,0 17960,1 17971,0 18025,1 18074,0 18125,1 18212,0 18278,1 18340,0 18410,1 18424,0 18455,1 18533,0 18548,1 18597,0 18675,1 18726,0 18728,1 18768,0 18806,1 18879,0 18935,1 19014,0 19022,1 19085,0 19137,1 19165,0 19196,1 19214,0 19250,1 19293,0 19390,1 19448,0 19496,1 19576,0 19591,1 19640,0 19703,1 19710,0 19797,1 19830,0 19917,1 19949,0 20038,1 20128,0 20204,1 20217,0 20295,1 20382,0 20425,1 20481,0 20506,1 20565,0 20642,1 20685,0 20766,1 20808,0 20897,1 20942,0 20984,1 20995,0 21019,1 21021,0 21101,1 21139,0 21166,1 21263,0 21321,1 21343,0 21368,1 21452,0 21486,1 21518,0 21590,1 21596,0 21626,1 21707,0 21736,1 21791,0 21809,1 21825,0 21858,1 21938,0 21964,1 22036,0 22058,1 22099,0 22197,1 22199,0 22253,1 22351,0 22451,1 22535,0 22592,1 22621,0 22664,1 22684,0 22732,1 22831,0 22904,1 22971,0 23051,1 23112,0 23179,1 23200,0 23288,1 23289,0 23355,1 23362,0 23390,1 23452,0 23549,1 23627,0 23714,1 23769,0 23847,1 23892,0 23939,1 23971,0 24033,1 24106,0 24184,1 24261,0 24298,1 24380,0 24415,1 24452,0 24485,1 24512,0 24520,1 24577,0 24673,1 24771,0 24850,1 24908,0 24924,1 24990,0 25013,1 25104,0 25127,1 25181,0 25220,1 25290,0 25341,1 25366,0 25423,1 25503,0 25545,1 25580,0 25635,1 25643,0 25711,1 25783,0 25863,1 25878,0 25976,1 26013,0 26018,1 26019,0 26095,1 26115,0 26143,1 26242,0 26259,1 26292,0 26308,1 26384,0 26469,1 26559,0 26614,1 26684,0 26735,1 26739,0 26772,1 26862,0 26864,1 26887,0 26953,1 26973,0 26996,1 27021,0 27109,1 27117,0 27159,1 27186,0 27242,1 27248,0 27327,1 27354,0 27426,1 27447,0 27510,1 27575,0 27638,1 27694,0 27719,1 27780,0 27875,1 27959,0 28008,1 28058,0 28127,1 28156,0 28246,1 28307,0 28352,1 28436,0 28444,1 28474,0 28484,1 28523,0 28573,1 28606,0 28705,1 28755,0 28759,1 28821,0 28864,1 28878,0 28904,1 28933,0 28944,1 29019,0 29103,1 29199,0 29211,1 29266,0 29303,1 29367,0 29374,1 29428,0 29522,1 29607,0 29691,1 29759,0 29781,1 29858,0 29902,1 29949,0 30020,1 30037,0 30119,1 30151,0 30221,1 30315,0 30357,1 30382,0 30478,1 30550,0 30566,1 30604,0 30664,1 30745,0 30755,1 30849,0 30865,1 30909,0 30973,1 31015,0 31079,1 31096,0 31153,1 31239,0 31279,1 31355,0 31388,1 31459,0 31542,1 31572,0 31637,1 31684,0 31728,1 31789,0 31848,1 31930,0 32023,1 32072,0 32117,1 32132,0 32156,1 32197,0 32264,1 32334,0 32415,1 32448,0 32454,1 32480,0 32543,1 32613,0 32659,1 32705,0 32763,1 32794,0 32879,1 32953,0 32967,1 33061,0 33111,1 33122,0 33185,1 33187,0 33242,1 33307,0 33400,1 33479,0 33500,1 33510,0 33568,1 33571,0 33671,1 33748,0 33810,1 33874,0 33892,1 33897,0 33977,1 34000,0 34052,1 34070,0 34130,1 34185,0 34195,1 34269,0 34366,1 34456,0 34501,1 34571,0 34581,1 34630,0 34649,1 34677,0 34733,1 34747,0 34831,1 34925,0 34989,1 35035,0 35054,1 35115,0 35163,1 35261,0 35297,1 35338,0 35422,1 35425,0 35432,1 35480,0 35521,1 35548,0 35629,1 35723,0 35728,1 35732,0 35749,1 35797,0 35850,1 35865,0 35948,1 36032,0 36121,1 36144,0 36167,1 36195,0 36203,1 36258,0 36319,1 36363,0 36367,1 36407,0 36491,1 36566,0 36589,1 36633,0 36645,1 36727,0 36778,1 36829,0 36847,1 36920,0 36966,1 37001,0 37098,1 37145,0 37229,1 37232,0 37295,1 37368,0 37461,1 37495,0 37554,1 37638,0 37712,1 37734,0 37788,1 37849,0 37862,1 37933,0 37960,1 38055,0 38135,1 38207,0 38296,1 38391,0 38399,1 38474,0 38564,1 38664,0 38678,1 38709,0 38794,1 38869,0 38939,1 38948,0 39013,1 39034,0 39037,1 39122,0 39222,1 39270,0 39344,1 39423,0 39500,1 39529,0 39608,1 39699,0 39723,1 39740,0 39742,1 39792,0 39837,1 39904,0 39963,1 40019,0 40056,1 40112,0 40204,1 40263,0 40291,1 40373,0 40469,1 40569,0 40593,1 40673,0 40761,1 40828,0 40858,1 40879,0 40898,1 40955,0 40956,1 40957,0 41013,1 41090,0 41151,1 41154,0 41191,1 41251,0 41292,1 41294,0 41381,1 41448,0 41511,1 41542,0 41628,1 41680,0 41698,1 41721,0 41807,1 41835,0 41891,1 41955,0 42025,1 42116,0 42175,1 42216,0 42270,1 42305,0 42336,1 42337,0 42424,1 42453,0 42475,1 42556,0 42575,1 42653,0 42689,1 42781,0 42848,1 42901,0 42989,1 43018,0 43110,1 43126,0 43215,1 43252,0 43269,1 43319,0 43401,1 43402,0 43497,1 43570,0 43635,1 43711,0 43732,1 43788,0 43857,1 43954,0 43963,1 44004,0 44050,1 44136,0 44223,1 44237,0 44240,1 44301,0 44399,1 44479,0 44530,1 44571,0 44595,1 44618,0 44670,1 44763,0 44805,1 44816,0 44839,1 44931,0 44991,1 45022,0 45111,1 45203,0 45246,1 45296,0 45385,1 45479,0 45493,1 45542,0 45560,1 45579,0 45635,1 45710,0 45739,1 45807,0 45893,1 45910,0 45975,1 46075,0 46090,1 46172,0 46183,1 46255,0 46259,1 46311,0 46383,1 46448,0 46488,1 46568,0 46579,1 46621,0 46682,1 46752,0 46817,1 46846,0 46859,1 46912,0 47007,1 47074,0 47107,1 47122,0 47144,1 47159,0 47214,1 47292,0 47378,1 47416,0 47486,1 47586,0 47640,1 47664,0 47702,1 47737,0 47795,1 47876,0 47901,1 47979,0 48010,1 48066,0 48164,1 48174,0 48227,1 48235,0 48333,1 48343,0 48382,1 48442,0 48486,1 48489,0 48546,1 48602,0 48630,1 48642,0 48735,1 48755,0 48854,1 48864,0 48901,1 48998,0 49008,1 49056,0 49132,1 49191,0 49221,1 49251,0 49294,1 49375,0 49440,1 49528,0 49597,1 49612,0 49674,1 49771,0 49800,1 49837,0 49870,1 49953,0 50048,1 50147,0 50188,1 50284,0 50342,1 50388,0 50429,1 50465,0 50478,1 end initlist b14 0,0 55,1 60,0 104,1 116,0 208,1 214,0 302,1 381,0 463,1 489,0 563,1 628,0 668,1 741,0 775,1 810,0 897,1 981,0 1029,1 1116,0 1210,1 1270,0 1271,1 1361,0 1395,1 1434,0 1502,1 1562,0 1630,1 1666,0 1760,1 1859,0 1920,1 1998,0 2034,1 2079,0 2120,1 2179,0 2206,1 2227,0 2259,1 2264,0 2272,1 2367,0 2428,1 2468,0 2487,1 2550,0 2558,1 2651,0 2734,1 2778,0 2844,1 2853,0 2942,1 3041,0 3045,1 3128,0 3159,1 3166,0 3262,1 3263,0 3326,1 3414,0 3420,1 3519,0 3544,1 3638,0 3715,1 3732,0 3772,1 3870,0 3898,1 3986,0 3998,1 4054,0 4104,1 4148,0 4151,1 4241,0 4308,1 4320,0 4412,1 4461,0 4488,1 4543,0 4642,1 4661,0 4687,1 4752,0 4763,1 4856,0 4914,1 4980,0 4989,1 4997,0 5065,1 5152,0 5156,1 5216,0 5300,1 5360,0 5429,1 5477,0 5530,1 5553,0 5605,1 5615,0 5651,1 5699,0 5781,1 5876,0 5969,1 6044,0 6134,1 6191,0 6284,1 6365,0 6420,1 6520,0 6616,1 6685,0 6745,1 6814,0 6830,1 6914,0 6999,1 7085,0 7171,1 7249,0 7277,1 7310,0 7363,1 7413,0 7494,1 7506,0 7557,1 7563,0 7576,1 7659,0 7731,1 7812,0 7897,1 7976,0 7991,1 8075,0 8102,1 8174,0 8223,1 8262,0 8347,1 8389,0 8427,1 8507,0 8589,1 8602,0 8662,1 8692,0 8781,1 8812,0 8910,1 8991,0 9076,1 9112,0 9136,1 9159,0 9191,1 9274,0 9351,1 9439,0 9515,1 9615,0 9701,1 9769,0 9811,1 9877,0 9924,1 9998,0 10095,1 10193,0 10260,1 10335,0 10417,1 10428,0 10456,1 10552,0 10566,1 10602,0 10679,1 10748,0 10759,1 10807,0 10836,1 10892,0 10898,1 10998,0 11055,1 11106,0 11199,1 11203,0 11271,1 11283,0 11362,1 11428,0 11453,1 11497,0 11575,1 11626,0 11673,1 11687,0 11693,1 11747,0 11837,1 11883,0 11936,1 11963,0 12029,1 12041,0 12078,1 12129,0 12157,1 12189,0 12213,1 12255,0 12342,1 12400,0 12450,1 12480,0 12560,1 12591,0 12667,1 12720,0 12791,1 12830,0 12854,1 12902,0 12940,1 12951,0 13018,1 13076,0 13175,1 13190,0 13220,1 13318,0 13329,1 13425,0 13520,1 13587,0 13613,1 13709,0 13745,1 13825,0 13827,1 13893,0 13972,1 14013,0 14107,1 14123,0 14131,1 14138,0 14210,1 14272,0 14305,1 14384,0 14461,1 14471,0 14538,1 14548,0 14601,1 14689,0 14706,1 14763,0 14835,1 14914,0 14951,1 14976,0 14994,1 15033,0 15093,1 15130,0 15170,1 15214,0 15299,1 15330,0 15410,1 15505,0 15536,1 15551,0 15579,1 15646,0 15739,1 15820,0 15843,1 15885,0 15929,1 15955,0 15985,1 16071,0 16121,1 16166,0 16261,1 16360,0 16382,1 16463,0 16556,1 16605,0 16608,1 16674,0 16708,1 16796,0 16848,1 16920,0 17004,1 17032,0 17124,1 17219,0 17288,1 17341,0 17422,1 17437,0 17441,1 17471,0 17522,1 17621,0 17644,1 17688,0 17769,1 17781,0 17812,1 17841,0 17866,1 17924,0 17927,1 17985,0 18016,1 18025,0 18035,1 18037,0 18120,1 18175,0 18192,1 18284,0 18288,1 18378,0 18455,1 18472,0 18530,1 18559,0 18618,1 18640,0 18683,1 18779,0 18843,1 18882,0 18937,1 18956,0 18991,1 19020,0 19088,1 19172,0 19188,1 19257,0 19273,1 19323,0 19401,1 19485,0 19581,1 19626,0 19687,1 19730,0 19817,1 19825,0 19893,1 19921,0 20010,1 20089,0 20177,1 20273,0 20277,1 20333,0 20371,1 20421,0 20442,1 20521,0 20527,1 20532,0 20553,1 20624,0 20717,1 20740,0 20748,1 20786,0 20826,1 20922,0 20987,1 21041,0 21080,1 21099,0 21130,1 21196,0 21230,1 21276,0 21375,1 21444,0 21530,1 21620,0 21642,1 21687,0 21752,1 21810,0 21818,1 21864,0 21895,1 21969,0 21996,1 22082,0 22100,1 22147,0 22247,1 22339,0 22426,1 22465,0 22472,1 22487,0 22508,1 22556,0 22582,1 22652,0 22655,1 22735,0 22784,1 22846,0 22880,1 22970,0 22977,1 23037,0 23071,1 23112,0 23191,1 23277,0 23334,1 23425,0 23435,1 23452,0 23457,1 23470,0 23562,1 23571,0 23630,1 23681,0 23682,1 23695,0 23764,1 23825,0 23896,1 23951,0 24051,1 24080,0 24124,1 24170,0 24246,1 24249,0 24266,1 24312,0 24350,1 24395,0 24477,1 24480,0 24543,1 24601,0 24621,1 24644,0 24717,1 24755,0 24785,1 24799,0 24893,1 24971,0 24998,1 25063,0 25101,1 25192,0 25282,1 25306,0 25354,1 25428,0 25526,1 25562,0 25620,1 25631,0 25705,1 25776,0 25850,1 25881,0 25964,1 26027,0 26094,1 26146,0 26203,1 26253,0 26281,1 26321,0 26344,1 26409,0 26429,1 26486,0 26535,1 26553,0 26636,1 26685,0 26765,1 26839,0 26882,1 26963,0 26978,1 27056,0 27065,1 27120,0 27155,1 27214,0 27260,1 27329,0 27418,1 27422,0 27463,1 27549,0 27568,1 27626,0 27656,1 27710,0 27767,1 27843,0 27921,1 27935,0 27958,1 27994,0 28079,1 28128,0 28135,1 28155,0 28179,1 28239,0 28271,1 28301,0 28372,1 28470,0 28476,1 28568,0 28584,1 28589,0 28632,1 28665,0 28741,1 28750,0 28776,1 28790,0 28799,1 28893,0 28937,1 28987,0 29085,1 29108,0 29149,1 29236,0 29269,1 29363,0 29426,1 29440,0 29443,1 29529,0 29594,1 29626,0 29629,1 29692,0 29789,1 29880,0 29979,1 30004,0 30010,1 30083,0 30125,1 30181,0 30197,1 30293,0 30317,1 30338,0 30366,1 30432,0 30486,1 30573,0 30628,1 30692,0 30740,1 30769,0 30849,1 30938,0 30967,1 31014,0 31063,1 31120,0 31175,1 31185,0 31266,1 31327,0 31367,1 31463,0 31526,1 31589,0 31653,1 31719,0 31798,1 31837,0 31915,1 31918,0 31932,1 31968,0 32065,1 32086,0 32103,1 32112,0 32198,1 32255,0 32297,1 32364,0 32393,1 32411,0 32461,1 32532,0 32591,1 32605,0 32625,1 32654,0 32713,1 32745,0 32793,1 32817,0 32861,1 32887,0 32918,1 32922,0 33007,1 33090,0 33128,1 33206,0 33286,1 33307,0 33357,1 33407,0 33408,1 33439,0 33502,1 33512,0 33554,1 33647,0 33662,1 33726,0 33731,1 33755,0 33824,1 33873,0 33951,1 33975,0 33990,1 33998,0 34091,1 34188,0 34240,1 34261,0 34355,1 34455,0 34551,1 34572,0 34658,1 34670,0 34729,1 34824,0 34910,1 34911,0 34999,1 35007,0 35091,1 35128,0 35213,1 35312,0 35326,1 35394,0 35395,1 35493,0 35517,1 35604,0 35649,1 35678,0 35682,1 35757,0 35818,1 35825,0 35832,1 35887,0 35975,1 36022,0 36106,1 36175,0 36203,1 36291,0 36359,1 36448,0 36463,1 36554,0 36623,1 36701,0 36794,1 36841,0 36923,1 37009,0 37064,1 37114,0 37186,1 37195,0 37268,1 37276,0 37331,1 37350,0 37412,1 37434,0 37516,1 37526,0 37583,1 37651,0 37723,1 37820,0 37918,1 37990,0 38077,1 38102,0 38200,1 38254,0 38333,1 38393,0 38487,1 38526,0 38594,1 38670,0 38671,1 38742,0 38769,1 38838,0 38860,1 38934,0 38966,1 38975,0 39006,1 39097,0 39147,1 39203,0 39287,1 39368,0 39413,1 39464,0 39546,1 39618,0 39627,1 39718,0 39781,1 39831,0 39915,1 39917,0 40013,1 40091,0 40124,1 40132,0 40167,1 40260,0 40311,1 40343,0 40378,1 40465,0 40536,1 40570,0 40613,1 40671,0 40682,1 40717,0 40741,1 40768,0 40854,1 40927,0 41023,1 41123,0 41163,1 41194,0 41282,1 41301,0 41364,1 41454,0 41475,1 41477,0 41490,1 41588,0 41687,1 41733,0 41763,1 41813,0 41863,1 41943,0 41999,1 42058,0 42094,1 42138,0 42200,1 42289,0 42336,1 42436,0 42468,1 42540,0 42567,1 42569,0 42591,1 42677,0 42737,1 42758,0 42806,1 42892,0 42921,1 42948,0 43006,1 43045,0 43088,1 43111,0 43197,1 43254,0 43288,1 43310,0 43329,1 43389,0 43452,1 43495,0 43559,1 43635,0 43684,1 43687,0 43731,1 43767,0 43850,1 43857,0 43869,1 43932,0 43976,1 44073,0 44111,1 44113,0 44127,1 44135,0 44204,1 44249,0 44318,1 44320,0 44411,1 44461,0 44483,1 44552,0 44573,1 44646,0 44728,1 44808,0 44877,1 44942,0 44983,1 45040,0 45089,1 45161,0 45184,1 45201,0 45207,1 45296,0 45312,1 45390,0 45394,1 45475,0 45565,1 45639,0 45729,1 45798,0 45872,1 45905,0 45912,1 45991,0 46021,1 46048,0 46054,1 46134,0 46165,1 46227,0 46272,1 46328,0 46413,1 46476,0 46556,1 46617,0 46649,1 46744,0 46806,1 46854,0 46913,1 46953,0 47004,1 47038,0 47049,1 47097,0 47119,1 47124,0 47198,1 47223,0 47269,1 47345,0 47440,1 47464,0 47471,1 47519,0 47533,1 47546,0 47565,1 47642,0 47734,1 47811,0 47820,1 47836,0 47932,1 47963,0 48061,1 48158,0 48256,1 48330,0 48419,1 48505,0 48583,1 48627,0 48651,1 48716,0 48764,1 48793,0 48804,1 48827,0 48905,1 48932,0 48973,1 49011,0 49034,1 49061,0 49068,1 49073,0 49137,1 49219,0 49226,1 49249,0 49263,1 49317,0 49398,1 49408,0 49428,1 49466,0 49541,1 49636,0 49702,1 49746,0 49797,1 49894,0 49930,1 49997,0 50042,1 50101,0 50139,1 50140,0 50156,1 50196,0 50229,1 50283,0 50291,1 50340,0 50351,1 50381,0 50414,1 50416,0 50427,1 50435,0 50492,1 50545,0 50582,1 50661,0 50701,1 50710,0 50716,1 50801,0 50835,1 50858,0 50911,1 50968,0 51037,1 51039,0 51097,1 51162,0 51179,1 end initlist b15 0,0 33,1 105,0 108,1 192,0 207,1 287,0 376,1 407,0 414,1 438,0 538,1 550,0 601,1 647,0 729,1 814,0 882,1 935,0 1034,1 1092,0 1121,1 1157,0 1170,1 1244,0 1254,1 1283,0 1371,1 1440,0 1523,1 1542,0 1546,1 1576,0 1620,1 1680,0 1758,1 1821,0 1916,1 1966,0 1969,1 2043,0 2054,1 2061,0 2145,1 2170,0 2258,1 2340,0 2388,1 2485,0 2504,1 2531,0 2535,1 2615,0 2695,1 2749,0 2823,1 2907,0 2923,1 2971,0 2999,1 3064,0 3132,1 3175,0 3221,1 3260,0 3320,1 3333,0 3344,1 3390,0 3479,1 3488,0 3524,1 3560,0 3595,1 3647,0 3669,1 3749,0 3836,1 3880,0 3930,1 3966,0 4064,1 4156,0 4199,1 4287,0 4363,1 4455,0 4487,1 4585,0 4622,1 4628,0 4656,1 4728,0 4823,1 4879,0 4960,1 5004,0 5083,1 5088,0 5116,1 5118,0 5154,1 5183,0 5211,1 5281,0 5343,1 5352,0 5374,1 5402,0 5487,1 5536,0 5596,1 5662,0 5744,1 5804,0 5813,1 5882,0 5947,1 5996,0 6044,1 6094,0 6171,1 6251,0 6270,1 6366,0 6371,1 6416,0 6467,1 6503,0 6529,1 6619,0 6704,1 6761,0 6767,1 6797,0 6867,1 6906,0 6920,1 6933,0 6983,1 7078,0 7130,1 7143,0 7157,1 7200,0 7300,1 7388,0 7437,1 7498,0 7525,1 7582,0 7680,1 7761,0 7800,1 7893,0 7974,1 8033,0 8037,1 8116,0 8138,1 8193,0 8277,1 8368,0 8381,1 8440,0 8441,1 8475,0 8476,1 8512,0 8530,1 8582,0 8664,1 8724,0 8796,1 8840,0 8865,1 8880,0 8924,1 8992,0 9049,1 9058,0 9140,1 9233,0 9300,1 9344,0 9439,1 9493,0 9588,1 9687,0 9759,1 9797,0 9838,1 9845,0 9859,1 9903,0 9965,1 10057,0 10149,1 10154,0 10169,1 10200,0 10287,1 10325,0 10390,1 10429,0 10500,1 10565,0 10575,1 10599,0 10604,1 10678,0 10761,1 10855,0 10925,1 11019,0 11098,1 11151,0 11226,1 11254,0 11281,1 11291,0 11321,1 11418,0 11468,1 11561,0 11567,1 11588,0 11684,1 11763,0 11810,1 11905,0 11932,1 12025,0 12058,1 12095,0 12146,1 12180,0 12236,1 12265,0 12356,1 12380,0 12437,1 12468,0 12490,1 12569,0 12611,1 12623,0 12634,1 12676,0 12703,1 12782,0 12795,1 12838,0 12889,1 12909,0 12993,1 13091,0 13107,1 13202,0 13292,1 13323,0 13325,1 13394,0 13435,1 13473,0 13557,1 13651,0 13682,1 13754,0 13853,1 13907,0 13916,1 13920,0 13976,1 14017,0 14046,1 14061,0 14084,1 14148,0 14180,1 14236,0 14237,1 14279,0 14350,1 14411,0 14452,1 14467,0 14487,1 14584,0 14626,1 14724,0 14795,1 14879,0 14903,1 14953,0 15030,1 15071,0 15123,1 15136,0 15178,1 15189,0 15218,1 15271,0 15284,1 15320,0 15420,1 15447,0 15457,1 15536,0 15617,1 15647,0 15676,1 15734,0 15741,1 15815,0 15820,1 15874,0 15926,1 16016,0 16026,1 16041,0 16114,1 16127,0 16194,1 16279,0 16288,1 16316,0 16324,1 16409,0 16496,1 16533,0 16616,1 16663,0 16743,1 16833,0 16899,1 16910,0 17008,1 17054,0 17086,1 17150,0 17226,1 17277,0 17339,1 17413,0 17503,1 17531,0 17576,1 17673,0 17747,1 17826,0 17900,1 17999,0 18088,1 18150,0 18152,1 18215,0 18294,1 18394,0 18441,1 18513,0 18603,1 18686,0 18778,1 18852,0 18891,1 18913,0 18930,1 18946,0 19037,1 19042,0 19061,1 19158,0 19170,1 19230,0 19232,1 19274,0 19355,1 19363,0 19442,1 19521,0 19572,1 19632,0 19705,1 19767,0 19798,1 19825,0 19918,1 19964,0 19977,1 20053,0 20097,1 20164,0 20180,1 20255,0 20296,1 20348,0 20394,1 20470,0 20568,1 20660,0 20758,1 20810,0 20870,1 20891,0 20953,1 20976,0 21075,1 21078,0 21151,1 21196,0 21214,1 21282,0 21364,1 21413,0 21442,1 21462,0 21479,1 21540,0 21637,1 21713,0 21789,1 21790,0 21833,1 21845,0 21875,1 21908,0 21995,1 22025,0 22027,1 22032,0 22116,1 22148,0 22155,1 22232,0 22242,1 22336,0 22346,1 22364,0 22398,1 22401,0 22462,1 22522,0 22573,1 22632,0 22679,1 22765,0 22813,1 22821,0 22854,1 22902,0 22961,1 23016,0 23096,1 23150,0 23189,1 23250,0 23301,1 23363,0 23407,1 23476,0 23502,1 23580,0 23660,1 23725,0 23812,1 23890,0 23985,1 24045,0 24096,1 24103,0 24104,1 24134,0 24148,1 24190,0 24232,1 24270,0 24279,1 24370,0 24446,1 24543,0 24612,1 24648,0 24655,1 24749,0 24798,1 24865,0 24960,1 25053,0 25108,1 25199,0 25208,1 25239,0 25261,1 25320,0 25388,1 25457,0 25506,1 25549,0 25563,1 25590,0 25607,1 25673,0 25743,1 25803,0 25813,1 25824,0 25827,1 25871,0 25921,1 25943,0 25997,1 26072,0 26099,1 26126,0 26180,1 26279,0 26286,1 26298,0 26366,1 26416,0 26480,1 26497,0 26509,1 26570,0 26659,1 26667,0 26746,1 26832,0 26858,1 26949,0 26997,1 27026,0 27091,1 27185,0 27268,1 27315,0 27318,1 27324,0 27346,1 27395,0 27478,1 27574,0 27593,1 27633,0 27713,1 27753,0 27796,1 27850,0 27928,1 27940,0 28028,1 28071,0 28163,1 28166,0 28181,1 28213,0 28262,1 28340,0 28373,1 28428,0 28440,1 28478,0 28536,1 28623,0 28699,1 28781,0 28816,1 28830,0 28882,1 28931,0 28991,1 29012,0 29100,1 29111,0 29204,1 29257,0 29258,1 29285,0 29383,1 29422,0 29428,1 29444,0 29486,1 29572,0 29656,1 29725,0 29762,1 29852,0 29863,1 29900,0 29997,1 30043,0 30143,1 30155,0 30254,1 30307,0 30334,1 30403,0 30479,1 30568,0 30647,1 30685,0 30691,1 30710,0 30748,1 30779,0 30806,1 30811,0 30844,1 30918,0 30940,1 30989,0 31075,1 31082,0 31105,1 31109,0 31206,1 31251,0 31283,1 31342,0 31399,1 31473,0 31488,1 31511,0 31608,1 31609,0 31625,1 31689,0 31769,1 31817,0 31823,1 31871,0 31971,1 31984,0 32082,1 32151,0 32192,1 32275,0 32299,1 32340,0 32387,1 32419,0 32519,1 32570,0 32589,1 32655,0 32730,1 32793,0 32882,1 32904,0 32991,1 33040,0 33105,1 33146,0 33197,1 33290,0 33322,1 33370,0 33431,1 33494,0 33522,1 33588,0 33685,1 33779,0 33851,1 33905,0 33910,1 33973,0 34039,1 34041,0 34061,1 34159,0 34184,1 34241,0 34284,1 34317,0 34386,1 34454,0 34459,1 34533,0 34582,1 34633,0 34714,1 34729,0 34775,1 34849,0 34860,1 34955,0 34993,1 35066,0 35153,1 35194,0 35258,1 35326,0 35423,1 35473,0 35491,1 35542,0 35616,1 35661,0 35662,1 35756,0 35809,1 35816,0 35859,1 35929,0 35974,1 35975,0 36029,1 36074,0 36163,1 36186,0 36207,1 36258,0 36309,1 36339,0 36372,1 36427,0 36501,1 36575,0 36605,1 36659,0 36730,1 36776,0 36794,1 36839,0 36901,1 36988,0 37062,1 37068,0 37103,1 37132,0 37215,1 37267,0 37342,1 37442,0 37512,1 37528,0 37607,1 37667,0 37705,1 37771,0 37822,1 37897,0 37980,1 38047,0 38079,1 38082,0 38152,1 38199,0 38295,1 38385,0 38442,1 38463,0 38464,1 38471,0 38473,1 38485,0 38563,1 38626,0 38630,1 38639,0 38719,1 38807,0 38865,1 38946,0 39006,1 39090,0 39158,1 39224,0 39323,1 39368,0 39418,1 39511,0 39541,1 39634,0 39653,1 39675,0 39771,1 39781,0 39836,1 39907,0 39944,1 39956,0 40007,1 40025,0 40030,1 40059,0 40088,1 40187,0 40195,1 40293,0 40332,1 40370,0 40457,1 40535,0 40562,1 40644,0 40701,1 40722,0 40741,1 40838,0 40935,1 40976,0 40981,1 41040,0 41064,1 41111,0 41148,1 41183,0 41254,1 41330,0 41422,1 41480,0 41533,1 41587,0 41631,1 41710,0 41750,1 41751,0 41794,1 41871,0 41891,1 41950,0 42043,1 42086,0 42113,1 42162,0 42170,1 42215,0 42251,1 42329,0 42366,1 42390,0 42436,1 42483,0 42545,1 42552,0 42572,1 42604,0 42693,1 42723,0 42777,1 42840,0 42927,1 42972,0 42978,1 43072,0 43164,1 43230,0 43248,1 43327,0 43344,1 43427,0 43480,1 43570,0 43666,1 43718,0 43734,1 43804,0 43890,1 43985,0 44062,1 44139,0 44154,1 44164,0 44173,1 44203,0 44276,1 44336,0 44434,1 44499,0 44531,1 44630,0 44634,1 44648,0 44707,1 44748,0 44795,1 44819,0 44879,1 44903,0 45000,1 45077,0 45143,1 45232,0 45288,1 45325,0 45422,1 45477,0 45524,1 45576,0 45663,1 45720,0 45776,1 45790,0 45851,1 45877,0 45919,1 45946,0 46019,1 46077,0 46106,1 46119,0 46212,1 46284,0 46320,1 46419,0 46513,1 46552,0 46566,1 46664,0 46677,1 46776,0 46784,1 46818,0 46847,1 46915,0 46983,1 47011,0 47111,1 47127,0 47191,1 47278,0 47313,1 47379,0 47452,1 47541,0 47601,1 47692,0 47734,1 47767,0 47833,1 47848,0 47885,1 47966,0 48038,1 48071,0 48153,1 48175,0 48185,1 48187,0 48191,1 48197,0 48268,1 48340,0 48388,1 48482,0 48545,1 48554,0 48628,1 48676,0 48733,1 48791,0 48816,1 48891,0 48923,1 49017,0 49092,1 49186,0 49218,1 49278,0 49282,1 49319,0 49356,1 49402,0 49471,1 49505,0 49563,1 49604,0 49671,1 49698,0 49766,1 49851,0 49912,1 49949,0 50022,1 50075,0 50080,1 50135,0 50138,1 50157,0 50247,1 50308,0 50408,1 50491,0 50590,1 50667,0 50685,1 50721,0 50742,1 50757,0 50771,1 50866,0 50894,1 50939,0 51018,1 51037,0 51048,1 51139,0 51210,1 end initlist b16 0,0 1,1 46,0 107,1 206,0 250,1 281,0 366,1 465,0 562,1 619,0 653,1 695,0 777,1 814,0 855,1 884,0 943,1 999,0 1051,1 1115,0 1209,1 1255,0 1348,1 1385,0 1462,1 1479,0 1532,1 1567,0 1637,1 1661,0 1702,1 1723,0 1763,1 1812,0 1855,1 1921,0 1993,1 2035,0 2065,1 2066,0 2144,1 2235,0 2238,1 2315,0 2316,1 2357,0 2392,1 2428,0 2472,1 2559,0 2580,1 2617,0 2651,1 2713,0 2812,1 2837,0 2846,1 2881,0 2887,1 2940,0 2989,1 3016,0 3047,1 3049,0 3083,1 3085,0 3175,1 3226,0 3247,1 3296,0 3358,1 3359,0 3441,1 3446,0 3487,1 3551,0 3651,1 3671,0 3712,1 3804,0 3880,1 3902,0 3912,1 4011,0 4049,1 4111,0 4180,1 4273,0 4334,1 4398,0 4401,1 4467,0 4494,1 4585,0 4670,1 4760,0 4791,1 4837,0 4880,1 4957,0 5016,1 5114,0 5209,1 5296,0 5352,1 5384,0 5432,1 5476,0 5485,1 5577,0 5604,1 5663,0 5664,1 5743,0 5773,1 5852,0 5873,1 5934,0 5982,1 6050,0 6145,1 6150,0 6242,1 6316,0 6343,1 6433,0 6522,1 6603,0 6641,1 6668,0 6719,1 6762,0 6772,1 6833,0 6839,1 6919,0 7005,1 7045,0 7134,1 7225,0 7324,1 7403,0 7450,1 7528,0 7598,1 7600,0 7625,1 7705,0 7763,1 7795,0 7797,1 7803,0 7844,1 7934,0 7945,1 8004,0 8036,1 8093,0 8098,1 8132,0 8230,1 8329,0 8390,1 8401,0 8420,1 8510,0 8584,1 8684,0 8708,1 8760,0 8852,1 8863,0 8882,1 8914,0 8926,1 8999,0 9067,1 9104,0 9168,1 9228,0 9290,1 9380,0 9414,1 9442,0 9495,1 9526,0 9544,1 9643,0 9645,1 9738,0 9793,1 9852,0 9878,1 9963,0 10024,1 10123,0 10139,1 10178,0 10220,1 10226,0 10269,1 10322,0 10395,1 10470,0 10539,1 10581,0 10635,1 10668,0 10681,1 10780,0 10781,1 10822,0 10895,1 10964,0 11029,1 11088,0 11099,1 11182,0 11250,1 11262,0 11334,1 11428,0 11459,1 11557,0 11602,1 11660,0 11691,1 11710,0 11807,1 11810,0 11886,1 11915,0 11958,1 11971,0 11995,1 12095,0 12168,1 12249,0 12292,1 12304,0 12398,1 12469,0 12542,1 12642,0 12657,1 12694,0 12718,1 12808,0 12818,1 12865,0 12942,1 12946,0 13009,1 13029,0 13111,1 13169,0 13241,1 13321,0 13364,1 13392,0 13490,1 13525,0 13581,1 13659,0 13744,1 13830,0 13852,1 13914,0 13915,1 13940,0 13941,1 14041,0 14112,1 14210,0 14288,1 14374,0 14415,1 14430,0 14435,1 14460,0 14548,1 14630,0 14663,1 14713,0 14786,1 14869,0 14884,1 14924,0 14935,1 14986,0 15062,1 15090,0 15190,1 15258,0 15309,1 15360,0 15437,1 15477,0 15479,1 15542,0 15620,1 15632,0 15698,1 15726,0 15740,1 15750,0 15822,1 15839,0 15897,1 15930,0 15957,1 16027,0 16068,1 16126,0 16225,1 16289,0 16364,1 16449,0 16531,1 16545,0 16637,1 16667,0 16742,1 16812,0 16829,1 16851,0 16883,1 16885,0 16969,1 17023,0 17070,1 17091,0 17142,1 17217,0 17268,1 17293,0 17308,1 17351,0 17416,1 17419,0 17463,1 17545,0 17608,1 17706,0 17793,1 17808,0 17862,1 17881,0 17884,1 17947,0 18030,1 18126,0 18142,1 18204,0 18227,1 18238,0 18252,1 18267,0 18346,1 18371,0 18471,1 18523,0 18575,1 18600,0 18639,1 18651,0 18707,1 18724,0 18749,1 18841,0 18870,1 18920,0 18951,1 18963,0 19038,1 19096,0 19101,1 19176,0 19211,1 19259,0 19299,1 19392,0 19436,1 19497,0 19548,1 19615,0 19679,1 19757,0 19772,1 19829,0 19837,1 19929,0 19958,1 20058,0 20157,1 20160,0 20196,1 20230,0 20311,1 20400,0 20466,1 20515,0 20611,1 20704,0 20800,1 20822,0 20834,1 20892,0 20918,1 20968,0 20982,1 21076,0 21169,1 21170,0 21191,1 21262,0 21291,1 21341,0 21376,1 21453,0 21492,1 21542,0 21642,1 21647,0 21685,1 21720,0 21820,1 21879,0 21889,1 21941,0 22020,1 22084,0 22165,1 22251,0 22338,1 22344,0 22350,1 22444,0 22467,1 22561,0 22569,1 22667,0 22737,1 22783,0 22861,1 22885,0 22961,1 22990,0 23085,1 23146,0 23195,1 23214,0 23232,1 23301,0 23359,1 23363,0 23381,1 23452,0 23517,1 23540,0 23585,1 23618,0 23634,1 23704,0 23751,1 23775,0 23788,1 23826,0 23902,1 23926,0 23949,1 24004,0 24055,1 24142,0 24147,1 24166,0 24250,1 24341,0 24417,1 24467,0 24526,1 24608,0 24690,1 24774,0 24829,1 24882,0 24935,1 25022,0 25040,1 25065,0 25089,1 25160,0 25237,1 25337,0 25414,1 25424,0 25447,1 25481,0 25492,1 25525,0 25606,1 25698,0 25777,1 25844,0 25944,1 25946,0 25999,1 26019,0 26065,1 26109,0 26179,1 26248,0 26250,1 26317,0 26340,1 26343,0 26400,1 26472,0 26476,1 26566,0 26649,1 26672,0 26755,1 26816,0 26901,1 26907,0 26976,1 26998,0 27074,1 27107,0 27174,1 27250,0 27333,1 27365,0 27417,1 27438,0 27530,1 27589,0 27614,1 27680,0 27683,1 27762,0 27848,1 27890,0 27968,1 28065,0 28086,1 28169,0 28178,1 28185,0 28233,1 28308,0 28370,1 28397,0 28429,1 28456,0 28518,1 28562,0 28640,1 28688,0 28715,1 28731,0 28784,1 28800,0 28804,1 28846,0 28898,1 28934,0 29020,1 29085,0 29144,1 29222,0 29287,1 29325,0 29425,1 29434,0 29505,1 29507,0 29595,1 29635,0 29659,1 29663,0 29708,1 29785,0 29819,1 29864,0 29947,1 29948,0 29995,1 30029,0 30048,1 30133,0 30212,1 30285,0 30343,1 30362,0 30384,1 30473,0 30529,1 30535,0 30574,1 30648,0 30747,1 30775,0 30833,1 30841,0 30878,1 30916,0 30974,1 31065,0 31080,1 31163,0 31195,1 31240,0 31305,1 31374,0 31462,1 31516,0 31583,1 31674,0 31721,1 31770,0 31807,1 31856,0 31932,1 31980,0 32026,1 32124,0 32137,1 32197,0 32228,1 32310,0 32376,1 32386,0 32462,1 32536,0 32622,1 32696,0 32732,1 32760,0 32779,1 32824,0 32852,1 32861,0 32907,1 32996,0 33015,1 33087,0 33119,1 33133,0 33186,1 33268,0 33367,1 33379,0 33389,1 33407,0 33432,1 33513,0 33600,1 33679,0 33687,1 33694,0 33725,1 33765,0 33809,1 33876,0 33904,1 33933,0 33998,1 34086,0 34130,1 34134,0 34182,1 34211,0 34279,1 34319,0 34391,1 34421,0 34492,1 34581,0 34630,1 34722,0 34757,1 34854,0 34890,1 34925,0 35020,1 35118,0 35181,1 35275,0 35303,1 35333,0 35341,1 35371,0 35459,1 35539,0 35540,1 35620,0 35633,1 35666,0 35742,1 35826,0 35912,1 35971,0 35991,1 36049,0 36057,1 36129,0 36216,1 36244,0 36329,1 36420,0 36505,1 36578,0 36610,1 36690,0 36788,1 36823,0 36898,1 36953,0 37040,1 37101,0 37139,1 37174,0 37176,1 37240,0 37321,1 37337,0 37388,1 37472,0 37534,1 37592,0 37684,1 37687,0 37740,1 37835,0 37894,1 37978,0 38067,1 38142,0 38206,1 38260,0 38327,1 38341,0 38430,1 38520,0 38580,1 38621,0 38652,1 38733,0 38795,1 38869,0 38886,1 38902,0 38985,1 39023,0 39071,1 39073,0 39077,1 39172,0 39179,1 39209,0 39242,1 39246,0 39269,1 39347,0 39414,1 39427,0 39483,1 39522,0 39524,1 39619,0 39692,1 39703,0 39734,1 39750,0 39822,1 39852,0 39873,1 39891,0 39932,1 39954,0 40039,1 40129,0 40162,1 40210,0 40295,1 40309,0 40373,1 40392,0 40394,1 40398,0 40445,1 40541,0 40636,1 40674,0 40708,1 40731,0 40803,1 40896,0 40985,1 41081,0 41161,1 41173,0 41189,1 41253,0 41314,1 41361,0 41392,1 41464,0 41523,1 41526,0 41561,1 41614,0 41651,1 41690,0 41735,1 41772,0 41780,1 41806,0 41874,1 41906,0 41925,1 41935,0 41998,1 42051,0 42068,1 42097,0 42177,1 42255,0 42350,1 42383,0 42481,1 42573,0 42616,1 42618,0 42665,1 42718,0 42724,1 42796,0 42881,1 42970,0 43001,1 43092,0 43113,1 43165,0 43184,1 43267,0 43301,1 43378,0 43402,1 43502,0 43542,1 43603,0 43703,1 43789,0 43832,1 43860,0 43949,1 43960,0 43973,1 44033,0 44064,1 44136,0 44196,1 44256,0 44305,1 44352,0 44375,1 44387,0 44447,1 44458,0 44538,1 44622,0 44672,1 44759,0 44842,1 44902,0 44936,1 44995,0 45013,1 45048,0 45060,1 45153,0 45180,1 45214,0 45227,1 45299,0 45357,1 45378,0 45423,1 45473,0 45489,1 45565,0 45569,1 45641,0 45656,1 45687,0 45785,1 45842,0 45882,1 45945,0 46026,1 46060,0 46063,1 46162,0 46206,1 46236,0 46263,1 46296,0 46366,1 46462,0 46467,1 46566,0 46597,1 46667,0 46735,1 46812,0 46841,1 46858,0 46930,1 46949,0 46970,1 47017,0 47115,1 47151,0 47204,1 47291,0 47385,1 47424,0 47470,1 47507,0 47510,1 47542,0 47635,1 47701,0 47765,1 47816,0 47895,1 47985,0 48082,1 48115,0 48166,1 48220,0 48280,1 48343,0 48375,1 48457,0 48530,1 48594,0 48602,1 48666,0 48719,1 48779,0 48788,1 48818,0 48830,1 48854,0 48942,1 49032,0 49034,1 49035,0 49103,1 49167,0 49242,1 49269,0 49299,1 49355,0 49446,1 49483,0 49488,1 49563,0 49621,1 49715,0 49779,1 49825,0 49889,1 49893,0 49934,1 49986,0 49995,1 50041,0 50098,1 50109,0 50128,1 50132,0 50187,1 50275,0 50328,1 50410,0 50479,1 50566,0 50666,1 50765,0 50795,1 50809,0 50875,1 50915,0 50973,1 51022,0 51111,1 end initlist b17 0,0 73,1 143,0 144,1 207,0 233,1 287,0 350,1 431,0 522,1 602,0 656,1 702,0 732,1 821,0 830,1 902,0 947,1 992,0 994,1 1057,0 1096,1 1164,0 1249,1 1288,0 1318,1 1333,0 1428,1 1524,0 1546,1 1588,0 1614,1 1631,0 1634,1 1675,0 1764,1 1830,0 1928,1 1936,0 2029,1 2051,0 2134,1 2192,0 2203,1 2211,0 2269,1 2322,0 2373,1 2449,0 2477,1 2516,0 2522,1 2537,0 2598,1 2639,0 2695,1 2792,0 2863,1 2916,0 2946,1 2947,0 3010,1 3101,0 3144,1 3167,0 3202,1 3212,0 3226,1 3264,0 3313,1 3401,0 3444,1 3465,0 3536,1 3543,0 3623,1 3712,0 3731,1 3795,0 3882,1 3900,0 3920,1 4015,0 4064,1 4082,0 4125,1 4212,0 4256,1 4325,0 4425,1 4435,0 4482,1 4495,0 4554,1 4602,0 4646,1 4647,0 4700,1 4799,0 4882,1 4902,0 4990,1 5058,0 5103,1 5197,0 5199,1 5282,0 5340,1 5411,0 5473,1 5479,0 5508,1 5525,0 5598,1 5629,0 5721,1 5807,0 5824,1 5844,0 5920,1 5974,0 6012,1 6087,0 6106,1 6191,0 6275,1 6334,0 6402,1 6408,0 6460,1 6508,0 6581,1 6660,0 6679,1 6693,0 6778,1 6804,0 6842,1 6847,0 6915,1 7015,0 7071,1 7107,0 7195,1 7208,0 7254,1 7344,0 7443,1 7482,0 7500,1 7525,0 7542,1 7546,0 7594,1 7605,0 7619,1 7703,0 7743,1 7827,0 7857,1 7945,0 7996,1 8007,0 8087,1 8089,0 8140,1 8207,0 8299,1 8333,0 8345,1 8418,0 8500,1 8578,0 8610,1 8668,0 8768,1 8770,0 8791,1 8830,0 8898,1 8959,0 9005,1 9032,0 9050,1 9110,0 9159,1 9161,0 9250,1 9280,0 9303,1 9392,0 9492,1 9577,0 9607,1 9632,0 9676,1 9771,0 9811,1 9882,0 9948,1 10001,0 10018,1 10036,0 10043,1 10143,0 10230,1 10235,0 10318,1 10379,0 10451,1 10514,0 10567,1 10656,0 10753,1 10797,0 10817,1 10875,0 10967,1 11031,0 11127,1 11140,0 11193,1 11269,0 11320,1 11361,0 11404,1 11495,0 11581,1 11600,0 11610,1 11615,0 11678,1 11681,0 11761,1 11786,0 11800,1 11813,0 11876,1 11953,0 12030,1 12034,0 12070,1 12071,0 12098,1 12169,0 12263,1 12319,0 12370,1 12389,0 12441,1 12491,0 12528,1 12569,0 12605,1 12609,0 12620,1 12692,0 12749,1 12777,0 12783,1 12812,0 12820,1 12879,0 12894,1 12979,0 13056,1 13149,0 13188,1 13212,0 13299,1 13398,0 13423,1 13465,0 13496,1 13576,0 13611,1 13651,0 13722,1 13776,0 13842,1 13845,0 13922,1 13946,0 13970,1 14046,0 14125,1 14167,0 14245,1 14310,0 14373,1 14417,0 14423,1 14474,0 14514,1 14527,0 14537,1 14585,0 14625,1 14701,0 14710,1 14732,0 14824,1 14861,0 14894,1 14958,0 15033,1 15112,0 15203,1 15267,0 15345,1 15351,0 15441,1 15504,0 15562,1 15591,0 15683,1 15687,0 15728,1 15731,0 15772,1 15799,0 15817,1 15886,0 15956,1 16018,0 16056,1 16113,0 16121,1 16210,0 16302,1 16348,0 16406,1 16455,0 16545,1 16567,0 16636,1 16662,0 16721,1 16723,0 16788,1 16798,0 16822,1 16828,0 16836,1 16884,0 16937,1 16949,0 16964,1 17041,0 17076,1 17105,0 17169,1 17224,0 17283,1 17295,0 17365,1 17377,0 17387,1 17410,0 17424,1 17447,0 17525,1 17568,0 17623,1 17717,0 17756,1 17797,0 17841,1 17907,0 17923,1 18003,0 18008,1 18101,0 18140,1 18175,0 18225,1 18230,0 18260,1 18320,0 18398,1 18403,0 18471,1 18519,0 18601,1 18670,0 18708,1 18794,0 18819,1 18860,0 18880,1 18932,0 19022,1 19110,0 19145,1 19199,0 19229,1 19260,0 19307,1 19340,0 19366,1 19380,0 19424,1 19496,0 19557,1 19580,0 19673,1 19683,0 19706,1 19751,0 19822,1 19906,0 19954,1 19972,0 20006,1 20080,0 20129,1 20191,0 20235,1 20275,0 20365,1 20410,0 20460,1 20531,0 20552,1 20571,0 20609,1 20681,0 20689,1 20762,0 20843,1 20898,0 20943,1 20984,0 21009,1 21015,0 21058,1 21105,0 21116,1 21158,0 21201,1 21298,0 21387,1 21399,0 21405,1 21471,0 21507,1 21600,0 21604,1 21614,0 21654,1 21729,0 21732,1 21767,0 21863,1 21870,0 21891,1 21949,0 22049,1 22130,0 22171,1 22251,0 22259,1 22307,0 22336,1 22435,0 22533,1 22551,0 22617,1 22711,0 22768,1 22847,0 22858,1 22880,0 22888,1 22923,0 22994,1 22997,0 23073,1 23155,0 23246,1 23344,0 23422,1 23484,0 23529,1 23570,0 23612,1 23627,0 23724,1 23754,0 23801,1 23828,0 23879,1 23962,0 24005,1 24080,0 24102,1 24198,0 24230,1 24254,0 24303,1 24402,0 24419,1 24487,0 24575,1 24605,0 24660,1 24723,0 24813,1 24818,0 24874,1 24896,0 24989,1 25001,0 25043,1 25084,0 25160,1 25174,0 25241,1 25283,0 25328,1 25386,0 25426,1 25441,0 25509,1 25563,0 25593,1 25658,0 25698,1 25761,0 25809,1 25904,0 25996,1 26039,0 26081,1 26173,0 26193,1 26232,0 26250,1 26277,0 26300,1 26366,0 26427,1 26464,0 26484,1 26532,0 26597,1 26621,0 26701,1 26775,0 26811,1 26903,0 26915,1 26956,0 27033,1 27123,0 27204,1 27298,0 27319,1 27336,0 27351,1 27415,0 27459,1 27525,0 27625,1 27697,0 27793,1 27824,0 27877,1 27928,0 27939,1 28032,0 28119,1 28151,0 28202,1 28230,0 28247,1 28322,0 28390,1 28469,0 28545,1 28597,0 28615,1 28663,0 28749,1 28823,0 28862,1 28905,0 28984,1 29060,0 29066,1 29086,0 29152,1 29240,0 29304,1 29346,0 29347,1 29372,0 29433,1 29527,0 29530,1 29595,0 29601,1 29633,0 29728,1 29747,0 29773,1 29809,0 29826,1 29851,0 29933,1 29954,0 30000,1 30075,0 30166,1 30249,0 30299,1 30334,0 30355,1 30454,0 30468,1 30566,0 30589,1 30619,0 30680,1 30766,0 30844,1 30893,0 30986,1 31031,0 31079,1 31159,0 31175,1 31180,0 31262,1 31351,0 31414,1 31472,0 31484,1 31584,0 31605,1 31645,0 31733,1 31809,0 31842,1 31899,0 31974,1 31999,0 32066,1 32165,0 32167,1 32206,0 32255,1 32341,0 32368,1 32429,0 32441,1 32538,0 32638,1 32706,0 32708,1 32805,0 32874,1 32881,0 32967,1 33056,0 33081,1 33096,0 33098,1 33128,0 33138,1 33183,0 33204,1 33241,0 33277,1 33340,0 33389,1 33410,0 33455,1 33475,0 33511,1 33548,0 33549,1 33646,0 33670,1 33689,0 33731,1 33767,0 33819,1 33829,0 33847,1 33871,0 33928,1 34001,0 34009,1 34081,0 34138,1 34145,0 34200,1 34292,0 34375,1 34408,0 34480,1 34533,0 34578,1 34609,0 34695,1 34734,0 34785,1 34814,0 34897,1 34938,0 34998,1 35028,0 35103,1 35193,0 35206,1 35208,0 35270,1 35319,0 35372,1 35392,0 35459,1 35517,0 35595,1 35694,0 35749,1 35825,0 35905,1 35953,0 35957,1 35987,0 36076,1 36102,0 36142,1 36226,0 36282,1 36365,0 36399,1 36467,0 36503,1 36553,0 36556,1 36559,0 36561,1 36633,0 36732,1 36756,0 36856,1 36904,0 36951,1 37045,0 37067,1 37087,0 37090,1 37137,0 37227,1 37260,0 37303,1 37384,0 37454,1 37484,0 37497,1 37549,0 37580,1 37595,0 37602,1 37669,0 37731,1 37736,0 37783,1 37833,0 37930,1 37962,0 37974,1 37991,0 38040,1 38131,0 38220,1 38257,0 38293,1 38316,0 38378,1 38468,0 38503,1 38588,0 38618,1 38631,0 38666,1 38732,0 38778,1 38814,0 38913,1 38995,0 39087,1 39135,0 39195,1 39211,0 39258,1 39294,0 39382,1 39462,0 39553,1 39630,0 39730,1 39738,0 39791,1 39845,0 39907,1 39959,0 39969,1 39983,0 40012,1 40106,0 40113,1 40204,0 40260,1 40351,0 40379,1 40456,0 40479,1 40482,0 40557,1 40584,0 40586,1 40614,0 40707,1 40730,0 40771,1 40824,0 40887,1 40945,0 40995,1 41041,0 41112,1 41157,0 41179,1 41186,0 41266,1 41311,0 41344,1 41429,0 41453,1 41495,0 41502,1 41545,0 41642,1 41724,0 41817,1 41848,0 41876,1 41882,0 41958,1 42022,0 42066,1 42070,0 42086,1 42106,0 42145,1 42151,0 42177,1 42220,0 42224,1 42303,0 42305,1 42306,0 42361,1 42456,0 42466,1 42475,0 42486,1 42576,0 42603,1 42694,0 42719,1 42752,0 42762,1 42837,0 42868,1 42925,0 42954,1 43016,0 43103,1 43203,0 43212,1 43265,0 43294,1 43323,0 43345,1 43424,0 43502,1 43570,0 43645,1 43649,0 43653,1 43731,0 43812,1 43876,0 43893,1 43908,0 43911,1 44004,0 44019,1 44033,0 44074,1 44145,0 44153,1 44240,0 44306,1 44307,0 44317,1 44411,0 44415,1 44465,0 44485,1 44556,0 44560,1 44611,0 44702,1 44801,0 44839,1 44920,0 45010,1 45093,0 45185,1 45246,0 45334,1 45376,0 45389,1 45444,0 45504,1 45563,0 45633,1 45666,0 45750,1 45769,0 45802,1 45842,0 45876,1 45907,0 45993,1 46009,0 46052,1 46053,0 46118,1 46163,0 46187,1 46259,0 46289,1 46363,0 46368,1 46458,0 46461,1 46511,0 46520,1 46526,0 46531,1 46602,0 46695,1 46729,0 46768,1 46805,0 46869,1 46907,0 46921,1 47009,0 47037,1 47120,0 47199,1 47258,0 47286,1 47375,0 47422,1 47469,0 47471,1 47539,0 47601,1 47654,0 47712,1 47720,0 47765,1 47826,0 47871,1 47952,0 47962,1 47966,0 47977,1 48077,0 48130,1 48168,0 48236,1 48331,0 48419,1 48497,0 48502,1 48528,0 48625,1 48666,0 48730,1 48797,0 48896,1 48946,0 49007,1 end initlist b18 0,0 30,1 130,0 222,1 292,0 373,1 397,0 443,1 464,0 561,1 604,0 626,1 702,0 798,1 838,0 933,1 948,0 1017,1 1047,0 1112,1 1197,0 1229,1 1294,0 1361,1 1366,0 1397,1 1417,0 1443,1 1464,0 1522,1 1525,0 1561,1 1640,0 1688,1 1741,0 1780,1 1814,0 1861,1 1932,0 1991,1 2073,0 2094,1 2190,0 2207,1 2307,0 2330,1 2368,0 2379,1 2420,0 2466,1 2490,0 2569,1 2590,0 2639,1 2643,0 2701,1 2755,0 2845,1 2876,0 2890,1 2933,0 2958,1 2971,0 3030,1 3044,0 3068,1 3155,0 3230,1 3298,0 3385,1 3397,0 3422,1 3428,0 3448,1 3481,0 3575,1 3588,0 3640,1 3730,0 3801,1 3885,0 3975,1 3995,0 4094,1 4156,0 4206,1 4226,0 4290,1 4347,0 4374,1 4465,0 4545,1 4556,0 4566,1 4575,0 4594,1 4625,0 4637,1 4686,0 4750,1 4816,0 4842,1 4915,0 4924,1 4963,0 5040,1 5048,0 5112,1 5127,0 5225,1 5270,0 5350,1 5409,0 5438,1 5534,0 5614,1 5683,0 5779,1 5809,0 5887,1 5949,0 5976,1 6039,0 6064,1 6119,0 6145,1 6185,0 6187,1 6257,0 6272,1 6348,0 6374,1 6437,0 6498,1 6516,0 6585,1 6670,0 6720,1 6731,0 6757,1 6786,0 6819,1 6854,0 6934,1 6977,0 6996,1 7076,0 7171,1 7247,0 7279,1 7359,0 7412,1 7416,0 7498,1 7553,0 7646,1 7737,0 7743,1 7804,0 7828,1 7847,0 7923,1 8012,0 8092,1 8100,0 8128,1 8223,0 8235,1 8270,0 8360,1 8435,0 8467,1 8543,0 8547,1 8591,0 8647,1 8741,0 8791,1 8800,0 8900,1 8941,0 9005,1 9035,0 9128,1 9161,0 9215,1 9309,0 9336,1 9380,0 9420,1 9468,0 9523,1 9601,0 9669,1 9698,0 9792,1 9813,0 9848,1 9922,0 10017,1 10019,0 10028,1 10043,0 10055,1 10109,0 10176,1 10246,0 10287,1 10360,0 10419,1 10458,0 10486,1 10517,0 10528,1 10582,0 10596,1 10658,0 10659,1 10715,0 10746,1 10748,0 10822,1 10849,0 10921,1 10984,0 11081,1 11140,0 11229,1 11234,0 11242,1 11263,0 11266,1 11365,0 11399,1 11466,0 11487,1 11567,0 11667,1 11707,0 11787,1 11825,0 11829,1 11890,0 11959,1 12022,0 12023,1 12115,0 12134,1 12228,0 12254,1 12270,0 12340,1 12391,0 12490,1 12567,0 12656,1 12747,0 12841,1 12842,0 12898,1 12942,0 13035,1 13079,0 13159,1 13181,0 13186,1 13245,0 13304,1 13336,0 13373,1 13390,0 13473,1 13517,0 13548,1 13617,0 13704,1 13782,0 13834,1 13855,0 13890,1 13959,0 14051,1 14109,0 14176,1 14217,0 14307,1 14365,0 14374,1 14386,0 14426,1 14476,0 14506,1 14552,0 14631,1 14725,0 14762,1 14846,0 14919,1 15000,0 15010,1 15060,0 15137,1 15196,0 15241,1 15247,0 15255,1 15288,0 15297,1 15369,0 15453,1 15534,0 15597,1 15693,0 15745,1 15759,0 15806,1 15842,0 15890,1 15902,0 15963,1 15984,0 16041,1 16060,0 16130,1 16216,0 16282,1 16313,0 16325,1 16368,0 16395,1 16483,0 16537,1 16582,0 16597,1 16666,0 16724,1 16803,0 16861,1 16884,0 16947,1 16996,0 17022,1 17029,0 17128,1 17226,0 17273,1 17329,0 17407,1 17498,0 17585,1 17664,0 17721,1 17733,0 17781,1 17837,0 17937,1 18027,0 18092,1 18130,0 18136,1 18225,0 18251,1 18258,0 18353,1 18416,0 18466,1 18565,0 18643,1 18743,0 18791,1 18832,0 18918,1 18968,0 19018,1 19044,0 19107,1 19151,0 19180,1 19186,0 19240,1 19257,0 19275,1 19371,0 19399,1 19418,0 19419,1 19517,0 19575,1 19580,0 19620,1 19635,0 19705,1 19729,0 19796,1 19864,0 19930,1 19989,0 20003,1 20050,0 20142,1 20182,0 20265,1 20267,0 20336,1 20433,0 20436,1 20502,0 20596,1 20694,0 20735,1 20758,0 20837,1 20908,0 20998,1 21007,0 21097,1 21193,0 21228,1 21323,0 21422,1 21452,0 21529,1 21534,0 21610,1 21709,0 21756,1 21796,0 21845,1 21863,0 21940,1 21945,0 21989,1 22007,0 22062,1 22080,0 22168,1 22264,0 22322,1 22339,0 22401,1 22450,0 22469,1 22560,0 22649,1 22683,0 22705,1 22767,0 22849,1 22931,0 22945,1 23016,0 23030,1 23054,0 23055,1 23068,0 23093,1 23139,0 23209,1 23308,0 23376,1 23473,0 23544,1 23640,0 23690,1 23727,0 23728,1 23772,0 23841,1 23922,0 23996,1 24002,0 24044,1 24105,0 24170,1 24252,0 24330,1 24347,0 24431,1 24439,0 24472,1 24478,0 24484,1 24541,0 24641,1 24713,0 24728,1 24778,0 24831,1 24895,0 24934,1 25028,0 25034,1 25047,0 25145,1 25216,0 25296,1 25366,0 25373,1 25387,0 25413,1 25418,0 25487,1 25524,0 25529,1 25534,0 25566,1 25600,0 25664,1 25711,0 25795,1 25886,0 25895,1 25976,0 25982,1 26035,0 26074,1 26106,0 26202,1 26270,0 26337,1 26338,0 26342,1 26393,0 26477,1 26517,0 26566,1 26658,0 26686,1 26755,0 26783,1 26826,0 26875,1 26940,0 27037,1 27065,0 27132,1 27141,0 27219,1 27312,0 27366,1 27455,0 27548,1 27597,0 27681,1 27714,0 27716,1 27790,0 27833,1 27874,0 27971,1 28001,0 28078,1 28168,0 28255,1 28317,0 28389,1 28452,0 28460,1 28528,0 28575,1 28608,0 28663,1 28689,0 28747,1 28834,0 28889,1 28909,0 28970,1 29060,0 29103,1 29175,0 29225,1 29270,0 29353,1 29447,0 29532,1 29553,0 29567,1 29586,0 29680,1 29780,0 29803,1 29860,0 29921,1 30011,0 30072,1 30101,0 30164,1 30207,0 30277,1 30364,0 30438,1 30524,0 30612,1 30700,0 30704,1 30743,0 30812,1 30904,0 30973,1 30982,0 31067,1 31144,0 31203,1 31296,0 31393,1 31402,0 31471,1 31560,0 31625,1 31645,0 31701,1 31716,0 31723,1 31748,0 31778,1 31840,0 31857,1 31940,0 32006,1 32036,0 32080,1 32176,0 32192,1 32215,0 32285,1 32334,0 32377,1 32381,0 32414,1 32442,0 32509,1 32606,0 32644,1 32691,0 32732,1 32826,0 32857,1 32878,0 32956,1 32973,0 33009,1 33028,0 33113,1 33139,0 33189,1 33217,0 33238,1 33304,0 33377,1 33436,0 33514,1 33604,0 33672,1 33745,0 33776,1 33845,0 33864,1 33891,0 33942,1 34019,0 34037,1 34047,0 34088,1 34104,0 34145,1 34204,0 34257,1 34300,0 34363,1 34456,0 34469,1 34564,0 34604,1 34632,0 34633,1 34715,0 34792,1 34883,0 34968,1 35058,0 35139,1 35187,0 35257,1 35343,0 35350,1 35407,0 35474,1 35569,0 35591,1 35650,0 35667,1 35699,0 35724,1 35778,0 35782,1 35865,0 35940,1 35997,0 36044,1 36141,0 36211,1 36304,0 36398,1 36399,0 36488,1 36498,0 36569,1 36577,0 36625,1 36685,0 36701,1 36791,0 36858,1 36859,0 36907,1 36971,0 37041,1 37107,0 37109,1 37161,0 37184,1 37245,0 37314,1 37321,0 37348,1 37415,0 37513,1 37547,0 37626,1 37662,0 37715,1 37748,0 37760,1 37839,0 37879,1 37881,0 37966,1 38010,0 38052,1 38073,0 38158,1 38187,0 38251,1 38330,0 38401,1 38420,0 38446,1 38543,0 38546,1 38609,0 38637,1 38704,0 38784,1 38793,0 38883,1 38936,0 38974,1 39031,0 39120,1 39168,0 39244,1 39290,0 39304,1 39396,0 39491,1 39552,0 39584,1 39638,0 39727,1 39743,0 39838,1 39873,0 39932,1 39984,0 40080,1 40092,0 40122,1 40208,0 40294,1 40334,0 40337,1 40363,0 40413,1 40463,0 40479,1 40536,0 40596,1 40610,0 40689,1 40746,0 40786,1 40796,0 40862,1 40931,0 40947,1 40995,0 40997,1 41083,0 41181,1 41216,0 41240,1 41332,0 41374,1 41385,0 41470,1 41556,0 41590,1 41617,0 41664,1 41752,0 41791,1 41824,0 41835,1 41891,0 41915,1 41983,0 42018,1 42084,0 42165,1 42228,0 42301,1 42311,0 42408,1 42446,0 42491,1 42492,0 42552,1 42617,0 42622,1 42710,0 42787,1 42849,0 42906,1 42919,0 42963,1 42970,0 43055,1 43084,0 43130,1 43213,0 43224,1 43304,0 43378,1 43396,0 43418,1 43510,0 43520,1 43545,0 43573,1 43662,0 43703,1 43770,0 43799,1 43855,0 43889,1 43935,0 44015,1 44023,0 44062,1 44147,0 44188,1 44260,0 44270,1 44327,0 44336,1 44412,0 44492,1 44553,0 44609,1 44688,0 44705,1 44752,0 44755,1 44796,0 44812,1 44818,0 44892,1 44956,0 45020,1 45035,0 45089,1 45144,0 45203,1 45218,0 45278,1 45366,0 45380,1 45451,0 45461,1 45552,0 45599,1 45691,0 45767,1 45824,0 45833,1 45924,0 45974,1 46012,0 46039,1 46120,0 46123,1 46209,0 46272,1 46359,0 46403,1 46472,0 46531,1 46591,0 46654,1 46703,0 46742,1 46816,0 46823,1 46830,0 46887,1 46957,0 47053,1 47063,0 47083,1 47121,0 47133,1 47160,0 47256,1 47270,0 47292,1 47346,0 47394,1 47462,0 47481,1 47581,0 47680,1 47747,0 47830,1 47870,0 47905,1 47914,0 47961,1 48029,0 48053,1 48078,0 48098,1 48172,0 48212,1 48222,0 48275,1 48319,0 48346,1 48428,0 48444,1 48508,0 48606,1 48696,0 48780,1 48797,0 48868,1 48872,0 48930,1 48934,0 48973,1 48974,0 48998,1 49020,0 49109,1 49148,0 49154,1 49193,0 49253,1 49353,0 49445,1 49521,0 49598,1 49668,0 49697,1 49712,0 49788,1 49824,0 49885,1 49907,0 49925,1 49959,0 50047,1 50102,0 50156,1 50202,0 50299,1 50301,0 50385,1 50437,0 50523,1 50575,0 50605,1 50623,0 50700,1 50714,0 50789,1 50887,0 50942,1 51036,0 51109,1 51124,0 51138,1 end initlist b19 0,0 83,1 163,0 249,1 252,0 292,1 357,0 424,1 522,0 568,1 588,0 630,1 656,0 702,1 786,0 826,1 888,0 987,1 1064,0 1146,1 1148,0 1225,1 1302,0 1371,1 1378,0 1431,1 1467,0 1553,1 1615,0 1634,1 1724,0 1798,1 1818,0 1911,1 1912,0 2001,1 2093,0 2149,1 2192,0 2226,1 2246,0 2274,1 2339,0 2423,1 2470,0 2528,1 2584,0 2661,1 2729,0 2826,1 2835,0 2907,1 2913,0 2973,1 3023,0 3076,1 3172,0 3259,1 3272,0 3369,1 3464,0 3519,1 3587,0 3683,1 3685,0 3759,1 3816,0 3897,1 3964,0 3965,1 3989,0 4047,1 4077,0 4120,1 4151,0 4245,1 4299,0 4327,1 4331,0 4403,1 4436,0 4514,1 4518,0 4589,1 4598,0 4613,1 4624,0 4673,1 4684,0 4741,1 4840,0 4906,1 4916,0 4996,1 5002,0 5048,1 5144,0 5193,1 5207,0 5224,1 5245,0 5273,1 5334,0 5369,1 5395,0 5432,1 5490,0 5569,1 5585,0 5669,1 5671,0 5678,1 5709,0 5798,1 5882,0 5910,1 5911,0 5955,1 5977,0 6056,1 6102,0 6107,1 6172,0 6191,1 6201,0 6252,1 6282,0 6309,1 6336,0 6416,1 6438,0 6470,1 6517,0 6559,1 6618,0 6707,1 6725,0 6769,1 6834,0 6931,1 7006,0 7076,1 7107,0 7178,1 7201,0 7251,1 7302,0 7324,1 7326,0 7389,1 7416,0 7469,1 7532,0 7541,1 7554,0 7561,1 7631,0 7666,1 7696,0 7766,1 7773,0 7866,1 7874,0 7938,1 7979,0 8013,1 8104,0 8137,1 8180,0 8230,1 8318,0 8384,1 8426,0 8516,1 8547,0 8563,1 8635,0 8642,1 8708,0 8716,1 8789,0 8847,1 8908,0 8971,1 9020,0 9112,1 9187,0 9272,1 9342,0 9412,1 9486,0 9567,1 9579,0 9670,1 9768,0 9820,1 9898,0 9959,1 10028,0 10127,1 10159,0 10222,1 10233,0 10264,1 10297,0 10302,1 10353,0 10356,1 10417,0 10438,1 10507,0 10565,1 10588,0 10686,1 10727,0 10780,1 10841,0 10909,1 10934,0 11026,1 11113,0 11129,1 11194,0 11273,1 11287,0 11298,1 11305,0 11325,1 11336,0 11358,1 11366,0 11435,1 11530,0 11573,1 11592,0 11649,1 11737,0 11778,1 11856,0 11910,1 11997,0 12002,1 12005,0 12024,1 12088,0 12179,1 12255,0 12296,1 12395,0 12451,1 12502,0 12567,1 12575,0 12612,1 12705,0 12800,1 12896,0 12967,1 13014,0 13046,1 13090,0 13170,1 13219,0 13305,1 13349,0 13369,1 13415,0 13503,1 13529,0 13594,1 13657,0 13756,1 13825,0 13915,1 13990,0 14058,1 14121,0 14212,1 14274,0 14288,1 14345,0 14379,1 14408,0 14462,1 14553,0 14618,1 14634,0 14698,1 14715,0 14774,1 14786,0 14837,1 14868,0 14959,1 15045,0 15105,1 15138,0 15223,1 15272,0 15298,1 15385,0 15438,1 15471,0 15503,1 15532,0 15584,1 15603,0 15688,1 15735,0 15776,1 15875,0 15945,1 15952,0 16014,1 16075,0 16158,1 16208,0 16217,1 16259,0 16328,1 16395,0 16405,1 16485,0 16533,1 16576,0 16641,1 16679,0 16732,1 16784,0 16852,1 16916,0 16998,1 17011,0 17050,1 17146,0 17200,1 17280,0 17333,1 17432,0 17451,1 17456,0 17542,1 17625,0 17673,1 17735,0 17772,1 17791,0 17886,1 17975,0 18012,1 18055,0 18143,1 18202,0 18231,1 18312,0 18339,1 18407,0 18444,1 18470,0 18534,1 18554,0 18634,1 18635,0 18674,1 18682,0 18740,1 18767,0 18802,1 18896,0 18949,1 18964,0 19041,1 19078,0 19082,1 19116,0 19206,1 19274,0 19303,1 19351,0 19404,1 19466,0 19467,1 19526,0 19611,1 19635,0 19734,1 19830,0 19928,1 20005,0 20084,1 20090,0 20176,1 20212,0 20263,1 20282,0 20373,1 20418,0 20472,1 20530,0 20586,1 20664,0 20699,1 20745,0 20747,1 20749,0 20763,1 20851,0 20949,1 21027,0 21069,1 21144,0 21172,1 21251,0 21293,1 21338,0 21351,1 21393,0 21428,1 21447,0 21512,1 21529,0 21541,1 21635,0 21703,1 21744,0 21774,1 21808,0 21908,1 21959,0 22058,1 22098,0 22165,1 22186,0 22281,1 22380,0 22452,1 22474,0 22475,1 22506,0 22527,1 22583,0 22636,1 22716,0 22749,1 22782,0 22816,1 22819,0 22873,1 22936,0 22965,1 23006,0 23069,1 23146,0 23208,1 23263,0 23312,1 23337,0 23415,1 23426,0 23445,1 23475,0 23549,1 23558,0 23594,1 23657,0 23706,1 23799,0 23894,1 23967,0 23987,1 24080,0 24119,1 24176,0 24261,1 24331,0 24383,1 24471,0 24477,1 24533,0 24601,1 24680,0 24708,1 24716,0 24722,1 24800,0 24817,1 24905,0 25002,1 25050,0 25077,1 25163,0 25198,1 25271,0 25319,1 25352,0 25361,1 25382,0 25391,1 25435,0 25459,1 25493,0 25510,1 25596,0 25673,1 25716,0 25767,1 25784,0 25794,1 25867,0 25875,1 25890,0 25978,1 26060,0 26077,1 26170,0 26260,1 26298,0 26326,1 26383,0 26397,1 26404,0 26433,1 26512,0 26595,1 26603,0 26638,1 26693,0 26743,1 26787,0 26859,1 26958,0 27017,1 27046,0 27070,1 27075,0 27087,1 27165,0 27198,1 27298,0 27340,1 27382,0 27436,1 27513,0 27535,1 27600,0 27629,1 27679,0 27686,1 27745,0 27757,1 27793,0 27847,1 27864,0 27934,1 27966,0 28048,1 28077,0 28121,1 28133,0 28144,1 28173,0 28246,1 28306,0 28382,1 28407,0 28484,1 28550,0 28564,1 28611,0 28647,1 28655,0 28657,1 28699,0 28701,1 28719,0 28815,1 28836,0 28892,1 28966,0 28971,1 29061,0 29156,1 29255,0 29259,1 29304,0 29384,1 29418,0 29447,1 29513,0 29611,1 29680,0 29754,1 29809,0 29867,1 29922,0 29969,1 29989,0 29993,1 30006,0 30085,1 30146,0 30216,1 30263,0 30333,1 30381,0 30403,1 30429,0 30432,1 30506,0 30601,1 30645,0 30715,1 30726,0 30786,1 30798,0 30876,1 30917,0 30919,1 30998,0 31024,1 31067,0 31130,1 31138,0 31151,1 31238,0 31260,1 31266,0 31348,1 31435,0 31473,1 31531,0 31625,1 31718,0 31731,1 31742,0 31839,1 31840,0 31934,1 31956,0 31959,1 31977,0 32067,1 32150,0 32197,1 32290,0 32326,1 32403,0 32476,1 32511,0 32571,1 32577,0 32644,1 32711,0 32741,1 32782,0 32823,1 32918,0 32981,1 33024,0 33079,1 33091,0 33092,1 33189,0 33289,1 33379,0 33380,1 33435,0 33487,1 33501,0 33596,1 33615,0 33638,1 33720,0 33728,1 33811,0 33896,1 33976,0 34064,1 34144,0 34180,1 34215,0 34296,1 34370,0 34416,1 34424,0 34438,1 34523,0 34599,1 34642,0 34741,1 34754,0 34821,1 34904,0 34914,1 34960,0 35041,1 35058,0 35157,1 35191,0 35196,1 35284,0 35299,1 35371,0 35372,1 35471,0 35485,1 35545,0 35571,1 35620,0 35673,1 35764,0 35765,1 35843,0 35869,1 35889,0 35927,1 35939,0 35946,1 35994,0 36079,1 36173,0 36179,1 36214,0 36295,1 36376,0 36432,1 36498,0 36544,1 36622,0 36715,1 36757,0 36770,1 36856,0 36921,1 36990,0 37031,1 37043,0 37125,1 37199,0 37206,1 37294,0 37370,1 37432,0 37461,1 37547,0 37613,1 37661,0 37753,1 37755,0 37802,1 37883,0 37935,1 38018,0 38037,1 38083,0 38084,1 38096,0 38099,1 38104,0 38158,1 38235,0 38308,1 38321,0 38362,1 38386,0 38402,1 38411,0 38424,1 38504,0 38603,1 38673,0 38686,1 38738,0 38822,1 38904,0 38924,1 39005,0 39074,1 39076,0 39176,1 39194,0 39237,1 39285,0 39307,1 39313,0 39361,1 39365,0 39384,1 39427,0 39491,1 39513,0 39533,1 39576,0 39607,1 39638,0 39724,1 39739,0 39759,1 39778,0 39827,1 39838,0 39845,1 39937,0 39985,1 40024,0 40096,1 40126,0 40158,1 40161,0 40196,1 40271,0 40353,1 40389,0 40394,1 40451,0 40524,1 40606,0 40671,1 40746,0 40752,1 40843,0 40939,1 40973,0 41032,1 41034,0 41082,1 41180,0 41215,1 41250,0 41322,1 41384,0 41481,1 41490,0 41532,1 41546,0 41593,1 41640,0 41664,1 41749,0 41813,1 41894,0 41933,1 42032,0 42074,1 42106,0 42154,1 42159,0 42214,1 42238,0 42338,1 42409,0 42485,1 42583,0 42645,1 42690,0 42712,1 42729,0 42732,1 42739,0 42768,1 42810,0 42863,1 42950,0 43023,1 43066,0 43073,1 43120,0 43126,1 43172,0 43206,1 43235,0 43291,1 43306,0 43332,1 43397,0 43433,1 43459,0 43545,1 43635,0 43701,1 43785,0 43792,1 43876,0 43962,1 44033,0 44064,1 44162,0 44229,1 44291,0 44355,1 44434,0 44494,1 44503,0 44508,1 44571,0 44633,1 44657,0 44700,1 44763,0 44832,1 44862,0 44942,1 44955,0 44999,1 45000,0 45003,1 45037,0 45059,1 45121,0 45126,1 45161,0 45256,1 45274,0 45324,1 45391,0 45405,1 45412,0 45443,1 45449,0 45471,1 45549,0 45557,1 45558,0 45628,1 45647,0 45745,1 45799,0 45816,1 45829,0 45860,1 45949,0 45959,1 46050,0 46138,1 46154,0 46190,1 46268,0 46368,1 46442,0 46460,1 46544,0 46578,1 46656,0 46750,1 46757,0 46802,1 46804,0 46880,1 46953,0 46991,1 46999,0 47074,1 47131,0 47145,1 47174,0 47265,1 47334,0 47362,1 47449,0 47465,1 47499,0 47599,1 47621,0 47707,1 47771,0 47819,1 47880,0 47924,1 47941,0 47958,1 48041,0 48074,1 48108,0 48186,1 48263,0 48284,1 48292,0 48319,1 48347,0 48361,1 48448,0 48481,1 48485,0 48555,1 48560,0 48654,1 48749,0 48828,1 48870,0 48964,1 49021,0 49032,1 49048,0 49110,1 49132,0 49222,1 49223,0 49246,1 49277,0 49314,1 49332,0 49369,1 end initlist b20 0,0 46,1 64,0 111,1 174,0 249,1 267,0 333,1 411,0 463,1 489,0 533,1 609,0 626,1 646,0 686,1 776,0 851,1 941,0 1018,1 1041,0 1060,1 1096,0 1132,1 1174,0 1187,1 1242,0 1259,1 1270,0 1306,1 1354,0 1420,1 1455,0 1529,1 1616,0 1693,1 1730,0 1818,1 1869,0 1917,1 1992,0 2004,1 2074,0 2115,1 2180,0 2209,1 2235,0 2298,1 2312,0 2371,1 2429,0 2448,1 2514,0 2538,1 2542,0 2547,1 2603,0 2666,1 2745,0 2801,1 2901,0 2988,1 3086,0 3174,1 3219,0 3294,1 3344,0 3358,1 3448,0 3496,1 3584,0 3620,1 3719,0 3754,1 3758,0 3809,1 3813,0 3860,1 3882,0 3945,1 3999,0 4090,1 4098,0 4159,1 4198,0 4240,1 4307,0 4349,1 4420,0 4505,1 4596,0 4633,1 4703,0 4717,1 4805,0 4872,1 4904,0 4917,1 4947,0 4977,1 4995,0 5063,1 5110,0 5158,1 5221,0 5260,1 5266,0 5267,1 5315,0 5363,1 5377,0 5382,1 5396,0 5400,1 5466,0 5528,1 5569,0 5592,1 5658,0 5752,1 5760,0 5765,1 5800,0 5817,1 5913,0 6007,1 6098,0 6159,1 6167,0 6260,1 6339,0 6361,1 6372,0 6436,1 6499,0 6520,1 6530,0 6563,1 6587,0 6675,1 6753,0 6793,1 6847,0 6889,1 6924,0 6946,1 6965,0 7031,1 7044,0 7097,1 7136,0 7181,1 7224,0 7277,1 7282,0 7320,1 7413,0 7436,1 7456,0 7530,1 7593,0 7631,1 7714,0 7792,1 7889,0 7892,1 7936,0 7947,1 7964,0 8024,1 8037,0 8043,1 8073,0 8091,1 8095,0 8104,1 8142,0 8208,1 8267,0 8361,1 8440,0 8481,1 8506,0 8581,1 8616,0 8639,1 8727,0 8811,1 8877,0 8974,1 8978,0 9018,1 9062,0 9150,1 9222,0 9263,1 9351,0 9450,1 9491,0 9555,1 9628,0 9666,1 9765,0 9777,1 9848,0 9876,1 9910,0 9962,1 10015,0 10037,1 10117,0 10150,1 10171,0 10175,1 10193,0 10194,1 10257,0 10313,1 10376,0 10399,1 10493,0 10537,1 10559,0 10609,1 10646,0 10739,1 10742,0 10747,1 10847,0 10887,1 10986,0 10987,1 11060,0 11107,1 11129,0 11227,1 11247,0 11271,1 11287,0 11317,1 11384,0 11397,1 11460,0 11557,1 11598,0 11684,1 11709,0 11779,1 11868,0 11960,1 11969,0 12040,1 12070,0 12120,1 12180,0 12278,1 12281,0 12316,1 12387,0 12482,1 12550,0 12618,1 12651,0 12724,1 12795,0 12802,1 12823,0 12829,1 12847,0 12885,1 12928,0 12979,1 13041,0 13073,1 13082,0 13180,1 13232,0 13300,1 13373,0 13412,1 13430,0 13473,1 13543,0 13567,1 13598,0 13646,1 13665,0 13734,1 13755,0 13784,1 13855,0 13940,1 13972,0 14052,1 14126,0 14158,1 14219,0 14229,1 14319,0 14367,1 14413,0 14452,1 14504,0 14590,1 14664,0 14745,1 14811,0 14883,1 14949,0 14966,1 14977,0 15077,1 15175,0 15212,1 15229,0 15248,1 15341,0 15344,1 15392,0 15432,1 15509,0 15576,1 15675,0 15680,1 15705,0 15795,1 15844,0 15918,1 15926,0 15966,1 16034,0 16101,1 16188,0 16199,1 16267,0 16284,1 16312,0 16383,1 16478,0 16501,1 16504,0 16531,1 16604,0 16700,1 16716,0 16799,1 16883,0 16951,1 16987,0 17035,1 17066,0 17104,1 17172,0 17206,1 17212,0 17293,1 17321,0 17325,1 17355,0 17443,1 17454,0 17496,1 17515,0 17520,1 17559,0 17571,1 17623,0 17684,1 17697,0 17723,1 17762,0 17789,1 17881,0 17976,1 18010,0 18093,1 18118,0 18124,1 18216,0 18234,1 18312,0 18338,1 18427,0 18518,1 18563,0 18626,1 18709,0 18773,1 18800,0 18867,1 18880,0 18971,1 18994,0 19081,1 19109,0 19123,1 19195,0 19253,1 19324,0 19347,1 19367,0 19421,1 19448,0 19493,1 19499,0 19589,1 19601,0 19680,1 19752,0 19755,1 19802,0 19877,1 19942,0 20022,1 20070,0 20122,1 20194,0 20272,1 20277,0 20365,1 20402,0 20417,1 20481,0 20543,1 20628,0 20710,1 20807,0 20876,1 20915,0 20999,1 21072,0 21110,1 21135,0 21146,1 21227,0 21324,1 21406,0 21466,1 21553,0 21612,1 21670,0 21740,1 21769,0 21836,1 21928,0 21977,1 21994,0 22003,1 22038,0 22095,1 22098,0 22127,1 22156,0 22254,1 22257,0 22309,1 22346,0 22420,1 22476,0 22502,1 22521,0 22552,1 22633,0 22662,1 22697,0 22739,1 22795,0 22849,1 22924,0 22954,1 23004,0 23049,1 23149,0 23197,1 23247,0 23315,1 23390,0 23400,1 23430,0 23497,1 23543,0 23637,1 23638,0 23722,1 23746,0 23759,1 23811,0 23830,1 23861,0 23868,1 23934,0 24021,1 24051,0 24068,1 24163,0 24221,1 24295,0 24307,1 24395,0 24474,1 24569,0 24606,1 24673,0 24706,1 24727,0 24770,1 24778,0 24832,1 24850,0 24881,1 24980,0 25003,1 25020,0 25101,1 25173,0 25219,1 25309,0 25315,1 25332,0 25344,1 25366,0 25427,1 25479,0 25482,1 25546,0 25569,1 25581,0 25680,1 25723,0 25732,1 25805,0 25899,1 25980,0 26034,1 26121,0 26137,1 26180,0 26244,1 26255,0 26280,1 26308,0 26374,1 26406,0 26407,1 26428,0 26507,1 26567,0 26582,1 26585,0 26673,1 26709,0 26802,1 26869,0 26922,1 26933,0 27018,1 27113,0 27178,1 27230,0 27328,1 27335,0 27383,1 27431,0 27528,1 27591,0 27651,1 27704,0 27755,1 27768,0 27800,1 27892,0 27951,1 27977,0 28035,1 28100,0 28196,1 28215,0 28241,1 28274,0 28365,1 28380,0 28386,1 28448,0 28458,1 28551,0 28570,1 28635,0 28690,1 28699,0 28791,1 28798,0 28850,1 28913,0 28949,1 28965,0 29059,1 29107,0 29196,1 29255,0 29267,1 29289,0 29300,1 29394,0 29431,1 29442,0 29534,1 29585,0 29645,1 29726,0 29745,1 29832,0 29839,1 29925,0 29971,1 29988,0 30087,1 30170,0 30223,1 30301,0 30308,1 30312,0 30367,1 30455,0 30536,1 30573,0 30616,1 30676,0 30770,1 30777,0 30805,1 30821,0 30917,1 30985,0 30994,1 31045,0 31132,1 31144,0 31196,1 31267,0 31279,1 31347,0 31382,1 31470,0 31515,1 31537,0 31618,1 31687,0 31735,1 31762,0 31797,1 31820,0 31828,1 31844,0 31857,1 31862,0 31884,1 31941,0 31975,1 31982,0 31996,1 32075,0 32174,1 32232,0 32241,1 32249,0 32348,1 32385,0 32394,1 32489,0 32518,1 32519,0 32605,1 32616,0 32655,1 32723,0 32817,1 32888,0 32940,1 33030,0 33107,1 33188,0 33193,1 33208,0 33306,1 33321,0 33325,1 33362,0 33368,1 33422,0 33428,1 33507,0 33551,1 33624,0 33706,1 33762,0 33771,1 33818,0 33829,1 33838,0 33858,1 33923,0 33949,1 34040,0 34133,1 34185,0 34198,1 34247,0 34334,1 34370,0 34467,1 34501,0 34593,1 34600,0 34640,1 34726,0 34772,1 34797,0 34849,1 34885,0 34946,1 34995,0 35081,1 35082,0 35109,1 35111,0 35138,1 35217,0 35244,1 35271,0 35317,1 35334,0 35407,1 35417,0 35440,1 35453,0 35490,1 35567,0 35649,1 35680,0 35760,1 35799,0 35805,1 35898,0 35951,1 35971,0 36036,1 36074,0 36170,1 36183,0 36233,1 36260,0 36263,1 36320,0 36358,1 36444,0 36538,1 36631,0 36637,1 36694,0 36734,1 36781,0 36841,1 36856,0 36956,1 37010,0 37051,1 37071,0 37103,1 37118,0 37182,1 37190,0 37205,1 37208,0 37241,1 37322,0 37327,1 37422,0 37490,1 37516,0 37586,1 37590,0 37654,1 37690,0 37741,1 37820,0 37842,1 37920,0 37939,1 37985,0 38040,1 38132,0 38168,1 38250,0 38318,1 38351,0 38382,1 38425,0 38479,1 38540,0 38622,1 38652,0 38661,1 38698,0 38718,1 38806,0 38837,1 38922,0 38958,1 38964,0 39024,1 39049,0 39109,1 39174,0 39194,1 39207,0 39228,1 39245,0 39313,1 39394,0 39420,1 39488,0 39544,1 39618,0 39635,1 39674,0 39691,1 39737,0 39769,1 39811,0 39819,1 39839,0 39897,1 39968,0 40031,1 40077,0 40171,1 40209,0 40251,1 40303,0 40399,1 40417,0 40446,1 40475,0 40558,1 40572,0 40590,1 40682,0 40737,1 40807,0 40813,1 40853,0 40869,1 40909,0 40912,1 40951,0 41047,1 41051,0 41136,1 41152,0 41175,1 41243,0 41335,1 41343,0 41375,1 41406,0 41432,1 41524,0 41554,1 41642,0 41648,1 41694,0 41727,1 41824,0 41861,1 41890,0 41908,1 41910,0 41927,1 41961,0 41987,1 42045,0 42049,1 42055,0 42103,1 42184,0 42199,1 42237,0 42280,1 42312,0 42359,1 42381,0 42396,1 42422,0 42427,1 42501,0 42524,1 42570,0 42604,1 42658,0 42683,1 42767,0 42802,1 42829,0 42831,1 42924,0 42943,1 42969,0 42974,1 42985,0 43036,1 43048,0 43127,1 43152,0 43215,1 43268,0 43304,1 43337,0 43371,1 43420,0 43433,1 43459,0 43519,1 43584,0 43606,1 43701,0 43782,1 43862,0 43949,1 43959,0 43991,1 44076,0 44097,1 44155,0 44157,1 44168,0 44253,1 44283,0 44305,1 44327,0 44365,1 44396,0 44423,1 44510,0 44551,1 44620,0 44643,1 44728,0 44736,1 44772,0 44839,1 44931,0 44954,1 45013,0 45036,1 45098,0 45197,1 45199,0 45213,1 45292,0 45311,1 45351,0 45423,1 45509,0 45550,1 45563,0 45654,1 45709,0 45797,1 45865,0 45910,1 45957,0 45963,1 46022,0 46058,1 46071,0 46144,1 46197,0 46219,1 46313,0 46381,1 46426,0 46431,1 46524,0 46547,1 46631,0 46688,1 46697,0 46746,1 46798,0 46836,1 46906,0 46917,1 46957,0 46959,1 47011,0 47065,1 47137,0 47199,1 47214,0 47255,1 47336,0 47354,1 end initlist b21 0,0 61,1 93,0 157,1 217,0 257,1 353,0 392,1 464,0 563,1 597,0 612,1 615,0 665,1 670,0 761,1 810,0 859,1 920,0 972,1 1072,0 1125,1 1135,0 1158,1 1237,0 1270,1 1298,0 1334,1 1421,0 1449,1 1529,0 1623,1 1706,0 1803,1 1872,0 1952,1 2039,0 2083,1 2130,0 2140,1 2225,0 2267,1 2338,0 2378,1 2402,0 2451,1 2458,0 2503,1 2532,0 2621,1 2636,0 2717,1 2811,0 2869,1 2904,0 2942,1 3022,0 3087,1 3112,0 3204,1 3295,0 3369,1 3410,0 3456,1 3474,0 3552,1 3630,0 3705,1 3720,0 3777,1 3792,0 3803,1 3810,0 3885,1 3984,0 4047,1 4093,0 4172,1 4231,0 4306,1 4312,0 4346,1 4361,0 4420,1 4514,0 4590,1 4689,0 4735,1 4762,0 4786,1 4858,0 4908,1 4971,0 5034,1 5050,0 5063,1 5118,0 5184,1 5260,0 5286,1 5366,0 5391,1 5404,0 5480,1 5501,0 5583,1 5585,0 5611,1 5654,0 5655,1 5675,0 5724,1 5753,0 5822,1 5914,0 5980,1 6019,0 6081,1 6163,0 6263,1 6275,0 6318,1 6394,0 6412,1 6494,0 6583,1 6621,0 6668,1 6717,0 6815,1 6880,0 6967,1 7027,0 7086,1 7106,0 7181,1 7224,0 7234,1 7242,0 7247,1 7255,0 7265,1 7331,0 7424,1 7447,0 7502,1 7540,0 7588,1 7607,0 7654,1 7670,0 7755,1 7801,0 7855,1 7880,0 7884,1 7887,0 7910,1 7934,0 8017,1 8052,0 8102,1 8123,0 8190,1 8196,0 8216,1 8275,0 8325,1 8415,0 8447,1 8518,0 8595,1 8669,0 8728,1 8784,0 8879,1 8920,0 8994,1 8997,0 9083,1 9096,0 9108,1 9125,0 9174,1 9268,0 9362,1 9385,0 9454,1 9515,0 9585,1 9624,0 9687,1 9725,0 9806,1 9880,0 9959,1 10009,0 10107,1 10168,0 10238,1 10282,0 10295,1 10313,0 10389,1 10452,0 10521,1 10572,0 10628,1 10711,0 10798,1 10826,0 10872,1 10903,0 10979,1 11008,0 11013,1 11056,0 11090,1 11099,0 11190,1 11231,0 11286,1 11315,0 11334,1 11410,0 11423,1 11467,0 11488,1 11531,0 11555,1 11596,0 11667,1 11752,0 11762,1 11775,0 11855,1 11886,0 11891,1 11918,0 11949,1 11996,0 12042,1 12083,0 12174,1 12179,0 12228,1 12248,0 12263,1 12313,0 12389,1 12408,0 12498,1 12556,0 12645,1 12712,0 12798,1 12803,0 12891,1 12961,0 12978,1 13041,0 13110,1 13188,0 13210,1 13235,0 13312,1 13382,0 13467,1 13519,0 13557,1 13577,0 13586,1 13624,0 13637,1 13721,0 13798,1 13883,0 13976,1 14058,0 14109,1 14141,0 14207,1 14236,0 14300,1 14303,0 14357,1 14432,0 14494,1 14562,0 14623,1 14716,0 14808,1 14865,0 14951,1 14953,0 15021,1 15024,0 15032,1 15125,0 15138,1 15229,0 15295,1 15373,0 15459,1 15467,0 15501,1 15512,0 15517,1 15603,0 15653,1 15743,0 15781,1 15810,0 15894,1 15929,0 16010,1 16014,0 16076,1 16131,0 16134,1 16212,0 16284,1 16316,0 16327,1 16386,0 16422,1 16500,0 16504,1 16591,0 16663,1 16724,0 16725,1 16738,0 16774,1 16815,0 16891,1 16951,0 16974,1 16983,0 17052,1 17085,0 17168,1 17229,0 17295,1 17301,0 17344,1 17367,0 17449,1 17506,0 17558,1 17646,0 17718,1 17731,0 17778,1 17791,0 17835,1 17863,0 17914,1 17928,0 17956,1 17994,0 17996,1 18032,0 18069,1 18157,0 18166,1 18188,0 18204,1 18281,0 18381,1 18477,0 18526,1 18592,0 18669,1 18740,0 18836,1 18874,0 18940,1 19009,0 19058,1 19113,0 19158,1 19219,0 19224,1 19261,0 19353,1 19449,0 19451,1 19524,0 19614,1 19659,0 19678,1 19753,0 19817,1 19844,0 19907,1 19936,0 19968,1 20001,0 20016,1 20033,0 20068,1 20109,0 20110,1 20148,0 20201,1 20279,0 20305,1 20328,0 20406,1 20438,0 20510,1 20514,0 20551,1 20597,0 20646,1 20679,0 20680,1 20732,0 20827,1 20924,0 20949,1 21002,0 21098,1 21103,0 21188,1 21259,0 21287,1 21312,0 21371,1 21466,0 21549,1 21582,0 21637,1 21692,0 21790,1 21864,0 21915,1 22013,0 22070,1 22158,0 22221,1 22300,0 22390,1 22423,0 22487,1 22498,0 22509,1 22586,0 22647,1 22682,0 22748,1 22770,0 22797,1 22864,0 22873,1 22931,0 22992,1 23055,0 23072,1 23082,0 23155,1 23251,0 23264,1 23329,0 23375,1 23385,0 23446,1 23468,0 23483,1 23570,0 23583,1 23600,0 23652,1 23747,0 23774,1 23858,0 23947,1 24034,0 24109,1 24209,0 24291,1 24295,0 24334,1 24375,0 24448,1 24537,0 24634,1 24715,0 24737,1 24752,0 24770,1 24790,0 24843,1 24887,0 24936,1 24980,0 25003,1 25036,0 25087,1 25151,0 25202,1 25279,0 25341,1 25413,0 25480,1 25519,0 25616,1 25619,0 25689,1 25752,0 25785,1 25792,0 25799,1 25851,0 25901,1 25945,0 26003,1 26103,0 26194,1 26233,0 26315,1 26375,0 26449,1 26544,0 26593,1 26648,0 26742,1 26819,0 26820,1 26837,0 26875,1 26904,0 27000,1 27020,0 27119,1 27159,0 27251,1 27323,0 27342,1 27352,0 27399,1 27437,0 27521,1 27606,0 27665,1 27731,0 27820,1 27895,0 27928,1 27933,0 28012,1 28089,0 28125,1 28200,0 28271,1 28335,0 28338,1 28377,0 28386,1 28435,0 28458,1 28470,0 28509,1 28557,0 28599,1 28683,0 28705,1 28773,0 28785,1 28815,0 28898,1 28966,0 28978,1 29077,0 29127,1 29187,0 29253,1 29261,0 29288,1 29350,0 29386,1 29429,0 29444,1 29531,0 29584,1 29652,0 29655,1 29732,0 29804,1 29834,0 29891,1 29981,0 30075,1 30114,0 30149,1 30173,0 30255,1 30308,0 30375,1 30401,0 30471,1 30556,0 30597,1 30626,0 30723,1 30788,0 30843,1 30887,0 30903,1 30929,0 30979,1 31054,0 31115,1 31159,0 31250,1 31285,0 31295,1 31364,0 31448,1 31465,0 31562,1 31565,0 31599,1 31673,0 31750,1 31822,0 31870,1 31916,0 31932,1 32020,0 32069,1 32130,0 32221,1 32258,0 32299,1 32387,0 32430,1 32472,0 32493,1 32530,0 32630,1 32702,0 32783,1 32850,0 32861,1 32909,0 32960,1 33055,0 33078,1 33167,0 33202,1 33263,0 33348,1 33386,0 33427,1 33502,0 33589,1 33646,0 33655,1 33663,0 33734,1 33822,0 33872,1 33949,0 33979,1 34074,0 34155,1 34159,0 34250,1 34306,0 34337,1 34354,0 34432,1 34504,0 34516,1 34546,0 34643,1 34718,0 34794,1 34837,0 34858,1 34943,0 34951,1 34972,0 34992,1 35068,0 35119,1 35179,0 35229,1 35316,0 35389,1 35465,0 35542,1 35549,0 35561,1 35660,0 35747,1 35840,0 35861,1 35892,0 35939,1 36033,0 36043,1 36120,0 36156,1 36245,0 36260,1 36297,0 36311,1 36362,0 36458,1 36516,0 36529,1 36618,0 36619,1 36655,0 36753,1 36767,0 36778,1 36816,0 36879,1 36896,0 36931,1 36993,0 37060,1 37134,0 37227,1 37305,0 37344,1 37438,0 37442,1 37465,0 37545,1 37566,0 37631,1 37693,0 37758,1 37792,0 37864,1 37874,0 37937,1 38027,0 38119,1 38202,0 38203,1 38255,0 38352,1 38393,0 38489,1 38587,0 38627,1 38661,0 38671,1 38713,0 38804,1 38854,0 38885,1 38962,0 38972,1 39038,0 39081,1 39111,0 39147,1 39188,0 39275,1 39281,0 39329,1 39373,0 39406,1 39490,0 39571,1 39636,0 39695,1 39725,0 39734,1 39823,0 39907,1 39947,0 40043,1 40126,0 40173,1 40228,0 40296,1 40337,0 40430,1 40434,0 40529,1 40546,0 40633,1 40671,0 40722,1 40760,0 40821,1 40847,0 40925,1 40960,0 41048,1 41072,0 41155,1 41159,0 41234,1 41274,0 41353,1 41429,0 41505,1 41527,0 41590,1 41593,0 41605,1 41654,0 41733,1 41761,0 41827,1 41845,0 41906,1 41988,0 41997,1 42071,0 42137,1 42152,0 42167,1 42225,0 42304,1 42389,0 42437,1 42502,0 42595,1 42631,0 42722,1 42789,0 42798,1 42845,0 42922,1 43008,0 43049,1 43079,0 43156,1 43239,0 43308,1 43351,0 43380,1 43461,0 43521,1 43620,0 43694,1 43790,0 43883,1 43936,0 43975,1 44027,0 44119,1 44165,0 44166,1 44218,0 44316,1 44366,0 44428,1 44461,0 44472,1 44481,0 44574,1 44607,0 44693,1 44714,0 44798,1 44801,0 44805,1 44901,0 44992,1 45081,0 45129,1 45137,0 45198,1 45223,0 45285,1 45299,0 45376,1 45408,0 45411,1 45484,0 45579,1 45623,0 45699,1 45798,0 45845,1 45901,0 45918,1 45960,0 46008,1 46017,0 46062,1 46091,0 46135,1 46155,0 46177,1 46258,0 46351,1 46424,0 46476,1 46554,0 46621,1 46661,0 46726,1 46807,0 46905,1 46915,0 47009,1 47062,0 47100,1 47107,0 47109,1 47130,0 47202,1 47270,0 47360,1 47441,0 47533,1 47553,0 47624,1 47708,0 47739,1 47767,0 47789,1 47804,0 47852,1 47853,0 47915,1 47958,0 48034,1 48070,0 48107,1 48204,0 48278,1 48341,0 48381,1 48464,0 48488,1 48544,0 48593,1 48616,0 48625,1 48663,0 48723,1 48806,0 48858,1 48882,0 48944,1 48945,0 49042,1 49117,0 49159,1 49201,0 49290,1 49389,0 49461,1 49538,0 49564,1 49569,0 49665,1 49759,0 49846,1 49895,0 49960,1 50000,0 50083,1 50174,0 50272,1 50319,0 50356,1 50455,0 50548,1 50607,0 50658,1 50672,0 50713,1 50783,0 50806,1 50902,0 50978,1 51038,0 51082,1 51172,0 51209,1 51304,0 51339,1 51427,0 51457,1 51492,0 51511,1 51582,0 51615,1 51699,0 51796,1 51882,0 51887,1 51931,0 52021,1 52088,0 52173,1 52209,0 52220,1 end initlist b22 0,0 19,1 110,0 124,1 142,0 169,1 198,0 261,1 313,0 334,1 340,0 430,1 520,0 613,1 679,0 758,1 834,0 891,1 979,0 1027,1 1082,0 1103,1 1187,0 1265,1 1281,0 1325,1 1394,0 1455,1 1486,0 1529,1 1550,0 1631,1 1692,0 1724,1 1732,0 1818,1 1850,0 1896,1 1988,0 2011,1 2067,0 2156,1 2209,0 2302,1 2353,0 2446,1 2525,0 2594,1 2684,0 2759,1 2832,0 2833,1 2882,0 2980,1 3003,0 3098,1 3135,0 3229,1 3248,0 3283,1 3308,0 3399,1 3429,0 3498,1 3540,0 3635,1 3694,0 3738,1 3747,0 3833,1 3871,0 3893,1 3940,0 3952,1 3984,0 4024,1 4051,0 4111,1 4210,0 4253,1 4318,0 4391,1 4457,0 4478,1 4549,0 4571,1 4627,0 4717,1 4793,0 4827,1 4867,0 4938,1 4948,0 4953,1 5050,0 5097,1 5146,0 5215,1 5247,0 5327,1 5420,0 5432,1 5447,0 5498,1 5561,0 5579,1 5628,0 5686,1 5745,0 5751,1 5767,0 5847,1 5915,0 5998,1 6048,0 6093,1 6142,0 6155,1 6209,0 6253,1 6282,0 6367,1 6411,0 6435,1 6459,0 6494,1 6594,0 6668,1 6726,0 6824,1 6871,0 6932,1 6962,0 7003,1 7099,0 7138,1 7214,0 7233,1 7267,0 7352,1 7388,0 7414,1 7493,0 7534,1 7608,0 7621,1 7719,0 7727,1 7764,0 7795,1 7807,0 7894,1 7915,0 8009,1 8040,0 8106,1 8164,0 8254,1 8335,0 8428,1 8489,0 8529,1 8538,0 8555,1 8604,0 8694,1 8704,0 8753,1 8842,0 8845,1 8907,0 8921,1 8944,0 8984,1 9027,0 9110,1 9129,0 9138,1 9227,0 9321,1 9336,0 9426,1 9487,0 9509,1 9590,0 9667,1 9761,0 9839,1 9903,0 9986,1 10071,0 10121,1 10170,0 10194,1 10280,0 10298,1 10392,0 10399,1 10462,0 10557,1 10558,0 10657,1 10685,0 10783,1 10829,0 10921,1 10945,0 10999,1 11021,0 11074,1 11145,0 11244,1 11307,0 11387,1 11397,0 11494,1 11496,0 11564,1 11638,0 11662,1 11700,0 11750,1 11784,0 11816,1 11900,0 11953,1 12028,0 12115,1 12165,0 12221,1 12222,0 12249,1 12326,0 12392,1 12411,0 12462,1 12558,0 12611,1 12707,0 12734,1 12756,0 12804,1 12842,0 12910,1 12972,0 13033,1 13072,0 13141,1 13170,0 13186,1 13240,0 13286,1 13332,0 13428,1 13501,0 13554,1 13572,0 13602,1 13606,0 13617,1 13644,0 13727,1 13786,0 13825,1 13893,0 13951,1 13977,0 13979,1 14066,0 14147,1 14156,0 14165,1 14256,0 14294,1 14366,0 14398,1 14461,0 14539,1 14561,0 14575,1 14609,0 14682,1 14698,0 14739,1 14780,0 14811,1 14864,0 14917,1 14920,0 14958,1 14973,0 15060,1 15099,0 15131,1 15187,0 15229,1 15276,0 15287,1 15354,0 15408,1 15447,0 15533,1 15574,0 15666,1 15727,0 15741,1 15825,0 15849,1 15944,0 15980,1 15988,0 16020,1 16037,0 16078,1 16101,0 16161,1 16173,0 16199,1 16286,0 16345,1 16400,0 16435,1 16524,0 16575,1 16612,0 16666,1 16746,0 16815,1 16906,0 16907,1 16947,0 17041,1 17054,0 17099,1 17171,0 17251,1 17270,0 17332,1 17355,0 17450,1 17481,0 17581,1 17600,0 17606,1 17698,0 17714,1 17790,0 17880,1 17901,0 17957,1 17991,0 18038,1 18132,0 18142,1 18191,0 18249,1 18288,0 18340,1 18355,0 18393,1 18478,0 18510,1 18599,0 18698,1 18761,0 18790,1 18884,0 18939,1 18966,0 19052,1 19144,0 19152,1 19248,0 19307,1 19322,0 19364,1 19365,0 19435,1 19522,0 19580,1 19666,0 19734,1 19799,0 19866,1 19916,0 19964,1 20060,0 20105,1 20117,0 20146,1 20200,0 20245,1 20308,0 20401,1 20408,0 20414,1 20467,0 20551,1 20591,0 20610,1 20618,0 20698,1 20725,0 20764,1 20804,0 20810,1 20884,0 20951,1 20970,0 21019,1 21049,0 21063,1 21105,0 21137,1 21191,0 21263,1 21306,0 21366,1 21409,0 21442,1 21499,0 21565,1 21625,0 21649,1 21723,0 21763,1 21805,0 21875,1 21959,0 21968,1 22024,0 22101,1 22146,0 22223,1 22300,0 22344,1 22384,0 22473,1 22514,0 22532,1 22608,0 22615,1 22626,0 22665,1 22712,0 22735,1 22786,0 22798,1 22821,0 22842,1 22908,0 22928,1 22967,0 22969,1 22982,0 23008,1 23099,0 23153,1 23196,0 23281,1 23364,0 23365,1 23448,0 23548,1 23613,0 23653,1 23708,0 23744,1 23820,0 23899,1 23990,0 24066,1 24141,0 24183,1 24198,0 24232,1 24301,0 24381,1 24462,0 24491,1 24583,0 24652,1 24703,0 24718,1 24740,0 24797,1 24798,0 24870,1 24906,0 24926,1 24944,0 24946,1 24958,0 25057,1 25143,0 25162,1 25183,0 25217,1 25308,0 25346,1 25381,0 25384,1 25440,0 25538,1 25569,0 25654,1 25718,0 25749,1 25768,0 25865,1 25887,0 25902,1 25983,0 26004,1 26078,0 26137,1 26189,0 26225,1 26322,0 26348,1 26403,0 26483,1 26501,0 26600,1 26628,0 26706,1 26799,0 26803,1 26868,0 26909,1 26956,0 26995,1 27080,0 27175,1 27245,0 27339,1 27439,0 27518,1 27582,0 27669,1 27734,0 27828,1 27839,0 27914,1 27923,0 27966,1 28031,0 28114,1 28155,0 28248,1 28334,0 28372,1 28379,0 28390,1 28428,0 28480,1 28547,0 28608,1 28692,0 28770,1 28791,0 28846,1 28891,0 28909,1 28992,0 29012,1 29094,0 29189,1 29220,0 29240,1 29300,0 29397,1 29486,0 29502,1 29533,0 29584,1 29684,0 29722,1 29727,0 29791,1 29793,0 29864,1 29938,0 29943,1 30041,0 30120,1 30176,0 30241,1 30325,0 30396,1 30481,0 30493,1 30533,0 30550,1 30596,0 30682,1 30733,0 30741,1 30820,0 30898,1 30906,0 30990,1 31057,0 31148,1 31174,0 31193,1 31216,0 31267,1 31348,0 31435,1 31446,0 31460,1 31544,0 31640,1 31681,0 31692,1 31727,0 31737,1 31803,0 31893,1 31904,0 31908,1 31921,0 31974,1 32043,0 32078,1 32127,0 32214,1 32293,0 32354,1 32440,0 32512,1 32529,0 32535,1 32566,0 32621,1 32671,0 32744,1 32824,0 32865,1 32899,0 32910,1 32962,0 33016,1 33071,0 33131,1 33223,0 33299,1 33327,0 33371,1 33437,0 33447,1 33516,0 33558,1 33586,0 33622,1 33713,0 33756,1 33801,0 33821,1 33824,0 33897,1 33963,0 33986,1 34085,0 34153,1 34201,0 34229,1 34266,0 34328,1 34394,0 34436,1 34471,0 34557,1 34612,0 34654,1 34745,0 34787,1 34821,0 34907,1 34909,0 34913,1 34954,0 34971,1 34980,0 35059,1 35095,0 35126,1 35204,0 35243,1 35323,0 35337,1 35352,0 35376,1 35378,0 35426,1 35461,0 35480,1 35501,0 35530,1 35602,0 35699,1 35718,0 35799,1 35843,0 35919,1 35958,0 36031,1 36041,0 36072,1 36129,0 36169,1 36232,0 36277,1 36367,0 36414,1 36510,0 36514,1 36610,0 36680,1 36707,0 36778,1 36855,0 36888,1 36925,0 37008,1 37095,0 37127,1 37133,0 37141,1 37217,0 37275,1 37323,0 37345,1 37416,0 37476,1 37558,0 37580,1 37621,0 37654,1 37663,0 37745,1 37801,0 37865,1 37938,0 37962,1 38014,0 38025,1 38047,0 38130,1 38212,0 38218,1 38314,0 38410,1 38482,0 38516,1 38545,0 38633,1 38708,0 38738,1 38831,0 38888,1 38897,0 38923,1 39014,0 39059,1 39124,0 39199,1 39257,0 39304,1 39373,0 39405,1 39454,0 39523,1 39553,0 39605,1 39688,0 39733,1 39814,0 39900,1 39974,0 39975,1 40022,0 40085,1 40114,0 40202,1 40211,0 40253,1 40323,0 40358,1 40422,0 40427,1 40483,0 40523,1 40622,0 40680,1 40765,0 40812,1 40893,0 40941,1 41028,0 41045,1 41094,0 41180,1 41226,0 41312,1 41354,0 41427,1 41494,0 41520,1 41537,0 41632,1 41646,0 41651,1 41691,0 41703,1 41786,0 41808,1 41846,0 41938,1 42002,0 42045,1 42072,0 42137,1 42176,0 42177,1 42227,0 42257,1 42285,0 42310,1 42362,0 42377,1 42428,0 42446,1 42545,0 42623,1 42628,0 42656,1 42708,0 42710,1 42730,0 42772,1 42776,0 42835,1 42864,0 42870,1 42898,0 42925,1 42963,0 43062,1 43144,0 43226,1 43246,0 43271,1 43341,0 43395,1 43461,0 43545,1 43644,0 43723,1 43801,0 43815,1 43825,0 43845,1 43907,0 44000,1 44087,0 44153,1 44213,0 44237,1 44241,0 44257,1 44313,0 44406,1 44411,0 44440,1 44526,0 44610,1 44680,0 44769,1 44783,0 44844,1 44851,0 44946,1 45007,0 45048,1 45100,0 45120,1 45183,0 45283,1 45333,0 45369,1 45404,0 45441,1 45541,0 45612,1 45666,0 45754,1 45790,0 45869,1 45930,0 45993,1 46089,0 46113,1 46179,0 46218,1 46283,0 46366,1 46423,0 46470,1 46568,0 46623,1 46691,0 46725,1 46782,0 46811,1 46816,0 46873,1 46899,0 46949,1 47008,0 47106,1 47185,0 47226,1 47242,0 47279,1 47313,0 47320,1 47408,0 47471,1 47567,0 47618,1 47682,0 47737,1 47831,0 47877,1 47962,0 48032,1 48104,0 48131,1 48179,0 48277,1 48323,0 48396,1 48397,0 48460,1 48555,0 48653,1 48726,0 48804,1 48840,0 48924,1 48952,0 49037,1 49096,0 49185,1 49245,0 49288,1 49302,0 49314,1 49398,0 49411,1 49475,0 49519,1 49588,0 49680,1 49719,0 49756,1 49766,0 49803,1 49863,0 49898,1 49997,0 50053,1 50141,0 50218,1 50262,0 50344,1 50346,0 50391,1 50463,0 50556,1 50598,0 50685,1 50687,0 50732,1 50797,0 50836,1 50865,0 50867,1 50959,0 51010,1 51070,0 51117,1 51204,0 51218,1 51278,0 51329,1 51420,0 51482,1 51509,0 51527,1 end initlist b23 0,0 21,1 26,0 120,1 200,0 224,1 233,0 283,1 355,0 450,1 466,0 471,1 565,0 665,1 668,0 691,1 695,0 785,1 852,0 893,1 955,0 959,1 1012,0 1016,1 1101,0 1192,1 1253,0 1348,1 1431,0 1498,1 1501,0 1598,1 1648,0 1699,1 1758,0 1792,1 1841,0 1916,1 1953,0 2020,1 2070,0 2162,1 2215,0 2266,1 2276,0 2343,1 2416,0 2491,1 2588,0 2633,1 2715,0 2808,1 2825,0 2855,1 2862,0 2915,1 2925,0 2932,1 2955,0 3053,1 3103,0 3120,1 3153,0 3199,1 3289,0 3389,1 3436,0 3457,1 3508,0 3536,1 3625,0 3653,1 3705,0 3802,1 3854,0 3932,1 3938,0 4006,1 4035,0 4079,1 4161,0 4230,1 4307,0 4330,1 4420,0 4456,1 4475,0 4477,1 4511,0 4532,1 4593,0 4689,1 4746,0 4841,1 4853,0 4866,1 4914,0 4984,1 4985,0 4995,1 5016,0 5101,1 5192,0 5193,1 5240,0 5280,1 5310,0 5338,1 5339,0 5414,1 5463,0 5527,1 5582,0 5606,1 5661,0 5720,1 5818,0 5867,1 5940,0 5960,1 5987,0 6005,1 6077,0 6139,1 6160,0 6229,1 6277,0 6280,1 6322,0 6331,1 6427,0 6493,1 6580,0 6649,1 6666,0 6739,1 6773,0 6801,1 6864,0 6887,1 6943,0 7006,1 7007,0 7101,1 7111,0 7211,1 7291,0 7295,1 7337,0 7436,1 7485,0 7585,1 7638,0 7691,1 7702,0 7710,1 7742,0 7763,1 7855,0 7952,1 7981,0 8028,1 8087,0 8178,1 8252,0 8278,1 8315,0 8402,1 8491,0 8544,1 8576,0 8629,1 8709,0 8776,1 8807,0 8882,1 8884,0 8889,1 8897,0 8910,1 8988,0 9088,1 9142,0 9152,1 9224,0 9237,1 9268,0 9343,1 9408,0 9496,1 9583,0 9656,1 9715,0 9757,1 9835,0 9898,1 9904,0 9990,1 10084,0 10098,1 10178,0 10196,1 10235,0 10323,1 10418,0 10441,1 10493,0 10510,1 10566,0 10631,1 10673,0 10674,1 10697,0 10701,1 10709,0 10795,1 10845,0 10853,1 10883,0 10959,1 11034,0 11132,1 11182,0 11257,1 11262,0 11319,1 11388,0 11419,1 11489,0 11521,1 11583,0 11664,1 11700,0 11711,1 11746,0 11809,1 11841,0 11847,1 11921,0 11996,1 12071,0 12074,1 12140,0 12190,1 12223,0 12310,1 12350,0 12365,1 12398,0 12450,1 12475,0 12511,1 12549,0 12590,1 12609,0 12705,1 12718,0 12768,1 12809,0 12842,1 12922,0 12932,1 12971,0 12997,1 13083,0 13180,1 13193,0 13281,1 13364,0 13412,1 13445,0 13493,1 13592,0 13633,1 13638,0 13680,1 13700,0 13709,1 13747,0 13817,1 13847,0 13921,1 13946,0 14038,1 14128,0 14165,1 14188,0 14206,1 14232,0 14331,1 14341,0 14413,1 14414,0 14466,1 14489,0 14506,1 14555,0 14625,1 14639,0 14676,1 14753,0 14822,1 14888,0 14951,1 15012,0 15082,1 15148,0 15235,1 15276,0 15281,1 15295,0 15330,1 15384,0 15402,1 15438,0 15514,1 15611,0 15648,1 15672,0 15722,1 15761,0 15793,1 15817,0 15915,1 15988,0 16041,1 16063,0 16162,1 16261,0 16269,1 16368,0 16428,1 16448,0 16515,1 16590,0 16683,1 16775,0 16822,1 16916,0 17002,1 17026,0 17085,1 17108,0 17177,1 17266,0 17344,1 17404,0 17475,1 17505,0 17533,1 17607,0 17640,1 17657,0 17757,1 17787,0 17858,1 17951,0 17996,1 18040,0 18137,1 18209,0 18304,1 18338,0 18410,1 18467,0 18501,1 18547,0 18601,1 18627,0 18686,1 18707,0 18793,1 18861,0 18958,1 19045,0 19121,1 19216,0 19226,1 19258,0 19301,1 19373,0 19436,1 19484,0 19529,1 19575,0 19623,1 19675,0 19688,1 19692,0 19722,1 19750,0 19798,1 19860,0 19910,1 19954,0 20016,1 20114,0 20145,1 20204,0 20239,1 20290,0 20305,1 20337,0 20403,1 20478,0 20545,1 20631,0 20640,1 20688,0 20779,1 20824,0 20870,1 20898,0 20994,1 21090,0 21158,1 21208,0 21246,1 21256,0 21304,1 21336,0 21350,1 21395,0 21397,1 21439,0 21453,1 21527,0 21613,1 21671,0 21754,1 21797,0 21802,1 21864,0 21868,1 21876,0 21893,1 21959,0 21999,1 22050,0 22122,1 22145,0 22194,1 22213,0 22224,1 22289,0 22337,1 22403,0 22455,1 22497,0 22555,1 22609,0 22640,1 22678,0 22772,1 22820,0 22853,1 22941,0 22989,1 23009,0 23089,1 23168,0 23202,1 23231,0 23291,1 23353,0 23436,1 23535,0 23591,1 23616,0 23617,1 23630,0 23694,1 23695,0 23739,1 23792,0 23883,1 23941,0 24012,1 24060,0 24109,1 24145,0 24239,1 24277,0 24337,1 24351,0 24403,1 24495,0 24527,1 24550,0 24644,1 24717,0 24763,1 24810,0 24841,1 24887,0 24933,1 24992,0 25022,1 25098,0 25129,1 25144,0 25198,1 25265,0 25287,1 25317,0 25332,1 25353,0 25365,1 25434,0 25483,1 25570,0 25613,1 25707,0 25792,1 25798,0 25886,1 25980,0 25982,1 26076,0 26085,1 26141,0 26183,1 26210,0 26283,1 26284,0 26339,1 26355,0 26368,1 26387,0 26407,1 26408,0 26472,1 26512,0 26528,1 26618,0 26623,1 26719,0 26801,1 26858,0 26921,1 26943,0 27033,1 27053,0 27094,1 27134,0 27167,1 27187,0 27188,1 27205,0 27236,1 27310,0 27380,1 27439,0 27492,1 27493,0 27513,1 27552,0 27640,1 27733,0 27789,1 27796,0 27878,1 27965,0 28039,1 28110,0 28146,1 28214,0 28283,1 28349,0 28360,1 28439,0 28537,1 28558,0 28622,1 28699,0 28770,1 28773,0 28780,1 28880,0 28896,1 28984,0 28993,1 29025,0 29033,1 29059,0 29064,1 29092,0 29129,1 29134,0 29163,1 29258,0 29336,1 29424,0 29490,1 29561,0 29612,1 29627,0 29719,1 29799,0 29889,1 29920,0 29955,1 30054,0 30131,1 30189,0 30212,1 30225,0 30258,1 30285,0 30384,1 30391,0 30419,1 30426,0 30519,1 30522,0 30591,1 30657,0 30740,1 30796,0 30849,1 30938,0 30975,1 31065,0 31112,1 31130,0 31220,1 31297,0 31306,1 31359,0 31379,1 31473,0 31558,1 31570,0 31614,1 31695,0 31715,1 31784,0 31854,1 31857,0 31921,1 31933,0 32003,1 32039,0 32120,1 32211,0 32294,1 32346,0 32378,1 32469,0 32557,1 32570,0 32664,1 32755,0 32792,1 32856,0 32933,1 33023,0 33028,1 33123,0 33198,1 33216,0 33229,1 33244,0 33311,1 33398,0 33415,1 33492,0 33592,1 33666,0 33686,1 33742,0 33790,1 33816,0 33864,1 33917,0 33921,1 33980,0 34068,1 34111,0 34176,1 34209,0 34215,1 34302,0 34374,1 34382,0 34422,1 34474,0 34562,1 34636,0 34678,1 34721,0 34798,1 34844,0 34906,1 34955,0 34956,1 35018,0 35058,1 35073,0 35115,1 35186,0 35274,1 35284,0 35331,1 35368,0 35393,1 35436,0 35479,1 35499,0 35541,1 35594,0 35681,1 35728,0 35811,1 35886,0 35893,1 35983,0 36014,1 36061,0 36067,1 36079,0 36141,1 36200,0 36256,1 36318,0 36378,1 36394,0 36399,1 36474,0 36524,1 36588,0 36662,1 36673,0 36763,1 36798,0 36874,1 36901,0 36996,1 37093,0 37172,1 37184,0 37206,1 37264,0 37281,1 37338,0 37397,1 37436,0 37449,1 37453,0 37524,1 37594,0 37633,1 37637,0 37638,1 37695,0 37772,1 37810,0 37858,1 37940,0 37981,1 38022,0 38101,1 38148,0 38218,1 38239,0 38304,1 38321,0 38413,1 38434,0 38529,1 38548,0 38589,1 38641,0 38665,1 38724,0 38750,1 38834,0 38853,1 38881,0 38902,1 38978,0 39048,1 39073,0 39157,1 39206,0 39225,1 39252,0 39323,1 39418,0 39450,1 39488,0 39542,1 39562,0 39575,1 39619,0 39678,1 39701,0 39800,1 39857,0 39895,1 39991,0 40083,1 40149,0 40238,1 40277,0 40314,1 40403,0 40472,1 40478,0 40570,1 40593,0 40663,1 40709,0 40779,1 40782,0 40803,1 40884,0 40917,1 41015,0 41084,1 41154,0 41184,1 41281,0 41282,1 41326,0 41382,1 41405,0 41419,1 41509,0 41599,1 41641,0 41732,1 41744,0 41809,1 41813,0 41823,1 41882,0 41958,1 42013,0 42043,1 42056,0 42132,1 42165,0 42191,1 42281,0 42377,1 42465,0 42498,1 42556,0 42621,1 42659,0 42731,1 42755,0 42854,1 42895,0 42922,1 42977,0 42989,1 43069,0 43079,1 43172,0 43268,1 43306,0 43376,1 43394,0 43427,1 43435,0 43511,1 43562,0 43575,1 43634,0 43674,1 43768,0 43771,1 43788,0 43865,1 43925,0 43952,1 44047,0 44057,1 44102,0 44169,1 44191,0 44200,1 44224,0 44310,1 44394,0 44430,1 44431,0 44496,1 44593,0 44663,1 44665,0 44699,1 44748,0 44799,1 44873,0 44963,1 45032,0 45045,1 45118,0 45187,1 45243,0 45252,1 45261,0 45292,1 45355,0 45406,1 45500,0 45525,1 45544,0 45628,1 45677,0 45742,1 45775,0 45806,1 45863,0 45929,1 46015,0 46019,1 46071,0 46155,1 46161,0 46228,1 46291,0 46352,1 46359,0 46392,1 46455,0 46530,1 46578,0 46617,1 46641,0 46740,1 46833,0 46868,1 46965,0 47053,1 47137,0 47146,1 47186,0 47273,1 47290,0 47337,1 47391,0 47468,1 47510,0 47609,1 47634,0 47734,1 47812,0 47898,1 47964,0 47980,1 48064,0 48091,1 48123,0 48130,1 48150,0 48170,1 48181,0 48225,1 48262,0 48267,1 48340,0 48381,1 48468,0 48492,1 48571,0 48594,1 48676,0 48748,1 48798,0 48861,1 48955,0 48957,1 49054,0 49107,1 49111,0 49114,1 49184,0 49260,1 49310,0 49378,1 49454,0 49470,1 49509,0 49588,1 49682,0 49765,1 49814,0 49861,1 49946,0 50038,1 50107,0 50117,1 50161,0 50224,1 50299,0 50384,1 50466,0 50490,1 end initlist b24 0,0 20,1 28,0 119,1 201,0 232,1 319,0 375,1 463,0 508,1 580,0 656,1 734,0 773,1 788,0 819,1 881,0 919,1 925,0 951,1 1000,0 1055,1 1085,0 1109,1 1182,0 1209,1 1229,0 1329,1 1390,0 1398,1 1439,0 1503,1 1546,0 1606,1 1666,0 1689,1 1745,0 1757,1 1801,0 1876,1 1931,0 1996,1 2019,0 2025,1 2056,0 2134,1 2193,0 2250,1 2347,0 2367,1 2418,0 2473,1 2531,0 2593,1 2647,0 2678,1 2733,0 2748,1 2801,0 2889,1 2959,0 2980,1 2991,0 3057,1 3133,0 3157,1 3194,0 3291,1 3378,0 3467,1 3527,0 3618,1 3631,0 3657,1 3752,0 3765,1 3843,0 3903,1 3989,0 4057,1 4125,0 4179,1 4193,0 4245,1 4290,0 4385,1 4463,0 4559,1 4652,0 4671,1 4752,0 4842,1 4861,0 4903,1 4911,0 4965,1 5023,0 5025,1 5064,0 5077,1 5129,0 5181,1 5219,0 5236,1 5271,0 5330,1 5354,0 5443,1 5477,0 5525,1 5585,0 5683,1 5772,0 5853,1 5866,0 5895,1 5909,0 5950,1 6049,0 6139,1 6168,0 6196,1 6282,0 6304,1 6395,0 6474,1 6485,0 6585,1 6605,0 6702,1 6757,0 6765,1 6863,0 6905,1 6969,0 6980,1 6989,0 7043,1 7045,0 7132,1 7202,0 7206,1 7257,0 7347,1 7440,0 7538,1 7567,0 7634,1 7689,0 7759,1 7773,0 7861,1 7863,0 7914,1 7954,0 7999,1 8042,0 8087,1 8139,0 8178,1 8224,0 8234,1 8316,0 8318,1 8320,0 8371,1 8455,0 8462,1 8525,0 8600,1 8679,0 8753,1 8823,0 8891,1 8990,0 9087,1 9112,0 9145,1 9163,0 9212,1 9275,0 9366,1 9412,0 9469,1 9569,0 9666,1 9700,0 9727,1 9749,0 9810,1 9883,0 9959,1 9962,0 10024,1 10049,0 10111,1 10158,0 10244,1 10327,0 10359,1 10418,0 10472,1 10519,0 10590,1 10613,0 10666,1 10740,0 10784,1 10787,0 10843,1 10852,0 10872,1 10958,0 11027,1 11098,0 11175,1 11189,0 11226,1 11262,0 11274,1 11314,0 11410,1 11416,0 11489,1 11557,0 11621,1 11641,0 11680,1 11752,0 11759,1 11842,0 11927,1 11939,0 11944,1 12013,0 12025,1 12117,0 12211,1 12295,0 12296,1 12332,0 12415,1 12478,0 12535,1 12610,0 12675,1 12682,0 12711,1 12742,0 12786,1 12885,0 12932,1 12978,0 13066,1 13081,0 13146,1 13169,0 13181,1 13215,0 13234,1 13258,0 13287,1 13315,0 13319,1 13399,0 13423,1 13509,0 13601,1 13611,0 13612,1 13684,0 13705,1 13710,0 13727,1 13752,0 13821,1 13892,0 13938,1 13946,0 13956,1 13988,0 13997,1 14083,0 14087,1 14148,0 14152,1 14215,0 14292,1 14349,0 14385,1 14471,0 14511,1 14602,0 14611,1 14707,0 14796,1 14873,0 14885,1 14961,0 15004,1 15058,0 15137,1 15198,0 15281,1 15377,0 15453,1 15487,0 15580,1 15659,0 15677,1 15687,0 15707,1 15741,0 15769,1 15831,0 15900,1 15906,0 15976,1 16023,0 16090,1 16120,0 16198,1 16249,0 16282,1 16321,0 16402,1 16502,0 16518,1 16575,0 16646,1 16729,0 16816,1 16864,0 16915,1 17004,0 17006,1 17015,0 17085,1 17107,0 17141,1 17230,0 17262,1 17350,0 17429,1 17458,0 17542,1 17634,0 17665,1 17757,0 17810,1 17860,0 17916,1 17956,0 17976,1 18056,0 18076,1 18096,0 18188,1 18204,0 18216,1 18238,0 18272,1 18273,0 18294,1 18343,0 18382,1 18477,0 18523,1 18623,0 18679,1 18756,0 18853,1 18938,0 19038,1 19112,0 19117,1 19190,0 19268,1 19275,0 19297,1 19306,0 19312,1 19374,0 19375,1 19434,0 19466,1 19469,0 19510,1 19610,0 19684,1 19773,0 19788,1 19789,0 19858,1 19895,0 19980,1 20034,0 20089,1 20178,0 20195,1 20210,0 20248,1 20346,0 20410,1 20505,0 20600,1 20671,0 20702,1 20769,0 20833,1 20915,0 20984,1 21053,0 21117,1 21142,0 21187,1 21261,0 21351,1 21406,0 21446,1 21489,0 21508,1 21586,0 21679,1 21729,0 21737,1 21747,0 21801,1 21889,0 21939,1 22015,0 22060,1 22114,0 22172,1 22270,0 22323,1 22360,0 22421,1 22451,0 22537,1 22629,0 22672,1 22744,0 22843,1 22899,0 22909,1 22953,0 22964,1 23049,0 23050,1 23126,0 23203,1 23225,0 23325,1 23405,0 23461,1 23491,0 23546,1 23590,0 23605,1 23632,0 23702,1 23774,0 23811,1 23833,0 23858,1 23876,0 23914,1 24006,0 24009,1 24046,0 24146,1 24181,0 24227,1 24297,0 24342,1 24363,0 24446,1 24457,0 24536,1 24555,0 24646,1 24683,0 24778,1 24866,0 24946,1 25030,0 25053,1 25152,0 25171,1 25268,0 25341,1 25431,0 25500,1 25555,0 25600,1 25610,0 25637,1 25716,0 25757,1 25845,0 25935,1 25983,0 26071,1 26137,0 26218,1 26237,0 26249,1 26342,0 26406,1 26418,0 26518,1 26618,0 26637,1 26681,0 26699,1 26757,0 26836,1 26842,0 26920,1 27001,0 27031,1 27103,0 27138,1 27203,0 27239,1 27263,0 27351,1 27418,0 27515,1 27559,0 27645,1 27653,0 27683,1 27721,0 27776,1 27787,0 27859,1 27902,0 27950,1 27982,0 28078,1 28117,0 28211,1 28238,0 28278,1 28341,0 28350,1 28421,0 28445,1 28505,0 28591,1 28651,0 28724,1 28804,0 28832,1 28843,0 28918,1 29012,0 29106,1 29111,0 29164,1 29191,0 29219,1 29318,0 29390,1 29392,0 29465,1 29540,0 29599,1 29635,0 29701,1 29793,0 29883,1 29964,0 30051,1 30070,0 30167,1 30189,0 30234,1 30288,0 30342,1 30348,0 30447,1 30485,0 30492,1 30562,0 30654,1 30746,0 30838,1 30923,0 31014,1 31097,0 31183,1 31280,0 31317,1 31334,0 31406,1 31472,0 31558,1 31614,0 31708,1 31779,0 31852,1 31887,0 31951,1 31979,0 32017,1 32077,0 32142,1 32184,0 32251,1 32314,0 32329,1 32362,0 32380,1 32404,0 32406,1 32425,0 32432,1 32518,0 32562,1 32619,0 32645,1 32683,0 32721,1 32765,0 32837,1 32903,0 32983,1 33035,0 33119,1 33131,0 33219,1 33282,0 33339,1 33389,0 33447,1 33497,0 33589,1 33601,0 33620,1 33660,0 33698,1 33729,0 33734,1 33754,0 33799,1 33891,0 33956,1 34050,0 34150,1 34172,0 34271,1 34312,0 34338,1 34424,0 34438,1 34473,0 34564,1 34638,0 34641,1 34694,0 34701,1 34724,0 34792,1 34842,0 34919,1 34945,0 35039,1 35125,0 35154,1 35187,0 35248,1 35302,0 35374,1 35461,0 35471,1 35505,0 35599,1 35654,0 35736,1 35795,0 35874,1 35876,0 35917,1 35927,0 36016,1 36087,0 36176,1 36202,0 36265,1 36331,0 36411,1 36470,0 36485,1 36487,0 36562,1 36599,0 36602,1 36625,0 36631,1 36646,0 36689,1 36745,0 36809,1 36859,0 36947,1 37037,0 37127,1 37131,0 37224,1 37248,0 37291,1 37360,0 37410,1 37452,0 37456,1 37503,0 37524,1 37612,0 37661,1 37731,0 37746,1 37820,0 37859,1 37953,0 38042,1 38142,0 38215,1 38269,0 38341,1 38347,0 38367,1 38401,0 38415,1 38494,0 38572,1 38626,0 38643,1 38675,0 38735,1 38765,0 38805,1 38884,0 38973,1 39072,0 39137,1 39234,0 39275,1 39331,0 39427,1 39475,0 39504,1 39584,0 39661,1 39698,0 39765,1 39778,0 39779,1 39839,0 39845,1 39916,0 40004,1 40077,0 40172,1 40182,0 40190,1 40205,0 40259,1 40309,0 40352,1 40400,0 40414,1 40488,0 40539,1 40553,0 40597,1 40662,0 40705,1 40724,0 40745,1 40814,0 40883,1 40911,0 40993,1 41085,0 41152,1 41198,0 41245,1 41340,0 41350,1 41420,0 41476,1 41508,0 41543,1 41588,0 41610,1 41667,0 41740,1 41786,0 41813,1 41833,0 41927,1 41930,0 41977,1 42054,0 42122,1 42133,0 42201,1 42282,0 42313,1 42394,0 42467,1 42560,0 42564,1 42612,0 42655,1 42728,0 42795,1 42870,0 42898,1 42900,0 42934,1 42996,0 43050,1 43100,0 43142,1 43193,0 43276,1 43345,0 43403,1 43450,0 43472,1 43511,0 43581,1 43669,0 43691,1 43761,0 43813,1 43886,0 43968,1 43971,0 44010,1 44051,0 44090,1 44147,0 44211,1 44251,0 44280,1 44316,0 44361,1 44421,0 44478,1 44520,0 44559,1 44565,0 44661,1 44673,0 44724,1 44799,0 44862,1 44945,0 44981,1 44990,0 45004,1 45020,0 45041,1 45125,0 45157,1 45256,0 45295,1 45392,0 45428,1 45441,0 45448,1 45528,0 45619,1 45714,0 45726,1 45779,0 45815,1 45818,0 45885,1 45945,0 45974,1 46062,0 46073,1 46127,0 46133,1 46188,0 46230,1 46328,0 46357,1 46367,0 46413,1 46445,0 46456,1 46548,0 46598,1 46642,0 46653,1 46702,0 46784,1 46884,0 46920,1 47007,0 47055,1 47123,0 47173,1 47208,0 47277,1 47311,0 47372,1 47435,0 47489,1 47557,0 47575,1 47580,0 47621,1 47700,0 47703,1 47745,0 47811,1 47813,0 47866,1 47946,0 47978,1 47994,0 48094,1 48174,0 48266,1 48303,0 48340,1 48428,0 48478,1 48562,0 48571,1 48580,0 48612,1 48624,0 48693,1 48711,0 48803,1 48857,0 48886,1 48979,0 49008,1 49014,0 49033,1 49060,0 49156,1 49225,0 49247,1 49263,0 49294,1 49366,0 49381,1 49438,0 49453,1 49478,0 49577,1 49641,0 49732,1 49741,0 49820,1 49920,0 49944,1 50008,0 50049,1 50109,0 50142,1 50167,0 50182,1 50206,0 50209,1 50218,0 50270,1 50336,0 50345,1 50410,0 50478,1 50533,0 50537,1 50540,0 50572,1 50623,0 50711,1 50764,0 50800,1 50883,0 50937,1 50989,0 51075,1 51115,0 51177,1 51192,0 51239,1 51280,0 51321,1 51340,0 51384,1 end initlist b25 0,0 59,1 83,0 166,1 187,0 221,1 260,0 326,1 401,0 417,1 503,0 539,1 613,0 708,1 726,0 815,1 828,0 911,1 989,0 996,1 998,0 1070,1 1106,0 1148,1 1185,0 1202,1 1269,0 1329,1 1412,0 1499,1 1536,0 1553,1 1652,0 1734,1 1772,0 1777,1 1815,0 1903,1 1959,0 2045,1 2109,0 2115,1 2170,0 2249,1 2282,0 2298,1 2299,0 2391,1 2419,0 2455,1 2542,0 2575,1 2583,0 2629,1 2691,0 2725,1 2747,0 2802,1 2850,0 2861,1 2905,0 2912,1 2950,0 3014,1 3038,0 3059,1 3130,0 3139,1 3185,0 3273,1 3323,0 3407,1 3498,0 3536,1 3568,0 3652,1 3703,0 3758,1 3843,0 3856,1 3907,0 3933,1 3979,0 4061,1 4064,0 4084,1 4145,0 4201,1 4229,0 4302,1 4394,0 4417,1 4457,0 4473,1 4526,0 4547,1 4566,0 4603,1 4656,0 4661,1 4739,0 4837,1 4868,0 4943,1 4987,0 5059,1 5073,0 5151,1 5200,0 5235,1 5295,0 5353,1 5449,0 5519,1 5563,0 5588,1 5639,0 5658,1 5756,0 5785,1 5823,0 5903,1 5957,0 5984,1 6042,0 6110,1 6120,0 6166,1 6213,0 6252,1 6308,0 6367,1 6464,0 6543,1 6566,0 6619,1 6655,0 6745,1 6780,0 6796,1 6874,0 6912,1 6939,0 7003,1 7100,0 7160,1 7255,0 7288,1 7375,0 7432,1 7441,0 7476,1 7498,0 7587,1 7589,0 7634,1 7672,0 7695,1 7793,0 7802,1 7877,0 7941,1 8028,0 8117,1 8200,0 8231,1 8237,0 8292,1 8346,0 8408,1 8466,0 8480,1 8493,0 8575,1 8655,0 8672,1 8764,0 8812,1 8819,0 8918,1 9018,0 9061,1 9095,0 9188,1 9193,0 9245,1 9275,0 9337,1 9381,0 9428,1 9483,0 9508,1 9567,0 9652,1 9747,0 9782,1 9861,0 9928,1 10015,0 10080,1 10170,0 10235,1 10304,0 10386,1 10448,0 10505,1 10569,0 10584,1 10641,0 10736,1 10744,0 10820,1 10821,0 10866,1 10940,0 11032,1 11067,0 11132,1 11212,0 11223,1 11303,0 11399,1 11446,0 11513,1 11608,0 11621,1 11701,0 11768,1 11811,0 11901,1 11922,0 12012,1 12034,0 12128,1 12134,0 12217,1 12268,0 12337,1 12390,0 12424,1 12467,0 12504,1 12585,0 12640,1 12669,0 12753,1 12797,0 12837,1 12860,0 12870,1 12917,0 12953,1 13048,0 13078,1 13092,0 13183,1 13184,0 13215,1 13225,0 13286,1 13349,0 13357,1 13408,0 13494,1 13569,0 13606,1 13685,0 13781,1 13806,0 13844,1 13845,0 13882,1 13946,0 13953,1 13996,0 14058,1 14085,0 14174,1 14232,0 14297,1 14394,0 14458,1 14545,0 14608,1 14657,0 14667,1 14760,0 14803,1 14879,0 14903,1 14937,0 14946,1 15021,0 15068,1 15069,0 15129,1 15155,0 15192,1 15237,0 15248,1 15270,0 15272,1 15295,0 15378,1 15466,0 15539,1 15581,0 15671,1 15740,0 15817,1 15915,0 15950,1 15972,0 16006,1 16009,0 16044,1 16105,0 16130,1 16137,0 16220,1 16302,0 16340,1 16360,0 16369,1 16408,0 16414,1 16501,0 16505,1 16601,0 16613,1 16673,0 16699,1 16765,0 16848,1 16891,0 16971,1 17054,0 17095,1 17098,0 17153,1 17206,0 17305,1 17334,0 17359,1 17386,0 17457,1 17496,0 17564,1 17569,0 17669,1 17715,0 17794,1 17808,0 17841,1 17911,0 17988,1 18018,0 18029,1 18115,0 18141,1 18228,0 18301,1 18384,0 18453,1 18489,0 18542,1 18609,0 18648,1 18701,0 18768,1 18843,0 18930,1 18972,0 18978,1 19063,0 19073,1 19077,0 19083,1 19133,0 19206,1 19215,0 19255,1 19348,0 19382,1 19463,0 19537,1 19604,0 19651,1 19730,0 19731,1 19753,0 19853,1 19855,0 19948,1 20019,0 20047,1 20094,0 20151,1 20188,0 20260,1 20304,0 20338,1 20380,0 20416,1 20493,0 20576,1 20582,0 20584,1 20606,0 20672,1 20760,0 20852,1 20946,0 20995,1 21055,0 21124,1 21199,0 21203,1 21209,0 21295,1 21323,0 21349,1 21352,0 21367,1 21373,0 21450,1 21464,0 21473,1 21481,0 21535,1 21631,0 21722,1 21757,0 21800,1 21834,0 21863,1 21892,0 21896,1 21949,0 21957,1 22054,0 22060,1 22109,0 22204,1 22209,0 22295,1 22353,0 22396,1 22465,0 22526,1 22577,0 22584,1 22621,0 22692,1 22769,0 22817,1 22898,0 22978,1 23044,0 23137,1 23237,0 23331,1 23373,0 23421,1 23516,0 23580,1 23670,0 23699,1 23732,0 23788,1 23852,0 23894,1 23980,0 24008,1 24054,0 24061,1 24158,0 24160,1 24240,0 24280,1 24357,0 24438,1 24509,0 24596,1 24606,0 24695,1 24744,0 24774,1 24786,0 24815,1 24833,0 24861,1 24885,0 24909,1 24999,0 25081,1 25110,0 25112,1 25145,0 25191,1 25246,0 25324,1 25413,0 25461,1 25501,0 25521,1 25567,0 25654,1 25665,0 25671,1 25694,0 25766,1 25828,0 25867,1 25875,0 25960,1 26026,0 26094,1 26102,0 26142,1 26213,0 26304,1 26363,0 26383,1 26450,0 26484,1 26505,0 26605,1 26691,0 26715,1 26813,0 26870,1 26912,0 26990,1 27062,0 27148,1 27221,0 27287,1 27309,0 27337,1 27431,0 27445,1 27461,0 27526,1 27529,0 27604,1 27632,0 27708,1 27736,0 27832,1 27844,0 27931,1 27969,0 28015,1 28101,0 28156,1 28200,0 28216,1 28265,0 28335,1 28400,0 28404,1 28463,0 28536,1 28541,0 28600,1 28607,0 28626,1 28721,0 28809,1 28887,0 28913,1 28933,0 28963,1 29050,0 29110,1 29206,0 29268,1 29365,0 29429,1 29493,0 29565,1 29656,0 29687,1 29693,0 29701,1 29705,0 29725,1 29783,0 29866,1 29925,0 29977,1 30049,0 30072,1 30094,0 30111,1 30199,0 30221,1 30266,0 30340,1 30399,0 30462,1 30550,0 30612,1 30666,0 30677,1 30720,0 30810,1 30846,0 30908,1 30946,0 30977,1 31021,0 31029,1 31034,0 31111,1 31142,0 31184,1 31250,0 31312,1 31338,0 31426,1 31503,0 31527,1 31609,0 31696,1 31705,0 31752,1 31815,0 31897,1 31970,0 32066,1 32142,0 32202,1 32205,0 32252,1 32262,0 32318,1 32400,0 32476,1 32497,0 32511,1 32534,0 32591,1 32636,0 32711,1 32731,0 32748,1 32822,0 32867,1 32876,0 32914,1 32951,0 32953,1 32957,0 33022,1 33069,0 33077,1 33092,0 33180,1 33199,0 33257,1 33293,0 33370,1 33409,0 33470,1 33543,0 33635,1 33691,0 33776,1 33798,0 33895,1 33924,0 33943,1 33981,0 34051,1 34121,0 34170,1 34205,0 34253,1 34326,0 34336,1 34368,0 34374,1 34444,0 34446,1 34530,0 34559,1 34574,0 34670,1 34722,0 34740,1 34814,0 34896,1 34943,0 35027,1 35041,0 35136,1 35184,0 35219,1 35238,0 35285,1 35347,0 35430,1 35462,0 35515,1 35597,0 35678,1 35708,0 35798,1 35833,0 35863,1 35878,0 35929,1 35996,0 36001,1 36037,0 36047,1 36083,0 36146,1 36241,0 36256,1 36316,0 36369,1 36445,0 36514,1 36547,0 36598,1 36646,0 36708,1 36785,0 36873,1 36901,0 36908,1 36961,0 37043,1 37124,0 37201,1 37249,0 37285,1 37307,0 37333,1 37423,0 37445,1 37482,0 37512,1 37599,0 37684,1 37777,0 37823,1 37842,0 37875,1 37897,0 37947,1 37966,0 38058,1 38093,0 38115,1 38175,0 38259,1 38295,0 38364,1 38458,0 38506,1 38563,0 38632,1 38647,0 38688,1 38704,0 38782,1 38811,0 38867,1 38941,0 39017,1 39093,0 39156,1 39185,0 39209,1 39226,0 39238,1 39320,0 39347,1 39407,0 39490,1 39568,0 39610,1 39625,0 39684,1 39724,0 39811,1 39815,0 39831,1 39840,0 39892,1 39902,0 39931,1 39945,0 40018,1 40065,0 40134,1 40193,0 40195,1 40201,0 40204,1 40304,0 40374,1 40428,0 40454,1 40517,0 40523,1 40602,0 40633,1 40662,0 40745,1 40766,0 40773,1 40791,0 40819,1 40834,0 40933,1 40940,0 40985,1 40988,0 41072,1 41149,0 41166,1 41242,0 41297,1 41323,0 41360,1 41458,0 41475,1 41503,0 41527,1 41596,0 41620,1 41625,0 41631,1 41688,0 41706,1 41728,0 41790,1 41822,0 41831,1 41901,0 41927,1 41950,0 42002,1 42039,0 42090,1 42181,0 42269,1 42280,0 42338,1 42384,0 42442,1 42443,0 42500,1 42563,0 42632,1 42699,0 42765,1 42788,0 42823,1 42853,0 42855,1 42873,0 42892,1 42895,0 42905,1 42951,0 43006,1 43069,0 43091,1 43147,0 43169,1 43219,0 43242,1 43247,0 43282,1 43334,0 43413,1 43469,0 43548,1 43602,0 43650,1 43702,0 43783,1 43796,0 43895,1 43907,0 43918,1 44002,0 44003,1 44102,0 44143,1 44230,0 44308,1 44392,0 44489,1 44585,0 44623,1 44691,0 44772,1 44842,0 44873,1 44898,0 44932,1 44969,0 44997,1 45052,0 45143,1 45167,0 45256,1 45307,0 45375,1 45384,0 45415,1 45490,0 45557,1 45618,0 45638,1 45734,0 45745,1 45812,0 45861,1 45895,0 45971,1 45996,0 46052,1 46099,0 46153,1 46207,0 46272,1 46357,0 46417,1 46465,0 46492,1 46522,0 46539,1 46553,0 46574,1 46636,0 46666,1 46759,0 46820,1 46856,0 46956,1 46963,0 47047,1 47059,0 47076,1 47095,0 47186,1 47244,0 47290,1 47307,0 47351,1 47377,0 47446,1 47452,0 47477,1 47546,0 47575,1 47636,0 47666,1 47672,0 47690,1 47696,0 47760,1 47845,0 47905,1 47985,0 47988,1 48030,0 48068,1 48125,0 48164,1 48202,0 48295,1 48394,0 48464,1 48494,0 48577,1 48579,0 48679,1 48734,0 48752,1 48810,0 48895,1 48913,0 48997,1 49022,0 49091,1 49107,0 49201,1 49263,0 49326,1 49408,0 49462,1 49542,0 49585,1 end initlist b26 0,0 82,1 102,0 141,1 239,0 330,1 401,0 456,1 556,0 564,1 664,0 719,1 807,0 897,1 949,0 1005,1 1101,0 1185,1 1273,0 1319,1 1334,0 1346,1 1428,0 1466,1 1478,0 1485,1 1500,0 1573,1 1641,0 1663,1 1763,0 1804,1 1885,0 1922,1 1990,0 2079,1 2089,0 2100,1 2102,0 2106,1 2199,0 2222,1 2307,0 2351,1 2442,0 2448,1 2529,0 2588,1 2594,0 2606,1 2648,0 2670,1 2742,0 2810,1 2869,0 2942,1 2996,0 3036,1 3082,0 3083,1 3172,0 3223,1 3276,0 3326,1 3424,0 3502,1 3571,0 3573,1 3664,0 3720,1 3785,0 3821,1 3903,0 3907,1 3956,0 4009,1 4034,0 4122,1 4174,0 4253,1 4340,0 4422,1 4426,0 4485,1 4565,0 4625,1 4630,0 4683,1 4727,0 4785,1 4792,0 4804,1 4831,0 4833,1 4886,0 4984,1 5019,0 5046,1 5101,0 5109,1 5168,0 5224,1 5265,0 5352,1 5408,0 5489,1 5552,0 5632,1 5663,0 5681,1 5755,0 5817,1 5859,0 5892,1 5973,0 6037,1 6052,0 6083,1 6121,0 6135,1 6174,0 6257,1 6331,0 6352,1 6402,0 6451,1 6486,0 6569,1 6656,0 6678,1 6723,0 6783,1 6811,0 6875,1 6919,0 7007,1 7064,0 7133,1 7178,0 7246,1 7318,0 7342,1 7350,0 7418,1 7490,0 7579,1 7646,0 7707,1 7713,0 7808,1 7862,0 7897,1 7899,0 7985,1 8054,0 8085,1 8132,0 8199,1 8227,0 8310,1 8392,0 8425,1 8474,0 8493,1 8584,0 8658,1 8717,0 8728,1 8790,0 8883,1 8937,0 8955,1 8984,0 9061,1 9103,0 9137,1 9228,0 9294,1 9355,0 9389,1 9405,0 9442,1 9498,0 9552,1 9644,0 9683,1 9740,0 9820,1 9894,0 9936,1 9961,0 10024,1 10078,0 10102,1 10116,0 10117,1 10134,0 10204,1 10273,0 10283,1 10366,0 10391,1 10417,0 10454,1 10466,0 10548,1 10628,0 10721,1 10802,0 10847,1 10903,0 10958,1 11015,0 11075,1 11078,0 11087,1 11172,0 11266,1 11308,0 11362,1 11408,0 11409,1 11411,0 11484,1 11563,0 11661,1 11727,0 11783,1 11875,0 11911,1 11948,0 11972,1 12003,0 12073,1 12091,0 12160,1 12204,0 12208,1 12298,0 12308,1 12319,0 12381,1 12422,0 12488,1 12575,0 12616,1 12644,0 12695,1 12780,0 12821,1 12895,0 12994,1 13020,0 13115,1 13124,0 13210,1 13310,0 13409,1 13496,0 13509,1 13589,0 13596,1 13674,0 13743,1 13828,0 13888,1 13898,0 13957,1 14021,0 14098,1 14159,0 14249,1 14334,0 14404,1 14473,0 14522,1 14554,0 14574,1 14658,0 14748,1 14825,0 14826,1 14872,0 14968,1 15018,0 15020,1 15023,0 15051,1 15057,0 15147,1 15231,0 15271,1 15299,0 15377,1 15461,0 15557,1 15596,0 15600,1 15700,0 15799,1 15893,0 15951,1 15974,0 16059,1 16127,0 16139,1 16184,0 16230,1 16329,0 16331,1 16388,0 16408,1 16472,0 16563,1 16578,0 16624,1 16680,0 16764,1 16830,0 16871,1 16889,0 16978,1 16985,0 17071,1 17163,0 17208,1 17252,0 17290,1 17332,0 17371,1 17435,0 17443,1 17477,0 17531,1 17602,0 17682,1 17715,0 17783,1 17854,0 17934,1 17947,0 18047,1 18051,0 18109,1 18152,0 18183,1 18283,0 18289,1 18339,0 18399,1 18453,0 18492,1 18503,0 18591,1 18633,0 18668,1 18672,0 18692,1 18703,0 18726,1 18746,0 18788,1 18798,0 18897,1 18913,0 19012,1 19067,0 19151,1 19238,0 19252,1 19271,0 19276,1 19316,0 19396,1 19461,0 19540,1 19606,0 19623,1 19636,0 19680,1 19747,0 19785,1 19818,0 19826,1 19877,0 19890,1 19953,0 19986,1 20044,0 20110,1 20177,0 20248,1 20345,0 20388,1 20481,0 20552,1 20640,0 20648,1 20722,0 20816,1 20835,0 20888,1 20947,0 21021,1 21064,0 21116,1 21208,0 21265,1 21310,0 21346,1 21412,0 21452,1 21534,0 21594,1 21644,0 21731,1 21808,0 21898,1 21960,0 21999,1 22047,0 22056,1 22092,0 22153,1 22240,0 22331,1 22357,0 22449,1 22505,0 22576,1 22612,0 22674,1 22702,0 22766,1 22777,0 22809,1 22822,0 22883,1 22937,0 22942,1 22983,0 23037,1 23042,0 23046,1 23054,0 23057,1 23145,0 23236,1 23314,0 23349,1 23377,0 23418,1 23428,0 23500,1 23590,0 23680,1 23777,0 23809,1 23864,0 23875,1 23930,0 23962,1 23984,0 24022,1 24092,0 24102,1 24160,0 24182,1 24220,0 24252,1 24319,0 24340,1 24427,0 24464,1 24491,0 24543,1 24583,0 24587,1 24644,0 24677,1 24705,0 24756,1 24764,0 24859,1 24886,0 24970,1 24979,0 25062,1 25148,0 25184,1 25206,0 25262,1 25345,0 25351,1 25362,0 25382,1 25470,0 25545,1 25623,0 25644,1 25693,0 25697,1 25785,0 25810,1 25820,0 25872,1 25890,0 25971,1 26067,0 26097,1 26161,0 26228,1 26247,0 26310,1 26330,0 26369,1 26400,0 26414,1 26447,0 26456,1 26508,0 26541,1 26543,0 26603,1 26658,0 26740,1 26759,0 26833,1 26894,0 26957,1 26998,0 27083,1 27088,0 27108,1 27147,0 27167,1 27246,0 27342,1 27421,0 27438,1 27538,0 27609,1 27640,0 27679,1 27720,0 27761,1 27811,0 27832,1 27906,0 27980,1 28043,0 28096,1 28161,0 28260,1 28281,0 28358,1 28385,0 28447,1 28539,0 28598,1 28629,0 28642,1 28662,0 28695,1 28745,0 28760,1 28859,0 28884,1 28931,0 28938,1 29012,0 29069,1 29129,0 29220,1 29301,0 29366,1 29436,0 29509,1 29600,0 29601,1 29698,0 29748,1 29809,0 29884,1 29910,0 29963,1 30011,0 30038,1 30081,0 30163,1 30178,0 30208,1 30265,0 30352,1 30423,0 30449,1 30455,0 30506,1 30528,0 30569,1 30603,0 30610,1 30666,0 30744,1 30831,0 30920,1 30993,0 30996,1 31092,0 31120,1 31194,0 31269,1 31325,0 31333,1 31425,0 31466,1 31544,0 31551,1 31625,0 31649,1 31692,0 31770,1 31842,0 31886,1 31925,0 31993,1 32022,0 32115,1 32169,0 32219,1 32241,0 32331,1 32417,0 32436,1 32464,0 32513,1 32524,0 32544,1 32556,0 32624,1 32687,0 32743,1 32783,0 32850,1 32909,0 32929,1 33001,0 33037,1 33079,0 33097,1 33153,0 33194,1 33288,0 33322,1 33347,0 33383,1 33459,0 33493,1 33562,0 33620,1 33651,0 33730,1 33816,0 33899,1 33985,0 34005,1 34080,0 34089,1 34135,0 34170,1 34268,0 34296,1 34343,0 34433,1 34533,0 34574,1 34629,0 34694,1 34746,0 34793,1 34797,0 34896,1 34957,0 35010,1 35106,0 35167,1 35214,0 35220,1 35309,0 35351,1 35431,0 35433,1 35461,0 35494,1 35546,0 35610,1 35654,0 35725,1 35754,0 35795,1 35831,0 35904,1 35967,0 36012,1 36060,0 36147,1 36193,0 36283,1 36316,0 36372,1 36384,0 36418,1 36443,0 36476,1 36534,0 36549,1 36645,0 36717,1 36784,0 36862,1 36942,0 37028,1 37038,0 37069,1 37073,0 37136,1 37158,0 37240,1 37270,0 37350,1 37359,0 37375,1 37433,0 37502,1 37536,0 37544,1 37563,0 37616,1 37653,0 37691,1 37768,0 37805,1 37894,0 37955,1 37959,0 38004,1 38027,0 38054,1 38133,0 38222,1 38297,0 38359,1 38416,0 38482,1 38510,0 38593,1 38679,0 38688,1 38716,0 38754,1 38841,0 38880,1 38978,0 39019,1 39034,0 39056,1 39147,0 39244,1 39248,0 39275,1 39314,0 39328,1 39354,0 39363,1 39377,0 39403,1 39465,0 39539,1 39630,0 39659,1 39738,0 39769,1 39804,0 39893,1 39984,0 40017,1 40060,0 40092,1 40102,0 40178,1 40220,0 40282,1 40375,0 40475,1 40559,0 40617,1 40686,0 40765,1 40814,0 40861,1 40887,0 40929,1 40981,0 41035,1 41127,0 41151,1 41238,0 41281,1 41368,0 41371,1 41383,0 41458,1 41508,0 41558,1 41615,0 41674,1 41717,0 41758,1 41807,0 41850,1 41876,0 41892,1 41931,0 41995,1 41997,0 42019,1 42064,0 42130,1 42204,0 42273,1 42308,0 42349,1 42420,0 42462,1 42541,0 42606,1 42689,0 42696,1 42755,0 42782,1 42869,0 42965,1 43030,0 43081,1 43149,0 43189,1 43274,0 43325,1 43351,0 43430,1 43460,0 43474,1 43527,0 43574,1 43671,0 43682,1 43709,0 43763,1 43862,0 43948,1 43995,0 44058,1 44151,0 44251,1 44274,0 44350,1 44429,0 44442,1 44531,0 44582,1 44631,0 44659,1 44674,0 44762,1 44833,0 44896,1 44990,0 45086,1 45122,0 45172,1 45198,0 45204,1 45290,0 45361,1 45461,0 45547,1 45605,0 45693,1 45700,0 45797,1 45894,0 45940,1 45983,0 46065,1 46142,0 46150,1 46156,0 46209,1 46283,0 46364,1 46427,0 46460,1 46531,0 46604,1 46700,0 46777,1 46834,0 46906,1 46962,0 47007,1 47064,0 47099,1 47167,0 47235,1 47254,0 47308,1 47339,0 47356,1 47377,0 47454,1 47476,0 47571,1 47649,0 47666,1 47728,0 47755,1 47833,0 47866,1 47935,0 48006,1 48042,0 48093,1 48160,0 48170,1 48267,0 48323,1 48349,0 48428,1 48463,0 48561,1 48571,0 48600,1 48634,0 48722,1 48761,0 48785,1 48824,0 48875,1 48879,0 48946,1 49046,0 49064,1 49145,0 49151,1 49215,0 49275,1 49335,0 49399,1 49431,0 49507,1 49580,0 49586,1 49603,0 49656,1 49685,0 49716,1 49742,0 49767,1 49847,0 49924,1 49944,0 50015,1 50020,0 50076,1 50093,0 50150,1 50203,0 50244,1 50281,0 50309,1 50352,0 50379,1 50386,0 50482,1 50541,0 50543,1 50577,0 50606,1 50703,0 50721,1 50794,0 50814,1 50845,0 50922,1 51000,0 51036,1 51076,0 51105,1 51202,0 51234,1 51316,0 51354,1 end initlist b27 0,0 63,1 116,0 146,1 152,0 252,1 299,0 374,1 380,0 447,1 450,0 546,1 618,0 624,1 628,0 646,1 702,0 720,1 810,0 897,1 936,0 992,1 1008,0 1054,1 1124,0 1170,1 1177,0 1256,1 1291,0 1386,1 1462,0 1552,1 1577,0 1606,1 1608,0 1681,1 1694,0 1713,1 1775,0 1860,1 1870,0 1876,1 1894,0 1911,1 1941,0 2035,1 2073,0 2141,1 2188,0 2263,1 2345,0 2425,1 2493,0 2523,1 2578,0 2579,1 2618,0 2691,1 2789,0 2864,1 2928,0 2941,1 2943,0 2986,1 3053,0 3140,1 3156,0 3208,1 3287,0 3383,1 3455,0 3464,1 3508,0 3527,1 3580,0 3616,1 3669,0 3716,1 3775,0 3785,1 3841,0 3845,1 3852,0 3906,1 3976,0 4058,1 4137,0 4184,1 4245,0 4278,1 4372,0 4461,1 4488,0 4491,1 4493,0 4515,1 4552,0 4596,1 4606,0 4670,1 4758,0 4764,1 4799,0 4875,1 4941,0 5034,1 5075,0 5136,1 5165,0 5260,1 5349,0 5375,1 5464,0 5484,1 5543,0 5579,1 5657,0 5685,1 5774,0 5818,1 5897,0 5901,1 5993,0 6043,1 6059,0 6141,1 6205,0 6275,1 6354,0 6447,1 6520,0 6525,1 6569,0 6666,1 6710,0 6766,1 6848,0 6941,1 6965,0 7019,1 7021,0 7083,1 7170,0 7219,1 7292,0 7367,1 7442,0 7472,1 7567,0 7648,1 7736,0 7737,1 7824,0 7923,1 7941,0 8030,1 8043,0 8069,1 8098,0 8129,1 8176,0 8179,1 8246,0 8251,1 8253,0 8273,1 8304,0 8317,1 8320,0 8393,1 8398,0 8445,1 8479,0 8518,1 8559,0 8634,1 8729,0 8775,1 8813,0 8889,1 8904,0 8957,1 8962,0 9029,1 9038,0 9124,1 9205,0 9248,1 9321,0 9340,1 9435,0 9480,1 9577,0 9601,1 9603,0 9642,1 9674,0 9696,1 9781,0 9827,1 9834,0 9849,1 9900,0 9938,1 10010,0 10024,1 10075,0 10136,1 10146,0 10199,1 10287,0 10304,1 10399,0 10449,1 10524,0 10546,1 10567,0 10613,1 10694,0 10750,1 10782,0 10879,1 10904,0 10968,1 11046,0 11082,1 11123,0 11170,1 11241,0 11287,1 11328,0 11372,1 11450,0 11475,1 11559,0 11572,1 11626,0 11666,1 11691,0 11755,1 11839,0 11902,1 11993,0 12092,1 12137,0 12228,1 12324,0 12341,1 12405,0 12431,1 12482,0 12521,1 12604,0 12641,1 12648,0 12670,1 12757,0 12765,1 12768,0 12803,1 12816,0 12907,1 12981,0 13006,1 13068,0 13115,1 13139,0 13196,1 13223,0 13291,1 13352,0 13414,1 13431,0 13442,1 13464,0 13535,1 13615,0 13636,1 13665,0 13685,1 13686,0 13714,1 13774,0 13815,1 13901,0 13950,1 13968,0 13993,1 14016,0 14021,1 14100,0 14187,1 14266,0 14349,1 14417,0 14512,1 14596,0 14646,1 14671,0 14761,1 14764,0 14862,1 14917,0 14936,1 15031,0 15041,1 15139,0 15165,1 15243,0 15297,1 15387,0 15390,1 15454,0 15547,1 15590,0 15657,1 15697,0 15704,1 15736,0 15738,1 15739,0 15747,1 15795,0 15843,1 15875,0 15878,1 15971,0 16056,1 16146,0 16164,1 16221,0 16315,1 16333,0 16343,1 16425,0 16459,1 16480,0 16563,1 16586,0 16628,1 16634,0 16733,1 16809,0 16847,1 16895,0 16922,1 16923,0 16939,1 17030,0 17112,1 17154,0 17217,1 17279,0 17352,1 17373,0 17399,1 17470,0 17501,1 17545,0 17557,1 17611,0 17629,1 17710,0 17770,1 17810,0 17822,1 17829,0 17861,1 17941,0 18017,1 18111,0 18169,1 18219,0 18246,1 18333,0 18372,1 18466,0 18482,1 18497,0 18557,1 18560,0 18586,1 18609,0 18640,1 18694,0 18701,1 18762,0 18827,1 18893,0 18933,1 18936,0 18952,1 19052,0 19130,1 19207,0 19229,1 19306,0 19373,1 19446,0 19481,1 19563,0 19662,1 19672,0 19724,1 19738,0 19757,1 19837,0 19842,1 19858,0 19937,1 19981,0 20026,1 20088,0 20134,1 20138,0 20217,1 20315,0 20405,1 20451,0 20488,1 20563,0 20574,1 20631,0 20653,1 20748,0 20781,1 20839,0 20868,1 20898,0 20929,1 20943,0 21026,1 21055,0 21101,1 21143,0 21200,1 21223,0 21269,1 21291,0 21308,1 21328,0 21344,1 21372,0 21409,1 21452,0 21480,1 21568,0 21596,1 21624,0 21628,1 21639,0 21738,1 21743,0 21841,1 21877,0 21958,1 22015,0 22099,1 22140,0 22227,1 22274,0 22349,1 22398,0 22426,1 22502,0 22546,1 22556,0 22635,1 22729,0 22768,1 22840,0 22867,1 22932,0 23031,1 23104,0 23187,1 23202,0 23262,1 23339,0 23405,1 23427,0 23441,1 23466,0 23539,1 23587,0 23596,1 23610,0 23637,1 23671,0 23699,1 23799,0 23838,1 23866,0 23887,1 23983,0 24064,1 24070,0 24147,1 24169,0 24221,1 24235,0 24325,1 24386,0 24392,1 24411,0 24460,1 24514,0 24535,1 24541,0 24542,1 24587,0 24613,1 24708,0 24757,1 24804,0 24901,1 24966,0 25008,1 25029,0 25051,1 25148,0 25248,1 25328,0 25356,1 25382,0 25438,1 25509,0 25545,1 25546,0 25589,1 25604,0 25692,1 25769,0 25811,1 25815,0 25904,1 25960,0 26014,1 26100,0 26200,1 26201,0 26249,1 26268,0 26340,1 26438,0 26484,1 26504,0 26592,1 26640,0 26678,1 26704,0 26719,1 26721,0 26806,1 26898,0 26987,1 27082,0 27145,1 27152,0 27186,1 27213,0 27302,1 27361,0 27436,1 27479,0 27487,1 27496,0 27564,1 27607,0 27692,1 27709,0 27773,1 27781,0 27827,1 27831,0 27887,1 27953,0 28042,1 28088,0 28171,1 28191,0 28276,1 28303,0 28388,1 28459,0 28496,1 28560,0 28582,1 28626,0 28656,1 28710,0 28733,1 28744,0 28815,1 28880,0 28945,1 28989,0 29069,1 29090,0 29182,1 29257,0 29300,1 29394,0 29420,1 29475,0 29480,1 29497,0 29580,1 29659,0 29662,1 29753,0 29842,1 29868,0 29905,1 29918,0 29921,1 29957,0 30034,1 30121,0 30217,1 30247,0 30320,1 30328,0 30368,1 30413,0 30508,1 30567,0 30579,1 30594,0 30664,1 30721,0 30729,1 30827,0 30834,1 30881,0 30898,1 30949,0 31001,1 31071,0 31111,1 31180,0 31233,1 31318,0 31335,1 31390,0 31482,1 31516,0 31589,1 31598,0 31697,1 31793,0 31836,1 31895,0 31939,1 31946,0 32046,1 32114,0 32200,1 32255,0 32350,1 32423,0 32456,1 32531,0 32542,1 32621,0 32635,1 32681,0 32706,1 32788,0 32876,1 32930,0 32969,1 33012,0 33112,1 33149,0 33163,1 33214,0 33296,1 33338,0 33437,1 33445,0 33486,1 33550,0 33619,1 33651,0 33697,1 33767,0 33773,1 33851,0 33889,1 33978,0 34072,1 34091,0 34125,1 34168,0 34210,1 34272,0 34309,1 34382,0 34390,1 34459,0 34553,1 34631,0 34650,1 34700,0 34750,1 34800,0 34887,1 34945,0 34958,1 34994,0 35018,1 35031,0 35105,1 35131,0 35192,1 35277,0 35309,1 35403,0 35460,1 35488,0 35577,1 35643,0 35695,1 35791,0 35881,1 35921,0 36002,1 36075,0 36174,1 36248,0 36342,1 36402,0 36427,1 36431,0 36498,1 36557,0 36629,1 36689,0 36719,1 36773,0 36805,1 36889,0 36985,1 37063,0 37127,1 37134,0 37148,1 37237,0 37262,1 37358,0 37448,1 37496,0 37569,1 37630,0 37723,1 37780,0 37832,1 37877,0 37975,1 37988,0 38072,1 38098,0 38155,1 38245,0 38308,1 38353,0 38451,1 38546,0 38548,1 38606,0 38629,1 38649,0 38684,1 38737,0 38749,1 38819,0 38853,1 38948,0 39000,1 39037,0 39137,1 39157,0 39170,1 39217,0 39225,1 39251,0 39270,1 39365,0 39433,1 39507,0 39607,1 39705,0 39785,1 39855,0 39939,1 40008,0 40066,1 40117,0 40164,1 40234,0 40249,1 40302,0 40361,1 40459,0 40556,1 40655,0 40738,1 40810,0 40820,1 40826,0 40892,1 40980,0 40982,1 41056,0 41128,1 41178,0 41234,1 41295,0 41359,1 41450,0 41537,1 41631,0 41663,1 41753,0 41775,1 41855,0 41863,1 41899,0 41918,1 41974,0 42000,1 42083,0 42175,1 42182,0 42211,1 42288,0 42349,1 42434,0 42511,1 42608,0 42676,1 42776,0 42822,1 42828,0 42855,1 42901,0 42906,1 42916,0 42927,1 43016,0 43050,1 43062,0 43103,1 43196,0 43266,1 43331,0 43402,1 43483,0 43530,1 43578,0 43585,1 43612,0 43706,1 43716,0 43762,1 43776,0 43809,1 43885,0 43912,1 43957,0 44044,1 44130,0 44189,1 44278,0 44316,1 44367,0 44399,1 44446,0 44488,1 44538,0 44609,1 44700,0 44796,1 44825,0 44891,1 44909,0 44986,1 45068,0 45155,1 45166,0 45258,1 45291,0 45356,1 45419,0 45508,1 45570,0 45616,1 45671,0 45726,1 45784,0 45801,1 45883,0 45958,1 45962,0 46002,1 46092,0 46178,1 46239,0 46247,1 46274,0 46359,1 46450,0 46484,1 46530,0 46589,1 46681,0 46687,1 46761,0 46809,1 46900,0 46938,1 46971,0 46984,1 47058,0 47115,1 47206,0 47279,1 47318,0 47418,1 47505,0 47569,1 47598,0 47629,1 47640,0 47678,1 47696,0 47775,1 47853,0 47857,1 47954,0 48038,1 48057,0 48082,1 48083,0 48157,1 48193,0 48291,1 48309,0 48362,1 48363,0 48376,1 48409,0 48414,1 48497,0 48508,1 48569,0 48616,1 48639,0 48679,1 48727,0 48763,1 48782,0 48861,1 48938,0 49020,1 49057,0 49113,1 49199,0 49268,1 49346,0 49374,1 49443,0 49445,1 49512,0 49569,1 49602,0 49648,1 49701,0 49777,1 49820,0 49887,1 49973,0 50010,1 50091,0 50120,1 50199,0 50282,1 50351,0 50426,1 50436,0 50473,1 50485,0 50527,1 50548,0 50598,1 50692,0 50713,1 50791,0 50849,1 50864,0 50880,1 end initlist b28 0,0 63,1 67,0 94,1 102,0 174,1 192,0 280,1 348,0 413,1 417,0 494,1 537,0 617,1 684,0 764,1 805,0 862,1 907,0 921,1 1006,0 1055,1 1101,0 1152,1 1158,0 1164,1 1186,0 1223,1 1263,0 1277,1 1345,0 1384,1 1418,0 1503,1 1554,0 1597,1 1619,0 1636,1 1664,0 1721,1 1753,0 1847,1 1850,0 1882,1 1927,0 1964,1 2053,0 2073,1 2115,0 2188,1 2242,0 2269,1 2316,0 2404,1 2487,0 2544,1 2554,0 2617,1 2715,0 2789,1 2863,0 2963,1 3039,0 3098,1 3113,0 3125,1 3191,0 3231,1 3260,0 3282,1 3341,0 3439,1 3535,0 3581,1 3585,0 3632,1 3724,0 3780,1 3806,0 3817,1 3888,0 3917,1 4012,0 4013,1 4036,0 4129,1 4188,0 4214,1 4241,0 4298,1 4387,0 4453,1 4517,0 4605,1 4687,0 4691,1 4699,0 4706,1 4805,0 4827,1 4865,0 4942,1 5036,0 5124,1 5125,0 5183,1 5226,0 5319,1 5335,0 5391,1 5434,0 5528,1 5539,0 5607,1 5674,0 5746,1 5788,0 5792,1 5839,0 5937,1 6014,0 6085,1 6158,0 6192,1 6224,0 6241,1 6310,0 6373,1 6440,0 6539,1 6608,0 6669,1 6740,0 6832,1 6857,0 6869,1 6936,0 7029,1 7032,0 7099,1 7161,0 7200,1 7293,0 7343,1 7432,0 7521,1 7556,0 7614,1 7619,0 7672,1 7694,0 7742,1 7818,0 7846,1 7875,0 7946,1 7962,0 7982,1 8029,0 8056,1 8070,0 8078,1 8130,0 8195,1 8210,0 8249,1 8288,0 8309,1 8330,0 8381,1 8431,0 8502,1 8572,0 8669,1 8748,0 8792,1 8809,0 8847,1 8925,0 8962,1 8966,0 9046,1 9055,0 9142,1 9189,0 9239,1 9320,0 9342,1 9354,0 9441,1 9468,0 9474,1 9544,0 9600,1 9615,0 9627,1 9630,0 9639,1 9681,0 9710,1 9809,0 9844,1 9849,0 9927,1 10021,0 10027,1 10078,0 10148,1 10172,0 10181,1 10184,0 10273,1 10350,0 10351,1 10440,0 10452,1 10487,0 10580,1 10605,0 10630,1 10710,0 10763,1 10828,0 10885,1 10887,0 10921,1 10935,0 11009,1 11075,0 11126,1 11196,0 11288,1 11369,0 11395,1 11421,0 11505,1 11506,0 11567,1 11575,0 11607,1 11635,0 11662,1 11720,0 11789,1 11853,0 11931,1 11963,0 12032,1 12099,0 12119,1 12180,0 12194,1 12248,0 12292,1 12332,0 12416,1 12448,0 12502,1 12540,0 12632,1 12636,0 12670,1 12706,0 12712,1 12808,0 12822,1 12838,0 12888,1 12898,0 12996,1 13056,0 13078,1 13177,0 13225,1 13233,0 13275,1 13287,0 13328,1 13403,0 13463,1 13488,0 13551,1 13558,0 13633,1 13650,0 13686,1 13781,0 13838,1 13902,0 13959,1 13987,0 14035,1 14072,0 14168,1 14239,0 14333,1 14404,0 14445,1 14484,0 14500,1 14513,0 14569,1 14644,0 14683,1 14745,0 14769,1 14783,0 14843,1 14920,0 14934,1 14960,0 15028,1 15096,0 15098,1 15116,0 15200,1 15283,0 15367,1 15383,0 15472,1 15553,0 15561,1 15590,0 15680,1 15745,0 15751,1 15847,0 15873,1 15913,0 16013,1 16090,0 16120,1 16151,0 16183,1 16267,0 16367,1 16463,0 16558,1 16626,0 16719,1 16785,0 16875,1 16903,0 16931,1 16987,0 17033,1 17123,0 17198,1 17239,0 17303,1 17382,0 17428,1 17483,0 17525,1 17548,0 17599,1 17614,0 17627,1 17713,0 17717,1 17812,0 17854,1 17925,0 17951,1 18009,0 18079,1 18172,0 18265,1 18334,0 18389,1 18427,0 18429,1 18519,0 18527,1 18559,0 18564,1 18596,0 18627,1 18697,0 18701,1 18707,0 18781,1 18803,0 18813,1 18831,0 18837,1 18930,0 18952,1 18954,0 18973,1 19042,0 19139,1 19153,0 19194,1 19219,0 19245,1 19276,0 19319,1 19349,0 19374,1 19439,0 19465,1 19532,0 19601,1 19652,0 19736,1 19772,0 19800,1 19805,0 19821,1 19861,0 19903,1 19933,0 19990,1 20088,0 20156,1 20214,0 20253,1 20326,0 20343,1 20405,0 20434,1 20453,0 20493,1 20499,0 20569,1 20652,0 20745,1 20844,0 20918,1 20925,0 20935,1 20987,0 21002,1 21080,0 21146,1 21177,0 21221,1 21256,0 21286,1 21369,0 21467,1 21491,0 21550,1 21577,0 21662,1 21707,0 21773,1 21850,0 21911,1 21936,0 22030,1 22041,0 22066,1 22143,0 22213,1 22266,0 22297,1 22366,0 22370,1 22378,0 22425,1 22448,0 22499,1 22542,0 22629,1 22671,0 22757,1 22793,0 22800,1 22840,0 22881,1 22900,0 22921,1 22978,0 23019,1 23069,0 23123,1 23166,0 23247,1 23308,0 23405,1 23503,0 23572,1 23643,0 23667,1 23738,0 23782,1 23844,0 23939,1 23950,0 24028,1 24121,0 24175,1 24247,0 24314,1 24412,0 24420,1 24459,0 24467,1 24487,0 24557,1 24657,0 24745,1 24746,0 24757,1 24836,0 24933,1 25021,0 25072,1 25156,0 25214,1 25239,0 25336,1 25355,0 25438,1 25466,0 25519,1 25581,0 25661,1 25671,0 25673,1 25678,0 25694,1 25777,0 25812,1 25912,0 25918,1 25928,0 25938,1 26032,0 26056,1 26133,0 26182,1 26277,0 26325,1 26372,0 26373,1 26467,0 26563,1 26575,0 26605,1 26631,0 26703,1 26766,0 26775,1 26845,0 26914,1 26964,0 26979,1 27070,0 27156,1 27167,0 27237,1 27324,0 27335,1 27340,0 27398,1 27462,0 27467,1 27511,0 27537,1 27539,0 27540,1 27551,0 27566,1 27602,0 27609,1 27672,0 27756,1 27806,0 27905,1 27945,0 27999,1 28066,0 28112,1 28189,0 28233,1 28323,0 28379,1 28413,0 28476,1 28527,0 28544,1 28603,0 28655,1 28693,0 28746,1 28766,0 28851,1 28887,0 28932,1 28988,0 29033,1 29055,0 29066,1 29133,0 29221,1 29256,0 29332,1 29420,0 29469,1 29560,0 29579,1 29632,0 29682,1 29781,0 29881,1 29890,0 29970,1 30032,0 30125,1 30152,0 30224,1 30283,0 30285,1 30290,0 30307,1 30391,0 30404,1 30445,0 30524,1 30538,0 30582,1 30645,0 30688,1 30761,0 30847,1 30900,0 30930,1 31009,0 31019,1 31029,0 31083,1 31104,0 31178,1 31209,0 31242,1 31327,0 31381,1 31426,0 31501,1 31535,0 31536,1 31602,0 31620,1 31673,0 31695,1 31706,0 31785,1 31833,0 31855,1 31939,0 31941,1 32024,0 32067,1 32157,0 32180,1 32265,0 32312,1 32324,0 32416,1 32493,0 32573,1 32644,0 32722,1 32765,0 32835,1 32874,0 32911,1 32923,0 32984,1 33025,0 33039,1 33052,0 33085,1 33174,0 33226,1 33316,0 33360,1 33390,0 33425,1 33510,0 33536,1 33547,0 33600,1 33667,0 33703,1 33780,0 33821,1 33880,0 33936,1 34021,0 34080,1 34088,0 34143,1 34180,0 34193,1 34211,0 34290,1 34318,0 34336,1 34401,0 34500,1 34501,0 34559,1 34563,0 34650,1 34721,0 34807,1 34880,0 34885,1 34951,0 35013,1 35082,0 35127,1 35129,0 35218,1 35265,0 35361,1 35419,0 35458,1 35542,0 35586,1 35619,0 35672,1 35716,0 35752,1 35814,0 35843,1 35927,0 35968,1 36063,0 36130,1 36217,0 36299,1 36383,0 36419,1 36436,0 36447,1 36481,0 36546,1 36613,0 36677,1 36742,0 36769,1 36844,0 36932,1 36946,0 37039,1 37102,0 37136,1 37232,0 37289,1 37348,0 37408,1 37452,0 37484,1 37563,0 37659,1 37669,0 37750,1 37760,0 37826,1 37880,0 37969,1 38022,0 38065,1 38137,0 38172,1 38188,0 38246,1 38319,0 38381,1 38439,0 38527,1 38608,0 38656,1 38751,0 38842,1 38915,0 38943,1 39024,0 39086,1 39183,0 39246,1 39320,0 39415,1 39510,0 39554,1 39571,0 39643,1 39728,0 39822,1 39824,0 39887,1 39949,0 40043,1 40069,0 40100,1 40151,0 40182,1 40224,0 40265,1 40323,0 40378,1 40471,0 40492,1 40563,0 40628,1 40691,0 40702,1 40753,0 40787,1 40836,0 40927,1 41004,0 41059,1 41153,0 41184,1 41191,0 41273,1 41360,0 41429,1 41433,0 41519,1 41558,0 41613,1 41673,0 41731,1 41764,0 41838,1 41901,0 41925,1 42000,0 42038,1 42102,0 42123,1 42187,0 42264,1 42334,0 42410,1 42422,0 42449,1 42532,0 42537,1 42547,0 42568,1 42577,0 42657,1 42659,0 42723,1 42776,0 42871,1 42875,0 42888,1 42970,0 43038,1 43116,0 43156,1 43229,0 43321,1 43350,0 43414,1 43487,0 43497,1 43567,0 43659,1 43719,0 43738,1 43812,0 43827,1 43922,0 43990,1 44020,0 44027,1 44085,0 44104,1 44115,0 44197,1 44214,0 44242,1 44292,0 44338,1 44393,0 44485,1 44541,0 44552,1 44621,0 44704,1 44772,0 44797,1 44811,0 44893,1 44959,0 44966,1 45063,0 45117,1 45149,0 45216,1 45248,0 45338,1 45387,0 45438,1 45463,0 45483,1 45542,0 45631,1 45689,0 45733,1 45803,0 45858,1 45919,0 45963,1 46026,0 46034,1 46069,0 46074,1 46118,0 46183,1 46271,0 46296,1 46344,0 46352,1 46412,0 46446,1 46502,0 46591,1 46647,0 46654,1 46720,0 46813,1 46888,0 46929,1 46954,0 46994,1 47005,0 47013,1 47104,0 47122,1 47192,0 47287,1 47320,0 47370,1 47430,0 47445,1 47497,0 47498,1 47560,0 47617,1 47663,0 47757,1 47783,0 47874,1 47927,0 47964,1 47984,0 48080,1 48131,0 48146,1 48230,0 48246,1 48308,0 48375,1 48378,0 48427,1 48518,0 48608,1 48671,0 48734,1 48738,0 48832,1 48871,0 48944,1 49032,0 49094,1 49104,0 49174,1 49260,0 49275,1 49316,0 49386,1 49415,0 49422,1 49455,0 49475,1 49569,0 49585,1 49669,0 49750,1 49849,0 49906,1 49969,0 50057,1 50122,0 50176,1 50212,0 50264,1 50363,0 50429,1 50500,0 50548,1 end initlist b29 0,0 96,1 183,0 188,1 234,0 314,1 395,0 433,1 489,0 553,1 572,0 581,1 667,0 759,1 845,0 919,1 977,0 1030,1 1113,0 1174,1 1242,0 1266,1 1346,0 1363,1 1404,0 1471,1 1498,0 1507,1 1562,0 1594,1 1604,0 1700,1 1785,0 1843,1 1901,0 1975,1 1993,0 2065,1 2155,0 2209,1 2247,0 2295,1 2371,0 2439,1 2476,0 2530,1 2550,0 2625,1 2640,0 2694,1 2732,0 2823,1 2829,0 2916,1 2993,0 3015,1 3017,0 3110,1 3128,0 3179,1 3201,0 3244,1 3293,0 3390,1 3484,0 3530,1 3574,0 3648,1 3689,0 3698,1 3699,0 3733,1 3793,0 3798,1 3878,0 3901,1 3914,0 3982,1 4027,0 4065,1 4112,0 4159,1 4210,0 4272,1 4361,0 4425,1 4500,0 4588,1 4595,0 4601,1 4611,0 4698,1 4790,0 4834,1 4871,0 4903,1 4993,0 5092,1 5146,0 5194,1 5207,0 5241,1 5336,0 5341,1 5376,0 5379,1 5452,0 5515,1 5603,0 5695,1 5734,0 5781,1 5810,0 5873,1 5876,0 5963,1 6007,0 6017,1 6076,0 6128,1 6167,0 6173,1 6205,0 6220,1 6290,0 6367,1 6429,0 6516,1 6599,0 6640,1 6663,0 6686,1 6702,0 6801,1 6895,0 6961,1 6965,0 6973,1 7049,0 7091,1 7135,0 7206,1 7231,0 7264,1 7318,0 7408,1 7432,0 7520,1 7599,0 7636,1 7700,0 7735,1 7803,0 7852,1 7948,0 8047,1 8094,0 8119,1 8120,0 8212,1 8259,0 8298,1 8383,0 8411,1 8457,0 8492,1 8522,0 8615,1 8627,0 8675,1 8678,0 8681,1 8728,0 8818,1 8843,0 8883,1 8901,0 8915,1 8970,0 9018,1 9076,0 9152,1 9232,0 9256,1 9285,0 9343,1 9389,0 9431,1 9530,0 9536,1 9582,0 9632,1 9716,0 9762,1 9861,0 9946,1 10022,0 10036,1 10092,0 10095,1 10154,0 10234,1 10325,0 10329,1 10355,0 10387,1 10407,0 10458,1 10499,0 10586,1 10589,0 10648,1 10669,0 10729,1 10762,0 10771,1 10778,0 10834,1 10873,0 10949,1 10956,0 10970,1 11026,0 11088,1 11149,0 11245,1 11336,0 11376,1 11395,0 11457,1 11507,0 11594,1 11665,0 11672,1 11684,0 11774,1 11779,0 11879,1 11947,0 11952,1 12022,0 12073,1 12107,0 12154,1 12194,0 12279,1 12353,0 12396,1 12450,0 12541,1 12580,0 12603,1 12665,0 12706,1 12707,0 12773,1 12810,0 12897,1 12952,0 13027,1 13048,0 13129,1 13190,0 13192,1 13228,0 13238,1 13242,0 13302,1 13339,0 13395,1 13419,0 13500,1 13508,0 13603,1 13650,0 13741,1 13761,0 13854,1 13898,0 13965,1 13982,0 14063,1 14117,0 14204,1 14290,0 14327,1 14349,0 14412,1 14480,0 14490,1 14559,0 14621,1 14665,0 14679,1 14729,0 14774,1 14848,0 14885,1 14958,0 15041,1 15125,0 15145,1 15158,0 15236,1 15273,0 15348,1 15436,0 15446,1 15476,0 15509,1 15558,0 15607,1 15701,0 15753,1 15821,0 15828,1 15874,0 15936,1 16020,0 16089,1 16094,0 16167,1 16236,0 16329,1 16427,0 16434,1 16499,0 16569,1 16628,0 16715,1 16740,0 16753,1 16762,0 16844,1 16862,0 16912,1 16983,0 17032,1 17081,0 17144,1 17233,0 17283,1 17293,0 17385,1 17389,0 17488,1 17519,0 17559,1 17634,0 17706,1 17759,0 17804,1 17861,0 17929,1 17962,0 18015,1 18067,0 18100,1 18124,0 18219,1 18300,0 18368,1 18438,0 18486,1 18498,0 18574,1 18582,0 18623,1 18708,0 18797,1 18801,0 18896,1 18962,0 19001,1 19027,0 19081,1 19170,0 19205,1 19244,0 19256,1 19343,0 19438,1 19487,0 19544,1 19605,0 19641,1 19673,0 19740,1 19825,0 19829,1 19851,0 19902,1 19965,0 20012,1 20056,0 20142,1 20211,0 20281,1 20367,0 20450,1 20537,0 20546,1 20575,0 20587,1 20641,0 20682,1 20686,0 20724,1 20742,0 20806,1 20874,0 20969,1 20981,0 21026,1 21063,0 21077,1 21087,0 21153,1 21238,0 21336,1 21374,0 21418,1 21467,0 21493,1 21502,0 21566,1 21584,0 21617,1 21647,0 21663,1 21744,0 21833,1 21901,0 21959,1 22025,0 22122,1 22171,0 22269,1 22279,0 22375,1 22411,0 22458,1 22465,0 22520,1 22526,0 22546,1 22641,0 22671,1 22762,0 22766,1 22849,0 22859,1 22946,0 22999,1 23034,0 23075,1 23092,0 23141,1 23156,0 23160,1 23167,0 23181,1 23232,0 23234,1 23319,0 23360,1 23418,0 23468,1 23563,0 23604,1 23687,0 23785,1 23791,0 23877,1 23912,0 23928,1 24018,0 24064,1 24074,0 24149,1 24227,0 24316,1 24335,0 24418,1 24442,0 24471,1 24569,0 24592,1 24610,0 24612,1 24622,0 24695,1 24720,0 24756,1 24797,0 24843,1 24874,0 24974,1 25013,0 25091,1 25138,0 25194,1 25268,0 25287,1 25290,0 25291,1 25294,0 25305,1 25374,0 25473,1 25529,0 25572,1 25605,0 25701,1 25780,0 25785,1 25850,0 25936,1 25964,0 25985,1 26061,0 26131,1 26189,0 26206,1 26275,0 26349,1 26388,0 26422,1 26454,0 26471,1 26568,0 26571,1 26669,0 26740,1 26784,0 26878,1 26970,0 27003,1 27062,0 27100,1 27174,0 27246,1 27248,0 27254,1 27326,0 27344,1 27393,0 27488,1 27539,0 27562,1 27632,0 27640,1 27661,0 27750,1 27830,0 27844,1 27929,0 27960,1 27961,0 28042,1 28078,0 28172,1 28250,0 28272,1 28285,0 28303,1 28386,0 28469,1 28538,0 28567,1 28645,0 28745,1 28824,0 28855,1 28856,0 28951,1 28979,0 29018,1 29097,0 29118,1 29210,0 29305,1 29347,0 29373,1 29420,0 29449,1 29541,0 29572,1 29651,0 29697,1 29762,0 29820,1 29843,0 29881,1 29957,0 30038,1 30079,0 30101,1 30102,0 30106,1 30187,0 30249,1 30285,0 30347,1 30401,0 30500,1 30506,0 30562,1 30645,0 30707,1 30767,0 30809,1 30903,0 30936,1 30990,0 31011,1 31034,0 31128,1 31223,0 31288,1 31366,0 31432,1 31464,0 31534,1 31547,0 31574,1 31634,0 31646,1 31675,0 31743,1 31772,0 31862,1 31960,0 31988,1 32070,0 32155,1 32239,0 32277,1 32347,0 32385,1 32389,0 32404,1 32466,0 32509,1 32540,0 32605,1 32665,0 32691,1 32784,0 32818,1 32909,0 32986,1 33065,0 33106,1 33154,0 33220,1 33313,0 33400,1 33486,0 33557,1 33564,0 33651,1 33743,0 33841,1 33929,0 34005,1 34071,0 34148,1 34169,0 34237,1 34310,0 34372,1 34403,0 34421,1 34506,0 34509,1 34510,0 34597,1 34608,0 34627,1 34704,0 34712,1 34790,0 34867,1 34929,0 35006,1 35043,0 35114,1 35152,0 35199,1 35243,0 35284,1 35368,0 35395,1 35494,0 35541,1 35564,0 35586,1 35644,0 35660,1 35674,0 35739,1 35769,0 35780,1 35867,0 35896,1 35963,0 36003,1 36034,0 36068,1 36117,0 36160,1 36215,0 36271,1 36331,0 36431,1 36529,0 36531,1 36580,0 36636,1 36693,0 36697,1 36794,0 36844,1 36857,0 36892,1 36894,0 36906,1 37001,0 37096,1 37115,0 37119,1 37182,0 37191,1 37222,0 37226,1 37257,0 37305,1 37314,0 37318,1 37377,0 37380,1 37467,0 37566,1 37636,0 37666,1 37710,0 37751,1 37763,0 37860,1 37911,0 37937,1 37968,0 38030,1 38081,0 38117,1 38183,0 38212,1 38280,0 38321,1 38387,0 38445,1 38516,0 38597,1 38646,0 38657,1 38713,0 38811,1 38842,0 38846,1 38901,0 38945,1 39010,0 39085,1 39125,0 39214,1 39312,0 39338,1 39382,0 39453,1 39499,0 39538,1 39571,0 39618,1 39692,0 39781,1 39792,0 39826,1 39899,0 39989,1 40012,0 40049,1 40075,0 40143,1 40158,0 40228,1 40323,0 40405,1 40432,0 40500,1 40588,0 40680,1 40771,0 40784,1 40869,0 40957,1 41001,0 41050,1 41090,0 41168,1 41242,0 41258,1 41336,0 41340,1 41404,0 41496,1 41581,0 41625,1 41701,0 41715,1 41798,0 41821,1 41833,0 41883,1 41965,0 41982,1 42032,0 42123,1 42222,0 42311,1 42347,0 42362,1 42436,0 42438,1 42537,0 42601,1 42673,0 42681,1 42700,0 42724,1 42811,0 42868,1 42923,0 42949,1 42984,0 43073,1 43129,0 43151,1 43183,0 43207,1 43230,0 43268,1 43346,0 43402,1 43429,0 43473,1 43529,0 43628,1 43667,0 43765,1 43767,0 43813,1 43814,0 43865,1 43885,0 43979,1 44002,0 44068,1 44108,0 44164,1 44188,0 44214,1 44217,0 44241,1 44243,0 44328,1 44394,0 44487,1 44565,0 44656,1 44672,0 44746,1 44766,0 44830,1 44842,0 44843,1 44895,0 44967,1 44989,0 45053,1 45125,0 45212,1 45232,0 45332,1 45339,0 45356,1 45379,0 45445,1 45446,0 45469,1 45515,0 45544,1 45597,0 45645,1 45726,0 45820,1 45851,0 45884,1 45899,0 45906,1 45988,0 46077,1 46147,0 46174,1 46202,0 46277,1 46285,0 46336,1 46410,0 46433,1 46470,0 46570,1 46649,0 46678,1 46697,0 46745,1 46819,0 46896,1 46897,0 46962,1 46964,0 46977,1 47048,0 47124,1 47153,0 47205,1 47223,0 47276,1 47315,0 47338,1 47380,0 47458,1 47536,0 47629,1 47669,0 47671,1 47717,0 47767,1 47839,0 47887,1 47904,0 47985,1 48012,0 48015,1 48064,0 48138,1 48189,0 48234,1 48242,0 48278,1 48339,0 48433,1 48462,0 48482,1 48512,0 48583,1 48617,0 48629,1 48691,0 48775,1 48788,0 48867,1 48919,0 48992,1 49009,0 49085,1 49091,0 49120,1 49152,0 49219,1 49287,0 49361,1 49398,0 49451,1 49506,0 49576,1 49660,0 49733,1 49763,0 49811,1 49885,0 49932,1 49962,0 50023,1 50056,0 50151,1 50227,0 50269,1 50306,0 50346,1 50421,0 50469,1 end initlist b30 0,0 8,1 14,0 81,1 98,0 129,1 142,0 216,1 253,0 321,1 362,0 377,1 401,0 440,1 451,0 497,1 576,0 638,1 718,0 793,1 844,0 907,1 942,0 1022,1 1049,0 1133,1 1143,0 1190,1 1280,0 1337,1 1393,0 1470,1 1544,0 1595,1 1681,0 1695,1 1728,0 1801,1 1847,0 1858,1 1928,0 1932,1 2025,0 2065,1 2160,0 2218,1 2316,0 2321,1 2322,0 2372,1 2443,0 2532,1 2588,0 2663,1 2673,0 2703,1 2794,0 2852,1 2891,0 2984,1 3055,0 3085,1 3133,0 3233,1 3236,0 3254,1 3289,0 3337,1 3395,0 3410,1 3455,0 3516,1 3575,0 3626,1 3692,0 3745,1 3808,0 3873,1 3931,0 4007,1 4097,0 4102,1 4138,0 4146,1 4176,0 4266,1 4365,0 4402,1 4478,0 4563,1 4587,0 4640,1 4709,0 4718,1 4789,0 4806,1 4844,0 4879,1 4925,0 5018,1 5077,0 5132,1 5166,0 5256,1 5285,0 5329,1 5382,0 5458,1 5527,0 5554,1 5575,0 5578,1 5585,0 5622,1 5717,0 5793,1 5797,0 5864,1 5926,0 5988,1 6039,0 6045,1 6129,0 6144,1 6168,0 6229,1 6275,0 6370,1 6425,0 6479,1 6566,0 6589,1 6607,0 6677,1 6688,0 6711,1 6769,0 6823,1 6915,0 6916,1 7016,0 7017,1 7033,0 7063,1 7089,0 7149,1 7234,0 7242,1 7298,0 7325,1 7363,0 7398,1 7458,0 7548,1 7646,0 7662,1 7718,0 7719,1 7806,0 7816,1 7834,0 7884,1 7974,0 8023,1 8057,0 8137,1 8157,0 8159,1 8232,0 8311,1 8371,0 8471,1 8547,0 8630,1 8665,0 8670,1 8743,0 8843,1 8911,0 8976,1 9011,0 9066,1 9130,0 9207,1 9286,0 9356,1 9385,0 9419,1 9467,0 9498,1 9525,0 9621,1 9669,0 9765,1 9858,0 9922,1 9999,0 10067,1 10108,0 10146,1 10244,0 10323,1 10357,0 10410,1 10437,0 10515,1 10546,0 10572,1 10613,0 10708,1 10724,0 10741,1 10813,0 10908,1 10936,0 10973,1 11054,0 11084,1 11118,0 11134,1 11153,0 11160,1 11245,0 11293,1 11296,0 11352,1 11427,0 11503,1 11570,0 11574,1 11586,0 11678,1 11713,0 11799,1 11858,0 11904,1 11991,0 12035,1 12099,0 12173,1 12216,0 12266,1 12276,0 12304,1 12331,0 12401,1 12494,0 12574,1 12612,0 12624,1 12629,0 12631,1 12686,0 12694,1 12715,0 12776,1 12790,0 12848,1 12888,0 12898,1 12904,0 12924,1 13000,0 13038,1 13043,0 13104,1 13182,0 13255,1 13322,0 13363,1 13444,0 13452,1 13493,0 13581,1 13603,0 13622,1 13646,0 13723,1 13786,0 13877,1 13893,0 13969,1 14063,0 14139,1 14173,0 14215,1 14250,0 14282,1 14305,0 14395,1 14494,0 14590,1 14619,0 14715,1 14781,0 14842,1 14855,0 14888,1 14957,0 14971,1 15024,0 15086,1 15130,0 15176,1 15191,0 15238,1 15245,0 15304,1 15333,0 15354,1 15365,0 15393,1 15415,0 15499,1 15575,0 15599,1 15608,0 15660,1 15713,0 15793,1 15878,0 15940,1 16036,0 16058,1 16073,0 16171,1 16270,0 16308,1 16387,0 16460,1 16502,0 16521,1 16599,0 16666,1 16753,0 16841,1 16842,0 16922,1 17002,0 17031,1 17041,0 17064,1 17112,0 17204,1 17240,0 17269,1 17369,0 17381,1 17468,0 17523,1 17582,0 17629,1 17701,0 17704,1 17741,0 17820,1 17833,0 17853,1 17880,0 17932,1 18025,0 18082,1 18130,0 18189,1 18210,0 18309,1 18344,0 18390,1 18465,0 18468,1 18474,0 18496,1 18531,0 18592,1 18655,0 18704,1 18795,0 18883,1 18944,0 19016,1 19072,0 19155,1 19170,0 19179,1 19210,0 19235,1 19296,0 19360,1 19388,0 19473,1 19556,0 19643,1 19677,0 19738,1 19787,0 19879,1 19959,0 19964,1 20002,0 20011,1 20017,0 20058,1 20122,0 20128,1 20193,0 20279,1 20379,0 20443,1 20495,0 20528,1 20606,0 20618,1 20635,0 20692,1 20712,0 20774,1 20832,0 20842,1 20852,0 20937,1 20961,0 21009,1 21100,0 21163,1 21172,0 21224,1 21314,0 21409,1 21481,0 21515,1 21587,0 21597,1 21648,0 21672,1 21709,0 21737,1 21812,0 21891,1 21892,0 21981,1 22007,0 22054,1 22137,0 22164,1 22229,0 22291,1 22357,0 22388,1 22404,0 22482,1 22529,0 22540,1 22623,0 22677,1 22748,0 22792,1 22855,0 22856,1 22896,0 22900,1 22908,0 22952,1 23005,0 23043,1 23063,0 23141,1 23212,0 23298,1 23366,0 23440,1 23530,0 23596,1 23680,0 23694,1 23710,0 23749,1 23816,0 23877,1 23907,0 23954,1 24027,0 24097,1 24168,0 24202,1 24288,0 24289,1 24290,0 24378,1 24386,0 24481,1 24517,0 24547,1 24636,0 24723,1 24750,0 24792,1 24881,0 24952,1 25010,0 25043,1 25073,0 25096,1 25123,0 25203,1 25213,0 25222,1 25263,0 25304,1 25402,0 25403,1 25462,0 25507,1 25592,0 25604,1 25682,0 25757,1 25809,0 25872,1 25954,0 26031,1 26052,0 26133,1 26228,0 26305,1 26393,0 26394,1 26453,0 26538,1 26613,0 26664,1 26751,0 26803,1 26870,0 26904,1 27000,0 27026,1 27082,0 27132,1 27184,0 27244,1 27313,0 27374,1 27467,0 27496,1 27589,0 27685,1 27705,0 27802,1 27887,0 27896,1 27955,0 28034,1 28093,0 28184,1 28207,0 28237,1 28281,0 28359,1 28367,0 28460,1 28520,0 28562,1 28586,0 28651,1 28732,0 28775,1 28843,0 28876,1 28913,0 28986,1 28998,0 29029,1 29040,0 29138,1 29224,0 29295,1 29369,0 29410,1 29424,0 29491,1 29587,0 29673,1 29710,0 29804,1 29849,0 29863,1 29960,0 30021,1 30062,0 30103,1 30201,0 30246,1 30333,0 30360,1 30422,0 30435,1 30474,0 30536,1 30628,0 30725,1 30742,0 30794,1 30875,0 30969,1 31026,0 31053,1 31115,0 31174,1 31273,0 31350,1 31393,0 31411,1 31437,0 31438,1 31505,0 31540,1 31613,0 31656,1 31702,0 31797,1 31810,0 31910,1 31985,0 32052,1 32141,0 32231,1 32318,0 32387,1 32460,0 32520,1 32592,0 32657,1 32701,0 32745,1 32816,0 32908,1 32981,0 33080,1 33142,0 33233,1 33281,0 33379,1 33387,0 33459,1 33497,0 33557,1 33569,0 33658,1 33743,0 33810,1 33812,0 33900,1 33911,0 33924,1 33984,0 34046,1 34047,0 34099,1 34124,0 34145,1 34215,0 34242,1 34299,0 34340,1 34421,0 34507,1 34602,0 34700,1 34795,0 34820,1 34854,0 34868,1 34896,0 34939,1 35015,0 35069,1 35089,0 35105,1 35199,0 35215,1 35275,0 35321,1 35373,0 35448,1 35466,0 35493,1 35578,0 35625,1 35630,0 35685,1 35693,0 35781,1 35788,0 35847,1 35877,0 35913,1 35982,0 35990,1 36031,0 36071,1 36080,0 36160,1 36175,0 36181,1 36236,0 36287,1 36365,0 36427,1 36484,0 36547,1 36564,0 36587,1 36664,0 36685,1 36738,0 36771,1 36786,0 36809,1 36845,0 36868,1 36922,0 36971,1 36981,0 36989,1 37049,0 37084,1 37090,0 37125,1 37127,0 37135,1 37177,0 37239,1 37278,0 37345,1 37399,0 37415,1 37454,0 37491,1 37587,0 37630,1 37730,0 37774,1 37840,0 37923,1 38022,0 38034,1 38093,0 38094,1 38186,0 38227,1 38289,0 38342,1 38368,0 38393,1 38403,0 38460,1 38523,0 38535,1 38558,0 38581,1 38611,0 38644,1 38711,0 38785,1 38862,0 38919,1 38938,0 38963,1 38982,0 39028,1 39038,0 39056,1 39076,0 39086,1 39184,0 39206,1 39227,0 39280,1 39283,0 39304,1 39326,0 39343,1 39346,0 39421,1 39489,0 39534,1 39556,0 39601,1 39652,0 39660,1 39713,0 39721,1 39788,0 39818,1 39831,0 39872,1 39894,0 39978,1 40037,0 40121,1 40139,0 40164,1 40196,0 40200,1 40253,0 40338,1 40422,0 40481,1 40523,0 40534,1 40629,0 40673,1 40740,0 40826,1 40912,0 40931,1 40989,0 41015,1 41063,0 41095,1 41133,0 41149,1 41244,0 41260,1 41295,0 41393,1 41408,0 41475,1 41536,0 41560,1 41600,0 41670,1 41713,0 41788,1 41876,0 41971,1 41998,0 42083,1 42149,0 42154,1 42155,0 42201,1 42275,0 42317,1 42372,0 42377,1 42406,0 42470,1 42536,0 42554,1 42564,0 42596,1 42684,0 42774,1 42869,0 42959,1 42971,0 42981,1 43035,0 43042,1 43100,0 43122,1 43160,0 43168,1 43266,0 43289,1 43294,0 43340,1 43425,0 43467,1 43525,0 43545,1 43584,0 43632,1 43702,0 43801,1 43890,0 43935,1 43954,0 44051,1 44078,0 44110,1 44207,0 44243,1 44261,0 44330,1 44377,0 44414,1 44427,0 44470,1 44562,0 44645,1 44735,0 44744,1 44756,0 44776,1 44826,0 44895,1 44933,0 45031,1 45117,0 45203,1 45256,0 45290,1 45313,0 45335,1 45367,0 45466,1 45486,0 45582,1 45585,0 45594,1 45608,0 45677,1 45762,0 45774,1 45870,0 45949,1 45969,0 45971,1 46043,0 46110,1 46208,0 46234,1 46314,0 46377,1 46399,0 46441,1 46446,0 46502,1 46598,0 46617,1 46622,0 46650,1 46733,0 46743,1 46835,0 46886,1 46947,0 47043,1 47102,0 47148,1 47191,0 47282,1 47312,0 47409,1 47492,0 47530,1 47598,0 47659,1 47721,0 47803,1 47873,0 47923,1 48023,0 48040,1 48129,0 48189,1 48227,0 48289,1 48328,0 48343,1 48357,0 48443,1 48454,0 48457,1 48542,0 48632,1 48706,0 48806,1 48906,0 48988,1 49042,0 49111,1 49203,0 49286,1 49374,0 49398,1 49444,0 49448,1 49532,0 49617,1 49658,0 49720,1 49768,0 49787,1 49818,0 49881,1 49978,0 50052,1 50143,0 50174,1 50209,0 50243,1 50271,0 50349,1 50390,0 50400,1 50419,0 50493,1 50516,0 50616,1 end initlist b31 0,0 38,1 71,0 170,1 259,0 290,1 295,0 314,1 338,0 356,1 404,0 455,1 546,0 598,1 695,0 770,1 809,0 813,1 873,0 920,1 979,0 992,1 1078,0 1152,1 1250,0 1342,1 1352,0 1403,1 1421,0 1509,1 1587,0 1604,1 1682,0 1759,1 1819,0 1829,1 1887,0 1912,1 1954,0 2018,1 2076,0 2116,1 2182,0 2263,1 2273,0 2334,1 2348,0 2350,1 2398,0 2473,1 2479,0 2556,1 2638,0 2657,1 2715,0 2760,1 2819,0 2908,1 2988,0 3060,1 3127,0 3141,1 3171,0 3256,1 3320,0 3420,1 3452,0 3491,1 3591,0 3633,1 3658,0 3757,1 3803,0 3884,1 3929,0 4001,1 4017,0 4043,1 4109,0 4173,1 4175,0 4211,1 4299,0 4313,1 4362,0 4439,1 4527,0 4618,1 4689,0 4789,1 4851,0 4883,1 4913,0 4930,1 4979,0 5076,1 5119,0 5122,1 5129,0 5180,1 5255,0 5349,1 5405,0 5440,1 5480,0 5525,1 5609,0 5694,1 5751,0 5799,1 5890,0 5965,1 6055,0 6154,1 6177,0 6235,1 6300,0 6329,1 6349,0 6432,1 6489,0 6551,1 6650,0 6742,1 6822,0 6866,1 6917,0 6996,1 7077,0 7120,1 7151,0 7186,1 7196,0 7234,1 7260,0 7321,1 7361,0 7363,1 7390,0 7436,1 7454,0 7547,1 7585,0 7655,1 7704,0 7716,1 7794,0 7817,1 7917,0 8005,1 8016,0 8050,1 8094,0 8166,1 8224,0 8263,1 8271,0 8279,1 8330,0 8416,1 8420,0 8453,1 8501,0 8585,1 8632,0 8724,1 8807,0 8861,1 8874,0 8954,1 9039,0 9088,1 9148,0 9201,1 9293,0 9328,1 9377,0 9435,1 9473,0 9551,1 9632,0 9721,1 9740,0 9771,1 9800,0 9896,1 9968,0 10068,1 10117,0 10191,1 10273,0 10283,1 10330,0 10387,1 10469,0 10476,1 10535,0 10562,1 10659,0 10695,1 10756,0 10849,1 10930,0 11019,1 11115,0 11194,1 11260,0 11346,1 11434,0 11523,1 11575,0 11609,1 11702,0 11724,1 11726,0 11743,1 11750,0 11769,1 11817,0 11827,1 11889,0 11945,1 11954,0 11997,1 12047,0 12088,1 12114,0 12123,1 12206,0 12269,1 12329,0 12428,1 12515,0 12547,1 12618,0 12703,1 12742,0 12783,1 12876,0 12919,1 12958,0 13008,1 13041,0 13079,1 13089,0 13104,1 13197,0 13279,1 13315,0 13408,1 13474,0 13478,1 13499,0 13554,1 13630,0 13694,1 13732,0 13768,1 13864,0 13867,1 13890,0 13927,1 14026,0 14098,1 14105,0 14190,1 14280,0 14320,1 14409,0 14484,1 14567,0 14609,1 14635,0 14665,1 14700,0 14709,1 14736,0 14835,1 14934,0 14943,1 15010,0 15045,1 15085,0 15147,1 15195,0 15214,1 15240,0 15340,1 15374,0 15429,1 15433,0 15529,1 15594,0 15681,1 15698,0 15762,1 15828,0 15850,1 15933,0 16025,1 16113,0 16162,1 16242,0 16293,1 16337,0 16341,1 16418,0 16500,1 16530,0 16548,1 16609,0 16640,1 16641,0 16661,1 16733,0 16801,1 16865,0 16900,1 16964,0 16966,1 17027,0 17054,1 17148,0 17242,1 17310,0 17313,1 17355,0 17394,1 17395,0 17401,1 17453,0 17552,1 17571,0 17584,1 17674,0 17690,1 17790,0 17797,1 17849,0 17851,1 17908,0 17941,1 17985,0 18026,1 18046,0 18068,1 18130,0 18170,1 18259,0 18304,1 18306,0 18390,1 18470,0 18476,1 18563,0 18654,1 18718,0 18805,1 18824,0 18900,1 18998,0 19078,1 19166,0 19180,1 19254,0 19328,1 19331,0 19350,1 19361,0 19453,1 19532,0 19541,1 19553,0 19614,1 19708,0 19714,1 19753,0 19804,1 19827,0 19890,1 19938,0 19939,1 19974,0 20067,1 20083,0 20175,1 20272,0 20353,1 20383,0 20472,1 20564,0 20621,1 20627,0 20696,1 20726,0 20825,1 20883,0 20939,1 21022,0 21084,1 21105,0 21130,1 21170,0 21257,1 21310,0 21318,1 21332,0 21377,1 21416,0 21457,1 21496,0 21588,1 21619,0 21648,1 21745,0 21788,1 21804,0 21815,1 21876,0 21916,1 21997,0 22052,1 22090,0 22129,1 22174,0 22233,1 22326,0 22348,1 22421,0 22500,1 22562,0 22623,1 22687,0 22751,1 22815,0 22818,1 22862,0 22907,1 22923,0 22931,1 22946,0 22977,1 23015,0 23078,1 23138,0 23185,1 23243,0 23306,1 23405,0 23410,1 23439,0 23481,1 23500,0 23535,1 23630,0 23684,1 23746,0 23843,1 23875,0 23973,1 24000,0 24026,1 24118,0 24189,1 24247,0 24317,1 24407,0 24408,1 24491,0 24565,1 24651,0 24663,1 24762,0 24855,1 24857,0 24926,1 24938,0 25023,1 25120,0 25142,1 25177,0 25257,1 25330,0 25372,1 25386,0 25403,1 25441,0 25537,1 25624,0 25689,1 25768,0 25783,1 25811,0 25842,1 25854,0 25869,1 25911,0 25919,1 25998,0 26093,1 26172,0 26202,1 26228,0 26317,1 26336,0 26399,1 26491,0 26542,1 26585,0 26645,1 26659,0 26727,1 26747,0 26813,1 26870,0 26963,1 27007,0 27027,1 27067,0 27104,1 27146,0 27215,1 27219,0 27316,1 27325,0 27373,1 27430,0 27480,1 27519,0 27598,1 27608,0 27622,1 27646,0 27725,1 27743,0 27824,1 27836,0 27850,1 27865,0 27913,1 27983,0 28037,1 28058,0 28099,1 28175,0 28213,1 28238,0 28268,1 28319,0 28326,1 28423,0 28447,1 28488,0 28502,1 28565,0 28620,1 28647,0 28702,1 28799,0 28834,1 28901,0 28938,1 28956,0 29001,1 29005,0 29066,1 29115,0 29164,1 29243,0 29268,1 29273,0 29332,1 29389,0 29431,1 29497,0 29596,1 29645,0 29688,1 29735,0 29817,1 29888,0 29948,1 29978,0 29984,1 30028,0 30114,1 30173,0 30254,1 30353,0 30377,1 30394,0 30427,1 30501,0 30545,1 30564,0 30591,1 30691,0 30704,1 30770,0 30812,1 30911,0 30916,1 30953,0 31032,1 31092,0 31123,1 31167,0 31183,1 31216,0 31304,1 31396,0 31462,1 31540,0 31615,1 31661,0 31711,1 31723,0 31740,1 31831,0 31851,1 31863,0 31890,1 31900,0 31915,1 31942,0 31944,1 32020,0 32070,1 32111,0 32152,1 32154,0 32211,1 32293,0 32299,1 32364,0 32392,1 32461,0 32506,1 32547,0 32550,1 32638,0 32680,1 32729,0 32825,1 32923,0 32946,1 33036,0 33112,1 33114,0 33184,1 33208,0 33300,1 33370,0 33395,1 33429,0 33437,1 33450,0 33482,1 33539,0 33633,1 33670,0 33755,1 33768,0 33846,1 33928,0 34015,1 34110,0 34175,1 34188,0 34206,1 34260,0 34351,1 34439,0 34527,1 34602,0 34678,1 34710,0 34732,1 34771,0 34860,1 34930,0 35020,1 35062,0 35149,1 35160,0 35234,1 35302,0 35331,1 35431,0 35456,1 35482,0 35563,1 35630,0 35643,1 35743,0 35843,1 35882,0 35956,1 36025,0 36120,1 36184,0 36223,1 36274,0 36313,1 36376,0 36474,1 36477,0 36488,1 36549,0 36628,1 36726,0 36757,1 36775,0 36860,1 36878,0 36894,1 36961,0 36981,1 37017,0 37094,1 37111,0 37147,1 37178,0 37244,1 37294,0 37318,1 37353,0 37377,1 37476,0 37546,1 37643,0 37700,1 37703,0 37705,1 37723,0 37730,1 37799,0 37853,1 37918,0 38017,1 38073,0 38124,1 38164,0 38182,1 38224,0 38303,1 38375,0 38409,1 38502,0 38518,1 38546,0 38551,1 38636,0 38696,1 38720,0 38757,1 38820,0 38894,1 38969,0 39022,1 39076,0 39136,1 39229,0 39236,1 39321,0 39326,1 39353,0 39404,1 39455,0 39546,1 39625,0 39674,1 39737,0 39800,1 39837,0 39845,1 39873,0 39953,1 40001,0 40008,1 40037,0 40057,1 40147,0 40188,1 40254,0 40298,1 40375,0 40437,1 40490,0 40494,1 40576,0 40624,1 40677,0 40739,1 40800,0 40879,1 40936,0 40994,1 41089,0 41176,1 41211,0 41302,1 41351,0 41416,1 41515,0 41567,1 41611,0 41669,1 41713,0 41741,1 41814,0 41886,1 41936,0 41957,1 41971,0 41985,1 42055,0 42137,1 42170,0 42203,1 42289,0 42299,1 42324,0 42407,1 42448,0 42526,1 42610,0 42663,1 42757,0 42801,1 42882,0 42953,1 42971,0 43061,1 43093,0 43164,1 43188,0 43259,1 43333,0 43430,1 43516,0 43576,1 43613,0 43638,1 43670,0 43716,1 43809,0 43811,1 43890,0 43934,1 43985,0 44053,1 44147,0 44241,1 44334,0 44401,1 44474,0 44566,1 44633,0 44713,1 44785,0 44864,1 44918,0 44969,1 45051,0 45098,1 45118,0 45214,1 45239,0 45247,1 45266,0 45364,1 45386,0 45439,1 45498,0 45503,1 45511,0 45602,1 45679,0 45775,1 45798,0 45893,1 45974,0 45980,1 46043,0 46108,1 46195,0 46261,1 46306,0 46367,1 46446,0 46478,1 46539,0 46567,1 46570,0 46610,1 46709,0 46729,1 46814,0 46909,1 46974,0 47053,1 47121,0 47191,1 47269,0 47351,1 47422,0 47430,1 47484,0 47517,1 47612,0 47708,1 47783,0 47825,1 47869,0 47925,1 47938,0 47968,1 47996,0 48076,1 48084,0 48144,1 48189,0 48192,1 48260,0 48286,1 48314,0 48366,1 48443,0 48541,1 48576,0 48613,1 48672,0 48697,1 48767,0 48802,1 48834,0 48890,1 48973,0 48974,1 49026,0 49097,1 49173,0 49175,1 49179,0 49249,1 49284,0 49333,1 49353,0 49375,1 49411,0 49446,1 49546,0 49569,1 49617,0 49652,1 49731,0 49785,1 49849,0 49914,1 49999,0 50052,1 50094,0 50122,1 50128,0 50214,1 50308,0 50345,1 50398,0 50473,1 50549,0 50610,1 50688,0 50734,1 50775,0 50829,1 50870,0 50883,1 50908,0 50939,1 50971,0 50992,1 51024,0 51049,1 51100,0 51120,1 51195,0 51286,1 51354,0 51365,1 51455,0 51499,1 51518,0 51560,1 51638,0 51641,1 51691,0 51778,1 51810,0 51846,1 51883,0 51939,1 end initlist cin 0, 0 69, 1 end outvalues s0 1, s1 1, s2 1, s3 1, s4 1, s5 1, s6 1, s7 1, s8 1, s9 1, s10 1, s11 1, s12 1, s13 1, s14 1, s15 1, s16 1, s17 1, s18 1, s19 1, s20 1, s21 1, s22 1, s23 1, s24 1, s25 1, s26 1, s27 1, s28 1, s29 1, s30 1, s31 1, , cout 1, end netlist // PGgen (g0,p0,a0,b0) xor2(p0,a0,b0)#5 and2(g0,a0,b0)#5 end netlist // PGgen (g1,p1,a1,b1) xor2(p1,a1,b1)#5 and2(g1,a1,b1)#5 end netlist // PGgen (g2,p2,a2,b2) xor2(p2,a2,b2)#5 and2(g2,a2,b2)#5 end netlist // PGgen (g3,p3,a3,b3) xor2(p3,a3,b3)#5 and2(g3,a3,b3)#5 end netlist // PGgen (g4,p4,a4,b4) xor2(p4,a4,b4)#5 and2(g4,a4,b4)#5 end netlist // PGgen (g5,p5,a5,b5) xor2(p5,a5,b5)#5 and2(g5,a5,b5)#5 end netlist // PGgen (g6,p6,a6,b6) xor2(p6,a6,b6)#5 and2(g6,a6,b6)#5 end netlist // PGgen (g7,p7,a7,b7) xor2(p7,a7,b7)#5 and2(g7,a7,b7)#5 end netlist // PGgen (g8,p8,a8,b8) xor2(p8,a8,b8)#5 and2(g8,a8,b8)#5 end netlist // PGgen (g9,p9,a9,b9) xor2(p9,a9,b9)#5 and2(g9,a9,b9)#5 end netlist // PGgen (g10,p10,a10,b10) xor2(p10,a10,b10)#5 and2(g10,a10,b10)#5 end netlist // PGgen (g11,p11,a11,b11) xor2(p11,a11,b11)#5 and2(g11,a11,b11)#5 end netlist // PGgen (g12,p12,a12,b12) xor2(p12,a12,b12)#5 and2(g12,a12,b12)#5 end netlist // PGgen (g13,p13,a13,b13) xor2(p13,a13,b13)#5 and2(g13,a13,b13)#5 end netlist // PGgen (g14,p14,a14,b14) xor2(p14,a14,b14)#5 and2(g14,a14,b14)#5 end netlist // PGgen (g15,p15,a15,b15) xor2(p15,a15,b15)#5 and2(g15,a15,b15)#5 end netlist // PGgen (g16,p16,a16,b16) xor2(p16,a16,b16)#5 and2(g16,a16,b16)#5 end netlist // PGgen (g17,p17,a17,b17) xor2(p17,a17,b17)#5 and2(g17,a17,b17)#5 end netlist // PGgen (g18,p18,a18,b18) xor2(p18,a18,b18)#5 and2(g18,a18,b18)#5 end netlist // PGgen (g19,p19,a19,b19) xor2(p19,a19,b19)#5 and2(g19,a19,b19)#5 end netlist // PGgen (g20,p20,a20,b20) xor2(p20,a20,b20)#5 and2(g20,a20,b20)#5 end netlist // PGgen (g21,p21,a21,b21) xor2(p21,a21,b21)#5 and2(g21,a21,b21)#5 end netlist // PGgen (g22,p22,a22,b22) xor2(p22,a22,b22)#5 and2(g22,a22,b22)#5 end netlist // PGgen (g23,p23,a23,b23) xor2(p23,a23,b23)#5 and2(g23,a23,b23)#5 end netlist // PGgen (g24,p24,a24,b24) xor2(p24,a24,b24)#5 and2(g24,a24,b24)#5 end netlist // PGgen (g25,p25,a25,b25) xor2(p25,a25,b25)#5 and2(g25,a25,b25)#5 end netlist // PGgen (g26,p26,a26,b26) xor2(p26,a26,b26)#5 and2(g26,a26,b26)#5 end netlist // PGgen (g27,p27,a27,b27) xor2(p27,a27,b27)#5 and2(g27,a27,b27)#5 end netlist // PGgen (g28,p28,a28,b28) xor2(p28,a28,b28)#5 and2(g28,a28,b28)#5 end netlist // PGgen (g29,p29,a29,b29) xor2(p29,a29,b29)#5 and2(g29,a29,b29)#5 end netlist // PGgen (g30,p30,a30,b30) xor2(p30,a30,b30)#5 and2(g30,a30,b30)#5 end netlist // PGgen (g31,p31,a31,b31) xor2(p31,a31,b31)#5 and2(g31,a31,b31)#5 end netlist // Gcombine (g_0_cin, g0, cin, p0 ) and2(w0g_0_cin, p0, cin )#5 or2( g_0_cin, w0g_0_cin, g0 )#5 end netlist // PGcombine (g_1_0,p_1_0,g1,p1,g0,p0) and2( w0g_1_0, p1, g0 )#5 or2( g_1_0, w0g_1_0, g1 )#5 and2( p_1_0, p1, p0)#5 end netlist // PGcombine (g_2_1,p_2_1,g2,p2,g1,p1) and2( w0g_2_1, p2, g1 )#5 or2( g_2_1, w0g_2_1, g2 )#5 and2( p_2_1, p2, p1)#5 end netlist // PGcombine (g_3_2,p_3_2,g3,p3,g2,p2) and2( w0g_3_2, p3, g2 )#5 or2( g_3_2, w0g_3_2, g3 )#5 and2( p_3_2, p3, p2)#5 end netlist // PGcombine (g_4_3,p_4_3,g4,p4,g3,p3) and2( w0g_4_3, p4, g3 )#5 or2( g_4_3, w0g_4_3, g4 )#5 and2( p_4_3, p4, p3)#5 end netlist // PGcombine (g_5_4,p_5_4,g5,p5,g4,p4) and2( w0g_5_4, p5, g4 )#5 or2( g_5_4, w0g_5_4, g5 )#5 and2( p_5_4, p5, p4)#5 end netlist // PGcombine (g_6_5,p_6_5,g6,p6,g5,p5) and2( w0g_6_5, p6, g5 )#5 or2( g_6_5, w0g_6_5, g6 )#5 and2( p_6_5, p6, p5)#5 end netlist // PGcombine (g_7_6,p_7_6,g7,p7,g6,p6) and2( w0g_7_6, p7, g6 )#5 or2( g_7_6, w0g_7_6, g7 )#5 and2( p_7_6, p7, p6)#5 end netlist // PGcombine (g_8_7,p_8_7,g8,p8,g7,p7) and2( w0g_8_7, p8, g7 )#5 or2( g_8_7, w0g_8_7, g8 )#5 and2( p_8_7, p8, p7)#5 end netlist // PGcombine (g_9_8,p_9_8,g9,p9,g8,p8) and2( w0g_9_8, p9, g8 )#5 or2( g_9_8, w0g_9_8, g9 )#5 and2( p_9_8, p9, p8)#5 end netlist // PGcombine (g_10_9,p_10_9,g10,p10,g9,p9) and2( w0g_10_9, p10, g9 )#5 or2( g_10_9, w0g_10_9, g10 )#5 and2( p_10_9, p10, p9)#5 end netlist // PGcombine (g_11_10,p_11_10,g11,p11,g10,p10) and2( w0g_11_10, p11, g10 )#5 or2( g_11_10, w0g_11_10, g11 )#5 and2( p_11_10, p11, p10)#5 end netlist // PGcombine (g_12_11,p_12_11,g12,p12,g11,p11) and2( w0g_12_11, p12, g11 )#5 or2( g_12_11, w0g_12_11, g12 )#5 and2( p_12_11, p12, p11)#5 end netlist // PGcombine (g_13_12,p_13_12,g13,p13,g12,p12) and2( w0g_13_12, p13, g12 )#5 or2( g_13_12, w0g_13_12, g13 )#5 and2( p_13_12, p13, p12)#5 end netlist // PGcombine (g_14_13,p_14_13,g14,p14,g13,p13) and2( w0g_14_13, p14, g13 )#5 or2( g_14_13, w0g_14_13, g14 )#5 and2( p_14_13, p14, p13)#5 end netlist // PGcombine (g_15_14,p_15_14,g15,p15,g14,p14) and2( w0g_15_14, p15, g14 )#5 or2( g_15_14, w0g_15_14, g15 )#5 and2( p_15_14, p15, p14)#5 end netlist // PGcombine (g_16_15,p_16_15,g16,p16,g15,p15) and2( w0g_16_15, p16, g15 )#5 or2( g_16_15, w0g_16_15, g16 )#5 and2( p_16_15, p16, p15)#5 end netlist // PGcombine (g_17_16,p_17_16,g17,p17,g16,p16) and2( w0g_17_16, p17, g16 )#5 or2( g_17_16, w0g_17_16, g17 )#5 and2( p_17_16, p17, p16)#5 end netlist // PGcombine (g_18_17,p_18_17,g18,p18,g17,p17) and2( w0g_18_17, p18, g17 )#5 or2( g_18_17, w0g_18_17, g18 )#5 and2( p_18_17, p18, p17)#5 end netlist // PGcombine (g_19_18,p_19_18,g19,p19,g18,p18) and2( w0g_19_18, p19, g18 )#5 or2( g_19_18, w0g_19_18, g19 )#5 and2( p_19_18, p19, p18)#5 end netlist // PGcombine (g_20_19,p_20_19,g20,p20,g19,p19) and2( w0g_20_19, p20, g19 )#5 or2( g_20_19, w0g_20_19, g20 )#5 and2( p_20_19, p20, p19)#5 end netlist // PGcombine (g_21_20,p_21_20,g21,p21,g20,p20) and2( w0g_21_20, p21, g20 )#5 or2( g_21_20, w0g_21_20, g21 )#5 and2( p_21_20, p21, p20)#5 end netlist // PGcombine (g_22_21,p_22_21,g22,p22,g21,p21) and2( w0g_22_21, p22, g21 )#5 or2( g_22_21, w0g_22_21, g22 )#5 and2( p_22_21, p22, p21)#5 end netlist // PGcombine (g_23_22,p_23_22,g23,p23,g22,p22) and2( w0g_23_22, p23, g22 )#5 or2( g_23_22, w0g_23_22, g23 )#5 and2( p_23_22, p23, p22)#5 end netlist // PGcombine (g_24_23,p_24_23,g24,p24,g23,p23) and2( w0g_24_23, p24, g23 )#5 or2( g_24_23, w0g_24_23, g24 )#5 and2( p_24_23, p24, p23)#5 end netlist // PGcombine (g_25_24,p_25_24,g25,p25,g24,p24) and2( w0g_25_24, p25, g24 )#5 or2( g_25_24, w0g_25_24, g25 )#5 and2( p_25_24, p25, p24)#5 end netlist // PGcombine (g_26_25,p_26_25,g26,p26,g25,p25) and2( w0g_26_25, p26, g25 )#5 or2( g_26_25, w0g_26_25, g26 )#5 and2( p_26_25, p26, p25)#5 end netlist // PGcombine (g_27_26,p_27_26,g27,p27,g26,p26) and2( w0g_27_26, p27, g26 )#5 or2( g_27_26, w0g_27_26, g27 )#5 and2( p_27_26, p27, p26)#5 end netlist // PGcombine (g_28_27,p_28_27,g28,p28,g27,p27) and2( w0g_28_27, p28, g27 )#5 or2( g_28_27, w0g_28_27, g28 )#5 and2( p_28_27, p28, p27)#5 end netlist // PGcombine (g_29_28,p_29_28,g29,p29,g28,p28) and2( w0g_29_28, p29, g28 )#5 or2( g_29_28, w0g_29_28, g29 )#5 and2( p_29_28, p29, p28)#5 end netlist // PGcombine (g_30_29,p_30_29,g30,p30,g29,p29) and2( w0g_30_29, p30, g29 )#5 or2( g_30_29, w0g_30_29, g30 )#5 and2( p_30_29, p30, p29)#5 end netlist // PGcombine (g_31_30,p_31_30,g31,p31,g30,p30) and2( w0g_31_30, p31, g30 )#5 or2( g_31_30, w0g_31_30, g31 )#5 and2( p_31_30, p31, p30)#5 end netlist // Gcombine (g_1_cin, g_1_0, cin, p_1_0 ) and2(w0g_1_cin, p_1_0, cin )#5 or2( g_1_cin, w0g_1_cin, g_1_0 )#5 end netlist // Gcombine (g_2_cin, g_2_1, g_0_cin, p_2_1 ) and2(w0g_2_cin, p_2_1, g_0_cin )#5 or2( g_2_cin, w0g_2_cin, g_2_1 )#5 end netlist // PGcombine (g_3_0,p_3_0,g_3_2,p_3_2,g_1_0,p_1_0) and2( w0g_3_0, p_3_2, g_1_0 )#5 or2( g_3_0, w0g_3_0, g_3_2 )#5 and2( p_3_0, p_3_2, p_1_0)#5 end netlist // PGcombine (g_4_1,p_4_1,g_4_3,p_4_3,g_2_1,p_2_1) and2( w0g_4_1, p_4_3, g_2_1 )#5 or2( g_4_1, w0g_4_1, g_4_3 )#5 and2( p_4_1, p_4_3, p_2_1)#5 end netlist // PGcombine (g_5_2,p_5_2,g_5_4,p_5_4,g_3_2,p_3_2) and2( w0g_5_2, p_5_4, g_3_2 )#5 or2( g_5_2, w0g_5_2, g_5_4 )#5 and2( p_5_2, p_5_4, p_3_2)#5 end netlist // PGcombine (g_6_3,p_6_3,g_6_5,p_6_5,g_4_3,p_4_3) and2( w0g_6_3, p_6_5, g_4_3 )#5 or2( g_6_3, w0g_6_3, g_6_5 )#5 and2( p_6_3, p_6_5, p_4_3)#5 end netlist // PGcombine (g_7_4,p_7_4,g_7_6,p_7_6,g_5_4,p_5_4) and2( w0g_7_4, p_7_6, g_5_4 )#5 or2( g_7_4, w0g_7_4, g_7_6 )#5 and2( p_7_4, p_7_6, p_5_4)#5 end netlist // PGcombine (g_8_5,p_8_5,g_8_7,p_8_7,g_6_5,p_6_5) and2( w0g_8_5, p_8_7, g_6_5 )#5 or2( g_8_5, w0g_8_5, g_8_7 )#5 and2( p_8_5, p_8_7, p_6_5)#5 end netlist // PGcombine (g_9_6,p_9_6,g_9_8,p_9_8,g_7_6,p_7_6) and2( w0g_9_6, p_9_8, g_7_6 )#5 or2( g_9_6, w0g_9_6, g_9_8 )#5 and2( p_9_6, p_9_8, p_7_6)#5 end netlist // PGcombine (g_10_7,p_10_7,g_10_9,p_10_9,g_8_7,p_8_7) and2( w0g_10_7, p_10_9, g_8_7 )#5 or2( g_10_7, w0g_10_7, g_10_9 )#5 and2( p_10_7, p_10_9, p_8_7)#5 end netlist // PGcombine (g_11_8,p_11_8,g_11_10,p_11_10,g_9_8,p_9_8) and2( w0g_11_8, p_11_10, g_9_8 )#5 or2( g_11_8, w0g_11_8, g_11_10 )#5 and2( p_11_8, p_11_10, p_9_8)#5 end netlist // PGcombine (g_12_9,p_12_9,g_12_11,p_12_11,g_10_9,p_10_9) and2( w0g_12_9, p_12_11, g_10_9 )#5 or2( g_12_9, w0g_12_9, g_12_11 )#5 and2( p_12_9, p_12_11, p_10_9)#5 end netlist // PGcombine (g_13_10,p_13_10,g_13_12,p_13_12,g_11_10,p_11_10) and2( w0g_13_10, p_13_12, g_11_10 )#5 or2( g_13_10, w0g_13_10, g_13_12 )#5 and2( p_13_10, p_13_12, p_11_10)#5 end netlist // PGcombine (g_14_11,p_14_11,g_14_13,p_14_13,g_12_11,p_12_11) and2( w0g_14_11, p_14_13, g_12_11 )#5 or2( g_14_11, w0g_14_11, g_14_13 )#5 and2( p_14_11, p_14_13, p_12_11)#5 end netlist // PGcombine (g_15_12,p_15_12,g_15_14,p_15_14,g_13_12,p_13_12) and2( w0g_15_12, p_15_14, g_13_12 )#5 or2( g_15_12, w0g_15_12, g_15_14 )#5 and2( p_15_12, p_15_14, p_13_12)#5 end netlist // PGcombine (g_16_13,p_16_13,g_16_15,p_16_15,g_14_13,p_14_13) and2( w0g_16_13, p_16_15, g_14_13 )#5 or2( g_16_13, w0g_16_13, g_16_15 )#5 and2( p_16_13, p_16_15, p_14_13)#5 end netlist // PGcombine (g_17_14,p_17_14,g_17_16,p_17_16,g_15_14,p_15_14) and2( w0g_17_14, p_17_16, g_15_14 )#5 or2( g_17_14, w0g_17_14, g_17_16 )#5 and2( p_17_14, p_17_16, p_15_14)#5 end netlist // PGcombine (g_18_15,p_18_15,g_18_17,p_18_17,g_16_15,p_16_15) and2( w0g_18_15, p_18_17, g_16_15 )#5 or2( g_18_15, w0g_18_15, g_18_17 )#5 and2( p_18_15, p_18_17, p_16_15)#5 end netlist // PGcombine (g_19_16,p_19_16,g_19_18,p_19_18,g_17_16,p_17_16) and2( w0g_19_16, p_19_18, g_17_16 )#5 or2( g_19_16, w0g_19_16, g_19_18 )#5 and2( p_19_16, p_19_18, p_17_16)#5 end netlist // PGcombine (g_20_17,p_20_17,g_20_19,p_20_19,g_18_17,p_18_17) and2( w0g_20_17, p_20_19, g_18_17 )#5 or2( g_20_17, w0g_20_17, g_20_19 )#5 and2( p_20_17, p_20_19, p_18_17)#5 end netlist // PGcombine (g_21_18,p_21_18,g_21_20,p_21_20,g_19_18,p_19_18) and2( w0g_21_18, p_21_20, g_19_18 )#5 or2( g_21_18, w0g_21_18, g_21_20 )#5 and2( p_21_18, p_21_20, p_19_18)#5 end netlist // PGcombine (g_22_19,p_22_19,g_22_21,p_22_21,g_20_19,p_20_19) and2( w0g_22_19, p_22_21, g_20_19 )#5 or2( g_22_19, w0g_22_19, g_22_21 )#5 and2( p_22_19, p_22_21, p_20_19)#5 end netlist // PGcombine (g_23_20,p_23_20,g_23_22,p_23_22,g_21_20,p_21_20) and2( w0g_23_20, p_23_22, g_21_20 )#5 or2( g_23_20, w0g_23_20, g_23_22 )#5 and2( p_23_20, p_23_22, p_21_20)#5 end netlist // PGcombine (g_24_21,p_24_21,g_24_23,p_24_23,g_22_21,p_22_21) and2( w0g_24_21, p_24_23, g_22_21 )#5 or2( g_24_21, w0g_24_21, g_24_23 )#5 and2( p_24_21, p_24_23, p_22_21)#5 end netlist // PGcombine (g_25_22,p_25_22,g_25_24,p_25_24,g_23_22,p_23_22) and2( w0g_25_22, p_25_24, g_23_22 )#5 or2( g_25_22, w0g_25_22, g_25_24 )#5 and2( p_25_22, p_25_24, p_23_22)#5 end netlist // PGcombine (g_26_23,p_26_23,g_26_25,p_26_25,g_24_23,p_24_23) and2( w0g_26_23, p_26_25, g_24_23 )#5 or2( g_26_23, w0g_26_23, g_26_25 )#5 and2( p_26_23, p_26_25, p_24_23)#5 end netlist // PGcombine (g_27_24,p_27_24,g_27_26,p_27_26,g_25_24,p_25_24) and2( w0g_27_24, p_27_26, g_25_24 )#5 or2( g_27_24, w0g_27_24, g_27_26 )#5 and2( p_27_24, p_27_26, p_25_24)#5 end netlist // PGcombine (g_28_25,p_28_25,g_28_27,p_28_27,g_26_25,p_26_25) and2( w0g_28_25, p_28_27, g_26_25 )#5 or2( g_28_25, w0g_28_25, g_28_27 )#5 and2( p_28_25, p_28_27, p_26_25)#5 end netlist // PGcombine (g_29_26,p_29_26,g_29_28,p_29_28,g_27_26,p_27_26) and2( w0g_29_26, p_29_28, g_27_26 )#5 or2( g_29_26, w0g_29_26, g_29_28 )#5 and2( p_29_26, p_29_28, p_27_26)#5 end netlist // PGcombine (g_30_27,p_30_27,g_30_29,p_30_29,g_28_27,p_28_27) and2( w0g_30_27, p_30_29, g_28_27 )#5 or2( g_30_27, w0g_30_27, g_30_29 )#5 and2( p_30_27, p_30_29, p_28_27)#5 end netlist // PGcombine (g_31_28,p_31_28,g_31_30,p_31_30,g_29_28,p_29_28) and2( w0g_31_28, p_31_30, g_29_28 )#5 or2( g_31_28, w0g_31_28, g_31_30 )#5 and2( p_31_28, p_31_30, p_29_28)#5 end netlist // Gcombine (g_3_cin, g_3_0, cin, p_3_0 ) and2(w0g_3_cin, p_3_0, cin )#5 or2( g_3_cin, w0g_3_cin, g_3_0 )#5 end netlist // Gcombine (g_4_cin, g_4_1, g_0_cin, p_4_1 ) and2(w0g_4_cin, p_4_1, g_0_cin )#5 or2( g_4_cin, w0g_4_cin, g_4_1 )#5 end netlist // Gcombine (g_5_cin, g_5_2, g_1_cin, p_5_2 ) and2(w0g_5_cin, p_5_2, g_1_cin )#5 or2( g_5_cin, w0g_5_cin, g_5_2 )#5 end netlist // Gcombine (g_6_cin, g_6_3, g_2_cin, p_6_3 ) and2(w0g_6_cin, p_6_3, g_2_cin )#5 or2( g_6_cin, w0g_6_cin, g_6_3 )#5 end netlist // PGcombine (g_7_0,p_7_0,g_7_4,p_7_4,g_3_0,p_3_0) and2( w0g_7_0, p_7_4, g_3_0 )#5 or2( g_7_0, w0g_7_0, g_7_4 )#5 and2( p_7_0, p_7_4, p_3_0)#5 end netlist // PGcombine (g_8_1,p_8_1,g_8_5,p_8_5,g_4_1,p_4_1) and2( w0g_8_1, p_8_5, g_4_1 )#5 or2( g_8_1, w0g_8_1, g_8_5 )#5 and2( p_8_1, p_8_5, p_4_1)#5 end netlist // PGcombine (g_9_2,p_9_2,g_9_6,p_9_6,g_5_2,p_5_2) and2( w0g_9_2, p_9_6, g_5_2 )#5 or2( g_9_2, w0g_9_2, g_9_6 )#5 and2( p_9_2, p_9_6, p_5_2)#5 end netlist // PGcombine (g_10_3,p_10_3,g_10_7,p_10_7,g_6_3,p_6_3) and2( w0g_10_3, p_10_7, g_6_3 )#5 or2( g_10_3, w0g_10_3, g_10_7 )#5 and2( p_10_3, p_10_7, p_6_3)#5 end netlist // PGcombine (g_11_4,p_11_4,g_11_8,p_11_8,g_7_4,p_7_4) and2( w0g_11_4, p_11_8, g_7_4 )#5 or2( g_11_4, w0g_11_4, g_11_8 )#5 and2( p_11_4, p_11_8, p_7_4)#5 end netlist // PGcombine (g_12_5,p_12_5,g_12_9,p_12_9,g_8_5,p_8_5) and2( w0g_12_5, p_12_9, g_8_5 )#5 or2( g_12_5, w0g_12_5, g_12_9 )#5 and2( p_12_5, p_12_9, p_8_5)#5 end netlist // PGcombine (g_13_6,p_13_6,g_13_10,p_13_10,g_9_6,p_9_6) and2( w0g_13_6, p_13_10, g_9_6 )#5 or2( g_13_6, w0g_13_6, g_13_10 )#5 and2( p_13_6, p_13_10, p_9_6)#5 end netlist // PGcombine (g_14_7,p_14_7,g_14_11,p_14_11,g_10_7,p_10_7) and2( w0g_14_7, p_14_11, g_10_7 )#5 or2( g_14_7, w0g_14_7, g_14_11 )#5 and2( p_14_7, p_14_11, p_10_7)#5 end netlist // PGcombine (g_15_8,p_15_8,g_15_12,p_15_12,g_11_8,p_11_8) and2( w0g_15_8, p_15_12, g_11_8 )#5 or2( g_15_8, w0g_15_8, g_15_12 )#5 and2( p_15_8, p_15_12, p_11_8)#5 end netlist // PGcombine (g_16_9,p_16_9,g_16_13,p_16_13,g_12_9,p_12_9) and2( w0g_16_9, p_16_13, g_12_9 )#5 or2( g_16_9, w0g_16_9, g_16_13 )#5 and2( p_16_9, p_16_13, p_12_9)#5 end netlist // PGcombine (g_17_10,p_17_10,g_17_14,p_17_14,g_13_10,p_13_10) and2( w0g_17_10, p_17_14, g_13_10 )#5 or2( g_17_10, w0g_17_10, g_17_14 )#5 and2( p_17_10, p_17_14, p_13_10)#5 end netlist // PGcombine (g_18_11,p_18_11,g_18_15,p_18_15,g_14_11,p_14_11) and2( w0g_18_11, p_18_15, g_14_11 )#5 or2( g_18_11, w0g_18_11, g_18_15 )#5 and2( p_18_11, p_18_15, p_14_11)#5 end netlist // PGcombine (g_19_12,p_19_12,g_19_16,p_19_16,g_15_12,p_15_12) and2( w0g_19_12, p_19_16, g_15_12 )#5 or2( g_19_12, w0g_19_12, g_19_16 )#5 and2( p_19_12, p_19_16, p_15_12)#5 end netlist // PGcombine (g_20_13,p_20_13,g_20_17,p_20_17,g_16_13,p_16_13) and2( w0g_20_13, p_20_17, g_16_13 )#5 or2( g_20_13, w0g_20_13, g_20_17 )#5 and2( p_20_13, p_20_17, p_16_13)#5 end netlist // PGcombine (g_21_14,p_21_14,g_21_18,p_21_18,g_17_14,p_17_14) and2( w0g_21_14, p_21_18, g_17_14 )#5 or2( g_21_14, w0g_21_14, g_21_18 )#5 and2( p_21_14, p_21_18, p_17_14)#5 end netlist // PGcombine (g_22_15,p_22_15,g_22_19,p_22_19,g_18_15,p_18_15) and2( w0g_22_15, p_22_19, g_18_15 )#5 or2( g_22_15, w0g_22_15, g_22_19 )#5 and2( p_22_15, p_22_19, p_18_15)#5 end netlist // PGcombine (g_23_16,p_23_16,g_23_20,p_23_20,g_19_16,p_19_16) and2( w0g_23_16, p_23_20, g_19_16 )#5 or2( g_23_16, w0g_23_16, g_23_20 )#5 and2( p_23_16, p_23_20, p_19_16)#5 end netlist // PGcombine (g_24_17,p_24_17,g_24_21,p_24_21,g_20_17,p_20_17) and2( w0g_24_17, p_24_21, g_20_17 )#5 or2( g_24_17, w0g_24_17, g_24_21 )#5 and2( p_24_17, p_24_21, p_20_17)#5 end netlist // PGcombine (g_25_18,p_25_18,g_25_22,p_25_22,g_21_18,p_21_18) and2( w0g_25_18, p_25_22, g_21_18 )#5 or2( g_25_18, w0g_25_18, g_25_22 )#5 and2( p_25_18, p_25_22, p_21_18)#5 end netlist // PGcombine (g_26_19,p_26_19,g_26_23,p_26_23,g_22_19,p_22_19) and2( w0g_26_19, p_26_23, g_22_19 )#5 or2( g_26_19, w0g_26_19, g_26_23 )#5 and2( p_26_19, p_26_23, p_22_19)#5 end netlist // PGcombine (g_27_20,p_27_20,g_27_24,p_27_24,g_23_20,p_23_20) and2( w0g_27_20, p_27_24, g_23_20 )#5 or2( g_27_20, w0g_27_20, g_27_24 )#5 and2( p_27_20, p_27_24, p_23_20)#5 end netlist // PGcombine (g_28_21,p_28_21,g_28_25,p_28_25,g_24_21,p_24_21) and2( w0g_28_21, p_28_25, g_24_21 )#5 or2( g_28_21, w0g_28_21, g_28_25 )#5 and2( p_28_21, p_28_25, p_24_21)#5 end netlist // PGcombine (g_29_22,p_29_22,g_29_26,p_29_26,g_25_22,p_25_22) and2( w0g_29_22, p_29_26, g_25_22 )#5 or2( g_29_22, w0g_29_22, g_29_26 )#5 and2( p_29_22, p_29_26, p_25_22)#5 end netlist // PGcombine (g_30_23,p_30_23,g_30_27,p_30_27,g_26_23,p_26_23) and2( w0g_30_23, p_30_27, g_26_23 )#5 or2( g_30_23, w0g_30_23, g_30_27 )#5 and2( p_30_23, p_30_27, p_26_23)#5 end netlist // PGcombine (g_31_24,p_31_24,g_31_28,p_31_28,g_27_24,p_27_24) and2( w0g_31_24, p_31_28, g_27_24 )#5 or2( g_31_24, w0g_31_24, g_31_28 )#5 and2( p_31_24, p_31_28, p_27_24)#5 end netlist // Gcombine (g_7_cin, g_7_0, cin, p_7_0 ) and2(w0g_7_cin, p_7_0, cin )#5 or2( g_7_cin, w0g_7_cin, g_7_0 )#5 end netlist // Gcombine (g_8_cin, g_8_1, g_0_cin, p_8_1 ) and2(w0g_8_cin, p_8_1, g_0_cin )#5 or2( g_8_cin, w0g_8_cin, g_8_1 )#5 end netlist // Gcombine (g_9_cin, g_9_2, g_1_cin, p_9_2 ) and2(w0g_9_cin, p_9_2, g_1_cin )#5 or2( g_9_cin, w0g_9_cin, g_9_2 )#5 end netlist // Gcombine (g_10_cin, g_10_3, g_2_cin, p_10_3 ) and2(w0g_10_cin, p_10_3, g_2_cin )#5 or2( g_10_cin, w0g_10_cin, g_10_3 )#5 end netlist // Gcombine (g_11_cin, g_11_4, g_3_cin, p_11_4 ) and2(w0g_11_cin, p_11_4, g_3_cin )#5 or2( g_11_cin, w0g_11_cin, g_11_4 )#5 end netlist // Gcombine (g_12_cin, g_12_5, g_4_cin, p_12_5 ) and2(w0g_12_cin, p_12_5, g_4_cin )#5 or2( g_12_cin, w0g_12_cin, g_12_5 )#5 end netlist // Gcombine (g_13_cin, g_13_6, g_5_cin, p_13_6 ) and2(w0g_13_cin, p_13_6, g_5_cin )#5 or2( g_13_cin, w0g_13_cin, g_13_6 )#5 end netlist // Gcombine (g_14_cin, g_14_7, g_6_cin, p_14_7 ) and2(w0g_14_cin, p_14_7, g_6_cin )#5 or2( g_14_cin, w0g_14_cin, g_14_7 )#5 end netlist // PGcombine (g_15_0,p_15_0,g_15_8,p_15_8,g_7_0,p_7_0) and2( w0g_15_0, p_15_8, g_7_0 )#5 or2( g_15_0, w0g_15_0, g_15_8 )#5 and2( p_15_0, p_15_8, p_7_0)#5 end netlist // PGcombine (g_16_1,p_16_1,g_16_9,p_16_9,g_8_1,p_8_1) and2( w0g_16_1, p_16_9, g_8_1 )#5 or2( g_16_1, w0g_16_1, g_16_9 )#5 and2( p_16_1, p_16_9, p_8_1)#5 end netlist // PGcombine (g_17_2,p_17_2,g_17_10,p_17_10,g_9_2,p_9_2) and2( w0g_17_2, p_17_10, g_9_2 )#5 or2( g_17_2, w0g_17_2, g_17_10 )#5 and2( p_17_2, p_17_10, p_9_2)#5 end netlist // PGcombine (g_18_3,p_18_3,g_18_11,p_18_11,g_10_3,p_10_3) and2( w0g_18_3, p_18_11, g_10_3 )#5 or2( g_18_3, w0g_18_3, g_18_11 )#5 and2( p_18_3, p_18_11, p_10_3)#5 end netlist // PGcombine (g_19_4,p_19_4,g_19_12,p_19_12,g_11_4,p_11_4) and2( w0g_19_4, p_19_12, g_11_4 )#5 or2( g_19_4, w0g_19_4, g_19_12 )#5 and2( p_19_4, p_19_12, p_11_4)#5 end netlist // PGcombine (g_20_5,p_20_5,g_20_13,p_20_13,g_12_5,p_12_5) and2( w0g_20_5, p_20_13, g_12_5 )#5 or2( g_20_5, w0g_20_5, g_20_13 )#5 and2( p_20_5, p_20_13, p_12_5)#5 end netlist // PGcombine (g_21_6,p_21_6,g_21_14,p_21_14,g_13_6,p_13_6) and2( w0g_21_6, p_21_14, g_13_6 )#5 or2( g_21_6, w0g_21_6, g_21_14 )#5 and2( p_21_6, p_21_14, p_13_6)#5 end netlist // PGcombine (g_22_7,p_22_7,g_22_15,p_22_15,g_14_7,p_14_7) and2( w0g_22_7, p_22_15, g_14_7 )#5 or2( g_22_7, w0g_22_7, g_22_15 )#5 and2( p_22_7, p_22_15, p_14_7)#5 end netlist // PGcombine (g_23_8,p_23_8,g_23_16,p_23_16,g_15_8,p_15_8) and2( w0g_23_8, p_23_16, g_15_8 )#5 or2( g_23_8, w0g_23_8, g_23_16 )#5 and2( p_23_8, p_23_16, p_15_8)#5 end netlist // PGcombine (g_24_9,p_24_9,g_24_17,p_24_17,g_16_9,p_16_9) and2( w0g_24_9, p_24_17, g_16_9 )#5 or2( g_24_9, w0g_24_9, g_24_17 )#5 and2( p_24_9, p_24_17, p_16_9)#5 end netlist // PGcombine (g_25_10,p_25_10,g_25_18,p_25_18,g_17_10,p_17_10) and2( w0g_25_10, p_25_18, g_17_10 )#5 or2( g_25_10, w0g_25_10, g_25_18 )#5 and2( p_25_10, p_25_18, p_17_10)#5 end netlist // PGcombine (g_26_11,p_26_11,g_26_19,p_26_19,g_18_11,p_18_11) and2( w0g_26_11, p_26_19, g_18_11 )#5 or2( g_26_11, w0g_26_11, g_26_19 )#5 and2( p_26_11, p_26_19, p_18_11)#5 end netlist // PGcombine (g_27_12,p_27_12,g_27_20,p_27_20,g_19_12,p_19_12) and2( w0g_27_12, p_27_20, g_19_12 )#5 or2( g_27_12, w0g_27_12, g_27_20 )#5 and2( p_27_12, p_27_20, p_19_12)#5 end netlist // PGcombine (g_28_13,p_28_13,g_28_21,p_28_21,g_20_13,p_20_13) and2( w0g_28_13, p_28_21, g_20_13 )#5 or2( g_28_13, w0g_28_13, g_28_21 )#5 and2( p_28_13, p_28_21, p_20_13)#5 end netlist // PGcombine (g_29_14,p_29_14,g_29_22,p_29_22,g_21_14,p_21_14) and2( w0g_29_14, p_29_22, g_21_14 )#5 or2( g_29_14, w0g_29_14, g_29_22 )#5 and2( p_29_14, p_29_22, p_21_14)#5 end netlist // PGcombine (g_30_15,p_30_15,g_30_23,p_30_23,g_22_15,p_22_15) and2( w0g_30_15, p_30_23, g_22_15 )#5 or2( g_30_15, w0g_30_15, g_30_23 )#5 and2( p_30_15, p_30_23, p_22_15)#5 end netlist // PGcombine (g_31_16,p_31_16,g_31_24,p_31_24,g_23_16,p_23_16) and2( w0g_31_16, p_31_24, g_23_16 )#5 or2( g_31_16, w0g_31_16, g_31_24 )#5 and2( p_31_16, p_31_24, p_23_16)#5 end netlist // Gcombine (g_15_cin, g_15_0, cin, p_15_0 ) and2(w0g_15_cin, p_15_0, cin )#5 or2( g_15_cin, w0g_15_cin, g_15_0 )#5 end netlist // Gcombine (g_16_cin, g_16_1, g_0_cin, p_16_1 ) and2(w0g_16_cin, p_16_1, g_0_cin )#5 or2( g_16_cin, w0g_16_cin, g_16_1 )#5 end netlist // Gcombine (g_17_cin, g_17_2, g_1_cin, p_17_2 ) and2(w0g_17_cin, p_17_2, g_1_cin )#5 or2( g_17_cin, w0g_17_cin, g_17_2 )#5 end netlist // Gcombine (g_18_cin, g_18_3, g_2_cin, p_18_3 ) and2(w0g_18_cin, p_18_3, g_2_cin )#5 or2( g_18_cin, w0g_18_cin, g_18_3 )#5 end netlist // Gcombine (g_19_cin, g_19_4, g_3_cin, p_19_4 ) and2(w0g_19_cin, p_19_4, g_3_cin )#5 or2( g_19_cin, w0g_19_cin, g_19_4 )#5 end netlist // Gcombine (g_20_cin, g_20_5, g_4_cin, p_20_5 ) and2(w0g_20_cin, p_20_5, g_4_cin )#5 or2( g_20_cin, w0g_20_cin, g_20_5 )#5 end netlist // Gcombine (g_21_cin, g_21_6, g_5_cin, p_21_6 ) and2(w0g_21_cin, p_21_6, g_5_cin )#5 or2( g_21_cin, w0g_21_cin, g_21_6 )#5 end netlist // Gcombine (g_22_cin, g_22_7, g_6_cin, p_22_7 ) and2(w0g_22_cin, p_22_7, g_6_cin )#5 or2( g_22_cin, w0g_22_cin, g_22_7 )#5 end netlist // Gcombine (g_23_cin, g_23_8, g_7_cin, p_23_8 ) and2(w0g_23_cin, p_23_8, g_7_cin )#5 or2( g_23_cin, w0g_23_cin, g_23_8 )#5 end netlist // Gcombine (g_24_cin, g_24_9, g_8_cin, p_24_9 ) and2(w0g_24_cin, p_24_9, g_8_cin )#5 or2( g_24_cin, w0g_24_cin, g_24_9 )#5 end netlist // Gcombine (g_25_cin, g_25_10, g_9_cin, p_25_10 ) and2(w0g_25_cin, p_25_10, g_9_cin )#5 or2( g_25_cin, w0g_25_cin, g_25_10 )#5 end netlist // Gcombine (g_26_cin, g_26_11, g_10_cin, p_26_11 ) and2(w0g_26_cin, p_26_11, g_10_cin )#5 or2( g_26_cin, w0g_26_cin, g_26_11 )#5 end netlist // Gcombine (g_27_cin, g_27_12, g_11_cin, p_27_12 ) and2(w0g_27_cin, p_27_12, g_11_cin )#5 or2( g_27_cin, w0g_27_cin, g_27_12 )#5 end netlist // Gcombine (g_28_cin, g_28_13, g_12_cin, p_28_13 ) and2(w0g_28_cin, p_28_13, g_12_cin )#5 or2( g_28_cin, w0g_28_cin, g_28_13 )#5 end netlist // Gcombine (g_29_cin, g_29_14, g_13_cin, p_29_14 ) and2(w0g_29_cin, p_29_14, g_13_cin )#5 or2( g_29_cin, w0g_29_cin, g_29_14 )#5 end netlist // Gcombine (g_30_cin, g_30_15, g_14_cin, p_30_15 ) and2(w0g_30_cin, p_30_15, g_14_cin )#5 or2( g_30_cin, w0g_30_cin, g_30_15 )#5 end netlist // PGcombine (g_31_0,p_31_0,g_31_16,p_31_16,g_15_0,p_15_0) and2( w0g_31_0, p_31_16, g_15_0 )#5 or2( g_31_0, w0g_31_0, g_31_16 )#5 and2( p_31_0, p_31_16, p_15_0)#5 end netlist // Gcombine (cout, g_31_0, cin, p_31_0 ) and2(w0cout, p_31_0, cin )#5 or2( cout, w0cout, g_31_0 )#5 end netlist xor2( s0, p0,cin )#5 xor2( s1, p1,g_0_cin )#5 xor2( s2, p2,g_1_cin )#5 xor2( s3, p3,g_2_cin )#5 xor2( s4, p4,g_3_cin )#5 xor2( s5, p5,g_4_cin )#5 xor2( s6, p6,g_5_cin )#5 xor2( s7, p7,g_6_cin )#5 xor2( s8, p8,g_7_cin )#5 xor2( s9, p9,g_8_cin )#5 xor2( s10, p10,g_9_cin )#5 xor2( s11, p11,g_10_cin )#5 xor2( s12, p12,g_11_cin )#5 xor2( s13, p13,g_12_cin )#5 xor2( s14, p14,g_13_cin )#5 xor2( s15, p15,g_14_cin )#5 xor2( s16, p16,g_15_cin )#5 xor2( s17, p17,g_16_cin )#5 xor2( s18, p18,g_17_cin )#5 xor2( s19, p19,g_18_cin )#5 xor2( s20, p20,g_19_cin )#5 xor2( s21, p21,g_20_cin )#5 xor2( s22, p22,g_21_cin )#5 xor2( s23, p23,g_22_cin )#5 xor2( s24, p24,g_23_cin )#5 xor2( s25, p25,g_24_cin )#5 xor2( s26, p26,g_25_cin )#5 xor2( s27, p27,g_26_cin )#5 xor2( s28, p28,g_27_cin )#5 xor2( s29, p29,g_28_cin )#5 xor2( s30, p30,g_29_cin )#5 xor2( s31, p31,g_30_cin )#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/xor2x1NandArray1.net
inputs a0, b0, end outputs o0, end finish=10000 initlist a0 0, 0 end initlist b0 0, 0 end outvalues o0 0, end netlist nand2(x0,a0,b0)#40 nand2(y0,a0,x0)#40 nand2(z0,b0,x0)#40 nand2(o0,y0,z0)#40 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/treeMult4bit.net
finish 100000 inputs a0, a1, a2, a3, b0, b1, b2, b3, GND end outputs m0, m1, m2, m3, m4, m5, m6, m7, end outvalues m0 1, m1 0, m2 0, m3 0, m4 0, m5 1, m6 1, m7 1, end initlist GND 0 0 end initlist a0 0,0 63, 1 end initlist a1 0,0 8, 1 end initlist a2 0,0 6, 1 end initlist a3 0,0 10, 1 end initlist b0 0,0 72, 1 end initlist b1 0,0 100, 1 end initlist b2 0,0 70, 1 end initlist b3 0,0 13, 1 end netlist // mux2x1 Bth0.0( PP_0_0, GND, a0, b0 ) inv(b0_n.Bth0.0, b0 )#4 and2(w0.Bth0.0, b0_n.Bth0.0, GND )#4 and2(w1.Bth0.0, b0, a0 )#4 or2(PP_0_0, w0.Bth0.0, w1.Bth0.0 )#4 // end mux2x1 Bth0.0 end netlist // mux2x1 Bth0.1( PP_0_1, GND, a1, b0 ) inv(b0_n.Bth0.1, b0 )#4 and2(w0.Bth0.1, b0_n.Bth0.1, GND )#4 and2(w1.Bth0.1, b0, a1 )#4 or2(PP_0_1, w0.Bth0.1, w1.Bth0.1 )#4 // end mux2x1 Bth0.1 end netlist // mux2x1 Bth0.2( PP_0_2, GND, a2, b0 ) inv(b0_n.Bth0.2, b0 )#4 and2(w0.Bth0.2, b0_n.Bth0.2, GND )#4 and2(w1.Bth0.2, b0, a2 )#4 or2(PP_0_2, w0.Bth0.2, w1.Bth0.2 )#4 // end mux2x1 Bth0.2 end netlist // mux2x1 Bth0.3( PP_0_3, GND, a3, b0 ) inv(b0_n.Bth0.3, b0 )#4 and2(w0.Bth0.3, b0_n.Bth0.3, GND )#4 and2(w1.Bth0.3, b0, a3 )#4 or2(PP_0_3, w0.Bth0.3, w1.Bth0.3 )#4 // end mux2x1 Bth0.3 end netlist // mux2x1 Bth0.4( PP_0_4, GND, GND, b0 ) inv(b0_n.Bth0.4, b0 )#4 and2(w0.Bth0.4, b0_n.Bth0.4, GND )#4 and2(w1.Bth0.4, b0, GND )#4 or2(PP_0_4, w0.Bth0.4, w1.Bth0.4 )#4 // end mux2x1 Bth0.4 end netlist // mux2x1 Bth0.5( PP_0_5, GND, GND, b0 ) inv(b0_n.Bth0.5, b0 )#4 and2(w0.Bth0.5, b0_n.Bth0.5, GND )#4 and2(w1.Bth0.5, b0, GND )#4 or2(PP_0_5, w0.Bth0.5, w1.Bth0.5 )#4 // end mux2x1 Bth0.5 end netlist // mux2x1 Bth0.6( PP_0_6, GND, GND, b0 ) inv(b0_n.Bth0.6, b0 )#4 and2(w0.Bth0.6, b0_n.Bth0.6, GND )#4 and2(w1.Bth0.6, b0, GND )#4 or2(PP_0_6, w0.Bth0.6, w1.Bth0.6 )#4 // end mux2x1 Bth0.6 end netlist // mux2x1 Bth0.7( PP_0_7, GND, GND, b0 ) inv(b0_n.Bth0.7, b0 )#4 and2(w0.Bth0.7, b0_n.Bth0.7, GND )#4 and2(w1.Bth0.7, b0, GND )#4 or2(PP_0_7, w0.Bth0.7, w1.Bth0.7 )#4 // end mux2x1 Bth0.7 end netlist // mux2x1 Bth1.0( PP_1_0, GND, GND, b1 ) inv(b1_n.Bth1.0, b1 )#4 and2(w0.Bth1.0, b1_n.Bth1.0, GND )#4 and2(w1.Bth1.0, b1, GND )#4 or2(PP_1_0, w0.Bth1.0, w1.Bth1.0 )#4 // end mux2x1 Bth1.0 end netlist // mux2x1 Bth1.1( PP_1_1, GND, a0, b1 ) inv(b1_n.Bth1.1, b1 )#4 and2(w0.Bth1.1, b1_n.Bth1.1, GND )#4 and2(w1.Bth1.1, b1, a0 )#4 or2(PP_1_1, w0.Bth1.1, w1.Bth1.1 )#4 // end mux2x1 Bth1.1 end netlist // mux2x1 Bth1.2( PP_1_2, GND, a1, b1 ) inv(b1_n.Bth1.2, b1 )#4 and2(w0.Bth1.2, b1_n.Bth1.2, GND )#4 and2(w1.Bth1.2, b1, a1 )#4 or2(PP_1_2, w0.Bth1.2, w1.Bth1.2 )#4 // end mux2x1 Bth1.2 end netlist // mux2x1 Bth1.3( PP_1_3, GND, a2, b1 ) inv(b1_n.Bth1.3, b1 )#4 and2(w0.Bth1.3, b1_n.Bth1.3, GND )#4 and2(w1.Bth1.3, b1, a2 )#4 or2(PP_1_3, w0.Bth1.3, w1.Bth1.3 )#4 // end mux2x1 Bth1.3 end netlist // mux2x1 Bth1.4( PP_1_4, GND, a3, b1 ) inv(b1_n.Bth1.4, b1 )#4 and2(w0.Bth1.4, b1_n.Bth1.4, GND )#4 and2(w1.Bth1.4, b1, a3 )#4 or2(PP_1_4, w0.Bth1.4, w1.Bth1.4 )#4 // end mux2x1 Bth1.4 end netlist // mux2x1 Bth1.5( PP_1_5, GND, GND, b1 ) inv(b1_n.Bth1.5, b1 )#4 and2(w0.Bth1.5, b1_n.Bth1.5, GND )#4 and2(w1.Bth1.5, b1, GND )#4 or2(PP_1_5, w0.Bth1.5, w1.Bth1.5 )#4 // end mux2x1 Bth1.5 end netlist // mux2x1 Bth1.6( PP_1_6, GND, GND, b1 ) inv(b1_n.Bth1.6, b1 )#4 and2(w0.Bth1.6, b1_n.Bth1.6, GND )#4 and2(w1.Bth1.6, b1, GND )#4 or2(PP_1_6, w0.Bth1.6, w1.Bth1.6 )#4 // end mux2x1 Bth1.6 end netlist // mux2x1 Bth1.7( PP_1_7, GND, GND, b1 ) inv(b1_n.Bth1.7, b1 )#4 and2(w0.Bth1.7, b1_n.Bth1.7, GND )#4 and2(w1.Bth1.7, b1, GND )#4 or2(PP_1_7, w0.Bth1.7, w1.Bth1.7 )#4 // end mux2x1 Bth1.7 end netlist // mux2x1 Bth2.0( PP_2_0, GND, GND, b2 ) inv(b2_n.Bth2.0, b2 )#4 and2(w0.Bth2.0, b2_n.Bth2.0, GND )#4 and2(w1.Bth2.0, b2, GND )#4 or2(PP_2_0, w0.Bth2.0, w1.Bth2.0 )#4 // end mux2x1 Bth2.0 end netlist // mux2x1 Bth2.1( PP_2_1, GND, GND, b2 ) inv(b2_n.Bth2.1, b2 )#4 and2(w0.Bth2.1, b2_n.Bth2.1, GND )#4 and2(w1.Bth2.1, b2, GND )#4 or2(PP_2_1, w0.Bth2.1, w1.Bth2.1 )#4 // end mux2x1 Bth2.1 end netlist // mux2x1 Bth2.2( PP_2_2, GND, a0, b2 ) inv(b2_n.Bth2.2, b2 )#4 and2(w0.Bth2.2, b2_n.Bth2.2, GND )#4 and2(w1.Bth2.2, b2, a0 )#4 or2(PP_2_2, w0.Bth2.2, w1.Bth2.2 )#4 // end mux2x1 Bth2.2 end netlist // mux2x1 Bth2.3( PP_2_3, GND, a1, b2 ) inv(b2_n.Bth2.3, b2 )#4 and2(w0.Bth2.3, b2_n.Bth2.3, GND )#4 and2(w1.Bth2.3, b2, a1 )#4 or2(PP_2_3, w0.Bth2.3, w1.Bth2.3 )#4 // end mux2x1 Bth2.3 end netlist // mux2x1 Bth2.4( PP_2_4, GND, a2, b2 ) inv(b2_n.Bth2.4, b2 )#4 and2(w0.Bth2.4, b2_n.Bth2.4, GND )#4 and2(w1.Bth2.4, b2, a2 )#4 or2(PP_2_4, w0.Bth2.4, w1.Bth2.4 )#4 // end mux2x1 Bth2.4 end netlist // mux2x1 Bth2.5( PP_2_5, GND, a3, b2 ) inv(b2_n.Bth2.5, b2 )#4 and2(w0.Bth2.5, b2_n.Bth2.5, GND )#4 and2(w1.Bth2.5, b2, a3 )#4 or2(PP_2_5, w0.Bth2.5, w1.Bth2.5 )#4 // end mux2x1 Bth2.5 end netlist // mux2x1 Bth2.6( PP_2_6, GND, GND, b2 ) inv(b2_n.Bth2.6, b2 )#4 and2(w0.Bth2.6, b2_n.Bth2.6, GND )#4 and2(w1.Bth2.6, b2, GND )#4 or2(PP_2_6, w0.Bth2.6, w1.Bth2.6 )#4 // end mux2x1 Bth2.6 end netlist // mux2x1 Bth2.7( PP_2_7, GND, GND, b2 ) inv(b2_n.Bth2.7, b2 )#4 and2(w0.Bth2.7, b2_n.Bth2.7, GND )#4 and2(w1.Bth2.7, b2, GND )#4 or2(PP_2_7, w0.Bth2.7, w1.Bth2.7 )#4 // end mux2x1 Bth2.7 end netlist // mux2x1 Bth3.0( PP_3_0, GND, GND, b3 ) inv(b3_n.Bth3.0, b3 )#4 and2(w0.Bth3.0, b3_n.Bth3.0, GND )#4 and2(w1.Bth3.0, b3, GND )#4 or2(PP_3_0, w0.Bth3.0, w1.Bth3.0 )#4 // end mux2x1 Bth3.0 end netlist // mux2x1 Bth3.1( PP_3_1, GND, GND, b3 ) inv(b3_n.Bth3.1, b3 )#4 and2(w0.Bth3.1, b3_n.Bth3.1, GND )#4 and2(w1.Bth3.1, b3, GND )#4 or2(PP_3_1, w0.Bth3.1, w1.Bth3.1 )#4 // end mux2x1 Bth3.1 end netlist // mux2x1 Bth3.2( PP_3_2, GND, GND, b3 ) inv(b3_n.Bth3.2, b3 )#4 and2(w0.Bth3.2, b3_n.Bth3.2, GND )#4 and2(w1.Bth3.2, b3, GND )#4 or2(PP_3_2, w0.Bth3.2, w1.Bth3.2 )#4 // end mux2x1 Bth3.2 end netlist // mux2x1 Bth3.3( PP_3_3, GND, a0, b3 ) inv(b3_n.Bth3.3, b3 )#4 and2(w0.Bth3.3, b3_n.Bth3.3, GND )#4 and2(w1.Bth3.3, b3, a0 )#4 or2(PP_3_3, w0.Bth3.3, w1.Bth3.3 )#4 // end mux2x1 Bth3.3 end netlist // mux2x1 Bth3.4( PP_3_4, GND, a1, b3 ) inv(b3_n.Bth3.4, b3 )#4 and2(w0.Bth3.4, b3_n.Bth3.4, GND )#4 and2(w1.Bth3.4, b3, a1 )#4 or2(PP_3_4, w0.Bth3.4, w1.Bth3.4 )#4 // end mux2x1 Bth3.4 end netlist // mux2x1 Bth3.5( PP_3_5, GND, a2, b3 ) inv(b3_n.Bth3.5, b3 )#4 and2(w0.Bth3.5, b3_n.Bth3.5, GND )#4 and2(w1.Bth3.5, b3, a2 )#4 or2(PP_3_5, w0.Bth3.5, w1.Bth3.5 )#4 // end mux2x1 Bth3.5 end netlist // mux2x1 Bth3.6( PP_3_6, GND, a3, b3 ) inv(b3_n.Bth3.6, b3 )#4 and2(w0.Bth3.6, b3_n.Bth3.6, GND )#4 and2(w1.Bth3.6, b3, a3 )#4 or2(PP_3_6, w0.Bth3.6, w1.Bth3.6 )#4 // end mux2x1 Bth3.6 end netlist // mux2x1 Bth3.7( PP_3_7, GND, GND, b3 ) inv(b3_n.Bth3.7, b3 )#4 and2(w0.Bth3.7, b3_n.Bth3.7, GND )#4 and2(w1.Bth3.7, b3, GND )#4 or2(PP_3_7, w0.Bth3.7, w1.Bth3.7 )#4 // end mux2x1 Bth3.7 end // instantiating csa4x2Vec at lvl 0 netlist // csa4x2 (csa4x2_0_lvl0.0, s0_lvl0_0,t0_lvl0_0,cout_csa4x2_0_lvl0.0,PP_0_0,PP_1_0,PP_2_0,PP_3_0,GND) ; // adder1bit Adder0.csa4x2_0_lvl0.0( sintcsa4x2_0_lvl0.0, cout_csa4x2_0_lvl0.0, PP_0_0, PP_1_0, PP_2_0) // sum nand2( w0.Adder0.csa4x2_0_lvl0.0, PP_0_0, PP_1_0 )#5 nand2( w1.Adder0.csa4x2_0_lvl0.0, PP_0_0, w0.Adder0.csa4x2_0_lvl0.0 )#5 nand2( w2.Adder0.csa4x2_0_lvl0.0, PP_1_0, w0.Adder0.csa4x2_0_lvl0.0 )#5 nand2( w3.Adder0.csa4x2_0_lvl0.0, w1.Adder0.csa4x2_0_lvl0.0, w2.Adder0.csa4x2_0_lvl0.0 )#5 nand2( w4.Adder0.csa4x2_0_lvl0.0, PP_2_0, w3.Adder0.csa4x2_0_lvl0.0 )#5 nand2( w5.Adder0.csa4x2_0_lvl0.0, PP_2_0, w4.Adder0.csa4x2_0_lvl0.0 )#5 nand2( w6.Adder0.csa4x2_0_lvl0.0, w3.Adder0.csa4x2_0_lvl0.0, w4.Adder0.csa4x2_0_lvl0.0 )#5 nand2( sintcsa4x2_0_lvl0.0, w5.Adder0.csa4x2_0_lvl0.0, w6.Adder0.csa4x2_0_lvl0.0 )#5 //cout and2( w7.Adder0.csa4x2_0_lvl0.0, PP_0_0, PP_1_0 )#5 and2( w8.Adder0.csa4x2_0_lvl0.0, PP_0_0, PP_2_0 )#5 and2( w9.Adder0.csa4x2_0_lvl0.0, PP_2_0, PP_1_0 )#5 or2( w10.Adder0.csa4x2_0_lvl0.0, w7.Adder0.csa4x2_0_lvl0.0, w8.Adder0.csa4x2_0_lvl0.0 )#5 or2( cout_csa4x2_0_lvl0.0, w9.Adder0.csa4x2_0_lvl0.0, w10.Adder0.csa4x2_0_lvl0.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.0( s0_lvl0_0, t0_lvl0_0, sintcsa4x2_0_lvl0.0, PP_3_0, GND) // sum nand2( w0.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, PP_3_0 )#5 nand2( w1.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, w0.Adder1.csa4x2_0_lvl0.0 )#5 nand2( w2.Adder1.csa4x2_0_lvl0.0, PP_3_0, w0.Adder1.csa4x2_0_lvl0.0 )#5 nand2( w3.Adder1.csa4x2_0_lvl0.0, w1.Adder1.csa4x2_0_lvl0.0, w2.Adder1.csa4x2_0_lvl0.0 )#5 nand2( w4.Adder1.csa4x2_0_lvl0.0, GND, w3.Adder1.csa4x2_0_lvl0.0 )#5 nand2( w5.Adder1.csa4x2_0_lvl0.0, GND, w4.Adder1.csa4x2_0_lvl0.0 )#5 nand2( w6.Adder1.csa4x2_0_lvl0.0, w3.Adder1.csa4x2_0_lvl0.0, w4.Adder1.csa4x2_0_lvl0.0 )#5 nand2( s0_lvl0_0, w5.Adder1.csa4x2_0_lvl0.0, w6.Adder1.csa4x2_0_lvl0.0 )#5 //cout and2( w7.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, PP_3_0 )#5 and2( w8.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, GND )#5 and2( w9.Adder1.csa4x2_0_lvl0.0, GND, PP_3_0 )#5 or2( w10.Adder1.csa4x2_0_lvl0.0, w7.Adder1.csa4x2_0_lvl0.0, w8.Adder1.csa4x2_0_lvl0.0 )#5 or2( t0_lvl0_0, w9.Adder1.csa4x2_0_lvl0.0, w10.Adder1.csa4x2_0_lvl0.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.1, s0_lvl0_1,t0_lvl0_1,cout_csa4x2_0_lvl0.1,PP_0_1,PP_1_1,PP_2_1,PP_3_1,cout_csa4x2_0_lvl0.0) ; // adder1bit Adder0.csa4x2_0_lvl0.1( sintcsa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.1, PP_0_1, PP_1_1, PP_2_1) // sum nand2( w0.Adder0.csa4x2_0_lvl0.1, PP_0_1, PP_1_1 )#5 nand2( w1.Adder0.csa4x2_0_lvl0.1, PP_0_1, w0.Adder0.csa4x2_0_lvl0.1 )#5 nand2( w2.Adder0.csa4x2_0_lvl0.1, PP_1_1, w0.Adder0.csa4x2_0_lvl0.1 )#5 nand2( w3.Adder0.csa4x2_0_lvl0.1, w1.Adder0.csa4x2_0_lvl0.1, w2.Adder0.csa4x2_0_lvl0.1 )#5 nand2( w4.Adder0.csa4x2_0_lvl0.1, PP_2_1, w3.Adder0.csa4x2_0_lvl0.1 )#5 nand2( w5.Adder0.csa4x2_0_lvl0.1, PP_2_1, w4.Adder0.csa4x2_0_lvl0.1 )#5 nand2( w6.Adder0.csa4x2_0_lvl0.1, w3.Adder0.csa4x2_0_lvl0.1, w4.Adder0.csa4x2_0_lvl0.1 )#5 nand2( sintcsa4x2_0_lvl0.1, w5.Adder0.csa4x2_0_lvl0.1, w6.Adder0.csa4x2_0_lvl0.1 )#5 //cout and2( w7.Adder0.csa4x2_0_lvl0.1, PP_0_1, PP_1_1 )#5 and2( w8.Adder0.csa4x2_0_lvl0.1, PP_0_1, PP_2_1 )#5 and2( w9.Adder0.csa4x2_0_lvl0.1, PP_2_1, PP_1_1 )#5 or2( w10.Adder0.csa4x2_0_lvl0.1, w7.Adder0.csa4x2_0_lvl0.1, w8.Adder0.csa4x2_0_lvl0.1 )#5 or2( cout_csa4x2_0_lvl0.1, w9.Adder0.csa4x2_0_lvl0.1, w10.Adder0.csa4x2_0_lvl0.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.1( s0_lvl0_1, t0_lvl0_1, sintcsa4x2_0_lvl0.1, PP_3_1, cout_csa4x2_0_lvl0.0) // sum nand2( w0.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, PP_3_1 )#5 nand2( w1.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, w0.Adder1.csa4x2_0_lvl0.1 )#5 nand2( w2.Adder1.csa4x2_0_lvl0.1, PP_3_1, w0.Adder1.csa4x2_0_lvl0.1 )#5 nand2( w3.Adder1.csa4x2_0_lvl0.1, w1.Adder1.csa4x2_0_lvl0.1, w2.Adder1.csa4x2_0_lvl0.1 )#5 nand2( w4.Adder1.csa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0, w3.Adder1.csa4x2_0_lvl0.1 )#5 nand2( w5.Adder1.csa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0, w4.Adder1.csa4x2_0_lvl0.1 )#5 nand2( w6.Adder1.csa4x2_0_lvl0.1, w3.Adder1.csa4x2_0_lvl0.1, w4.Adder1.csa4x2_0_lvl0.1 )#5 nand2( s0_lvl0_1, w5.Adder1.csa4x2_0_lvl0.1, w6.Adder1.csa4x2_0_lvl0.1 )#5 //cout and2( w7.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, PP_3_1 )#5 and2( w8.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0 )#5 and2( w9.Adder1.csa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0, PP_3_1 )#5 or2( w10.Adder1.csa4x2_0_lvl0.1, w7.Adder1.csa4x2_0_lvl0.1, w8.Adder1.csa4x2_0_lvl0.1 )#5 or2( t0_lvl0_1, w9.Adder1.csa4x2_0_lvl0.1, w10.Adder1.csa4x2_0_lvl0.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.2, s0_lvl0_2,t0_lvl0_2,cout_csa4x2_0_lvl0.2,PP_0_2,PP_1_2,PP_2_2,PP_3_2,cout_csa4x2_0_lvl0.1) ; // adder1bit Adder0.csa4x2_0_lvl0.2( sintcsa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.2, PP_0_2, PP_1_2, PP_2_2) // sum nand2( w0.Adder0.csa4x2_0_lvl0.2, PP_0_2, PP_1_2 )#5 nand2( w1.Adder0.csa4x2_0_lvl0.2, PP_0_2, w0.Adder0.csa4x2_0_lvl0.2 )#5 nand2( w2.Adder0.csa4x2_0_lvl0.2, PP_1_2, w0.Adder0.csa4x2_0_lvl0.2 )#5 nand2( w3.Adder0.csa4x2_0_lvl0.2, w1.Adder0.csa4x2_0_lvl0.2, w2.Adder0.csa4x2_0_lvl0.2 )#5 nand2( w4.Adder0.csa4x2_0_lvl0.2, PP_2_2, w3.Adder0.csa4x2_0_lvl0.2 )#5 nand2( w5.Adder0.csa4x2_0_lvl0.2, PP_2_2, w4.Adder0.csa4x2_0_lvl0.2 )#5 nand2( w6.Adder0.csa4x2_0_lvl0.2, w3.Adder0.csa4x2_0_lvl0.2, w4.Adder0.csa4x2_0_lvl0.2 )#5 nand2( sintcsa4x2_0_lvl0.2, w5.Adder0.csa4x2_0_lvl0.2, w6.Adder0.csa4x2_0_lvl0.2 )#5 //cout and2( w7.Adder0.csa4x2_0_lvl0.2, PP_0_2, PP_1_2 )#5 and2( w8.Adder0.csa4x2_0_lvl0.2, PP_0_2, PP_2_2 )#5 and2( w9.Adder0.csa4x2_0_lvl0.2, PP_2_2, PP_1_2 )#5 or2( w10.Adder0.csa4x2_0_lvl0.2, w7.Adder0.csa4x2_0_lvl0.2, w8.Adder0.csa4x2_0_lvl0.2 )#5 or2( cout_csa4x2_0_lvl0.2, w9.Adder0.csa4x2_0_lvl0.2, w10.Adder0.csa4x2_0_lvl0.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.2( s0_lvl0_2, t0_lvl0_2, sintcsa4x2_0_lvl0.2, PP_3_2, cout_csa4x2_0_lvl0.1) // sum nand2( w0.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, PP_3_2 )#5 nand2( w1.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, w0.Adder1.csa4x2_0_lvl0.2 )#5 nand2( w2.Adder1.csa4x2_0_lvl0.2, PP_3_2, w0.Adder1.csa4x2_0_lvl0.2 )#5 nand2( w3.Adder1.csa4x2_0_lvl0.2, w1.Adder1.csa4x2_0_lvl0.2, w2.Adder1.csa4x2_0_lvl0.2 )#5 nand2( w4.Adder1.csa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1, w3.Adder1.csa4x2_0_lvl0.2 )#5 nand2( w5.Adder1.csa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1, w4.Adder1.csa4x2_0_lvl0.2 )#5 nand2( w6.Adder1.csa4x2_0_lvl0.2, w3.Adder1.csa4x2_0_lvl0.2, w4.Adder1.csa4x2_0_lvl0.2 )#5 nand2( s0_lvl0_2, w5.Adder1.csa4x2_0_lvl0.2, w6.Adder1.csa4x2_0_lvl0.2 )#5 //cout and2( w7.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, PP_3_2 )#5 and2( w8.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1 )#5 and2( w9.Adder1.csa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1, PP_3_2 )#5 or2( w10.Adder1.csa4x2_0_lvl0.2, w7.Adder1.csa4x2_0_lvl0.2, w8.Adder1.csa4x2_0_lvl0.2 )#5 or2( t0_lvl0_2, w9.Adder1.csa4x2_0_lvl0.2, w10.Adder1.csa4x2_0_lvl0.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.3, s0_lvl0_3,t0_lvl0_3,cout_csa4x2_0_lvl0.3,PP_0_3,PP_1_3,PP_2_3,PP_3_3,cout_csa4x2_0_lvl0.2) ; // adder1bit Adder0.csa4x2_0_lvl0.3( sintcsa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.3, PP_0_3, PP_1_3, PP_2_3) // sum nand2( w0.Adder0.csa4x2_0_lvl0.3, PP_0_3, PP_1_3 )#5 nand2( w1.Adder0.csa4x2_0_lvl0.3, PP_0_3, w0.Adder0.csa4x2_0_lvl0.3 )#5 nand2( w2.Adder0.csa4x2_0_lvl0.3, PP_1_3, w0.Adder0.csa4x2_0_lvl0.3 )#5 nand2( w3.Adder0.csa4x2_0_lvl0.3, w1.Adder0.csa4x2_0_lvl0.3, w2.Adder0.csa4x2_0_lvl0.3 )#5 nand2( w4.Adder0.csa4x2_0_lvl0.3, PP_2_3, w3.Adder0.csa4x2_0_lvl0.3 )#5 nand2( w5.Adder0.csa4x2_0_lvl0.3, PP_2_3, w4.Adder0.csa4x2_0_lvl0.3 )#5 nand2( w6.Adder0.csa4x2_0_lvl0.3, w3.Adder0.csa4x2_0_lvl0.3, w4.Adder0.csa4x2_0_lvl0.3 )#5 nand2( sintcsa4x2_0_lvl0.3, w5.Adder0.csa4x2_0_lvl0.3, w6.Adder0.csa4x2_0_lvl0.3 )#5 //cout and2( w7.Adder0.csa4x2_0_lvl0.3, PP_0_3, PP_1_3 )#5 and2( w8.Adder0.csa4x2_0_lvl0.3, PP_0_3, PP_2_3 )#5 and2( w9.Adder0.csa4x2_0_lvl0.3, PP_2_3, PP_1_3 )#5 or2( w10.Adder0.csa4x2_0_lvl0.3, w7.Adder0.csa4x2_0_lvl0.3, w8.Adder0.csa4x2_0_lvl0.3 )#5 or2( cout_csa4x2_0_lvl0.3, w9.Adder0.csa4x2_0_lvl0.3, w10.Adder0.csa4x2_0_lvl0.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.3( s0_lvl0_3, t0_lvl0_3, sintcsa4x2_0_lvl0.3, PP_3_3, cout_csa4x2_0_lvl0.2) // sum nand2( w0.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, PP_3_3 )#5 nand2( w1.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, w0.Adder1.csa4x2_0_lvl0.3 )#5 nand2( w2.Adder1.csa4x2_0_lvl0.3, PP_3_3, w0.Adder1.csa4x2_0_lvl0.3 )#5 nand2( w3.Adder1.csa4x2_0_lvl0.3, w1.Adder1.csa4x2_0_lvl0.3, w2.Adder1.csa4x2_0_lvl0.3 )#5 nand2( w4.Adder1.csa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2, w3.Adder1.csa4x2_0_lvl0.3 )#5 nand2( w5.Adder1.csa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2, w4.Adder1.csa4x2_0_lvl0.3 )#5 nand2( w6.Adder1.csa4x2_0_lvl0.3, w3.Adder1.csa4x2_0_lvl0.3, w4.Adder1.csa4x2_0_lvl0.3 )#5 nand2( s0_lvl0_3, w5.Adder1.csa4x2_0_lvl0.3, w6.Adder1.csa4x2_0_lvl0.3 )#5 //cout and2( w7.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, PP_3_3 )#5 and2( w8.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2 )#5 and2( w9.Adder1.csa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2, PP_3_3 )#5 or2( w10.Adder1.csa4x2_0_lvl0.3, w7.Adder1.csa4x2_0_lvl0.3, w8.Adder1.csa4x2_0_lvl0.3 )#5 or2( t0_lvl0_3, w9.Adder1.csa4x2_0_lvl0.3, w10.Adder1.csa4x2_0_lvl0.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.4, s0_lvl0_4,t0_lvl0_4,cout_csa4x2_0_lvl0.4,PP_0_4,PP_1_4,PP_2_4,PP_3_4,cout_csa4x2_0_lvl0.3) ; // adder1bit Adder0.csa4x2_0_lvl0.4( sintcsa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.4, PP_0_4, PP_1_4, PP_2_4) // sum nand2( w0.Adder0.csa4x2_0_lvl0.4, PP_0_4, PP_1_4 )#5 nand2( w1.Adder0.csa4x2_0_lvl0.4, PP_0_4, w0.Adder0.csa4x2_0_lvl0.4 )#5 nand2( w2.Adder0.csa4x2_0_lvl0.4, PP_1_4, w0.Adder0.csa4x2_0_lvl0.4 )#5 nand2( w3.Adder0.csa4x2_0_lvl0.4, w1.Adder0.csa4x2_0_lvl0.4, w2.Adder0.csa4x2_0_lvl0.4 )#5 nand2( w4.Adder0.csa4x2_0_lvl0.4, PP_2_4, w3.Adder0.csa4x2_0_lvl0.4 )#5 nand2( w5.Adder0.csa4x2_0_lvl0.4, PP_2_4, w4.Adder0.csa4x2_0_lvl0.4 )#5 nand2( w6.Adder0.csa4x2_0_lvl0.4, w3.Adder0.csa4x2_0_lvl0.4, w4.Adder0.csa4x2_0_lvl0.4 )#5 nand2( sintcsa4x2_0_lvl0.4, w5.Adder0.csa4x2_0_lvl0.4, w6.Adder0.csa4x2_0_lvl0.4 )#5 //cout and2( w7.Adder0.csa4x2_0_lvl0.4, PP_0_4, PP_1_4 )#5 and2( w8.Adder0.csa4x2_0_lvl0.4, PP_0_4, PP_2_4 )#5 and2( w9.Adder0.csa4x2_0_lvl0.4, PP_2_4, PP_1_4 )#5 or2( w10.Adder0.csa4x2_0_lvl0.4, w7.Adder0.csa4x2_0_lvl0.4, w8.Adder0.csa4x2_0_lvl0.4 )#5 or2( cout_csa4x2_0_lvl0.4, w9.Adder0.csa4x2_0_lvl0.4, w10.Adder0.csa4x2_0_lvl0.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.4( s0_lvl0_4, t0_lvl0_4, sintcsa4x2_0_lvl0.4, PP_3_4, cout_csa4x2_0_lvl0.3) // sum nand2( w0.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, PP_3_4 )#5 nand2( w1.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, w0.Adder1.csa4x2_0_lvl0.4 )#5 nand2( w2.Adder1.csa4x2_0_lvl0.4, PP_3_4, w0.Adder1.csa4x2_0_lvl0.4 )#5 nand2( w3.Adder1.csa4x2_0_lvl0.4, w1.Adder1.csa4x2_0_lvl0.4, w2.Adder1.csa4x2_0_lvl0.4 )#5 nand2( w4.Adder1.csa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3, w3.Adder1.csa4x2_0_lvl0.4 )#5 nand2( w5.Adder1.csa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3, w4.Adder1.csa4x2_0_lvl0.4 )#5 nand2( w6.Adder1.csa4x2_0_lvl0.4, w3.Adder1.csa4x2_0_lvl0.4, w4.Adder1.csa4x2_0_lvl0.4 )#5 nand2( s0_lvl0_4, w5.Adder1.csa4x2_0_lvl0.4, w6.Adder1.csa4x2_0_lvl0.4 )#5 //cout and2( w7.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, PP_3_4 )#5 and2( w8.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3 )#5 and2( w9.Adder1.csa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3, PP_3_4 )#5 or2( w10.Adder1.csa4x2_0_lvl0.4, w7.Adder1.csa4x2_0_lvl0.4, w8.Adder1.csa4x2_0_lvl0.4 )#5 or2( t0_lvl0_4, w9.Adder1.csa4x2_0_lvl0.4, w10.Adder1.csa4x2_0_lvl0.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.5, s0_lvl0_5,t0_lvl0_5,cout_csa4x2_0_lvl0.5,PP_0_5,PP_1_5,PP_2_5,PP_3_5,cout_csa4x2_0_lvl0.4) ; // adder1bit Adder0.csa4x2_0_lvl0.5( sintcsa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.5, PP_0_5, PP_1_5, PP_2_5) // sum nand2( w0.Adder0.csa4x2_0_lvl0.5, PP_0_5, PP_1_5 )#5 nand2( w1.Adder0.csa4x2_0_lvl0.5, PP_0_5, w0.Adder0.csa4x2_0_lvl0.5 )#5 nand2( w2.Adder0.csa4x2_0_lvl0.5, PP_1_5, w0.Adder0.csa4x2_0_lvl0.5 )#5 nand2( w3.Adder0.csa4x2_0_lvl0.5, w1.Adder0.csa4x2_0_lvl0.5, w2.Adder0.csa4x2_0_lvl0.5 )#5 nand2( w4.Adder0.csa4x2_0_lvl0.5, PP_2_5, w3.Adder0.csa4x2_0_lvl0.5 )#5 nand2( w5.Adder0.csa4x2_0_lvl0.5, PP_2_5, w4.Adder0.csa4x2_0_lvl0.5 )#5 nand2( w6.Adder0.csa4x2_0_lvl0.5, w3.Adder0.csa4x2_0_lvl0.5, w4.Adder0.csa4x2_0_lvl0.5 )#5 nand2( sintcsa4x2_0_lvl0.5, w5.Adder0.csa4x2_0_lvl0.5, w6.Adder0.csa4x2_0_lvl0.5 )#5 //cout and2( w7.Adder0.csa4x2_0_lvl0.5, PP_0_5, PP_1_5 )#5 and2( w8.Adder0.csa4x2_0_lvl0.5, PP_0_5, PP_2_5 )#5 and2( w9.Adder0.csa4x2_0_lvl0.5, PP_2_5, PP_1_5 )#5 or2( w10.Adder0.csa4x2_0_lvl0.5, w7.Adder0.csa4x2_0_lvl0.5, w8.Adder0.csa4x2_0_lvl0.5 )#5 or2( cout_csa4x2_0_lvl0.5, w9.Adder0.csa4x2_0_lvl0.5, w10.Adder0.csa4x2_0_lvl0.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.5( s0_lvl0_5, t0_lvl0_5, sintcsa4x2_0_lvl0.5, PP_3_5, cout_csa4x2_0_lvl0.4) // sum nand2( w0.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, PP_3_5 )#5 nand2( w1.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, w0.Adder1.csa4x2_0_lvl0.5 )#5 nand2( w2.Adder1.csa4x2_0_lvl0.5, PP_3_5, w0.Adder1.csa4x2_0_lvl0.5 )#5 nand2( w3.Adder1.csa4x2_0_lvl0.5, w1.Adder1.csa4x2_0_lvl0.5, w2.Adder1.csa4x2_0_lvl0.5 )#5 nand2( w4.Adder1.csa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4, w3.Adder1.csa4x2_0_lvl0.5 )#5 nand2( w5.Adder1.csa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4, w4.Adder1.csa4x2_0_lvl0.5 )#5 nand2( w6.Adder1.csa4x2_0_lvl0.5, w3.Adder1.csa4x2_0_lvl0.5, w4.Adder1.csa4x2_0_lvl0.5 )#5 nand2( s0_lvl0_5, w5.Adder1.csa4x2_0_lvl0.5, w6.Adder1.csa4x2_0_lvl0.5 )#5 //cout and2( w7.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, PP_3_5 )#5 and2( w8.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4 )#5 and2( w9.Adder1.csa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4, PP_3_5 )#5 or2( w10.Adder1.csa4x2_0_lvl0.5, w7.Adder1.csa4x2_0_lvl0.5, w8.Adder1.csa4x2_0_lvl0.5 )#5 or2( t0_lvl0_5, w9.Adder1.csa4x2_0_lvl0.5, w10.Adder1.csa4x2_0_lvl0.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.6, s0_lvl0_6,t0_lvl0_6,cout_csa4x2_0_lvl0.6,PP_0_6,PP_1_6,PP_2_6,PP_3_6,cout_csa4x2_0_lvl0.5) ; // adder1bit Adder0.csa4x2_0_lvl0.6( sintcsa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.6, PP_0_6, PP_1_6, PP_2_6) // sum nand2( w0.Adder0.csa4x2_0_lvl0.6, PP_0_6, PP_1_6 )#5 nand2( w1.Adder0.csa4x2_0_lvl0.6, PP_0_6, w0.Adder0.csa4x2_0_lvl0.6 )#5 nand2( w2.Adder0.csa4x2_0_lvl0.6, PP_1_6, w0.Adder0.csa4x2_0_lvl0.6 )#5 nand2( w3.Adder0.csa4x2_0_lvl0.6, w1.Adder0.csa4x2_0_lvl0.6, w2.Adder0.csa4x2_0_lvl0.6 )#5 nand2( w4.Adder0.csa4x2_0_lvl0.6, PP_2_6, w3.Adder0.csa4x2_0_lvl0.6 )#5 nand2( w5.Adder0.csa4x2_0_lvl0.6, PP_2_6, w4.Adder0.csa4x2_0_lvl0.6 )#5 nand2( w6.Adder0.csa4x2_0_lvl0.6, w3.Adder0.csa4x2_0_lvl0.6, w4.Adder0.csa4x2_0_lvl0.6 )#5 nand2( sintcsa4x2_0_lvl0.6, w5.Adder0.csa4x2_0_lvl0.6, w6.Adder0.csa4x2_0_lvl0.6 )#5 //cout and2( w7.Adder0.csa4x2_0_lvl0.6, PP_0_6, PP_1_6 )#5 and2( w8.Adder0.csa4x2_0_lvl0.6, PP_0_6, PP_2_6 )#5 and2( w9.Adder0.csa4x2_0_lvl0.6, PP_2_6, PP_1_6 )#5 or2( w10.Adder0.csa4x2_0_lvl0.6, w7.Adder0.csa4x2_0_lvl0.6, w8.Adder0.csa4x2_0_lvl0.6 )#5 or2( cout_csa4x2_0_lvl0.6, w9.Adder0.csa4x2_0_lvl0.6, w10.Adder0.csa4x2_0_lvl0.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.6( s0_lvl0_6, t0_lvl0_6, sintcsa4x2_0_lvl0.6, PP_3_6, cout_csa4x2_0_lvl0.5) // sum nand2( w0.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, PP_3_6 )#5 nand2( w1.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, w0.Adder1.csa4x2_0_lvl0.6 )#5 nand2( w2.Adder1.csa4x2_0_lvl0.6, PP_3_6, w0.Adder1.csa4x2_0_lvl0.6 )#5 nand2( w3.Adder1.csa4x2_0_lvl0.6, w1.Adder1.csa4x2_0_lvl0.6, w2.Adder1.csa4x2_0_lvl0.6 )#5 nand2( w4.Adder1.csa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5, w3.Adder1.csa4x2_0_lvl0.6 )#5 nand2( w5.Adder1.csa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5, w4.Adder1.csa4x2_0_lvl0.6 )#5 nand2( w6.Adder1.csa4x2_0_lvl0.6, w3.Adder1.csa4x2_0_lvl0.6, w4.Adder1.csa4x2_0_lvl0.6 )#5 nand2( s0_lvl0_6, w5.Adder1.csa4x2_0_lvl0.6, w6.Adder1.csa4x2_0_lvl0.6 )#5 //cout and2( w7.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, PP_3_6 )#5 and2( w8.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5 )#5 and2( w9.Adder1.csa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5, PP_3_6 )#5 or2( w10.Adder1.csa4x2_0_lvl0.6, w7.Adder1.csa4x2_0_lvl0.6, w8.Adder1.csa4x2_0_lvl0.6 )#5 or2( t0_lvl0_6, w9.Adder1.csa4x2_0_lvl0.6, w10.Adder1.csa4x2_0_lvl0.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.7, s0_lvl0_7,t0_lvl0_7,cout_csa4x2_0_lvl0.7,PP_0_7,PP_1_7,PP_2_7,PP_3_7,cout_csa4x2_0_lvl0.6) ; // adder1bit Adder0.csa4x2_0_lvl0.7( sintcsa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.7, PP_0_7, PP_1_7, PP_2_7) // sum nand2( w0.Adder0.csa4x2_0_lvl0.7, PP_0_7, PP_1_7 )#5 nand2( w1.Adder0.csa4x2_0_lvl0.7, PP_0_7, w0.Adder0.csa4x2_0_lvl0.7 )#5 nand2( w2.Adder0.csa4x2_0_lvl0.7, PP_1_7, w0.Adder0.csa4x2_0_lvl0.7 )#5 nand2( w3.Adder0.csa4x2_0_lvl0.7, w1.Adder0.csa4x2_0_lvl0.7, w2.Adder0.csa4x2_0_lvl0.7 )#5 nand2( w4.Adder0.csa4x2_0_lvl0.7, PP_2_7, w3.Adder0.csa4x2_0_lvl0.7 )#5 nand2( w5.Adder0.csa4x2_0_lvl0.7, PP_2_7, w4.Adder0.csa4x2_0_lvl0.7 )#5 nand2( w6.Adder0.csa4x2_0_lvl0.7, w3.Adder0.csa4x2_0_lvl0.7, w4.Adder0.csa4x2_0_lvl0.7 )#5 nand2( sintcsa4x2_0_lvl0.7, w5.Adder0.csa4x2_0_lvl0.7, w6.Adder0.csa4x2_0_lvl0.7 )#5 //cout and2( w7.Adder0.csa4x2_0_lvl0.7, PP_0_7, PP_1_7 )#5 and2( w8.Adder0.csa4x2_0_lvl0.7, PP_0_7, PP_2_7 )#5 and2( w9.Adder0.csa4x2_0_lvl0.7, PP_2_7, PP_1_7 )#5 or2( w10.Adder0.csa4x2_0_lvl0.7, w7.Adder0.csa4x2_0_lvl0.7, w8.Adder0.csa4x2_0_lvl0.7 )#5 or2( cout_csa4x2_0_lvl0.7, w9.Adder0.csa4x2_0_lvl0.7, w10.Adder0.csa4x2_0_lvl0.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.7( s0_lvl0_7, t0_lvl0_7, sintcsa4x2_0_lvl0.7, PP_3_7, cout_csa4x2_0_lvl0.6) // sum nand2( w0.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, PP_3_7 )#5 nand2( w1.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, w0.Adder1.csa4x2_0_lvl0.7 )#5 nand2( w2.Adder1.csa4x2_0_lvl0.7, PP_3_7, w0.Adder1.csa4x2_0_lvl0.7 )#5 nand2( w3.Adder1.csa4x2_0_lvl0.7, w1.Adder1.csa4x2_0_lvl0.7, w2.Adder1.csa4x2_0_lvl0.7 )#5 nand2( w4.Adder1.csa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6, w3.Adder1.csa4x2_0_lvl0.7 )#5 nand2( w5.Adder1.csa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6, w4.Adder1.csa4x2_0_lvl0.7 )#5 nand2( w6.Adder1.csa4x2_0_lvl0.7, w3.Adder1.csa4x2_0_lvl0.7, w4.Adder1.csa4x2_0_lvl0.7 )#5 nand2( s0_lvl0_7, w5.Adder1.csa4x2_0_lvl0.7, w6.Adder1.csa4x2_0_lvl0.7 )#5 //cout and2( w7.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, PP_3_7 )#5 and2( w8.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6 )#5 and2( w9.Adder1.csa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6, PP_3_7 )#5 or2( w10.Adder1.csa4x2_0_lvl0.7, w7.Adder1.csa4x2_0_lvl0.7, w8.Adder1.csa4x2_0_lvl0.7 )#5 or2( t0_lvl0_7, w9.Adder1.csa4x2_0_lvl0.7, w10.Adder1.csa4x2_0_lvl0.7 )#5 // end adder1bit // end csa4x2 end // genKoggeStoneVec(2*numBits, outVec, "cout", currRow->[0], currRow->[1], 'GND' ); netlist // PGgen (g0,p0,s0_lvl0_0,GND) xor2(p0,s0_lvl0_0,GND)#5 and2(g0,s0_lvl0_0,GND)#5 end netlist // PGgen (g1,p1,s0_lvl0_1,t0_lvl0_0) xor2(p1,s0_lvl0_1,t0_lvl0_0)#5 and2(g1,s0_lvl0_1,t0_lvl0_0)#5 end netlist // PGgen (g2,p2,s0_lvl0_2,t0_lvl0_1) xor2(p2,s0_lvl0_2,t0_lvl0_1)#5 and2(g2,s0_lvl0_2,t0_lvl0_1)#5 end netlist // PGgen (g3,p3,s0_lvl0_3,t0_lvl0_2) xor2(p3,s0_lvl0_3,t0_lvl0_2)#5 and2(g3,s0_lvl0_3,t0_lvl0_2)#5 end netlist // PGgen (g4,p4,s0_lvl0_4,t0_lvl0_3) xor2(p4,s0_lvl0_4,t0_lvl0_3)#5 and2(g4,s0_lvl0_4,t0_lvl0_3)#5 end netlist // PGgen (g5,p5,s0_lvl0_5,t0_lvl0_4) xor2(p5,s0_lvl0_5,t0_lvl0_4)#5 and2(g5,s0_lvl0_5,t0_lvl0_4)#5 end netlist // PGgen (g6,p6,s0_lvl0_6,t0_lvl0_5) xor2(p6,s0_lvl0_6,t0_lvl0_5)#5 and2(g6,s0_lvl0_6,t0_lvl0_5)#5 end netlist // PGgen (g7,p7,s0_lvl0_7,t0_lvl0_6) xor2(p7,s0_lvl0_7,t0_lvl0_6)#5 and2(g7,s0_lvl0_7,t0_lvl0_6)#5 end netlist // Gcombine (g_0_GND, g0, GND, p0 ) and2(w0g_0_GND, p0, GND )#5 or2( g_0_GND, w0g_0_GND, g0 )#5 end netlist // PGcombine (g_1_0,p_1_0,g1,g0,p1,p0) and2( w0g_1_0, g0, p1 )#5 or2( g_1_0, w0g_1_0, g1 )#5 and2( p_1_0, g0, p0)#5 end netlist // PGcombine (g_2_1,p_2_1,g2,g1,p2,p1) and2( w0g_2_1, g1, p2 )#5 or2( g_2_1, w0g_2_1, g2 )#5 and2( p_2_1, g1, p1)#5 end netlist // PGcombine (g_3_2,p_3_2,g3,g2,p3,p2) and2( w0g_3_2, g2, p3 )#5 or2( g_3_2, w0g_3_2, g3 )#5 and2( p_3_2, g2, p2)#5 end netlist // PGcombine (g_4_3,p_4_3,g4,g3,p4,p3) and2( w0g_4_3, g3, p4 )#5 or2( g_4_3, w0g_4_3, g4 )#5 and2( p_4_3, g3, p3)#5 end netlist // PGcombine (g_5_4,p_5_4,g5,g4,p5,p4) and2( w0g_5_4, g4, p5 )#5 or2( g_5_4, w0g_5_4, g5 )#5 and2( p_5_4, g4, p4)#5 end netlist // PGcombine (g_6_5,p_6_5,g6,g5,p6,p5) and2( w0g_6_5, g5, p6 )#5 or2( g_6_5, w0g_6_5, g6 )#5 and2( p_6_5, g5, p5)#5 end netlist // PGcombine (g_7_6,p_7_6,g7,g6,p7,p6) and2( w0g_7_6, g6, p7 )#5 or2( g_7_6, w0g_7_6, g7 )#5 and2( p_7_6, g6, p6)#5 end netlist // Gcombine (g_1_GND, g_1_0, GND, p_1_0 ) and2(w0g_1_GND, p_1_0, GND )#5 or2( g_1_GND, w0g_1_GND, g_1_0 )#5 end netlist // Gcombine (g_2_GND, g_2_1, g_0_GND, p_2_1 ) and2(w0g_2_GND, p_2_1, g_0_GND )#5 or2( g_2_GND, w0g_2_GND, g_2_1 )#5 end netlist // PGcombine (g_3_0,p_3_0,g_3_2,g_1_0,p_3_2,p_1_0) and2( w0g_3_0, g_1_0, p_3_2 )#5 or2( g_3_0, w0g_3_0, g_3_2 )#5 and2( p_3_0, g_1_0, p_1_0)#5 end netlist // PGcombine (g_4_1,p_4_1,g_4_3,g_2_1,p_4_3,p_2_1) and2( w0g_4_1, g_2_1, p_4_3 )#5 or2( g_4_1, w0g_4_1, g_4_3 )#5 and2( p_4_1, g_2_1, p_2_1)#5 end netlist // PGcombine (g_5_2,p_5_2,g_5_4,g_3_2,p_5_4,p_3_2) and2( w0g_5_2, g_3_2, p_5_4 )#5 or2( g_5_2, w0g_5_2, g_5_4 )#5 and2( p_5_2, g_3_2, p_3_2)#5 end netlist // PGcombine (g_6_3,p_6_3,g_6_5,g_4_3,p_6_5,p_4_3) and2( w0g_6_3, g_4_3, p_6_5 )#5 or2( g_6_3, w0g_6_3, g_6_5 )#5 and2( p_6_3, g_4_3, p_4_3)#5 end netlist // PGcombine (g_7_4,p_7_4,g_7_6,g_5_4,p_7_6,p_5_4) and2( w0g_7_4, g_5_4, p_7_6 )#5 or2( g_7_4, w0g_7_4, g_7_6 )#5 and2( p_7_4, g_5_4, p_5_4)#5 end netlist // Gcombine (g_3_GND, g_3_0, GND, p_3_0 ) and2(w0g_3_GND, p_3_0, GND )#5 or2( g_3_GND, w0g_3_GND, g_3_0 )#5 end netlist // Gcombine (g_4_GND, g_4_1, g_0_GND, p_4_1 ) and2(w0g_4_GND, p_4_1, g_0_GND )#5 or2( g_4_GND, w0g_4_GND, g_4_1 )#5 end netlist // Gcombine (g_5_GND, g_5_2, g_1_GND, p_5_2 ) and2(w0g_5_GND, p_5_2, g_1_GND )#5 or2( g_5_GND, w0g_5_GND, g_5_2 )#5 end netlist // Gcombine (g_6_GND, g_6_3, g_2_GND, p_6_3 ) and2(w0g_6_GND, p_6_3, g_2_GND )#5 or2( g_6_GND, w0g_6_GND, g_6_3 )#5 end netlist // PGcombine (g_7_0,p_7_0,g_7_4,g_3_0,p_7_4,p_3_0) and2( w0g_7_0, g_3_0, p_7_4 )#5 or2( g_7_0, w0g_7_0, g_7_4 )#5 and2( p_7_0, g_3_0, p_3_0)#5 end netlist // Gcombine (cout, g_7_0, GND, p_7_0 ) and2(w0cout, p_7_0, GND )#5 or2( cout, w0cout, g_7_0 )#5 end netlist xor2( m0, p0,GND ) xor2( m1, p1,g_0_GND ) xor2( m2, p2,g_1_GND ) xor2( m3, p3,g_2_GND ) xor2( m4, p4,g_3_GND ) xor2( m5, p5,g_4_GND ) xor2( m6, p6,g_5_GND ) xor2( m7, p7,g_6_GND ) end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/csaArray32.net
// Lonestar Benchmark Suite for irregular applications that exhibit // amorphous data-parallelism. // // Center for Grid and Distributed Computing // The University of Texas at Austin // // Copyright (C) 2007, 2008, 2009 The University of Texas at Austin // // Licensed under the Eclipse Public License, Version 1.0 (the "License"); // you may not use this file except in compliance with the License. // You may obtain a copy of the License at // // http://www.eclipse.org/legal/epl-v10.html // // Unless required by applicable law or agreed to in writing, software // distributed under the License is distributed on an "AS IS" BASIS, // WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. // See the License for the specific language governing permissions and // limitations under the License. // // File: csaArray32.net finish 100000 inputs a0, a1, a2, a3, a4, a5, a6, a7, a8, a9, a10, a11, a12, a13, a14, a15, a16, a17, a18, a19, a20, a21, a22, a23, a24, a25, a26, a27, a28, a29, a30, a31 b0, b1, b2, b3, b4, b5, b6, b7, b8, b9, b10, b11, b12, b13, b14, b15, b16, b17, b18, b19, b20, b21, b22, b23, b24, b25, b26, b27, b28, b29, b30, b31 c0, c1, c2, c3, c4, c5, c6, c7, c8, c9, c10, c11, c12, c13, c14, c15, c16, c17, c18, c19, c20, c21, c22, c23, c24, c25, c26, c27, c28, c29, c30, c31 end initlist a0 0,0 1,1 56,0 62,1 91,0 103,1 150,0 165,1 169,0 202,1 232,0 271,1 359,0 431,1 493,0 562,1 653,0 655,1 751,0 811,1 818,0 851,1 901,0 915,1 1005,0 1025,1 1097,0 1128,1 1169,0 1251,1 1329,0 1382,1 1451,0 1528,1 1627,0 1649,1 1731,0 1772,1 1805,0 1874,1 1906,0 1961,1 1977,0 1990,1 2054,0 2088,1 2137,0 2145,1 2200,0 2216,1 2230,0 2277,1 2327,0 2368,1 2462,0 2499,1 2560,0 2651,1 2727,0 2736,1 2743,0 2817,1 2897,0 2939,1 2996,0 3070,1 3139,0 3201,1 3237,0 3331,1 3334,0 3425,1 3433,0 3505,1 3564,0 3603,1 3647,0 3655,1 3666,0 3753,1 3786,0 3832,1 3885,0 3920,1 3941,0 4022,1 4102,0 4179,1 4270,0 4284,1 4312,0 4363,1 4388,0 4439,1 4487,0 4576,1 4604,0 4633,1 4723,0 4765,1 4827,0 4866,1 4951,0 4971,1 5002,0 5068,1 5087,0 5109,1 5171,0 5262,1 5348,0 5442,1 5515,0 5517,1 5535,0 5589,1 5673,0 5722,1 5818,0 5857,1 5956,0 5993,1 6009,0 6046,1 6118,0 6210,1 6220,0 6281,1 6315,0 6375,1 6388,0 6432,1 6476,0 6492,1 6564,0 6565,1 6566,0 6572,1 6634,0 6717,1 6792,0 6850,1 6855,0 6924,1 6962,0 7036,1 7064,0 7149,1 7156,0 7237,1 7264,0 7278,1 7314,0 7341,1 7417,0 7435,1 7444,0 7483,1 7561,0 7583,1 7614,0 7675,1 7704,0 7778,1 7861,0 7905,1 7958,0 7991,1 8089,0 8187,1 8258,0 8342,1 8356,0 8397,1 8475,0 8515,1 8559,0 8650,1 8713,0 8736,1 8753,0 8841,1 8918,0 8954,1 9053,0 9119,1 9131,0 9223,1 9319,0 9398,1 9485,0 9491,1 9548,0 9618,1 9687,0 9780,1 9805,0 9848,1 9886,0 9977,1 10017,0 10094,1 10164,0 10264,1 10341,0 10418,1 10507,0 10607,1 10611,0 10675,1 10709,0 10761,1 10779,0 10800,1 10812,0 10833,1 10886,0 10888,1 10919,0 10958,1 11039,0 11056,1 11119,0 11164,1 11212,0 11277,1 11326,0 11422,1 11492,0 11503,1 11534,0 11580,1 11664,0 11751,1 11845,0 11932,1 11955,0 12030,1 12078,0 12124,1 12143,0 12241,1 12252,0 12320,1 12324,0 12347,1 12417,0 12458,1 12472,0 12490,1 12546,0 12621,1 12719,0 12722,1 12794,0 12884,1 12896,0 12937,1 13030,0 13079,1 13089,0 13098,1 13192,0 13250,1 13257,0 13355,1 13415,0 13501,1 13590,0 13646,1 13698,0 13747,1 13806,0 13900,1 13960,0 13973,1 14002,0 14013,1 14107,0 14197,1 14244,0 14310,1 14380,0 14456,1 14488,0 14536,1 14636,0 14725,1 14765,0 14776,1 14782,0 14857,1 14902,0 14907,1 14962,0 15036,1 15055,0 15076,1 15163,0 15188,1 15205,0 15218,1 15315,0 15410,1 15509,0 15516,1 15568,0 15631,1 15716,0 15761,1 15790,0 15868,1 15880,0 15896,1 15924,0 15938,1 15944,0 16032,1 16047,0 16100,1 16173,0 16251,1 16273,0 16281,1 16305,0 16331,1 16344,0 16433,1 16503,0 16554,1 16574,0 16633,1 16639,0 16682,1 16685,0 16734,1 16783,0 16792,1 16871,0 16889,1 16914,0 16938,1 16983,0 17006,1 17034,0 17099,1 17197,0 17267,1 17290,0 17333,1 17396,0 17478,1 17486,0 17536,1 17537,0 17621,1 17694,0 17762,1 17846,0 17862,1 17944,0 17953,1 18051,0 18058,1 18128,0 18222,1 18312,0 18409,1 18439,0 18538,1 18568,0 18616,1 18710,0 18781,1 18802,0 18868,1 18968,0 19034,1 19112,0 19165,1 19201,0 19226,1 19268,0 19351,1 19411,0 19423,1 19429,0 19437,1 19480,0 19495,1 19538,0 19562,1 19633,0 19652,1 19682,0 19709,1 19729,0 19823,1 19889,0 19893,1 19946,0 19964,1 20052,0 20103,1 20121,0 20174,1 20227,0 20310,1 20354,0 20373,1 20410,0 20508,1 20586,0 20623,1 20631,0 20669,1 20731,0 20770,1 20791,0 20842,1 20881,0 20894,1 20903,0 20982,1 20985,0 21058,1 21073,0 21162,1 21217,0 21302,1 21368,0 21424,1 21459,0 21473,1 21559,0 21611,1 21695,0 21769,1 21804,0 21831,1 21915,0 21990,1 22020,0 22091,1 22093,0 22112,1 22182,0 22252,1 22275,0 22361,1 22422,0 22453,1 22534,0 22595,1 22620,0 22671,1 22705,0 22745,1 22815,0 22901,1 22980,0 23024,1 23028,0 23045,1 23069,0 23080,1 23151,0 23172,1 23262,0 23272,1 23318,0 23380,1 23432,0 23442,1 23483,0 23534,1 23538,0 23633,1 23636,0 23700,1 23719,0 23809,1 23817,0 23839,1 23878,0 23926,1 24010,0 24040,1 24124,0 24184,1 24279,0 24318,1 24335,0 24348,1 24424,0 24488,1 24551,0 24579,1 24618,0 24659,1 24741,0 24768,1 24791,0 24814,1 24861,0 24863,1 24866,0 24889,1 24931,0 24985,1 25040,0 25116,1 25164,0 25236,1 25286,0 25325,1 25423,0 25427,1 25468,0 25479,1 25480,0 25560,1 25615,0 25659,1 25733,0 25739,1 25808,0 25854,1 25906,0 25907,1 25988,0 26063,1 26120,0 26149,1 26191,0 26268,1 26278,0 26367,1 26403,0 26442,1 26479,0 26521,1 26600,0 26602,1 26620,0 26664,1 26713,0 26775,1 26780,0 26795,1 26879,0 26954,1 27004,0 27085,1 27086,0 27102,1 27177,0 27210,1 27247,0 27262,1 27325,0 27384,1 27467,0 27565,1 27629,0 27717,1 27784,0 27792,1 27845,0 27870,1 27939,0 27941,1 28020,0 28106,1 28157,0 28193,1 28285,0 28292,1 28385,0 28413,1 28449,0 28485,1 28565,0 28612,1 28710,0 28749,1 28843,0 28911,1 28968,0 29063,1 29133,0 29218,1 29267,0 29361,1 29416,0 29447,1 29505,0 29518,1 29546,0 29640,1 29737,0 29749,1 29833,0 29847,1 29853,0 29872,1 29886,0 29972,1 30043,0 30113,1 30212,0 30280,1 30332,0 30399,1 30484,0 30542,1 30564,0 30645,1 30727,0 30814,1 30858,0 30864,1 30890,0 30944,1 31038,0 31136,1 31144,0 31166,1 31228,0 31323,1 31381,0 31398,1 31474,0 31514,1 31544,0 31581,1 31679,0 31735,1 31743,0 31823,1 31861,0 31911,1 32001,0 32010,1 32086,0 32127,1 32161,0 32226,1 32240,0 32319,1 32392,0 32445,1 32516,0 32590,1 32663,0 32731,1 32803,0 32886,1 32939,0 32986,1 33061,0 33155,1 33213,0 33280,1 33328,0 33424,1 33498,0 33528,1 33560,0 33616,1 33648,0 33678,1 33709,0 33802,1 33822,0 33839,1 33890,0 33949,1 34025,0 34116,1 34128,0 34156,1 34219,0 34271,1 34360,0 34375,1 34457,0 34496,1 34539,0 34607,1 34663,0 34714,1 34805,0 34901,1 34920,0 34991,1 35051,0 35133,1 35150,0 35151,1 35209,0 35247,1 35330,0 35415,1 35497,0 35574,1 35655,0 35672,1 35698,0 35747,1 35764,0 35784,1 35802,0 35877,1 35939,0 35964,1 35984,0 36013,1 36039,0 36040,1 36093,0 36156,1 36171,0 36177,1 36246,0 36267,1 36347,0 36364,1 36394,0 36400,1 36439,0 36459,1 36500,0 36584,1 36618,0 36659,1 36745,0 36785,1 36837,0 36874,1 36896,0 36964,1 37050,0 37056,1 37108,0 37133,1 37202,0 37217,1 37315,0 37415,1 37461,0 37496,1 37576,0 37577,1 37666,0 37682,1 37684,0 37781,1 37819,0 37829,1 37919,0 37993,1 38014,0 38074,1 38092,0 38093,1 38178,0 38224,1 38260,0 38347,1 38376,0 38418,1 38443,0 38463,1 38475,0 38513,1 38604,0 38700,1 38751,0 38809,1 38861,0 38927,1 38932,0 38947,1 39018,0 39098,1 39148,0 39178,1 39227,0 39305,1 39394,0 39414,1 39443,0 39505,1 39595,0 39692,1 39708,0 39768,1 39821,0 39875,1 39957,0 39975,1 39979,0 40072,1 40131,0 40168,1 40209,0 40237,1 40277,0 40332,1 40403,0 40464,1 40545,0 40558,1 40578,0 40611,1 40647,0 40693,1 40783,0 40797,1 40856,0 40897,1 40929,0 40984,1 40990,0 41082,1 41125,0 41159,1 41255,0 41258,1 41299,0 41376,1 41442,0 41485,1 41505,0 41591,1 41675,0 41727,1 41766,0 41814,1 41904,0 41907,1 41918,0 41944,1 42014,0 42049,1 42133,0 42179,1 42212,0 42306,1 42355,0 42372,1 42433,0 42451,1 42549,0 42584,1 42652,0 42727,1 42815,0 42900,1 42956,0 42979,1 43013,0 43104,1 43173,0 43184,1 43257,0 43275,1 43353,0 43403,1 43454,0 43538,1 43550,0 43592,1 43648,0 43716,1 43813,0 43827,1 43879,0 43972,1 43974,0 44074,1 44166,0 44175,1 44219,0 44226,1 44264,0 44351,1 44378,0 44449,1 44522,0 44610,1 44660,0 44668,1 44754,0 44786,1 44832,0 44863,1 44959,0 45001,1 45043,0 45053,1 45100,0 45152,1 45184,0 45266,1 45336,0 45408,1 45486,0 45563,1 45599,0 45641,1 45737,0 45813,1 45833,0 45838,1 45843,0 45870,1 45912,0 45955,1 46004,0 46010,1 46039,0 46112,1 46190,0 46261,1 46293,0 46344,1 46411,0 46417,1 46503,0 46549,1 46636,0 46657,1 46670,0 46693,1 46736,0 46780,1 46805,0 46848,1 46853,0 46923,1 46971,0 46980,1 47039,0 47101,1 47122,0 47182,1 47268,0 47308,1 47329,0 47387,1 47392,0 47409,1 47502,0 47555,1 47640,0 47668,1 47749,0 47807,1 47850,0 47901,1 47913,0 47920,1 47969,0 48058,1 48097,0 48108,1 48112,0 48205,1 48236,0 48241,1 48273,0 48373,1 48431,0 48525,1 48526,0 48552,1 48603,0 48662,1 48737,0 48756,1 48762,0 48787,1 48811,0 48857,1 48916,0 49006,1 49038,0 49108,1 49155,0 49176,1 49241,0 49283,1 49353,0 49442,1 49523,0 49541,1 49587,0 49658,1 49727,0 49796,1 end initlist a1 0,0 13,1 94,0 130,1 131,0 136,1 140,0 165,1 181,0 253,1 320,0 329,1 425,0 445,1 467,0 479,1 540,0 541,1 602,0 683,1 770,0 825,1 890,0 913,1 940,0 955,1 962,0 1040,1 1131,0 1144,1 1205,0 1208,1 1259,0 1356,1 1382,0 1420,1 1493,0 1506,1 1593,0 1634,1 1648,0 1745,1 1829,0 1854,1 1895,0 1966,1 2016,0 2097,1 2128,0 2148,1 2161,0 2206,1 2284,0 2363,1 2375,0 2416,1 2501,0 2544,1 2573,0 2644,1 2651,0 2695,1 2706,0 2742,1 2756,0 2790,1 2839,0 2935,1 2969,0 3038,1 3086,0 3124,1 3162,0 3173,1 3224,0 3242,1 3268,0 3273,1 3371,0 3406,1 3432,0 3501,1 3516,0 3571,1 3588,0 3656,1 3685,0 3773,1 3816,0 3866,1 3922,0 3983,1 4019,0 4051,1 4106,0 4200,1 4225,0 4261,1 4334,0 4391,1 4443,0 4448,1 4533,0 4578,1 4630,0 4720,1 4785,0 4843,1 4862,0 4954,1 4957,0 5023,1 5095,0 5100,1 5195,0 5288,1 5292,0 5391,1 5410,0 5418,1 5449,0 5484,1 5518,0 5540,1 5561,0 5624,1 5704,0 5779,1 5807,0 5862,1 5960,0 6047,1 6137,0 6166,1 6265,0 6314,1 6338,0 6434,1 6483,0 6580,1 6650,0 6717,1 6762,0 6775,1 6802,0 6816,1 6896,0 6934,1 7007,0 7015,1 7027,0 7055,1 7063,0 7153,1 7194,0 7236,1 7331,0 7350,1 7373,0 7470,1 7538,0 7601,1 7694,0 7742,1 7769,0 7848,1 7880,0 7978,1 8063,0 8139,1 8166,0 8212,1 8229,0 8230,1 8255,0 8280,1 8297,0 8355,1 8370,0 8457,1 8542,0 8604,1 8611,0 8692,1 8715,0 8741,1 8749,0 8781,1 8837,0 8861,1 8959,0 9056,1 9062,0 9152,1 9248,0 9311,1 9407,0 9424,1 9495,0 9555,1 9602,0 9631,1 9679,0 9718,1 9806,0 9840,1 9920,0 10010,1 10100,0 10106,1 10201,0 10283,1 10357,0 10360,1 10372,0 10380,1 10421,0 10512,1 10534,0 10604,1 10649,0 10727,1 10791,0 10888,1 10960,0 11008,1 11048,0 11075,1 11171,0 11213,1 11297,0 11373,1 11383,0 11464,1 11489,0 11554,1 11582,0 11613,1 11701,0 11770,1 11802,0 11883,1 11944,0 11948,1 12037,0 12067,1 12095,0 12172,1 12180,0 12200,1 12255,0 12280,1 12371,0 12418,1 12439,0 12459,1 12465,0 12487,1 12575,0 12577,1 12598,0 12648,1 12675,0 12738,1 12776,0 12805,1 12830,0 12926,1 12937,0 12942,1 12947,0 13039,1 13138,0 13230,1 13250,0 13342,1 13415,0 13478,1 13517,0 13593,1 13677,0 13754,1 13827,0 13829,1 13882,0 13918,1 13978,0 14059,1 14101,0 14150,1 14247,0 14304,1 14367,0 14376,1 14443,0 14454,1 14474,0 14566,1 14624,0 14690,1 14777,0 14841,1 14930,0 14997,1 15009,0 15088,1 15119,0 15136,1 15185,0 15215,1 15264,0 15295,1 15304,0 15338,1 15415,0 15489,1 15521,0 15531,1 15550,0 15567,1 15648,0 15698,1 15781,0 15784,1 15819,0 15905,1 16002,0 16029,1 16124,0 16155,1 16187,0 16250,1 16264,0 16282,1 16347,0 16385,1 16453,0 16502,1 16602,0 16684,1 16729,0 16778,1 16791,0 16884,1 16924,0 16962,1 16990,0 17029,1 17111,0 17125,1 17141,0 17241,1 17341,0 17412,1 17437,0 17496,1 17556,0 17637,1 17690,0 17771,1 17843,0 17916,1 17919,0 17982,1 17994,0 18007,1 18077,0 18142,1 18156,0 18179,1 18240,0 18317,1 18331,0 18361,1 18382,0 18429,1 18453,0 18470,1 18561,0 18611,1 18694,0 18721,1 18795,0 18882,1 18936,0 18995,1 19056,0 19073,1 19166,0 19181,1 19202,0 19296,1 19303,0 19313,1 19402,0 19479,1 19499,0 19533,1 19569,0 19629,1 19667,0 19732,1 19785,0 19845,1 19850,0 19914,1 19998,0 20093,1 20128,0 20196,1 20268,0 20355,1 20381,0 20403,1 20427,0 20479,1 20493,0 20546,1 20578,0 20627,1 20723,0 20758,1 20822,0 20848,1 20927,0 21025,1 21106,0 21153,1 21217,0 21236,1 21301,0 21328,1 21347,0 21386,1 21468,0 21565,1 21592,0 21636,1 21697,0 21759,1 21810,0 21903,1 21978,0 22069,1 22112,0 22171,1 22181,0 22237,1 22239,0 22254,1 22263,0 22358,1 22409,0 22471,1 22487,0 22496,1 22513,0 22545,1 22560,0 22606,1 22632,0 22686,1 22716,0 22786,1 22884,0 22919,1 23009,0 23034,1 23087,0 23153,1 23242,0 23313,1 23315,0 23330,1 23373,0 23414,1 23480,0 23559,1 23614,0 23711,1 23762,0 23833,1 23907,0 23910,1 23941,0 23996,1 24004,0 24086,1 24119,0 24137,1 24183,0 24215,1 24252,0 24329,1 24401,0 24403,1 24414,0 24439,1 24535,0 24610,1 24643,0 24705,1 24769,0 24814,1 24854,0 24886,1 24919,0 24920,1 24941,0 24983,1 25029,0 25129,1 25203,0 25293,1 25375,0 25433,1 25531,0 25559,1 25626,0 25693,1 25694,0 25721,1 25797,0 25802,1 25856,0 25911,1 25939,0 25966,1 25999,0 26092,1 26146,0 26156,1 26193,0 26207,1 26224,0 26300,1 26398,0 26464,1 26528,0 26623,1 26675,0 26731,1 26800,0 26889,1 26942,0 27019,1 27094,0 27138,1 27209,0 27282,1 27314,0 27363,1 27406,0 27449,1 27543,0 27559,1 27633,0 27719,1 27765,0 27781,1 27873,0 27963,1 28042,0 28080,1 28087,0 28089,1 28130,0 28148,1 28212,0 28250,1 28347,0 28416,1 28501,0 28551,1 28620,0 28714,1 28745,0 28749,1 28834,0 28841,1 28856,0 28902,1 28952,0 29048,1 29117,0 29207,1 29267,0 29355,1 29382,0 29438,1 29477,0 29531,1 29623,0 29688,1 29776,0 29806,1 29852,0 29884,1 29899,0 29958,1 29997,0 30044,1 30045,0 30117,1 30130,0 30176,1 30233,0 30274,1 30313,0 30367,1 30443,0 30496,1 30592,0 30639,1 30735,0 30817,1 30824,0 30881,1 30886,0 30960,1 30964,0 30993,1 31014,0 31105,1 31114,0 31134,1 31146,0 31157,1 31165,0 31257,1 31336,0 31436,1 31457,0 31527,1 31566,0 31586,1 31618,0 31688,1 31729,0 31812,1 31823,0 31923,1 32009,0 32048,1 32113,0 32183,1 32250,0 32303,1 32306,0 32307,1 32386,0 32423,1 32493,0 32495,1 32578,0 32636,1 32725,0 32767,1 32791,0 32856,1 32884,0 32984,1 32991,0 33016,1 33078,0 33140,1 33184,0 33274,1 33361,0 33422,1 33430,0 33438,1 33476,0 33477,1 33482,0 33488,1 33492,0 33545,1 33635,0 33733,1 33738,0 33789,1 33794,0 33865,1 33871,0 33942,1 33998,0 34084,1 34105,0 34169,1 34202,0 34210,1 34267,0 34337,1 34365,0 34442,1 34501,0 34587,1 34604,0 34691,1 34770,0 34787,1 34811,0 34896,1 34915,0 34950,1 35000,0 35001,1 35002,0 35086,1 35106,0 35160,1 35171,0 35252,1 35345,0 35375,1 35413,0 35494,1 35497,0 35587,1 35607,0 35695,1 35795,0 35865,1 35897,0 35969,1 36015,0 36032,1 36045,0 36083,1 36096,0 36140,1 36217,0 36264,1 36357,0 36455,1 36492,0 36535,1 36613,0 36654,1 36741,0 36756,1 36807,0 36830,1 36845,0 36936,1 36988,0 36996,1 37093,0 37175,1 37182,0 37245,1 37322,0 37376,1 37392,0 37446,1 37492,0 37509,1 37521,0 37619,1 37643,0 37650,1 37698,0 37699,1 37788,0 37845,1 37873,0 37883,1 37925,0 37934,1 38031,0 38098,1 38100,0 38136,1 38138,0 38162,1 38166,0 38225,1 38287,0 38316,1 38380,0 38442,1 38532,0 38556,1 38572,0 38635,1 38636,0 38638,1 38709,0 38729,1 38817,0 38837,1 38894,0 38910,1 39003,0 39015,1 39055,0 39089,1 39173,0 39185,1 39244,0 39305,1 39321,0 39362,1 39388,0 39435,1 39465,0 39516,1 39575,0 39673,1 39723,0 39804,1 39851,0 39946,1 39966,0 40049,1 40077,0 40119,1 40192,0 40221,1 40283,0 40291,1 40358,0 40455,1 40491,0 40506,1 40603,0 40626,1 40638,0 40711,1 40808,0 40819,1 40911,0 40914,1 41003,0 41036,1 41070,0 41168,1 41181,0 41255,1 41261,0 41339,1 41360,0 41424,1 41463,0 41521,1 41572,0 41633,1 41640,0 41717,1 41743,0 41821,1 41842,0 41935,1 42023,0 42025,1 42043,0 42091,1 42178,0 42273,1 42361,0 42362,1 42455,0 42554,1 42622,0 42679,1 42778,0 42827,1 42844,0 42870,1 42933,0 42970,1 43041,0 43106,1 43195,0 43274,1 43290,0 43364,1 43419,0 43439,1 43499,0 43566,1 43653,0 43686,1 43731,0 43823,1 43923,0 43958,1 44047,0 44115,1 44215,0 44299,1 44354,0 44396,1 44398,0 44455,1 44523,0 44579,1 44618,0 44666,1 44700,0 44754,1 44759,0 44763,1 44848,0 44863,1 44941,0 44974,1 44985,0 44999,1 45083,0 45141,1 45165,0 45233,1 45312,0 45369,1 45399,0 45415,1 45442,0 45504,1 45546,0 45580,1 45678,0 45750,1 45771,0 45846,1 45880,0 45926,1 46023,0 46054,1 46087,0 46091,1 46110,0 46204,1 46287,0 46294,1 46385,0 46475,1 46481,0 46573,1 46595,0 46617,1 46645,0 46649,1 46702,0 46745,1 46806,0 46892,1 46957,0 47056,1 47134,0 47207,1 47282,0 47328,1 47334,0 47392,1 47472,0 47515,1 47587,0 47619,1 47667,0 47724,1 47771,0 47828,1 47852,0 47860,1 47906,0 47935,1 47942,0 47973,1 48017,0 48050,1 48060,0 48078,1 48171,0 48256,1 48274,0 48278,1 48360,0 48407,1 48475,0 48478,1 48537,0 48557,1 48635,0 48707,1 48746,0 48835,1 48926,0 48972,1 48989,0 49080,1 49178,0 49270,1 49320,0 49325,1 49348,0 49425,1 49471,0 49571,1 49653,0 49695,1 end initlist a2 0,0 71,1 130,0 153,1 155,0 240,1 330,0 398,1 470,0 569,1 608,0 636,1 698,0 733,1 801,0 834,1 847,0 895,1 957,0 976,1 1065,0 1114,1 1172,0 1176,1 1246,0 1303,1 1388,0 1431,1 1452,0 1470,1 1497,0 1513,1 1559,0 1641,1 1650,0 1655,1 1700,0 1716,1 1720,0 1729,1 1740,0 1760,1 1792,0 1877,1 1975,0 2060,1 2085,0 2184,1 2229,0 2289,1 2352,0 2428,1 2442,0 2498,1 2550,0 2573,1 2667,0 2696,1 2795,0 2853,1 2886,0 2971,1 3002,0 3075,1 3118,0 3124,1 3151,0 3190,1 3279,0 3378,1 3425,0 3474,1 3565,0 3574,1 3600,0 3605,1 3683,0 3697,1 3788,0 3812,1 3828,0 3863,1 3938,0 3963,1 4049,0 4109,1 4152,0 4194,1 4272,0 4318,1 4347,0 4358,1 4425,0 4456,1 4479,0 4524,1 4563,0 4641,1 4676,0 4749,1 4766,0 4852,1 4924,0 4978,1 5003,0 5010,1 5044,0 5054,1 5098,0 5153,1 5235,0 5267,1 5286,0 5297,1 5319,0 5412,1 5473,0 5489,1 5585,0 5610,1 5702,0 5746,1 5837,0 5842,1 5870,0 5968,1 6051,0 6080,1 6164,0 6180,1 6230,0 6311,1 6358,0 6442,1 6520,0 6586,1 6616,0 6647,1 6673,0 6761,1 6844,0 6870,1 6943,0 6976,1 6979,0 7054,1 7140,0 7178,1 7191,0 7210,1 7266,0 7335,1 7390,0 7418,1 7505,0 7517,1 7543,0 7608,1 7693,0 7735,1 7807,0 7856,1 7874,0 7878,1 7969,0 7983,1 8058,0 8104,1 8171,0 8246,1 8337,0 8403,1 8475,0 8561,1 8576,0 8599,1 8680,0 8696,1 8754,0 8783,1 8823,0 8894,1 8912,0 8998,1 9026,0 9064,1 9149,0 9202,1 9231,0 9273,1 9290,0 9337,1 9396,0 9453,1 9547,0 9572,1 9602,0 9651,1 9714,0 9782,1 9785,0 9877,1 9940,0 10005,1 10064,0 10099,1 10176,0 10268,1 10330,0 10343,1 10408,0 10489,1 10518,0 10578,1 10603,0 10685,1 10745,0 10842,1 10850,0 10855,1 10940,0 10981,1 11032,0 11059,1 11096,0 11158,1 11183,0 11212,1 11283,0 11381,1 11457,0 11494,1 11544,0 11633,1 11697,0 11707,1 11727,0 11745,1 11796,0 11821,1 11909,0 11997,1 12017,0 12115,1 12215,0 12315,1 12373,0 12443,1 12478,0 12495,1 12539,0 12607,1 12638,0 12711,1 12722,0 12788,1 12816,0 12839,1 12928,0 13022,1 13028,0 13093,1 13116,0 13184,1 13212,0 13296,1 13314,0 13343,1 13402,0 13475,1 13566,0 13592,1 13683,0 13690,1 13752,0 13831,1 13839,0 13922,1 13981,0 14061,1 14123,0 14202,1 14268,0 14330,1 14410,0 14422,1 14505,0 14579,1 14612,0 14701,1 14736,0 14802,1 14854,0 14908,1 14910,0 14991,1 14996,0 15089,1 15159,0 15161,1 15233,0 15315,1 15336,0 15347,1 15400,0 15452,1 15467,0 15492,1 15519,0 15613,1 15647,0 15648,1 15725,0 15799,1 15877,0 15967,1 16067,0 16162,1 16191,0 16212,1 16216,0 16272,1 16356,0 16427,1 16435,0 16493,1 16507,0 16562,1 16623,0 16691,1 16771,0 16776,1 16839,0 16909,1 16962,0 16999,1 17091,0 17111,1 17140,0 17148,1 17239,0 17272,1 17370,0 17383,1 17467,0 17488,1 17549,0 17574,1 17629,0 17709,1 17752,0 17770,1 17836,0 17915,1 17935,0 17937,1 18015,0 18092,1 18135,0 18142,1 18171,0 18242,1 18275,0 18371,1 18396,0 18397,1 18497,0 18503,1 18550,0 18560,1 18608,0 18658,1 18674,0 18677,1 18678,0 18744,1 18748,0 18787,1 18845,0 18907,1 18959,0 19001,1 19008,0 19012,1 19077,0 19166,1 19213,0 19259,1 19273,0 19309,1 19354,0 19378,1 19440,0 19540,1 19549,0 19553,1 19614,0 19638,1 19728,0 19821,1 19910,0 19945,1 20008,0 20066,1 20142,0 20146,1 20234,0 20272,1 20345,0 20346,1 20391,0 20487,1 20532,0 20569,1 20662,0 20744,1 20813,0 20875,1 20920,0 21011,1 21043,0 21066,1 21154,0 21171,1 21242,0 21284,1 21358,0 21414,1 21497,0 21513,1 21576,0 21630,1 21661,0 21678,1 21758,0 21824,1 21889,0 21983,1 22026,0 22068,1 22104,0 22149,1 22201,0 22271,1 22317,0 22403,1 22469,0 22528,1 22617,0 22620,1 22696,0 22765,1 22807,0 22837,1 22856,0 22893,1 22983,0 23071,1 23105,0 23110,1 23158,0 23238,1 23330,0 23390,1 23459,0 23465,1 23547,0 23584,1 23599,0 23660,1 23736,0 23751,1 23850,0 23911,1 23979,0 24021,1 24110,0 24149,1 24174,0 24211,1 24268,0 24339,1 24439,0 24519,1 24569,0 24585,1 24658,0 24664,1 24688,0 24760,1 24770,0 24870,1 24940,0 24972,1 25038,0 25044,1 25056,0 25146,1 25156,0 25229,1 25322,0 25370,1 25449,0 25500,1 25572,0 25605,1 25694,0 25717,1 25724,0 25786,1 25839,0 25844,1 25863,0 25884,1 25923,0 25971,1 26050,0 26116,1 26119,0 26129,1 26140,0 26210,1 26279,0 26335,1 26398,0 26445,1 26453,0 26503,1 26556,0 26579,1 26601,0 26683,1 26738,0 26837,1 26872,0 26893,1 26966,0 27033,1 27092,0 27128,1 27189,0 27282,1 27289,0 27371,1 27466,0 27560,1 27609,0 27671,1 27730,0 27813,1 27878,0 27887,1 27951,0 27972,1 28059,0 28124,1 28197,0 28291,1 28346,0 28374,1 28397,0 28439,1 28528,0 28586,1 28672,0 28737,1 28836,0 28870,1 28894,0 28961,1 29007,0 29055,1 29131,0 29158,1 29164,0 29234,1 29280,0 29297,1 29339,0 29393,1 29426,0 29489,1 29504,0 29519,1 29561,0 29577,1 29635,0 29642,1 29676,0 29705,1 29771,0 29865,1 29951,0 29958,1 30015,0 30026,1 30116,0 30131,1 30147,0 30236,1 30334,0 30431,1 30451,0 30467,1 30504,0 30578,1 30644,0 30692,1 30697,0 30748,1 30760,0 30812,1 30851,0 30864,1 30929,0 31003,1 31094,0 31097,1 31136,0 31138,1 31148,0 31230,1 31329,0 31370,1 31396,0 31428,1 31479,0 31489,1 31557,0 31570,1 31599,0 31657,1 31732,0 31821,1 31880,0 31893,1 31976,0 32014,1 32054,0 32125,1 32149,0 32204,1 32222,0 32292,1 32298,0 32348,1 32396,0 32419,1 32433,0 32492,1 32536,0 32598,1 32663,0 32755,1 32770,0 32814,1 32873,0 32903,1 32948,0 33036,1 33082,0 33092,1 33107,0 33181,1 33216,0 33262,1 33319,0 33387,1 33460,0 33533,1 33621,0 33651,1 33733,0 33826,1 33892,0 33978,1 33994,0 34033,1 34074,0 34129,1 34144,0 34224,1 34291,0 34378,1 34397,0 34439,1 34488,0 34571,1 34619,0 34673,1 34746,0 34792,1 34885,0 34971,1 34984,0 35025,1 35088,0 35171,1 35235,0 35313,1 35354,0 35413,1 35477,0 35576,1 35581,0 35635,1 35681,0 35726,1 35822,0 35837,1 35842,0 35896,1 35962,0 36006,1 36068,0 36124,1 36157,0 36202,1 36205,0 36300,1 36346,0 36403,1 36408,0 36430,1 36516,0 36535,1 36612,0 36658,1 36758,0 36823,1 36849,0 36890,1 36911,0 36970,1 37009,0 37054,1 37104,0 37129,1 37203,0 37254,1 37321,0 37366,1 37442,0 37479,1 37533,0 37612,1 37658,0 37726,1 37802,0 37830,1 37848,0 37944,1 37976,0 38015,1 38077,0 38146,1 38212,0 38310,1 38336,0 38341,1 38432,0 38512,1 38569,0 38631,1 38703,0 38794,1 38814,0 38853,1 38854,0 38925,1 39012,0 39102,1 39126,0 39200,1 39272,0 39340,1 39393,0 39406,1 39466,0 39534,1 39557,0 39615,1 39677,0 39714,1 39794,0 39814,1 39821,0 39906,1 39949,0 40011,1 40028,0 40029,1 40119,0 40137,1 40146,0 40224,1 40285,0 40363,1 40388,0 40399,1 40431,0 40494,1 40533,0 40567,1 40636,0 40639,1 40695,0 40776,1 40840,0 40871,1 40927,0 40959,1 40995,0 41074,1 41166,0 41201,1 41222,0 41313,1 41374,0 41430,1 41519,0 41612,1 41623,0 41679,1 41738,0 41814,1 41895,0 41945,1 41999,0 42024,1 42069,0 42085,1 42158,0 42178,1 42231,0 42316,1 42400,0 42467,1 42477,0 42548,1 42640,0 42644,1 42685,0 42724,1 42802,0 42891,1 42930,0 42960,1 42999,0 43005,1 43006,0 43062,1 43140,0 43160,1 43229,0 43233,1 43256,0 43325,1 43340,0 43422,1 43484,0 43547,1 43610,0 43661,1 43714,0 43716,1 43794,0 43890,1 43943,0 43972,1 44041,0 44138,1 44227,0 44264,1 44304,0 44396,1 44397,0 44416,1 44479,0 44493,1 44551,0 44589,1 44674,0 44731,1 44756,0 44844,1 44880,0 44966,1 44988,0 45066,1 45107,0 45114,1 45208,0 45231,1 45293,0 45357,1 45397,0 45403,1 45499,0 45525,1 45543,0 45623,1 45690,0 45740,1 45766,0 45847,1 45877,0 45912,1 45990,0 46047,1 46080,0 46180,1 46247,0 46329,1 46387,0 46481,1 46541,0 46578,1 46637,0 46690,1 46703,0 46794,1 46799,0 46895,1 46963,0 47045,1 47131,0 47160,1 47220,0 47242,1 47275,0 47355,1 47452,0 47516,1 47553,0 47591,1 47631,0 47695,1 47776,0 47787,1 47794,0 47873,1 47955,0 48012,1 48037,0 48057,1 48138,0 48175,1 48177,0 48215,1 48301,0 48398,1 48474,0 48558,1 48600,0 48633,1 48659,0 48687,1 48782,0 48795,1 48811,0 48901,1 48926,0 49008,1 49028,0 49119,1 49146,0 49177,1 49186,0 49275,1 49347,0 49371,1 49419,0 49438,1 49510,0 49581,1 49599,0 49634,1 49680,0 49710,1 49786,0 49834,1 49839,0 49911,1 49977,0 50077,1 50117,0 50135,1 50142,0 50148,1 50215,0 50216,1 50292,0 50304,1 50395,0 50425,1 50464,0 50551,1 50622,0 50647,1 50744,0 50797,1 end initlist a3 0,0 15,1 52,0 99,1 145,0 193,1 286,0 377,1 466,0 478,1 503,0 526,1 547,0 615,1 675,0 741,1 810,0 856,1 889,0 920,1 1005,0 1009,1 1025,0 1098,1 1172,0 1220,1 1306,0 1362,1 1398,0 1471,1 1536,0 1564,1 1592,0 1641,1 1718,0 1801,1 1885,0 1887,1 1892,0 1916,1 1959,0 1984,1 2072,0 2131,1 2163,0 2204,1 2226,0 2323,1 2340,0 2399,1 2433,0 2461,1 2558,0 2630,1 2729,0 2799,1 2817,0 2860,1 2906,0 2922,1 2968,0 3017,1 3107,0 3143,1 3209,0 3264,1 3338,0 3344,1 3381,0 3395,1 3461,0 3556,1 3604,0 3669,1 3671,0 3689,1 3748,0 3799,1 3888,0 3906,1 3925,0 3993,1 4008,0 4096,1 4100,0 4154,1 4240,0 4270,1 4289,0 4321,1 4370,0 4392,1 4405,0 4485,1 4519,0 4557,1 4621,0 4645,1 4649,0 4651,1 4705,0 4718,1 4803,0 4887,1 4959,0 5029,1 5062,0 5113,1 5199,0 5259,1 5304,0 5388,1 5437,0 5516,1 5598,0 5656,1 5687,0 5724,1 5761,0 5820,1 5841,0 5901,1 5962,0 5985,1 6000,0 6023,1 6073,0 6157,1 6210,0 6264,1 6337,0 6371,1 6471,0 6487,1 6559,0 6614,1 6617,0 6706,1 6713,0 6721,1 6773,0 6799,1 6845,0 6945,1 7014,0 7096,1 7110,0 7157,1 7193,0 7196,1 7264,0 7321,1 7398,0 7399,1 7498,0 7513,1 7608,0 7641,1 7730,0 7760,1 7811,0 7818,1 7820,0 7849,1 7926,0 8008,1 8019,0 8107,1 8195,0 8211,1 8247,0 8325,1 8355,0 8452,1 8481,0 8511,1 8516,0 8531,1 8562,0 8653,1 8691,0 8759,1 8798,0 8830,1 8869,0 8965,1 9003,0 9013,1 9092,0 9139,1 9141,0 9232,1 9268,0 9350,1 9399,0 9431,1 9467,0 9506,1 9526,0 9617,1 9662,0 9713,1 9780,0 9785,1 9831,0 9923,1 9988,0 9992,1 10072,0 10133,1 10173,0 10197,1 10279,0 10292,1 10324,0 10347,1 10407,0 10454,1 10500,0 10534,1 10615,0 10685,1 10690,0 10707,1 10793,0 10848,1 10885,0 10984,1 11027,0 11069,1 11094,0 11149,1 11157,0 11192,1 11264,0 11328,1 11360,0 11378,1 11472,0 11541,1 11565,0 11604,1 11704,0 11802,1 11871,0 11941,1 12038,0 12136,1 12184,0 12200,1 12204,0 12288,1 12332,0 12365,1 12414,0 12453,1 12487,0 12521,1 12542,0 12612,1 12658,0 12748,1 12770,0 12860,1 12917,0 12940,1 12999,0 13025,1 13045,0 13111,1 13119,0 13174,1 13212,0 13252,1 13305,0 13330,1 13347,0 13441,1 13530,0 13579,1 13603,0 13675,1 13740,0 13749,1 13814,0 13862,1 13931,0 13984,1 14076,0 14160,1 14211,0 14290,1 14376,0 14456,1 14516,0 14522,1 14590,0 14615,1 14653,0 14713,1 14775,0 14825,1 14840,0 14918,1 14959,0 15006,1 15093,0 15151,1 15241,0 15337,1 15392,0 15454,1 15490,0 15540,1 15631,0 15690,1 15755,0 15787,1 15825,0 15890,1 15986,0 16047,1 16130,0 16162,1 16172,0 16188,1 16191,0 16270,1 16319,0 16407,1 16497,0 16539,1 16542,0 16563,1 16608,0 16655,1 16725,0 16728,1 16784,0 16879,1 16932,0 16995,1 17031,0 17128,1 17210,0 17265,1 17284,0 17335,1 17367,0 17402,1 17489,0 17561,1 17576,0 17595,1 17681,0 17713,1 17741,0 17798,1 17815,0 17868,1 17880,0 17920,1 17923,0 18021,1 18090,0 18117,1 18171,0 18199,1 18264,0 18327,1 18361,0 18385,1 18386,0 18414,1 18422,0 18446,1 18524,0 18598,1 18619,0 18629,1 18639,0 18673,1 18713,0 18727,1 18802,0 18829,1 18920,0 18997,1 19078,0 19105,1 19143,0 19176,1 19187,0 19266,1 19271,0 19317,1 19329,0 19375,1 19427,0 19525,1 19624,0 19718,1 19743,0 19832,1 19844,0 19882,1 19910,0 19994,1 20039,0 20079,1 20167,0 20190,1 20265,0 20293,1 20309,0 20360,1 20419,0 20476,1 20518,0 20607,1 20645,0 20697,1 20760,0 20776,1 20797,0 20828,1 20898,0 20978,1 21056,0 21119,1 21151,0 21207,1 21305,0 21368,1 21377,0 21380,1 21453,0 21525,1 21563,0 21564,1 21600,0 21605,1 21608,0 21674,1 21714,0 21716,1 21758,0 21776,1 21789,0 21877,1 21962,0 21995,1 22007,0 22070,1 22087,0 22094,1 22189,0 22226,1 22244,0 22292,1 22309,0 22339,1 22378,0 22413,1 22423,0 22483,1 22533,0 22604,1 22638,0 22687,1 22752,0 22769,1 22850,0 22905,1 22947,0 22995,1 23045,0 23140,1 23170,0 23173,1 23206,0 23273,1 23330,0 23386,1 23400,0 23432,1 23487,0 23560,1 23607,0 23629,1 23709,0 23788,1 23813,0 23867,1 23883,0 23942,1 24002,0 24027,1 24049,0 24118,1 24143,0 24234,1 24305,0 24385,1 24466,0 24505,1 24566,0 24591,1 24609,0 24637,1 24708,0 24806,1 24864,0 24865,1 24890,0 24907,1 24911,0 24981,1 25010,0 25100,1 25122,0 25213,1 25285,0 25379,1 25410,0 25488,1 25496,0 25501,1 25552,0 25557,1 25571,0 25606,1 25617,0 25695,1 25709,0 25764,1 25771,0 25820,1 25841,0 25873,1 25911,0 25954,1 26048,0 26135,1 26172,0 26175,1 26184,0 26226,1 26227,0 26279,1 26372,0 26393,1 26482,0 26485,1 26509,0 26583,1 26587,0 26682,1 26717,0 26731,1 26787,0 26794,1 26846,0 26847,1 26855,0 26909,1 26961,0 27051,1 27104,0 27202,1 27286,0 27373,1 27416,0 27423,1 27460,0 27550,1 27559,0 27615,1 27678,0 27747,1 27827,0 27840,1 27916,0 28002,1 28019,0 28093,1 28112,0 28123,1 28145,0 28188,1 28214,0 28219,1 28274,0 28362,1 28450,0 28505,1 28540,0 28564,1 28617,0 28714,1 28813,0 28873,1 28929,0 28941,1 28984,0 28995,1 29077,0 29131,1 29189,0 29240,1 29286,0 29299,1 29324,0 29392,1 29482,0 29553,1 29637,0 29695,1 29787,0 29796,1 29841,0 29877,1 29898,0 29928,1 29987,0 30029,1 30046,0 30083,1 30110,0 30121,1 30179,0 30279,1 30304,0 30313,1 30316,0 30339,1 30345,0 30392,1 30401,0 30501,1 30579,0 30609,1 30643,0 30668,1 30750,0 30753,1 30762,0 30781,1 30841,0 30896,1 30928,0 31004,1 31061,0 31148,1 31177,0 31220,1 31306,0 31330,1 31386,0 31443,1 31526,0 31617,1 31657,0 31748,1 31779,0 31787,1 31791,0 31828,1 31845,0 31928,1 31936,0 31944,1 31950,0 32050,1 32091,0 32164,1 32218,0 32307,1 32384,0 32452,1 32480,0 32484,1 32529,0 32597,1 32613,0 32664,1 32735,0 32745,1 32763,0 32829,1 32882,0 32944,1 33025,0 33123,1 33146,0 33195,1 33207,0 33217,1 33308,0 33365,1 33444,0 33543,1 33553,0 33630,1 33712,0 33779,1 33849,0 33856,1 33956,0 34020,1 34112,0 34178,1 34252,0 34349,1 34380,0 34393,1 34457,0 34526,1 34579,0 34600,1 34612,0 34644,1 34705,0 34720,1 34741,0 34744,1 34844,0 34919,1 34957,0 34963,1 34976,0 35040,1 35140,0 35176,1 35258,0 35356,1 35417,0 35446,1 35518,0 35581,1 35664,0 35708,1 35729,0 35762,1 35782,0 35854,1 35859,0 35952,1 36003,0 36039,1 36082,0 36139,1 36233,0 36302,1 36332,0 36354,1 36390,0 36451,1 36550,0 36638,1 36729,0 36805,1 36897,0 36984,1 36998,0 37004,1 37039,0 37060,1 37120,0 37209,1 37253,0 37290,1 37304,0 37308,1 37395,0 37403,1 37428,0 37470,1 37515,0 37525,1 37545,0 37601,1 37680,0 37726,1 37729,0 37822,1 37901,0 37978,1 38013,0 38055,1 38110,0 38144,1 38149,0 38151,1 38159,0 38248,1 38341,0 38344,1 38443,0 38473,1 38530,0 38562,1 38587,0 38684,1 38731,0 38809,1 38891,0 38921,1 38950,0 39045,1 39124,0 39128,1 39129,0 39164,1 39232,0 39319,1 39340,0 39409,1 39490,0 39544,1 39556,0 39567,1 39600,0 39658,1 39715,0 39787,1 39856,0 39875,1 39962,0 40050,1 40055,0 40062,1 40078,0 40102,1 40139,0 40218,1 40291,0 40325,1 40392,0 40406,1 40467,0 40490,1 40584,0 40646,1 40715,0 40772,1 40793,0 40852,1 40904,0 40939,1 40958,0 40968,1 41052,0 41065,1 41120,0 41210,1 41287,0 41335,1 41346,0 41437,1 41494,0 41563,1 41608,0 41619,1 41699,0 41761,1 41785,0 41794,1 41854,0 41927,1 42011,0 42071,1 42163,0 42198,1 42199,0 42266,1 42278,0 42368,1 42457,0 42540,1 42629,0 42639,1 42708,0 42755,1 42756,0 42851,1 42926,0 43018,1 43111,0 43142,1 43226,0 43253,1 43299,0 43347,1 43378,0 43417,1 43496,0 43559,1 43590,0 43600,1 43694,0 43789,1 43845,0 43893,1 43954,0 44049,1 44146,0 44194,1 44253,0 44339,1 44360,0 44456,1 44481,0 44532,1 44576,0 44649,1 44730,0 44764,1 44820,0 44836,1 44837,0 44923,1 44995,0 45012,1 45041,0 45124,1 45156,0 45166,1 45170,0 45265,1 45350,0 45389,1 45460,0 45554,1 45566,0 45645,1 45675,0 45708,1 45713,0 45782,1 45806,0 45814,1 45843,0 45901,1 45957,0 46049,1 46118,0 46148,1 46163,0 46167,1 46174,0 46207,1 46280,0 46341,1 46436,0 46487,1 46491,0 46587,1 46603,0 46628,1 46629,0 46671,1 46692,0 46699,1 46782,0 46799,1 46885,0 46979,1 47003,0 47099,1 47100,0 47117,1 47124,0 47171,1 47251,0 47325,1 47354,0 47387,1 47406,0 47424,1 47426,0 47475,1 47484,0 47549,1 47634,0 47702,1 47742,0 47815,1 47884,0 47889,1 47947,0 47999,1 48035,0 48061,1 48159,0 48189,1 48244,0 48299,1 48343,0 48384,1 48478,0 48549,1 end initlist a4 0,0 18,1 45,0 50,1 117,0 198,1 255,0 335,1 350,0 430,1 512,0 561,1 656,0 660,1 748,0 836,1 902,0 987,1 1087,0 1125,1 1133,0 1205,1 1288,0 1358,1 1406,0 1471,1 1534,0 1618,1 1718,0 1806,1 1824,0 1895,1 1928,0 1971,1 1983,0 2073,1 2118,0 2128,1 2225,0 2240,1 2276,0 2361,1 2368,0 2376,1 2443,0 2522,1 2562,0 2653,1 2747,0 2793,1 2852,0 2887,1 2961,0 3050,1 3077,0 3081,1 3172,0 3198,1 3259,0 3281,1 3304,0 3396,1 3463,0 3497,1 3577,0 3658,1 3681,0 3775,1 3810,0 3832,1 3908,0 3990,1 4050,0 4111,1 4175,0 4248,1 4293,0 4300,1 4302,0 4397,1 4406,0 4420,1 4517,0 4548,1 4553,0 4624,1 4689,0 4737,1 4786,0 4828,1 4859,0 4916,1 4944,0 4948,1 4992,0 5070,1 5159,0 5188,1 5204,0 5261,1 5285,0 5298,1 5387,0 5481,1 5546,0 5603,1 5668,0 5676,1 5703,0 5791,1 5869,0 5910,1 5988,0 6008,1 6020,0 6090,1 6185,0 6255,1 6293,0 6344,1 6351,0 6390,1 6393,0 6446,1 6475,0 6561,1 6597,0 6690,1 6745,0 6840,1 6896,0 6981,1 7001,0 7055,1 7064,0 7093,1 7178,0 7266,1 7346,0 7398,1 7425,0 7463,1 7517,0 7612,1 7691,0 7782,1 7824,0 7847,1 7905,0 7919,1 7931,0 7976,1 8029,0 8080,1 8172,0 8244,1 8338,0 8360,1 8420,0 8455,1 8512,0 8556,1 8573,0 8645,1 8669,0 8752,1 8808,0 8897,1 8985,0 9034,1 9085,0 9122,1 9208,0 9294,1 9352,0 9414,1 9455,0 9485,1 9572,0 9606,1 9666,0 9722,1 9782,0 9852,1 9895,0 9963,1 10054,0 10118,1 10137,0 10201,1 10205,0 10229,1 10233,0 10319,1 10347,0 10374,1 10416,0 10485,1 10502,0 10544,1 10596,0 10644,1 10712,0 10803,1 10815,0 10836,1 10923,0 10954,1 10958,0 11040,1 11134,0 11234,1 11250,0 11280,1 11309,0 11311,1 11399,0 11422,1 11463,0 11500,1 11565,0 11606,1 11658,0 11680,1 11685,0 11768,1 11776,0 11850,1 11922,0 11955,1 12021,0 12029,1 12103,0 12120,1 12173,0 12231,1 12265,0 12306,1 12351,0 12395,1 12417,0 12459,1 12516,0 12556,1 12646,0 12723,1 12752,0 12810,1 12820,0 12902,1 12938,0 13029,1 13054,0 13059,1 13108,0 13148,1 13169,0 13176,1 13227,0 13277,1 13312,0 13353,1 13382,0 13419,1 13495,0 13533,1 13534,0 13630,1 13724,0 13772,1 13822,0 13834,1 13907,0 13938,1 14033,0 14130,1 14193,0 14284,1 14376,0 14389,1 14396,0 14463,1 14471,0 14514,1 14573,0 14627,1 14683,0 14707,1 14758,0 14769,1 14770,0 14842,1 14929,0 14979,1 15039,0 15075,1 15128,0 15167,1 15184,0 15280,1 15315,0 15374,1 15420,0 15452,1 15476,0 15491,1 15529,0 15558,1 15561,0 15578,1 15641,0 15730,1 15817,0 15910,1 15958,0 15959,1 16014,0 16088,1 16124,0 16201,1 16283,0 16337,1 16413,0 16429,1 16496,0 16533,1 16590,0 16668,1 16671,0 16683,1 16712,0 16785,1 16829,0 16882,1 16962,0 17031,1 17124,0 17134,1 17231,0 17267,1 17365,0 17435,1 17503,0 17564,1 17585,0 17618,1 17718,0 17758,1 17815,0 17881,1 17920,0 17974,1 18056,0 18097,1 18174,0 18228,1 18252,0 18322,1 18408,0 18471,1 18479,0 18485,1 18573,0 18663,1 18749,0 18779,1 18877,0 18912,1 18988,0 18997,1 19036,0 19105,1 19108,0 19130,1 19228,0 19252,1 19309,0 19398,1 19492,0 19520,1 19539,0 19636,1 19647,0 19739,1 19804,0 19815,1 19868,0 19870,1 19960,0 20025,1 20073,0 20139,1 20142,0 20175,1 20214,0 20257,1 20344,0 20364,1 20459,0 20485,1 20550,0 20552,1 20588,0 20671,1 20708,0 20807,1 20883,0 20972,1 21028,0 21035,1 21097,0 21136,1 21169,0 21196,1 21202,0 21218,1 21301,0 21346,1 21398,0 21430,1 21457,0 21541,1 21597,0 21626,1 21710,0 21762,1 21849,0 21927,1 21940,0 22031,1 22114,0 22180,1 22207,0 22233,1 22272,0 22340,1 22341,0 22382,1 22432,0 22467,1 22550,0 22633,1 22708,0 22744,1 22817,0 22881,1 22903,0 22984,1 22986,0 23007,1 23022,0 23116,1 23131,0 23161,1 23212,0 23259,1 23264,0 23329,1 23364,0 23447,1 23547,0 23562,1 23584,0 23586,1 23673,0 23770,1 23782,0 23810,1 23855,0 23934,1 23991,0 24078,1 24110,0 24135,1 24210,0 24239,1 24256,0 24352,1 24384,0 24469,1 24567,0 24654,1 24726,0 24826,1 24847,0 24911,1 24941,0 25036,1 25062,0 25159,1 25167,0 25263,1 25341,0 25366,1 25427,0 25433,1 25491,0 25567,1 25657,0 25685,1 25739,0 25816,1 25829,0 25889,1 25985,0 26082,1 26111,0 26115,1 26203,0 26253,1 26308,0 26331,1 26375,0 26457,1 26535,0 26555,1 26561,0 26593,1 26607,0 26655,1 26695,0 26774,1 26828,0 26925,1 26967,0 27006,1 27051,0 27086,1 27170,0 27189,1 27196,0 27294,1 27384,0 27474,1 27556,0 27569,1 27641,0 27660,1 27730,0 27762,1 27833,0 27859,1 27870,0 27882,1 27895,0 27972,1 28008,0 28040,1 28058,0 28073,1 28099,0 28142,1 28187,0 28209,1 28247,0 28260,1 28284,0 28358,1 28391,0 28481,1 28507,0 28567,1 28605,0 28614,1 28652,0 28730,1 28796,0 28880,1 28896,0 28957,1 29020,0 29060,1 29105,0 29169,1 29181,0 29232,1 29299,0 29362,1 29442,0 29540,1 29550,0 29627,1 29635,0 29671,1 29687,0 29778,1 29877,0 29884,1 29889,0 29904,1 29984,0 30020,1 30080,0 30157,1 30177,0 30266,1 30289,0 30334,1 30409,0 30437,1 30467,0 30547,1 30613,0 30687,1 30787,0 30867,1 30912,0 30971,1 31040,0 31097,1 31132,0 31220,1 31278,0 31331,1 31383,0 31481,1 31482,0 31550,1 31559,0 31643,1 31679,0 31768,1 31797,0 31819,1 31845,0 31936,1 32015,0 32044,1 32075,0 32114,1 32132,0 32170,1 32268,0 32318,1 32323,0 32337,1 32395,0 32426,1 32520,0 32564,1 32648,0 32704,1 32740,0 32759,1 32858,0 32878,1 32947,0 32951,1 32975,0 32997,1 33095,0 33167,1 33258,0 33345,1 33418,0 33478,1 33555,0 33600,1 33636,0 33657,1 33742,0 33802,1 33872,0 33940,1 33992,0 34042,1 34086,0 34170,1 34257,0 34320,1 34364,0 34416,1 34509,0 34516,1 34544,0 34603,1 34669,0 34681,1 34748,0 34820,1 34838,0 34896,1 34966,0 34996,1 35027,0 35118,1 35137,0 35146,1 35233,0 35259,1 35289,0 35372,1 35412,0 35456,1 35525,0 35559,1 35656,0 35687,1 35769,0 35788,1 35806,0 35887,1 35914,0 35960,1 36060,0 36097,1 36117,0 36157,1 36205,0 36232,1 36305,0 36385,1 36441,0 36524,1 36616,0 36643,1 36652,0 36705,1 36731,0 36741,1 36798,0 36856,1 36864,0 36889,1 36921,0 36970,1 37053,0 37082,1 37135,0 37177,1 37208,0 37228,1 37277,0 37368,1 37426,0 37491,1 37549,0 37628,1 37657,0 37687,1 37729,0 37795,1 37857,0 37899,1 37919,0 37964,1 38044,0 38089,1 38162,0 38234,1 38282,0 38312,1 38394,0 38430,1 38465,0 38557,1 38594,0 38612,1 38616,0 38626,1 38691,0 38738,1 38766,0 38830,1 38892,0 38974,1 38975,0 38988,1 39067,0 39137,1 39207,0 39226,1 39259,0 39327,1 39356,0 39417,1 39478,0 39567,1 39610,0 39665,1 39677,0 39703,1 39747,0 39808,1 39819,0 39860,1 39935,0 39987,1 40079,0 40124,1 40144,0 40234,1 40260,0 40341,1 40363,0 40377,1 40395,0 40467,1 40500,0 40527,1 40596,0 40646,1 40681,0 40750,1 40817,0 40901,1 40971,0 41012,1 41110,0 41197,1 41233,0 41256,1 41266,0 41273,1 41274,0 41294,1 41367,0 41456,1 41543,0 41610,1 41637,0 41652,1 41658,0 41674,1 41742,0 41760,1 41767,0 41843,1 41914,0 42002,1 42040,0 42119,1 42163,0 42183,1 42208,0 42273,1 42324,0 42358,1 42361,0 42436,1 42451,0 42540,1 42610,0 42688,1 42725,0 42732,1 42746,0 42756,1 42850,0 42910,1 43006,0 43008,1 43057,0 43108,1 43208,0 43256,1 43326,0 43394,1 43412,0 43463,1 43517,0 43538,1 43630,0 43683,1 43755,0 43765,1 43830,0 43872,1 43916,0 43927,1 44027,0 44114,1 44206,0 44248,1 44269,0 44286,1 44327,0 44329,1 44418,0 44500,1 44575,0 44642,1 44721,0 44734,1 44779,0 44807,1 44902,0 44918,1 44948,0 45024,1 45097,0 45141,1 45230,0 45239,1 45326,0 45380,1 45476,0 45479,1 45555,0 45567,1 45641,0 45712,1 45773,0 45837,1 45863,0 45894,1 45903,0 45977,1 46066,0 46162,1 46260,0 46313,1 46390,0 46489,1 46508,0 46593,1 46632,0 46637,1 46649,0 46738,1 46790,0 46864,1 46957,0 47021,1 47092,0 47188,1 47227,0 47228,1 47315,0 47383,1 47414,0 47469,1 47524,0 47589,1 47684,0 47709,1 47714,0 47807,1 47879,0 47896,1 47898,0 47957,1 48015,0 48044,1 48091,0 48097,1 48179,0 48222,1 48287,0 48305,1 48400,0 48414,1 48418,0 48431,1 48477,0 48555,1 48624,0 48642,1 48681,0 48721,1 48788,0 48841,1 48896,0 48920,1 48939,0 48992,1 49037,0 49131,1 49186,0 49233,1 49333,0 49353,1 49394,0 49416,1 49478,0 49563,1 49623,0 49683,1 49747,0 49753,1 49842,0 49926,1 50012,0 50086,1 50170,0 50227,1 50315,0 50375,1 50377,0 50441,1 50531,0 50583,1 50653,0 50735,1 50767,0 50779,1 50830,0 50899,1 50916,0 50918,1 50963,0 51061,1 end initlist a5 0,0 81,1 136,0 220,1 292,0 322,1 366,0 374,1 429,0 476,1 503,0 555,1 634,0 654,1 663,0 725,1 787,0 803,1 895,0 936,1 1006,0 1082,1 1157,0 1238,1 1255,0 1292,1 1315,0 1361,1 1427,0 1489,1 1581,0 1650,1 1712,0 1806,1 1867,0 1926,1 2026,0 2049,1 2072,0 2164,1 2252,0 2292,1 2361,0 2427,1 2446,0 2447,1 2507,0 2536,1 2541,0 2565,1 2631,0 2708,1 2790,0 2820,1 2840,0 2936,1 2956,0 3033,1 3045,0 3104,1 3107,0 3160,1 3223,0 3304,1 3363,0 3381,1 3416,0 3483,1 3529,0 3591,1 3659,0 3733,1 3804,0 3830,1 3894,0 3915,1 3933,0 4029,1 4104,0 4122,1 4128,0 4200,1 4222,0 4235,1 4288,0 4319,1 4324,0 4388,1 4467,0 4538,1 4574,0 4658,1 4685,0 4699,1 4703,0 4715,1 4746,0 4837,1 4937,0 4993,1 5001,0 5025,1 5086,0 5112,1 5140,0 5222,1 5236,0 5292,1 5338,0 5350,1 5389,0 5425,1 5525,0 5573,1 5580,0 5612,1 5626,0 5718,1 5800,0 5866,1 5905,0 5929,1 5988,0 6009,1 6091,0 6144,1 6219,0 6254,1 6278,0 6357,1 6448,0 6539,1 6576,0 6610,1 6626,0 6659,1 6686,0 6711,1 6785,0 6818,1 6884,0 6978,1 7042,0 7111,1 7112,0 7169,1 7226,0 7310,1 7377,0 7464,1 7542,0 7599,1 7697,0 7741,1 7820,0 7898,1 7921,0 7958,1 8037,0 8049,1 8148,0 8248,1 8267,0 8335,1 8433,0 8467,1 8509,0 8511,1 8604,0 8618,1 8692,0 8768,1 8842,0 8942,1 8945,0 9038,1 9051,0 9145,1 9148,0 9192,1 9258,0 9322,1 9355,0 9402,1 9498,0 9554,1 9558,0 9612,1 9669,0 9751,1 9824,0 9918,1 9925,0 9980,1 10042,0 10079,1 10102,0 10161,1 10170,0 10194,1 10248,0 10332,1 10356,0 10370,1 10382,0 10481,1 10512,0 10575,1 10610,0 10656,1 10659,0 10754,1 10770,0 10865,1 10923,0 10987,1 11071,0 11128,1 11181,0 11243,1 11321,0 11396,1 11476,0 11576,1 11663,0 11683,1 11703,0 11757,1 11780,0 11852,1 11912,0 11954,1 12026,0 12065,1 12124,0 12218,1 12304,0 12353,1 12391,0 12400,1 12417,0 12495,1 12587,0 12673,1 12724,0 12742,1 12814,0 12842,1 12920,0 12989,1 12995,0 13030,1 13075,0 13087,1 13120,0 13166,1 13204,0 13240,1 13243,0 13292,1 13389,0 13411,1 13455,0 13518,1 13523,0 13594,1 13662,0 13754,1 13815,0 13911,1 14006,0 14104,1 14108,0 14158,1 14225,0 14325,1 14365,0 14377,1 14455,0 14483,1 14575,0 14608,1 14682,0 14743,1 14784,0 14861,1 14882,0 14944,1 14948,0 15008,1 15098,0 15123,1 15218,0 15274,1 15360,0 15446,1 15499,0 15547,1 15608,0 15700,1 15757,0 15808,1 15844,0 15865,1 15898,0 15913,1 15994,0 16005,1 16076,0 16141,1 16146,0 16150,1 16211,0 16309,1 16335,0 16349,1 16430,0 16454,1 16523,0 16568,1 16605,0 16632,1 16642,0 16709,1 16795,0 16838,1 16915,0 16991,1 17032,0 17046,1 17066,0 17136,1 17155,0 17246,1 17255,0 17290,1 17310,0 17358,1 17432,0 17486,1 17545,0 17620,1 17720,0 17745,1 17784,0 17837,1 17863,0 17872,1 17873,0 17888,1 17910,0 17924,1 18002,0 18064,1 18163,0 18256,1 18323,0 18398,1 18412,0 18453,1 18529,0 18595,1 18687,0 18728,1 18828,0 18862,1 18903,0 18930,1 19026,0 19084,1 19101,0 19164,1 19197,0 19237,1 19315,0 19400,1 19491,0 19547,1 19585,0 19634,1 19729,0 19775,1 19831,0 19926,1 19935,0 19936,1 20015,0 20112,1 20205,0 20265,1 20305,0 20374,1 20422,0 20469,1 20524,0 20538,1 20541,0 20587,1 20659,0 20704,1 20741,0 20774,1 20869,0 20911,1 20962,0 21052,1 21070,0 21156,1 21209,0 21216,1 21251,0 21253,1 21284,0 21319,1 21418,0 21422,1 21445,0 21515,1 21529,0 21580,1 21616,0 21710,1 21755,0 21815,1 21821,0 21829,1 21868,0 21876,1 21918,0 21929,1 21939,0 21978,1 22021,0 22086,1 22176,0 22179,1 22267,0 22268,1 22301,0 22337,1 22430,0 22438,1 22511,0 22578,1 22596,0 22603,1 22680,0 22746,1 22816,0 22885,1 22970,0 23063,1 23130,0 23171,1 23244,0 23263,1 23337,0 23426,1 23446,0 23520,1 23591,0 23635,1 23685,0 23761,1 23768,0 23771,1 23787,0 23809,1 23863,0 23915,1 23985,0 24030,1 24069,0 24150,1 24224,0 24294,1 24344,0 24368,1 24438,0 24471,1 24491,0 24505,1 24548,0 24620,1 24695,0 24769,1 24848,0 24894,1 24934,0 25005,1 25056,0 25140,1 25157,0 25217,1 25227,0 25292,1 25328,0 25422,1 25474,0 25548,1 25636,0 25702,1 25794,0 25823,1 25827,0 25891,1 25967,0 26017,1 26021,0 26046,1 26140,0 26171,1 26266,0 26347,1 26432,0 26510,1 26606,0 26633,1 26727,0 26814,1 26907,0 26951,1 27038,0 27061,1 27148,0 27231,1 27267,0 27316,1 27377,0 27431,1 27452,0 27542,1 27624,0 27713,1 27800,0 27810,1 27888,0 27951,1 28038,0 28113,1 28127,0 28136,1 28227,0 28238,1 28267,0 28282,1 28284,0 28320,1 28410,0 28430,1 28475,0 28554,1 28581,0 28628,1 28669,0 28711,1 28798,0 28823,1 28850,0 28867,1 28966,0 28981,1 29052,0 29131,1 29208,0 29271,1 29332,0 29364,1 29391,0 29487,1 29492,0 29538,1 29628,0 29645,1 29693,0 29721,1 29810,0 29852,1 29905,0 29985,1 30009,0 30094,1 30175,0 30235,1 30329,0 30355,1 30378,0 30403,1 30404,0 30491,1 30515,0 30591,1 30600,0 30614,1 30617,0 30700,1 30786,0 30812,1 30870,0 30932,1 30976,0 31051,1 31096,0 31131,1 31162,0 31237,1 31255,0 31279,1 31305,0 31334,1 31343,0 31428,1 31429,0 31490,1 31541,0 31611,1 31635,0 31696,1 31722,0 31734,1 31825,0 31870,1 31885,0 31928,1 32016,0 32069,1 32070,0 32163,1 32164,0 32178,1 32241,0 32259,1 32277,0 32365,1 32401,0 32407,1 32475,0 32500,1 32580,0 32625,1 32713,0 32780,1 32809,0 32903,1 33000,0 33001,1 33092,0 33109,1 33203,0 33215,1 33299,0 33328,1 33386,0 33434,1 33449,0 33452,1 33526,0 33624,1 33627,0 33722,1 33742,0 33826,1 33856,0 33930,1 33981,0 34008,1 34027,0 34100,1 34104,0 34118,1 34207,0 34251,1 34312,0 34409,1 34508,0 34601,1 34647,0 34691,1 34751,0 34790,1 34859,0 34894,1 34975,0 35064,1 35080,0 35084,1 35139,0 35220,1 35301,0 35356,1 35438,0 35528,1 35577,0 35617,1 35713,0 35809,1 35901,0 35903,1 35914,0 35957,1 36047,0 36130,1 36207,0 36245,1 36322,0 36373,1 36377,0 36454,1 36484,0 36575,1 36666,0 36687,1 36767,0 36784,1 36819,0 36905,1 36941,0 37028,1 37072,0 37152,1 37195,0 37279,1 37346,0 37371,1 37414,0 37505,1 37526,0 37584,1 37605,0 37611,1 37695,0 37786,1 37878,0 37976,1 38011,0 38055,1 38100,0 38141,1 38210,0 38284,1 38300,0 38360,1 38447,0 38465,1 38550,0 38626,1 38650,0 38714,1 38808,0 38821,1 38871,0 38911,1 39006,0 39089,1 39155,0 39164,1 39174,0 39266,1 39277,0 39354,1 39406,0 39478,1 39575,0 39596,1 39693,0 39789,1 39836,0 39901,1 39948,0 40013,1 40037,0 40093,1 40193,0 40229,1 40256,0 40286,1 40352,0 40443,1 40541,0 40629,1 40728,0 40780,1 40817,0 40871,1 40921,0 40940,1 40979,0 41023,1 41071,0 41103,1 41172,0 41213,1 41294,0 41370,1 41417,0 41483,1 41488,0 41556,1 41570,0 41627,1 41690,0 41753,1 41799,0 41804,1 41807,0 41902,1 41930,0 42011,1 42015,0 42102,1 42126,0 42201,1 42221,0 42228,1 42268,0 42278,1 42306,0 42332,1 42396,0 42425,1 42488,0 42491,1 42515,0 42568,1 42622,0 42649,1 42726,0 42790,1 42860,0 42910,1 42926,0 42975,1 43035,0 43117,1 43137,0 43209,1 43274,0 43316,1 43325,0 43371,1 43461,0 43513,1 43536,0 43575,1 43662,0 43687,1 43773,0 43861,1 43936,0 43983,1 44047,0 44139,1 44144,0 44156,1 44255,0 44314,1 44397,0 44411,1 44509,0 44585,1 44601,0 44663,1 44736,0 44779,1 44784,0 44876,1 44954,0 45035,1 45127,0 45129,1 45139,0 45233,1 45253,0 45264,1 45299,0 45389,1 45393,0 45469,1 45514,0 45602,1 45631,0 45678,1 45696,0 45779,1 45869,0 45944,1 45988,0 45995,1 46075,0 46107,1 46174,0 46264,1 46272,0 46319,1 46365,0 46431,1 46480,0 46501,1 46561,0 46601,1 46610,0 46643,1 46667,0 46738,1 46759,0 46791,1 46872,0 46919,1 46941,0 47007,1 47058,0 47063,1 47144,0 47208,1 47240,0 47241,1 47282,0 47335,1 47351,0 47429,1 47474,0 47541,1 47626,0 47674,1 47774,0 47834,1 47865,0 47963,1 47992,0 48026,1 48077,0 48164,1 48222,0 48322,1 48389,0 48484,1 48547,0 48635,1 48687,0 48697,1 48735,0 48751,1 48780,0 48820,1 48904,0 48948,1 48952,0 49039,1 49051,0 49129,1 49157,0 49208,1 49264,0 49325,1 49375,0 49451,1 49483,0 49544,1 49634,0 49692,1 49736,0 49760,1 49797,0 49839,1 49845,0 49904,1 49979,0 49983,1 49984,0 50037,1 50126,0 50165,1 50207,0 50283,1 50380,0 50438,1 50497,0 50594,1 50631,0 50669,1 50705,0 50714,1 50743,0 50786,1 50814,0 50847,1 50868,0 50900,1 50906,0 50958,1 51047,0 51116,1 51165,0 51228,1 51265,0 51268,1 51368,0 51371,1 51408,0 51508,1 51512,0 51561,1 end initlist a6 0,0 97,1 196,0 291,1 297,0 386,1 464,0 503,1 551,0 606,1 705,0 755,1 840,0 910,1 991,0 1065,1 1152,0 1200,1 1245,0 1258,1 1281,0 1339,1 1408,0 1427,1 1478,0 1542,1 1580,0 1601,1 1631,0 1676,1 1732,0 1742,1 1772,0 1822,1 1827,0 1887,1 1976,0 2013,1 2033,0 2050,1 2056,0 2117,1 2189,0 2239,1 2248,0 2338,1 2387,0 2413,1 2481,0 2488,1 2584,0 2623,1 2660,0 2725,1 2738,0 2778,1 2808,0 2861,1 2890,0 2988,1 3050,0 3142,1 3166,0 3243,1 3267,0 3293,1 3332,0 3384,1 3397,0 3474,1 3543,0 3579,1 3611,0 3616,1 3618,0 3634,1 3659,0 3757,1 3823,0 3882,1 3890,0 3894,1 3964,0 3986,1 4016,0 4032,1 4043,0 4105,1 4107,0 4121,1 4129,0 4148,1 4232,0 4313,1 4403,0 4454,1 4551,0 4583,1 4648,0 4699,1 4785,0 4804,1 4813,0 4889,1 4905,0 4993,1 5071,0 5143,1 5171,0 5237,1 5276,0 5362,1 5382,0 5466,1 5521,0 5604,1 5649,0 5705,1 5772,0 5852,1 5951,0 6013,1 6054,0 6147,1 6191,0 6276,1 6319,0 6353,1 6439,0 6502,1 6514,0 6546,1 6563,0 6600,1 6666,0 6751,1 6809,0 6881,1 6895,0 6915,1 6981,0 6997,1 7050,0 7094,1 7179,0 7181,1 7198,0 7209,1 7289,0 7299,1 7347,0 7425,1 7493,0 7560,1 7574,0 7590,1 7658,0 7669,1 7755,0 7823,1 7878,0 7932,1 7993,0 8050,1 8083,0 8107,1 8132,0 8138,1 8205,0 8244,1 8293,0 8389,1 8467,0 8498,1 8523,0 8578,1 8661,0 8673,1 8690,0 8723,1 8802,0 8821,1 8872,0 8877,1 8882,0 8967,1 9027,0 9119,1 9152,0 9179,1 9243,0 9261,1 9271,0 9328,1 9427,0 9507,1 9570,0 9640,1 9701,0 9754,1 9797,0 9845,1 9862,0 9874,1 9893,0 9944,1 9948,0 10030,1 10048,0 10053,1 10057,0 10073,1 10100,0 10113,1 10122,0 10131,1 10132,0 10229,1 10318,0 10364,1 10420,0 10502,1 10533,0 10612,1 10660,0 10674,1 10749,0 10771,1 10821,0 10920,1 10946,0 11022,1 11120,0 11156,1 11201,0 11218,1 11244,0 11334,1 11368,0 11419,1 11503,0 11575,1 11630,0 11699,1 11790,0 11873,1 11962,0 12062,1 12103,0 12149,1 12208,0 12209,1 12258,0 12347,1 12382,0 12449,1 12511,0 12576,1 12594,0 12650,1 12691,0 12722,1 12793,0 12874,1 12922,0 12949,1 12966,0 13007,1 13075,0 13118,1 13174,0 13251,1 13285,0 13303,1 13388,0 13469,1 13536,0 13630,1 13657,0 13739,1 13751,0 13823,1 13876,0 13925,1 14005,0 14022,1 14061,0 14108,1 14179,0 14213,1 14282,0 14338,1 14436,0 14443,1 14459,0 14495,1 14542,0 14626,1 14691,0 14752,1 14788,0 14805,1 14887,0 14941,1 15024,0 15116,1 15123,0 15164,1 15239,0 15324,1 15387,0 15391,1 15459,0 15500,1 15591,0 15670,1 15672,0 15697,1 15765,0 15804,1 15820,0 15884,1 15954,0 16015,1 16102,0 16139,1 16183,0 16212,1 16308,0 16365,1 16394,0 16439,1 16464,0 16509,1 16512,0 16555,1 16568,0 16646,1 16709,0 16723,1 16772,0 16793,1 16797,0 16881,1 16977,0 17064,1 17115,0 17214,1 17307,0 17320,1 17407,0 17471,1 17555,0 17583,1 17640,0 17650,1 17743,0 17751,1 17815,0 17835,1 17918,0 18005,1 18045,0 18074,1 18116,0 18145,1 18216,0 18245,1 18258,0 18356,1 18357,0 18443,1 18532,0 18560,1 18648,0 18699,1 18749,0 18778,1 18812,0 18833,1 18894,0 18917,1 19014,0 19078,1 19165,0 19246,1 19271,0 19350,1 19359,0 19374,1 19459,0 19497,1 19510,0 19516,1 19596,0 19656,1 19672,0 19732,1 19741,0 19823,1 19850,0 19923,1 19950,0 20015,1 20018,0 20097,1 20187,0 20247,1 20324,0 20341,1 20359,0 20397,1 20456,0 20502,1 20583,0 20647,1 20719,0 20817,1 20909,0 21003,1 21053,0 21114,1 21168,0 21243,1 21300,0 21382,1 21435,0 21511,1 21545,0 21623,1 21631,0 21703,1 21734,0 21830,1 21831,0 21897,1 21900,0 21965,1 21975,0 22001,1 22015,0 22061,1 22136,0 22198,1 22260,0 22342,1 22394,0 22410,1 22507,0 22557,1 22583,0 22634,1 22677,0 22742,1 22761,0 22786,1 22881,0 22950,1 22995,0 23054,1 23132,0 23228,1 23268,0 23366,1 23381,0 23454,1 23464,0 23493,1 23496,0 23514,1 23522,0 23555,1 23636,0 23735,1 23802,0 23854,1 23917,0 23927,1 23979,0 24047,1 24068,0 24127,1 24212,0 24217,1 24260,0 24313,1 24360,0 24378,1 24461,0 24462,1 24549,0 24560,1 24642,0 24713,1 24770,0 24846,1 24850,0 24916,1 24997,0 25035,1 25102,0 25115,1 25146,0 25201,1 25238,0 25295,1 25302,0 25310,1 25333,0 25341,1 25405,0 25429,1 25496,0 25595,1 25609,0 25680,1 25706,0 25756,1 25824,0 25924,1 25925,0 26012,1 26018,0 26033,1 26129,0 26173,1 26194,0 26219,1 26292,0 26294,1 26371,0 26441,1 26493,0 26520,1 26600,0 26656,1 26693,0 26732,1 26734,0 26791,1 26836,0 26919,1 26984,0 27022,1 27032,0 27110,1 27161,0 27251,1 27351,0 27405,1 27482,0 27494,1 27535,0 27591,1 27683,0 27699,1 27774,0 27788,1 27793,0 27822,1 27835,0 27931,1 27956,0 27995,1 28005,0 28087,1 28149,0 28160,1 28213,0 28228,1 28285,0 28379,1 28478,0 28526,1 28620,0 28706,1 28729,0 28786,1 28877,0 28886,1 28889,0 28905,1 28964,0 28971,1 29036,0 29133,1 29166,0 29252,1 29310,0 29401,1 29428,0 29514,1 29591,0 29617,1 29653,0 29731,1 29815,0 29845,1 29941,0 30026,1 30122,0 30160,1 30222,0 30248,1 30316,0 30331,1 30395,0 30470,1 30518,0 30571,1 30641,0 30668,1 30682,0 30778,1 30851,0 30923,1 30930,0 30983,1 31067,0 31071,1 31162,0 31243,1 31307,0 31342,1 31429,0 31461,1 31511,0 31518,1 31577,0 31617,1 31712,0 31766,1 31859,0 31916,1 31956,0 32020,1 32074,0 32106,1 32192,0 32224,1 32263,0 32348,1 32441,0 32495,1 32545,0 32574,1 32631,0 32720,1 32763,0 32770,1 32862,0 32891,1 32923,0 32971,1 33059,0 33134,1 33158,0 33222,1 33297,0 33343,1 33349,0 33360,1 33361,0 33435,1 33514,0 33561,1 33641,0 33665,1 33762,0 33799,1 33835,0 33863,1 33880,0 33980,1 34064,0 34100,1 34183,0 34254,1 34351,0 34445,1 34451,0 34477,1 34539,0 34625,1 34717,0 34726,1 34816,0 34871,1 34933,0 34986,1 35040,0 35055,1 35141,0 35237,1 35241,0 35330,1 35368,0 35389,1 35418,0 35493,1 35553,0 35606,1 35648,0 35738,1 35739,0 35777,1 35871,0 35962,1 35994,0 36038,1 36054,0 36138,1 36212,0 36306,1 36384,0 36421,1 36495,0 36502,1 36525,0 36589,1 36595,0 36627,1 36647,0 36720,1 36769,0 36825,1 36831,0 36930,1 36983,0 37037,1 37110,0 37195,1 37215,0 37217,1 37219,0 37253,1 37305,0 37387,1 37400,0 37413,1 37493,0 37560,1 37579,0 37592,1 37685,0 37687,1 37744,0 37820,1 37857,0 37873,1 37904,0 37986,1 38045,0 38122,1 38210,0 38253,1 38335,0 38344,1 38416,0 38468,1 38480,0 38572,1 38639,0 38669,1 38695,0 38760,1 38790,0 38885,1 38977,0 39023,1 39068,0 39159,1 39232,0 39326,1 39392,0 39433,1 39511,0 39540,1 39613,0 39614,1 39673,0 39696,1 39699,0 39738,1 39739,0 39743,1 39767,0 39855,1 39914,0 39943,1 39969,0 39978,1 40003,0 40083,1 40144,0 40240,1 40315,0 40364,1 40397,0 40478,1 40517,0 40566,1 40662,0 40750,1 40785,0 40804,1 40809,0 40884,1 40938,0 41019,1 41119,0 41133,1 41163,0 41209,1 41210,0 41242,1 41336,0 41419,1 41477,0 41539,1 41586,0 41611,1 41648,0 41671,1 41760,0 41823,1 41905,0 41939,1 41979,0 41990,1 42000,0 42012,1 42021,0 42044,1 42061,0 42100,1 42165,0 42172,1 42190,0 42247,1 42313,0 42335,1 42365,0 42461,1 42497,0 42520,1 42550,0 42602,1 42697,0 42702,1 42778,0 42788,1 42888,0 42960,1 43003,0 43100,1 43168,0 43183,1 43282,0 43305,1 43324,0 43411,1 43502,0 43599,1 43643,0 43654,1 43714,0 43725,1 43781,0 43865,1 43906,0 43953,1 43989,0 44044,1 44060,0 44073,1 44157,0 44197,1 44269,0 44335,1 44342,0 44410,1 44457,0 44511,1 44528,0 44561,1 44633,0 44690,1 44716,0 44751,1 44799,0 44875,1 44922,0 44995,1 45082,0 45168,1 45267,0 45366,1 45455,0 45532,1 45625,0 45674,1 45767,0 45818,1 45904,0 45907,1 45987,0 46081,1 46089,0 46123,1 46177,0 46186,1 46211,0 46232,1 46270,0 46289,1 46379,0 46399,1 46495,0 46593,1 46659,0 46732,1 46778,0 46831,1 46845,0 46858,1 46951,0 47016,1 47077,0 47110,1 47121,0 47178,1 47247,0 47297,1 47371,0 47417,1 47421,0 47460,1 47509,0 47549,1 47567,0 47593,1 47693,0 47727,1 47752,0 47773,1 47835,0 47884,1 47891,0 47944,1 48026,0 48075,1 48103,0 48131,1 48188,0 48218,1 48269,0 48314,1 48403,0 48425,1 48448,0 48528,1 48579,0 48653,1 48739,0 48825,1 48905,0 48956,1 49042,0 49057,1 49121,0 49125,1 49162,0 49202,1 49302,0 49374,1 49425,0 49470,1 49478,0 49541,1 49600,0 49656,1 49742,0 49754,1 49843,0 49913,1 49966,0 50025,1 50058,0 50103,1 50107,0 50166,1 50256,0 50315,1 50367,0 50433,1 50510,0 50572,1 50653,0 50745,1 50759,0 50794,1 end initlist a7 0,0 4,1 13,0 86,1 128,0 199,1 244,0 283,1 308,0 318,1 413,0 498,1 546,0 575,1 593,0 621,1 652,0 674,1 766,0 801,1 837,0 909,1 990,0 1035,1 1066,0 1095,1 1122,0 1220,1 1299,0 1317,1 1330,0 1339,1 1378,0 1470,1 1499,0 1577,1 1646,0 1678,1 1774,0 1820,1 1854,0 1954,1 2038,0 2072,1 2150,0 2174,1 2228,0 2316,1 2345,0 2421,1 2518,0 2524,1 2614,0 2666,1 2679,0 2716,1 2769,0 2796,1 2894,0 2951,1 3026,0 3089,1 3175,0 3199,1 3216,0 3232,1 3242,0 3295,1 3374,0 3446,1 3511,0 3522,1 3610,0 3705,1 3747,0 3810,1 3862,0 3946,1 3962,0 3963,1 4024,0 4027,1 4060,0 4070,1 4165,0 4211,1 4224,0 4267,1 4351,0 4399,1 4480,0 4487,1 4585,0 4685,1 4746,0 4755,1 4799,0 4825,1 4882,0 4912,1 5004,0 5040,1 5126,0 5146,1 5152,0 5216,1 5287,0 5333,1 5433,0 5517,1 5541,0 5561,1 5575,0 5592,1 5614,0 5687,1 5713,0 5782,1 5785,0 5824,1 5895,0 5978,1 5995,0 6066,1 6101,0 6167,1 6185,0 6202,1 6246,0 6296,1 6353,0 6451,1 6501,0 6593,1 6625,0 6635,1 6723,0 6764,1 6826,0 6851,1 6889,0 6890,1 6957,0 7057,1 7120,0 7179,1 7258,0 7353,1 7415,0 7444,1 7445,0 7496,1 7567,0 7572,1 7645,0 7688,1 7752,0 7761,1 7818,0 7905,1 7969,0 8057,1 8129,0 8148,1 8210,0 8240,1 8317,0 8382,1 8429,0 8442,1 8481,0 8547,1 8618,0 8717,1 8726,0 8822,1 8901,0 8989,1 9023,0 9101,1 9122,0 9176,1 9242,0 9259,1 9320,0 9389,1 9391,0 9398,1 9476,0 9496,1 9589,0 9648,1 9742,0 9761,1 9825,0 9899,1 9982,0 10018,1 10024,0 10090,1 10146,0 10190,1 10278,0 10346,1 10440,0 10455,1 10480,0 10492,1 10516,0 10542,1 10562,0 10572,1 10613,0 10639,1 10683,0 10704,1 10787,0 10864,1 10871,0 10914,1 10929,0 10997,1 11087,0 11154,1 11242,0 11334,1 11426,0 11430,1 11495,0 11592,1 11635,0 11656,1 11713,0 11802,1 11833,0 11895,1 11921,0 11988,1 11990,0 12043,1 12098,0 12195,1 12241,0 12315,1 12384,0 12451,1 12487,0 12537,1 12615,0 12662,1 12742,0 12786,1 12852,0 12865,1 12955,0 13030,1 13059,0 13087,1 13128,0 13217,1 13261,0 13341,1 13374,0 13427,1 13504,0 13543,1 13623,0 13697,1 13739,0 13810,1 13871,0 13917,1 13934,0 13949,1 13987,0 13990,1 13994,0 14025,1 14079,0 14089,1 14141,0 14190,1 14238,0 14263,1 14358,0 14385,1 14479,0 14559,1 14654,0 14656,1 14684,0 14691,1 14696,0 14742,1 14772,0 14844,1 14855,0 14905,1 14949,0 15029,1 15082,0 15172,1 15225,0 15276,1 15325,0 15392,1 15465,0 15531,1 15580,0 15625,1 15634,0 15710,1 15744,0 15785,1 15872,0 15913,1 15945,0 16028,1 16062,0 16118,1 16195,0 16241,1 16266,0 16307,1 16385,0 16424,1 16472,0 16568,1 16582,0 16589,1 16602,0 16612,1 16679,0 16752,1 16825,0 16868,1 16937,0 16981,1 17046,0 17146,1 17159,0 17216,1 17299,0 17393,1 17455,0 17528,1 17574,0 17667,1 17742,0 17806,1 17896,0 17977,1 18070,0 18088,1 18164,0 18231,1 18242,0 18340,1 18354,0 18421,1 18473,0 18550,1 18636,0 18695,1 18794,0 18835,1 18878,0 18973,1 19052,0 19123,1 19180,0 19250,1 19270,0 19309,1 19341,0 19360,1 19426,0 19523,1 19569,0 19621,1 19688,0 19722,1 19729,0 19816,1 19865,0 19867,1 19892,0 19975,1 20053,0 20116,1 20203,0 20207,1 20272,0 20363,1 20457,0 20500,1 20577,0 20635,1 20657,0 20670,1 20720,0 20804,1 20866,0 20944,1 21018,0 21106,1 21181,0 21188,1 21266,0 21306,1 21386,0 21449,1 21538,0 21561,1 21615,0 21712,1 21713,0 21790,1 21818,0 21842,1 21906,0 21998,1 22078,0 22141,1 22240,0 22254,1 22305,0 22365,1 22448,0 22494,1 22572,0 22659,1 22684,0 22783,1 22790,0 22889,1 22917,0 23001,1 23016,0 23055,1 23089,0 23171,1 23257,0 23326,1 23343,0 23428,1 23504,0 23602,1 23670,0 23674,1 23770,0 23786,1 23867,0 23932,1 23970,0 23996,1 24031,0 24080,1 24085,0 24178,1 24269,0 24363,1 24454,0 24546,1 24644,0 24683,1 24711,0 24776,1 24784,0 24839,1 24881,0 24886,1 24895,0 24989,1 25021,0 25038,1 25041,0 25106,1 25111,0 25197,1 25238,0 25331,1 25336,0 25356,1 25418,0 25437,1 25471,0 25568,1 25662,0 25687,1 25708,0 25733,1 25782,0 25881,1 25898,0 25993,1 26008,0 26054,1 26123,0 26199,1 26245,0 26333,1 26404,0 26414,1 26454,0 26548,1 26614,0 26697,1 26712,0 26747,1 26792,0 26840,1 26879,0 26965,1 27007,0 27015,1 27103,0 27161,1 27170,0 27204,1 27245,0 27270,1 27331,0 27428,1 27475,0 27485,1 27561,0 27588,1 27642,0 27691,1 27719,0 27782,1 27840,0 27886,1 27951,0 28004,1 28091,0 28144,1 28225,0 28303,1 28307,0 28356,1 28383,0 28413,1 28481,0 28493,1 28517,0 28551,1 28646,0 28734,1 28767,0 28845,1 28906,0 28991,1 29087,0 29151,1 29187,0 29188,1 29203,0 29254,1 29276,0 29302,1 29317,0 29388,1 29428,0 29472,1 29554,0 29570,1 29646,0 29659,1 29701,0 29777,1 29810,0 29868,1 29904,0 29930,1 29958,0 30033,1 30074,0 30111,1 30117,0 30154,1 30173,0 30201,1 30238,0 30287,1 30297,0 30308,1 30344,0 30388,1 30476,0 30568,1 30601,0 30614,1 30663,0 30763,1 30771,0 30795,1 30815,0 30852,1 30932,0 31003,1 31032,0 31047,1 31068,0 31112,1 31119,0 31175,1 31190,0 31285,1 31368,0 31403,1 31455,0 31457,1 31501,0 31507,1 31606,0 31693,1 31739,0 31799,1 31878,0 31897,1 31899,0 31974,1 31976,0 31988,1 32056,0 32119,1 32171,0 32250,1 32333,0 32416,1 32508,0 32569,1 32614,0 32648,1 32710,0 32733,1 32827,0 32906,1 32984,0 33076,1 33166,0 33224,1 33240,0 33310,1 33337,0 33408,1 33479,0 33541,1 33580,0 33610,1 33673,0 33689,1 33785,0 33800,1 33819,0 33861,1 33945,0 33948,1 33985,0 34076,1 34109,0 34116,1 34137,0 34149,1 34189,0 34258,1 34316,0 34371,1 34375,0 34449,1 34517,0 34542,1 34617,0 34680,1 34738,0 34811,1 34835,0 34857,1 34953,0 35030,1 35119,0 35122,1 35148,0 35226,1 35303,0 35324,1 35368,0 35465,1 35507,0 35532,1 35547,0 35559,1 35638,0 35661,1 35754,0 35853,1 35948,0 36038,1 36053,0 36087,1 36102,0 36171,1 36214,0 36280,1 36365,0 36462,1 36534,0 36554,1 36622,0 36668,1 36723,0 36783,1 36805,0 36836,1 36868,0 36900,1 36985,0 37030,1 37108,0 37145,1 37179,0 37273,1 37365,0 37423,1 37471,0 37509,1 37577,0 37639,1 37660,0 37665,1 37732,0 37812,1 37853,0 37894,1 37960,0 38001,1 38024,0 38060,1 38085,0 38141,1 38171,0 38240,1 38305,0 38328,1 38422,0 38474,1 38562,0 38631,1 38662,0 38715,1 38768,0 38857,1 38866,0 38904,1 38998,0 39047,1 39131,0 39148,1 39210,0 39249,1 39280,0 39368,1 39424,0 39430,1 39431,0 39482,1 39534,0 39621,1 39637,0 39708,1 39725,0 39822,1 39851,0 39887,1 39959,0 40031,1 40110,0 40158,1 40214,0 40218,1 40260,0 40295,1 40299,0 40387,1 40429,0 40450,1 40544,0 40598,1 40635,0 40649,1 40737,0 40786,1 40797,0 40888,1 40926,0 41021,1 41041,0 41100,1 41121,0 41217,1 41260,0 41338,1 41374,0 41379,1 41431,0 41528,1 41543,0 41632,1 41638,0 41652,1 41665,0 41755,1 41852,0 41891,1 41945,0 41965,1 42061,0 42088,1 42131,0 42227,1 42309,0 42321,1 42322,0 42415,1 42488,0 42558,1 42611,0 42661,1 42701,0 42776,1 42867,0 42934,1 43032,0 43059,1 43086,0 43110,1 43149,0 43180,1 43181,0 43237,1 43309,0 43375,1 43467,0 43474,1 43539,0 43589,1 43675,0 43681,1 43728,0 43730,1 43785,0 43835,1 43856,0 43905,1 43969,0 43976,1 43983,0 44081,1 44094,0 44148,1 44213,0 44299,1 44373,0 44412,1 44444,0 44521,1 44575,0 44636,1 44702,0 44774,1 44809,0 44867,1 44872,0 44930,1 45010,0 45018,1 45042,0 45119,1 45142,0 45230,1 45231,0 45252,1 45349,0 45352,1 45371,0 45418,1 45426,0 45460,1 45466,0 45561,1 45617,0 45716,1 45726,0 45744,1 45764,0 45808,1 45821,0 45832,1 45914,0 45950,1 46045,0 46109,1 46179,0 46204,1 46219,0 46262,1 46359,0 46405,1 46505,0 46510,1 46609,0 46675,1 46743,0 46745,1 46781,0 46794,1 46818,0 46839,1 46868,0 46918,1 46924,0 46957,1 46982,0 47010,1 47099,0 47179,1 47241,0 47267,1 47345,0 47407,1 47455,0 47517,1 47540,0 47569,1 47580,0 47638,1 47716,0 47758,1 47782,0 47827,1 47899,0 47939,1 47979,0 47999,1 48037,0 48081,1 48168,0 48194,1 48210,0 48213,1 48280,0 48375,1 48461,0 48536,1 48539,0 48587,1 48594,0 48630,1 48635,0 48732,1 48823,0 48889,1 48946,0 48951,1 48952,0 49015,1 49048,0 49139,1 49157,0 49213,1 49233,0 49297,1 49300,0 49325,1 49350,0 49442,1 49447,0 49475,1 49495,0 49583,1 49630,0 49665,1 49690,0 49768,1 49851,0 49933,1 50006,0 50060,1 50147,0 50212,1 50232,0 50280,1 50281,0 50296,1 50353,0 50426,1 50477,0 50514,1 50578,0 50610,1 end initlist a8 0,0 23,1 103,0 187,1 281,0 319,1 370,0 442,1 502,0 504,1 527,0 599,1 620,0 626,1 708,0 780,1 859,0 936,1 981,0 1026,1 1050,0 1052,1 1095,0 1177,1 1272,0 1278,1 1319,0 1367,1 1449,0 1493,1 1529,0 1600,1 1644,0 1696,1 1768,0 1774,1 1834,0 1858,1 1888,0 1980,1 2036,0 2111,1 2173,0 2183,1 2278,0 2349,1 2363,0 2447,1 2458,0 2540,1 2638,0 2640,1 2664,0 2714,1 2735,0 2742,1 2834,0 2845,1 2939,0 3005,1 3055,0 3146,1 3242,0 3259,1 3273,0 3354,1 3372,0 3442,1 3492,0 3494,1 3572,0 3648,1 3734,0 3803,1 3830,0 3836,1 3894,0 3992,1 3998,0 4069,1 4074,0 4084,1 4133,0 4137,1 4219,0 4238,1 4255,0 4297,1 4361,0 4363,1 4408,0 4414,1 4487,0 4571,1 4651,0 4671,1 4718,0 4756,1 4801,0 4835,1 4880,0 4897,1 4941,0 4986,1 5086,0 5149,1 5249,0 5307,1 5370,0 5452,1 5462,0 5501,1 5537,0 5579,1 5674,0 5701,1 5783,0 5792,1 5797,0 5846,1 5868,0 5967,1 6061,0 6075,1 6098,0 6151,1 6206,0 6288,1 6340,0 6422,1 6468,0 6535,1 6616,0 6617,1 6677,0 6708,1 6756,0 6763,1 6789,0 6815,1 6876,0 6944,1 6986,0 7026,1 7103,0 7170,1 7224,0 7272,1 7290,0 7329,1 7355,0 7397,1 7483,0 7526,1 7531,0 7548,1 7581,0 7656,1 7663,0 7686,1 7746,0 7809,1 7846,0 7919,1 7932,0 8009,1 8041,0 8075,1 8171,0 8179,1 8214,0 8228,1 8308,0 8333,1 8376,0 8432,1 8526,0 8563,1 8643,0 8713,1 8778,0 8782,1 8868,0 8887,1 8979,0 9026,1 9053,0 9081,1 9084,0 9181,1 9238,0 9315,1 9346,0 9375,1 9408,0 9463,1 9472,0 9501,1 9554,0 9647,1 9677,0 9702,1 9784,0 9848,1 9924,0 9996,1 10051,0 10125,1 10197,0 10283,1 10377,0 10473,1 10493,0 10522,1 10606,0 10650,1 10666,0 10754,1 10818,0 10906,1 10996,0 11009,1 11018,0 11024,1 11114,0 11134,1 11196,0 11270,1 11314,0 11414,1 11473,0 11512,1 11527,0 11533,1 11583,0 11584,1 11656,0 11731,1 11797,0 11889,1 11969,0 12026,1 12030,0 12061,1 12114,0 12183,1 12201,0 12233,1 12304,0 12368,1 12391,0 12469,1 12490,0 12536,1 12545,0 12609,1 12656,0 12754,1 12838,0 12892,1 12919,0 12975,1 12977,0 13048,1 13091,0 13130,1 13188,0 13272,1 13333,0 13415,1 13496,0 13509,1 13571,0 13574,1 13607,0 13654,1 13684,0 13783,1 13813,0 13887,1 13915,0 14003,1 14004,0 14075,1 14166,0 14168,1 14201,0 14284,1 14346,0 14419,1 14480,0 14552,1 14579,0 14649,1 14724,0 14728,1 14763,0 14805,1 14851,0 14866,1 14871,0 14914,1 14965,0 15044,1 15120,0 15216,1 15257,0 15327,1 15377,0 15434,1 15460,0 15532,1 15539,0 15590,1 15656,0 15714,1 15798,0 15810,1 15887,0 15900,1 15982,0 16047,1 16071,0 16169,1 16202,0 16283,1 16325,0 16365,1 16401,0 16467,1 16522,0 16570,1 16668,0 16724,1 16756,0 16840,1 16892,0 16896,1 16950,0 16982,1 17027,0 17105,1 17137,0 17147,1 17237,0 17253,1 17322,0 17328,1 17404,0 17456,1 17548,0 17626,1 17647,0 17698,1 17793,0 17818,1 17829,0 17896,1 17924,0 17937,1 17998,0 18041,1 18131,0 18186,1 18203,0 18205,1 18208,0 18240,1 18242,0 18320,1 18407,0 18442,1 18539,0 18615,1 18642,0 18679,1 18687,0 18775,1 18823,0 18918,1 18980,0 19037,1 19043,0 19135,1 19157,0 19217,1 19222,0 19258,1 19353,0 19453,1 19469,0 19532,1 19568,0 19609,1 19684,0 19685,1 19726,0 19743,1 19759,0 19832,1 19881,0 19892,1 19967,0 20061,1 20090,0 20111,1 20126,0 20217,1 20269,0 20281,1 20348,0 20436,1 20506,0 20605,1 20703,0 20786,1 20840,0 20895,1 20962,0 21036,1 21115,0 21121,1 21217,0 21293,1 21376,0 21441,1 21531,0 21598,1 21664,0 21700,1 21701,0 21783,1 21785,0 21788,1 21879,0 21971,1 22067,0 22127,1 22196,0 22214,1 22263,0 22307,1 22355,0 22433,1 22527,0 22601,1 22663,0 22747,1 22838,0 22885,1 22928,0 22975,1 23013,0 23022,1 23049,0 23102,1 23115,0 23179,1 23185,0 23270,1 23345,0 23423,1 23519,0 23540,1 23596,0 23691,1 23778,0 23872,1 23933,0 23970,1 23985,0 24040,1 24111,0 24168,1 24199,0 24264,1 24276,0 24322,1 24337,0 24367,1 24401,0 24410,1 24480,0 24507,1 24557,0 24650,1 24699,0 24750,1 24800,0 24892,1 24985,0 25008,1 25021,0 25037,1 25092,0 25128,1 25170,0 25188,1 25194,0 25292,1 25361,0 25417,1 25512,0 25605,1 25612,0 25627,1 25665,0 25681,1 25708,0 25806,1 25810,0 25833,1 25842,0 25864,1 25939,0 26033,1 26088,0 26113,1 26121,0 26170,1 26239,0 26304,1 26339,0 26416,1 26427,0 26500,1 26557,0 26601,1 26688,0 26692,1 26715,0 26749,1 26752,0 26795,1 26854,0 26857,1 26915,0 26993,1 27046,0 27100,1 27195,0 27235,1 27281,0 27378,1 27381,0 27396,1 27452,0 27521,1 27525,0 27540,1 27572,0 27657,1 27727,0 27801,1 27811,0 27832,1 27853,0 27858,1 27861,0 27917,1 27960,0 27973,1 28038,0 28130,1 28171,0 28219,1 28261,0 28315,1 28330,0 28417,1 28432,0 28455,1 28526,0 28559,1 28637,0 28696,1 28781,0 28825,1 28868,0 28960,1 29009,0 29041,1 29061,0 29082,1 29134,0 29233,1 29318,0 29373,1 29471,0 29492,1 29506,0 29586,1 29596,0 29621,1 29667,0 29681,1 29774,0 29821,1 29891,0 29972,1 30016,0 30085,1 30109,0 30198,1 30240,0 30299,1 30334,0 30364,1 30426,0 30479,1 30511,0 30606,1 30635,0 30685,1 30765,0 30845,1 30883,0 30959,1 31027,0 31039,1 31127,0 31206,1 31223,0 31295,1 31331,0 31375,1 31463,0 31468,1 31512,0 31604,1 31655,0 31709,1 31761,0 31785,1 31841,0 31860,1 31946,0 31960,1 31997,0 32048,1 32068,0 32157,1 32158,0 32167,1 32258,0 32317,1 32395,0 32398,1 32491,0 32555,1 32633,0 32711,1 32779,0 32799,1 32832,0 32892,1 32906,0 32976,1 33037,0 33048,1 33114,0 33161,1 33254,0 33346,1 33422,0 33462,1 33463,0 33549,1 33553,0 33593,1 33598,0 33600,1 33699,0 33788,1 33873,0 33946,1 33947,0 33948,1 33995,0 34084,1 34174,0 34239,1 34317,0 34365,1 34460,0 34544,1 34590,0 34605,1 34648,0 34728,1 34730,0 34740,1 34790,0 34875,1 34885,0 34967,1 35009,0 35087,1 35185,0 35248,1 35340,0 35427,1 35513,0 35591,1 35641,0 35664,1 35715,0 35799,1 35806,0 35879,1 35974,0 36021,1 36096,0 36141,1 36159,0 36167,1 36265,0 36323,1 36407,0 36410,1 36411,0 36492,1 36550,0 36631,1 36726,0 36789,1 36840,0 36877,1 36919,0 37013,1 37015,0 37053,1 37132,0 37148,1 37157,0 37240,1 37275,0 37292,1 37313,0 37342,1 37421,0 37477,1 37550,0 37582,1 37659,0 37670,1 37712,0 37769,1 37856,0 37864,1 37940,0 38012,1 38088,0 38160,1 38162,0 38242,1 38267,0 38327,1 38348,0 38412,1 38505,0 38533,1 38576,0 38590,1 38592,0 38611,1 38660,0 38739,1 38741,0 38753,1 38853,0 38932,1 39030,0 39037,1 39092,0 39093,1 39110,0 39192,1 39199,0 39241,1 39244,0 39291,1 39310,0 39344,1 39350,0 39419,1 39497,0 39587,1 39648,0 39741,1 39764,0 39836,1 39847,0 39873,1 39895,0 39933,1 39990,0 40083,1 40101,0 40150,1 40151,0 40178,1 40223,0 40276,1 40310,0 40387,1 40450,0 40490,1 40555,0 40576,1 40646,0 40693,1 40772,0 40854,1 40877,0 40948,1 41024,0 41075,1 41097,0 41181,1 41195,0 41293,1 41385,0 41468,1 41524,0 41564,1 41655,0 41665,1 41746,0 41774,1 41841,0 41860,1 41943,0 41986,1 42033,0 42080,1 42147,0 42149,1 42161,0 42180,1 42271,0 42334,1 42412,0 42492,1 42543,0 42639,1 42707,0 42743,1 42777,0 42843,1 42844,0 42908,1 42955,0 43044,1 43094,0 43187,1 43193,0 43240,1 43318,0 43338,1 43339,0 43381,1 43403,0 43404,1 43437,0 43530,1 43580,0 43617,1 43714,0 43722,1 43723,0 43742,1 43809,0 43904,1 43938,0 43966,1 44043,0 44055,1 44095,0 44184,1 44242,0 44293,1 44332,0 44335,1 44380,0 44455,1 44509,0 44537,1 44637,0 44694,1 44787,0 44858,1 44890,0 44930,1 44947,0 45025,1 45114,0 45194,1 45280,0 45315,1 45407,0 45496,1 45511,0 45595,1 45657,0 45700,1 45761,0 45767,1 45770,0 45862,1 45932,0 45949,1 45983,0 46001,1 46060,0 46131,1 46189,0 46254,1 46316,0 46369,1 46469,0 46503,1 46579,0 46606,1 46639,0 46656,1 46725,0 46749,1 46846,0 46935,1 46977,0 47012,1 47047,0 47058,1 47143,0 47189,1 47278,0 47283,1 47325,0 47391,1 47429,0 47450,1 47510,0 47598,1 47696,0 47750,1 47754,0 47821,1 47879,0 47903,1 48002,0 48076,1 48106,0 48115,1 48148,0 48187,1 48193,0 48269,1 48322,0 48387,1 48431,0 48472,1 48517,0 48617,1 48621,0 48699,1 48749,0 48821,1 48869,0 48958,1 49023,0 49032,1 49112,0 49130,1 49148,0 49152,1 49237,0 49323,1 49404,0 49428,1 49490,0 49512,1 49545,0 49640,1 49674,0 49680,1 49684,0 49692,1 49756,0 49761,1 49777,0 49839,1 49875,0 49904,1 49988,0 50033,1 50083,0 50109,1 50193,0 50280,1 50291,0 50294,1 end initlist a9 0,0 35,1 89,0 135,1 170,0 230,1 299,0 334,1 394,0 482,1 509,0 578,1 608,0 659,1 731,0 743,1 796,0 828,1 854,0 889,1 944,0 1026,1 1082,0 1137,1 1140,0 1181,1 1240,0 1248,1 1333,0 1352,1 1375,0 1389,1 1434,0 1529,1 1542,0 1596,1 1686,0 1727,1 1795,0 1812,1 1896,0 1950,1 1956,0 2019,1 2027,0 2085,1 2098,0 2164,1 2184,0 2235,1 2274,0 2310,1 2400,0 2413,1 2431,0 2480,1 2513,0 2582,1 2604,0 2611,1 2671,0 2701,1 2738,0 2824,1 2874,0 2888,1 2904,0 2916,1 2994,0 3039,1 3098,0 3099,1 3187,0 3253,1 3293,0 3334,1 3380,0 3435,1 3515,0 3549,1 3579,0 3659,1 3661,0 3750,1 3778,0 3830,1 3895,0 3903,1 3929,0 3996,1 4059,0 4074,1 4158,0 4190,1 4245,0 4328,1 4357,0 4442,1 4489,0 4549,1 4570,0 4571,1 4639,0 4691,1 4732,0 4745,1 4774,0 4864,1 4956,0 5016,1 5055,0 5091,1 5092,0 5139,1 5198,0 5296,1 5350,0 5364,1 5448,0 5529,1 5546,0 5561,1 5573,0 5653,1 5747,0 5767,1 5858,0 5925,1 5999,0 6087,1 6119,0 6129,1 6228,0 6293,1 6307,0 6382,1 6475,0 6489,1 6579,0 6678,1 6713,0 6807,1 6816,0 6908,1 6967,0 7061,1 7161,0 7229,1 7264,0 7340,1 7364,0 7432,1 7442,0 7540,1 7634,0 7641,1 7714,0 7748,1 7835,0 7913,1 7962,0 8023,1 8053,0 8097,1 8108,0 8130,1 8150,0 8223,1 8299,0 8359,1 8369,0 8388,1 8460,0 8478,1 8535,0 8603,1 8691,0 8726,1 8777,0 8875,1 8969,0 8972,1 9062,0 9116,1 9123,0 9212,1 9224,0 9254,1 9273,0 9331,1 9364,0 9425,1 9474,0 9520,1 9606,0 9625,1 9650,0 9704,1 9765,0 9829,1 9846,0 9887,1 9915,0 9972,1 10008,0 10039,1 10136,0 10226,1 10270,0 10361,1 10407,0 10410,1 10500,0 10576,1 10581,0 10605,1 10675,0 10701,1 10784,0 10807,1 10884,0 10935,1 11034,0 11117,1 11163,0 11192,1 11274,0 11294,1 11352,0 11387,1 11484,0 11496,1 11514,0 11611,1 11685,0 11702,1 11705,0 11725,1 11760,0 11844,1 11853,0 11917,1 11942,0 11954,1 12018,0 12073,1 12156,0 12168,1 12250,0 12297,1 12350,0 12354,1 12452,0 12463,1 12518,0 12521,1 12523,0 12584,1 12630,0 12644,1 12681,0 12769,1 12816,0 12824,1 12879,0 12917,1 12953,0 13029,1 13088,0 13162,1 13171,0 13253,1 13265,0 13268,1 13285,0 13382,1 13466,0 13516,1 13574,0 13616,1 13655,0 13672,1 13736,0 13810,1 13878,0 13942,1 13949,0 13982,1 14049,0 14132,1 14198,0 14265,1 14364,0 14425,1 14469,0 14542,1 14574,0 14672,1 14755,0 14764,1 14816,0 14858,1 14946,0 15003,1 15086,0 15090,1 15136,0 15218,1 15270,0 15288,1 15319,0 15413,1 15450,0 15462,1 15474,0 15534,1 15587,0 15683,1 15687,0 15743,1 15788,0 15800,1 15860,0 15917,1 15987,0 16067,1 16096,0 16105,1 16163,0 16220,1 16239,0 16283,1 16380,0 16448,1 16507,0 16531,1 16609,0 16709,1 16733,0 16811,1 16833,0 16904,1 16977,0 17037,1 17134,0 17232,1 17274,0 17353,1 17371,0 17375,1 17451,0 17481,1 17533,0 17580,1 17628,0 17671,1 17747,0 17756,1 17786,0 17856,1 17938,0 18033,1 18124,0 18197,1 18271,0 18326,1 18394,0 18465,1 18506,0 18595,1 18666,0 18763,1 18834,0 18852,1 18896,0 18931,1 19007,0 19073,1 19118,0 19135,1 19206,0 19297,1 19339,0 19384,1 19413,0 19445,1 19528,0 19564,1 19605,0 19695,1 19774,0 19858,1 19907,0 19921,1 19945,0 20029,1 20100,0 20115,1 20176,0 20232,1 20261,0 20310,1 20326,0 20418,1 20497,0 20500,1 20571,0 20662,1 20685,0 20747,1 20837,0 20865,1 20932,0 21010,1 21052,0 21132,1 21190,0 21224,1 21309,0 21335,1 21352,0 21451,1 21465,0 21560,1 21573,0 21666,1 21687,0 21745,1 21769,0 21817,1 21887,0 21914,1 21994,0 22084,1 22108,0 22192,1 22268,0 22360,1 22394,0 22481,1 22503,0 22576,1 22626,0 22659,1 22703,0 22771,1 22815,0 22915,1 22941,0 23025,1 23055,0 23065,1 23163,0 23227,1 23245,0 23295,1 23367,0 23381,1 23458,0 23541,1 23640,0 23648,1 23649,0 23666,1 23705,0 23800,1 23814,0 23819,1 23900,0 23946,1 23966,0 24030,1 24103,0 24108,1 24183,0 24250,1 24272,0 24288,1 24360,0 24418,1 24516,0 24548,1 24590,0 24666,1 24727,0 24743,1 24787,0 24800,1 24862,0 24874,1 24942,0 24972,1 25050,0 25140,1 25210,0 25267,1 25300,0 25302,1 25391,0 25422,1 25437,0 25484,1 25568,0 25638,1 25702,0 25726,1 25776,0 25777,1 25805,0 25861,1 25875,0 25912,1 25946,0 26006,1 26053,0 26144,1 26243,0 26339,1 26414,0 26438,1 26504,0 26510,1 26561,0 26612,1 26693,0 26701,1 26739,0 26808,1 26811,0 26877,1 26944,0 26983,1 26997,0 27006,1 27078,0 27159,1 27243,0 27326,1 27328,0 27345,1 27430,0 27470,1 27514,0 27612,1 27626,0 27644,1 27667,0 27701,1 27785,0 27872,1 27947,0 28023,1 28113,0 28163,1 28195,0 28233,1 28325,0 28326,1 28417,0 28488,1 28563,0 28629,1 28654,0 28691,1 28788,0 28829,1 28885,0 28929,1 28948,0 28958,1 29057,0 29130,1 29159,0 29182,1 29210,0 29272,1 29282,0 29289,1 29304,0 29351,1 29362,0 29380,1 29449,0 29502,1 29557,0 29618,1 29675,0 29676,1 29700,0 29723,1 29749,0 29812,1 29814,0 29914,1 29948,0 29983,1 30039,0 30138,1 30168,0 30178,1 30277,0 30370,1 30458,0 30463,1 30556,0 30624,1 30673,0 30678,1 30743,0 30836,1 30878,0 30906,1 30981,0 31060,1 31077,0 31144,1 31189,0 31262,1 31327,0 31336,1 31418,0 31479,1 31560,0 31588,1 31627,0 31639,1 31655,0 31735,1 31820,0 31907,1 31923,0 31929,1 31950,0 31965,1 31991,0 32009,1 32021,0 32112,1 32115,0 32206,1 32228,0 32298,1 32372,0 32402,1 32439,0 32453,1 32471,0 32542,1 32620,0 32690,1 32751,0 32805,1 32882,0 32918,1 32983,0 32998,1 33087,0 33096,1 33185,0 33219,1 33254,0 33300,1 33336,0 33422,1 33446,0 33534,1 33592,0 33621,1 33719,0 33750,1 33775,0 33873,1 33925,0 33970,1 33973,0 33993,1 34009,0 34036,1 34041,0 34107,1 34147,0 34180,1 34235,0 34305,1 34331,0 34369,1 34403,0 34434,1 34510,0 34533,1 34570,0 34587,1 34603,0 34695,1 34781,0 34798,1 34838,0 34879,1 34963,0 35051,1 35090,0 35154,1 35240,0 35247,1 35284,0 35360,1 35434,0 35464,1 35533,0 35590,1 35663,0 35742,1 35771,0 35847,1 35869,0 35944,1 35948,0 35987,1 36060,0 36079,1 36080,0 36129,1 36186,0 36274,1 36285,0 36330,1 36415,0 36471,1 36571,0 36577,1 36646,0 36694,1 36758,0 36785,1 36795,0 36865,1 36921,0 36957,1 36976,0 37048,1 37148,0 37229,1 37324,0 37369,1 37437,0 37439,1 37465,0 37549,1 37642,0 37683,1 37701,0 37748,1 37767,0 37800,1 37848,0 37850,1 37899,0 37905,1 37926,0 37976,1 37993,0 38046,1 38091,0 38114,1 38144,0 38241,1 38315,0 38351,1 38369,0 38394,1 38444,0 38495,1 38555,0 38627,1 38702,0 38750,1 38781,0 38808,1 38871,0 38895,1 38965,0 38968,1 39052,0 39129,1 39226,0 39261,1 39327,0 39420,1 39505,0 39530,1 39597,0 39632,1 39645,0 39674,1 39731,0 39821,1 39907,0 39993,1 40015,0 40092,1 40099,0 40110,1 40159,0 40191,1 40260,0 40349,1 40434,0 40515,1 40547,0 40590,1 40661,0 40689,1 40789,0 40790,1 40830,0 40882,1 40974,0 41017,1 41033,0 41072,1 41107,0 41118,1 41128,0 41188,1 41224,0 41270,1 41272,0 41349,1 41394,0 41469,1 41528,0 41576,1 41639,0 41658,1 41681,0 41695,1 41725,0 41751,1 41791,0 41840,1 41871,0 41917,1 41975,0 42013,1 42077,0 42145,1 42223,0 42281,1 42300,0 42365,1 42394,0 42446,1 42475,0 42520,1 42550,0 42646,1 42661,0 42729,1 42738,0 42833,1 42875,0 42948,1 43014,0 43071,1 43153,0 43194,1 43251,0 43305,1 43380,0 43471,1 43531,0 43533,1 43538,0 43634,1 43734,0 43813,1 43904,0 43976,1 44012,0 44016,1 44046,0 44111,1 44167,0 44216,1 44224,0 44249,1 44254,0 44340,1 44349,0 44398,1 44408,0 44471,1 44570,0 44593,1 44685,0 44765,1 44820,0 44828,1 44853,0 44944,1 45034,0 45074,1 45139,0 45147,1 45174,0 45218,1 45268,0 45311,1 45345,0 45407,1 45427,0 45508,1 45590,0 45670,1 45726,0 45779,1 45824,0 45838,1 45905,0 45980,1 46063,0 46136,1 46195,0 46265,1 46332,0 46344,1 46407,0 46473,1 46491,0 46567,1 46572,0 46608,1 46683,0 46730,1 46792,0 46845,1 46862,0 46957,1 46980,0 47021,1 47059,0 47121,1 47195,0 47231,1 47259,0 47345,1 47348,0 47416,1 47424,0 47456,1 47529,0 47602,1 47695,0 47735,1 47773,0 47806,1 47899,0 47946,1 48021,0 48117,1 48164,0 48233,1 48283,0 48334,1 48426,0 48454,1 48517,0 48604,1 48610,0 48649,1 48740,0 48817,1 48877,0 48914,1 48958,0 48981,1 49064,0 49104,1 49184,0 49270,1 49317,0 49352,1 49389,0 49401,1 49492,0 49553,1 49565,0 49651,1 49698,0 49727,1 49730,0 49770,1 49830,0 49871,1 49935,0 50025,1 50063,0 50155,1 50245,0 50334,1 50394,0 50402,1 end initlist a10 0,0 52,1 131,0 206,1 295,0 393,1 469,0 487,1 555,0 557,1 628,0 654,1 699,0 771,1 794,0 826,1 919,0 984,1 1060,0 1140,1 1229,0 1313,1 1369,0 1435,1 1534,0 1564,1 1605,0 1613,1 1673,0 1694,1 1781,0 1805,1 1818,0 1828,1 1881,0 1923,1 1965,0 2009,1 2060,0 2097,1 2132,0 2148,1 2220,0 2290,1 2363,0 2460,1 2472,0 2489,1 2572,0 2665,1 2748,0 2793,1 2820,0 2849,1 2938,0 2962,1 3002,0 3052,1 3078,0 3166,1 3170,0 3185,1 3275,0 3300,1 3301,0 3330,1 3428,0 3478,1 3531,0 3619,1 3713,0 3782,1 3842,0 3876,1 3892,0 3964,1 4046,0 4098,1 4161,0 4182,1 4236,0 4315,1 4360,0 4406,1 4418,0 4424,1 4444,0 4488,1 4534,0 4567,1 4659,0 4690,1 4741,0 4824,1 4903,0 4999,1 5087,0 5187,1 5225,0 5246,1 5256,0 5259,1 5339,0 5385,1 5396,0 5440,1 5466,0 5467,1 5519,0 5592,1 5620,0 5688,1 5788,0 5804,1 5816,0 5866,1 5951,0 5993,1 5999,0 6095,1 6194,0 6285,1 6358,0 6426,1 6438,0 6469,1 6475,0 6533,1 6558,0 6638,1 6665,0 6669,1 6719,0 6760,1 6833,0 6841,1 6886,0 6940,1 6960,0 7034,1 7112,0 7196,1 7247,0 7340,1 7368,0 7386,1 7389,0 7413,1 7429,0 7439,1 7515,0 7588,1 7641,0 7732,1 7773,0 7872,1 7946,0 8003,1 8061,0 8083,1 8111,0 8152,1 8210,0 8225,1 8302,0 8343,1 8401,0 8480,1 8508,0 8520,1 8559,0 8595,1 8669,0 8715,1 8791,0 8828,1 8926,0 9008,1 9102,0 9148,1 9227,0 9255,1 9267,0 9316,1 9340,0 9350,1 9369,0 9392,1 9410,0 9431,1 9454,0 9502,1 9541,0 9637,1 9685,0 9761,1 9854,0 9945,1 9946,0 10022,1 10026,0 10088,1 10139,0 10232,1 10245,0 10259,1 10351,0 10393,1 10405,0 10434,1 10436,0 10464,1 10531,0 10570,1 10661,0 10752,1 10787,0 10836,1 10927,0 10973,1 11072,0 11125,1 11148,0 11178,1 11244,0 11279,1 11311,0 11402,1 11425,0 11512,1 11584,0 11672,1 11712,0 11784,1 11871,0 11935,1 11999,0 12065,1 12129,0 12205,1 12220,0 12223,1 12234,0 12250,1 12280,0 12294,1 12308,0 12390,1 12477,0 12522,1 12597,0 12620,1 12670,0 12727,1 12781,0 12814,1 12856,0 12889,1 12919,0 12951,1 13019,0 13057,1 13153,0 13248,1 13263,0 13363,1 13415,0 13488,1 13561,0 13594,1 13687,0 13743,1 13773,0 13824,1 13907,0 13919,1 13977,0 14003,1 14090,0 14171,1 14249,0 14293,1 14379,0 14462,1 14516,0 14552,1 14635,0 14688,1 14748,0 14822,1 14847,0 14901,1 14937,0 15014,1 15093,0 15137,1 15235,0 15269,1 15338,0 15411,1 15448,0 15543,1 15607,0 15608,1 15615,0 15665,1 15683,0 15743,1 15821,0 15871,1 15970,0 16066,1 16110,0 16188,1 16254,0 16347,1 16382,0 16401,1 16461,0 16497,1 16538,0 16580,1 16586,0 16607,1 16621,0 16634,1 16681,0 16755,1 16819,0 16887,1 16979,0 16986,1 17014,0 17101,1 17132,0 17217,1 17229,0 17256,1 17354,0 17413,1 17513,0 17552,1 17595,0 17601,1 17664,0 17763,1 17774,0 17869,1 17885,0 17896,1 17981,0 17999,1 18065,0 18096,1 18130,0 18197,1 18205,0 18289,1 18358,0 18457,1 18545,0 18595,1 18658,0 18745,1 18842,0 18910,1 18997,0 19017,1 19043,0 19064,1 19142,0 19188,1 19266,0 19281,1 19326,0 19408,1 19473,0 19481,1 19530,0 19613,1 19616,0 19656,1 19745,0 19767,1 19809,0 19832,1 19894,0 19948,1 19977,0 20041,1 20130,0 20161,1 20255,0 20324,1 20355,0 20388,1 20431,0 20530,1 20588,0 20622,1 20708,0 20746,1 20808,0 20899,1 20923,0 20970,1 20993,0 21057,1 21071,0 21125,1 21152,0 21218,1 21244,0 21276,1 21346,0 21420,1 21462,0 21540,1 21628,0 21715,1 21763,0 21824,1 21867,0 21941,1 22018,0 22034,1 22046,0 22061,1 22114,0 22199,1 22299,0 22385,1 22417,0 22461,1 22488,0 22569,1 22594,0 22636,1 22698,0 22738,1 22835,0 22863,1 22913,0 22967,1 22979,0 23057,1 23100,0 23184,1 23248,0 23251,1 23308,0 23314,1 23408,0 23476,1 23568,0 23612,1 23682,0 23760,1 23782,0 23837,1 23845,0 23869,1 23886,0 23960,1 24060,0 24121,1 24150,0 24152,1 24175,0 24190,1 24214,0 24285,1 24360,0 24375,1 24396,0 24433,1 24453,0 24488,1 24538,0 24574,1 24650,0 24675,1 24762,0 24801,1 24825,0 24841,1 24866,0 24936,1 25036,0 25047,1 25082,0 25123,1 25188,0 25211,1 25275,0 25350,1 25373,0 25468,1 25529,0 25541,1 25640,0 25720,1 25777,0 25802,1 25856,0 25905,1 25939,0 26030,1 26127,0 26139,1 26213,0 26265,1 26343,0 26385,1 26451,0 26497,1 26529,0 26595,1 26684,0 26706,1 26780,0 26820,1 26850,0 26940,1 27036,0 27058,1 27153,0 27237,1 27308,0 27367,1 27458,0 27479,1 27488,0 27507,1 27564,0 27625,1 27634,0 27662,1 27742,0 27816,1 27818,0 27914,1 27933,0 27990,1 28030,0 28116,1 28169,0 28173,1 28205,0 28218,1 28308,0 28317,1 28380,0 28427,1 28483,0 28513,1 28526,0 28605,1 28692,0 28777,1 28877,0 28923,1 28973,0 29021,1 29060,0 29128,1 29147,0 29159,1 29188,0 29217,1 29309,0 29353,1 29402,0 29464,1 29561,0 29586,1 29658,0 29715,1 29768,0 29863,1 29945,0 29970,1 29986,0 29998,1 30017,0 30098,1 30180,0 30213,1 30257,0 30323,1 30421,0 30438,1 30489,0 30574,1 30577,0 30675,1 30774,0 30862,1 30907,0 30931,1 30950,0 31031,1 31034,0 31109,1 31134,0 31151,1 31226,0 31250,1 31313,0 31384,1 31394,0 31430,1 31512,0 31605,1 31633,0 31723,1 31800,0 31854,1 31925,0 31983,1 32077,0 32108,1 32127,0 32199,1 32244,0 32286,1 32357,0 32364,1 32406,0 32451,1 32490,0 32584,1 32608,0 32650,1 32708,0 32799,1 32813,0 32848,1 32882,0 32916,1 32960,0 33039,1 33098,0 33100,1 33108,0 33132,1 33216,0 33231,1 33330,0 33392,1 33428,0 33483,1 33544,0 33608,1 33654,0 33745,1 33774,0 33794,1 33828,0 33840,1 33864,0 33941,1 33995,0 34054,1 34055,0 34085,1 34107,0 34201,1 34208,0 34235,1 34317,0 34396,1 34433,0 34435,1 34532,0 34536,1 34558,0 34586,1 34608,0 34690,1 34696,0 34785,1 34810,0 34881,1 34918,0 34948,1 35004,0 35098,1 35127,0 35218,1 35296,0 35384,1 35468,0 35545,1 35587,0 35682,1 35702,0 35765,1 35815,0 35839,1 35856,0 35951,1 36034,0 36054,1 36067,0 36099,1 36123,0 36172,1 36197,0 36264,1 36340,0 36383,1 36431,0 36472,1 36553,0 36575,1 36636,0 36649,1 36746,0 36748,1 36794,0 36826,1 36866,0 36875,1 36942,0 36995,1 37035,0 37090,1 37106,0 37154,1 37211,0 37305,1 37376,0 37400,1 37444,0 37512,1 37555,0 37610,1 37703,0 37763,1 37838,0 37926,1 37984,0 38014,1 38071,0 38132,1 38161,0 38229,1 38283,0 38298,1 38379,0 38474,1 38527,0 38619,1 38701,0 38775,1 38843,0 38855,1 38915,0 38934,1 38994,0 39075,1 39112,0 39181,1 39199,0 39260,1 39268,0 39319,1 39380,0 39415,1 39446,0 39526,1 39579,0 39597,1 39661,0 39749,1 39792,0 39862,1 39916,0 39960,1 39977,0 40053,1 40151,0 40216,1 40263,0 40324,1 40391,0 40454,1 40475,0 40492,1 40519,0 40613,1 40704,0 40804,1 40900,0 40920,1 40926,0 40955,1 40969,0 40980,1 40986,0 41009,1 41085,0 41115,1 41118,0 41163,1 41219,0 41319,1 41397,0 41490,1 41578,0 41586,1 41589,0 41637,1 41660,0 41664,1 41762,0 41841,1 41909,0 41960,1 42059,0 42124,1 42136,0 42149,1 42210,0 42249,1 42277,0 42295,1 42378,0 42404,1 42461,0 42510,1 42607,0 42636,1 42712,0 42769,1 42868,0 42930,1 42987,0 43014,1 43028,0 43041,1 43135,0 43173,1 43221,0 43305,1 43361,0 43443,1 43492,0 43524,1 43598,0 43657,1 43731,0 43777,1 43789,0 43877,1 43920,0 43966,1 44064,0 44067,1 44123,0 44191,1 44210,0 44308,1 44376,0 44388,1 44394,0 44426,1 44431,0 44527,1 44558,0 44593,1 44686,0 44690,1 44754,0 44797,1 44885,0 44970,1 45013,0 45078,1 45093,0 45190,1 45222,0 45280,1 45357,0 45374,1 45400,0 45466,1 45517,0 45612,1 45698,0 45794,1 45880,0 45884,1 45887,0 45939,1 45986,0 46022,1 46078,0 46116,1 46172,0 46266,1 46338,0 46380,1 46472,0 46567,1 46575,0 46604,1 46626,0 46689,1 46726,0 46753,1 46790,0 46871,1 46955,0 46962,1 46983,0 47042,1 47128,0 47159,1 47185,0 47250,1 47269,0 47355,1 47389,0 47472,1 47494,0 47507,1 47601,0 47652,1 47678,0 47692,1 47721,0 47730,1 47805,0 47849,1 47905,0 47919,1 47978,0 48053,1 48126,0 48187,1 48230,0 48321,1 48352,0 48447,1 48490,0 48547,1 48572,0 48620,1 48693,0 48714,1 48745,0 48756,1 48829,0 48881,1 48920,0 49017,1 49030,0 49129,1 49201,0 49232,1 49327,0 49409,1 49446,0 49473,1 49499,0 49571,1 49644,0 49707,1 49777,0 49844,1 49932,0 50019,1 50111,0 50179,1 50267,0 50293,1 50352,0 50427,1 50526,0 50537,1 50629,0 50710,1 50719,0 50724,1 50791,0 50865,1 50924,0 50989,1 51084,0 51160,1 51257,0 51296,1 51396,0 51423,1 51437,0 51439,1 51502,0 51519,1 51550,0 51623,1 end initlist a11 0,0 26,1 64,0 98,1 104,0 112,1 148,0 229,1 281,0 311,1 348,0 382,1 475,0 509,1 536,0 597,1 662,0 676,1 744,0 780,1 879,0 922,1 960,0 963,1 1015,0 1100,1 1177,0 1201,1 1232,0 1292,1 1382,0 1398,1 1486,0 1530,1 1602,0 1639,1 1691,0 1693,1 1695,0 1708,1 1753,0 1852,1 1902,0 1948,1 1959,0 2054,1 2117,0 2191,1 2250,0 2329,1 2341,0 2363,1 2374,0 2400,1 2420,0 2512,1 2521,0 2585,1 2598,0 2655,1 2692,0 2779,1 2835,0 2933,1 2958,0 2959,1 2966,0 2987,1 3072,0 3131,1 3137,0 3208,1 3230,0 3326,1 3358,0 3393,1 3413,0 3498,1 3596,0 3670,1 3761,0 3846,1 3847,0 3881,1 3887,0 3935,1 3995,0 4003,1 4026,0 4079,1 4176,0 4229,1 4322,0 4405,1 4501,0 4557,1 4635,0 4666,1 4671,0 4753,1 4834,0 4887,1 4908,0 4939,1 5025,0 5095,1 5121,0 5208,1 5272,0 5361,1 5368,0 5405,1 5470,0 5496,1 5581,0 5652,1 5660,0 5711,1 5796,0 5872,1 5888,0 5899,1 5921,0 5928,1 5976,0 5991,1 6035,0 6121,1 6203,0 6267,1 6295,0 6355,1 6417,0 6464,1 6545,0 6604,1 6612,0 6669,1 6740,0 6838,1 6876,0 6895,1 6907,0 6918,1 6957,0 6990,1 7035,0 7087,1 7160,0 7190,1 7247,0 7330,1 7342,0 7400,1 7480,0 7493,1 7497,0 7540,1 7590,0 7642,1 7669,0 7706,1 7772,0 7833,1 7885,0 7920,1 7927,0 7993,1 7998,0 8047,1 8057,0 8100,1 8138,0 8159,1 8256,0 8259,1 8294,0 8334,1 8378,0 8404,1 8445,0 8450,1 8487,0 8510,1 8568,0 8663,1 8718,0 8795,1 8881,0 8953,1 8980,0 9003,1 9039,0 9066,1 9146,0 9211,1 9299,0 9357,1 9426,0 9489,1 9546,0 9644,1 9695,0 9752,1 9775,0 9851,1 9883,0 9965,1 10030,0 10043,1 10064,0 10161,1 10235,0 10239,1 10248,0 10316,1 10322,0 10329,1 10360,0 10436,1 10506,0 10524,1 10540,0 10590,1 10674,0 10750,1 10755,0 10834,1 10880,0 10946,1 10986,0 11051,1 11074,0 11080,1 11143,0 11213,1 11272,0 11316,1 11370,0 11406,1 11505,0 11573,1 11631,0 11651,1 11678,0 11683,1 11704,0 11723,1 11738,0 11801,1 11831,0 11918,1 12015,0 12064,1 12095,0 12118,1 12207,0 12242,1 12295,0 12384,1 12404,0 12457,1 12543,0 12640,1 12727,0 12795,1 12831,0 12884,1 12963,0 12977,1 13018,0 13073,1 13118,0 13175,1 13266,0 13282,1 13290,0 13380,1 13470,0 13551,1 13569,0 13570,1 13625,0 13679,1 13729,0 13775,1 13811,0 13891,1 13932,0 14020,1 14099,0 14152,1 14178,0 14216,1 14262,0 14309,1 14322,0 14419,1 14477,0 14491,1 14517,0 14610,1 14654,0 14715,1 14799,0 14847,1 14939,0 14996,1 15069,0 15123,1 15148,0 15159,1 15172,0 15184,1 15259,0 15293,1 15310,0 15348,1 15441,0 15528,1 15535,0 15542,1 15599,0 15689,1 15744,0 15769,1 15824,0 15851,1 15879,0 15971,1 16048,0 16058,1 16070,0 16166,1 16184,0 16250,1 16260,0 16323,1 16419,0 16488,1 16499,0 16528,1 16534,0 16625,1 16638,0 16642,1 16649,0 16723,1 16737,0 16797,1 16833,0 16905,1 16967,0 17053,1 17063,0 17069,1 17112,0 17207,1 17261,0 17334,1 17342,0 17438,1 17503,0 17505,1 17560,0 17644,1 17651,0 17735,1 17753,0 17769,1 17772,0 17777,1 17835,0 17902,1 17987,0 18071,1 18091,0 18161,1 18204,0 18281,1 18380,0 18464,1 18493,0 18528,1 18536,0 18633,1 18688,0 18714,1 18814,0 18903,1 18942,0 18999,1 19098,0 19099,1 19165,0 19196,1 19234,0 19235,1 19264,0 19322,1 19333,0 19342,1 19360,0 19394,1 19401,0 19430,1 19478,0 19480,1 19542,0 19576,1 19650,0 19735,1 19770,0 19836,1 19880,0 19881,1 19900,0 19932,1 20024,0 20087,1 20141,0 20166,1 20262,0 20304,1 20342,0 20379,1 20441,0 20486,1 20532,0 20579,1 20593,0 20641,1 20690,0 20720,1 20792,0 20797,1 20841,0 20875,1 20971,0 21036,1 21092,0 21093,1 21150,0 21209,1 21269,0 21343,1 21362,0 21424,1 21488,0 21559,1 21579,0 21658,1 21713,0 21805,1 21893,0 21931,1 21937,0 21941,1 21945,0 21969,1 21986,0 22054,1 22098,0 22138,1 22146,0 22245,1 22320,0 22348,1 22426,0 22453,1 22535,0 22605,1 22628,0 22712,1 22792,0 22875,1 22969,0 23002,1 23046,0 23099,1 23164,0 23191,1 23290,0 23383,1 23468,0 23558,1 23572,0 23585,1 23672,0 23769,1 23840,0 23920,1 23998,0 24071,1 24117,0 24120,1 24218,0 24245,1 24299,0 24316,1 24322,0 24413,1 24483,0 24532,1 24572,0 24611,1 24684,0 24732,1 24788,0 24831,1 24850,0 24869,1 24901,0 24923,1 24943,0 25033,1 25068,0 25115,1 25136,0 25235,1 25294,0 25364,1 25463,0 25509,1 25608,0 25668,1 25751,0 25827,1 25906,0 25927,1 25952,0 26015,1 26075,0 26161,1 26217,0 26260,1 26302,0 26371,1 26384,0 26457,1 26478,0 26496,1 26544,0 26562,1 26590,0 26629,1 26669,0 26729,1 26826,0 26898,1 26901,0 26952,1 27034,0 27127,1 27148,0 27177,1 27200,0 27289,1 27292,0 27296,1 27333,0 27431,1 27481,0 27554,1 27649,0 27680,1 27780,0 27834,1 27887,0 27930,1 28006,0 28007,1 28088,0 28091,1 28189,0 28205,1 28220,0 28225,1 28246,0 28286,1 28291,0 28387,1 28416,0 28423,1 28449,0 28493,1 28587,0 28663,1 28678,0 28725,1 28807,0 28903,1 28966,0 29012,1 29027,0 29046,1 29107,0 29117,1 29148,0 29174,1 29255,0 29341,1 29424,0 29461,1 29514,0 29522,1 29619,0 29630,1 29659,0 29708,1 29732,0 29737,1 29836,0 29881,1 29959,0 30056,1 30153,0 30157,1 30186,0 30267,1 30359,0 30424,1 30455,0 30495,1 30583,0 30678,1 30691,0 30764,1 30778,0 30807,1 30865,0 30960,1 30988,0 31065,1 31159,0 31214,1 31303,0 31313,1 31413,0 31468,1 31508,0 31601,1 31622,0 31659,1 31703,0 31799,1 31898,0 31951,1 32050,0 32129,1 32139,0 32155,1 32227,0 32255,1 32345,0 32378,1 32398,0 32436,1 32474,0 32518,1 32528,0 32615,1 32662,0 32733,1 32807,0 32825,1 32921,0 32969,1 32995,0 33086,1 33172,0 33182,1 33211,0 33230,1 33285,0 33343,1 33408,0 33483,1 33547,0 33614,1 33707,0 33733,1 33747,0 33751,1 33850,0 33887,1 33971,0 34049,1 34093,0 34149,1 34224,0 34321,1 34356,0 34358,1 34376,0 34465,1 34535,0 34553,1 34592,0 34640,1 34686,0 34722,1 34755,0 34841,1 34907,0 34971,1 34983,0 35021,1 35059,0 35088,1 35158,0 35213,1 35310,0 35317,1 35339,0 35349,1 35440,0 35505,1 35586,0 35671,1 35689,0 35785,1 35807,0 35890,1 35916,0 35970,1 36069,0 36160,1 36167,0 36212,1 36276,0 36368,1 36447,0 36502,1 36516,0 36545,1 36640,0 36735,1 36788,0 36852,1 36946,0 36990,1 37000,0 37068,1 37146,0 37191,1 37222,0 37303,1 37362,0 37423,1 37520,0 37563,1 37590,0 37647,1 37739,0 37781,1 37806,0 37889,1 37891,0 37971,1 38065,0 38153,1 38231,0 38287,1 38290,0 38374,1 38453,0 38539,1 38556,0 38566,1 38621,0 38714,1 38804,0 38843,1 38853,0 38952,1 39038,0 39055,1 39111,0 39206,1 39263,0 39313,1 39319,0 39419,1 39468,0 39490,1 39539,0 39563,1 39579,0 39674,1 39727,0 39728,1 39743,0 39835,1 39865,0 39892,1 39988,0 39990,1 40046,0 40057,1 40151,0 40174,1 40175,0 40222,1 40304,0 40403,1 40432,0 40483,1 40569,0 40606,1 40639,0 40709,1 40809,0 40894,1 40994,0 41005,1 41065,0 41162,1 41190,0 41274,1 41282,0 41314,1 41365,0 41460,1 41551,0 41558,1 41580,0 41641,1 41732,0 41752,1 41786,0 41850,1 41887,0 41957,1 42050,0 42065,1 42130,0 42223,1 42243,0 42336,1 42360,0 42438,1 42451,0 42523,1 42527,0 42618,1 42672,0 42763,1 42827,0 42835,1 42923,0 43004,1 43097,0 43148,1 43224,0 43306,1 43324,0 43423,1 43449,0 43508,1 43574,0 43673,1 43740,0 43780,1 43797,0 43897,1 43908,0 43993,1 44018,0 44041,1 44106,0 44183,1 44276,0 44368,1 44424,0 44513,1 44522,0 44580,1 44622,0 44661,1 44725,0 44817,1 44866,0 44936,1 44985,0 45045,1 45068,0 45086,1 45106,0 45186,1 45228,0 45271,1 45322,0 45352,1 45417,0 45510,1 45581,0 45672,1 45755,0 45832,1 45881,0 45946,1 46006,0 46055,1 46092,0 46158,1 46174,0 46177,1 46192,0 46223,1 46273,0 46343,1 46384,0 46438,1 46499,0 46587,1 46611,0 46678,1 46773,0 46847,1 46917,0 46926,1 46976,0 47023,1 47091,0 47137,1 47139,0 47230,1 47248,0 47293,1 47314,0 47335,1 47384,0 47419,1 47501,0 47515,1 47565,0 47632,1 47661,0 47686,1 47786,0 47835,1 47886,0 47898,1 47989,0 48001,1 48057,0 48087,1 48146,0 48234,1 48246,0 48341,1 48367,0 48464,1 48477,0 48575,1 48655,0 48656,1 48661,0 48727,1 48802,0 48814,1 48866,0 48893,1 48937,0 48987,1 48989,0 49087,1 49103,0 49137,1 49221,0 49256,1 49312,0 49392,1 49464,0 49476,1 49542,0 49551,1 49585,0 49614,1 49712,0 49772,1 49857,0 49941,1 49981,0 50074,1 50145,0 50175,1 50258,0 50330,1 50400,0 50495,1 50581,0 50676,1 50693,0 50789,1 50848,0 50862,1 50942,0 51005,1 51047,0 51105,1 end initlist a12 0,0 10,1 83,0 86,1 90,0 106,1 121,0 189,1 215,0 247,1 261,0 292,1 316,0 415,1 474,0 552,1 621,0 703,1 777,0 780,1 812,0 868,1 943,0 988,1 1064,0 1142,1 1177,0 1255,1 1354,0 1362,1 1381,0 1417,1 1516,0 1547,1 1594,0 1622,1 1711,0 1804,1 1845,0 1895,1 1932,0 1959,1 2045,0 2071,1 2077,0 2150,1 2185,0 2199,1 2289,0 2349,1 2434,0 2467,1 2520,0 2526,1 2557,0 2595,1 2624,0 2698,1 2702,0 2718,1 2767,0 2802,1 2897,0 2970,1 2973,0 3021,1 3111,0 3199,1 3220,0 3309,1 3346,0 3420,1 3507,0 3526,1 3584,0 3681,1 3750,0 3768,1 3853,0 3890,1 3972,0 4028,1 4073,0 4150,1 4217,0 4253,1 4270,0 4343,1 4401,0 4402,1 4467,0 4513,1 4592,0 4628,1 4725,0 4732,1 4783,0 4870,1 4896,0 4948,1 4976,0 5028,1 5067,0 5135,1 5141,0 5194,1 5212,0 5270,1 5333,0 5408,1 5431,0 5456,1 5536,0 5575,1 5579,0 5617,1 5680,0 5751,1 5800,0 5838,1 5850,0 5880,1 5954,0 5995,1 6001,0 6067,1 6098,0 6175,1 6179,0 6246,1 6334,0 6335,1 6386,0 6404,1 6496,0 6540,1 6574,0 6593,1 6660,0 6672,1 6719,0 6775,1 6840,0 6885,1 6965,0 6985,1 7081,0 7090,1 7139,0 7172,1 7199,0 7233,1 7265,0 7319,1 7383,0 7459,1 7520,0 7582,1 7593,0 7640,1 7731,0 7777,1 7834,0 7902,1 7912,0 7958,1 8047,0 8066,1 8069,0 8155,1 8216,0 8247,1 8258,0 8313,1 8325,0 8331,1 8402,0 8471,1 8566,0 8573,1 8611,0 8689,1 8693,0 8738,1 8808,0 8885,1 8963,0 9004,1 9041,0 9063,1 9097,0 9148,1 9229,0 9306,1 9344,0 9379,1 9404,0 9407,1 9476,0 9567,1 9581,0 9603,1 9639,0 9702,1 9763,0 9838,1 9851,0 9895,1 9963,0 10046,1 10090,0 10100,1 10107,0 10203,1 10232,0 10317,1 10366,0 10387,1 10475,0 10492,1 10520,0 10556,1 10595,0 10668,1 10767,0 10810,1 10866,0 10936,1 10961,0 11010,1 11041,0 11058,1 11136,0 11181,1 11231,0 11269,1 11287,0 11297,1 11344,0 11411,1 11436,0 11483,1 11501,0 11545,1 11621,0 11662,1 11697,0 11772,1 11857,0 11942,1 12007,0 12067,1 12161,0 12260,1 12290,0 12308,1 12349,0 12359,1 12366,0 12390,1 12397,0 12475,1 12482,0 12537,1 12582,0 12639,1 12723,0 12823,1 12892,0 12948,1 13037,0 13053,1 13102,0 13141,1 13217,0 13282,1 13344,0 13390,1 13409,0 13411,1 13463,0 13480,1 13522,0 13575,1 13589,0 13652,1 13743,0 13774,1 13789,0 13837,1 13846,0 13907,1 13909,0 13965,1 14016,0 14116,1 14124,0 14135,1 14211,0 14238,1 14272,0 14346,1 14440,0 14441,1 14538,0 14576,1 14607,0 14698,1 14753,0 14803,1 14853,0 14857,1 14875,0 14918,1 14933,0 14992,1 15073,0 15155,1 15211,0 15218,1 15304,0 15384,1 15404,0 15461,1 15530,0 15545,1 15637,0 15721,1 15808,0 15873,1 15889,0 15984,1 16076,0 16150,1 16206,0 16254,1 16328,0 16392,1 16410,0 16445,1 16507,0 16523,1 16596,0 16634,1 16642,0 16643,1 16693,0 16738,1 16803,0 16901,1 16974,0 17014,1 17069,0 17160,1 17210,0 17238,1 17243,0 17291,1 17386,0 17459,1 17546,0 17609,1 17668,0 17686,1 17695,0 17755,1 17759,0 17772,1 17779,0 17809,1 17885,0 17970,1 18050,0 18119,1 18165,0 18244,1 18298,0 18333,1 18354,0 18368,1 18398,0 18406,1 18435,0 18504,1 18536,0 18605,1 18648,0 18671,1 18763,0 18818,1 18905,0 18934,1 18980,0 18985,1 18999,0 19028,1 19070,0 19161,1 19215,0 19239,1 19268,0 19296,1 19322,0 19402,1 19438,0 19448,1 19520,0 19618,1 19682,0 19683,1 19736,0 19830,1 19851,0 19933,1 19998,0 20062,1 20110,0 20120,1 20176,0 20229,1 20272,0 20364,1 20464,0 20531,1 20574,0 20619,1 20665,0 20715,1 20748,0 20759,1 20764,0 20836,1 20869,0 20883,1 20959,0 21002,1 21054,0 21117,1 21172,0 21239,1 21316,0 21343,1 21443,0 21489,1 21585,0 21643,1 21689,0 21695,1 21755,0 21795,1 21891,0 21971,1 22067,0 22135,1 22208,0 22282,1 22288,0 22365,1 22416,0 22510,1 22589,0 22670,1 22672,0 22713,1 22750,0 22791,1 22794,0 22799,1 22880,0 22970,1 23033,0 23085,1 23125,0 23204,1 23229,0 23257,1 23290,0 23379,1 23412,0 23421,1 23518,0 23540,1 23610,0 23652,1 23659,0 23711,1 23774,0 23803,1 23881,0 23933,1 23977,0 24032,1 24036,0 24127,1 24145,0 24233,1 24259,0 24345,1 24418,0 24497,1 24561,0 24606,1 24615,0 24640,1 24707,0 24800,1 24820,0 24893,1 24975,0 25045,1 25145,0 25179,1 25274,0 25341,1 25425,0 25469,1 25556,0 25581,1 25612,0 25694,1 25774,0 25849,1 25875,0 25907,1 25996,0 26069,1 26097,0 26148,1 26241,0 26260,1 26298,0 26336,1 26401,0 26493,1 26529,0 26595,1 26623,0 26631,1 26651,0 26675,1 26769,0 26777,1 26836,0 26883,1 26955,0 26982,1 27034,0 27111,1 27150,0 27188,1 27212,0 27245,1 27279,0 27322,1 27385,0 27432,1 27453,0 27543,1 27634,0 27654,1 27715,0 27792,1 27863,0 27899,1 27920,0 27976,1 28008,0 28097,1 28113,0 28173,1 28236,0 28322,1 28411,0 28493,1 28522,0 28590,1 28591,0 28593,1 28655,0 28665,1 28704,0 28720,1 28756,0 28830,1 28916,0 28977,1 29009,0 29098,1 29187,0 29213,1 29234,0 29260,1 29275,0 29348,1 29422,0 29452,1 29520,0 29578,1 29610,0 29665,1 29702,0 29785,1 29826,0 29864,1 29868,0 29910,1 29917,0 29980,1 29995,0 30018,1 30066,0 30067,1 30085,0 30158,1 30233,0 30255,1 30338,0 30424,1 30520,0 30571,1 30573,0 30631,1 30702,0 30703,1 30803,0 30812,1 30838,0 30887,1 30975,0 31034,1 31097,0 31098,1 31183,0 31256,1 31356,0 31408,1 31492,0 31588,1 31677,0 31708,1 31718,0 31773,1 31790,0 31882,1 31972,0 32042,1 32128,0 32155,1 32209,0 32277,1 32316,0 32317,1 32374,0 32397,1 32403,0 32452,1 32485,0 32515,1 32518,0 32589,1 32619,0 32621,1 32693,0 32761,1 32804,0 32855,1 32886,0 32963,1 33014,0 33053,1 33150,0 33177,1 33260,0 33322,1 33410,0 33427,1 33502,0 33586,1 33589,0 33655,1 33699,0 33711,1 33733,0 33775,1 33799,0 33865,1 33955,0 34048,1 34136,0 34211,1 34252,0 34283,1 34337,0 34402,1 34496,0 34540,1 34605,0 34700,1 34704,0 34742,1 34750,0 34818,1 34865,0 34953,1 35022,0 35031,1 35110,0 35203,1 35277,0 35295,1 35341,0 35345,1 35398,0 35427,1 35439,0 35441,1 35528,0 35622,1 35673,0 35704,1 35793,0 35866,1 35940,0 35988,1 36030,0 36127,1 36138,0 36233,1 36313,0 36384,1 36484,0 36569,1 36598,0 36640,1 36663,0 36754,1 36762,0 36779,1 36789,0 36815,1 36848,0 36872,1 36919,0 36973,1 36997,0 37011,1 37037,0 37056,1 37149,0 37240,1 37318,0 37383,1 37456,0 37494,1 37496,0 37580,1 37616,0 37700,1 37742,0 37763,1 37846,0 37872,1 37954,0 38022,1 38110,0 38135,1 38137,0 38146,1 38163,0 38217,1 38273,0 38370,1 38438,0 38508,1 38535,0 38632,1 38673,0 38694,1 38741,0 38796,1 38864,0 38925,1 39012,0 39062,1 39132,0 39139,1 39184,0 39199,1 39248,0 39334,1 39359,0 39455,1 39503,0 39596,1 39660,0 39719,1 39786,0 39857,1 39936,0 39947,1 40034,0 40118,1 40128,0 40202,1 40272,0 40285,1 40374,0 40377,1 40456,0 40509,1 40564,0 40565,1 40598,0 40619,1 40630,0 40730,1 40776,0 40845,1 40872,0 40910,1 41004,0 41006,1 41044,0 41084,1 41105,0 41151,1 41177,0 41273,1 41370,0 41372,1 41408,0 41458,1 41543,0 41590,1 41688,0 41774,1 41847,0 41870,1 41952,0 41961,1 42012,0 42061,1 42095,0 42110,1 42199,0 42213,1 42283,0 42305,1 42371,0 42422,1 42463,0 42553,1 42639,0 42657,1 42664,0 42725,1 42769,0 42839,1 42855,0 42941,1 43035,0 43055,1 43077,0 43173,1 43264,0 43267,1 43276,0 43314,1 43322,0 43331,1 43392,0 43393,1 43407,0 43506,1 43598,0 43645,1 43651,0 43743,1 43809,0 43824,1 43840,0 43931,1 43978,0 43985,1 44060,0 44134,1 44182,0 44223,1 44281,0 44367,1 44370,0 44381,1 44400,0 44412,1 44489,0 44553,1 44575,0 44674,1 44748,0 44831,1 44843,0 44937,1 44969,0 45021,1 45104,0 45146,1 45195,0 45201,1 45272,0 45274,1 45324,0 45409,1 45459,0 45518,1 45568,0 45651,1 45685,0 45698,1 45703,0 45792,1 45819,0 45906,1 45927,0 45938,1 45964,0 46055,1 46111,0 46190,1 46196,0 46204,1 46259,0 46289,1 46317,0 46414,1 46499,0 46565,1 46654,0 46752,1 46807,0 46809,1 46862,0 46909,1 46927,0 46954,1 47050,0 47120,1 47130,0 47211,1 47299,0 47355,1 47372,0 47406,1 47456,0 47481,1 47537,0 47599,1 47650,0 47681,1 47686,0 47725,1 47766,0 47851,1 47942,0 47961,1 48019,0 48087,1 48102,0 48175,1 48219,0 48301,1 48363,0 48398,1 48416,0 48472,1 48551,0 48574,1 48658,0 48712,1 48749,0 48790,1 48792,0 48841,1 48918,0 49013,1 49110,0 49130,1 49164,0 49190,1 49264,0 49305,1 49343,0 49358,1 49453,0 49550,1 49597,0 49621,1 49630,0 49644,1 49678,0 49714,1 49779,0 49835,1 end initlist a13 0,0 27,1 93,0 156,1 175,0 226,1 245,0 276,1 285,0 295,1 331,0 428,1 476,0 509,1 583,0 606,1 614,0 656,1 665,0 691,1 711,0 776,1 829,0 929,1 1006,0 1031,1 1059,0 1146,1 1236,0 1298,1 1302,0 1395,1 1449,0 1527,1 1550,0 1551,1 1589,0 1623,1 1723,0 1775,1 1780,0 1868,1 1895,0 1934,1 2004,0 2071,1 2115,0 2125,1 2144,0 2194,1 2276,0 2355,1 2420,0 2435,1 2439,0 2523,1 2559,0 2636,1 2653,0 2744,1 2828,0 2847,1 2927,0 2997,1 3052,0 3055,1 3149,0 3212,1 3253,0 3255,1 3308,0 3340,1 3424,0 3466,1 3535,0 3578,1 3654,0 3678,1 3729,0 3823,1 3914,0 3995,1 4000,0 4064,1 4122,0 4139,1 4201,0 4298,1 4308,0 4388,1 4449,0 4501,1 4562,0 4654,1 4690,0 4711,1 4735,0 4738,1 4799,0 4855,1 4867,0 4942,1 4973,0 4986,1 4993,0 5068,1 5081,0 5143,1 5173,0 5188,1 5195,0 5203,1 5216,0 5281,1 5311,0 5391,1 5487,0 5565,1 5600,0 5674,1 5747,0 5756,1 5759,0 5827,1 5923,0 5924,1 5963,0 6049,1 6144,0 6214,1 6226,0 6261,1 6342,0 6362,1 6456,0 6509,1 6604,0 6681,1 6740,0 6825,1 6910,0 6983,1 6992,0 7011,1 7021,0 7068,1 7160,0 7199,1 7212,0 7219,1 7229,0 7326,1 7391,0 7468,1 7502,0 7590,1 7666,0 7706,1 7730,0 7788,1 7824,0 7852,1 7950,0 7974,1 8011,0 8028,1 8097,0 8186,1 8196,0 8245,1 8252,0 8269,1 8317,0 8401,1 8441,0 8521,1 8567,0 8646,1 8732,0 8823,1 8856,0 8906,1 8969,0 9053,1 9151,0 9224,1 9306,0 9401,1 9490,0 9516,1 9601,0 9671,1 9720,0 9722,1 9790,0 9852,1 9949,0 10010,1 10076,0 10157,1 10204,0 10276,1 10332,0 10408,1 10475,0 10540,1 10635,0 10703,1 10783,0 10851,1 10884,0 10970,1 10998,0 11061,1 11122,0 11206,1 11284,0 11346,1 11434,0 11468,1 11544,0 11551,1 11559,0 11654,1 11699,0 11743,1 11789,0 11885,1 11979,0 12013,1 12039,0 12100,1 12152,0 12203,1 12206,0 12269,1 12270,0 12290,1 12384,0 12431,1 12464,0 12473,1 12495,0 12515,1 12610,0 12704,1 12709,0 12714,1 12717,0 12805,1 12894,0 12929,1 13005,0 13095,1 13109,0 13199,1 13261,0 13352,1 13448,0 13539,1 13567,0 13570,1 13597,0 13652,1 13707,0 13801,1 13891,0 13946,1 13958,0 14008,1 14030,0 14045,1 14057,0 14121,1 14180,0 14198,1 14238,0 14252,1 14316,0 14350,1 14427,0 14467,1 14557,0 14647,1 14678,0 14707,1 14771,0 14816,1 14877,0 14959,1 14973,0 15071,1 15100,0 15191,1 15202,0 15214,1 15245,0 15309,1 15361,0 15435,1 15470,0 15499,1 15545,0 15616,1 15657,0 15696,1 15772,0 15871,1 15966,0 16011,1 16069,0 16166,1 16259,0 16272,1 16322,0 16341,1 16426,0 16449,1 16504,0 16596,1 16653,0 16750,1 16769,0 16798,1 16892,0 16973,1 17050,0 17061,1 17132,0 17208,1 17217,0 17286,1 17365,0 17406,1 17474,0 17542,1 17598,0 17698,1 17749,0 17826,1 17846,0 17887,1 17917,0 17931,1 17975,0 18014,1 18060,0 18150,1 18194,0 18276,1 18359,0 18370,1 18401,0 18474,1 18541,0 18636,1 18660,0 18747,1 18843,0 18916,1 19007,0 19074,1 19137,0 19217,1 19315,0 19399,1 19452,0 19542,1 19640,0 19727,1 19822,0 19870,1 19921,0 19990,1 20045,0 20137,1 20235,0 20249,1 20309,0 20343,1 20371,0 20374,1 20382,0 20475,1 20553,0 20575,1 20640,0 20696,1 20735,0 20792,1 20876,0 20925,1 20965,0 21062,1 21102,0 21119,1 21216,0 21244,1 21337,0 21346,1 21422,0 21491,1 21532,0 21540,1 21575,0 21617,1 21668,0 21678,1 21776,0 21867,1 21909,0 21914,1 21998,0 22004,1 22073,0 22074,1 22111,0 22150,1 22158,0 22179,1 22276,0 22319,1 22326,0 22339,1 22388,0 22425,1 22453,0 22471,1 22479,0 22532,1 22572,0 22647,1 22673,0 22770,1 22771,0 22832,1 22836,0 22885,1 22912,0 22953,1 22982,0 23050,1 23141,0 23183,1 23278,0 23369,1 23379,0 23472,1 23526,0 23538,1 23552,0 23622,1 23707,0 23715,1 23753,0 23783,1 23864,0 23948,1 24022,0 24043,1 24137,0 24161,1 24245,0 24317,1 24359,0 24458,1 24493,0 24549,1 24590,0 24626,1 24653,0 24728,1 24737,0 24783,1 24800,0 24870,1 24912,0 24961,1 25023,0 25068,1 25093,0 25101,1 25189,0 25219,1 25240,0 25336,1 25379,0 25417,1 25442,0 25503,1 25570,0 25588,1 25623,0 25682,1 25780,0 25798,1 25897,0 25962,1 26038,0 26054,1 26133,0 26223,1 26233,0 26302,1 26350,0 26431,1 26452,0 26464,1 26534,0 26627,1 26648,0 26669,1 26751,0 26833,1 26904,0 26961,1 26979,0 27019,1 27048,0 27139,1 27226,0 27269,1 27349,0 27372,1 27410,0 27441,1 27465,0 27499,1 27549,0 27636,1 27707,0 27799,1 27897,0 27971,1 28003,0 28007,1 28038,0 28042,1 28093,0 28127,1 28135,0 28182,1 28275,0 28333,1 28384,0 28431,1 28467,0 28551,1 28621,0 28654,1 28667,0 28694,1 28713,0 28788,1 28794,0 28807,1 28827,0 28886,1 28911,0 28952,1 28974,0 29053,1 29134,0 29146,1 29202,0 29259,1 29320,0 29388,1 29454,0 29493,1 29580,0 29673,1 29753,0 29802,1 29838,0 29932,1 29982,0 30051,1 30109,0 30185,1 30279,0 30311,1 30365,0 30457,1 30514,0 30524,1 30564,0 30565,1 30587,0 30623,1 30708,0 30751,1 30820,0 30874,1 30965,0 31023,1 31033,0 31129,1 31223,0 31261,1 31322,0 31401,1 31487,0 31524,1 31606,0 31627,1 31685,0 31695,1 31760,0 31789,1 31813,0 31861,1 31954,0 31991,1 31997,0 32085,1 32180,0 32216,1 32288,0 32356,1 32359,0 32406,1 32481,0 32509,1 32551,0 32639,1 32729,0 32759,1 32838,0 32866,1 32874,0 32878,1 32943,0 33020,1 33090,0 33184,1 33239,0 33281,1 33306,0 33319,1 33387,0 33393,1 33430,0 33514,1 33591,0 33684,1 33724,0 33806,1 33860,0 33893,1 33903,0 33925,1 33980,0 34004,1 34055,0 34114,1 34121,0 34150,1 34197,0 34242,1 34333,0 34428,1 34437,0 34519,1 34549,0 34629,1 34696,0 34711,1 34715,0 34815,1 34832,0 34867,1 34873,0 34897,1 34939,0 34967,1 34976,0 35046,1 35124,0 35161,1 35165,0 35175,1 35197,0 35234,1 35328,0 35416,1 35459,0 35544,1 35624,0 35625,1 35688,0 35707,1 35786,0 35870,1 35891,0 35953,1 36002,0 36083,1 36178,0 36185,1 36216,0 36253,1 36349,0 36425,1 36460,0 36484,1 36539,0 36612,1 36710,0 36772,1 36774,0 36871,1 36947,0 37022,1 37030,0 37034,1 37124,0 37151,1 37209,0 37242,1 37253,0 37306,1 37330,0 37416,1 37471,0 37484,1 37555,0 37616,1 37626,0 37649,1 37656,0 37678,1 37686,0 37759,1 37781,0 37838,1 37868,0 37872,1 37885,0 37905,1 37934,0 38007,1 38080,0 38086,1 38108,0 38196,1 38282,0 38336,1 38391,0 38460,1 38535,0 38563,1 38650,0 38652,1 38678,0 38681,1 38713,0 38727,1 38738,0 38740,1 38758,0 38767,1 38832,0 38869,1 38930,0 38969,1 39050,0 39071,1 39099,0 39175,1 39193,0 39232,1 39267,0 39282,1 39304,0 39379,1 39448,0 39491,1 39512,0 39527,1 39603,0 39690,1 39755,0 39850,1 39934,0 39950,1 40047,0 40132,1 40162,0 40231,1 40269,0 40362,1 40411,0 40480,1 40567,0 40651,1 40652,0 40716,1 40779,0 40821,1 40883,0 40974,1 40995,0 41089,1 41092,0 41184,1 41243,0 41318,1 41338,0 41370,1 41418,0 41448,1 41461,0 41549,1 41642,0 41729,1 41758,0 41856,1 41950,0 41976,1 42005,0 42054,1 42106,0 42154,1 42215,0 42252,1 42267,0 42343,1 42404,0 42490,1 42540,0 42628,1 42644,0 42734,1 42815,0 42890,1 42916,0 42923,1 42970,0 43069,1 43119,0 43161,1 43211,0 43309,1 43339,0 43391,1 43439,0 43525,1 43554,0 43563,1 43566,0 43628,1 43629,0 43727,1 43738,0 43828,1 43862,0 43942,1 44007,0 44084,1 44161,0 44186,1 44236,0 44316,1 44389,0 44403,1 44477,0 44572,1 44661,0 44696,1 44793,0 44820,1 44871,0 44905,1 44941,0 45035,1 45134,0 45182,1 45238,0 45283,1 45375,0 45462,1 45466,0 45471,1 45559,0 45580,1 45606,0 45611,1 45693,0 45729,1 45820,0 45902,1 45983,0 46040,1 46090,0 46104,1 46198,0 46242,1 46316,0 46404,1 46406,0 46445,1 46471,0 46542,1 46607,0 46660,1 46722,0 46728,1 46764,0 46858,1 46878,0 46973,1 46996,0 47005,1 47051,0 47079,1 47150,0 47174,1 47221,0 47301,1 47377,0 47384,1 47411,0 47436,1 47475,0 47543,1 47551,0 47634,1 47713,0 47813,1 47897,0 47974,1 48030,0 48074,1 48108,0 48136,1 48208,0 48224,1 48279,0 48326,1 48334,0 48433,1 48475,0 48569,1 48584,0 48635,1 48719,0 48738,1 48812,0 48860,1 48958,0 49048,1 49098,0 49161,1 49216,0 49218,1 49312,0 49320,1 49387,0 49434,1 49490,0 49558,1 49602,0 49643,1 49687,0 49735,1 49790,0 49792,1 49859,0 49898,1 49981,0 50065,1 50137,0 50188,1 50263,0 50303,1 50311,0 50397,1 50422,0 50505,1 50563,0 50622,1 50717,0 50780,1 50799,0 50897,1 50943,0 50972,1 51032,0 51043,1 51049,0 51067,1 51135,0 51222,1 51300,0 51353,1 51449,0 51450,1 51464,0 51503,1 51587,0 51626,1 end initlist a14 0,0 29,1 76,0 164,1 249,0 303,1 328,0 378,1 458,0 498,1 517,0 575,1 614,0 628,1 728,0 799,1 892,0 911,1 917,0 934,1 969,0 982,1 1068,0 1144,1 1210,0 1238,1 1256,0 1328,1 1346,0 1408,1 1439,0 1460,1 1532,0 1538,1 1592,0 1652,1 1747,0 1803,1 1862,0 1877,1 1911,0 1993,1 2033,0 2037,1 2058,0 2110,1 2189,0 2267,1 2303,0 2386,1 2406,0 2467,1 2518,0 2521,1 2578,0 2632,1 2693,0 2720,1 2799,0 2878,1 2933,0 2955,1 2994,0 3093,1 3143,0 3222,1 3236,0 3288,1 3317,0 3365,1 3395,0 3434,1 3447,0 3518,1 3585,0 3674,1 3707,0 3728,1 3825,0 3907,1 3963,0 4059,1 4112,0 4166,1 4228,0 4270,1 4315,0 4337,1 4410,0 4460,1 4482,0 4529,1 4553,0 4561,1 4631,0 4664,1 4753,0 4783,1 4828,0 4864,1 4890,0 4941,1 4974,0 4977,1 5007,0 5090,1 5163,0 5181,1 5263,0 5314,1 5327,0 5424,1 5522,0 5622,1 5654,0 5677,1 5743,0 5773,1 5831,0 5881,1 5902,0 5912,1 5968,0 5989,1 6061,0 6114,1 6202,0 6233,1 6278,0 6299,1 6367,0 6380,1 6418,0 6515,1 6556,0 6586,1 6596,0 6606,1 6700,0 6703,1 6756,0 6771,1 6791,0 6873,1 6893,0 6974,1 7052,0 7118,1 7169,0 7254,1 7304,0 7306,1 7331,0 7368,1 7455,0 7469,1 7564,0 7579,1 7652,0 7657,1 7727,0 7743,1 7772,0 7829,1 7918,0 7928,1 7964,0 8000,1 8013,0 8032,1 8122,0 8164,1 8203,0 8272,1 8292,0 8330,1 8368,0 8370,1 8376,0 8384,1 8420,0 8505,1 8571,0 8638,1 8705,0 8798,1 8860,0 8941,1 8958,0 9054,1 9061,0 9075,1 9138,0 9226,1 9308,0 9356,1 9387,0 9454,1 9543,0 9643,1 9685,0 9771,1 9856,0 9901,1 9993,0 10007,1 10033,0 10106,1 10187,0 10244,1 10255,0 10315,1 10354,0 10368,1 10416,0 10434,1 10498,0 10569,1 10590,0 10642,1 10646,0 10669,1 10696,0 10709,1 10749,0 10832,1 10932,0 10951,1 10970,0 11062,1 11064,0 11138,1 11233,0 11264,1 11299,0 11338,1 11347,0 11412,1 11483,0 11572,1 11573,0 11580,1 11598,0 11623,1 11720,0 11781,1 11821,0 11871,1 11885,0 11923,1 11927,0 12009,1 12060,0 12118,1 12201,0 12243,1 12342,0 12423,1 12488,0 12575,1 12673,0 12699,1 12788,0 12808,1 12826,0 12844,1 12939,0 12964,1 12987,0 13041,1 13088,0 13125,1 13216,0 13243,1 13254,0 13268,1 13271,0 13301,1 13352,0 13414,1 13476,0 13531,1 13607,0 13671,1 13756,0 13820,1 13896,0 13909,1 13912,0 13921,1 13985,0 13996,1 14003,0 14035,1 14063,0 14155,1 14247,0 14313,1 14320,0 14332,1 14382,0 14416,1 14451,0 14550,1 14607,0 14646,1 14673,0 14678,1 14688,0 14784,1 14796,0 14812,1 14842,0 14881,1 14883,0 14941,1 15003,0 15102,1 15202,0 15242,1 15294,0 15338,1 15412,0 15434,1 15514,0 15589,1 15636,0 15669,1 15692,0 15715,1 15795,0 15893,1 15921,0 15936,1 16019,0 16052,1 16055,0 16119,1 16151,0 16164,1 16205,0 16282,1 16382,0 16409,1 16481,0 16492,1 16531,0 16615,1 16685,0 16753,1 16812,0 16882,1 16971,0 17046,1 17105,0 17193,1 17285,0 17322,1 17411,0 17440,1 17516,0 17565,1 17573,0 17613,1 17624,0 17724,1 17795,0 17837,1 17898,0 17942,1 17997,0 18003,1 18069,0 18118,1 18175,0 18217,1 18313,0 18389,1 18477,0 18504,1 18523,0 18623,1 18719,0 18771,1 18854,0 18912,1 18955,0 19001,1 19074,0 19081,1 19179,0 19245,1 19338,0 19400,1 19462,0 19523,1 19585,0 19648,1 19661,0 19680,1 19723,0 19819,1 19833,0 19858,1 19947,0 20024,1 20084,0 20131,1 20134,0 20233,1 20281,0 20293,1 20347,0 20438,1 20523,0 20533,1 20575,0 20597,1 20602,0 20672,1 20755,0 20759,1 20851,0 20905,1 20971,0 21062,1 21086,0 21133,1 21230,0 21248,1 21307,0 21308,1 21344,0 21376,1 21463,0 21514,1 21517,0 21614,1 21618,0 21678,1 21778,0 21781,1 21821,0 21907,1 21950,0 22008,1 22054,0 22112,1 22125,0 22197,1 22242,0 22255,1 22313,0 22396,1 22458,0 22513,1 22516,0 22615,1 22625,0 22710,1 22742,0 22769,1 22799,0 22804,1 22815,0 22824,1 22916,0 23003,1 23057,0 23155,1 23185,0 23242,1 23267,0 23334,1 23369,0 23441,1 23530,0 23601,1 23622,0 23627,1 23640,0 23681,1 23752,0 23822,1 23922,0 23986,1 24029,0 24095,1 24124,0 24133,1 24148,0 24237,1 24310,0 24322,1 24370,0 24447,1 24534,0 24582,1 24680,0 24756,1 24821,0 24889,1 24949,0 25032,1 25080,0 25132,1 25171,0 25202,1 25220,0 25315,1 25381,0 25400,1 25437,0 25482,1 25550,0 25578,1 25636,0 25682,1 25711,0 25724,1 25818,0 25913,1 25970,0 26037,1 26048,0 26142,1 26149,0 26168,1 26169,0 26248,1 26292,0 26323,1 26403,0 26440,1 26527,0 26615,1 26703,0 26720,1 26814,0 26910,1 27004,0 27007,1 27021,0 27093,1 27094,0 27174,1 27246,0 27284,1 27325,0 27377,1 27424,0 27430,1 27444,0 27529,1 27572,0 27646,1 27721,0 27758,1 27790,0 27817,1 27852,0 27914,1 27918,0 27934,1 28000,0 28083,1 28146,0 28206,1 28306,0 28374,1 28414,0 28422,1 28431,0 28436,1 28482,0 28523,1 28590,0 28615,1 28646,0 28706,1 28727,0 28775,1 28848,0 28948,1 28961,0 28983,1 29015,0 29023,1 29090,0 29120,1 29203,0 29213,1 29262,0 29287,1 29332,0 29354,1 29385,0 29421,1 29471,0 29546,1 29626,0 29627,1 29701,0 29735,1 29832,0 29877,1 29912,0 29914,1 30011,0 30097,1 30182,0 30224,1 30301,0 30302,1 30327,0 30338,1 30345,0 30384,1 30403,0 30499,1 30566,0 30627,1 30675,0 30697,1 30772,0 30858,1 30897,0 30904,1 31002,0 31040,1 31102,0 31150,1 31189,0 31259,1 31345,0 31426,1 31450,0 31467,1 31471,0 31539,1 31633,0 31679,1 31690,0 31764,1 31785,0 31793,1 31873,0 31917,1 31999,0 32097,1 32118,0 32133,1 32157,0 32190,1 32267,0 32337,1 32345,0 32434,1 32498,0 32525,1 32528,0 32545,1 32618,0 32718,1 32816,0 32864,1 32957,0 33046,1 33048,0 33093,1 33139,0 33160,1 33228,0 33288,1 33290,0 33354,1 33421,0 33483,1 33552,0 33631,1 33648,0 33680,1 33758,0 33765,1 33770,0 33847,1 33851,0 33888,1 33954,0 33973,1 34032,0 34055,1 34103,0 34203,1 34222,0 34241,1 34293,0 34321,1 34355,0 34385,1 34469,0 34555,1 34625,0 34724,1 34810,0 34860,1 34865,0 34964,1 35053,0 35147,1 35158,0 35221,1 35319,0 35377,1 35434,0 35464,1 35507,0 35606,1 35627,0 35709,1 35753,0 35795,1 35869,0 35881,1 35946,0 35995,1 36054,0 36106,1 36157,0 36158,1 36240,0 36314,1 36390,0 36486,1 36583,0 36646,1 36706,0 36754,1 36848,0 36873,1 36880,0 36928,1 36936,0 36999,1 37080,0 37173,1 37249,0 37251,1 37285,0 37318,1 37345,0 37401,1 37437,0 37451,1 37517,0 37542,1 37595,0 37631,1 37669,0 37747,1 37797,0 37875,1 37883,0 37954,1 37984,0 37997,1 38088,0 38116,1 38118,0 38158,1 38166,0 38177,1 38250,0 38280,1 38366,0 38391,1 38438,0 38476,1 38502,0 38583,1 38619,0 38641,1 38671,0 38763,1 38819,0 38837,1 38930,0 38985,1 39001,0 39035,1 39037,0 39056,1 39140,0 39235,1 39292,0 39388,1 39451,0 39465,1 39506,0 39582,1 39609,0 39662,1 39673,0 39708,1 39798,0 39898,1 39903,0 39997,1 40093,0 40163,1 40177,0 40213,1 40227,0 40228,1 40265,0 40278,1 40298,0 40369,1 40426,0 40473,1 40546,0 40606,1 40625,0 40648,1 40651,0 40704,1 40787,0 40793,1 40839,0 40920,1 40984,0 41000,1 41029,0 41080,1 41107,0 41155,1 41170,0 41196,1 41291,0 41327,1 41376,0 41470,1 41475,0 41536,1 41630,0 41648,1 41732,0 41743,1 41773,0 41834,1 41879,0 41975,1 42050,0 42070,1 42121,0 42220,1 42253,0 42301,1 42302,0 42368,1 42395,0 42437,1 42517,0 42568,1 42654,0 42722,1 42819,0 42888,1 42894,0 42980,1 43062,0 43088,1 43164,0 43174,1 43261,0 43329,1 43388,0 43439,1 43492,0 43541,1 43561,0 43612,1 43621,0 43719,1 43807,0 43819,1 43852,0 43868,1 43872,0 43909,1 43995,0 44084,1 44102,0 44126,1 44216,0 44293,1 44348,0 44397,1 44405,0 44452,1 44507,0 44544,1 44572,0 44612,1 44645,0 44684,1 44710,0 44743,1 44793,0 44860,1 44901,0 44934,1 44941,0 44953,1 45009,0 45108,1 45197,0 45234,1 45235,0 45279,1 45375,0 45460,1 45552,0 45587,1 45605,0 45682,1 45716,0 45797,1 45890,0 45928,1 45969,0 46033,1 46089,0 46108,1 46173,0 46178,1 46213,0 46272,1 46330,0 46350,1 46365,0 46435,1 46444,0 46544,1 46636,0 46661,1 46734,0 46832,1 46855,0 46911,1 46939,0 47022,1 47078,0 47133,1 47159,0 47190,1 47195,0 47212,1 47267,0 47363,1 47421,0 47478,1 47576,0 47579,1 47646,0 47689,1 47729,0 47786,1 47811,0 47818,1 47875,0 47928,1 47988,0 48083,1 48160,0 48245,1 48327,0 48338,1 48398,0 48449,1 48523,0 48587,1 48598,0 48613,1 48648,0 48729,1 48766,0 48816,1 48873,0 48901,1 48935,0 48968,1 49018,0 49067,1 49112,0 49159,1 49258,0 49357,1 49414,0 49476,1 49568,0 49655,1 end initlist a15 0,0 53,1 124,0 175,1 267,0 279,1 283,0 335,1 371,0 373,1 402,0 502,1 509,0 568,1 614,0 704,1 782,0 836,1 848,0 892,1 985,0 1024,1 1099,0 1122,1 1124,0 1152,1 1211,0 1219,1 1276,0 1307,1 1343,0 1416,1 1460,0 1476,1 1504,0 1516,1 1575,0 1624,1 1628,0 1656,1 1686,0 1729,1 1804,0 1881,1 1895,0 1937,1 2017,0 2024,1 2060,0 2106,1 2145,0 2199,1 2287,0 2329,1 2387,0 2421,1 2459,0 2476,1 2558,0 2572,1 2657,0 2691,1 2727,0 2735,1 2781,0 2872,1 2946,0 3028,1 3086,0 3100,1 3142,0 3157,1 3252,0 3258,1 3276,0 3286,1 3365,0 3400,1 3471,0 3568,1 3623,0 3658,1 3692,0 3771,1 3857,0 3904,1 4001,0 4080,1 4169,0 4186,1 4207,0 4213,1 4269,0 4327,1 4370,0 4456,1 4481,0 4488,1 4576,0 4638,1 4718,0 4796,1 4825,0 4866,1 4890,0 4899,1 4979,0 5036,1 5084,0 5107,1 5127,0 5133,1 5198,0 5218,1 5238,0 5286,1 5329,0 5421,1 5437,0 5486,1 5515,0 5613,1 5660,0 5758,1 5843,0 5910,1 5928,0 5964,1 6003,0 6029,1 6119,0 6138,1 6140,0 6151,1 6247,0 6299,1 6398,0 6425,1 6469,0 6481,1 6546,0 6550,1 6592,0 6689,1 6765,0 6824,1 6915,0 6926,1 7016,0 7078,1 7094,0 7169,1 7170,0 7178,1 7265,0 7323,1 7362,0 7430,1 7491,0 7501,1 7587,0 7665,1 7761,0 7850,1 7935,0 8002,1 8031,0 8047,1 8062,0 8123,1 8144,0 8149,1 8163,0 8209,1 8283,0 8330,1 8354,0 8421,1 8456,0 8528,1 8626,0 8691,1 8728,0 8733,1 8828,0 8927,1 8958,0 9042,1 9125,0 9195,1 9218,0 9229,1 9260,0 9285,1 9346,0 9377,1 9440,0 9510,1 9540,0 9620,1 9691,0 9729,1 9796,0 9855,1 9887,0 9939,1 10005,0 10028,1 10076,0 10142,1 10207,0 10283,1 10341,0 10372,1 10448,0 10509,1 10531,0 10558,1 10577,0 10642,1 10648,0 10708,1 10740,0 10757,1 10854,0 10868,1 10936,0 11017,1 11097,0 11131,1 11177,0 11219,1 11312,0 11336,1 11338,0 11410,1 11418,0 11491,1 11591,0 11653,1 11706,0 11756,1 11769,0 11810,1 11842,0 11916,1 12008,0 12033,1 12075,0 12153,1 12213,0 12294,1 12368,0 12438,1 12518,0 12568,1 12635,0 12699,1 12795,0 12848,1 12863,0 12941,1 12952,0 13020,1 13047,0 13120,1 13206,0 13252,1 13304,0 13335,1 13433,0 13470,1 13481,0 13487,1 13534,0 13583,1 13599,0 13667,1 13723,0 13735,1 13821,0 13883,1 13904,0 13991,1 14058,0 14123,1 14129,0 14159,1 14205,0 14244,1 14279,0 14324,1 14373,0 14453,1 14528,0 14554,1 14607,0 14688,1 14775,0 14815,1 14877,0 14964,1 15026,0 15054,1 15102,0 15151,1 15197,0 15268,1 15345,0 15436,1 15440,0 15511,1 15537,0 15569,1 15617,0 15661,1 15701,0 15710,1 15766,0 15854,1 15887,0 15940,1 16026,0 16121,1 16151,0 16170,1 16206,0 16278,1 16354,0 16433,1 16450,0 16534,1 16582,0 16600,1 16692,0 16761,1 16827,0 16840,1 16926,0 16994,1 16995,0 17081,1 17111,0 17178,1 17229,0 17303,1 17362,0 17386,1 17459,0 17520,1 17549,0 17610,1 17667,0 17727,1 17737,0 17774,1 17848,0 17918,1 17974,0 18016,1 18058,0 18092,1 18140,0 18141,1 18200,0 18249,1 18295,0 18311,1 18366,0 18422,1 18426,0 18439,1 18457,0 18543,1 18618,0 18717,1 18801,0 18821,1 18891,0 18959,1 19001,0 19058,1 19059,0 19095,1 19119,0 19201,1 19248,0 19348,1 19411,0 19482,1 19575,0 19576,1 19603,0 19692,1 19694,0 19695,1 19766,0 19851,1 19927,0 20005,1 20041,0 20057,1 20116,0 20208,1 20239,0 20294,1 20358,0 20452,1 20552,0 20582,1 20675,0 20694,1 20768,0 20771,1 20817,0 20904,1 20929,0 20951,1 21050,0 21073,1 21156,0 21207,1 21208,0 21209,1 21255,0 21354,1 21382,0 21456,1 21526,0 21621,1 21622,0 21692,1 21787,0 21878,1 21948,0 21973,1 21999,0 22097,1 22136,0 22173,1 22271,0 22276,1 22339,0 22343,1 22380,0 22447,1 22464,0 22523,1 22577,0 22578,1 22660,0 22665,1 22725,0 22758,1 22812,0 22906,1 22946,0 22972,1 23011,0 23076,1 23078,0 23085,1 23143,0 23183,1 23231,0 23295,1 23361,0 23433,1 23525,0 23606,1 23638,0 23721,1 23783,0 23842,1 23883,0 23975,1 24074,0 24158,1 24196,0 24237,1 24325,0 24423,1 24452,0 24516,1 24542,0 24629,1 24670,0 24720,1 24809,0 24824,1 24867,0 24906,1 24922,0 24969,1 25065,0 25070,1 25073,0 25119,1 25214,0 25269,1 25278,0 25305,1 25349,0 25442,1 25522,0 25549,1 25597,0 25599,1 25626,0 25672,1 25724,0 25812,1 25890,0 25899,1 25974,0 26018,1 26113,0 26187,1 26265,0 26302,1 26393,0 26425,1 26462,0 26495,1 26570,0 26660,1 26705,0 26771,1 26813,0 26893,1 26947,0 27006,1 27064,0 27078,1 27135,0 27199,1 27259,0 27295,1 27363,0 27455,1 27518,0 27539,1 27617,0 27651,1 27658,0 27757,1 27850,0 27872,1 27939,0 27962,1 28058,0 28155,1 28226,0 28312,1 28404,0 28503,1 28561,0 28618,1 28635,0 28669,1 28674,0 28723,1 28805,0 28865,1 28958,0 29013,1 29068,0 29146,1 29232,0 29331,1 29416,0 29499,1 29524,0 29571,1 29594,0 29643,1 29690,0 29775,1 29778,0 29844,1 29873,0 29883,1 29931,0 30025,1 30088,0 30102,1 30200,0 30227,1 30257,0 30280,1 30281,0 30316,1 30318,0 30366,1 30430,0 30457,1 30489,0 30568,1 30646,0 30691,1 30780,0 30869,1 30963,0 31044,1 31142,0 31202,1 31213,0 31308,1 31398,0 31406,1 31442,0 31536,1 31543,0 31614,1 31694,0 31749,1 31763,0 31808,1 31814,0 31883,1 31891,0 31963,1 32038,0 32058,1 32070,0 32131,1 32132,0 32179,1 32200,0 32289,1 32372,0 32437,1 32487,0 32511,1 32551,0 32577,1 32625,0 32720,1 32777,0 32797,1 32879,0 32913,1 32991,0 33073,1 33168,0 33172,1 33207,0 33279,1 33344,0 33370,1 33393,0 33426,1 33512,0 33570,1 33588,0 33647,1 33667,0 33675,1 33775,0 33804,1 33812,0 33843,1 33885,0 33967,1 33980,0 34013,1 34047,0 34084,1 34098,0 34116,1 34180,0 34228,1 34252,0 34298,1 34353,0 34426,1 34464,0 34487,1 34504,0 34519,1 34570,0 34610,1 34622,0 34708,1 34775,0 34798,1 34843,0 34890,1 34930,0 35018,1 35035,0 35069,1 35158,0 35187,1 35228,0 35293,1 35338,0 35381,1 35475,0 35565,1 35605,0 35640,1 35705,0 35720,1 35799,0 35861,1 35874,0 35910,1 35915,0 36003,1 36085,0 36183,1 36260,0 36328,1 36369,0 36391,1 36435,0 36446,1 36469,0 36544,1 36617,0 36711,1 36738,0 36811,1 36879,0 36918,1 36940,0 37008,1 37096,0 37126,1 37189,0 37276,1 37351,0 37385,1 37466,0 37565,1 37610,0 37660,1 37686,0 37715,1 37720,0 37810,1 37904,0 37953,1 37976,0 38030,1 38062,0 38106,1 38197,0 38240,1 38273,0 38303,1 38357,0 38385,1 38435,0 38477,1 38568,0 38632,1 38654,0 38686,1 38758,0 38764,1 38823,0 38882,1 38896,0 38996,1 39031,0 39121,1 39156,0 39225,1 39235,0 39238,1 39329,0 39345,1 39357,0 39397,1 39410,0 39423,1 39491,0 39496,1 39506,0 39597,1 39696,0 39749,1 39782,0 39866,1 39959,0 39981,1 40072,0 40162,1 40219,0 40270,1 40282,0 40349,1 40444,0 40504,1 40514,0 40574,1 40648,0 40709,1 40733,0 40827,1 40885,0 40904,1 40917,0 40980,1 41013,0 41039,1 41056,0 41096,1 41192,0 41254,1 41329,0 41336,1 41399,0 41429,1 41473,0 41508,1 41569,0 41580,1 41584,0 41671,1 41674,0 41766,1 41835,0 41901,1 41934,0 41936,1 41957,0 41967,1 42017,0 42093,1 42192,0 42273,1 42351,0 42357,1 42417,0 42455,1 42523,0 42556,1 42574,0 42634,1 42720,0 42820,1 42866,0 42920,1 42957,0 42994,1 42999,0 43081,1 43157,0 43184,1 43186,0 43208,1 43228,0 43302,1 43399,0 43465,1 43470,0 43539,1 43579,0 43645,1 43655,0 43751,1 43833,0 43849,1 43917,0 43939,1 43982,0 43983,1 44069,0 44132,1 44146,0 44230,1 44319,0 44381,1 44450,0 44546,1 44636,0 44650,1 44666,0 44679,1 44742,0 44780,1 44871,0 44915,1 44991,0 45089,1 45138,0 45238,1 45311,0 45388,1 45434,0 45530,1 45569,0 45602,1 45653,0 45746,1 45818,0 45884,1 45962,0 45963,1 46035,0 46080,1 46162,0 46168,1 46217,0 46258,1 46306,0 46387,1 46404,0 46412,1 46491,0 46512,1 46565,0 46638,1 46669,0 46748,1 46759,0 46803,1 46876,0 46894,1 46951,0 46968,1 47010,0 47088,1 47107,0 47193,1 47226,0 47310,1 47399,0 47492,1 47493,0 47539,1 47603,0 47703,1 47778,0 47877,1 47895,0 47985,1 47998,0 48089,1 48130,0 48157,1 48172,0 48204,1 48252,0 48297,1 48321,0 48419,1 48421,0 48429,1 48491,0 48542,1 48637,0 48677,1 48701,0 48744,1 48785,0 48822,1 48824,0 48866,1 48924,0 48997,1 49082,0 49155,1 49162,0 49221,1 49307,0 49363,1 49379,0 49472,1 49517,0 49598,1 49601,0 49674,1 49688,0 49783,1 49882,0 49945,1 49955,0 50047,1 50118,0 50137,1 50141,0 50183,1 50258,0 50283,1 50307,0 50343,1 50367,0 50393,1 50436,0 50518,1 50612,0 50667,1 50760,0 50814,1 50893,0 50984,1 51026,0 51060,1 end initlist a16 0,0 5,1 51,0 55,1 140,0 216,1 307,0 377,1 451,0 504,1 567,0 612,1 637,0 725,1 812,0 890,1 897,0 997,1 1088,0 1177,1 1242,0 1243,1 1327,0 1350,1 1359,0 1363,1 1443,0 1470,1 1563,0 1597,1 1681,0 1748,1 1789,0 1793,1 1799,0 1820,1 1838,0 1910,1 1989,0 2041,1 2052,0 2060,1 2074,0 2159,1 2247,0 2272,1 2303,0 2349,1 2413,0 2436,1 2527,0 2562,1 2638,0 2639,1 2685,0 2709,1 2728,0 2777,1 2874,0 2893,1 2959,0 2981,1 3015,0 3086,1 3104,0 3113,1 3162,0 3242,1 3270,0 3347,1 3380,0 3445,1 3538,0 3579,1 3632,0 3673,1 3707,0 3803,1 3844,0 3846,1 3933,0 3952,1 3998,0 4036,1 4038,0 4133,1 4156,0 4251,1 4293,0 4387,1 4412,0 4425,1 4474,0 4497,1 4589,0 4602,1 4678,0 4748,1 4837,0 4909,1 4975,0 5043,1 5091,0 5136,1 5209,0 5249,1 5339,0 5397,1 5415,0 5468,1 5489,0 5501,1 5529,0 5550,1 5618,0 5713,1 5758,0 5815,1 5869,0 5917,1 5983,0 6077,1 6095,0 6190,1 6281,0 6339,1 6354,0 6441,1 6461,0 6523,1 6544,0 6580,1 6669,0 6735,1 6774,0 6810,1 6824,0 6835,1 6879,0 6927,1 6936,0 7004,1 7070,0 7078,1 7145,0 7239,1 7262,0 7290,1 7328,0 7396,1 7408,0 7496,1 7596,0 7668,1 7746,0 7752,1 7825,0 7841,1 7918,0 7998,1 8030,0 8047,1 8056,0 8131,1 8217,0 8290,1 8333,0 8348,1 8430,0 8521,1 8572,0 8627,1 8643,0 8716,1 8727,0 8805,1 8832,0 8913,1 8986,0 9041,1 9071,0 9115,1 9119,0 9203,1 9220,0 9260,1 9337,0 9342,1 9358,0 9410,1 9492,0 9552,1 9591,0 9638,1 9642,0 9702,1 9749,0 9787,1 9811,0 9901,1 9950,0 9981,1 10078,0 10155,1 10235,0 10318,1 10347,0 10352,1 10374,0 10448,1 10514,0 10612,1 10666,0 10676,1 10679,0 10742,1 10775,0 10777,1 10790,0 10816,1 10886,0 10897,1 10936,0 10967,1 11008,0 11036,1 11050,0 11145,1 11178,0 11190,1 11248,0 11290,1 11357,0 11448,1 11479,0 11493,1 11573,0 11642,1 11734,0 11738,1 11801,0 11870,1 11881,0 11954,1 11975,0 12063,1 12157,0 12220,1 12294,0 12297,1 12381,0 12449,1 12500,0 12514,1 12555,0 12571,1 12593,0 12676,1 12768,0 12863,1 12872,0 12901,1 12936,0 12988,1 13025,0 13124,1 13220,0 13294,1 13305,0 13339,1 13414,0 13429,1 13430,0 13470,1 13555,0 13561,1 13656,0 13702,1 13747,0 13843,1 13919,0 13982,1 14082,0 14173,1 14240,0 14313,1 14411,0 14422,1 14444,0 14459,1 14544,0 14549,1 14625,0 14703,1 14730,0 14793,1 14838,0 14864,1 14905,0 14910,1 14985,0 15007,1 15046,0 15128,1 15157,0 15252,1 15290,0 15318,1 15411,0 15456,1 15541,0 15612,1 15675,0 15728,1 15732,0 15772,1 15857,0 15930,1 16011,0 16075,1 16172,0 16220,1 16315,0 16348,1 16399,0 16401,1 16480,0 16513,1 16524,0 16548,1 16608,0 16700,1 16729,0 16764,1 16812,0 16905,1 16922,0 16978,1 17004,0 17010,1 17079,0 17138,1 17158,0 17192,1 17266,0 17327,1 17360,0 17434,1 17523,0 17594,1 17617,0 17649,1 17680,0 17688,1 17695,0 17733,1 17793,0 17876,1 17943,0 17958,1 18050,0 18132,1 18230,0 18298,1 18367,0 18453,1 18512,0 18523,1 18538,0 18558,1 18595,0 18641,1 18660,0 18747,1 18790,0 18851,1 18912,0 19005,1 19096,0 19127,1 19204,0 19281,1 19301,0 19353,1 19395,0 19417,1 19442,0 19462,1 19541,0 19603,1 19676,0 19708,1 19803,0 19842,1 19931,0 20030,1 20088,0 20139,1 20194,0 20253,1 20326,0 20367,1 20427,0 20463,1 20534,0 20570,1 20666,0 20737,1 20768,0 20839,1 20907,0 20994,1 21049,0 21088,1 21186,0 21283,1 21322,0 21377,1 21449,0 21515,1 21594,0 21630,1 21667,0 21753,1 21807,0 21827,1 21899,0 21979,1 22066,0 22139,1 22190,0 22287,1 22331,0 22428,1 22454,0 22513,1 22613,0 22619,1 22632,0 22724,1 22790,0 22853,1 22904,0 22961,1 23027,0 23042,1 23121,0 23168,1 23241,0 23297,1 23304,0 23404,1 23430,0 23526,1 23543,0 23593,1 23608,0 23639,1 23663,0 23667,1 23760,0 23808,1 23846,0 23905,1 24005,0 24079,1 24085,0 24127,1 24151,0 24185,1 24201,0 24248,1 24331,0 24335,1 24336,0 24428,1 24438,0 24495,1 24501,0 24539,1 24574,0 24629,1 24729,0 24822,1 24903,0 24945,1 24975,0 24977,1 25054,0 25125,1 25197,0 25243,1 25336,0 25410,1 25411,0 25486,1 25514,0 25548,1 25633,0 25719,1 25746,0 25795,1 25802,0 25896,1 25972,0 26036,1 26054,0 26066,1 26077,0 26142,1 26221,0 26259,1 26315,0 26377,1 26397,0 26469,1 26531,0 26566,1 26665,0 26705,1 26752,0 26757,1 26793,0 26805,1 26897,0 26974,1 27052,0 27106,1 27143,0 27154,1 27227,0 27247,1 27305,0 27385,1 27481,0 27561,1 27657,0 27751,1 27813,0 27851,1 27920,0 27987,1 28025,0 28112,1 28160,0 28175,1 28265,0 28354,1 28451,0 28480,1 28564,0 28600,1 28656,0 28712,1 28752,0 28767,1 28863,0 28962,1 29058,0 29117,1 29169,0 29246,1 29261,0 29302,1 29368,0 29445,1 29476,0 29534,1 29542,0 29559,1 29631,0 29693,1 29748,0 29815,1 29879,0 29951,1 30000,0 30034,1 30086,0 30173,1 30213,0 30255,1 30273,0 30349,1 30429,0 30490,1 30537,0 30540,1 30638,0 30712,1 30743,0 30774,1 30791,0 30834,1 30860,0 30943,1 30946,0 31033,1 31098,0 31111,1 31202,0 31215,1 31251,0 31266,1 31362,0 31370,1 31398,0 31465,1 31470,0 31498,1 31592,0 31627,1 31717,0 31817,1 31839,0 31876,1 31898,0 31934,1 32017,0 32040,1 32120,0 32167,1 32235,0 32250,1 32331,0 32358,1 32378,0 32442,1 32508,0 32550,1 32575,0 32626,1 32649,0 32683,1 32746,0 32817,1 32823,0 32843,1 32893,0 32896,1 32960,0 33055,1 33148,0 33200,1 33258,0 33286,1 33322,0 33372,1 33382,0 33393,1 33458,0 33492,1 33570,0 33666,1 33739,0 33774,1 33869,0 33933,1 34012,0 34073,1 34083,0 34084,1 34102,0 34199,1 34291,0 34307,1 34313,0 34359,1 34360,0 34432,1 34446,0 34454,1 34457,0 34541,1 34558,0 34657,1 34697,0 34706,1 34721,0 34816,1 34858,0 34938,1 34963,0 35019,1 35082,0 35175,1 35235,0 35298,1 35391,0 35465,1 35471,0 35547,1 35642,0 35643,1 35678,0 35733,1 35832,0 35859,1 35938,0 35983,1 36041,0 36049,1 36142,0 36216,1 36275,0 36331,1 36375,0 36446,1 36495,0 36585,1 36639,0 36730,1 36787,0 36795,1 36842,0 36910,1 37004,0 37071,1 37155,0 37194,1 37281,0 37355,1 37371,0 37386,1 37389,0 37458,1 37557,0 37643,1 37740,0 37743,1 37775,0 37867,1 37934,0 38030,1 38054,0 38148,1 38159,0 38254,1 38294,0 38335,1 38377,0 38438,1 38507,0 38523,1 38574,0 38638,1 38722,0 38765,1 38843,0 38851,1 38867,0 38962,1 38999,0 39057,1 39075,0 39140,1 39236,0 39277,1 39282,0 39314,1 39322,0 39352,1 39374,0 39383,1 39405,0 39453,1 39548,0 39573,1 39621,0 39642,1 39696,0 39708,1 39711,0 39785,1 39797,0 39811,1 39821,0 39828,1 39925,0 39955,1 40055,0 40120,1 40172,0 40193,1 40238,0 40243,1 40275,0 40359,1 40403,0 40441,1 40448,0 40517,1 40598,0 40605,1 40643,0 40730,1 40732,0 40799,1 40885,0 40912,1 41011,0 41067,1 41138,0 41168,1 41203,0 41244,1 41284,0 41322,1 41326,0 41419,1 41494,0 41567,1 41642,0 41742,1 41841,0 41872,1 41889,0 41952,1 42046,0 42134,1 42212,0 42259,1 42357,0 42368,1 42400,0 42456,1 42477,0 42575,1 42668,0 42726,1 42745,0 42765,1 42809,0 42904,1 42986,0 43075,1 43174,0 43239,1 43255,0 43341,1 43429,0 43476,1 43549,0 43631,1 43686,0 43708,1 43808,0 43889,1 43941,0 44007,1 44107,0 44159,1 44195,0 44265,1 44297,0 44320,1 44337,0 44352,1 44392,0 44393,1 44400,0 44462,1 44523,0 44545,1 44634,0 44656,1 44672,0 44675,1 44733,0 44794,1 44865,0 44925,1 44986,0 45030,1 45064,0 45096,1 45156,0 45237,1 45269,0 45355,1 45453,0 45473,1 45515,0 45520,1 45539,0 45612,1 45655,0 45661,1 45756,0 45832,1 45897,0 45985,1 46019,0 46081,1 46120,0 46123,1 46145,0 46180,1 46263,0 46341,1 46418,0 46518,1 46607,0 46633,1 46672,0 46735,1 46764,0 46792,1 46864,0 46916,1 46959,0 47037,1 47076,0 47098,1 47166,0 47211,1 47252,0 47345,1 47353,0 47437,1 47460,0 47465,1 47555,0 47578,1 47665,0 47672,1 47678,0 47700,1 47730,0 47747,1 47830,0 47867,1 47891,0 47933,1 47991,0 47992,1 48078,0 48121,1 48198,0 48274,1 48318,0 48379,1 48444,0 48520,1 48561,0 48612,1 48662,0 48700,1 48702,0 48760,1 48761,0 48816,1 48846,0 48861,1 48922,0 48954,1 49045,0 49054,1 49071,0 49150,1 49155,0 49170,1 49193,0 49249,1 49275,0 49280,1 49324,0 49350,1 49403,0 49421,1 49506,0 49550,1 49632,0 49644,1 49707,0 49796,1 49831,0 49923,1 49995,0 50044,1 50076,0 50140,1 50237,0 50292,1 50331,0 50342,1 50389,0 50459,1 50523,0 50584,1 50643,0 50688,1 50788,0 50852,1 50855,0 50903,1 50931,0 50942,1 50976,0 51059,1 51140,0 51195,1 end initlist a17 0,0 71,1 87,0 116,1 177,0 241,1 276,0 335,1 365,0 382,1 430,0 508,1 563,0 624,1 705,0 764,1 852,0 870,1 915,0 946,1 969,0 1062,1 1079,0 1163,1 1182,0 1192,1 1252,0 1254,1 1319,0 1410,1 1501,0 1508,1 1572,0 1580,1 1611,0 1644,1 1720,0 1736,1 1830,0 1863,1 1938,0 2021,1 2073,0 2130,1 2199,0 2293,1 2323,0 2347,1 2361,0 2433,1 2456,0 2494,1 2524,0 2571,1 2616,0 2652,1 2690,0 2770,1 2787,0 2857,1 2883,0 2971,1 3013,0 3050,1 3063,0 3105,1 3139,0 3152,1 3209,0 3240,1 3309,0 3409,1 3475,0 3477,1 3521,0 3567,1 3654,0 3714,1 3803,0 3810,1 3858,0 3914,1 4003,0 4006,1 4079,0 4096,1 4179,0 4231,1 4293,0 4356,1 4435,0 4501,1 4504,0 4559,1 4577,0 4605,1 4628,0 4664,1 4756,0 4761,1 4799,0 4859,1 4950,0 5039,1 5135,0 5209,1 5227,0 5271,1 5313,0 5377,1 5425,0 5503,1 5561,0 5611,1 5698,0 5753,1 5851,0 5875,1 5888,0 5969,1 6021,0 6087,1 6132,0 6146,1 6179,0 6276,1 6333,0 6352,1 6411,0 6506,1 6537,0 6556,1 6603,0 6648,1 6675,0 6731,1 6752,0 6764,1 6780,0 6846,1 6881,0 6907,1 6977,0 7015,1 7079,0 7118,1 7125,0 7149,1 7226,0 7312,1 7406,0 7479,1 7509,0 7602,1 7669,0 7720,1 7723,0 7756,1 7842,0 7933,1 8032,0 8042,1 8080,0 8137,1 8185,0 8195,1 8227,0 8268,1 8355,0 8365,1 8443,0 8460,1 8470,0 8564,1 8633,0 8727,1 8815,0 8855,1 8929,0 8938,1 9033,0 9063,1 9149,0 9212,1 9274,0 9334,1 9355,0 9415,1 9453,0 9549,1 9560,0 9626,1 9641,0 9717,1 9801,0 9857,1 9900,0 9926,1 9929,0 10027,1 10071,0 10075,1 10165,0 10255,1 10295,0 10347,1 10399,0 10415,1 10441,0 10474,1 10535,0 10632,1 10650,0 10678,1 10775,0 10839,1 10892,0 10908,1 10985,0 11037,1 11080,0 11147,1 11225,0 11258,1 11270,0 11315,1 11328,0 11420,1 11479,0 11493,1 11575,0 11628,1 11708,0 11780,1 11828,0 11875,1 11937,0 12014,1 12088,0 12116,1 12137,0 12176,1 12192,0 12261,1 12334,0 12410,1 12508,0 12605,1 12697,0 12728,1 12758,0 12810,1 12819,0 12880,1 12956,0 12978,1 13065,0 13107,1 13152,0 13250,1 13337,0 13364,1 13420,0 13447,1 13481,0 13498,1 13509,0 13534,1 13570,0 13655,1 13709,0 13797,1 13868,0 13961,1 13971,0 14015,1 14114,0 14204,1 14280,0 14299,1 14394,0 14487,1 14516,0 14559,1 14622,0 14668,1 14697,0 14792,1 14846,0 14863,1 14916,0 14969,1 14982,0 15044,1 15051,0 15138,1 15174,0 15270,1 15347,0 15370,1 15414,0 15435,1 15532,0 15631,1 15659,0 15742,1 15839,0 15864,1 15889,0 15942,1 15984,0 15993,1 16092,0 16163,1 16234,0 16240,1 16340,0 16364,1 16381,0 16473,1 16550,0 16616,1 16668,0 16755,1 16850,0 16905,1 16966,0 17031,1 17057,0 17083,1 17130,0 17145,1 17158,0 17207,1 17291,0 17293,1 17329,0 17398,1 17402,0 17472,1 17483,0 17551,1 17632,0 17670,1 17741,0 17829,1 17921,0 17940,1 17988,0 18020,1 18113,0 18203,1 18279,0 18358,1 18418,0 18461,1 18501,0 18511,1 18597,0 18598,1 18692,0 18732,1 18745,0 18792,1 18874,0 18951,1 19022,0 19034,1 19091,0 19160,1 19176,0 19244,1 19260,0 19331,1 19394,0 19487,1 19534,0 19597,1 19612,0 19671,1 19681,0 19695,1 19722,0 19743,1 19780,0 19845,1 19917,0 19987,1 20007,0 20012,1 20097,0 20156,1 20161,0 20183,1 20210,0 20262,1 20353,0 20441,1 20489,0 20523,1 20561,0 20599,1 20608,0 20657,1 20690,0 20740,1 20825,0 20923,1 21019,0 21077,1 21081,0 21137,1 21186,0 21196,1 21239,0 21336,1 21433,0 21532,1 21539,0 21606,1 21696,0 21732,1 21777,0 21840,1 21884,0 21966,1 22066,0 22123,1 22144,0 22145,1 22155,0 22165,1 22233,0 22330,1 22398,0 22485,1 22531,0 22548,1 22628,0 22710,1 22726,0 22815,1 22889,0 22940,1 22990,0 23006,1 23093,0 23193,1 23229,0 23280,1 23346,0 23400,1 23447,0 23481,1 23561,0 23572,1 23614,0 23635,1 23723,0 23731,1 23768,0 23806,1 23898,0 23956,1 24029,0 24096,1 24149,0 24191,1 24248,0 24340,1 24400,0 24441,1 24490,0 24550,1 24555,0 24563,1 24578,0 24641,1 24729,0 24804,1 24841,0 24870,1 24937,0 24939,1 25026,0 25047,1 25069,0 25071,1 25099,0 25132,1 25227,0 25304,1 25307,0 25338,1 25348,0 25389,1 25390,0 25436,1 25491,0 25586,1 25621,0 25661,1 25684,0 25736,1 25768,0 25814,1 25821,0 25849,1 25897,0 25960,1 26008,0 26100,1 26159,0 26169,1 26253,0 26337,1 26346,0 26392,1 26405,0 26448,1 26505,0 26597,1 26664,0 26762,1 26851,0 26870,1 26938,0 26962,1 27009,0 27103,1 27201,0 27227,1 27260,0 27273,1 27361,0 27445,1 27512,0 27607,1 27608,0 27628,1 27690,0 27767,1 27789,0 27796,1 27872,0 27960,1 28028,0 28117,1 28128,0 28177,1 28227,0 28302,1 28368,0 28450,1 28462,0 28546,1 28600,0 28698,1 28772,0 28834,1 28900,0 28965,1 28990,0 29067,1 29097,0 29156,1 29160,0 29211,1 29235,0 29333,1 29374,0 29444,1 29523,0 29571,1 29609,0 29701,1 29729,0 29732,1 29807,0 29859,1 29890,0 29903,1 29917,0 29990,1 29996,0 30008,1 30108,0 30171,1 30190,0 30247,1 30266,0 30342,1 30370,0 30407,1 30445,0 30509,1 30551,0 30571,1 30656,0 30722,1 30787,0 30850,1 30904,0 30973,1 31032,0 31093,1 31186,0 31254,1 31293,0 31380,1 31447,0 31500,1 31595,0 31636,1 31706,0 31771,1 31774,0 31839,1 31932,0 31939,1 31950,0 32009,1 32075,0 32136,1 32194,0 32292,1 32317,0 32388,1 32437,0 32442,1 32453,0 32498,1 32502,0 32557,1 32581,0 32623,1 32633,0 32694,1 32792,0 32795,1 32843,0 32939,1 32971,0 33000,1 33092,0 33109,1 33155,0 33183,1 33276,0 33323,1 33381,0 33458,1 33470,0 33495,1 33593,0 33676,1 33699,0 33726,1 33749,0 33840,1 33939,0 33993,1 34055,0 34058,1 34137,0 34191,1 34283,0 34312,1 34352,0 34355,1 34454,0 34471,1 34475,0 34534,1 34595,0 34645,1 34708,0 34710,1 34780,0 34880,1 34966,0 35024,1 35027,0 35079,1 35141,0 35190,1 35275,0 35280,1 35378,0 35408,1 35499,0 35559,1 35592,0 35666,1 35687,0 35787,1 35860,0 35926,1 36026,0 36101,1 36181,0 36237,1 36276,0 36319,1 36398,0 36405,1 36463,0 36482,1 36504,0 36514,1 36521,0 36594,1 36600,0 36662,1 36664,0 36749,1 36825,0 36842,1 36846,0 36848,1 36930,0 37001,1 37004,0 37027,1 37098,0 37163,1 37164,0 37248,1 37281,0 37338,1 37387,0 37451,1 37500,0 37542,1 37550,0 37561,1 37598,0 37627,1 37634,0 37663,1 37743,0 37752,1 37792,0 37891,1 37952,0 38044,1 38089,0 38132,1 38149,0 38216,1 38290,0 38302,1 38398,0 38455,1 38511,0 38514,1 38550,0 38567,1 38614,0 38695,1 38746,0 38790,1 38798,0 38865,1 38964,0 38998,1 39022,0 39095,1 39127,0 39219,1 39276,0 39318,1 39332,0 39346,1 39399,0 39472,1 39555,0 39598,1 39664,0 39726,1 39801,0 39842,1 39893,0 39958,1 39983,0 40010,1 40013,0 40112,1 40139,0 40144,1 40206,0 40289,1 40324,0 40424,1 40451,0 40490,1 40586,0 40660,1 40666,0 40719,1 40771,0 40775,1 40856,0 40888,1 40919,0 40925,1 40989,0 41029,1 41030,0 41031,1 41040,0 41139,1 41146,0 41230,1 41268,0 41322,1 41367,0 41449,1 41535,0 41618,1 41653,0 41700,1 41704,0 41785,1 41823,0 41843,1 41853,0 41868,1 41946,0 42009,1 42087,0 42138,1 42231,0 42268,1 42316,0 42358,1 42430,0 42462,1 42511,0 42582,1 42675,0 42736,1 42799,0 42895,1 42979,0 43015,1 43067,0 43154,1 43249,0 43272,1 43289,0 43328,1 43339,0 43398,1 43410,0 43507,1 43599,0 43607,1 43693,0 43761,1 43815,0 43885,1 43951,0 44007,1 44098,0 44184,1 44242,0 44252,1 44278,0 44318,1 44347,0 44408,1 44463,0 44548,1 44586,0 44616,1 44713,0 44783,1 44787,0 44863,1 44896,0 44933,1 44971,0 45055,1 45121,0 45199,1 45200,0 45268,1 45355,0 45369,1 45410,0 45473,1 45550,0 45560,1 45582,0 45599,1 45665,0 45761,1 45769,0 45782,1 45854,0 45945,1 45986,0 45987,1 46043,0 46089,1 46104,0 46200,1 46272,0 46292,1 46331,0 46337,1 46373,0 46456,1 46492,0 46531,1 46571,0 46655,1 46738,0 46751,1 46807,0 46902,1 46955,0 47027,1 47091,0 47126,1 47171,0 47205,1 47243,0 47259,1 47270,0 47337,1 47369,0 47379,1 47443,0 47516,1 47535,0 47542,1 47567,0 47624,1 47662,0 47720,1 47811,0 47858,1 47943,0 47971,1 48015,0 48102,1 48187,0 48268,1 48329,0 48395,1 48410,0 48444,1 48526,0 48609,1 48691,0 48699,1 48728,0 48820,1 48868,0 48902,1 48942,0 49002,1 49060,0 49069,1 49121,0 49138,1 49212,0 49308,1 49321,0 49352,1 49364,0 49424,1 49522,0 49563,1 49658,0 49746,1 49836,0 49911,1 49939,0 50025,1 50074,0 50166,1 50261,0 50332,1 50396,0 50471,1 50552,0 50631,1 50634,0 50656,1 50707,0 50738,1 50779,0 50809,1 50833,0 50883,1 50981,0 50994,1 51035,0 51044,1 end initlist a18 0,0 29,1 88,0 121,1 142,0 162,1 194,0 223,1 232,0 259,1 358,0 408,1 481,0 541,1 598,0 633,1 733,0 797,1 878,0 883,1 928,0 936,1 945,0 967,1 978,0 1037,1 1117,0 1172,1 1257,0 1270,1 1321,0 1415,1 1424,0 1521,1 1609,0 1619,1 1681,0 1717,1 1795,0 1849,1 1911,0 1934,1 1979,0 2013,1 2033,0 2063,1 2153,0 2231,1 2309,0 2335,1 2353,0 2387,1 2406,0 2458,1 2476,0 2497,1 2559,0 2593,1 2634,0 2698,1 2728,0 2774,1 2782,0 2824,1 2881,0 2902,1 2950,0 2981,1 3062,0 3095,1 3189,0 3274,1 3349,0 3377,1 3379,0 3416,1 3439,0 3538,1 3541,0 3549,1 3644,0 3734,1 3752,0 3766,1 3841,0 3854,1 3925,0 4007,1 4090,0 4103,1 4169,0 4185,1 4203,0 4209,1 4211,0 4310,1 4345,0 4408,1 4459,0 4526,1 4623,0 4694,1 4779,0 4853,1 4930,0 5022,1 5055,0 5087,1 5094,0 5123,1 5215,0 5218,1 5277,0 5279,1 5280,0 5296,1 5301,0 5323,1 5370,0 5425,1 5471,0 5505,1 5583,0 5592,1 5679,0 5706,1 5779,0 5847,1 5852,0 5907,1 5972,0 6024,1 6065,0 6116,1 6129,0 6208,1 6292,0 6363,1 6389,0 6461,1 6555,0 6647,1 6649,0 6676,1 6716,0 6805,1 6875,0 6956,1 7012,0 7090,1 7117,0 7194,1 7221,0 7242,1 7284,0 7368,1 7414,0 7454,1 7487,0 7503,1 7560,0 7653,1 7673,0 7729,1 7769,0 7815,1 7858,0 7940,1 8030,0 8113,1 8205,0 8221,1 8307,0 8387,1 8465,0 8500,1 8537,0 8566,1 8610,0 8708,1 8780,0 8841,1 8900,0 8988,1 9054,0 9106,1 9203,0 9242,1 9319,0 9409,1 9443,0 9505,1 9598,0 9655,1 9752,0 9778,1 9821,0 9868,1 9903,0 9991,1 9996,0 10041,1 10093,0 10186,1 10281,0 10370,1 10435,0 10456,1 10547,0 10635,1 10638,0 10698,1 10716,0 10787,1 10866,0 10950,1 11047,0 11088,1 11101,0 11188,1 11202,0 11253,1 11268,0 11323,1 11423,0 11438,1 11475,0 11508,1 11551,0 11616,1 11625,0 11695,1 11794,0 11859,1 11922,0 11938,1 12024,0 12055,1 12066,0 12141,1 12172,0 12223,1 12307,0 12372,1 12386,0 12441,1 12482,0 12496,1 12508,0 12598,1 12600,0 12609,1 12666,0 12753,1 12822,0 12890,1 12952,0 13004,1 13037,0 13106,1 13153,0 13204,1 13254,0 13354,1 13441,0 13458,1 13495,0 13531,1 13604,0 13617,1 13629,0 13716,1 13779,0 13794,1 13873,0 13959,1 14004,0 14083,1 14093,0 14098,1 14194,0 14253,1 14308,0 14361,1 14427,0 14449,1 14527,0 14600,1 14658,0 14742,1 14793,0 14862,1 14891,0 14956,1 14958,0 14979,1 15006,0 15067,1 15072,0 15122,1 15146,0 15194,1 15248,0 15304,1 15395,0 15480,1 15568,0 15653,1 15738,0 15811,1 15872,0 15918,1 15998,0 16098,1 16137,0 16167,1 16253,0 16302,1 16382,0 16431,1 16529,0 16629,1 16656,0 16730,1 16772,0 16847,1 16934,0 16942,1 16998,0 17061,1 17123,0 17167,1 17187,0 17220,1 17226,0 17273,1 17356,0 17381,1 17459,0 17462,1 17554,0 17574,1 17615,0 17703,1 17789,0 17798,1 17811,0 17864,1 17922,0 17961,1 18057,0 18114,1 18165,0 18250,1 18348,0 18358,1 18369,0 18468,1 18485,0 18551,1 18586,0 18629,1 18693,0 18788,1 18812,0 18862,1 18869,0 18926,1 18989,0 19000,1 19092,0 19184,1 19210,0 19246,1 19284,0 19287,1 19365,0 19420,1 19432,0 19507,1 19562,0 19567,1 19657,0 19703,1 19704,0 19776,1 19778,0 19807,1 19884,0 19952,1 19989,0 20012,1 20049,0 20080,1 20088,0 20092,1 20099,0 20151,1 20251,0 20277,1 20337,0 20384,1 20444,0 20462,1 20488,0 20559,1 20569,0 20640,1 20649,0 20659,1 20698,0 20766,1 20771,0 20828,1 20923,0 20963,1 20968,0 21039,1 21055,0 21107,1 21143,0 21195,1 21249,0 21306,1 21353,0 21407,1 21465,0 21554,1 21626,0 21682,1 21752,0 21804,1 21874,0 21952,1 22022,0 22028,1 22046,0 22062,1 22090,0 22104,1 22175,0 22237,1 22269,0 22275,1 22317,0 22331,1 22393,0 22437,1 22512,0 22550,1 22617,0 22687,1 22703,0 22791,1 22793,0 22810,1 22909,0 22934,1 22991,0 22999,1 23047,0 23075,1 23090,0 23150,1 23236,0 23298,1 23333,0 23402,1 23485,0 23514,1 23589,0 23648,1 23691,0 23725,1 23768,0 23849,1 23892,0 23897,1 23982,0 24017,1 24076,0 24090,1 24163,0 24221,1 24277,0 24360,1 24447,0 24523,1 24542,0 24603,1 24691,0 24740,1 24821,0 24894,1 24928,0 25001,1 25031,0 25080,1 25101,0 25166,1 25217,0 25275,1 25325,0 25381,1 25425,0 25506,1 25588,0 25617,1 25707,0 25735,1 25779,0 25854,1 25904,0 25998,1 26064,0 26107,1 26129,0 26139,1 26211,0 26296,1 26321,0 26334,1 26350,0 26387,1 26471,0 26487,1 26529,0 26558,1 26620,0 26626,1 26697,0 26734,1 26794,0 26888,1 26934,0 26949,1 27027,0 27123,1 27202,0 27294,1 27316,0 27320,1 27341,0 27342,1 27435,0 27523,1 27556,0 27639,1 27662,0 27749,1 27793,0 27848,1 27863,0 27883,1 27962,0 27984,1 28080,0 28175,1 28271,0 28279,1 28368,0 28429,1 28519,0 28612,1 28645,0 28664,1 28684,0 28694,1 28786,0 28873,1 28884,0 28960,1 28970,0 29048,1 29088,0 29133,1 29154,0 29252,1 29303,0 29305,1 29371,0 29420,1 29437,0 29475,1 29488,0 29554,1 29620,0 29694,1 29786,0 29820,1 29886,0 29893,1 29939,0 30028,1 30051,0 30114,1 30143,0 30220,1 30259,0 30346,1 30364,0 30436,1 30483,0 30545,1 30568,0 30591,1 30670,0 30697,1 30783,0 30864,1 30899,0 30934,1 30942,0 31030,1 31051,0 31088,1 31105,0 31183,1 31222,0 31282,1 31291,0 31328,1 31425,0 31441,1 31525,0 31537,1 31539,0 31629,1 31638,0 31684,1 31707,0 31757,1 31793,0 31835,1 31890,0 31895,1 31909,0 31997,1 32002,0 32082,1 32103,0 32148,1 32225,0 32255,1 32308,0 32319,1 32338,0 32355,1 32446,0 32459,1 32501,0 32538,1 32557,0 32615,1 32638,0 32687,1 32712,0 32762,1 32843,0 32849,1 32923,0 32956,1 33013,0 33063,1 33074,0 33113,1 33142,0 33222,1 33321,0 33369,1 33443,0 33489,1 33585,0 33603,1 33608,0 33667,1 33710,0 33757,1 33775,0 33822,1 33885,0 33979,1 34031,0 34045,1 34059,0 34149,1 34232,0 34306,1 34335,0 34413,1 34447,0 34488,1 34506,0 34574,1 34578,0 34624,1 34687,0 34690,1 34769,0 34800,1 34862,0 34868,1 34935,0 34939,1 34948,0 35006,1 35032,0 35116,1 35203,0 35278,1 35289,0 35323,1 35392,0 35422,1 35448,0 35488,1 35534,0 35571,1 35644,0 35739,1 35758,0 35792,1 35845,0 35859,1 35914,0 35935,1 36025,0 36103,1 36202,0 36243,1 36284,0 36337,1 36379,0 36462,1 36546,0 36617,1 36682,0 36708,1 36800,0 36839,1 36934,0 36942,1 37042,0 37141,1 37142,0 37229,1 37312,0 37371,1 37447,0 37546,1 37548,0 37588,1 37616,0 37660,1 37662,0 37720,1 37783,0 37801,1 37886,0 37889,1 37977,0 38027,1 38073,0 38156,1 38206,0 38276,1 38346,0 38381,1 38473,0 38483,1 38534,0 38596,1 38643,0 38734,1 38792,0 38829,1 38834,0 38880,1 38959,0 39042,1 39114,0 39154,1 39254,0 39352,1 39452,0 39540,1 39608,0 39637,1 39734,0 39819,1 39872,0 39917,1 40011,0 40090,1 40106,0 40131,1 40205,0 40276,1 40287,0 40345,1 40394,0 40403,1 40426,0 40464,1 40523,0 40582,1 40661,0 40684,1 40759,0 40765,1 40788,0 40831,1 40859,0 40930,1 40940,0 40994,1 41005,0 41081,1 41158,0 41203,1 41221,0 41300,1 41308,0 41324,1 41372,0 41409,1 41421,0 41501,1 41507,0 41601,1 41648,0 41660,1 41725,0 41791,1 41842,0 41844,1 41941,0 41950,1 42003,0 42004,1 42009,0 42090,1 42176,0 42231,1 42253,0 42270,1 42312,0 42396,1 42443,0 42531,1 42532,0 42544,1 42644,0 42707,1 42740,0 42781,1 42866,0 42898,1 42910,0 42926,1 42988,0 43035,1 43101,0 43193,1 43268,0 43328,1 43419,0 43467,1 43543,0 43569,1 43602,0 43619,1 43651,0 43684,1 43730,0 43790,1 43887,0 43888,1 43902,0 43951,1 44050,0 44051,1 44078,0 44160,1 44206,0 44260,1 44262,0 44320,1 44335,0 44408,1 44451,0 44488,1 44511,0 44587,1 44600,0 44647,1 44729,0 44781,1 44849,0 44948,1 44965,0 44995,1 45033,0 45073,1 45114,0 45119,1 45151,0 45229,1 45314,0 45414,1 45457,0 45490,1 45506,0 45597,1 45625,0 45718,1 45800,0 45822,1 45894,0 45916,1 45979,0 46069,1 46109,0 46202,1 46266,0 46276,1 46351,0 46353,1 46373,0 46463,1 46529,0 46607,1 46688,0 46767,1 46802,0 46826,1 46884,0 46981,1 47081,0 47126,1 47174,0 47206,1 47243,0 47342,1 47425,0 47449,1 47533,0 47577,1 47636,0 47698,1 47773,0 47859,1 47895,0 47919,1 47980,0 48074,1 48087,0 48128,1 48214,0 48309,1 48355,0 48409,1 48413,0 48464,1 48526,0 48609,1 48668,0 48722,1 48723,0 48746,1 48751,0 48811,1 48883,0 48895,1 48922,0 49002,1 49043,0 49054,1 49061,0 49112,1 49152,0 49166,1 49240,0 49322,1 49393,0 49421,1 49446,0 49505,1 49595,0 49616,1 49625,0 49721,1 49741,0 49824,1 49849,0 49909,1 49976,0 50056,1 50073,0 50112,1 50146,0 50175,1 end initlist a19 0,0 17,1 21,0 82,1 114,0 119,1 205,0 249,1 315,0 344,1 381,0 469,1 528,0 558,1 636,0 734,1 779,0 791,1 862,0 946,1 1039,0 1073,1 1128,0 1157,1 1185,0 1260,1 1291,0 1332,1 1359,0 1390,1 1478,0 1536,1 1620,0 1640,1 1725,0 1728,1 1745,0 1746,1 1797,0 1855,1 1872,0 1948,1 1957,0 1996,1 2055,0 2084,1 2129,0 2216,1 2309,0 2391,1 2461,0 2559,1 2587,0 2637,1 2659,0 2754,1 2838,0 2850,1 2929,0 3016,1 3061,0 3116,1 3147,0 3169,1 3199,0 3254,1 3307,0 3332,1 3334,0 3396,1 3490,0 3576,1 3601,0 3616,1 3677,0 3760,1 3843,0 3856,1 3944,0 3961,1 3989,0 4047,1 4093,0 4139,1 4149,0 4192,1 4289,0 4305,1 4359,0 4439,1 4517,0 4545,1 4626,0 4669,1 4694,0 4759,1 4774,0 4838,1 4863,0 4880,1 4963,0 5043,1 5062,0 5115,1 5173,0 5258,1 5325,0 5348,1 5407,0 5483,1 5575,0 5596,1 5614,0 5640,1 5717,0 5725,1 5742,0 5806,1 5864,0 5873,1 5971,0 5998,1 6033,0 6100,1 6131,0 6214,1 6215,0 6288,1 6359,0 6415,1 6514,0 6575,1 6675,0 6685,1 6713,0 6812,1 6878,0 6880,1 6883,0 6928,1 6955,0 7026,1 7060,0 7114,1 7200,0 7300,1 7361,0 7400,1 7453,0 7468,1 7479,0 7550,1 7650,0 7744,1 7766,0 7855,1 7926,0 8007,1 8008,0 8086,1 8170,0 8250,1 8321,0 8329,1 8407,0 8450,1 8530,0 8570,1 8587,0 8635,1 8686,0 8745,1 8766,0 8839,1 8845,0 8890,1 8961,0 8963,1 9059,0 9102,1 9182,0 9199,1 9222,0 9271,1 9299,0 9331,1 9352,0 9407,1 9460,0 9483,1 9537,0 9598,1 9610,0 9644,1 9679,0 9752,1 9758,0 9829,1 9883,0 9926,1 9959,0 9987,1 10031,0 10100,1 10133,0 10186,1 10192,0 10249,1 10304,0 10320,1 10372,0 10460,1 10558,0 10645,1 10724,0 10754,1 10769,0 10867,1 10890,0 10935,1 10946,0 11019,1 11064,0 11067,1 11150,0 11211,1 11308,0 11389,1 11472,0 11476,1 11540,0 11597,1 11681,0 11702,1 11787,0 11881,1 11906,0 11917,1 11958,0 12004,1 12016,0 12058,1 12152,0 12250,1 12271,0 12273,1 12288,0 12320,1 12347,0 12432,1 12467,0 12556,1 12580,0 12633,1 12644,0 12684,1 12737,0 12828,1 12890,0 12908,1 13000,0 13079,1 13152,0 13217,1 13303,0 13396,1 13400,0 13427,1 13441,0 13463,1 13561,0 13583,1 13602,0 13638,1 13736,0 13816,1 13821,0 13896,1 13975,0 13996,1 14050,0 14069,1 14116,0 14165,1 14166,0 14231,1 14277,0 14341,1 14378,0 14452,1 14496,0 14539,1 14580,0 14599,1 14663,0 14755,1 14812,0 14817,1 14915,0 14963,1 14966,0 15003,1 15026,0 15029,1 15118,0 15164,1 15175,0 15205,1 15279,0 15282,1 15353,0 15384,1 15469,0 15569,1 15576,0 15666,1 15683,0 15771,1 15797,0 15825,1 15829,0 15880,1 15919,0 15922,1 15957,0 16049,1 16058,0 16088,1 16156,0 16237,1 16240,0 16305,1 16400,0 16499,1 16570,0 16654,1 16723,0 16755,1 16764,0 16835,1 16932,0 16978,1 16983,0 16989,1 17004,0 17009,1 17065,0 17163,1 17224,0 17244,1 17284,0 17285,1 17326,0 17342,1 17374,0 17383,1 17401,0 17410,1 17502,0 17531,1 17598,0 17674,1 17723,0 17746,1 17792,0 17804,1 17871,0 17958,1 18014,0 18102,1 18201,0 18275,1 18332,0 18403,1 18459,0 18497,1 18526,0 18559,1 18623,0 18710,1 18766,0 18860,1 18907,0 18927,1 19010,0 19035,1 19092,0 19104,1 19146,0 19178,1 19210,0 19299,1 19387,0 19485,1 19535,0 19563,1 19657,0 19687,1 19719,0 19753,1 19832,0 19870,1 19893,0 19904,1 19981,0 19997,1 20018,0 20065,1 20081,0 20103,1 20136,0 20196,1 20272,0 20311,1 20342,0 20437,1 20454,0 20539,1 20634,0 20675,1 20677,0 20690,1 20750,0 20779,1 20809,0 20844,1 20919,0 20965,1 21006,0 21098,1 21124,0 21217,1 21224,0 21271,1 21364,0 21450,1 21491,0 21528,1 21603,0 21641,1 21703,0 21794,1 21798,0 21852,1 21885,0 21906,1 21997,0 22012,1 22052,0 22149,1 22181,0 22230,1 22238,0 22286,1 22384,0 22443,1 22478,0 22515,1 22571,0 22586,1 22592,0 22672,1 22721,0 22778,1 22788,0 22882,1 22921,0 22922,1 22984,0 23049,1 23082,0 23086,1 23166,0 23240,1 23262,0 23297,1 23373,0 23387,1 23410,0 23415,1 23417,0 23497,1 23538,0 23543,1 23560,0 23624,1 23710,0 23732,1 23753,0 23845,1 23917,0 23948,1 23974,0 24002,1 24065,0 24154,1 24205,0 24271,1 24365,0 24372,1 24425,0 24469,1 24479,0 24496,1 24509,0 24574,1 24584,0 24669,1 24713,0 24780,1 24824,0 24904,1 24905,0 24944,1 24980,0 24992,1 25088,0 25097,1 25116,0 25157,1 25178,0 25248,1 25324,0 25374,1 25407,0 25453,1 25531,0 25630,1 25667,0 25681,1 25753,0 25827,1 25871,0 25957,1 26046,0 26095,1 26160,0 26215,1 26216,0 26251,1 26289,0 26384,1 26478,0 26527,1 26583,0 26610,1 26650,0 26707,1 26771,0 26862,1 26888,0 26924,1 26999,0 27059,1 27152,0 27216,1 27291,0 27292,1 27339,0 27432,1 27527,0 27557,1 27655,0 27713,1 27811,0 27814,1 27896,0 27989,1 28012,0 28102,1 28182,0 28271,1 28324,0 28387,1 28481,0 28510,1 28552,0 28595,1 28633,0 28726,1 28767,0 28778,1 28836,0 28887,1 28922,0 28986,1 29053,0 29141,1 29164,0 29170,1 29201,0 29253,1 29258,0 29339,1 29369,0 29461,1 29538,0 29593,1 29598,0 29607,1 29706,0 29719,1 29797,0 29891,1 29905,0 30002,1 30081,0 30176,1 30274,0 30302,1 30334,0 30389,1 30482,0 30529,1 30556,0 30601,1 30614,0 30708,1 30783,0 30806,1 30813,0 30887,1 30962,0 31041,1 31106,0 31178,1 31206,0 31261,1 31269,0 31346,1 31386,0 31457,1 31510,0 31540,1 31625,0 31630,1 31715,0 31800,1 31881,0 31919,1 32008,0 32100,1 32182,0 32281,1 32361,0 32387,1 32431,0 32521,1 32562,0 32583,1 32667,0 32702,1 32750,0 32828,1 32879,0 32956,1 32964,0 33028,1 33046,0 33127,1 33217,0 33242,1 33257,0 33295,1 33348,0 33404,1 33412,0 33506,1 33586,0 33599,1 33691,0 33771,1 33833,0 33874,1 33935,0 34025,1 34119,0 34177,1 34189,0 34231,1 34321,0 34355,1 34444,0 34452,1 34470,0 34542,1 34558,0 34559,1 34607,0 34618,1 34622,0 34669,1 34684,0 34774,1 34843,0 34868,1 34877,0 34966,1 35016,0 35067,1 35106,0 35191,1 35267,0 35340,1 35376,0 35417,1 35499,0 35598,1 35608,0 35663,1 35681,0 35701,1 35785,0 35828,1 35914,0 35919,1 36011,0 36031,1 36059,0 36094,1 36183,0 36248,1 36319,0 36404,1 36425,0 36472,1 36513,0 36517,1 36554,0 36619,1 36657,0 36687,1 36704,0 36778,1 36839,0 36903,1 36992,0 37064,1 37107,0 37160,1 37174,0 37176,1 37257,0 37299,1 37374,0 37466,1 37487,0 37500,1 37537,0 37624,1 37710,0 37756,1 37809,0 37907,1 37946,0 38035,1 38089,0 38148,1 38181,0 38281,1 38287,0 38327,1 38391,0 38483,1 38511,0 38573,1 38654,0 38704,1 38797,0 38827,1 38875,0 38973,1 39035,0 39061,1 39161,0 39246,1 39274,0 39298,1 39381,0 39472,1 39550,0 39592,1 39620,0 39680,1 39752,0 39836,1 39842,0 39884,1 39962,0 39979,1 39980,0 39994,1 40010,0 40058,1 40139,0 40226,1 40235,0 40248,1 40343,0 40435,1 40466,0 40473,1 40517,0 40531,1 40631,0 40641,1 40689,0 40690,1 40738,0 40787,1 40855,0 40862,1 40877,0 40887,1 40930,0 40945,1 40951,0 40956,1 41004,0 41033,1 41114,0 41164,1 41195,0 41241,1 41288,0 41380,1 41392,0 41427,1 41467,0 41503,1 41563,0 41584,1 41648,0 41674,1 41704,0 41740,1 41756,0 41762,1 41845,0 41890,1 41915,0 41981,1 42072,0 42141,1 42152,0 42202,1 42257,0 42299,1 42315,0 42332,1 42333,0 42420,1 42449,0 42495,1 42521,0 42571,1 42626,0 42636,1 42644,0 42692,1 42766,0 42836,1 42912,0 43011,1 43099,0 43156,1 43248,0 43284,1 43349,0 43441,1 43534,0 43604,1 43630,0 43716,1 43782,0 43834,1 43862,0 43942,1 43952,0 43971,1 44037,0 44068,1 44166,0 44192,1 44218,0 44282,1 44371,0 44444,1 44473,0 44543,1 44572,0 44620,1 44654,0 44723,1 44814,0 44894,1 44929,0 45010,1 45107,0 45114,1 45134,0 45169,1 45223,0 45257,1 45353,0 45370,1 45399,0 45420,1 45467,0 45483,1 45520,0 45568,1 45656,0 45726,1 45825,0 45913,1 45924,0 45976,1 45990,0 46033,1 46124,0 46171,1 46239,0 46266,1 46280,0 46290,1 46363,0 46385,1 46452,0 46490,1 46509,0 46516,1 46602,0 46691,1 46732,0 46799,1 46812,0 46850,1 46891,0 46932,1 46947,0 47018,1 47036,0 47048,1 47112,0 47141,1 47209,0 47298,1 47365,0 47410,1 47480,0 47510,1 47583,0 47607,1 47696,0 47700,1 47749,0 47844,1 47887,0 47985,1 47991,0 48014,1 48043,0 48052,1 48105,0 48204,1 48236,0 48289,1 48337,0 48378,1 48405,0 48495,1 48588,0 48653,1 48681,0 48738,1 48813,0 48822,1 48863,0 48954,1 49020,0 49105,1 49107,0 49169,1 49192,0 49264,1 49296,0 49321,1 49411,0 49489,1 49570,0 49626,1 49694,0 49762,1 49774,0 49779,1 49793,0 49843,1 49917,0 49994,1 50073,0 50141,1 end initlist a20 0,0 89,1 147,0 178,1 269,0 351,1 394,0 466,1 531,0 577,1 627,0 653,1 663,0 676,1 689,0 776,1 840,0 847,1 901,0 947,1 1033,0 1113,1 1196,0 1225,1 1291,0 1336,1 1355,0 1360,1 1372,0 1414,1 1492,0 1504,1 1509,0 1576,1 1627,0 1654,1 1750,0 1801,1 1830,0 1838,1 1860,0 1875,1 1880,0 1883,1 1952,0 2021,1 2058,0 2092,1 2151,0 2218,1 2232,0 2262,1 2329,0 2417,1 2434,0 2527,1 2618,0 2624,1 2703,0 2727,1 2760,0 2818,1 2893,0 2949,1 3026,0 3096,1 3167,0 3201,1 3217,0 3312,1 3340,0 3432,1 3532,0 3575,1 3621,0 3716,1 3724,0 3815,1 3906,0 3948,1 3970,0 4043,1 4060,0 4133,1 4164,0 4252,1 4312,0 4402,1 4451,0 4498,1 4585,0 4660,1 4692,0 4696,1 4792,0 4795,1 4893,0 4941,1 4957,0 4997,1 5021,0 5072,1 5163,0 5175,1 5192,0 5233,1 5239,0 5324,1 5400,0 5459,1 5553,0 5587,1 5605,0 5633,1 5675,0 5723,1 5741,0 5808,1 5849,0 5930,1 5961,0 6052,1 6111,0 6189,1 6222,0 6319,1 6396,0 6461,1 6486,0 6528,1 6570,0 6664,1 6704,0 6752,1 6812,0 6883,1 6978,0 7015,1 7060,0 7146,1 7151,0 7156,1 7224,0 7304,1 7339,0 7350,1 7353,0 7405,1 7459,0 7487,1 7569,0 7666,1 7764,0 7862,1 7922,0 7932,1 7934,0 7989,1 8060,0 8072,1 8138,0 8209,1 8266,0 8277,1 8323,0 8402,1 8457,0 8550,1 8592,0 8663,1 8724,0 8763,1 8779,0 8807,1 8837,0 8869,1 8958,0 9036,1 9102,0 9106,1 9151,0 9239,1 9248,0 9318,1 9381,0 9431,1 9528,0 9547,1 9578,0 9599,1 9615,0 9684,1 9773,0 9778,1 9845,0 9867,1 9928,0 10011,1 10041,0 10088,1 10131,0 10167,1 10248,0 10251,1 10340,0 10428,1 10487,0 10533,1 10585,0 10645,1 10702,0 10800,1 10847,0 10861,1 10927,0 10937,1 10950,0 10965,1 10994,0 11050,1 11064,0 11154,1 11180,0 11196,1 11282,0 11340,1 11399,0 11499,1 11532,0 11537,1 11594,0 11630,1 11654,0 11673,1 11761,0 11857,1 11920,0 11944,1 11950,0 11975,1 12040,0 12073,1 12084,0 12159,1 12242,0 12299,1 12384,0 12461,1 12479,0 12496,1 12516,0 12605,1 12680,0 12763,1 12799,0 12843,1 12884,0 12967,1 13005,0 13037,1 13117,0 13174,1 13258,0 13267,1 13292,0 13368,1 13392,0 13431,1 13436,0 13487,1 13583,0 13630,1 13702,0 13783,1 13808,0 13860,1 13891,0 13906,1 13953,0 14038,1 14122,0 14217,1 14222,0 14258,1 14351,0 14382,1 14442,0 14459,1 14510,0 14595,1 14690,0 14760,1 14810,0 14861,1 14883,0 14917,1 14960,0 14979,1 15009,0 15055,1 15153,0 15237,1 15297,0 15319,1 15358,0 15391,1 15438,0 15499,1 15560,0 15650,1 15747,0 15759,1 15760,0 15825,1 15843,0 15915,1 15991,0 16089,1 16109,0 16193,1 16242,0 16266,1 16299,0 16323,1 16357,0 16400,1 16499,0 16591,1 16683,0 16715,1 16783,0 16790,1 16801,0 16838,1 16899,0 16929,1 17029,0 17122,1 17179,0 17232,1 17275,0 17360,1 17424,0 17467,1 17491,0 17556,1 17570,0 17630,1 17651,0 17673,1 17751,0 17756,1 17841,0 17891,1 17917,0 17952,1 18047,0 18093,1 18146,0 18188,1 18211,0 18310,1 18374,0 18405,1 18484,0 18539,1 18593,0 18679,1 18757,0 18796,1 18798,0 18808,1 18908,0 18999,1 19023,0 19035,1 19084,0 19099,1 19157,0 19216,1 19256,0 19350,1 19390,0 19413,1 19418,0 19441,1 19470,0 19561,1 19611,0 19661,1 19745,0 19838,1 19908,0 19972,1 20023,0 20103,1 20167,0 20181,1 20219,0 20309,1 20347,0 20373,1 20390,0 20412,1 20455,0 20467,1 20536,0 20613,1 20646,0 20696,1 20715,0 20767,1 20833,0 20879,1 20940,0 20986,1 21073,0 21134,1 21162,0 21187,1 21256,0 21271,1 21318,0 21376,1 21427,0 21518,1 21544,0 21597,1 21633,0 21686,1 21727,0 21731,1 21748,0 21795,1 21887,0 21958,1 21996,0 22074,1 22098,0 22198,1 22298,0 22371,1 22385,0 22432,1 22449,0 22542,1 22570,0 22656,1 22737,0 22815,1 22854,0 22907,1 22933,0 23003,1 23011,0 23021,1 23115,0 23194,1 23291,0 23362,1 23386,0 23471,1 23568,0 23574,1 23659,0 23664,1 23698,0 23777,1 23836,0 23837,1 23899,0 23961,1 24049,0 24125,1 24194,0 24200,1 24252,0 24320,1 24365,0 24460,1 24558,0 24607,1 24650,0 24740,1 24806,0 24891,1 24926,0 24948,1 24970,0 25026,1 25091,0 25102,1 25195,0 25223,1 25282,0 25363,1 25444,0 25483,1 25558,0 25626,1 25703,0 25721,1 25797,0 25868,1 25963,0 26052,1 26080,0 26128,1 26205,0 26225,1 26306,0 26373,1 26379,0 26441,1 26518,0 26532,1 26564,0 26614,1 26669,0 26679,1 26739,0 26770,1 26848,0 26880,1 26970,0 26994,1 27092,0 27180,1 27259,0 27319,1 27388,0 27469,1 27506,0 27579,1 27625,0 27638,1 27692,0 27782,1 27855,0 27922,1 27968,0 27973,1 28011,0 28045,1 28129,0 28134,1 28188,0 28199,1 28292,0 28315,1 28362,0 28413,1 28419,0 28458,1 28483,0 28545,1 28559,0 28629,1 28676,0 28734,1 28768,0 28817,1 28856,0 28866,1 28925,0 29016,1 29070,0 29170,1 29176,0 29220,1 29319,0 29357,1 29370,0 29403,1 29480,0 29507,1 29576,0 29604,1 29650,0 29699,1 29743,0 29832,1 29931,0 29950,1 29962,0 29992,1 30001,0 30073,1 30130,0 30171,1 30192,0 30262,1 30315,0 30371,1 30382,0 30472,1 30508,0 30600,1 30612,0 30664,1 30682,0 30691,1 30788,0 30822,1 30898,0 30916,1 30972,0 31006,1 31069,0 31117,1 31204,0 31258,1 31265,0 31354,1 31454,0 31540,1 31583,0 31635,1 31683,0 31692,1 31762,0 31792,1 31881,0 31941,1 31991,0 32053,1 32056,0 32062,1 32122,0 32209,1 32231,0 32310,1 32392,0 32453,1 32543,0 32567,1 32637,0 32714,1 32746,0 32766,1 32812,0 32844,1 32894,0 32902,1 32998,0 33055,1 33059,0 33098,1 33140,0 33227,1 33291,0 33306,1 33403,0 33470,1 33492,0 33500,1 33522,0 33571,1 33666,0 33723,1 33756,0 33780,1 33831,0 33835,1 33896,0 33991,1 34074,0 34166,1 34228,0 34260,1 34341,0 34387,1 34422,0 34433,1 34469,0 34508,1 34598,0 34624,1 34640,0 34713,1 34777,0 34850,1 34950,0 34960,1 34997,0 35068,1 35153,0 35212,1 35223,0 35252,1 35307,0 35337,1 35355,0 35369,1 35421,0 35497,1 35522,0 35561,1 35623,0 35656,1 35745,0 35810,1 35881,0 35927,1 35981,0 36067,1 36103,0 36153,1 36217,0 36262,1 36321,0 36410,1 36437,0 36519,1 36537,0 36600,1 36671,0 36739,1 36754,0 36772,1 36861,0 36936,1 36984,0 37027,1 37092,0 37097,1 37180,0 37206,1 37239,0 37289,1 37292,0 37360,1 37450,0 37527,1 37582,0 37592,1 37646,0 37702,1 37715,0 37746,1 37781,0 37846,1 37906,0 37976,1 38006,0 38087,1 38117,0 38134,1 38151,0 38197,1 38236,0 38313,1 38339,0 38357,1 38360,0 38448,1 38530,0 38570,1 38648,0 38668,1 38761,0 38776,1 38815,0 38850,1 38943,0 39032,1 39058,0 39079,1 39112,0 39148,1 39200,0 39205,1 39268,0 39302,1 39323,0 39393,1 39475,0 39528,1 39539,0 39546,1 39603,0 39684,1 39759,0 39786,1 39868,0 39916,1 39975,0 40026,1 40109,0 40164,1 40184,0 40231,1 40308,0 40349,1 40378,0 40385,1 40479,0 40538,1 40622,0 40717,1 40734,0 40743,1 40770,0 40837,1 40903,0 40964,1 40969,0 41039,1 41044,0 41048,1 41091,0 41127,1 41208,0 41300,1 41379,0 41473,1 41554,0 41631,1 41695,0 41721,1 41800,0 41864,1 41924,0 41933,1 41953,0 42002,1 42091,0 42171,1 42254,0 42296,1 42360,0 42442,1 42483,0 42540,1 42580,0 42633,1 42719,0 42811,1 42813,0 42869,1 42912,0 42929,1 42971,0 43012,1 43023,0 43097,1 43168,0 43227,1 43239,0 43241,1 43312,0 43412,1 43455,0 43550,1 43594,0 43638,1 43699,0 43749,1 43776,0 43860,1 43932,0 43985,1 44065,0 44128,1 44209,0 44239,1 44319,0 44418,1 44497,0 44548,1 44570,0 44629,1 44677,0 44682,1 44693,0 44706,1 44748,0 44804,1 44807,0 44811,1 44821,0 44857,1 44922,0 44974,1 44995,0 45094,1 45176,0 45224,1 45296,0 45331,1 45367,0 45438,1 45502,0 45586,1 45618,0 45630,1 45722,0 45811,1 45858,0 45892,1 45943,0 46040,1 46103,0 46117,1 46189,0 46197,1 46282,0 46297,1 46349,0 46387,1 46406,0 46448,1 46509,0 46550,1 46553,0 46558,1 46574,0 46584,1 46607,0 46646,1 46684,0 46726,1 46814,0 46841,1 46868,0 46889,1 46911,0 46966,1 46967,0 47064,1 47163,0 47226,1 47238,0 47280,1 47377,0 47469,1 47502,0 47585,1 47682,0 47729,1 47776,0 47827,1 47870,0 47945,1 48037,0 48059,1 48138,0 48232,1 48254,0 48344,1 48420,0 48428,1 48445,0 48482,1 48578,0 48631,1 48634,0 48649,1 48685,0 48774,1 48874,0 48953,1 49019,0 49101,1 49187,0 49271,1 49317,0 49357,1 49446,0 49491,1 49522,0 49533,1 49597,0 49695,1 49760,0 49795,1 49881,0 49908,1 50004,0 50101,1 50125,0 50142,1 50180,0 50202,1 50245,0 50313,1 50381,0 50457,1 50486,0 50540,1 50581,0 50586,1 50683,0 50706,1 50788,0 50868,1 50901,0 50913,1 50980,0 51078,1 51168,0 51268,1 end initlist a21 0,0 9,1 34,0 37,1 58,0 117,1 166,0 239,1 246,0 324,1 397,0 447,1 504,0 568,1 577,0 604,1 650,0 684,1 715,0 812,1 897,0 934,1 996,0 1060,1 1122,0 1215,1 1297,0 1328,1 1341,0 1368,1 1395,0 1424,1 1449,0 1501,1 1537,0 1571,1 1616,0 1706,1 1797,0 1854,1 1937,0 2014,1 2077,0 2175,1 2253,0 2299,1 2395,0 2488,1 2574,0 2638,1 2702,0 2709,1 2751,0 2783,1 2860,0 2907,1 2998,0 3073,1 3144,0 3206,1 3258,0 3347,1 3356,0 3434,1 3476,0 3557,1 3640,0 3657,1 3705,0 3765,1 3823,0 3835,1 3910,0 3931,1 3937,0 4036,1 4091,0 4124,1 4155,0 4160,1 4234,0 4288,1 4303,0 4383,1 4407,0 4481,1 4535,0 4604,1 4666,0 4691,1 4744,0 4812,1 4880,0 4969,1 5027,0 5049,1 5089,0 5184,1 5237,0 5243,1 5249,0 5290,1 5322,0 5337,1 5367,0 5428,1 5436,0 5506,1 5523,0 5585,1 5637,0 5673,1 5681,0 5693,1 5713,0 5771,1 5841,0 5935,1 5966,0 6064,1 6085,0 6160,1 6166,0 6174,1 6197,0 6223,1 6233,0 6308,1 6401,0 6479,1 6574,0 6640,1 6712,0 6756,1 6825,0 6879,1 6900,0 6958,1 6990,0 7080,1 7151,0 7179,1 7229,0 7261,1 7316,0 7321,1 7408,0 7460,1 7556,0 7574,1 7655,0 7667,1 7684,0 7749,1 7809,0 7887,1 7967,0 7999,1 8018,0 8118,1 8135,0 8232,1 8256,0 8324,1 8349,0 8431,1 8494,0 8554,1 8595,0 8660,1 8704,0 8783,1 8865,0 8932,1 8998,0 9006,1 9084,0 9093,1 9192,0 9284,1 9313,0 9401,1 9408,0 9421,1 9478,0 9529,1 9604,0 9645,1 9680,0 9746,1 9770,0 9771,1 9809,0 9831,1 9912,0 10012,1 10059,0 10124,1 10178,0 10205,1 10273,0 10332,1 10400,0 10491,1 10522,0 10598,1 10693,0 10738,1 10825,0 10844,1 10934,0 10956,1 11042,0 11086,1 11096,0 11154,1 11186,0 11251,1 11293,0 11310,1 11381,0 11472,1 11513,0 11543,1 11629,0 11659,1 11747,0 11804,1 11884,0 11966,1 12064,0 12118,1 12143,0 12198,1 12206,0 12215,1 12233,0 12278,1 12297,0 12316,1 12378,0 12440,1 12480,0 12571,1 12640,0 12666,1 12707,0 12737,1 12820,0 12823,1 12905,0 12988,1 13053,0 13113,1 13124,0 13182,1 13183,0 13230,1 13278,0 13331,1 13338,0 13368,1 13453,0 13518,1 13530,0 13608,1 13688,0 13754,1 13804,0 13834,1 13872,0 13905,1 13996,0 14066,1 14117,0 14211,1 14310,0 14339,1 14368,0 14387,1 14439,0 14525,1 14598,0 14625,1 14651,0 14747,1 14817,0 14883,1 14956,0 15018,1 15074,0 15168,1 15183,0 15199,1 15219,0 15281,1 15315,0 15331,1 15431,0 15482,1 15554,0 15590,1 15637,0 15708,1 15789,0 15848,1 15891,0 15895,1 15955,0 16036,1 16136,0 16193,1 16252,0 16281,1 16348,0 16371,1 16454,0 16538,1 16633,0 16733,1 16821,0 16900,1 16946,0 17039,1 17113,0 17127,1 17177,0 17228,1 17323,0 17351,1 17441,0 17494,1 17583,0 17624,1 17722,0 17789,1 17883,0 17943,1 17964,0 18027,1 18119,0 18196,1 18249,0 18302,1 18370,0 18460,1 18505,0 18562,1 18654,0 18700,1 18751,0 18787,1 18800,0 18851,1 18892,0 18931,1 18938,0 19034,1 19094,0 19100,1 19196,0 19239,1 19284,0 19371,1 19390,0 19416,1 19428,0 19519,1 19569,0 19636,1 19711,0 19767,1 19855,0 19883,1 19931,0 20018,1 20104,0 20135,1 20188,0 20251,1 20266,0 20301,1 20324,0 20350,1 20427,0 20467,1 20524,0 20619,1 20695,0 20701,1 20702,0 20797,1 20892,0 20987,1 20989,0 21046,1 21095,0 21150,1 21229,0 21275,1 21321,0 21350,1 21392,0 21435,1 21472,0 21543,1 21585,0 21683,1 21722,0 21774,1 21853,0 21878,1 21975,0 21988,1 22038,0 22082,1 22181,0 22246,1 22345,0 22420,1 22470,0 22496,1 22502,0 22556,1 22628,0 22694,1 22780,0 22781,1 22796,0 22848,1 22948,0 23042,1 23099,0 23156,1 23158,0 23245,1 23320,0 23418,1 23451,0 23488,1 23582,0 23623,1 23636,0 23718,1 23745,0 23787,1 23827,0 23831,1 23845,0 23920,1 23928,0 23959,1 23960,0 24033,1 24054,0 24078,1 24131,0 24195,1 24247,0 24323,1 24410,0 24442,1 24470,0 24547,1 24595,0 24682,1 24723,0 24744,1 24835,0 24876,1 24935,0 24953,1 24999,0 25096,1 25147,0 25243,1 25339,0 25406,1 25499,0 25500,1 25540,0 25556,1 25566,0 25585,1 25656,0 25742,1 25776,0 25803,1 25843,0 25936,1 26034,0 26052,1 26130,0 26164,1 26207,0 26283,1 26343,0 26390,1 26432,0 26454,1 26475,0 26549,1 26649,0 26667,1 26725,0 26794,1 26864,0 26894,1 26928,0 26935,1 27030,0 27037,1 27084,0 27093,1 27099,0 27191,1 27263,0 27318,1 27337,0 27348,1 27357,0 27436,1 27523,0 27572,1 27627,0 27723,1 27747,0 27814,1 27831,0 27913,1 27961,0 27989,1 28000,0 28072,1 28112,0 28201,1 28267,0 28332,1 28391,0 28475,1 28521,0 28553,1 28584,0 28672,1 28733,0 28766,1 28838,0 28890,1 28951,0 28983,1 29050,0 29084,1 29085,0 29161,1 29187,0 29247,1 29331,0 29370,1 29436,0 29453,1 29460,0 29542,1 29589,0 29642,1 29713,0 29809,1 29836,0 29855,1 29889,0 29971,1 29987,0 30031,1 30063,0 30130,1 30195,0 30282,1 30361,0 30384,1 30482,0 30519,1 30561,0 30646,1 30694,0 30711,1 30793,0 30819,1 30885,0 30917,1 30982,0 30983,1 31066,0 31125,1 31198,0 31275,1 31311,0 31359,1 31441,0 31463,1 31559,0 31656,1 31733,0 31832,1 31932,0 32018,1 32117,0 32178,1 32212,0 32239,1 32254,0 32307,1 32336,0 32410,1 32454,0 32488,1 32538,0 32570,1 32580,0 32590,1 32640,0 32679,1 32684,0 32745,1 32806,0 32833,1 32922,0 32946,1 32951,0 33010,1 33021,0 33022,1 33113,0 33143,1 33169,0 33170,1 33226,0 33319,1 33379,0 33470,1 33484,0 33552,1 33602,0 33661,1 33720,0 33778,1 33803,0 33833,1 33884,0 33948,1 34004,0 34043,1 34131,0 34222,1 34304,0 34335,1 34431,0 34501,1 34546,0 34611,1 34704,0 34742,1 34812,0 34883,1 34926,0 34993,1 35071,0 35129,1 35211,0 35244,1 35270,0 35307,1 35310,0 35406,1 35431,0 35463,1 35479,0 35574,1 35633,0 35655,1 35720,0 35728,1 35766,0 35816,1 35892,0 35952,1 36003,0 36033,1 36115,0 36122,1 36132,0 36212,1 36287,0 36328,1 36413,0 36497,1 36552,0 36628,1 36699,0 36732,1 36814,0 36856,1 36938,0 37024,1 37093,0 37157,1 37192,0 37243,1 37247,0 37327,1 37368,0 37426,1 37455,0 37489,1 37496,0 37528,1 37572,0 37605,1 37639,0 37661,1 37748,0 37825,1 37836,0 37840,1 37852,0 37936,1 37944,0 38044,1 38088,0 38107,1 38155,0 38210,1 38265,0 38338,1 38400,0 38405,1 38421,0 38479,1 38534,0 38628,1 38664,0 38699,1 38774,0 38850,1 38908,0 39001,1 39051,0 39109,1 39158,0 39222,1 39277,0 39324,1 39394,0 39425,1 39511,0 39559,1 39596,0 39684,1 39724,0 39810,1 39890,0 39978,1 40032,0 40047,1 40115,0 40162,1 40260,0 40306,1 40329,0 40352,1 40433,0 40511,1 40534,0 40613,1 40704,0 40738,1 40775,0 40864,1 40907,0 40962,1 41054,0 41101,1 41160,0 41164,1 41261,0 41271,1 41326,0 41401,1 41408,0 41485,1 41583,0 41669,1 41761,0 41803,1 41818,0 41841,1 41912,0 41985,1 42064,0 42085,1 42176,0 42189,1 42286,0 42376,1 42432,0 42494,1 42523,0 42549,1 42644,0 42736,1 42752,0 42822,1 42913,0 42998,1 43072,0 43111,1 43207,0 43274,1 43341,0 43430,1 43508,0 43575,1 43666,0 43668,1 43733,0 43825,1 43875,0 43969,1 44058,0 44127,1 44202,0 44211,1 44277,0 44374,1 44430,0 44469,1 44511,0 44538,1 44599,0 44636,1 44638,0 44657,1 44733,0 44811,1 44874,0 44957,1 45021,0 45097,1 45197,0 45277,1 45334,0 45404,1 45463,0 45475,1 45518,0 45548,1 45554,0 45654,1 45718,0 45816,1 45881,0 45931,1 46011,0 46040,1 46116,0 46203,1 46293,0 46389,1 46424,0 46469,1 46553,0 46637,1 46686,0 46733,1 46773,0 46864,1 46936,0 46972,1 46988,0 47039,1 47079,0 47087,1 47174,0 47200,1 47289,0 47324,1 47344,0 47367,1 47373,0 47396,1 47478,0 47505,1 47574,0 47595,1 47606,0 47657,1 47692,0 47725,1 47756,0 47820,1 47834,0 47898,1 47940,0 48040,1 48104,0 48115,1 48135,0 48235,1 48319,0 48366,1 48387,0 48487,1 48516,0 48546,1 48644,0 48742,1 48825,0 48842,1 48848,0 48851,1 48910,0 48972,1 49029,0 49067,1 49132,0 49160,1 49186,0 49253,1 49321,0 49351,1 49414,0 49441,1 49509,0 49552,1 49573,0 49672,1 49772,0 49791,1 49814,0 49833,1 49924,0 49949,1 50042,0 50085,1 50168,0 50205,1 50242,0 50309,1 50315,0 50394,1 50482,0 50576,1 50665,0 50733,1 50749,0 50757,1 50806,0 50836,1 50848,0 50850,1 50948,0 51044,1 51127,0 51165,1 51187,0 51280,1 51360,0 51443,1 51496,0 51548,1 51553,0 51628,1 51661,0 51689,1 51766,0 51788,1 51830,0 51835,1 51838,0 51863,1 51882,0 51889,1 51974,0 51994,1 52021,0 52070,1 52159,0 52220,1 52248,0 52261,1 52337,0 52427,1 52481,0 52537,1 52635,0 52712,1 52777,0 52785,1 52833,0 52872,1 52942,0 53039,1 53077,0 53160,1 end initlist a22 0,0 97,1 179,0 278,1 313,0 342,1 357,0 420,1 471,0 525,1 607,0 691,1 694,0 794,1 824,0 893,1 908,0 995,1 1028,0 1037,1 1119,0 1170,1 1179,0 1205,1 1260,0 1285,1 1385,0 1440,1 1504,0 1579,1 1625,0 1651,1 1726,0 1740,1 1782,0 1882,1 1904,0 1908,1 1968,0 2061,1 2095,0 2147,1 2200,0 2225,1 2268,0 2334,1 2352,0 2412,1 2413,0 2505,1 2507,0 2569,1 2595,0 2670,1 2761,0 2790,1 2876,0 2922,1 2943,0 2982,1 3076,0 3159,1 3195,0 3238,1 3254,0 3279,1 3309,0 3324,1 3381,0 3439,1 3534,0 3619,1 3641,0 3676,1 3684,0 3774,1 3866,0 3930,1 3950,0 4002,1 4094,0 4169,1 4263,0 4349,1 4419,0 4470,1 4494,0 4557,1 4558,0 4569,1 4667,0 4743,1 4798,0 4836,1 4897,0 4910,1 4979,0 5038,1 5050,0 5089,1 5170,0 5171,1 5249,0 5326,1 5332,0 5382,1 5474,0 5519,1 5523,0 5533,1 5597,0 5680,1 5688,0 5751,1 5761,0 5847,1 5898,0 5916,1 5978,0 6029,1 6064,0 6130,1 6177,0 6271,1 6282,0 6321,1 6334,0 6347,1 6398,0 6461,1 6524,0 6557,1 6596,0 6689,1 6743,0 6796,1 6824,0 6855,1 6878,0 6955,1 7047,0 7053,1 7126,0 7158,1 7200,0 7286,1 7331,0 7373,1 7465,0 7536,1 7552,0 7621,1 7675,0 7764,1 7766,0 7774,1 7822,0 7912,1 7916,0 7940,1 7973,0 8030,1 8089,0 8107,1 8183,0 8251,1 8275,0 8337,1 8371,0 8411,1 8462,0 8557,1 8608,0 8707,1 8754,0 8755,1 8806,0 8831,1 8857,0 8897,1 8990,0 9022,1 9117,0 9183,1 9241,0 9305,1 9327,0 9358,1 9402,0 9431,1 9444,0 9540,1 9577,0 9617,1 9678,0 9689,1 9705,0 9803,1 9865,0 9878,1 9918,0 9950,1 9974,0 9994,1 10083,0 10127,1 10215,0 10235,1 10297,0 10342,1 10394,0 10468,1 10502,0 10576,1 10577,0 10668,1 10683,0 10781,1 10799,0 10819,1 10900,0 10994,1 11010,0 11077,1 11153,0 11160,1 11190,0 11238,1 11246,0 11300,1 11318,0 11403,1 11458,0 11550,1 11644,0 11681,1 11708,0 11736,1 11780,0 11827,1 11889,0 11958,1 12053,0 12108,1 12168,0 12239,1 12294,0 12345,1 12430,0 12470,1 12525,0 12616,1 12655,0 12716,1 12755,0 12850,1 12937,0 12976,1 13003,0 13053,1 13115,0 13119,1 13185,0 13195,1 13200,0 13294,1 13309,0 13353,1 13360,0 13455,1 13547,0 13635,1 13722,0 13749,1 13761,0 13849,1 13936,0 13954,1 14033,0 14114,1 14175,0 14220,1 14289,0 14353,1 14387,0 14405,1 14499,0 14543,1 14550,0 14639,1 14687,0 14759,1 14800,0 14807,1 14845,0 14923,1 14940,0 14981,1 14986,0 15039,1 15105,0 15128,1 15161,0 15175,1 15273,0 15328,1 15346,0 15414,1 15503,0 15560,1 15658,0 15704,1 15713,0 15760,1 15827,0 15910,1 15949,0 15967,1 16011,0 16089,1 16135,0 16176,1 16222,0 16320,1 16369,0 16420,1 16425,0 16434,1 16446,0 16464,1 16551,0 16645,1 16667,0 16685,1 16720,0 16722,1 16789,0 16861,1 16927,0 16957,1 16964,0 17051,1 17056,0 17105,1 17130,0 17195,1 17233,0 17301,1 17345,0 17402,1 17441,0 17461,1 17467,0 17540,1 17621,0 17646,1 17722,0 17802,1 17844,0 17894,1 17948,0 17978,1 18066,0 18139,1 18158,0 18201,1 18288,0 18348,1 18378,0 18473,1 18559,0 18583,1 18612,0 18685,1 18734,0 18809,1 18888,0 18910,1 18956,0 18995,1 19004,0 19045,1 19138,0 19147,1 19233,0 19319,1 19387,0 19465,1 19499,0 19565,1 19609,0 19651,1 19749,0 19804,1 19839,0 19864,1 19960,0 20036,1 20136,0 20228,1 20298,0 20336,1 20376,0 20423,1 20429,0 20471,1 20552,0 20593,1 20690,0 20696,1 20734,0 20801,1 20849,0 20924,1 20951,0 20974,1 21015,0 21057,1 21101,0 21129,1 21179,0 21250,1 21270,0 21271,1 21277,0 21354,1 21445,0 21475,1 21478,0 21479,1 21491,0 21525,1 21580,0 21636,1 21667,0 21761,1 21797,0 21877,1 21894,0 21978,1 21991,0 22021,1 22050,0 22056,1 22058,0 22095,1 22143,0 22148,1 22173,0 22237,1 22265,0 22304,1 22365,0 22420,1 22461,0 22544,1 22607,0 22644,1 22743,0 22764,1 22808,0 22831,1 22881,0 22918,1 22926,0 22991,1 23011,0 23082,1 23154,0 23157,1 23232,0 23279,1 23339,0 23384,1 23391,0 23439,1 23493,0 23570,1 23575,0 23630,1 23722,0 23768,1 23788,0 23793,1 23845,0 23921,1 23988,0 24042,1 24091,0 24157,1 24218,0 24264,1 24339,0 24360,1 24453,0 24477,1 24513,0 24516,1 24526,0 24549,1 24558,0 24612,1 24630,0 24641,1 24683,0 24726,1 24738,0 24795,1 24824,0 24829,1 24903,0 24922,1 24995,0 25023,1 25096,0 25130,1 25132,0 25161,1 25191,0 25237,1 25259,0 25291,1 25317,0 25357,1 25373,0 25392,1 25481,0 25563,1 25648,0 25725,1 25760,0 25788,1 25888,0 25936,1 26003,0 26029,1 26065,0 26085,1 26117,0 26146,1 26178,0 26278,1 26295,0 26342,1 26356,0 26433,1 26444,0 26459,1 26532,0 26614,1 26701,0 26721,1 26776,0 26844,1 26861,0 26896,1 26927,0 26933,1 27009,0 27047,1 27110,0 27157,1 27165,0 27167,1 27203,0 27260,1 27295,0 27373,1 27449,0 27480,1 27561,0 27590,1 27662,0 27663,1 27739,0 27788,1 27887,0 27922,1 27948,0 27974,1 27982,0 28034,1 28071,0 28080,1 28158,0 28180,1 28240,0 28323,1 28334,0 28398,1 28453,0 28523,1 28599,0 28695,1 28776,0 28848,1 28912,0 28956,1 28972,0 29037,1 29106,0 29200,1 29289,0 29344,1 29374,0 29408,1 29452,0 29473,1 29491,0 29564,1 29575,0 29604,1 29678,0 29750,1 29762,0 29840,1 29921,0 30000,1 30057,0 30088,1 30118,0 30163,1 30232,0 30332,1 30376,0 30412,1 30477,0 30539,1 30612,0 30639,1 30640,0 30645,1 30739,0 30834,1 30906,0 30987,1 30996,0 31008,1 31067,0 31134,1 31164,0 31175,1 31250,0 31261,1 31262,0 31270,1 31288,0 31346,1 31363,0 31374,1 31431,0 31517,1 31528,0 31593,1 31627,0 31642,1 31667,0 31764,1 31822,0 31864,1 31869,0 31871,1 31923,0 31976,1 32006,0 32047,1 32065,0 32089,1 32113,0 32180,1 32265,0 32355,1 32429,0 32473,1 32475,0 32484,1 32570,0 32629,1 32689,0 32781,1 32855,0 32949,1 33027,0 33076,1 33124,0 33161,1 33233,0 33315,1 33332,0 33391,1 33426,0 33524,1 33571,0 33662,1 33663,0 33716,1 33781,0 33791,1 33844,0 33932,1 34008,0 34074,1 34086,0 34168,1 34234,0 34273,1 34354,0 34429,1 34506,0 34511,1 34529,0 34594,1 34628,0 34683,1 34704,0 34740,1 34789,0 34812,1 34815,0 34899,1 34972,0 35040,1 35083,0 35135,1 35180,0 35232,1 35332,0 35423,1 35465,0 35520,1 35537,0 35574,1 35650,0 35703,1 35748,0 35825,1 35873,0 35899,1 35981,0 36013,1 36041,0 36090,1 36092,0 36134,1 36145,0 36237,1 36271,0 36334,1 36377,0 36413,1 36443,0 36493,1 36582,0 36664,1 36728,0 36744,1 36831,0 36840,1 36847,0 36940,1 37022,0 37122,1 37152,0 37199,1 37240,0 37307,1 37321,0 37336,1 37363,0 37437,1 37449,0 37519,1 37559,0 37653,1 37714,0 37799,1 37877,0 37892,1 37964,0 37986,1 38076,0 38121,1 38215,0 38227,1 38236,0 38250,1 38328,0 38421,1 38448,0 38498,1 38517,0 38535,1 38573,0 38663,1 38723,0 38797,1 38835,0 38840,1 38903,0 38960,1 39018,0 39073,1 39081,0 39108,1 39164,0 39187,1 39256,0 39342,1 39400,0 39462,1 39470,0 39485,1 39548,0 39584,1 39595,0 39640,1 39739,0 39742,1 39836,0 39839,1 39907,0 39948,1 39982,0 40079,1 40115,0 40153,1 40236,0 40253,1 40266,0 40312,1 40386,0 40400,1 40423,0 40507,1 40518,0 40534,1 40597,0 40611,1 40675,0 40751,1 40776,0 40816,1 40850,0 40943,1 40986,0 41068,1 41153,0 41197,1 41240,0 41315,1 41403,0 41473,1 41554,0 41561,1 41633,0 41699,1 41738,0 41758,1 41805,0 41896,1 41956,0 41975,1 42033,0 42065,1 42120,0 42189,1 42266,0 42304,1 42335,0 42386,1 42458,0 42505,1 42558,0 42597,1 42613,0 42653,1 42721,0 42784,1 42791,0 42871,1 42876,0 42915,1 43011,0 43035,1 43131,0 43165,1 43183,0 43234,1 43237,0 43307,1 43329,0 43413,1 43486,0 43531,1 43619,0 43702,1 43751,0 43764,1 43838,0 43870,1 43940,0 44012,1 44084,0 44136,1 44215,0 44285,1 44331,0 44394,1 44397,0 44490,1 44507,0 44601,1 44613,0 44685,1 44710,0 44774,1 44789,0 44826,1 44849,0 44888,1 44945,0 44970,1 45039,0 45084,1 45124,0 45136,1 45235,0 45256,1 45285,0 45325,1 45340,0 45358,1 45376,0 45397,1 45451,0 45472,1 45491,0 45566,1 45600,0 45630,1 45704,0 45709,1 45775,0 45844,1 45846,0 45879,1 45897,0 45941,1 45948,0 45990,1 46017,0 46021,1 46085,0 46148,1 46220,0 46262,1 46289,0 46314,1 46336,0 46374,1 46474,0 46544,1 46611,0 46694,1 46741,0 46771,1 46791,0 46842,1 46933,0 46998,1 47005,0 47023,1 47030,0 47063,1 47095,0 47134,1 47234,0 47309,1 47342,0 47354,1 47379,0 47422,1 47472,0 47491,1 47514,0 47515,1 47523,0 47571,1 47662,0 47757,1 47758,0 47843,1 47888,0 47907,1 47915,0 47959,1 47965,0 47969,1 48036,0 48051,1 48148,0 48178,1 end initlist a23 0,0 48,1 54,0 91,1 152,0 194,1 272,0 326,1 410,0 484,1 558,0 654,1 721,0 811,1 839,0 880,1 959,0 1036,1 1045,0 1135,1 1233,0 1258,1 1351,0 1373,1 1419,0 1478,1 1543,0 1615,1 1653,0 1677,1 1715,0 1724,1 1790,0 1826,1 1895,0 1920,1 1985,0 2027,1 2054,0 2148,1 2154,0 2196,1 2212,0 2254,1 2270,0 2366,1 2460,0 2504,1 2505,0 2562,1 2596,0 2625,1 2693,0 2746,1 2812,0 2909,1 2929,0 2979,1 3033,0 3085,1 3122,0 3191,1 3197,0 3206,1 3296,0 3327,1 3359,0 3402,1 3420,0 3497,1 3596,0 3658,1 3670,0 3710,1 3753,0 3821,1 3842,0 3894,1 3908,0 3977,1 4051,0 4087,1 4151,0 4240,1 4318,0 4377,1 4443,0 4521,1 4571,0 4654,1 4657,0 4734,1 4806,0 4899,1 4925,0 4972,1 5039,0 5099,1 5114,0 5181,1 5279,0 5297,1 5318,0 5375,1 5425,0 5511,1 5592,0 5682,1 5747,0 5777,1 5790,0 5871,1 5963,0 6024,1 6091,0 6190,1 6226,0 6284,1 6349,0 6439,1 6456,0 6469,1 6485,0 6542,1 6573,0 6624,1 6652,0 6692,1 6705,0 6751,1 6792,0 6830,1 6878,0 6977,1 7032,0 7083,1 7117,0 7208,1 7302,0 7319,1 7341,0 7398,1 7488,0 7573,1 7596,0 7657,1 7667,0 7761,1 7834,0 7895,1 7903,0 7947,1 8025,0 8050,1 8130,0 8159,1 8171,0 8232,1 8254,0 8344,1 8371,0 8405,1 8443,0 8470,1 8520,0 8524,1 8583,0 8610,1 8621,0 8663,1 8733,0 8814,1 8884,0 8932,1 8995,0 9047,1 9089,0 9182,1 9241,0 9252,1 9308,0 9316,1 9344,0 9394,1 9467,0 9512,1 9530,0 9589,1 9598,0 9683,1 9765,0 9816,1 9908,0 9978,1 10072,0 10147,1 10186,0 10242,1 10265,0 10347,1 10425,0 10475,1 10483,0 10508,1 10516,0 10573,1 10629,0 10674,1 10741,0 10800,1 10858,0 10931,1 11014,0 11044,1 11113,0 11140,1 11239,0 11270,1 11360,0 11402,1 11441,0 11499,1 11502,0 11511,1 11609,0 11682,1 11703,0 11740,1 11778,0 11840,1 11885,0 11934,1 12008,0 12009,1 12099,0 12127,1 12188,0 12276,1 12355,0 12415,1 12450,0 12496,1 12522,0 12534,1 12539,0 12623,1 12697,0 12750,1 12841,0 12941,1 13020,0 13074,1 13139,0 13142,1 13215,0 13228,1 13276,0 13326,1 13385,0 13475,1 13514,0 13577,1 13664,0 13758,1 13772,0 13844,1 13891,0 13987,1 14065,0 14101,1 14162,0 14226,1 14315,0 14353,1 14395,0 14471,1 14504,0 14534,1 14606,0 14618,1 14687,0 14732,1 14748,0 14754,1 14810,0 14902,1 14918,0 14932,1 15009,0 15030,1 15123,0 15182,1 15271,0 15304,1 15367,0 15388,1 15395,0 15451,1 15453,0 15538,1 15560,0 15634,1 15703,0 15754,1 15756,0 15809,1 15863,0 15942,1 16015,0 16086,1 16120,0 16204,1 16297,0 16377,1 16473,0 16517,1 16563,0 16656,1 16721,0 16787,1 16839,0 16915,1 16931,0 17030,1 17066,0 17152,1 17166,0 17229,1 17240,0 17286,1 17313,0 17413,1 17471,0 17545,1 17629,0 17716,1 17727,0 17772,1 17829,0 17865,1 17901,0 17932,1 17957,0 17987,1 18063,0 18134,1 18167,0 18219,1 18252,0 18315,1 18409,0 18434,1 18526,0 18567,1 18662,0 18758,1 18835,0 18868,1 18881,0 18952,1 19029,0 19055,1 19108,0 19120,1 19140,0 19225,1 19291,0 19379,1 19467,0 19504,1 19514,0 19549,1 19635,0 19646,1 19671,0 19689,1 19709,0 19719,1 19723,0 19729,1 19796,0 19823,1 19900,0 19909,1 19973,0 20056,1 20146,0 20171,1 20230,0 20273,1 20327,0 20420,1 20444,0 20471,1 20486,0 20545,1 20636,0 20662,1 20724,0 20798,1 20818,0 20837,1 20855,0 20856,1 20921,0 20987,1 21039,0 21090,1 21188,0 21246,1 21281,0 21310,1 21396,0 21397,1 21410,0 21477,1 21479,0 21502,1 21577,0 21604,1 21694,0 21756,1 21833,0 21890,1 21892,0 21982,1 22018,0 22083,1 22139,0 22190,1 22206,0 22265,1 22298,0 22372,1 22427,0 22520,1 22567,0 22639,1 22682,0 22710,1 22770,0 22810,1 22879,0 22970,1 23012,0 23019,1 23101,0 23104,1 23204,0 23284,1 23292,0 23336,1 23436,0 23465,1 23534,0 23564,1 23661,0 23749,1 23800,0 23843,1 23902,0 23926,1 23948,0 23970,1 23985,0 24060,1 24109,0 24201,1 24271,0 24283,1 24334,0 24343,1 24438,0 24448,1 24536,0 24553,1 24621,0 24649,1 24707,0 24807,1 24836,0 24865,1 24872,0 24942,1 24955,0 25006,1 25015,0 25110,1 25124,0 25185,1 25259,0 25270,1 25317,0 25385,1 25458,0 25463,1 25551,0 25648,1 25652,0 25677,1 25682,0 25728,1 25813,0 25830,1 25832,0 25896,1 25900,0 25942,1 25985,0 26033,1 26085,0 26097,1 26125,0 26222,1 26299,0 26361,1 26428,0 26504,1 26586,0 26684,1 26686,0 26690,1 26784,0 26883,1 26898,0 26914,1 26969,0 26972,1 27053,0 27067,1 27162,0 27242,1 27342,0 27348,1 27424,0 27464,1 27491,0 27515,1 27524,0 27585,1 27679,0 27725,1 27749,0 27806,1 27823,0 27879,1 27913,0 27982,1 28026,0 28052,1 28096,0 28105,1 28166,0 28240,1 28268,0 28334,1 28362,0 28407,1 28442,0 28515,1 28563,0 28572,1 28665,0 28720,1 28773,0 28845,1 28934,0 29007,1 29016,0 29086,1 29090,0 29131,1 29221,0 29289,1 29302,0 29365,1 29449,0 29517,1 29607,0 29622,1 29679,0 29705,1 29758,0 29821,1 29914,0 29965,1 30058,0 30064,1 30120,0 30134,1 30136,0 30169,1 30258,0 30313,1 30373,0 30468,1 30536,0 30611,1 30658,0 30715,1 30802,0 30851,1 30919,0 30944,1 31032,0 31081,1 31122,0 31149,1 31152,0 31176,1 31210,0 31215,1 31247,0 31342,1 31386,0 31392,1 31418,0 31425,1 31460,0 31526,1 31606,0 31679,1 31773,0 31867,1 31884,0 31915,1 31998,0 32072,1 32114,0 32194,1 32206,0 32262,1 32284,0 32301,1 32320,0 32404,1 32460,0 32481,1 32515,0 32542,1 32556,0 32585,1 32646,0 32735,1 32795,0 32828,1 32911,0 32935,1 33026,0 33068,1 33152,0 33203,1 33215,0 33299,1 33376,0 33438,1 33460,0 33551,1 33620,0 33674,1 33701,0 33797,1 33876,0 33917,1 33988,0 34062,1 34077,0 34158,1 34213,0 34277,1 34296,0 34339,1 34373,0 34462,1 34479,0 34515,1 34554,0 34622,1 34677,0 34756,1 34827,0 34848,1 34911,0 34959,1 35044,0 35060,1 35078,0 35168,1 35259,0 35334,1 35417,0 35506,1 35535,0 35600,1 35618,0 35619,1 35706,0 35732,1 35771,0 35843,1 35846,0 35891,1 35926,0 35959,1 36001,0 36044,1 36121,0 36196,1 36279,0 36377,1 36413,0 36436,1 36529,0 36607,1 36621,0 36649,1 36710,0 36755,1 36760,0 36852,1 36870,0 36944,1 36997,0 37014,1 37094,0 37175,1 37215,0 37279,1 37344,0 37382,1 37416,0 37432,1 37514,0 37520,1 37542,0 37555,1 37640,0 37727,1 37770,0 37822,1 37851,0 37948,1 38046,0 38074,1 38083,0 38109,1 38203,0 38276,1 38280,0 38311,1 38367,0 38369,1 38439,0 38474,1 38476,0 38560,1 38605,0 38690,1 38692,0 38742,1 38752,0 38765,1 38777,0 38811,1 38854,0 38888,1 38912,0 38914,1 38976,0 39031,1 39110,0 39149,1 39249,0 39265,1 39359,0 39443,1 39448,0 39475,1 39556,0 39629,1 39701,0 39705,1 39793,0 39807,1 39855,0 39878,1 39941,0 40008,1 40018,0 40106,1 40143,0 40172,1 40233,0 40300,1 40320,0 40385,1 40437,0 40511,1 40578,0 40641,1 40666,0 40756,1 40818,0 40887,1 40965,0 41006,1 41090,0 41108,1 41110,0 41185,1 41225,0 41285,1 41364,0 41379,1 41444,0 41487,1 41584,0 41597,1 41615,0 41635,1 41726,0 41805,1 41836,0 41848,1 41876,0 41905,1 41987,0 42062,1 42085,0 42126,1 42184,0 42192,1 42252,0 42319,1 42390,0 42412,1 42438,0 42494,1 42527,0 42606,1 42703,0 42735,1 42749,0 42757,1 42826,0 42838,1 42840,0 42922,1 42938,0 42992,1 43002,0 43021,1 43058,0 43111,1 43129,0 43174,1 43266,0 43298,1 43382,0 43450,1 43550,0 43609,1 43657,0 43667,1 43756,0 43762,1 43850,0 43886,1 43903,0 43959,1 44012,0 44061,1 44140,0 44223,1 44292,0 44349,1 44414,0 44483,1 44548,0 44626,1 44643,0 44699,1 44785,0 44831,1 44883,0 44903,1 44924,0 44967,1 44982,0 45020,1 45076,0 45119,1 45151,0 45155,1 45182,0 45245,1 45294,0 45335,1 45383,0 45451,1 45472,0 45538,1 45560,0 45574,1 45666,0 45706,1 45768,0 45792,1 45818,0 45863,1 45871,0 45969,1 46049,0 46092,1 46113,0 46160,1 46162,0 46212,1 46224,0 46242,1 46248,0 46288,1 46366,0 46424,1 46507,0 46589,1 46669,0 46730,1 46818,0 46901,1 46988,0 47064,1 47155,0 47167,1 47203,0 47264,1 47345,0 47411,1 47480,0 47505,1 47587,0 47682,1 47701,0 47726,1 47789,0 47824,1 47880,0 47928,1 47976,0 48058,1 48082,0 48136,1 48146,0 48161,1 48255,0 48287,1 48328,0 48422,1 48489,0 48514,1 48558,0 48582,1 48634,0 48700,1 48713,0 48811,1 48861,0 48902,1 48973,0 49026,1 49049,0 49132,1 49210,0 49220,1 49317,0 49349,1 49352,0 49355,1 49385,0 49426,1 49495,0 49572,1 49649,0 49720,1 49765,0 49806,1 49855,0 49921,1 49993,0 50049,1 50125,0 50162,1 50201,0 50254,1 50353,0 50397,1 50446,0 50479,1 50523,0 50578,1 50614,0 50625,1 end initlist a24 0,0 30,1 85,0 176,1 189,0 227,1 317,0 388,1 425,0 450,1 466,0 565,1 602,0 656,1 697,0 762,1 832,0 857,1 953,0 1010,1 1101,0 1195,1 1232,0 1283,1 1383,0 1439,1 1473,0 1522,1 1587,0 1666,1 1766,0 1771,1 1785,0 1868,1 1909,0 1973,1 2050,0 2107,1 2168,0 2193,1 2291,0 2384,1 2468,0 2530,1 2594,0 2685,1 2775,0 2842,1 2907,0 2922,1 2980,0 3062,1 3139,0 3186,1 3204,0 3219,1 3316,0 3396,1 3410,0 3466,1 3530,0 3612,1 3661,0 3712,1 3777,0 3832,1 3842,0 3845,1 3851,0 3861,1 3877,0 3889,1 3972,0 3984,1 4017,0 4037,1 4119,0 4147,1 4194,0 4221,1 4315,0 4400,1 4499,0 4511,1 4593,0 4658,1 4743,0 4828,1 4896,0 4963,1 4971,0 5043,1 5057,0 5075,1 5156,0 5173,1 5179,0 5273,1 5281,0 5378,1 5413,0 5476,1 5515,0 5579,1 5649,0 5666,1 5733,0 5751,1 5759,0 5815,1 5907,0 5989,1 6073,0 6147,1 6237,0 6252,1 6286,0 6304,1 6321,0 6354,1 6385,0 6455,1 6549,0 6579,1 6637,0 6727,1 6778,0 6811,1 6866,0 6958,1 7046,0 7048,1 7138,0 7190,1 7253,0 7307,1 7385,0 7442,1 7539,0 7580,1 7660,0 7699,1 7738,0 7773,1 7808,0 7894,1 7980,0 8052,1 8143,0 8207,1 8291,0 8304,1 8344,0 8402,1 8476,0 8493,1 8530,0 8557,1 8568,0 8630,1 8716,0 8781,1 8798,0 8846,1 8919,0 9015,1 9100,0 9138,1 9141,0 9172,1 9179,0 9249,1 9281,0 9310,1 9332,0 9348,1 9445,0 9468,1 9560,0 9594,1 9639,0 9721,1 9798,0 9851,1 9875,0 9964,1 10024,0 10032,1 10129,0 10131,1 10192,0 10230,1 10262,0 10356,1 10367,0 10371,1 10376,0 10471,1 10485,0 10539,1 10616,0 10663,1 10727,0 10777,1 10811,0 10861,1 10879,0 10932,1 11029,0 11032,1 11109,0 11180,1 11203,0 11215,1 11303,0 11324,1 11399,0 11423,1 11439,0 11483,1 11573,0 11612,1 11680,0 11717,1 11754,0 11843,1 11878,0 11947,1 12035,0 12119,1 12120,0 12136,1 12234,0 12301,1 12315,0 12369,1 12439,0 12522,1 12592,0 12597,1 12639,0 12657,1 12739,0 12798,1 12821,0 12894,1 12991,0 13003,1 13036,0 13089,1 13109,0 13140,1 13170,0 13211,1 13308,0 13346,1 13378,0 13382,1 13424,0 13453,1 13488,0 13569,1 13570,0 13631,1 13714,0 13779,1 13794,0 13859,1 13946,0 13959,1 14008,0 14022,1 14084,0 14174,1 14266,0 14335,1 14380,0 14383,1 14406,0 14415,1 14436,0 14499,1 14584,0 14665,1 14719,0 14736,1 14757,0 14771,1 14821,0 14905,1 14986,0 15015,1 15028,0 15098,1 15112,0 15202,1 15292,0 15369,1 15432,0 15474,1 15552,0 15637,1 15653,0 15657,1 15688,0 15737,1 15830,0 15920,1 15982,0 16043,1 16117,0 16192,1 16262,0 16279,1 16376,0 16436,1 16473,0 16500,1 16543,0 16561,1 16635,0 16697,1 16723,0 16736,1 16789,0 16887,1 16948,0 17007,1 17075,0 17139,1 17187,0 17210,1 17250,0 17265,1 17286,0 17291,1 17327,0 17349,1 17443,0 17487,1 17568,0 17632,1 17685,0 17690,1 17790,0 17870,1 17877,0 17879,1 17888,0 17912,1 18003,0 18101,1 18128,0 18200,1 18288,0 18371,1 18449,0 18450,1 18491,0 18565,1 18640,0 18705,1 18709,0 18805,1 18869,0 18879,1 18882,0 18911,1 18923,0 18964,1 18999,0 19053,1 19102,0 19180,1 19260,0 19279,1 19370,0 19416,1 19462,0 19473,1 19497,0 19515,1 19544,0 19644,1 19721,0 19760,1 19809,0 19837,1 19927,0 19961,1 19977,0 20003,1 20020,0 20087,1 20184,0 20190,1 20290,0 20339,1 20366,0 20431,1 20460,0 20519,1 20580,0 20673,1 20714,0 20757,1 20817,0 20829,1 20835,0 20857,1 20956,0 20988,1 21026,0 21055,1 21096,0 21106,1 21116,0 21183,1 21256,0 21319,1 21405,0 21452,1 21535,0 21566,1 21633,0 21688,1 21781,0 21830,1 21882,0 21949,1 21975,0 21999,1 22052,0 22139,1 22218,0 22298,1 22301,0 22363,1 22424,0 22463,1 22471,0 22478,1 22565,0 22584,1 22619,0 22693,1 22723,0 22806,1 22905,0 22906,1 22942,0 22985,1 23011,0 23063,1 23137,0 23156,1 23253,0 23345,1 23421,0 23501,1 23553,0 23559,1 23631,0 23643,1 23691,0 23728,1 23811,0 23882,1 23951,0 23967,1 24022,0 24093,1 24123,0 24153,1 24176,0 24240,1 24297,0 24329,1 24419,0 24517,1 24558,0 24560,1 24604,0 24695,1 24720,0 24763,1 24802,0 24820,1 24908,0 24980,1 25025,0 25042,1 25106,0 25166,1 25223,0 25269,1 25327,0 25421,1 25485,0 25576,1 25612,0 25650,1 25705,0 25779,1 25810,0 25896,1 25964,0 25990,1 26083,0 26131,1 26223,0 26241,1 26246,0 26332,1 26392,0 26489,1 26499,0 26500,1 26560,0 26648,1 26705,0 26707,1 26755,0 26820,1 26879,0 26976,1 26981,0 27078,1 27103,0 27184,1 27266,0 27320,1 27338,0 27363,1 27379,0 27437,1 27452,0 27475,1 27536,0 27553,1 27618,0 27633,1 27681,0 27747,1 27781,0 27857,1 27882,0 27908,1 28002,0 28058,1 28106,0 28166,1 28232,0 28291,1 28306,0 28332,1 28363,0 28433,1 28519,0 28602,1 28697,0 28763,1 28795,0 28828,1 28872,0 28879,1 28921,0 28984,1 29014,0 29049,1 29101,0 29196,1 29265,0 29360,1 29443,0 29446,1 29508,0 29526,1 29610,0 29615,1 29623,0 29662,1 29732,0 29744,1 29787,0 29866,1 29880,0 29913,1 29992,0 29993,1 30067,0 30146,1 30204,0 30255,1 30315,0 30332,1 30382,0 30423,1 30468,0 30567,1 30598,0 30601,1 30610,0 30618,1 30643,0 30660,1 30744,0 30778,1 30864,0 30884,1 30893,0 30915,1 30978,0 31054,1 31111,0 31165,1 31243,0 31257,1 31263,0 31333,1 31359,0 31421,1 31513,0 31603,1 31669,0 31676,1 31762,0 31778,1 31791,0 31867,1 31886,0 31915,1 31941,0 31979,1 32007,0 32054,1 32123,0 32136,1 32203,0 32206,1 32260,0 32300,1 32327,0 32416,1 32481,0 32571,1 32620,0 32678,1 32725,0 32751,1 32785,0 32806,1 32820,0 32848,1 32860,0 32889,1 32984,0 33084,1 33152,0 33202,1 33267,0 33309,1 33366,0 33378,1 33456,0 33538,1 33547,0 33599,1 33664,0 33700,1 33709,0 33732,1 33737,0 33739,1 33776,0 33804,1 33858,0 33891,1 33902,0 33988,1 34087,0 34135,1 34232,0 34326,1 34351,0 34369,1 34407,0 34466,1 34553,0 34599,1 34673,0 34763,1 34826,0 34828,1 34922,0 35002,1 35004,0 35007,1 35056,0 35080,1 35132,0 35141,1 35149,0 35245,1 35271,0 35341,1 35391,0 35417,1 35421,0 35448,1 35543,0 35613,1 35689,0 35775,1 35844,0 35926,1 36010,0 36029,1 36072,0 36125,1 36149,0 36218,1 36220,0 36308,1 36351,0 36383,1 36468,0 36547,1 36557,0 36603,1 36694,0 36784,1 36793,0 36852,1 36949,0 37012,1 37075,0 37115,1 37214,0 37312,1 37357,0 37397,1 37466,0 37552,1 37644,0 37722,1 37822,0 37921,1 38011,0 38106,1 38197,0 38201,1 38300,0 38389,1 38488,0 38532,1 38542,0 38609,1 38620,0 38662,1 38709,0 38795,1 38888,0 38965,1 39033,0 39118,1 39213,0 39258,1 39305,0 39396,1 39474,0 39505,1 39547,0 39616,1 39706,0 39787,1 39835,0 39934,1 39986,0 40034,1 40055,0 40123,1 40134,0 40186,1 40187,0 40189,1 40218,0 40293,1 40321,0 40393,1 40414,0 40447,1 40535,0 40565,1 40617,0 40654,1 40683,0 40689,1 40703,0 40725,1 40802,0 40859,1 40918,0 40952,1 40955,0 41013,1 41061,0 41158,1 41168,0 41201,1 41239,0 41312,1 41390,0 41395,1 41457,0 41532,1 41540,0 41541,1 41589,0 41611,1 41659,0 41737,1 41835,0 41848,1 41865,0 41891,1 41941,0 42020,1 42049,0 42099,1 42190,0 42282,1 42292,0 42348,1 42379,0 42440,1 42477,0 42494,1 42546,0 42591,1 42604,0 42676,1 42753,0 42783,1 42877,0 42936,1 42977,0 43066,1 43162,0 43247,1 43272,0 43319,1 43341,0 43383,1 43454,0 43535,1 43595,0 43618,1 43672,0 43730,1 43750,0 43764,1 43853,0 43925,1 43941,0 43984,1 43998,0 44050,1 44091,0 44180,1 44267,0 44344,1 44379,0 44475,1 44531,0 44583,1 44663,0 44688,1 44773,0 44776,1 44820,0 44826,1 44884,0 44962,1 45030,0 45114,1 45152,0 45193,1 45215,0 45238,1 45273,0 45337,1 45430,0 45496,1 45508,0 45588,1 45629,0 45649,1 45747,0 45786,1 45837,0 45842,1 45856,0 45861,1 45957,0 46036,1 46054,0 46087,1 46137,0 46183,1 46203,0 46302,1 46370,0 46382,1 46436,0 46477,1 46490,0 46517,1 46562,0 46603,1 46659,0 46663,1 46711,0 46783,1 46792,0 46823,1 46922,0 46985,1 47012,0 47073,1 47136,0 47209,1 47308,0 47402,1 47442,0 47465,1 47494,0 47560,1 47605,0 47702,1 47775,0 47807,1 47809,0 47867,1 47912,0 47929,1 48023,0 48064,1 48157,0 48188,1 48257,0 48290,1 48336,0 48360,1 48383,0 48472,1 48557,0 48560,1 48585,0 48683,1 48729,0 48734,1 48753,0 48766,1 48817,0 48898,1 48928,0 49001,1 49070,0 49158,1 49231,0 49331,1 49427,0 49466,1 49468,0 49480,1 49544,0 49619,1 49679,0 49710,1 49735,0 49761,1 49825,0 49840,1 49861,0 49955,1 49977,0 50047,1 50126,0 50174,1 50256,0 50297,1 50388,0 50450,1 50469,0 50508,1 50557,0 50591,1 50684,0 50701,1 50724,0 50766,1 end initlist a25 0,0 2,1 6,0 17,1 69,0 156,1 200,0 271,1 354,0 412,1 433,0 472,1 503,0 507,1 591,0 672,1 716,0 726,1 747,0 782,1 816,0 890,1 943,0 1021,1 1102,0 1107,1 1137,0 1161,1 1169,0 1171,1 1217,0 1266,1 1274,0 1308,1 1395,0 1480,1 1510,0 1553,1 1562,0 1603,1 1683,0 1772,1 1860,0 1949,1 2037,0 2132,1 2211,0 2272,1 2313,0 2393,1 2467,0 2492,1 2540,0 2618,1 2691,0 2696,1 2732,0 2759,1 2815,0 2842,1 2876,0 2877,1 2880,0 2902,1 2939,0 2950,1 2982,0 3013,1 3066,0 3159,1 3168,0 3207,1 3284,0 3310,1 3331,0 3338,1 3402,0 3483,1 3514,0 3608,1 3620,0 3623,1 3675,0 3721,1 3767,0 3800,1 3864,0 3892,1 3965,0 4043,1 4088,0 4108,1 4207,0 4241,1 4281,0 4293,1 4360,0 4437,1 4485,0 4532,1 4568,0 4626,1 4717,0 4733,1 4820,0 4856,1 4920,0 4971,1 5048,0 5063,1 5064,0 5089,1 5108,0 5142,1 5147,0 5175,1 5257,0 5346,1 5356,0 5441,1 5520,0 5542,1 5600,0 5690,1 5771,0 5833,1 5919,0 5958,1 5975,0 6018,1 6083,0 6173,1 6217,0 6233,1 6322,0 6407,1 6495,0 6500,1 6595,0 6685,1 6779,0 6813,1 6846,0 6861,1 6895,0 6925,1 6961,0 7042,1 7121,0 7202,1 7287,0 7330,1 7430,0 7461,1 7503,0 7525,1 7593,0 7604,1 7657,0 7703,1 7711,0 7789,1 7853,0 7882,1 7951,0 8051,1 8142,0 8180,1 8255,0 8269,1 8272,0 8360,1 8409,0 8501,1 8585,0 8588,1 8654,0 8690,1 8781,0 8844,1 8915,0 8985,1 9054,0 9149,1 9243,0 9250,1 9346,0 9443,1 9477,0 9479,1 9531,0 9581,1 9641,0 9735,1 9823,0 9844,1 9857,0 9950,1 10016,0 10061,1 10116,0 10131,1 10141,0 10157,1 10183,0 10278,1 10356,0 10408,1 10500,0 10578,1 10630,0 10713,1 10803,0 10806,1 10854,0 10923,1 10952,0 10977,1 11075,0 11118,1 11125,0 11131,1 11179,0 11193,1 11209,0 11273,1 11353,0 11425,1 11456,0 11526,1 11621,0 11709,1 11741,0 11795,1 11871,0 11938,1 12009,0 12107,1 12141,0 12195,1 12232,0 12254,1 12338,0 12363,1 12393,0 12435,1 12478,0 12480,1 12490,0 12542,1 12602,0 12618,1 12691,0 12785,1 12807,0 12890,1 12935,0 12970,1 13070,0 13091,1 13172,0 13196,1 13264,0 13339,1 13361,0 13461,1 13514,0 13520,1 13592,0 13601,1 13614,0 13642,1 13701,0 13751,1 13842,0 13854,1 13898,0 13912,1 13950,0 13965,1 14026,0 14122,1 14171,0 14209,1 14305,0 14310,1 14382,0 14438,1 14505,0 14577,1 14654,0 14660,1 14694,0 14743,1 14837,0 14838,1 14910,0 14932,1 14969,0 14981,1 15035,0 15078,1 15128,0 15188,1 15272,0 15361,1 15380,0 15462,1 15486,0 15514,1 15545,0 15602,1 15631,0 15654,1 15670,0 15723,1 15783,0 15786,1 15809,0 15827,1 15891,0 15986,1 16024,0 16081,1 16168,0 16177,1 16248,0 16327,1 16334,0 16396,1 16443,0 16507,1 16561,0 16651,1 16747,0 16795,1 16838,0 16898,1 16970,0 16984,1 17006,0 17018,1 17101,0 17152,1 17196,0 17200,1 17205,0 17258,1 17287,0 17350,1 17431,0 17435,1 17439,0 17488,1 17555,0 17625,1 17670,0 17724,1 17789,0 17806,1 17879,0 17946,1 17960,0 17971,1 17981,0 18016,1 18062,0 18157,1 18221,0 18313,1 18395,0 18450,1 18490,0 18509,1 18606,0 18608,1 18707,0 18743,1 18815,0 18828,1 18861,0 18904,1 18991,0 19018,1 19076,0 19142,1 19185,0 19189,1 19284,0 19311,1 19361,0 19435,1 19450,0 19465,1 19565,0 19655,1 19678,0 19766,1 19847,0 19935,1 19993,0 20032,1 20109,0 20117,1 20184,0 20237,1 20319,0 20338,1 20436,0 20526,1 20599,0 20694,1 20762,0 20844,1 20858,0 20891,1 20924,0 20989,1 21000,0 21064,1 21121,0 21143,1 21211,0 21264,1 21310,0 21404,1 21419,0 21454,1 21496,0 21563,1 21654,0 21691,1 21759,0 21830,1 21845,0 21862,1 21952,0 22015,1 22072,0 22164,1 22173,0 22204,1 22274,0 22348,1 22372,0 22452,1 22528,0 22555,1 22638,0 22673,1 22706,0 22709,1 22734,0 22758,1 22793,0 22868,1 22926,0 23003,1 23080,0 23098,1 23110,0 23199,1 23218,0 23224,1 23236,0 23307,1 23322,0 23329,1 23371,0 23425,1 23467,0 23547,1 23633,0 23702,1 23711,0 23731,1 23756,0 23772,1 23842,0 23867,1 23920,0 23981,1 24045,0 24060,1 24142,0 24154,1 24231,0 24329,1 24348,0 24405,1 24468,0 24561,1 24614,0 24638,1 24716,0 24803,1 24883,0 24981,1 25024,0 25052,1 25087,0 25162,1 25245,0 25304,1 25313,0 25390,1 25395,0 25397,1 25497,0 25537,1 25567,0 25634,1 25726,0 25763,1 25778,0 25822,1 25833,0 25868,1 25874,0 25881,1 25893,0 25964,1 25965,0 26038,1 26042,0 26081,1 26172,0 26255,1 26288,0 26348,1 26358,0 26411,1 26433,0 26448,1 26507,0 26587,1 26672,0 26718,1 26721,0 26777,1 26840,0 26841,1 26864,0 26933,1 26934,0 26947,1 26989,0 27069,1 27142,0 27188,1 27218,0 27264,1 27324,0 27406,1 27464,0 27468,1 27552,0 27574,1 27587,0 27610,1 27664,0 27717,1 27735,0 27815,1 27858,0 27937,1 27974,0 28059,1 28121,0 28122,1 28180,0 28254,1 28282,0 28337,1 28379,0 28411,1 28461,0 28497,1 28512,0 28590,1 28676,0 28704,1 28709,0 28746,1 28841,0 28902,1 28971,0 29040,1 29073,0 29162,1 29224,0 29313,1 29316,0 29328,1 29342,0 29428,1 29435,0 29508,1 29512,0 29551,1 29559,0 29615,1 29691,0 29740,1 29768,0 29773,1 29831,0 29912,1 29942,0 29967,1 29986,0 30047,1 30116,0 30174,1 30182,0 30214,1 30226,0 30240,1 30298,0 30397,1 30465,0 30532,1 30570,0 30649,1 30671,0 30694,1 30794,0 30877,1 30932,0 31000,1 31034,0 31046,1 31056,0 31092,1 31165,0 31208,1 31279,0 31305,1 31361,0 31438,1 31511,0 31544,1 31579,0 31628,1 31715,0 31789,1 31863,0 31906,1 31972,0 31986,1 31990,0 32001,1 32010,0 32079,1 32138,0 32209,1 32247,0 32297,1 32343,0 32377,1 32436,0 32511,1 32561,0 32637,1 32665,0 32691,1 32702,0 32726,1 32728,0 32741,1 32775,0 32822,1 32829,0 32879,1 32926,0 32987,1 33049,0 33127,1 33161,0 33179,1 33238,0 33323,1 33417,0 33463,1 33488,0 33525,1 33596,0 33637,1 33663,0 33688,1 33745,0 33808,1 33904,0 33999,1 34016,0 34081,1 34153,0 34253,1 34292,0 34303,1 34304,0 34323,1 34413,0 34501,1 34586,0 34680,1 34715,0 34771,1 34858,0 34900,1 34925,0 35017,1 35075,0 35155,1 35181,0 35221,1 35281,0 35366,1 35448,0 35513,1 35583,0 35632,1 35683,0 35712,1 35780,0 35863,1 35880,0 35921,1 35962,0 36030,1 36040,0 36128,1 36212,0 36235,1 36302,0 36398,1 36437,0 36470,1 36566,0 36611,1 36708,0 36752,1 36755,0 36836,1 36854,0 36868,1 36968,0 37064,1 37129,0 37228,1 37302,0 37383,1 37455,0 37512,1 37599,0 37693,1 37788,0 37873,1 37945,0 37961,1 38031,0 38034,1 38046,0 38086,1 38130,0 38207,1 38295,0 38356,1 38367,0 38374,1 38414,0 38449,1 38503,0 38520,1 38545,0 38600,1 38627,0 38727,1 38777,0 38867,1 38880,0 38926,1 38955,0 38993,1 39066,0 39164,1 39260,0 39308,1 39350,0 39445,1 39486,0 39578,1 39629,0 39721,1 39788,0 39831,1 39924,0 40009,1 40055,0 40148,1 40167,0 40242,1 40269,0 40317,1 40403,0 40430,1 40462,0 40507,1 40562,0 40588,1 40664,0 40731,1 40758,0 40796,1 40840,0 40841,1 40853,0 40924,1 40997,0 41042,1 41080,0 41156,1 41216,0 41271,1 41338,0 41404,1 41454,0 41537,1 41582,0 41648,1 41738,0 41750,1 41835,0 41897,1 41968,0 42039,1 42074,0 42123,1 42133,0 42175,1 42207,0 42250,1 42258,0 42340,1 42425,0 42429,1 42481,0 42530,1 42534,0 42620,1 42693,0 42771,1 42787,0 42789,1 42858,0 42938,1 43018,0 43066,1 43139,0 43170,1 43267,0 43313,1 43377,0 43440,1 43447,0 43478,1 43563,0 43651,1 43712,0 43805,1 43844,0 43867,1 43889,0 43986,1 44058,0 44091,1 44130,0 44148,1 44182,0 44200,1 44250,0 44324,1 44379,0 44447,1 44493,0 44570,1 44642,0 44741,1 44789,0 44871,1 44958,0 44998,1 45056,0 45091,1 45126,0 45134,1 45224,0 45280,1 45380,0 45411,1 45470,0 45487,1 45515,0 45580,1 45615,0 45678,1 45773,0 45803,1 45814,0 45848,1 45887,0 45931,1 46002,0 46021,1 46065,0 46070,1 46166,0 46223,1 46307,0 46379,1 46475,0 46562,1 46612,0 46617,1 46685,0 46718,1 46802,0 46834,1 46857,0 46880,1 46897,0 46916,1 46950,0 47035,1 47077,0 47172,1 47197,0 47226,1 47324,0 47383,1 47388,0 47461,1 47554,0 47610,1 47683,0 47733,1 47766,0 47857,1 47932,0 47993,1 48010,0 48034,1 48043,0 48130,1 48148,0 48187,1 48255,0 48271,1 48352,0 48380,1 48397,0 48422,1 48458,0 48480,1 48555,0 48580,1 48582,0 48603,1 48635,0 48718,1 48760,0 48844,1 48935,0 48962,1 48979,0 49041,1 49069,0 49117,1 49120,0 49155,1 49172,0 49253,1 49301,0 49389,1 49469,0 49527,1 49624,0 49642,1 49705,0 49764,1 49787,0 49788,1 49866,0 49956,1 49975,0 49976,1 49977,0 50002,1 50093,0 50096,1 50109,0 50153,1 end initlist a26 0,0 57,1 101,0 113,1 122,0 156,1 238,0 242,1 253,0 343,1 396,0 436,1 514,0 541,1 554,0 637,1 703,0 720,1 761,0 791,1 825,0 883,1 926,0 982,1 1082,0 1112,1 1191,0 1195,1 1220,0 1240,1 1244,0 1250,1 1253,0 1270,1 1358,0 1417,1 1433,0 1518,1 1600,0 1692,1 1729,0 1789,1 1816,0 1855,1 1941,0 2012,1 2085,0 2089,1 2103,0 2176,1 2226,0 2251,1 2297,0 2362,1 2400,0 2419,1 2467,0 2471,1 2565,0 2621,1 2675,0 2688,1 2766,0 2860,1 2864,0 2872,1 2972,0 3041,1 3087,0 3117,1 3169,0 3259,1 3329,0 3372,1 3428,0 3498,1 3589,0 3680,1 3724,0 3810,1 3889,0 3968,1 4043,0 4077,1 4126,0 4162,1 4187,0 4193,1 4276,0 4279,1 4350,0 4375,1 4434,0 4479,1 4522,0 4523,1 4557,0 4597,1 4668,0 4758,1 4781,0 4848,1 4930,0 5017,1 5068,0 5129,1 5198,0 5253,1 5280,0 5290,1 5376,0 5419,1 5479,0 5578,1 5620,0 5636,1 5723,0 5819,1 5821,0 5826,1 5915,0 6009,1 6094,0 6136,1 6219,0 6315,1 6402,0 6478,1 6537,0 6586,1 6638,0 6707,1 6782,0 6808,1 6896,0 6995,1 7039,0 7062,1 7102,0 7185,1 7226,0 7241,1 7329,0 7414,1 7429,0 7514,1 7605,0 7705,1 7732,0 7764,1 7845,0 7856,1 7914,0 7924,1 7963,0 8047,1 8076,0 8140,1 8200,0 8228,1 8286,0 8325,1 8384,0 8398,1 8425,0 8516,1 8547,0 8558,1 8621,0 8639,1 8695,0 8727,1 8806,0 8897,1 8915,0 8924,1 8936,0 9025,1 9097,0 9166,1 9183,0 9249,1 9336,0 9344,1 9441,0 9484,1 9517,0 9530,1 9607,0 9695,1 9699,0 9731,1 9748,0 9774,1 9834,0 9903,1 9945,0 10031,1 10114,0 10174,1 10246,0 10314,1 10403,0 10489,1 10525,0 10526,1 10567,0 10569,1 10635,0 10728,1 10771,0 10866,1 10893,0 10921,1 10930,0 10957,1 10977,0 10991,1 11043,0 11065,1 11155,0 11197,1 11256,0 11349,1 11358,0 11373,1 11383,0 11452,1 11524,0 11621,1 11720,0 11753,1 11844,0 11922,1 11941,0 12015,1 12050,0 12097,1 12133,0 12143,1 12234,0 12334,1 12380,0 12447,1 12469,0 12544,1 12635,0 12671,1 12761,0 12838,1 12876,0 12913,1 12976,0 13000,1 13014,0 13102,1 13143,0 13215,1 13287,0 13293,1 13356,0 13414,1 13438,0 13449,1 13519,0 13572,1 13634,0 13636,1 13698,0 13761,1 13842,0 13868,1 13902,0 13956,1 14050,0 14121,1 14140,0 14159,1 14241,0 14244,1 14274,0 14373,1 14465,0 14500,1 14573,0 14594,1 14628,0 14677,1 14761,0 14804,1 14885,0 14959,1 15036,0 15103,1 15107,0 15116,1 15183,0 15191,1 15245,0 15257,1 15291,0 15292,1 15339,0 15371,1 15406,0 15420,1 15439,0 15490,1 15558,0 15644,1 15658,0 15742,1 15832,0 15901,1 15945,0 15955,1 16017,0 16094,1 16125,0 16166,1 16236,0 16296,1 16396,0 16425,1 16480,0 16550,1 16595,0 16679,1 16681,0 16723,1 16761,0 16785,1 16810,0 16861,1 16907,0 16975,1 17031,0 17087,1 17136,0 17172,1 17198,0 17291,1 17346,0 17443,1 17536,0 17633,1 17700,0 17756,1 17783,0 17810,1 17818,0 17890,1 17966,0 18060,1 18073,0 18098,1 18194,0 18271,1 18337,0 18362,1 18376,0 18386,1 18483,0 18499,1 18513,0 18562,1 18657,0 18709,1 18751,0 18789,1 18825,0 18869,1 18920,0 18979,1 19055,0 19064,1 19081,0 19109,1 19165,0 19169,1 19213,0 19251,1 19301,0 19400,1 19467,0 19562,1 19577,0 19641,1 19737,0 19781,1 19785,0 19797,1 19879,0 19938,1 19941,0 20026,1 20035,0 20051,1 20089,0 20116,1 20170,0 20255,1 20266,0 20311,1 20400,0 20424,1 20523,0 20536,1 20606,0 20655,1 20697,0 20762,1 20853,0 20867,1 20959,0 21027,1 21060,0 21141,1 21182,0 21203,1 21285,0 21368,1 21374,0 21440,1 21504,0 21561,1 21569,0 21605,1 21686,0 21776,1 21850,0 21917,1 21948,0 21986,1 22086,0 22097,1 22179,0 22192,1 22255,0 22281,1 22282,0 22302,1 22389,0 22427,1 22440,0 22454,1 22475,0 22521,1 22606,0 22624,1 22703,0 22796,1 22811,0 22853,1 22938,0 22995,1 23090,0 23180,1 23227,0 23292,1 23364,0 23454,1 23507,0 23599,1 23618,0 23639,1 23699,0 23715,1 23777,0 23877,1 23937,0 24000,1 24001,0 24085,1 24183,0 24201,1 24286,0 24313,1 24384,0 24479,1 24520,0 24556,1 24593,0 24603,1 24692,0 24709,1 24763,0 24773,1 24868,0 24924,1 25014,0 25077,1 25095,0 25164,1 25236,0 25295,1 25331,0 25416,1 25489,0 25522,1 25606,0 25623,1 25722,0 25761,1 25796,0 25808,1 25841,0 25910,1 25923,0 25983,1 26027,0 26058,1 26127,0 26173,1 26262,0 26334,1 26430,0 26459,1 26482,0 26550,1 26598,0 26610,1 26708,0 26723,1 26774,0 26872,1 26909,0 26965,1 26971,0 27022,1 27086,0 27157,1 27181,0 27249,1 27287,0 27339,1 27407,0 27432,1 27452,0 27456,1 27490,0 27581,1 27599,0 27623,1 27654,0 27753,1 27823,0 27884,1 27976,0 28004,1 28092,0 28139,1 28227,0 28265,1 28296,0 28317,1 28322,0 28367,1 28404,0 28477,1 28496,0 28538,1 28623,0 28638,1 28665,0 28757,1 28796,0 28881,1 28913,0 28956,1 29025,0 29042,1 29100,0 29127,1 29221,0 29308,1 29382,0 29411,1 29467,0 29529,1 29548,0 29620,1 29679,0 29739,1 29786,0 29825,1 29892,0 29902,1 29908,0 29993,1 30060,0 30131,1 30198,0 30210,1 30216,0 30222,1 30245,0 30258,1 30356,0 30449,1 30518,0 30541,1 30544,0 30577,1 30584,0 30612,1 30637,0 30645,1 30664,0 30712,1 30804,0 30870,1 30908,0 30937,1 30939,0 30960,1 30980,0 31050,1 31115,0 31194,1 31266,0 31359,1 31432,0 31464,1 31473,0 31533,1 31617,0 31634,1 31714,0 31771,1 31864,0 31876,1 31903,0 31920,1 31991,0 31998,1 32091,0 32132,1 32206,0 32272,1 32283,0 32315,1 32319,0 32409,1 32425,0 32478,1 32489,0 32512,1 32602,0 32702,1 32738,0 32759,1 32842,0 32923,1 32973,0 32985,1 32986,0 33039,1 33080,0 33160,1 33202,0 33254,1 33259,0 33304,1 33332,0 33346,1 33434,0 33472,1 33567,0 33662,1 33730,0 33820,1 33877,0 33920,1 33975,0 34036,1 34054,0 34135,1 34228,0 34327,1 34397,0 34489,1 34557,0 34644,1 34719,0 34736,1 34788,0 34854,1 34921,0 34935,1 34941,0 34943,1 35032,0 35118,1 35184,0 35262,1 35352,0 35371,1 35430,0 35467,1 35542,0 35547,1 35627,0 35636,1 35658,0 35711,1 35804,0 35840,1 35899,0 35911,1 35994,0 36044,1 36143,0 36179,1 36232,0 36254,1 36353,0 36433,1 36493,0 36572,1 36603,0 36637,1 36717,0 36750,1 36841,0 36901,1 36975,0 37045,1 37069,0 37167,1 37189,0 37197,1 37293,0 37338,1 37431,0 37463,1 37484,0 37584,1 37626,0 37700,1 37761,0 37858,1 37932,0 37996,1 38057,0 38139,1 38208,0 38254,1 38352,0 38355,1 38416,0 38490,1 38571,0 38621,1 38684,0 38706,1 38787,0 38880,1 38913,0 38987,1 39060,0 39126,1 39203,0 39283,1 39359,0 39383,1 39390,0 39423,1 39492,0 39540,1 39614,0 39658,1 39725,0 39742,1 39825,0 39919,1 39980,0 40012,1 40076,0 40087,1 40146,0 40196,1 40284,0 40301,1 40310,0 40345,1 40440,0 40468,1 40490,0 40510,1 40573,0 40600,1 40644,0 40692,1 40733,0 40784,1 40825,0 40850,1 40874,0 40936,1 40956,0 41040,1 41076,0 41172,1 41233,0 41305,1 41322,0 41357,1 41374,0 41415,1 41511,0 41603,1 41679,0 41763,1 41830,0 41837,1 41910,0 41976,1 42044,0 42061,1 42156,0 42202,1 42236,0 42313,1 42385,0 42456,1 42538,0 42633,1 42654,0 42714,1 42783,0 42834,1 42898,0 42899,1 42957,0 43012,1 43058,0 43113,1 43198,0 43249,1 43259,0 43321,1 43390,0 43455,1 43547,0 43613,1 43637,0 43699,1 43738,0 43837,1 43885,0 43902,1 43976,0 44070,1 44143,0 44222,1 44293,0 44334,1 44414,0 44482,1 44520,0 44601,1 44602,0 44660,1 44685,0 44723,1 44727,0 44812,1 44837,0 44877,1 44888,0 44897,1 44951,0 44960,1 44996,0 45008,1 45057,0 45098,1 45106,0 45185,1 45228,0 45246,1 45319,0 45370,1 45404,0 45408,1 45498,0 45519,1 45546,0 45585,1 45655,0 45735,1 45778,0 45784,1 45833,0 45838,1 45844,0 45943,1 45963,0 46035,1 46080,0 46131,1 46225,0 46286,1 46309,0 46374,1 46466,0 46480,1 46496,0 46563,1 46624,0 46634,1 46668,0 46768,1 46819,0 46853,1 46888,0 46915,1 46999,0 47030,1 47110,0 47124,1 47132,0 47200,1 47240,0 47245,1 47288,0 47335,1 47370,0 47395,1 47408,0 47492,1 47534,0 47585,1 47644,0 47673,1 47763,0 47764,1 47794,0 47873,1 47907,0 47927,1 47940,0 48037,1 48074,0 48120,1 48163,0 48220,1 48264,0 48339,1 48395,0 48396,1 48432,0 48518,1 48541,0 48578,1 48641,0 48734,1 48805,0 48844,1 48906,0 48955,1 48981,0 49022,1 49066,0 49074,1 49134,0 49178,1 49219,0 49267,1 49360,0 49405,1 49431,0 49474,1 49499,0 49521,1 49614,0 49647,1 49692,0 49706,1 49741,0 49804,1 49818,0 49914,1 49990,0 50037,1 50126,0 50223,1 50262,0 50358,1 50387,0 50423,1 50479,0 50483,1 50543,0 50612,1 50695,0 50774,1 50857,0 50937,1 51018,0 51090,1 end initlist a27 0,0 86,1 109,0 140,1 219,0 263,1 287,0 316,1 344,0 392,1 420,0 441,1 446,0 530,1 622,0 720,1 802,0 883,1 953,0 1053,1 1065,0 1164,1 1249,0 1303,1 1314,0 1391,1 1455,0 1516,1 1593,0 1685,1 1738,0 1763,1 1772,0 1862,1 1886,0 1892,1 1932,0 1960,1 1994,0 2092,1 2119,0 2126,1 2153,0 2219,1 2222,0 2223,1 2301,0 2347,1 2418,0 2479,1 2574,0 2662,1 2711,0 2725,1 2784,0 2793,1 2817,0 2863,1 2891,0 2915,1 2966,0 3038,1 3044,0 3128,1 3130,0 3154,1 3166,0 3210,1 3270,0 3332,1 3395,0 3440,1 3497,0 3578,1 3588,0 3624,1 3715,0 3737,1 3741,0 3823,1 3847,0 3884,1 3885,0 3887,1 3952,0 4014,1 4091,0 4178,1 4232,0 4320,1 4354,0 4446,1 4495,0 4517,1 4574,0 4600,1 4691,0 4708,1 4758,0 4826,1 4917,0 4968,1 4982,0 5032,1 5126,0 5208,1 5264,0 5283,1 5356,0 5365,1 5451,0 5491,1 5586,0 5639,1 5719,0 5763,1 5835,0 5899,1 5962,0 6028,1 6077,0 6129,1 6181,0 6276,1 6278,0 6319,1 6369,0 6411,1 6424,0 6458,1 6529,0 6564,1 6645,0 6662,1 6723,0 6819,1 6869,0 6871,1 6910,0 7000,1 7013,0 7048,1 7102,0 7124,1 7150,0 7210,1 7232,0 7234,1 7285,0 7286,1 7383,0 7472,1 7521,0 7610,1 7708,0 7776,1 7851,0 7922,1 7968,0 8052,1 8104,0 8202,1 8236,0 8254,1 8337,0 8386,1 8414,0 8427,1 8512,0 8551,1 8630,0 8680,1 8703,0 8766,1 8835,0 8914,1 8982,0 8994,1 9050,0 9087,1 9112,0 9125,1 9129,0 9138,1 9142,0 9202,1 9263,0 9312,1 9367,0 9389,1 9419,0 9420,1 9422,0 9497,1 9516,0 9615,1 9677,0 9749,1 9798,0 9844,1 9915,0 9922,1 10015,0 10111,1 10210,0 10258,1 10326,0 10357,1 10397,0 10440,1 10496,0 10499,1 10555,0 10597,1 10631,0 10721,1 10790,0 10837,1 10875,0 10914,1 10916,0 10974,1 11034,0 11089,1 11160,0 11214,1 11309,0 11349,1 11378,0 11452,1 11487,0 11586,1 11675,0 11724,1 11816,0 11893,1 11948,0 11956,1 12040,0 12120,1 12177,0 12246,1 12290,0 12359,1 12441,0 12495,1 12574,0 12585,1 12633,0 12721,1 12774,0 12836,1 12864,0 12939,1 12964,0 13002,1 13010,0 13096,1 13127,0 13191,1 13258,0 13297,1 13298,0 13300,1 13386,0 13409,1 13480,0 13559,1 13568,0 13588,1 13590,0 13638,1 13639,0 13713,1 13773,0 13855,1 13944,0 14041,1 14120,0 14131,1 14163,0 14183,1 14269,0 14357,1 14406,0 14429,1 14477,0 14535,1 14605,0 14631,1 14717,0 14730,1 14818,0 14858,1 14874,0 14937,1 14984,0 15083,1 15131,0 15223,1 15289,0 15377,1 15453,0 15471,1 15528,0 15547,1 15586,0 15612,1 15636,0 15684,1 15759,0 15806,1 15878,0 15928,1 16006,0 16063,1 16126,0 16158,1 16256,0 16289,1 16290,0 16317,1 16348,0 16367,1 16445,0 16493,1 16505,0 16533,1 16577,0 16604,1 16702,0 16710,1 16759,0 16792,1 16886,0 16888,1 16983,0 17017,1 17058,0 17082,1 17113,0 17199,1 17238,0 17327,1 17384,0 17411,1 17469,0 17534,1 17629,0 17709,1 17757,0 17809,1 17874,0 17910,1 17964,0 18011,1 18097,0 18191,1 18203,0 18239,1 18330,0 18346,1 18373,0 18376,1 18405,0 18462,1 18557,0 18560,1 18579,0 18612,1 18707,0 18737,1 18786,0 18846,1 18898,0 18925,1 18945,0 18992,1 19025,0 19075,1 19153,0 19213,1 19252,0 19299,1 19386,0 19433,1 19435,0 19496,1 19583,0 19626,1 19640,0 19725,1 19802,0 19888,1 19942,0 19989,1 19995,0 20017,1 20056,0 20066,1 20120,0 20136,1 20236,0 20314,1 20326,0 20411,1 20484,0 20505,1 20554,0 20607,1 20619,0 20663,1 20758,0 20852,1 20944,0 20974,1 21017,0 21074,1 21077,0 21125,1 21211,0 21238,1 21239,0 21317,1 21328,0 21355,1 21379,0 21380,1 21466,0 21478,1 21510,0 21596,1 21606,0 21696,1 21728,0 21733,1 21752,0 21773,1 21814,0 21869,1 21904,0 21981,1 22068,0 22090,1 22144,0 22190,1 22220,0 22259,1 22317,0 22389,1 22414,0 22490,1 22507,0 22599,1 22605,0 22702,1 22735,0 22767,1 22796,0 22834,1 22842,0 22852,1 22941,0 23031,1 23106,0 23182,1 23189,0 23230,1 23243,0 23341,1 23408,0 23447,1 23458,0 23529,1 23570,0 23583,1 23612,0 23693,1 23732,0 23783,1 23844,0 23866,1 23875,0 23881,1 23944,0 24042,1 24136,0 24185,1 24234,0 24273,1 24340,0 24393,1 24466,0 24515,1 24593,0 24682,1 24775,0 24815,1 24880,0 24952,1 24969,0 24981,1 25054,0 25066,1 25102,0 25180,1 25208,0 25227,1 25260,0 25277,1 25320,0 25322,1 25366,0 25389,1 25435,0 25471,1 25545,0 25581,1 25595,0 25634,1 25659,0 25708,1 25709,0 25809,1 25823,0 25910,1 25986,0 25994,1 26058,0 26061,1 26152,0 26215,1 26307,0 26369,1 26382,0 26482,1 26557,0 26652,1 26726,0 26809,1 26871,0 26905,1 26932,0 27013,1 27086,0 27135,1 27169,0 27175,1 27192,0 27288,1 27342,0 27360,1 27370,0 27416,1 27477,0 27492,1 27565,0 27614,1 27632,0 27696,1 27730,0 27814,1 27880,0 27947,1 27988,0 28065,1 28101,0 28166,1 28178,0 28260,1 28300,0 28374,1 28429,0 28502,1 28559,0 28582,1 28590,0 28645,1 28707,0 28733,1 28743,0 28796,1 28871,0 28926,1 28939,0 29037,1 29079,0 29143,1 29165,0 29264,1 29327,0 29371,1 29376,0 29391,1 29452,0 29533,1 29572,0 29636,1 29671,0 29685,1 29751,0 29802,1 29821,0 29841,1 29884,0 29965,1 30024,0 30099,1 30177,0 30275,1 30362,0 30433,1 30435,0 30447,1 30492,0 30579,1 30587,0 30648,1 30700,0 30779,1 30864,0 30944,1 30982,0 31049,1 31083,0 31171,1 31216,0 31307,1 31322,0 31379,1 31424,0 31426,1 31469,0 31477,1 31571,0 31624,1 31631,0 31690,1 31788,0 31859,1 31915,0 31938,1 31973,0 32070,1 32093,0 32145,1 32194,0 32288,1 32293,0 32350,1 32398,0 32420,1 32427,0 32501,1 32518,0 32603,1 32658,0 32740,1 32793,0 32866,1 32916,0 33006,1 33025,0 33111,1 33195,0 33274,1 33295,0 33304,1 33324,0 33377,1 33383,0 33454,1 33552,0 33595,1 33688,0 33710,1 33799,0 33848,1 33851,0 33897,1 33928,0 33997,1 34020,0 34052,1 34076,0 34115,1 34178,0 34249,1 34335,0 34350,1 34407,0 34480,1 34513,0 34568,1 34620,0 34707,1 34760,0 34837,1 34917,0 34948,1 34954,0 35000,1 35013,0 35023,1 35099,0 35174,1 35204,0 35240,1 35317,0 35405,1 35451,0 35531,1 35619,0 35712,1 35801,0 35807,1 35888,0 35951,1 35963,0 36009,1 36072,0 36147,1 36246,0 36291,1 36323,0 36325,1 36413,0 36501,1 36518,0 36579,1 36627,0 36664,1 36745,0 36836,1 36873,0 36889,1 36966,0 37048,1 37148,0 37215,1 37262,0 37312,1 37344,0 37392,1 37419,0 37433,1 37438,0 37493,1 37541,0 37640,1 37660,0 37752,1 37808,0 37892,1 37925,0 37995,1 38016,0 38033,1 38104,0 38152,1 38226,0 38268,1 38314,0 38400,1 38406,0 38455,1 38516,0 38549,1 38648,0 38713,1 38796,0 38871,1 38917,0 38922,1 39016,0 39111,1 39192,0 39242,1 39338,0 39436,1 39520,0 39532,1 39582,0 39589,1 39603,0 39636,1 39658,0 39691,1 39717,0 39753,1 39838,0 39893,1 39962,0 40029,1 40129,0 40135,1 40161,0 40231,1 40310,0 40325,1 40332,0 40392,1 40394,0 40408,1 40459,0 40514,1 40539,0 40549,1 40577,0 40578,1 40602,0 40636,1 40640,0 40643,1 40667,0 40711,1 40801,0 40856,1 40899,0 40982,1 41008,0 41055,1 41085,0 41169,1 41221,0 41279,1 41357,0 41383,1 41407,0 41476,1 41506,0 41533,1 41623,0 41716,1 41799,0 41809,1 41899,0 41904,1 41921,0 41922,1 41934,0 42010,1 42066,0 42117,1 42207,0 42264,1 42277,0 42365,1 42463,0 42528,1 42582,0 42622,1 42686,0 42708,1 42800,0 42806,1 42837,0 42869,1 42916,0 42981,1 43036,0 43091,1 43184,0 43192,1 43271,0 43297,1 43386,0 43397,1 43412,0 43488,1 43503,0 43551,1 43637,0 43665,1 43732,0 43738,1 43740,0 43802,1 43896,0 43920,1 43966,0 44007,1 44077,0 44079,1 44110,0 44150,1 44200,0 44297,1 44361,0 44427,1 44524,0 44556,1 44655,0 44707,1 44788,0 44845,1 44906,0 44980,1 45072,0 45127,1 45171,0 45211,1 45254,0 45331,1 45354,0 45414,1 45464,0 45513,1 45556,0 45603,1 45642,0 45680,1 45685,0 45755,1 45841,0 45929,1 45971,0 46007,1 46077,0 46171,1 46225,0 46280,1 46370,0 46442,1 46532,0 46604,1 46689,0 46754,1 46812,0 46820,1 46847,0 46854,1 46906,0 46912,1 46950,0 46968,1 47009,0 47052,1 47121,0 47141,1 47156,0 47252,1 47336,0 47349,1 47401,0 47439,1 47465,0 47545,1 47641,0 47686,1 47733,0 47787,1 47854,0 47859,1 47937,0 47971,1 48041,0 48121,1 48141,0 48220,1 48225,0 48252,1 48332,0 48350,1 48393,0 48419,1 48465,0 48545,1 48645,0 48649,1 48652,0 48734,1 48760,0 48844,1 48861,0 48914,1 48959,0 49041,1 49074,0 49079,1 49103,0 49175,1 49199,0 49268,1 49335,0 49360,1 49402,0 49481,1 49495,0 49507,1 49537,0 49550,1 49633,0 49652,1 49710,0 49755,1 49813,0 49860,1 49899,0 49904,1 49916,0 49943,1 end initlist a28 0,0 38,1 72,0 74,1 159,0 210,1 218,0 302,1 390,0 470,1 490,0 510,1 562,0 624,1 692,0 762,1 814,0 817,1 826,0 907,1 992,0 1078,1 1157,0 1218,1 1308,0 1400,1 1401,0 1469,1 1558,0 1653,1 1697,0 1720,1 1738,0 1800,1 1854,0 1893,1 1993,0 2009,1 2030,0 2120,1 2167,0 2198,1 2227,0 2295,1 2337,0 2430,1 2513,0 2522,1 2594,0 2641,1 2684,0 2724,1 2784,0 2822,1 2906,0 2998,1 3082,0 3106,1 3174,0 3188,1 3254,0 3342,1 3359,0 3369,1 3464,0 3555,1 3583,0 3641,1 3700,0 3738,1 3817,0 3893,1 3954,0 3969,1 3972,0 4007,1 4107,0 4119,1 4126,0 4157,1 4239,0 4270,1 4272,0 4286,1 4378,0 4451,1 4482,0 4489,1 4552,0 4583,1 4609,0 4624,1 4656,0 4702,1 4788,0 4835,1 4869,0 4875,1 4883,0 4896,1 4943,0 4976,1 5064,0 5106,1 5119,0 5176,1 5217,0 5297,1 5394,0 5458,1 5464,0 5553,1 5592,0 5597,1 5655,0 5660,1 5703,0 5726,1 5817,0 5892,1 5984,0 6006,1 6069,0 6098,1 6172,0 6199,1 6215,0 6300,1 6334,0 6357,1 6405,0 6492,1 6591,0 6681,1 6729,0 6780,1 6848,0 6863,1 6888,0 6903,1 6917,0 6982,1 7012,0 7092,1 7150,0 7250,1 7325,0 7364,1 7440,0 7513,1 7597,0 7660,1 7730,0 7810,1 7897,0 7988,1 8012,0 8060,1 8111,0 8117,1 8172,0 8241,1 8323,0 8373,1 8393,0 8462,1 8516,0 8550,1 8609,0 8685,1 8706,0 8793,1 8870,0 8885,1 8959,0 9030,1 9118,0 9161,1 9181,0 9266,1 9275,0 9296,1 9321,0 9368,1 9444,0 9521,1 9545,0 9635,1 9664,0 9707,1 9779,0 9867,1 9924,0 10021,1 10092,0 10095,1 10170,0 10257,1 10352,0 10430,1 10521,0 10586,1 10658,0 10675,1 10744,0 10794,1 10836,0 10904,1 10947,0 10990,1 11066,0 11166,1 11223,0 11267,1 11346,0 11384,1 11439,0 11472,1 11496,0 11530,1 11552,0 11627,1 11702,0 11743,1 11765,0 11864,1 11953,0 12033,1 12036,0 12061,1 12148,0 12190,1 12226,0 12231,1 12266,0 12312,1 12397,0 12478,1 12536,0 12619,1 12635,0 12728,1 12738,0 12780,1 12807,0 12818,1 12901,0 12952,1 12969,0 13014,1 13053,0 13103,1 13172,0 13237,1 13272,0 13334,1 13414,0 13479,1 13573,0 13621,1 13622,0 13633,1 13722,0 13775,1 13820,0 13911,1 13924,0 13974,1 14045,0 14124,1 14205,0 14241,1 14277,0 14322,1 14368,0 14385,1 14396,0 14399,1 14479,0 14568,1 14658,0 14721,1 14745,0 14809,1 14818,0 14907,1 14984,0 15037,1 15044,0 15079,1 15098,0 15147,1 15183,0 15215,1 15284,0 15317,1 15362,0 15378,1 15412,0 15475,1 15562,0 15602,1 15667,0 15721,1 15735,0 15743,1 15746,0 15833,1 15850,0 15927,1 15939,0 16018,1 16087,0 16125,1 16127,0 16161,1 16227,0 16311,1 16354,0 16415,1 16450,0 16454,1 16511,0 16560,1 16579,0 16607,1 16651,0 16656,1 16720,0 16734,1 16752,0 16811,1 16883,0 16983,1 17009,0 17022,1 17058,0 17068,1 17098,0 17113,1 17124,0 17169,1 17205,0 17214,1 17239,0 17249,1 17299,0 17346,1 17410,0 17432,1 17502,0 17584,1 17617,0 17630,1 17699,0 17730,1 17744,0 17842,1 17907,0 17939,1 17968,0 18019,1 18112,0 18163,1 18193,0 18224,1 18277,0 18348,1 18386,0 18478,1 18483,0 18557,1 18653,0 18740,1 18829,0 18856,1 18872,0 18949,1 19004,0 19078,1 19082,0 19180,1 19228,0 19315,1 19412,0 19502,1 19580,0 19668,1 19675,0 19679,1 19774,0 19804,1 19809,0 19841,1 19846,0 19889,1 19895,0 19974,1 20002,0 20044,1 20074,0 20134,1 20167,0 20250,1 20341,0 20428,1 20503,0 20543,1 20591,0 20687,1 20775,0 20869,1 20921,0 21005,1 21010,0 21021,1 21037,0 21129,1 21225,0 21289,1 21296,0 21377,1 21390,0 21409,1 21505,0 21571,1 21637,0 21641,1 21737,0 21832,1 21914,0 21980,1 21988,0 22055,1 22067,0 22086,1 22145,0 22244,1 22259,0 22329,1 22375,0 22443,1 22491,0 22557,1 22642,0 22733,1 22798,0 22859,1 22902,0 22985,1 23009,0 23107,1 23119,0 23160,1 23172,0 23219,1 23307,0 23337,1 23345,0 23437,1 23483,0 23582,1 23654,0 23676,1 23680,0 23740,1 23831,0 23881,1 23914,0 23949,1 23954,0 23967,1 24041,0 24101,1 24125,0 24206,1 24251,0 24252,1 24286,0 24380,1 24419,0 24433,1 24530,0 24540,1 24543,0 24634,1 24676,0 24723,1 24790,0 24795,1 24862,0 24961,1 25036,0 25076,1 25160,0 25187,1 25222,0 25276,1 25374,0 25416,1 25498,0 25588,1 25631,0 25690,1 25749,0 25750,1 25778,0 25831,1 25890,0 25908,1 25964,0 25973,1 26004,0 26053,1 26152,0 26244,1 26251,0 26290,1 26313,0 26390,1 26446,0 26456,1 26529,0 26582,1 26677,0 26766,1 26825,0 26910,1 26993,0 27059,1 27126,0 27220,1 27304,0 27383,1 27444,0 27452,1 27519,0 27543,1 27589,0 27686,1 27747,0 27817,1 27818,0 27828,1 27865,0 27944,1 27959,0 28003,1 28085,0 28101,1 28119,0 28203,1 28251,0 28346,1 28423,0 28450,1 28509,0 28539,1 28595,0 28623,1 28696,0 28781,1 28803,0 28839,1 28881,0 28898,1 28925,0 28975,1 29065,0 29144,1 29200,0 29237,1 29316,0 29354,1 29378,0 29461,1 29468,0 29565,1 29628,0 29638,1 29713,0 29798,1 29872,0 29925,1 29978,0 30027,1 30104,0 30125,1 30219,0 30297,1 30314,0 30406,1 30496,0 30593,1 30666,0 30734,1 30827,0 30837,1 30896,0 30939,1 31015,0 31101,1 31171,0 31182,1 31213,0 31257,1 31311,0 31353,1 31378,0 31429,1 31491,0 31555,1 31561,0 31630,1 31643,0 31729,1 31757,0 31816,1 31896,0 31936,1 32007,0 32107,1 32194,0 32288,1 32376,0 32416,1 32479,0 32535,1 32610,0 32703,1 32798,0 32851,1 32920,0 32988,1 33029,0 33034,1 33113,0 33167,1 33217,0 33314,1 33351,0 33404,1 33477,0 33569,1 33586,0 33647,1 33653,0 33706,1 33745,0 33827,1 33898,0 33948,1 34007,0 34076,1 34106,0 34158,1 34195,0 34226,1 34249,0 34310,1 34388,0 34454,1 34541,0 34632,1 34633,0 34657,1 34747,0 34820,1 34914,0 34957,1 35048,0 35128,1 35164,0 35249,1 35330,0 35357,1 35404,0 35465,1 35556,0 35644,1 35741,0 35812,1 35826,0 35856,1 35868,0 35869,1 35967,0 36052,1 36117,0 36123,1 36207,0 36247,1 36300,0 36395,1 36443,0 36453,1 36544,0 36617,1 36621,0 36717,1 36798,0 36882,1 36919,0 37018,1 37083,0 37127,1 37177,0 37255,1 37337,0 37423,1 37488,0 37539,1 37562,0 37574,1 37627,0 37723,1 37765,0 37812,1 37813,0 37886,1 37923,0 37958,1 38057,0 38128,1 38139,0 38236,1 38253,0 38262,1 38349,0 38394,1 38446,0 38474,1 38487,0 38574,1 38591,0 38641,1 38732,0 38819,1 38836,0 38848,1 38872,0 38880,1 38913,0 38940,1 39037,0 39056,1 39114,0 39145,1 39176,0 39235,1 39255,0 39355,1 39384,0 39446,1 39460,0 39511,1 39589,0 39684,1 39770,0 39859,1 39885,0 39926,1 39994,0 40070,1 40094,0 40158,1 40250,0 40305,1 40394,0 40414,1 40480,0 40511,1 40541,0 40615,1 40644,0 40649,1 40673,0 40710,1 40771,0 40850,1 40867,0 40872,1 40906,0 40943,1 40983,0 40989,1 41043,0 41059,1 41095,0 41155,1 41195,0 41206,1 41242,0 41284,1 41342,0 41409,1 41425,0 41478,1 41519,0 41584,1 41679,0 41766,1 41794,0 41798,1 41879,0 41926,1 42005,0 42087,1 42179,0 42181,1 42219,0 42266,1 42295,0 42363,1 42446,0 42469,1 42565,0 42657,1 42717,0 42760,1 42779,0 42795,1 42852,0 42869,1 42914,0 42999,1 43070,0 43122,1 43140,0 43200,1 43227,0 43301,1 43374,0 43469,1 43539,0 43627,1 43639,0 43665,1 43728,0 43786,1 43837,0 43849,1 43938,0 44012,1 44103,0 44196,1 44239,0 44328,1 44424,0 44470,1 44503,0 44565,1 44570,0 44609,1 44636,0 44685,1 44733,0 44818,1 44910,0 45007,1 45072,0 45134,1 45220,0 45231,1 45284,0 45331,1 45340,0 45349,1 45426,0 45519,1 45613,0 45659,1 45726,0 45778,1 45834,0 45838,1 45916,0 45924,1 45967,0 46038,1 46085,0 46103,1 46143,0 46199,1 46253,0 46267,1 46296,0 46323,1 46393,0 46428,1 46432,0 46438,1 46463,0 46488,1 46576,0 46616,1 46693,0 46705,1 46723,0 46754,1 46829,0 46866,1 46870,0 46946,1 46962,0 46993,1 47032,0 47058,1 47098,0 47099,1 47185,0 47251,1 47295,0 47360,1 47379,0 47456,1 47500,0 47586,1 47606,0 47636,1 47725,0 47761,1 47829,0 47865,1 47913,0 48001,1 48033,0 48073,1 48090,0 48182,1 48230,0 48315,1 48324,0 48331,1 48391,0 48410,1 48456,0 48531,1 48585,0 48609,1 48681,0 48760,1 48784,0 48870,1 48902,0 48967,1 49013,0 49047,1 49101,0 49179,1 49271,0 49304,1 49363,0 49381,1 49455,0 49502,1 49565,0 49627,1 49632,0 49717,1 49727,0 49764,1 49813,0 49901,1 49903,0 49940,1 50003,0 50101,1 50171,0 50202,1 50287,0 50374,1 50442,0 50504,1 50527,0 50572,1 50595,0 50691,1 50699,0 50712,1 50756,0 50847,1 50886,0 50936,1 51019,0 51105,1 51113,0 51146,1 51241,0 51332,1 51411,0 51419,1 51470,0 51528,1 51534,0 51545,1 51602,0 51605,1 51703,0 51730,1 51773,0 51797,1 end initlist a29 0,0 87,1 119,0 121,1 195,0 286,1 332,0 422,1 462,0 490,1 554,0 636,1 708,0 791,1 822,0 824,1 880,0 973,1 1072,0 1107,1 1133,0 1205,1 1280,0 1295,1 1371,0 1442,1 1497,0 1561,1 1613,0 1669,1 1694,0 1753,1 1782,0 1852,1 1936,0 2036,1 2109,0 2207,1 2217,0 2229,1 2280,0 2285,1 2297,0 2368,1 2443,0 2465,1 2527,0 2549,1 2568,0 2611,1 2626,0 2648,1 2721,0 2761,1 2785,0 2814,1 2892,0 2910,1 2976,0 3030,1 3096,0 3105,1 3174,0 3207,1 3302,0 3341,1 3419,0 3468,1 3532,0 3581,1 3674,0 3677,1 3726,0 3729,1 3776,0 3794,1 3873,0 3904,1 3929,0 3984,1 4076,0 4167,1 4178,0 4264,1 4306,0 4352,1 4382,0 4456,1 4470,0 4551,1 4601,0 4605,1 4695,0 4755,1 4774,0 4783,1 4862,0 4885,1 4891,0 4974,1 5031,0 5085,1 5137,0 5226,1 5313,0 5363,1 5395,0 5402,1 5409,0 5494,1 5554,0 5564,1 5664,0 5700,1 5757,0 5855,1 5925,0 5976,1 6005,0 6054,1 6138,0 6163,1 6207,0 6288,1 6293,0 6335,1 6416,0 6462,1 6505,0 6554,1 6647,0 6660,1 6674,0 6732,1 6831,0 6900,1 6929,0 7023,1 7113,0 7126,1 7218,0 7254,1 7332,0 7421,1 7464,0 7519,1 7603,0 7685,1 7739,0 7818,1 7882,0 7923,1 8008,0 8010,1 8088,0 8135,1 8191,0 8285,1 8327,0 8364,1 8414,0 8422,1 8442,0 8473,1 8506,0 8564,1 8659,0 8680,1 8690,0 8752,1 8759,0 8775,1 8827,0 8838,1 8930,0 8961,1 9054,0 9092,1 9173,0 9209,1 9262,0 9277,1 9377,0 9458,1 9494,0 9522,1 9612,0 9703,1 9731,0 9817,1 9854,0 9949,1 9979,0 10049,1 10114,0 10173,1 10198,0 10282,1 10330,0 10332,1 10341,0 10425,1 10447,0 10511,1 10523,0 10589,1 10676,0 10747,1 10824,0 10916,1 10953,0 10966,1 11062,0 11129,1 11179,0 11274,1 11337,0 11391,1 11430,0 11462,1 11547,0 11571,1 11577,0 11661,1 11700,0 11789,1 11797,0 11876,1 11901,0 11968,1 12005,0 12082,1 12178,0 12191,1 12216,0 12246,1 12278,0 12337,1 12340,0 12377,1 12470,0 12530,1 12599,0 12610,1 12676,0 12742,1 12821,0 12857,1 12931,0 12994,1 13057,0 13104,1 13146,0 13238,1 13301,0 13316,1 13410,0 13463,1 13502,0 13594,1 13693,0 13762,1 13808,0 13866,1 13963,0 13972,1 14013,0 14031,1 14115,0 14195,1 14275,0 14342,1 14352,0 14368,1 14451,0 14476,1 14564,0 14593,1 14606,0 14629,1 14708,0 14752,1 14798,0 14866,1 14876,0 14968,1 15029,0 15106,1 15107,0 15136,1 15171,0 15245,1 15330,0 15337,1 15364,0 15428,1 15465,0 15492,1 15524,0 15589,1 15618,0 15620,1 15711,0 15774,1 15871,0 15944,1 15963,0 15966,1 16053,0 16111,1 16137,0 16192,1 16196,0 16206,1 16226,0 16227,1 16301,0 16310,1 16391,0 16434,1 16481,0 16533,1 16579,0 16633,1 16660,0 16687,1 16747,0 16834,1 16925,0 16987,1 17062,0 17157,1 17209,0 17291,1 17340,0 17407,1 17445,0 17509,1 17552,0 17625,1 17683,0 17690,1 17732,0 17760,1 17821,0 17903,1 17980,0 18000,1 18042,0 18117,1 18215,0 18225,1 18230,0 18236,1 18274,0 18359,1 18407,0 18491,1 18551,0 18641,1 18659,0 18660,1 18724,0 18785,1 18879,0 18969,1 19069,0 19139,1 19224,0 19263,1 19272,0 19336,1 19342,0 19422,1 19521,0 19554,1 19651,0 19671,1 19697,0 19779,1 19804,0 19866,1 19949,0 19959,1 20048,0 20103,1 20158,0 20206,1 20214,0 20279,1 20348,0 20350,1 20360,0 20391,1 20472,0 20516,1 20554,0 20644,1 20737,0 20780,1 20864,0 20897,1 20972,0 20975,1 21064,0 21161,1 21198,0 21256,1 21260,0 21282,1 21330,0 21343,1 21433,0 21498,1 21579,0 21635,1 21656,0 21716,1 21754,0 21791,1 21802,0 21820,1 21920,0 21972,1 21984,0 22038,1 22040,0 22084,1 22180,0 22217,1 22248,0 22257,1 22299,0 22355,1 22447,0 22455,1 22495,0 22592,1 22647,0 22709,1 22727,0 22794,1 22891,0 22912,1 22956,0 22989,1 23010,0 23073,1 23130,0 23175,1 23226,0 23312,1 23400,0 23429,1 23488,0 23576,1 23639,0 23698,1 23758,0 23775,1 23825,0 23863,1 23961,0 23985,1 24060,0 24104,1 24140,0 24194,1 24284,0 24285,1 24358,0 24422,1 24483,0 24513,1 24523,0 24594,1 24686,0 24757,1 24762,0 24862,1 24884,0 24944,1 25025,0 25098,1 25131,0 25230,1 25258,0 25307,1 25313,0 25412,1 25463,0 25479,1 25570,0 25598,1 25677,0 25689,1 25779,0 25817,1 25840,0 25873,1 25937,0 25953,1 26033,0 26130,1 26215,0 26247,1 26300,0 26396,1 26421,0 26513,1 26541,0 26557,1 26654,0 26733,1 26766,0 26830,1 26852,0 26927,1 26952,0 26969,1 26995,0 27024,1 27123,0 27193,1 27206,0 27208,1 27245,0 27246,1 27292,0 27319,1 27382,0 27473,1 27564,0 27565,1 27651,0 27731,1 27788,0 27862,1 27938,0 28007,1 28088,0 28140,1 28216,0 28315,1 28336,0 28338,1 28341,0 28382,1 28449,0 28524,1 28538,0 28557,1 28603,0 28645,1 28693,0 28762,1 28772,0 28836,1 28935,0 28946,1 29001,0 29014,1 29112,0 29171,1 29242,0 29313,1 29358,0 29410,1 29453,0 29553,1 29564,0 29565,1 29600,0 29628,1 29688,0 29703,1 29756,0 29851,1 29898,0 29960,1 30029,0 30097,1 30107,0 30115,1 30173,0 30246,1 30284,0 30375,1 30397,0 30440,1 30533,0 30585,1 30647,0 30688,1 30769,0 30825,1 30893,0 30957,1 31055,0 31085,1 31120,0 31162,1 31232,0 31249,1 31317,0 31391,1 31411,0 31479,1 31507,0 31534,1 31555,0 31561,1 31567,0 31622,1 31637,0 31638,1 31650,0 31651,1 31739,0 31765,1 31850,0 31865,1 31957,0 32028,1 32085,0 32138,1 32169,0 32265,1 32321,0 32365,1 32446,0 32465,1 32538,0 32634,1 32727,0 32769,1 32830,0 32857,1 32927,0 32971,1 33063,0 33110,1 33142,0 33202,1 33209,0 33307,1 33370,0 33464,1 33499,0 33510,1 33578,0 33630,1 33659,0 33749,1 33761,0 33861,1 33935,0 33941,1 33980,0 34032,1 34121,0 34191,1 34242,0 34300,1 34320,0 34403,1 34499,0 34570,1 34631,0 34720,1 34733,0 34819,1 34847,0 34911,1 34954,0 35035,1 35104,0 35152,1 35246,0 35270,1 35285,0 35345,1 35428,0 35430,1 35515,0 35529,1 35546,0 35611,1 35631,0 35649,1 35694,0 35733,1 35759,0 35760,1 35842,0 35853,1 35872,0 35907,1 35971,0 36026,1 36113,0 36171,1 36268,0 36307,1 36356,0 36415,1 36416,0 36513,1 36581,0 36612,1 36639,0 36665,1 36676,0 36683,1 36723,0 36808,1 36848,0 36880,1 36957,0 37046,1 37136,0 37206,1 37270,0 37315,1 37396,0 37460,1 37536,0 37625,1 37637,0 37709,1 37754,0 37816,1 37912,0 37950,1 37989,0 38023,1 38118,0 38121,1 38133,0 38228,1 38326,0 38347,1 38420,0 38440,1 38464,0 38501,1 38538,0 38634,1 38725,0 38790,1 38821,0 38879,1 38891,0 38931,1 39024,0 39107,1 39137,0 39196,1 39235,0 39266,1 39308,0 39309,1 39402,0 39460,1 39551,0 39646,1 39734,0 39774,1 39866,0 39875,1 39918,0 39955,1 39965,0 40043,1 40087,0 40187,1 40190,0 40246,1 40263,0 40347,1 40404,0 40451,1 40460,0 40544,1 40624,0 40721,1 40771,0 40864,1 40897,0 40928,1 41012,0 41016,1 41021,0 41024,1 41035,0 41094,1 41194,0 41282,1 41351,0 41403,1 41422,0 41508,1 41577,0 41649,1 41736,0 41814,1 41914,0 41972,1 41980,0 42062,1 42122,0 42126,1 42211,0 42291,1 42344,0 42369,1 42382,0 42400,1 42408,0 42472,1 42496,0 42570,1 42659,0 42726,1 42727,0 42779,1 42817,0 42831,1 42905,0 42963,1 43007,0 43065,1 43090,0 43124,1 43171,0 43241,1 43246,0 43338,1 43432,0 43433,1 43435,0 43531,1 43566,0 43596,1 43618,0 43666,1 43761,0 43767,1 43770,0 43847,1 43907,0 43911,1 43924,0 43926,1 44009,0 44060,1 44084,0 44092,1 44135,0 44181,1 44262,0 44344,1 44415,0 44441,1 44508,0 44539,1 44580,0 44629,1 44667,0 44740,1 44791,0 44801,1 44814,0 44816,1 44904,0 44961,1 45031,0 45075,1 45121,0 45214,1 45311,0 45357,1 45427,0 45456,1 45509,0 45566,1 45660,0 45668,1 45724,0 45775,1 45835,0 45865,1 45871,0 45954,1 46036,0 46115,1 46214,0 46281,1 46340,0 46376,1 46427,0 46514,1 46565,0 46650,1 46660,0 46699,1 46795,0 46842,1 46851,0 46912,1 46945,0 47023,1 47078,0 47148,1 47212,0 47224,1 47242,0 47323,1 47339,0 47412,1 47508,0 47600,1 47623,0 47656,1 47696,0 47715,1 47757,0 47851,1 47917,0 47989,1 48047,0 48054,1 48088,0 48132,1 48179,0 48217,1 48277,0 48284,1 48330,0 48416,1 48430,0 48527,1 48566,0 48571,1 48621,0 48684,1 48686,0 48715,1 48770,0 48787,1 48832,0 48924,1 49022,0 49038,1 49095,0 49173,1 49272,0 49285,1 49325,0 49404,1 49469,0 49556,1 49609,0 49680,1 49698,0 49785,1 49859,0 49932,1 50029,0 50066,1 50157,0 50230,1 50253,0 50273,1 50284,0 50294,1 50340,0 50405,1 50500,0 50586,1 50627,0 50720,1 50750,0 50818,1 50858,0 50864,1 50922,0 51010,1 51016,0 51083,1 51144,0 51227,1 51233,0 51264,1 51356,0 51389,1 51433,0 51503,1 51510,0 51517,1 51584,0 51668,1 end initlist a30 0,0 24,1 38,0 54,1 102,0 159,1 169,0 179,1 209,0 303,1 335,0 340,1 358,0 451,1 523,0 526,1 626,0 653,1 693,0 707,1 725,0 812,1 888,0 926,1 934,0 972,1 1059,0 1068,1 1164,0 1172,1 1254,0 1345,1 1407,0 1443,1 1508,0 1540,1 1633,0 1643,1 1739,0 1744,1 1815,0 1848,1 1904,0 1977,1 2044,0 2111,1 2178,0 2263,1 2296,0 2303,1 2402,0 2500,1 2583,0 2657,1 2725,0 2802,1 2816,0 2836,1 2843,0 2897,1 2950,0 2967,1 2988,0 3087,1 3181,0 3266,1 3331,0 3334,1 3348,0 3437,1 3517,0 3542,1 3574,0 3618,1 3687,0 3752,1 3830,0 3930,1 3938,0 3952,1 4051,0 4106,1 4181,0 4259,1 4296,0 4366,1 4465,0 4561,1 4642,0 4725,1 4786,0 4837,1 4932,0 4961,1 5031,0 5117,1 5134,0 5181,1 5207,0 5233,1 5269,0 5291,1 5338,0 5438,1 5466,0 5480,1 5550,0 5569,1 5605,0 5683,1 5726,0 5737,1 5748,0 5780,1 5828,0 5844,1 5923,0 6023,1 6081,0 6106,1 6132,0 6147,1 6161,0 6175,1 6207,0 6234,1 6321,0 6359,1 6452,0 6542,1 6550,0 6597,1 6676,0 6747,1 6801,0 6848,1 6849,0 6881,1 6981,0 7052,1 7129,0 7146,1 7238,0 7278,1 7354,0 7376,1 7395,0 7434,1 7479,0 7567,1 7653,0 7753,1 7782,0 7851,1 7917,0 7930,1 7991,0 8086,1 8100,0 8178,1 8254,0 8277,1 8331,0 8424,1 8481,0 8490,1 8532,0 8627,1 8675,0 8738,1 8811,0 8862,1 8928,0 8995,1 9034,0 9049,1 9116,0 9184,1 9213,0 9260,1 9354,0 9415,1 9416,0 9450,1 9471,0 9531,1 9608,0 9627,1 9637,0 9715,1 9815,0 9899,1 9984,0 10045,1 10060,0 10067,1 10147,0 10154,1 10249,0 10295,1 10362,0 10379,1 10385,0 10431,1 10434,0 10524,1 10610,0 10701,1 10717,0 10760,1 10765,0 10801,1 10849,0 10926,1 10932,0 10966,1 10969,0 11035,1 11053,0 11096,1 11112,0 11148,1 11155,0 11181,1 11219,0 11293,1 11316,0 11347,1 11374,0 11447,1 11453,0 11476,1 11551,0 11601,1 11613,0 11687,1 11691,0 11744,1 11772,0 11780,1 11870,0 11896,1 11970,0 11979,1 11984,0 12025,1 12048,0 12083,1 12152,0 12242,1 12262,0 12275,1 12294,0 12335,1 12396,0 12472,1 12559,0 12613,1 12673,0 12772,1 12796,0 12894,1 12985,0 13029,1 13066,0 13119,1 13125,0 13153,1 13162,0 13249,1 13341,0 13369,1 13376,0 13404,1 13408,0 13412,1 13413,0 13452,1 13459,0 13541,1 13606,0 13643,1 13690,0 13727,1 13823,0 13885,1 13975,0 14013,1 14029,0 14085,1 14164,0 14238,1 14333,0 14390,1 14404,0 14492,1 14569,0 14645,1 14711,0 14736,1 14797,0 14864,1 14957,0 14980,1 14999,0 15012,1 15025,0 15034,1 15088,0 15155,1 15241,0 15277,1 15328,0 15378,1 15434,0 15448,1 15547,0 15644,1 15653,0 15697,1 15733,0 15800,1 15821,0 15911,1 15928,0 15940,1 16002,0 16086,1 16179,0 16218,1 16221,0 16253,1 16266,0 16320,1 16370,0 16417,1 16461,0 16532,1 16533,0 16628,1 16677,0 16756,1 16840,0 16859,1 16954,0 17014,1 17111,0 17136,1 17183,0 17281,1 17373,0 17454,1 17501,0 17544,1 17617,0 17666,1 17708,0 17781,1 17801,0 17894,1 17951,0 18032,1 18131,0 18225,1 18236,0 18298,1 18330,0 18395,1 18456,0 18540,1 18597,0 18628,1 18636,0 18653,1 18723,0 18806,1 18882,0 18975,1 19067,0 19136,1 19146,0 19179,1 19265,0 19342,1 19345,0 19418,1 19448,0 19462,1 19495,0 19562,1 19568,0 19583,1 19602,0 19692,1 19737,0 19772,1 19774,0 19862,1 19914,0 19991,1 20046,0 20101,1 20187,0 20215,1 20313,0 20390,1 20472,0 20501,1 20521,0 20609,1 20660,0 20748,1 20798,0 20844,1 20859,0 20875,1 20902,0 20920,1 20926,0 20986,1 21043,0 21094,1 21101,0 21188,1 21280,0 21356,1 21399,0 21470,1 21489,0 21547,1 21639,0 21714,1 21743,0 21757,1 21765,0 21814,1 21848,0 21896,1 21983,0 22021,1 22053,0 22140,1 22213,0 22243,1 22306,0 22366,1 22392,0 22415,1 22461,0 22531,1 22562,0 22582,1 22680,0 22727,1 22792,0 22799,1 22850,0 22878,1 22899,0 22984,1 23067,0 23114,1 23200,0 23216,1 23274,0 23369,1 23447,0 23511,1 23517,0 23601,1 23615,0 23672,1 23749,0 23768,1 23847,0 23848,1 23911,0 23977,1 24004,0 24066,1 24134,0 24224,1 24235,0 24325,1 24354,0 24367,1 24438,0 24484,1 24583,0 24587,1 24687,0 24705,1 24800,0 24808,1 24829,0 24849,1 24864,0 24961,1 25047,0 25110,1 25119,0 25175,1 25189,0 25282,1 25331,0 25391,1 25426,0 25485,1 25564,0 25628,1 25692,0 25707,1 25788,0 25852,1 25922,0 25955,1 26055,0 26094,1 26105,0 26196,1 26251,0 26261,1 26340,0 26370,1 26409,0 26485,1 26493,0 26574,1 26613,0 26711,1 26778,0 26787,1 26887,0 26924,1 26930,0 27001,1 27092,0 27192,1 27199,0 27293,1 27385,0 27473,1 27564,0 27640,1 27730,0 27768,1 27820,0 27853,1 27934,0 28011,1 28027,0 28100,1 28116,0 28135,1 28209,0 28274,1 28344,0 28431,1 28488,0 28500,1 28575,0 28646,1 28741,0 28803,1 28852,0 28910,1 28957,0 29051,1 29149,0 29212,1 29310,0 29363,1 29439,0 29518,1 29595,0 29610,1 29690,0 29764,1 29775,0 29830,1 29858,0 29954,1 30020,0 30043,1 30069,0 30136,1 30204,0 30290,1 30313,0 30373,1 30407,0 30498,1 30553,0 30599,1 30687,0 30720,1 30744,0 30751,1 30828,0 30891,1 30972,0 31027,1 31051,0 31098,1 31189,0 31238,1 31251,0 31319,1 31343,0 31422,1 31475,0 31527,1 31536,0 31614,1 31706,0 31727,1 31752,0 31849,1 31872,0 31902,1 32001,0 32009,1 32033,0 32084,1 32135,0 32203,1 32301,0 32313,1 32378,0 32474,1 32571,0 32577,1 32585,0 32642,1 32715,0 32717,1 32791,0 32874,1 32920,0 33011,1 33107,0 33169,1 33243,0 33323,1 33358,0 33384,1 33426,0 33494,1 33508,0 33586,1 33587,0 33601,1 33674,0 33677,1 33736,0 33803,1 33869,0 33880,1 33892,0 33916,1 34016,0 34083,1 34109,0 34175,1 34273,0 34312,1 34410,0 34510,1 34590,0 34637,1 34656,0 34693,1 34745,0 34804,1 34849,0 34907,1 34974,0 34998,1 35037,0 35086,1 35170,0 35240,1 35281,0 35349,1 35435,0 35503,1 35575,0 35664,1 35671,0 35756,1 35787,0 35852,1 35893,0 35964,1 36050,0 36143,1 36154,0 36185,1 36282,0 36341,1 36370,0 36389,1 36429,0 36439,1 36444,0 36532,1 36629,0 36667,1 36689,0 36692,1 36697,0 36718,1 36792,0 36859,1 36912,0 36942,1 36993,0 37025,1 37027,0 37092,1 37177,0 37268,1 37338,0 37398,1 37425,0 37510,1 37571,0 37671,1 37747,0 37757,1 37785,0 37884,1 37977,0 38009,1 38061,0 38089,1 38155,0 38227,1 38276,0 38293,1 38349,0 38414,1 38486,0 38581,1 38671,0 38755,1 38818,0 38862,1 38904,0 38910,1 38940,0 38963,1 39063,0 39145,1 39177,0 39178,1 39222,0 39322,1 39413,0 39436,1 39451,0 39491,1 39591,0 39641,1 39736,0 39780,1 39815,0 39882,1 39967,0 40058,1 40090,0 40152,1 40202,0 40208,1 40275,0 40314,1 40360,0 40382,1 40459,0 40501,1 40509,0 40533,1 40604,0 40633,1 40692,0 40760,1 40860,0 40871,1 40967,0 41013,1 41056,0 41097,1 41113,0 41147,1 41163,0 41218,1 41266,0 41279,1 41281,0 41302,1 41355,0 41358,1 41428,0 41507,1 41565,0 41664,1 41744,0 41822,1 41895,0 41974,1 42068,0 42092,1 42149,0 42151,1 42238,0 42250,1 42320,0 42333,1 42336,0 42423,1 42474,0 42568,1 42571,0 42575,1 42667,0 42736,1 42820,0 42919,1 42922,0 42925,1 42969,0 43000,1 43010,0 43103,1 43152,0 43237,1 43316,0 43398,1 43400,0 43411,1 43461,0 43500,1 43542,0 43551,1 43625,0 43689,1 43752,0 43821,1 43896,0 43995,1 44004,0 44067,1 44102,0 44194,1 44253,0 44272,1 44366,0 44380,1 44450,0 44491,1 44533,0 44626,1 44678,0 44717,1 44723,0 44816,1 44849,0 44886,1 44963,0 45060,1 45117,0 45143,1 45145,0 45147,1 45209,0 45210,1 45215,0 45303,1 45403,0 45425,1 45481,0 45548,1 45634,0 45698,1 45705,0 45777,1 45781,0 45822,1 45828,0 45851,1 45889,0 45967,1 46040,0 46062,1 46150,0 46164,1 46239,0 46268,1 46353,0 46407,1 46435,0 46471,1 46559,0 46599,1 46616,0 46713,1 46720,0 46740,1 46814,0 46832,1 46908,0 46978,1 47061,0 47087,1 47167,0 47234,1 47309,0 47406,1 47425,0 47458,1 47552,0 47589,1 47608,0 47610,1 47686,0 47715,1 47767,0 47854,1 47912,0 47948,1 47975,0 47979,1 47998,0 48046,1 48098,0 48123,1 48154,0 48191,1 48192,0 48234,1 48304,0 48397,1 48419,0 48505,1 48541,0 48587,1 48665,0 48725,1 48727,0 48811,1 48896,0 48913,1 48962,0 49006,1 49078,0 49169,1 49217,0 49251,1 49328,0 49403,1 49444,0 49448,1 49450,0 49528,1 49592,0 49631,1 49697,0 49761,1 49797,0 49849,1 49856,0 49866,1 49932,0 49973,1 50033,0 50047,1 50106,0 50117,1 50200,0 50213,1 50258,0 50314,1 50390,0 50490,1 50554,0 50611,1 50682,0 50780,1 50878,0 50894,1 50919,0 50928,1 50970,0 51062,1 51145,0 51170,1 51258,0 51299,1 51351,0 51447,1 51502,0 51568,1 end initlist a31 0,0 54,1 110,0 112,1 115,0 178,1 181,0 280,1 342,0 404,1 434,0 516,1 591,0 667,1 767,0 784,1 831,0 913,1 985,0 1034,1 1060,0 1083,1 1125,0 1135,1 1206,0 1284,1 1374,0 1385,1 1456,0 1498,1 1587,0 1621,1 1677,0 1751,1 1839,0 1846,1 1849,0 1927,1 1970,0 2045,1 2143,0 2168,1 2199,0 2286,1 2292,0 2369,1 2395,0 2489,1 2580,0 2659,1 2730,0 2806,1 2906,0 2992,1 3068,0 3146,1 3180,0 3260,1 3360,0 3371,1 3433,0 3515,1 3613,0 3618,1 3667,0 3670,1 3763,0 3852,1 3911,0 3978,1 4027,0 4057,1 4121,0 4183,1 4194,0 4269,1 4330,0 4336,1 4414,0 4417,1 4501,0 4533,1 4548,0 4610,1 4620,0 4704,1 4761,0 4784,1 4822,0 4843,1 4893,0 4980,1 5062,0 5154,1 5209,0 5281,1 5286,0 5367,1 5368,0 5413,1 5456,0 5464,1 5495,0 5504,1 5604,0 5623,1 5641,0 5644,1 5716,0 5746,1 5842,0 5875,1 5927,0 5971,1 6001,0 6092,1 6101,0 6198,1 6294,0 6376,1 6388,0 6454,1 6502,0 6592,1 6613,0 6643,1 6692,0 6749,1 6784,0 6808,1 6875,0 6938,1 7008,0 7029,1 7052,0 7082,1 7164,0 7193,1 7212,0 7260,1 7302,0 7391,1 7408,0 7422,1 7460,0 7524,1 7549,0 7595,1 7615,0 7633,1 7685,0 7765,1 7861,0 7871,1 7925,0 7994,1 8072,0 8080,1 8106,0 8180,1 8189,0 8191,1 8206,0 8235,1 8284,0 8338,1 8432,0 8504,1 8516,0 8596,1 8679,0 8701,1 8735,0 8741,1 8838,0 8849,1 8944,0 8981,1 9051,0 9113,1 9128,0 9166,1 9215,0 9219,1 9268,0 9283,1 9364,0 9437,1 9438,0 9447,1 9532,0 9602,1 9697,0 9765,1 9864,0 9892,1 9946,0 10033,1 10047,0 10104,1 10111,0 10157,1 10207,0 10294,1 10322,0 10353,1 10391,0 10410,1 10445,0 10484,1 10582,0 10650,1 10687,0 10764,1 10811,0 10904,1 10983,0 11038,1 11122,0 11198,1 11236,0 11301,1 11302,0 11381,1 11470,0 11482,1 11507,0 11561,1 11621,0 11719,1 11733,0 11793,1 11835,0 11881,1 11904,0 11994,1 12015,0 12071,1 12137,0 12138,1 12238,0 12285,1 12298,0 12390,1 12408,0 12415,1 12463,0 12545,1 12600,0 12697,1 12713,0 12767,1 12802,0 12830,1 12861,0 12915,1 12994,0 13055,1 13146,0 13156,1 13158,0 13213,1 13301,0 13395,1 13479,0 13546,1 13575,0 13580,1 13677,0 13744,1 13775,0 13793,1 13875,0 13969,1 13992,0 14050,1 14084,0 14099,1 14168,0 14219,1 14255,0 14345,1 14417,0 14501,1 14551,0 14558,1 14613,0 14626,1 14721,0 14821,1 14910,0 14932,1 15028,0 15089,1 15187,0 15224,1 15303,0 15324,1 15349,0 15442,1 15475,0 15538,1 15591,0 15594,1 15663,0 15719,1 15791,0 15827,1 15883,0 15935,1 15963,0 15996,1 16069,0 16157,1 16257,0 16356,1 16363,0 16459,1 16461,0 16515,1 16614,0 16656,1 16678,0 16714,1 16790,0 16817,1 16829,0 16865,1 16905,0 16970,1 17033,0 17102,1 17183,0 17201,1 17285,0 17319,1 17353,0 17383,1 17391,0 17486,1 17533,0 17564,1 17573,0 17599,1 17643,0 17729,1 17826,0 17887,1 17959,0 18025,1 18027,0 18119,1 18173,0 18188,1 18275,0 18310,1 18320,0 18322,1 18377,0 18414,1 18490,0 18538,1 18629,0 18723,1 18806,0 18815,1 18838,0 18883,1 18939,0 18977,1 19018,0 19118,1 19160,0 19171,1 19219,0 19282,1 19328,0 19417,1 19489,0 19582,1 19655,0 19709,1 19741,0 19805,1 19845,0 19853,1 19922,0 19958,1 19976,0 20000,1 20090,0 20100,1 20131,0 20157,1 20189,0 20248,1 20315,0 20393,1 20435,0 20471,1 20554,0 20577,1 20614,0 20630,1 20708,0 20733,1 20818,0 20908,1 20942,0 21032,1 21033,0 21061,1 21086,0 21090,1 21174,0 21223,1 21265,0 21291,1 21296,0 21304,1 21373,0 21408,1 21411,0 21503,1 21564,0 21568,1 21651,0 21659,1 21725,0 21801,1 21872,0 21894,1 21914,0 21991,1 22001,0 22061,1 22080,0 22175,1 22213,0 22311,1 22319,0 22402,1 22442,0 22458,1 22475,0 22498,1 22522,0 22589,1 22679,0 22682,1 22738,0 22808,1 22900,0 22913,1 22946,0 22964,1 22981,0 23029,1 23129,0 23175,1 23206,0 23229,1 23317,0 23399,1 23470,0 23527,1 23570,0 23621,1 23634,0 23725,1 23774,0 23838,1 23886,0 23974,1 24008,0 24055,1 24154,0 24229,1 24313,0 24397,1 24472,0 24496,1 24542,0 24552,1 24606,0 24678,1 24772,0 24859,1 24933,0 24951,1 24953,0 25042,1 25097,0 25162,1 25233,0 25280,1 25377,0 25403,1 25411,0 25423,1 25474,0 25557,1 25607,0 25655,1 25657,0 25665,1 25751,0 25792,1 25817,0 25906,1 25933,0 26032,1 26034,0 26050,1 26071,0 26153,1 26208,0 26278,1 26327,0 26427,1 26487,0 26565,1 26620,0 26719,1 26815,0 26858,1 26911,0 26999,1 27030,0 27120,1 27135,0 27212,1 27279,0 27307,1 27308,0 27402,1 27419,0 27515,1 27536,0 27572,1 27671,0 27689,1 27754,0 27793,1 27828,0 27860,1 27921,0 27949,1 28042,0 28137,1 28208,0 28248,1 28279,0 28299,1 28385,0 28438,1 28456,0 28503,1 28545,0 28584,1 28592,0 28660,1 28724,0 28762,1 28788,0 28841,1 28888,0 28980,1 29005,0 29066,1 29068,0 29128,1 29211,0 29310,1 29346,0 29379,1 29453,0 29467,1 29484,0 29559,1 29603,0 29658,1 29719,0 29745,1 29794,0 29864,1 29932,0 29945,1 29958,0 29962,1 30007,0 30032,1 30085,0 30122,1 30145,0 30151,1 30213,0 30289,1 30336,0 30379,1 30449,0 30524,1 30580,0 30678,1 30679,0 30750,1 30785,0 30884,1 30899,0 30949,1 30958,0 31016,1 31027,0 31073,1 31122,0 31126,1 31131,0 31140,1 31177,0 31194,1 31257,0 31287,1 31334,0 31359,1 31442,0 31467,1 31470,0 31477,1 31576,0 31600,1 31618,0 31703,1 31796,0 31820,1 31861,0 31893,1 31899,0 31992,1 32009,0 32108,1 32165,0 32263,1 32296,0 32313,1 32405,0 32428,1 32479,0 32494,1 32541,0 32609,1 32691,0 32762,1 32829,0 32859,1 32868,0 32903,1 32972,0 33053,1 33124,0 33216,1 33239,0 33320,1 33384,0 33403,1 33462,0 33527,1 33549,0 33639,1 33683,0 33698,1 33733,0 33752,1 33837,0 33858,1 33900,0 33919,1 33929,0 33977,1 33993,0 34091,1 34135,0 34184,1 34250,0 34320,1 34331,0 34390,1 34400,0 34474,1 34486,0 34563,1 34617,0 34709,1 34753,0 34791,1 34798,0 34897,1 34933,0 34949,1 35048,0 35106,1 35190,0 35247,1 35310,0 35325,1 35418,0 35497,1 35533,0 35596,1 35667,0 35718,1 35740,0 35813,1 35880,0 35891,1 35913,0 35928,1 35937,0 35955,1 35965,0 36045,1 36119,0 36127,1 36205,0 36272,1 36369,0 36449,1 36453,0 36474,1 36492,0 36549,1 36582,0 36590,1 36632,0 36668,1 36720,0 36794,1 36888,0 36915,1 36930,0 37025,1 37099,0 37149,1 37214,0 37272,1 37274,0 37363,1 37436,0 37498,1 37580,0 37616,1 37678,0 37734,1 37760,0 37770,1 37869,0 37889,1 37932,0 37990,1 38066,0 38143,1 38155,0 38223,1 38248,0 38329,1 38394,0 38395,1 38461,0 38517,1 38584,0 38668,1 38717,0 38730,1 38787,0 38886,1 38980,0 39044,1 39115,0 39185,1 39220,0 39281,1 39293,0 39359,1 39397,0 39405,1 39463,0 39536,1 39612,0 39707,1 39711,0 39726,1 39738,0 39747,1 39791,0 39865,1 39867,0 39962,1 39983,0 40002,1 40060,0 40097,1 40184,0 40284,1 40300,0 40394,1 40488,0 40581,1 40627,0 40649,1 40651,0 40660,1 40703,0 40732,1 40756,0 40827,1 40837,0 40860,1 40955,0 41045,1 41075,0 41115,1 41211,0 41302,1 41394,0 41417,1 41471,0 41498,1 41544,0 41550,1 41595,0 41659,1 41679,0 41719,1 41814,0 41902,1 41947,0 42035,1 42057,0 42146,1 42165,0 42261,1 42352,0 42354,1 42406,0 42428,1 42483,0 42518,1 42561,0 42610,1 42688,0 42769,1 42812,0 42871,1 42877,0 42950,1 43029,0 43036,1 43134,0 43226,1 43260,0 43344,1 43428,0 43489,1 43564,0 43638,1 43691,0 43761,1 43792,0 43840,1 43866,0 43869,1 43917,0 43942,1 43966,0 44058,1 44130,0 44160,1 44208,0 44257,1 44294,0 44306,1 44363,0 44426,1 44472,0 44494,1 44549,0 44589,1 44625,0 44635,1 44671,0 44751,1 44777,0 44833,1 44837,0 44873,1 44919,0 44962,1 44994,0 45063,1 45128,0 45157,1 45207,0 45217,1 45240,0 45283,1 45365,0 45402,1 45474,0 45544,1 45572,0 45605,1 45696,0 45730,1 45772,0 45870,1 45920,0 45990,1 45999,0 46042,1 46053,0 46074,1 46111,0 46186,1 46235,0 46290,1 46388,0 46401,1 46464,0 46542,1 46635,0 46664,1 46687,0 46704,1 46770,0 46787,1 46790,0 46827,1 46841,0 46856,1 46873,0 46889,1 46894,0 46923,1 46937,0 47023,1 47093,0 47171,1 47233,0 47309,1 47392,0 47472,1 47514,0 47529,1 47593,0 47602,1 47649,0 47690,1 47739,0 47759,1 47806,0 47840,1 47940,0 48022,1 48094,0 48122,1 48197,0 48249,1 48324,0 48406,1 48498,0 48581,1 48659,0 48671,1 48735,0 48763,1 48811,0 48854,1 48880,0 48972,1 49016,0 49115,1 49197,0 49207,1 49239,0 49329,1 49401,0 49441,1 49459,0 49484,1 49488,0 49535,1 49568,0 49581,1 49600,0 49626,1 49668,0 49705,1 49761,0 49779,1 49792,0 49803,1 49828,0 49902,1 end initlist b0 0,0 71,1 97,0 173,1 242,0 294,1 375,0 462,1 496,0 553,1 652,0 692,1 749,0 799,1 879,0 975,1 1041,0 1056,1 1117,0 1210,1 1214,0 1291,1 1335,0 1390,1 1461,0 1475,1 1555,0 1607,1 1668,0 1744,1 1807,0 1872,1 1930,0 2002,1 2097,0 2194,1 2270,0 2356,1 2424,0 2438,1 2526,0 2575,1 2613,0 2615,1 2677,0 2777,1 2834,0 2879,1 2926,0 2964,1 3020,0 3081,1 3123,0 3210,1 3304,0 3378,1 3460,0 3523,1 3605,0 3615,1 3623,0 3629,1 3694,0 3765,1 3792,0 3853,1 3855,0 3946,1 4013,0 4079,1 4175,0 4238,1 4293,0 4324,1 4371,0 4464,1 4476,0 4478,1 4577,0 4661,1 4733,0 4823,1 4851,0 4905,1 4970,0 5020,1 5066,0 5128,1 5223,0 5251,1 5311,0 5356,1 5376,0 5451,1 5548,0 5608,1 5661,0 5699,1 5742,0 5781,1 5869,0 5884,1 5898,0 5958,1 6017,0 6109,1 6189,0 6223,1 6253,0 6315,1 6380,0 6413,1 6428,0 6450,1 6545,0 6551,1 6557,0 6639,1 6727,0 6801,1 6832,0 6871,1 6924,0 6995,1 6999,0 7016,1 7100,0 7119,1 7184,0 7258,1 7291,0 7365,1 7402,0 7480,1 7576,0 7653,1 7742,0 7745,1 7774,0 7824,1 7857,0 7900,1 7924,0 7965,1 8014,0 8056,1 8070,0 8153,1 8252,0 8316,1 8395,0 8404,1 8486,0 8545,1 8570,0 8616,1 8672,0 8689,1 8765,0 8770,1 8777,0 8806,1 8809,0 8904,1 8909,0 8953,1 8968,0 9048,1 9080,0 9140,1 9170,0 9190,1 9242,0 9266,1 9353,0 9436,1 9490,0 9509,1 9546,0 9585,1 9597,0 9612,1 9646,0 9731,1 9823,0 9914,1 10009,0 10097,1 10149,0 10238,1 10289,0 10290,1 10297,0 10304,1 10330,0 10345,1 10350,0 10378,1 10425,0 10509,1 10538,0 10558,1 10588,0 10609,1 10637,0 10701,1 10705,0 10740,1 10807,0 10842,1 10872,0 10884,1 10959,0 11006,1 11082,0 11119,1 11132,0 11135,1 11176,0 11186,1 11257,0 11260,1 11272,0 11340,1 11365,0 11444,1 11480,0 11567,1 11586,0 11644,1 11726,0 11793,1 11822,0 11894,1 11935,0 11944,1 12003,0 12053,1 12116,0 12180,1 12218,0 12273,1 12280,0 12320,1 12388,0 12432,1 12436,0 12450,1 12507,0 12519,1 12553,0 12571,1 12645,0 12651,1 12751,0 12797,1 12818,0 12859,1 12951,0 13011,1 13044,0 13068,1 13137,0 13236,1 13301,0 13303,1 13361,0 13362,1 13391,0 13448,1 13492,0 13495,1 13519,0 13547,1 13568,0 13595,1 13605,0 13646,1 13681,0 13781,1 13802,0 13887,1 13925,0 13954,1 14054,0 14140,1 14145,0 14200,1 14300,0 14342,1 14356,0 14372,1 14468,0 14500,1 14566,0 14595,1 14621,0 14710,1 14778,0 14874,1 14961,0 15044,1 15127,0 15171,1 15260,0 15266,1 15342,0 15350,1 15353,0 15373,1 15440,0 15473,1 15483,0 15488,1 15533,0 15590,1 15626,0 15669,1 15764,0 15809,1 15878,0 15920,1 15992,0 16025,1 16086,0 16100,1 16122,0 16210,1 16265,0 16269,1 16283,0 16366,1 16377,0 16381,1 16471,0 16472,1 16517,0 16526,1 16619,0 16696,1 16771,0 16870,1 16874,0 16922,1 16949,0 16999,1 17082,0 17099,1 17189,0 17275,1 17310,0 17349,1 17428,0 17478,1 17532,0 17570,1 17615,0 17672,1 17734,0 17786,1 17824,0 17859,1 17914,0 17915,1 17931,0 18029,1 18107,0 18111,1 18204,0 18292,1 18388,0 18406,1 18490,0 18543,1 18545,0 18567,1 18636,0 18675,1 18717,0 18811,1 18853,0 18902,1 18935,0 18970,1 19048,0 19130,1 19205,0 19282,1 19365,0 19440,1 19452,0 19459,1 19483,0 19492,1 19577,0 19665,1 19714,0 19803,1 19843,0 19907,1 19917,0 19966,1 20025,0 20115,1 20135,0 20148,1 20241,0 20277,1 20365,0 20454,1 20542,0 20572,1 20578,0 20611,1 20685,0 20686,1 20729,0 20733,1 20807,0 20885,1 20981,0 20984,1 21004,0 21097,1 21128,0 21181,1 21222,0 21289,1 21320,0 21389,1 21433,0 21492,1 21528,0 21602,1 21664,0 21680,1 21740,0 21743,1 21758,0 21799,1 21853,0 21890,1 21980,0 22065,1 22119,0 22172,1 22248,0 22262,1 22296,0 22390,1 22437,0 22466,1 22512,0 22551,1 22572,0 22615,1 22703,0 22744,1 22815,0 22846,1 22932,0 22961,1 23037,0 23039,1 23044,0 23132,1 23149,0 23178,1 23210,0 23271,1 23289,0 23342,1 23426,0 23506,1 23539,0 23544,1 23609,0 23642,1 23677,0 23688,1 23704,0 23790,1 23863,0 23919,1 23933,0 24032,1 24126,0 24219,1 24277,0 24361,1 24459,0 24533,1 24545,0 24617,1 24710,0 24729,1 24804,0 24846,1 24946,0 24972,1 24997,0 25086,1 25177,0 25205,1 25284,0 25363,1 25410,0 25474,1 25507,0 25594,1 25595,0 25668,1 25673,0 25715,1 25782,0 25790,1 25853,0 25886,1 25954,0 26053,1 26055,0 26062,1 26092,0 26093,1 26134,0 26171,1 26203,0 26221,1 26223,0 26256,1 26306,0 26373,1 26382,0 26472,1 26528,0 26615,1 26632,0 26700,1 26720,0 26745,1 26836,0 26896,1 26928,0 26952,1 27045,0 27140,1 27177,0 27223,1 27250,0 27290,1 27303,0 27320,1 27341,0 27409,1 27493,0 27589,1 27633,0 27638,1 27661,0 27728,1 27747,0 27787,1 27865,0 27958,1 27965,0 28000,1 28076,0 28092,1 28158,0 28200,1 28229,0 28293,1 28302,0 28349,1 28432,0 28493,1 28576,0 28601,1 28662,0 28701,1 28773,0 28825,1 28912,0 29005,1 29041,0 29104,1 29148,0 29220,1 29246,0 29256,1 29325,0 29377,1 29430,0 29527,1 29570,0 29655,1 29721,0 29735,1 29777,0 29782,1 29825,0 29876,1 29927,0 29941,1 30037,0 30111,1 30185,0 30188,1 30194,0 30202,1 30270,0 30329,1 30424,0 30443,1 30513,0 30530,1 30585,0 30658,1 30690,0 30759,1 30817,0 30856,1 30871,0 30933,1 30981,0 31062,1 31102,0 31144,1 31232,0 31256,1 31327,0 31406,1 31500,0 31558,1 31657,0 31734,1 31812,0 31878,1 31973,0 32042,1 32099,0 32196,1 32242,0 32335,1 32433,0 32488,1 32528,0 32612,1 32681,0 32781,1 32802,0 32842,1 32845,0 32880,1 32974,0 33017,1 33043,0 33090,1 33133,0 33134,1 33194,0 33231,1 33307,0 33366,1 33393,0 33406,1 33436,0 33487,1 33573,0 33635,1 33718,0 33789,1 33791,0 33862,1 33904,0 33950,1 34037,0 34126,1 34175,0 34198,1 34238,0 34282,1 34338,0 34425,1 34512,0 34600,1 34659,0 34735,1 34788,0 34850,1 34923,0 34992,1 35034,0 35132,1 35191,0 35200,1 35260,0 35354,1 35437,0 35465,1 35480,0 35507,1 35548,0 35591,1 35600,0 35621,1 35622,0 35683,1 35738,0 35819,1 35860,0 35887,1 35903,0 35969,1 35984,0 36063,1 36117,0 36146,1 36236,0 36265,1 36315,0 36409,1 36432,0 36447,1 36496,0 36507,1 36572,0 36596,1 36620,0 36679,1 36768,0 36776,1 36869,0 36875,1 36907,0 36988,1 37038,0 37045,1 37133,0 37166,1 37257,0 37296,1 37358,0 37415,1 37453,0 37542,1 37626,0 37652,1 37715,0 37725,1 37821,0 37861,1 37958,0 37962,1 38054,0 38107,1 38207,0 38267,1 38329,0 38331,1 38407,0 38473,1 38481,0 38562,1 38585,0 38667,1 38674,0 38694,1 38724,0 38766,1 38821,0 38864,1 38930,0 39028,1 39047,0 39094,1 39170,0 39269,1 39338,0 39369,1 39452,0 39548,1 39627,0 39687,1 39780,0 39869,1 39958,0 40051,1 40113,0 40119,1 40204,0 40256,1 40335,0 40433,1 40476,0 40499,1 40533,0 40604,1 40618,0 40636,1 40714,0 40770,1 40862,0 40939,1 40992,0 40999,1 41024,0 41098,1 41151,0 41223,1 41241,0 41335,1 41356,0 41385,1 41484,0 41517,1 41521,0 41546,1 41594,0 41685,1 41730,0 41754,1 41761,0 41848,1 41930,0 41999,1 42070,0 42137,1 42138,0 42153,1 42194,0 42281,1 42352,0 42437,1 42449,0 42522,1 42536,0 42608,1 42707,0 42750,1 42753,0 42853,1 42943,0 42953,1 42997,0 43012,1 43018,0 43060,1 43126,0 43190,1 43191,0 43249,1 43258,0 43274,1 43343,0 43401,1 43465,0 43495,1 43560,0 43644,1 43729,0 43756,1 43791,0 43812,1 43837,0 43873,1 43904,0 43952,1 43984,0 43994,1 44044,0 44069,1 44085,0 44134,1 44153,0 44252,1 44294,0 44375,1 44439,0 44521,1 44598,0 44630,1 44700,0 44767,1 44787,0 44856,1 44891,0 44960,1 45051,0 45093,1 45118,0 45156,1 45190,0 45208,1 45267,0 45341,1 45351,0 45432,1 45518,0 45575,1 45581,0 45640,1 45650,0 45665,1 45675,0 45691,1 45734,0 45775,1 45860,0 45911,1 45959,0 45963,1 46010,0 46089,1 46110,0 46134,1 46142,0 46224,1 46244,0 46273,1 46299,0 46371,1 46464,0 46515,1 46612,0 46700,1 46726,0 46761,1 46793,0 46823,1 46851,0 46884,1 46970,0 47070,1 47133,0 47178,1 47277,0 47292,1 47305,0 47352,1 47365,0 47458,1 47492,0 47582,1 47616,0 47651,1 47677,0 47712,1 47791,0 47828,1 47853,0 47950,1 48005,0 48049,1 48143,0 48187,1 48202,0 48297,1 48366,0 48423,1 48470,0 48491,1 48566,0 48614,1 48693,0 48723,1 48736,0 48750,1 48836,0 48897,1 48971,0 48991,1 49018,0 49107,1 49161,0 49253,1 49288,0 49298,1 49390,0 49428,1 49463,0 49508,1 49561,0 49614,1 49685,0 49691,1 49740,0 49831,1 49849,0 49930,1 50017,0 50096,1 50137,0 50237,1 50267,0 50338,1 50422,0 50473,1 50524,0 50595,1 50643,0 50730,1 end initlist b1 0,0 26,1 93,0 108,1 181,0 232,1 332,0 405,1 505,0 510,1 543,0 585,1 622,0 663,1 727,0 788,1 857,0 872,1 912,0 1002,1 1093,0 1123,1 1124,0 1153,1 1174,0 1227,1 1264,0 1278,1 1291,0 1354,1 1375,0 1424,1 1478,0 1531,1 1627,0 1694,1 1788,0 1886,1 1971,0 1997,1 2046,0 2078,1 2143,0 2148,1 2170,0 2224,1 2306,0 2373,1 2420,0 2520,1 2572,0 2628,1 2663,0 2718,1 2771,0 2806,1 2828,0 2842,1 2853,0 2888,1 2951,0 2983,1 3064,0 3110,1 3111,0 3153,1 3211,0 3249,1 3290,0 3311,1 3376,0 3436,1 3442,0 3478,1 3501,0 3596,1 3688,0 3699,1 3726,0 3767,1 3845,0 3848,1 3859,0 3884,1 3932,0 3961,1 3979,0 4068,1 4100,0 4186,1 4258,0 4349,1 4410,0 4498,1 4549,0 4568,1 4651,0 4702,1 4784,0 4879,1 4979,0 5051,1 5091,0 5101,1 5141,0 5202,1 5282,0 5358,1 5363,0 5433,1 5445,0 5519,1 5562,0 5593,1 5639,0 5698,1 5796,0 5890,1 5943,0 6036,1 6086,0 6108,1 6195,0 6248,1 6342,0 6389,1 6443,0 6540,1 6586,0 6673,1 6730,0 6743,1 6815,0 6835,1 6895,0 6942,1 6991,0 7010,1 7062,0 7159,1 7258,0 7289,1 7339,0 7360,1 7420,0 7459,1 7486,0 7586,1 7670,0 7754,1 7809,0 7829,1 7887,0 7963,1 7967,0 8019,1 8072,0 8170,1 8245,0 8258,1 8355,0 8382,1 8475,0 8527,1 8544,0 8634,1 8692,0 8699,1 8731,0 8782,1 8880,0 8954,1 9047,0 9069,1 9164,0 9264,1 9356,0 9405,1 9475,0 9493,1 9577,0 9586,1 9614,0 9686,1 9688,0 9697,1 9730,0 9767,1 9787,0 9869,1 9937,0 9978,1 9989,0 10029,1 10071,0 10153,1 10223,0 10235,1 10245,0 10251,1 10303,0 10393,1 10433,0 10464,1 10482,0 10566,1 10644,0 10730,1 10743,0 10830,1 10852,0 10878,1 10976,0 11053,1 11056,0 11127,1 11135,0 11166,1 11221,0 11228,1 11237,0 11254,1 11329,0 11404,1 11427,0 11487,1 11586,0 11686,1 11756,0 11783,1 11858,0 11867,1 11928,0 12026,1 12050,0 12099,1 12136,0 12180,1 12249,0 12328,1 12422,0 12430,1 12477,0 12480,1 12514,0 12607,1 12656,0 12672,1 12743,0 12775,1 12784,0 12867,1 12884,0 12896,1 12901,0 12987,1 13055,0 13118,1 13169,0 13249,1 13318,0 13415,1 13460,0 13555,1 13571,0 13577,1 13672,0 13731,1 13818,0 13913,1 13944,0 14015,1 14069,0 14101,1 14198,0 14291,1 14387,0 14388,1 14427,0 14492,1 14563,0 14618,1 14631,0 14679,1 14715,0 14752,1 14773,0 14791,1 14793,0 14879,1 14896,0 14920,1 14975,0 15052,1 15136,0 15201,1 15257,0 15280,1 15307,0 15358,1 15377,0 15425,1 15440,0 15517,1 15537,0 15603,1 15692,0 15706,1 15715,0 15804,1 15814,0 15903,1 15970,0 16019,1 16079,0 16099,1 16166,0 16236,1 16333,0 16401,1 16471,0 16531,1 16562,0 16610,1 16662,0 16748,1 16827,0 16878,1 16958,0 17016,1 17065,0 17086,1 17144,0 17152,1 17179,0 17257,1 17313,0 17359,1 17410,0 17446,1 17495,0 17541,1 17620,0 17667,1 17682,0 17749,1 17799,0 17801,1 17901,0 17906,1 17980,0 17981,1 18039,0 18115,1 18133,0 18192,1 18223,0 18263,1 18337,0 18413,1 18483,0 18581,1 18623,0 18660,1 18714,0 18723,1 18769,0 18790,1 18796,0 18853,1 18944,0 19014,1 19024,0 19107,1 19157,0 19191,1 19263,0 19314,1 19411,0 19475,1 19568,0 19610,1 19700,0 19744,1 19829,0 19895,1 19905,0 19980,1 19983,0 20077,1 20096,0 20195,1 20218,0 20226,1 20248,0 20294,1 20358,0 20441,1 20463,0 20487,1 20489,0 20567,1 20596,0 20626,1 20698,0 20797,1 20870,0 20922,1 20934,0 20981,1 21050,0 21149,1 21167,0 21194,1 21205,0 21232,1 21319,0 21345,1 21405,0 21440,1 21464,0 21496,1 21596,0 21620,1 21654,0 21743,1 21838,0 21932,1 21947,0 22027,1 22037,0 22091,1 22172,0 22271,1 22318,0 22325,1 22341,0 22362,1 22366,0 22419,1 22454,0 22475,1 22480,0 22490,1 22502,0 22588,1 22619,0 22715,1 22755,0 22802,1 22895,0 22949,1 23025,0 23096,1 23186,0 23278,1 23354,0 23404,1 23411,0 23505,1 23511,0 23535,1 23625,0 23725,1 23799,0 23868,1 23875,0 23883,1 23911,0 23987,1 23997,0 24000,1 24088,0 24187,1 24256,0 24328,1 24410,0 24411,1 24488,0 24556,1 24628,0 24713,1 24764,0 24823,1 24890,0 24909,1 24983,0 25010,1 25050,0 25089,1 25142,0 25239,1 25324,0 25353,1 25379,0 25394,1 25400,0 25416,1 25505,0 25519,1 25574,0 25623,1 25699,0 25718,1 25795,0 25805,1 25878,0 25911,1 25935,0 26015,1 26098,0 26167,1 26176,0 26218,1 26303,0 26380,1 26479,0 26519,1 26614,0 26692,1 26762,0 26858,1 26946,0 26968,1 27035,0 27068,1 27078,0 27146,1 27205,0 27297,1 27389,0 27393,1 27448,0 27518,1 27576,0 27604,1 27700,0 27749,1 27791,0 27868,1 27966,0 28040,1 28105,0 28114,1 28138,0 28232,1 28263,0 28271,1 28333,0 28410,1 28493,0 28503,1 28553,0 28613,1 28713,0 28797,1 28829,0 28836,1 28877,0 28923,1 28975,0 29070,1 29126,0 29217,1 29309,0 29391,1 29430,0 29433,1 29468,0 29514,1 29566,0 29596,1 29609,0 29695,1 29763,0 29798,1 29806,0 29822,1 29862,0 29903,1 29994,0 30072,1 30165,0 30253,1 30353,0 30445,1 30522,0 30598,1 30650,0 30729,1 30822,0 30901,1 30986,0 31001,1 31051,0 31077,1 31102,0 31141,1 31166,0 31176,1 31194,0 31253,1 31348,0 31387,1 31451,0 31475,1 31489,0 31515,1 31562,0 31625,1 31710,0 31769,1 31827,0 31908,1 31940,0 31951,1 31969,0 32030,1 32069,0 32129,1 32141,0 32171,1 32186,0 32201,1 32295,0 32354,1 32435,0 32458,1 32505,0 32597,1 32652,0 32690,1 32708,0 32770,1 32805,0 32881,1 32966,0 33014,1 33039,0 33112,1 33138,0 33185,1 33216,0 33304,1 33318,0 33326,1 33328,0 33374,1 33397,0 33444,1 33516,0 33520,1 33570,0 33575,1 33599,0 33611,1 33688,0 33783,1 33847,0 33891,1 33909,0 33910,1 33954,0 34005,1 34095,0 34167,1 34253,0 34280,1 34337,0 34403,1 34443,0 34527,1 34557,0 34622,1 34698,0 34735,1 34805,0 34816,1 34829,0 34833,1 34889,0 34986,1 34999,0 35027,1 35121,0 35218,1 35244,0 35324,1 35354,0 35430,1 35444,0 35541,1 35580,0 35609,1 35640,0 35740,1 35838,0 35893,1 35961,0 35968,1 35990,0 36004,1 36011,0 36098,1 36176,0 36208,1 36258,0 36329,1 36371,0 36397,1 36430,0 36446,1 36520,0 36524,1 36574,0 36673,1 36696,0 36746,1 36779,0 36823,1 36868,0 36957,1 36963,0 36975,1 37007,0 37077,1 37161,0 37235,1 37284,0 37365,1 37367,0 37417,1 37475,0 37564,1 37648,0 37705,1 37762,0 37819,1 37822,0 37912,1 37924,0 38012,1 38108,0 38164,1 38172,0 38214,1 38275,0 38311,1 38324,0 38351,1 38358,0 38418,1 38450,0 38528,1 38581,0 38603,1 38654,0 38712,1 38798,0 38810,1 38831,0 38892,1 38968,0 39001,1 39066,0 39140,1 39231,0 39268,1 39349,0 39373,1 39401,0 39437,1 39504,0 39549,1 39594,0 39654,1 39663,0 39683,1 39762,0 39825,1 39846,0 39849,1 39944,0 39986,1 40077,0 40172,1 40219,0 40233,1 40241,0 40248,1 40338,0 40378,1 40387,0 40407,1 40455,0 40532,1 40630,0 40635,1 40727,0 40809,1 40863,0 40888,1 40978,0 41071,1 41126,0 41163,1 41208,0 41304,1 41363,0 41453,1 41543,0 41606,1 41650,0 41671,1 41674,0 41721,1 41737,0 41758,1 41780,0 41876,1 41898,0 41927,1 41981,0 42064,1 42110,0 42175,1 42198,0 42269,1 42292,0 42328,1 42347,0 42349,1 42409,0 42496,1 42579,0 42616,1 42630,0 42701,1 42721,0 42749,1 42824,0 42904,1 42959,0 43057,1 43076,0 43151,1 43197,0 43275,1 43319,0 43337,1 43419,0 43447,1 43533,0 43629,1 43670,0 43765,1 43827,0 43911,1 43979,0 44065,1 44087,0 44127,1 44145,0 44173,1 44224,0 44282,1 44375,0 44440,1 44456,0 44523,1 44587,0 44613,1 44680,0 44758,1 44833,0 44849,1 44852,0 44905,1 44957,0 44989,1 45026,0 45083,1 45134,0 45211,1 45274,0 45340,1 45345,0 45408,1 45412,0 45445,1 45540,0 45543,1 45548,0 45564,1 45623,0 45690,1 45762,0 45845,1 45938,0 46013,1 46105,0 46203,1 46279,0 46354,1 46355,0 46391,1 46456,0 46480,1 46564,0 46569,1 46600,0 46674,1 46690,0 46751,1 46835,0 46859,1 46945,0 47000,1 47037,0 47074,1 47174,0 47244,1 47333,0 47368,1 47457,0 47490,1 47537,0 47632,1 47705,0 47747,1 47783,0 47811,1 47878,0 47968,1 48034,0 48071,1 48084,0 48120,1 48207,0 48267,1 48344,0 48424,1 48521,0 48580,1 48593,0 48633,1 48634,0 48734,1 48735,0 48819,1 48916,0 48940,1 49026,0 49089,1 49092,0 49154,1 49230,0 49293,1 49295,0 49326,1 49388,0 49467,1 49559,0 49618,1 49688,0 49721,1 49811,0 49909,1 49930,0 49995,1 50073,0 50090,1 50149,0 50230,1 50302,0 50370,1 50460,0 50496,1 50580,0 50660,1 50669,0 50729,1 50740,0 50755,1 50823,0 50870,1 50961,0 51020,1 51113,0 51187,1 51237,0 51279,1 51332,0 51416,1 51487,0 51562,1 51631,0 51676,1 51734,0 51806,1 51898,0 51958,1 end initlist b2 0,0 43,1 116,0 188,1 273,0 292,1 299,0 369,1 422,0 519,1 617,0 663,1 696,0 745,1 818,0 876,1 942,0 960,1 1001,0 1043,1 1141,0 1212,1 1257,0 1297,1 1376,0 1470,1 1563,0 1633,1 1675,0 1733,1 1833,0 1845,1 1903,0 1954,1 2029,0 2109,1 2202,0 2272,1 2279,0 2309,1 2316,0 2388,1 2414,0 2483,1 2581,0 2648,1 2698,0 2735,1 2783,0 2883,1 2977,0 2980,1 3039,0 3100,1 3129,0 3206,1 3258,0 3318,1 3393,0 3432,1 3499,0 3566,1 3659,0 3667,1 3681,0 3761,1 3784,0 3874,1 3910,0 4000,1 4095,0 4109,1 4166,0 4170,1 4237,0 4317,1 4378,0 4417,1 4494,0 4589,1 4664,0 4690,1 4719,0 4773,1 4858,0 4917,1 4991,0 5074,1 5162,0 5203,1 5295,0 5390,1 5415,0 5489,1 5568,0 5635,1 5666,0 5741,1 5753,0 5769,1 5779,0 5799,1 5862,0 5869,1 5923,0 5951,1 5968,0 6016,1 6067,0 6105,1 6180,0 6182,1 6269,0 6276,1 6297,0 6334,1 6405,0 6483,1 6579,0 6625,1 6680,0 6770,1 6865,0 6892,1 6962,0 7042,1 7131,0 7145,1 7197,0 7254,1 7325,0 7354,1 7430,0 7494,1 7503,0 7529,1 7603,0 7609,1 7651,0 7727,1 7734,0 7760,1 7792,0 7838,1 7912,0 7921,1 7989,0 8034,1 8064,0 8164,1 8245,0 8307,1 8396,0 8468,1 8482,0 8555,1 8565,0 8596,1 8641,0 8727,1 8791,0 8825,1 8892,0 8921,1 9000,0 9059,1 9135,0 9205,1 9270,0 9348,1 9369,0 9439,1 9535,0 9610,1 9622,0 9632,1 9639,0 9652,1 9690,0 9747,1 9837,0 9926,1 9983,0 10048,1 10078,0 10082,1 10135,0 10168,1 10223,0 10233,1 10331,0 10393,1 10462,0 10540,1 10639,0 10651,1 10688,0 10768,1 10828,0 10917,1 11000,0 11035,1 11040,0 11081,1 11099,0 11104,1 11138,0 11156,1 11209,0 11264,1 11302,0 11387,1 11480,0 11534,1 11574,0 11671,1 11728,0 11751,1 11778,0 11812,1 11893,0 11953,1 12009,0 12103,1 12163,0 12255,1 12308,0 12372,1 12423,0 12458,1 12480,0 12500,1 12545,0 12608,1 12649,0 12663,1 12699,0 12757,1 12821,0 12829,1 12869,0 12968,1 13029,0 13113,1 13136,0 13165,1 13194,0 13258,1 13330,0 13391,1 13480,0 13519,1 13567,0 13655,1 13718,0 13805,1 13876,0 13922,1 13985,0 14022,1 14101,0 14196,1 14259,0 14287,1 14342,0 14442,1 14458,0 14537,1 14628,0 14703,1 14798,0 14887,1 14976,0 15063,1 15131,0 15193,1 15233,0 15253,1 15323,0 15358,1 15448,0 15497,1 15594,0 15599,1 15620,0 15696,1 15777,0 15864,1 15895,0 15904,1 15920,0 15985,1 16019,0 16027,1 16032,0 16055,1 16118,0 16174,1 16234,0 16270,1 16320,0 16349,1 16384,0 16401,1 16408,0 16429,1 16470,0 16522,1 16581,0 16632,1 16706,0 16737,1 16810,0 16834,1 16904,0 16978,1 17035,0 17120,1 17127,0 17139,1 17222,0 17260,1 17332,0 17386,1 17435,0 17483,1 17522,0 17605,1 17703,0 17766,1 17837,0 17925,1 17961,0 18003,1 18077,0 18127,1 18177,0 18198,1 18268,0 18361,1 18371,0 18452,1 18549,0 18600,1 18668,0 18739,1 18834,0 18868,1 18955,0 19019,1 19114,0 19211,1 19227,0 19302,1 19331,0 19344,1 19409,0 19472,1 19544,0 19590,1 19605,0 19685,1 19690,0 19717,1 19798,0 19860,1 19936,0 19969,1 20002,0 20025,1 20039,0 20108,1 20165,0 20195,1 20273,0 20358,1 20455,0 20520,1 20531,0 20625,1 20687,0 20738,1 20769,0 20847,1 20910,0 21010,1 21104,0 21167,1 21244,0 21281,1 21328,0 21339,1 21378,0 21402,1 21482,0 21554,1 21627,0 21665,1 21699,0 21758,1 21786,0 21831,1 21928,0 21982,1 21988,0 22052,1 22092,0 22167,1 22206,0 22255,1 22298,0 22337,1 22343,0 22425,1 22513,0 22602,1 22611,0 22690,1 22698,0 22784,1 22799,0 22861,1 22921,0 22933,1 22943,0 23008,1 23056,0 23148,1 23176,0 23215,1 23272,0 23324,1 23416,0 23506,1 23578,0 23596,1 23646,0 23739,1 23786,0 23844,1 23919,0 23925,1 23952,0 24049,1 24070,0 24155,1 24202,0 24205,1 24265,0 24346,1 24423,0 24468,1 24549,0 24579,1 24621,0 24721,1 24746,0 24785,1 24863,0 24950,1 24993,0 25068,1 25092,0 25127,1 25221,0 25251,1 25279,0 25317,1 25337,0 25369,1 25392,0 25442,1 25464,0 25541,1 25611,0 25693,1 25695,0 25786,1 25790,0 25868,1 25897,0 25986,1 26036,0 26088,1 26101,0 26116,1 26173,0 26261,1 26351,0 26380,1 26397,0 26451,1 26536,0 26604,1 26665,0 26683,1 26754,0 26767,1 26828,0 26902,1 26975,0 27043,1 27073,0 27092,1 27118,0 27189,1 27197,0 27254,1 27261,0 27285,1 27312,0 27370,1 27452,0 27528,1 27537,0 27546,1 27558,0 27655,1 27703,0 27723,1 27776,0 27838,1 27890,0 27895,1 27949,0 27967,1 28057,0 28123,1 28200,0 28259,1 28340,0 28380,1 28454,0 28550,1 28560,0 28562,1 28611,0 28621,1 28721,0 28785,1 28822,0 28833,1 28843,0 28914,1 29014,0 29088,1 29090,0 29174,1 29269,0 29337,1 29339,0 29431,1 29496,0 29573,1 29621,0 29702,1 29792,0 29811,1 29814,0 29912,1 29980,0 30060,1 30159,0 30209,1 30237,0 30297,1 30368,0 30374,1 30381,0 30460,1 30478,0 30561,1 30630,0 30696,1 30772,0 30851,1 30951,0 30960,1 31053,0 31126,1 31139,0 31211,1 31279,0 31374,1 31389,0 31398,1 31497,0 31504,1 31549,0 31629,1 31633,0 31684,1 31757,0 31841,1 31881,0 31940,1 32034,0 32092,1 32156,0 32207,1 32222,0 32229,1 32299,0 32350,1 32442,0 32443,1 32521,0 32558,1 32627,0 32661,1 32711,0 32803,1 32889,0 32924,1 33018,0 33043,1 33128,0 33164,1 33210,0 33257,1 33262,0 33345,1 33423,0 33508,1 33515,0 33518,1 33548,0 33616,1 33676,0 33733,1 33811,0 33910,1 33985,0 34034,1 34056,0 34065,1 34079,0 34087,1 34128,0 34221,1 34289,0 34313,1 34364,0 34422,1 34433,0 34464,1 34476,0 34573,1 34659,0 34711,1 34718,0 34719,1 34797,0 34848,1 34875,0 34930,1 35000,0 35009,1 35031,0 35067,1 35165,0 35238,1 35276,0 35308,1 35376,0 35381,1 35441,0 35460,1 35518,0 35582,1 35590,0 35591,1 35629,0 35696,1 35729,0 35824,1 35915,0 35950,1 35991,0 36026,1 36047,0 36049,1 36132,0 36135,1 36157,0 36216,1 36247,0 36264,1 36345,0 36400,1 36490,0 36541,1 36609,0 36664,1 36687,0 36692,1 36786,0 36821,1 36857,0 36957,1 36981,0 36996,1 37026,0 37102,1 37179,0 37198,1 37250,0 37275,1 37302,0 37307,1 37357,0 37426,1 37444,0 37477,1 37541,0 37601,1 37654,0 37698,1 37783,0 37787,1 37795,0 37891,1 37949,0 37958,1 37979,0 38018,1 38099,0 38152,1 38168,0 38184,1 38247,0 38280,1 38340,0 38417,1 38474,0 38535,1 38562,0 38620,1 38709,0 38711,1 38743,0 38809,1 38833,0 38931,1 39020,0 39041,1 39060,0 39149,1 39236,0 39303,1 39353,0 39385,1 39409,0 39452,1 39458,0 39506,1 39541,0 39549,1 39617,0 39692,1 39742,0 39830,1 39929,0 40021,1 40103,0 40119,1 40189,0 40224,1 40249,0 40343,1 40409,0 40423,1 40439,0 40449,1 40546,0 40617,1 40687,0 40692,1 40778,0 40874,1 40929,0 40999,1 41084,0 41174,1 41235,0 41329,1 41331,0 41427,1 41484,0 41496,1 41575,0 41643,1 41702,0 41752,1 41820,0 41859,1 41866,0 41914,1 41928,0 41960,1 42024,0 42111,1 42125,0 42157,1 42247,0 42249,1 42339,0 42366,1 42447,0 42542,1 42582,0 42639,1 42699,0 42783,1 42873,0 42913,1 43010,0 43110,1 43128,0 43202,1 43286,0 43294,1 43305,0 43349,1 43446,0 43485,1 43561,0 43608,1 43648,0 43664,1 43743,0 43753,1 43773,0 43794,1 43835,0 43866,1 43898,0 43905,1 43916,0 43969,1 44032,0 44130,1 44202,0 44244,1 44255,0 44291,1 44331,0 44346,1 44381,0 44383,1 44450,0 44453,1 44485,0 44532,1 44543,0 44628,1 44677,0 44739,1 44810,0 44899,1 44964,0 45055,1 45133,0 45149,1 45240,0 45315,1 45374,0 45425,1 45510,0 45522,1 45590,0 45597,1 45636,0 45643,1 45675,0 45706,1 45796,0 45799,1 45815,0 45838,1 45851,0 45860,1 45886,0 45967,1 46030,0 46116,1 46175,0 46272,1 46302,0 46313,1 46397,0 46442,1 46542,0 46584,1 46654,0 46665,1 46765,0 46820,1 46828,0 46869,1 46881,0 46965,1 46995,0 47045,1 47099,0 47112,1 47203,0 47283,1 47376,0 47445,1 47478,0 47526,1 47534,0 47579,1 47662,0 47716,1 47809,0 47866,1 47903,0 47994,1 48069,0 48095,1 48115,0 48205,1 48256,0 48293,1 48375,0 48467,1 48474,0 48511,1 48552,0 48585,1 48662,0 48669,1 48683,0 48736,1 48773,0 48851,1 48922,0 49004,1 49024,0 49048,1 49120,0 49179,1 49256,0 49296,1 49359,0 49415,1 49466,0 49507,1 49536,0 49597,1 49680,0 49730,1 49768,0 49859,1 49886,0 49898,1 49976,0 50044,1 50131,0 50181,1 50186,0 50286,1 50380,0 50446,1 50465,0 50470,1 50510,0 50544,1 50628,0 50701,1 50726,0 50793,1 50890,0 50904,1 50984,0 51067,1 51150,0 51202,1 51234,0 51245,1 51256,0 51259,1 51326,0 51353,1 51422,0 51501,1 51561,0 51625,1 51651,0 51688,1 51712,0 51792,1 51877,0 51928,1 52019,0 52028,1 52104,0 52200,1 52202,0 52244,1 end initlist b3 0,0 46,1 80,0 96,1 155,0 237,1 312,0 363,1 388,0 476,1 515,0 605,1 691,0 761,1 777,0 822,1 912,0 941,1 990,0 1072,1 1095,0 1106,1 1122,0 1181,1 1196,0 1234,1 1238,0 1290,1 1338,0 1394,1 1406,0 1492,1 1564,0 1662,1 1701,0 1729,1 1799,0 1822,1 1831,0 1882,1 1925,0 1936,1 1996,0 2027,1 2068,0 2082,1 2131,0 2168,1 2259,0 2330,1 2347,0 2356,1 2402,0 2446,1 2517,0 2577,1 2584,0 2677,1 2771,0 2839,1 2887,0 2974,1 3065,0 3113,1 3165,0 3264,1 3359,0 3383,1 3459,0 3522,1 3538,0 3594,1 3644,0 3659,1 3727,0 3769,1 3802,0 3814,1 3851,0 3862,1 3895,0 3921,1 3929,0 4012,1 4087,0 4112,1 4211,0 4260,1 4345,0 4394,1 4459,0 4522,1 4573,0 4608,1 4702,0 4776,1 4807,0 4844,1 4882,0 4970,1 5030,0 5123,1 5153,0 5189,1 5264,0 5323,1 5331,0 5358,1 5444,0 5463,1 5534,0 5564,1 5591,0 5681,1 5695,0 5709,1 5748,0 5840,1 5859,0 5904,1 5968,0 5997,1 6094,0 6134,1 6218,0 6302,1 6351,0 6398,1 6408,0 6504,1 6513,0 6555,1 6610,0 6687,1 6738,0 6817,1 6892,0 6943,1 6991,0 7062,1 7152,0 7191,1 7255,0 7306,1 7368,0 7465,1 7528,0 7619,1 7626,0 7654,1 7656,0 7725,1 7751,0 7781,1 7793,0 7884,1 7892,0 7985,1 8079,0 8166,1 8262,0 8313,1 8405,0 8451,1 8538,0 8579,1 8626,0 8712,1 8745,0 8767,1 8793,0 8805,1 8860,0 8930,1 8980,0 8996,1 9096,0 9132,1 9209,0 9293,1 9378,0 9439,1 9453,0 9514,1 9608,0 9648,1 9663,0 9695,1 9745,0 9791,1 9891,0 9907,1 9923,0 9943,1 9979,0 10010,1 10084,0 10182,1 10275,0 10299,1 10376,0 10454,1 10502,0 10552,1 10640,0 10727,1 10810,0 10816,1 10891,0 10951,1 10979,0 10997,1 11067,0 11074,1 11080,0 11141,1 11201,0 11244,1 11264,0 11267,1 11339,0 11410,1 11508,0 11512,1 11566,0 11603,1 11631,0 11645,1 11659,0 11689,1 11770,0 11818,1 11903,0 11991,1 11993,0 12043,1 12059,0 12061,1 12123,0 12211,1 12240,0 12271,1 12356,0 12400,1 12442,0 12462,1 12469,0 12472,1 12503,0 12595,1 12600,0 12689,1 12715,0 12781,1 12856,0 12887,1 12938,0 13028,1 13086,0 13127,1 13154,0 13161,1 13213,0 13290,1 13310,0 13351,1 13372,0 13466,1 13501,0 13571,1 13623,0 13634,1 13678,0 13739,1 13808,0 13875,1 13892,0 13969,1 14038,0 14109,1 14121,0 14197,1 14253,0 14261,1 14309,0 14395,1 14479,0 14512,1 14542,0 14614,1 14652,0 14669,1 14764,0 14828,1 14849,0 14894,1 14936,0 14977,1 15041,0 15062,1 15074,0 15145,1 15196,0 15203,1 15215,0 15307,1 15391,0 15477,1 15513,0 15588,1 15602,0 15669,1 15680,0 15721,1 15762,0 15785,1 15818,0 15857,1 15872,0 15940,1 16018,0 16023,1 16028,0 16092,1 16143,0 16157,1 16164,0 16264,1 16314,0 16388,1 16435,0 16451,1 16546,0 16573,1 16606,0 16645,1 16648,0 16718,1 16786,0 16873,1 16893,0 16954,1 16987,0 17033,1 17121,0 17143,1 17205,0 17223,1 17275,0 17317,1 17406,0 17467,1 17524,0 17594,1 17674,0 17734,1 17803,0 17824,1 17886,0 17969,1 17982,0 17986,1 18073,0 18165,1 18264,0 18278,1 18317,0 18369,1 18438,0 18489,1 18502,0 18541,1 18589,0 18654,1 18740,0 18800,1 18812,0 18831,1 18885,0 18980,1 19032,0 19116,1 19121,0 19191,1 19264,0 19276,1 19290,0 19305,1 19402,0 19406,1 19413,0 19462,1 19475,0 19524,1 19528,0 19540,1 19624,0 19718,1 19778,0 19851,1 19903,0 19912,1 19920,0 19979,1 19995,0 20081,1 20135,0 20197,1 20272,0 20355,1 20406,0 20445,1 20538,0 20595,1 20605,0 20637,1 20704,0 20764,1 20852,0 20872,1 20963,0 20972,1 21035,0 21112,1 21203,0 21292,1 21320,0 21332,1 21344,0 21385,1 21433,0 21443,1 21460,0 21543,1 21593,0 21660,1 21673,0 21740,1 21838,0 21874,1 21885,0 21937,1 22033,0 22040,1 22113,0 22196,1 22229,0 22261,1 22336,0 22340,1 22343,0 22378,1 22385,0 22389,1 22485,0 22500,1 22600,0 22644,1 22709,0 22771,1 22773,0 22777,1 22808,0 22812,1 22909,0 22912,1 22992,0 23003,1 23075,0 23094,1 23154,0 23224,1 23291,0 23386,1 23419,0 23500,1 23586,0 23603,1 23627,0 23675,1 23678,0 23777,1 23795,0 23854,1 23928,0 23977,1 24018,0 24030,1 24087,0 24176,1 24254,0 24283,1 24337,0 24379,1 24434,0 24514,1 24580,0 24657,1 24743,0 24835,1 24886,0 24930,1 25003,0 25065,1 25146,0 25147,1 25175,0 25214,1 25280,0 25328,1 25403,0 25424,1 25493,0 25523,1 25605,0 25627,1 25660,0 25743,1 25804,0 25899,1 25914,0 25955,1 25969,0 26040,1 26123,0 26134,1 26157,0 26205,1 26215,0 26266,1 26291,0 26339,1 26416,0 26424,1 26450,0 26523,1 26538,0 26621,1 26695,0 26696,1 26773,0 26834,1 26868,0 26968,1 27033,0 27128,1 27141,0 27212,1 27277,0 27363,1 27437,0 27458,1 27472,0 27554,1 27605,0 27643,1 27653,0 27676,1 27745,0 27752,1 27794,0 27814,1 27837,0 27880,1 27905,0 27909,1 27930,0 27931,1 28026,0 28051,1 28084,0 28173,1 28247,0 28262,1 28266,0 28279,1 28364,0 28414,1 28489,0 28569,1 28640,0 28708,1 28718,0 28801,1 28872,0 28923,1 29018,0 29033,1 29106,0 29146,1 29174,0 29270,1 29278,0 29307,1 29395,0 29409,1 29472,0 29540,1 29630,0 29651,1 29653,0 29693,1 29753,0 29814,1 29825,0 29901,1 29942,0 29958,1 30031,0 30103,1 30198,0 30242,1 30290,0 30309,1 30355,0 30445,1 30485,0 30556,1 30644,0 30694,1 30782,0 30849,1 30885,0 30931,1 30966,0 30976,1 31074,0 31099,1 31120,0 31210,1 31220,0 31246,1 31317,0 31393,1 31448,0 31506,1 31539,0 31600,1 31624,0 31684,1 31716,0 31809,1 31889,0 31893,1 31912,0 32005,1 32073,0 32164,1 32172,0 32228,1 32307,0 32342,1 32373,0 32429,1 32455,0 32539,1 32611,0 32626,1 32634,0 32712,1 32755,0 32831,1 32904,0 32947,1 32992,0 33022,1 33030,0 33053,1 33059,0 33097,1 33136,0 33178,1 33238,0 33281,1 33362,0 33416,1 33477,0 33534,1 33540,0 33629,1 33701,0 33739,1 33830,0 33912,1 33992,0 34014,1 34077,0 34116,1 34188,0 34279,1 34308,0 34332,1 34382,0 34479,1 34535,0 34590,1 34622,0 34634,1 34700,0 34743,1 34768,0 34813,1 34839,0 34915,1 34961,0 35022,1 35069,0 35149,1 35220,0 35287,1 35291,0 35378,1 35418,0 35503,1 35565,0 35600,1 35659,0 35726,1 35793,0 35883,1 35955,0 35993,1 36020,0 36063,1 36147,0 36247,1 36289,0 36377,1 36396,0 36411,1 36502,0 36557,1 36627,0 36685,1 36726,0 36768,1 36855,0 36878,1 36907,0 36987,1 37037,0 37045,1 37101,0 37129,1 37145,0 37178,1 37256,0 37340,1 37398,0 37408,1 37482,0 37509,1 37519,0 37539,1 37631,0 37652,1 37731,0 37736,1 37783,0 37795,1 37887,0 37925,1 37975,0 38045,1 38084,0 38162,1 38241,0 38299,1 38371,0 38409,1 38490,0 38505,1 38525,0 38595,1 38676,0 38744,1 38762,0 38771,1 38852,0 38871,1 38920,0 38962,1 39054,0 39106,1 39141,0 39196,1 39223,0 39307,1 39403,0 39455,1 39546,0 39549,1 39556,0 39565,1 39649,0 39724,1 39750,0 39818,1 39838,0 39867,1 39952,0 40008,1 40108,0 40154,1 40197,0 40279,1 40342,0 40382,1 40452,0 40531,1 40599,0 40678,1 40759,0 40824,1 40913,0 40998,1 41061,0 41115,1 41128,0 41173,1 41264,0 41314,1 41396,0 41415,1 41488,0 41559,1 41577,0 41617,1 41692,0 41703,1 41735,0 41756,1 41825,0 41868,1 41939,0 42032,1 42131,0 42207,1 42235,0 42287,1 42317,0 42382,1 42446,0 42492,1 42556,0 42625,1 42699,0 42718,1 42742,0 42791,1 42880,0 42882,1 42932,0 42996,1 43038,0 43073,1 43152,0 43208,1 43253,0 43263,1 43341,0 43360,1 43446,0 43457,1 43476,0 43550,1 43601,0 43689,1 43734,0 43758,1 43852,0 43931,1 44023,0 44033,1 44121,0 44153,1 44193,0 44285,1 44306,0 44383,1 44432,0 44491,1 44591,0 44637,1 44694,0 44703,1 44744,0 44746,1 44786,0 44818,1 44868,0 44873,1 44932,0 44988,1 45038,0 45101,1 45133,0 45225,1 45274,0 45324,1 45366,0 45460,1 45504,0 45595,1 45615,0 45715,1 45810,0 45822,1 45861,0 45879,1 45956,0 45973,1 46027,0 46080,1 46158,0 46177,1 46199,0 46286,1 46366,0 46417,1 46504,0 46539,1 46554,0 46645,1 46733,0 46752,1 46830,0 46905,1 46987,0 47065,1 47120,0 47165,1 47231,0 47307,1 47390,0 47451,1 47521,0 47552,1 47558,0 47607,1 47628,0 47681,1 47691,0 47733,1 47794,0 47844,1 47924,0 48014,1 48062,0 48079,1 48157,0 48187,1 48254,0 48318,1 48373,0 48446,1 48538,0 48567,1 48645,0 48704,1 48758,0 48852,1 48914,0 48995,1 49067,0 49107,1 49124,0 49147,1 49176,0 49220,1 49233,0 49294,1 49301,0 49347,1 49399,0 49450,1 49469,0 49476,1 49533,0 49611,1 49671,0 49693,1 49702,0 49790,1 49886,0 49969,1 50013,0 50070,1 50159,0 50241,1 50329,0 50416,1 50425,0 50466,1 50504,0 50581,1 50647,0 50701,1 50714,0 50725,1 50765,0 50862,1 end initlist b4 0,0 85,1 175,0 268,1 349,0 423,1 426,0 487,1 542,0 625,1 709,0 773,1 776,0 818,1 897,0 917,1 984,0 1046,1 1075,0 1095,1 1106,0 1124,1 1196,0 1296,1 1370,0 1454,1 1524,0 1532,1 1566,0 1646,1 1679,0 1743,1 1752,0 1782,1 1791,0 1844,1 1863,0 1916,1 1936,0 1995,1 2018,0 2037,1 2121,0 2198,1 2266,0 2297,1 2326,0 2356,1 2412,0 2454,1 2457,0 2470,1 2477,0 2484,1 2502,0 2522,1 2567,0 2618,1 2621,0 2654,1 2715,0 2748,1 2794,0 2803,1 2834,0 2905,1 2927,0 2952,1 2965,0 3048,1 3148,0 3160,1 3260,0 3293,1 3316,0 3400,1 3454,0 3468,1 3482,0 3559,1 3626,0 3658,1 3748,0 3779,1 3828,0 3871,1 3967,0 3976,1 3984,0 4024,1 4064,0 4069,1 4090,0 4171,1 4220,0 4319,1 4327,0 4403,1 4415,0 4505,1 4566,0 4637,1 4706,0 4746,1 4839,0 4890,1 4956,0 5022,1 5122,0 5175,1 5177,0 5228,1 5328,0 5385,1 5420,0 5477,1 5567,0 5664,1 5762,0 5846,1 5880,0 5938,1 6008,0 6088,1 6106,0 6198,1 6281,0 6298,1 6349,0 6446,1 6527,0 6552,1 6602,0 6671,1 6719,0 6732,1 6755,0 6829,1 6891,0 6944,1 6954,0 7038,1 7044,0 7102,1 7110,0 7209,1 7285,0 7357,1 7422,0 7448,1 7464,0 7492,1 7592,0 7655,1 7691,0 7705,1 7716,0 7801,1 7859,0 7943,1 7947,0 8017,1 8054,0 8114,1 8139,0 8145,1 8200,0 8269,1 8280,0 8297,1 8353,0 8402,1 8474,0 8492,1 8495,0 8552,1 8611,0 8684,1 8750,0 8808,1 8853,0 8939,1 9033,0 9044,1 9137,0 9192,1 9238,0 9307,1 9327,0 9427,1 9495,0 9509,1 9541,0 9558,1 9628,0 9629,1 9677,0 9725,1 9747,0 9830,1 9840,0 9857,1 9871,0 9955,1 10025,0 10063,1 10128,0 10223,1 10288,0 10318,1 10336,0 10435,1 10441,0 10448,1 10454,0 10515,1 10588,0 10659,1 10684,0 10754,1 10810,0 10906,1 10958,0 11056,1 11139,0 11153,1 11231,0 11293,1 11387,0 11441,1 11489,0 11511,1 11534,0 11602,1 11605,0 11643,1 11685,0 11744,1 11792,0 11800,1 11802,0 11843,1 11865,0 11873,1 11936,0 12028,1 12039,0 12107,1 12168,0 12179,1 12212,0 12271,1 12294,0 12315,1 12346,0 12419,1 12510,0 12571,1 12651,0 12708,1 12733,0 12806,1 12871,0 12920,1 12981,0 12996,1 13071,0 13159,1 13197,0 13276,1 13279,0 13295,1 13383,0 13403,1 13479,0 13526,1 13531,0 13600,1 13634,0 13682,1 13769,0 13844,1 13874,0 13974,1 14017,0 14030,1 14124,0 14139,1 14184,0 14197,1 14280,0 14287,1 14293,0 14316,1 14363,0 14373,1 14375,0 14456,1 14467,0 14498,1 14522,0 14607,1 14649,0 14728,1 14800,0 14826,1 14913,0 14995,1 15089,0 15157,1 15176,0 15198,1 15254,0 15288,1 15299,0 15380,1 15430,0 15509,1 15575,0 15591,1 15688,0 15709,1 15741,0 15744,1 15843,0 15860,1 15882,0 15957,1 16032,0 16089,1 16158,0 16187,1 16270,0 16339,1 16361,0 16420,1 16484,0 16583,1 16677,0 16700,1 16776,0 16829,1 16840,0 16912,1 16995,0 17001,1 17081,0 17145,1 17156,0 17253,1 17266,0 17361,1 17397,0 17420,1 17433,0 17521,1 17618,0 17692,1 17724,0 17785,1 17835,0 17852,1 17945,0 17974,1 18038,0 18119,1 18205,0 18237,1 18311,0 18394,1 18455,0 18456,1 18503,0 18578,1 18587,0 18590,1 18625,0 18691,1 18693,0 18730,1 18749,0 18847,1 18886,0 18961,1 18965,0 19021,1 19068,0 19162,1 19207,0 19278,1 19376,0 19382,1 19442,0 19541,1 19562,0 19568,1 19597,0 19697,1 19721,0 19731,1 19740,0 19815,1 19894,0 19924,1 19956,0 20043,1 20094,0 20178,1 20230,0 20298,1 20387,0 20400,1 20403,0 20477,1 20495,0 20504,1 20588,0 20603,1 20627,0 20717,1 20799,0 20883,1 20913,0 20943,1 20963,0 20972,1 21032,0 21111,1 21154,0 21197,1 21290,0 21306,1 21372,0 21436,1 21488,0 21499,1 21522,0 21598,1 21664,0 21761,1 21834,0 21931,1 21997,0 22022,1 22034,0 22098,1 22114,0 22184,1 22197,0 22223,1 22264,0 22361,1 22448,0 22519,1 22561,0 22601,1 22680,0 22681,1 22738,0 22794,1 22864,0 22951,1 23001,0 23066,1 23151,0 23248,1 23341,0 23353,1 23378,0 23429,1 23490,0 23549,1 23580,0 23603,1 23668,0 23744,1 23773,0 23836,1 23882,0 23962,1 24042,0 24118,1 24192,0 24202,1 24248,0 24288,1 24302,0 24335,1 24405,0 24474,1 24507,0 24549,1 24553,0 24586,1 24631,0 24729,1 24827,0 24863,1 24951,0 25046,1 25114,0 25173,1 25246,0 25307,1 25377,0 25384,1 25396,0 25480,1 25527,0 25541,1 25561,0 25578,1 25629,0 25679,1 25727,0 25809,1 25816,0 25873,1 25930,0 25959,1 25961,0 25973,1 25997,0 26082,1 26091,0 26173,1 26211,0 26233,1 26273,0 26315,1 26402,0 26424,1 26441,0 26495,1 26552,0 26624,1 26643,0 26731,1 26763,0 26837,1 26906,0 26926,1 26953,0 27005,1 27074,0 27101,1 27155,0 27171,1 27244,0 27294,1 27319,0 27329,1 27363,0 27389,1 27462,0 27545,1 27546,0 27603,1 27665,0 27673,1 27731,0 27772,1 27828,0 27831,1 27886,0 27971,1 28012,0 28077,1 28163,0 28197,1 28241,0 28315,1 28405,0 28447,1 28458,0 28522,1 28609,0 28694,1 28751,0 28781,1 28858,0 28902,1 28934,0 29029,1 29031,0 29089,1 29127,0 29151,1 29174,0 29198,1 29213,0 29301,1 29375,0 29406,1 29457,0 29481,1 29548,0 29598,1 29605,0 29610,1 29631,0 29701,1 29788,0 29841,1 29929,0 29945,1 30023,0 30110,1 30185,0 30250,1 30298,0 30316,1 30407,0 30496,1 30511,0 30518,1 30543,0 30630,1 30676,0 30770,1 30848,0 30924,1 30927,0 30942,1 30996,0 31060,1 31123,0 31138,1 31224,0 31282,1 31338,0 31397,1 31488,0 31555,1 31580,0 31647,1 31739,0 31785,1 31879,0 31918,1 31980,0 32018,1 32108,0 32189,1 32214,0 32243,1 32343,0 32428,1 32492,0 32564,1 32625,0 32634,1 32683,0 32687,1 32691,0 32712,1 32741,0 32808,1 32892,0 32898,1 32951,0 33018,1 33106,0 33178,1 33198,0 33215,1 33297,0 33343,1 33424,0 33459,1 33480,0 33559,1 33607,0 33644,1 33655,0 33727,1 33778,0 33836,1 33856,0 33944,1 34003,0 34026,1 34032,0 34061,1 34133,0 34167,1 34258,0 34291,1 34307,0 34348,1 34378,0 34395,1 34420,0 34442,1 34505,0 34566,1 34616,0 34676,1 34745,0 34825,1 34865,0 34945,1 34988,0 35029,1 35080,0 35174,1 35264,0 35356,1 35377,0 35394,1 35420,0 35458,1 35480,0 35520,1 35613,0 35697,1 35699,0 35755,1 35820,0 35913,1 35916,0 36014,1 36015,0 36047,1 36058,0 36127,1 36212,0 36288,1 36354,0 36454,1 36479,0 36540,1 36590,0 36592,1 36617,0 36621,1 36654,0 36688,1 36770,0 36778,1 36795,0 36873,1 36931,0 36997,1 37002,0 37079,1 37085,0 37167,1 37201,0 37214,1 37274,0 37311,1 37335,0 37415,1 37511,0 37528,1 37577,0 37657,1 37720,0 37798,1 37829,0 37904,1 37962,0 37977,1 38021,0 38069,1 38134,0 38173,1 38220,0 38300,1 38345,0 38374,1 38457,0 38531,1 38540,0 38624,1 38647,0 38720,1 38817,0 38852,1 38863,0 38946,1 38999,0 39074,1 39171,0 39179,1 39235,0 39247,1 39253,0 39293,1 39391,0 39477,1 39576,0 39591,1 39597,0 39689,1 39779,0 39807,1 39885,0 39971,1 40042,0 40054,1 40062,0 40146,1 40243,0 40250,1 40296,0 40363,1 40423,0 40425,1 40457,0 40525,1 40612,0 40630,1 40665,0 40689,1 40751,0 40769,1 40837,0 40910,1 40941,0 40989,1 41032,0 41074,1 41106,0 41157,1 41240,0 41282,1 41325,0 41340,1 41415,0 41426,1 41494,0 41534,1 41565,0 41647,1 41667,0 41674,1 41696,0 41761,1 41776,0 41780,1 41828,0 41868,1 41954,0 42045,1 42051,0 42104,1 42176,0 42203,1 42298,0 42390,1 42411,0 42501,1 42591,0 42631,1 42722,0 42737,1 42795,0 42850,1 42868,0 42957,1 43030,0 43123,1 43142,0 43173,1 43183,0 43241,1 43329,0 43403,1 43453,0 43467,1 43516,0 43538,1 43603,0 43653,1 43654,0 43733,1 43755,0 43833,1 43927,0 44016,1 44090,0 44145,1 44188,0 44204,1 44233,0 44311,1 44351,0 44443,1 44454,0 44543,1 44583,0 44625,1 44627,0 44720,1 44815,0 44862,1 44942,0 44946,1 45031,0 45093,1 45160,0 45247,1 45306,0 45324,1 45329,0 45384,1 45388,0 45453,1 45513,0 45578,1 45626,0 45700,1 45729,0 45813,1 45887,0 45979,1 46022,0 46096,1 46111,0 46173,1 46203,0 46252,1 46265,0 46288,1 46322,0 46375,1 46472,0 46508,1 46566,0 46659,1 46709,0 46761,1 46816,0 46852,1 46905,0 46918,1 46984,0 47061,1 47151,0 47233,1 47276,0 47357,1 47428,0 47464,1 47522,0 47546,1 47633,0 47688,1 47750,0 47848,1 47861,0 47950,1 48027,0 48098,1 48157,0 48207,1 48229,0 48297,1 48327,0 48363,1 48442,0 48517,1 48587,0 48646,1 48705,0 48790,1 48854,0 48945,1 48952,0 48968,1 48994,0 49053,1 49134,0 49197,1 49210,0 49226,1 49263,0 49267,1 49330,0 49372,1 49428,0 49504,1 49544,0 49552,1 49648,0 49692,1 49780,0 49836,1 49890,0 49892,1 49949,0 49988,1 50070,0 50153,1 50159,0 50201,1 50260,0 50262,1 50316,0 50338,1 end initlist b5 0,0 85,1 138,0 184,1 211,0 286,1 316,0 372,1 398,0 489,1 533,0 581,1 612,0 711,1 722,0 806,1 862,0 959,1 1000,0 1027,1 1034,0 1046,1 1113,0 1192,1 1250,0 1335,1 1429,0 1438,1 1475,0 1513,1 1540,0 1595,1 1663,0 1762,1 1829,0 1866,1 1882,0 1911,1 1915,0 1984,1 2047,0 2138,1 2184,0 2216,1 2256,0 2311,1 2376,0 2423,1 2521,0 2599,1 2690,0 2776,1 2826,0 2888,1 2939,0 3028,1 3080,0 3084,1 3092,0 3156,1 3249,0 3349,1 3431,0 3444,1 3539,0 3636,1 3665,0 3749,1 3760,0 3793,1 3884,0 3964,1 3975,0 3984,1 3999,0 4076,1 4130,0 4175,1 4245,0 4340,1 4341,0 4357,1 4414,0 4497,1 4535,0 4566,1 4571,0 4635,1 4701,0 4772,1 4861,0 4882,1 4920,0 5016,1 5049,0 5106,1 5170,0 5248,1 5269,0 5272,1 5280,0 5327,1 5386,0 5480,1 5556,0 5562,1 5640,0 5703,1 5704,0 5738,1 5833,0 5909,1 5910,0 5915,1 5972,0 6072,1 6152,0 6175,1 6257,0 6288,1 6310,0 6401,1 6409,0 6473,1 6512,0 6605,1 6639,0 6710,1 6751,0 6813,1 6836,0 6861,1 6887,0 6950,1 7026,0 7043,1 7141,0 7217,1 7246,0 7336,1 7389,0 7390,1 7427,0 7478,1 7495,0 7562,1 7649,0 7658,1 7726,0 7751,1 7786,0 7843,1 7864,0 7962,1 8023,0 8086,1 8091,0 8135,1 8158,0 8163,1 8242,0 8305,1 8340,0 8412,1 8422,0 8490,1 8543,0 8577,1 8585,0 8604,1 8668,0 8760,1 8848,0 8870,1 8950,0 9042,1 9104,0 9196,1 9286,0 9304,1 9338,0 9386,1 9450,0 9475,1 9480,0 9525,1 9610,0 9666,1 9733,0 9744,1 9752,0 9824,1 9842,0 9855,1 9914,0 10005,1 10104,0 10176,1 10216,0 10305,1 10358,0 10434,1 10489,0 10495,1 10561,0 10605,1 10675,0 10676,1 10774,0 10842,1 10872,0 10963,1 11041,0 11098,1 11128,0 11164,1 11188,0 11194,1 11240,0 11264,1 11278,0 11366,1 11456,0 11546,1 11601,0 11700,1 11717,0 11792,1 11881,0 11936,1 11965,0 11984,1 12053,0 12141,1 12147,0 12203,1 12275,0 12345,1 12399,0 12482,1 12567,0 12606,1 12611,0 12704,1 12737,0 12778,1 12781,0 12867,1 12929,0 12931,1 12962,0 13057,1 13061,0 13135,1 13223,0 13238,1 13279,0 13338,1 13374,0 13411,1 13455,0 13526,1 13536,0 13630,1 13656,0 13677,1 13724,0 13819,1 13887,0 13916,1 13959,0 14008,1 14090,0 14128,1 14195,0 14196,1 14290,0 14355,1 14447,0 14523,1 14598,0 14636,1 14641,0 14674,1 14699,0 14743,1 14840,0 14853,1 14895,0 14969,1 15027,0 15104,1 15127,0 15192,1 15226,0 15231,1 15244,0 15258,1 15275,0 15329,1 15345,0 15413,1 15455,0 15529,1 15564,0 15630,1 15720,0 15762,1 15848,0 15916,1 15920,0 16019,1 16097,0 16167,1 16248,0 16313,1 16350,0 16425,1 16471,0 16497,1 16519,0 16548,1 16572,0 16573,1 16614,0 16669,1 16700,0 16761,1 16764,0 16857,1 16935,0 16994,1 17006,0 17022,1 17110,0 17189,1 17206,0 17242,1 17274,0 17276,1 17277,0 17318,1 17399,0 17452,1 17505,0 17584,1 17625,0 17717,1 17776,0 17844,1 17941,0 18017,1 18018,0 18089,1 18172,0 18205,1 18252,0 18280,1 18312,0 18348,1 18401,0 18402,1 18421,0 18465,1 18549,0 18631,1 18701,0 18775,1 18840,0 18903,1 18953,0 19012,1 19076,0 19124,1 19194,0 19233,1 19238,0 19318,1 19405,0 19434,1 19481,0 19503,1 19534,0 19596,1 19622,0 19650,1 19725,0 19803,1 19848,0 19945,1 19992,0 20016,1 20099,0 20106,1 20202,0 20241,1 20246,0 20267,1 20323,0 20340,1 20395,0 20422,1 20436,0 20521,1 20600,0 20634,1 20707,0 20786,1 20814,0 20844,1 20878,0 20919,1 20922,0 20935,1 21021,0 21118,1 21142,0 21178,1 21214,0 21294,1 21313,0 21382,1 21427,0 21467,1 21563,0 21586,1 21645,0 21702,1 21776,0 21801,1 21893,0 21936,1 22014,0 22084,1 22148,0 22218,1 22315,0 22386,1 22408,0 22429,1 22464,0 22541,1 22567,0 22568,1 22650,0 22663,1 22740,0 22774,1 22834,0 22853,1 22927,0 22954,1 22970,0 23049,1 23146,0 23176,1 23252,0 23350,1 23360,0 23405,1 23408,0 23505,1 23520,0 23526,1 23590,0 23667,1 23745,0 23769,1 23834,0 23921,1 23963,0 24028,1 24116,0 24119,1 24128,0 24172,1 24207,0 24227,1 24296,0 24338,1 24422,0 24502,1 24582,0 24635,1 24651,0 24688,1 24700,0 24737,1 24752,0 24780,1 24838,0 24881,1 24960,0 25000,1 25040,0 25128,1 25224,0 25308,1 25380,0 25474,1 25574,0 25616,1 25654,0 25725,1 25819,0 25836,1 25854,0 25900,1 25941,0 25971,1 26006,0 26064,1 26146,0 26188,1 26287,0 26379,1 26454,0 26489,1 26532,0 26595,1 26629,0 26665,1 26763,0 26770,1 26802,0 26834,1 26892,0 26913,1 26988,0 27058,1 27075,0 27135,1 27175,0 27261,1 27327,0 27328,1 27329,0 27364,1 27388,0 27484,1 27563,0 27580,1 27641,0 27734,1 27743,0 27745,1 27778,0 27799,1 27847,0 27916,1 27996,0 28085,1 28114,0 28181,1 28265,0 28300,1 28371,0 28390,1 28397,0 28477,1 28552,0 28634,1 28721,0 28767,1 28790,0 28842,1 28871,0 28895,1 28957,0 28965,1 29053,0 29153,1 29245,0 29304,1 29344,0 29370,1 29407,0 29447,1 29464,0 29522,1 29606,0 29633,1 29652,0 29653,1 29753,0 29815,1 29852,0 29911,1 29946,0 30029,1 30083,0 30173,1 30222,0 30264,1 30287,0 30297,1 30339,0 30383,1 30442,0 30511,1 30606,0 30647,1 30733,0 30798,1 30881,0 30943,1 30954,0 30988,1 31064,0 31096,1 31113,0 31165,1 31172,0 31252,1 31267,0 31327,1 31348,0 31388,1 31428,0 31470,1 31476,0 31518,1 31568,0 31666,1 31692,0 31773,1 31804,0 31856,1 31882,0 31944,1 31970,0 32012,1 32029,0 32091,1 32126,0 32151,1 32163,0 32204,1 32293,0 32308,1 32325,0 32349,1 32352,0 32377,1 32432,0 32480,1 32488,0 32578,1 32661,0 32717,1 32783,0 32823,1 32866,0 32886,1 32890,0 32950,1 33012,0 33070,1 33159,0 33256,1 33259,0 33266,1 33294,0 33370,1 33437,0 33514,1 33602,0 33649,1 33669,0 33763,1 33806,0 33866,1 33906,0 33915,1 33960,0 33965,1 33994,0 34064,1 34105,0 34111,1 34188,0 34263,1 34357,0 34425,1 34490,0 34533,1 34550,0 34649,1 34723,0 34735,1 34831,0 34929,1 35009,0 35042,1 35050,0 35115,1 35122,0 35199,1 35236,0 35312,1 35365,0 35402,1 35457,0 35460,1 35509,0 35569,1 35651,0 35662,1 35739,0 35780,1 35822,0 35875,1 35935,0 35954,1 36020,0 36049,1 36121,0 36131,1 36170,0 36243,1 36274,0 36369,1 36398,0 36409,1 36420,0 36502,1 36558,0 36572,1 36586,0 36621,1 36699,0 36756,1 36773,0 36795,1 36831,0 36851,1 36927,0 37002,1 37021,0 37059,1 37154,0 37216,1 37219,0 37314,1 37363,0 37390,1 37409,0 37461,1 37469,0 37565,1 37664,0 37676,1 37712,0 37741,1 37774,0 37872,1 37958,0 38017,1 38054,0 38136,1 38179,0 38226,1 38308,0 38311,1 38341,0 38369,1 38389,0 38411,1 38414,0 38487,1 38580,0 38659,1 38733,0 38785,1 38810,0 38822,1 38827,0 38918,1 38987,0 39079,1 39127,0 39144,1 39179,0 39251,1 39302,0 39364,1 39394,0 39485,1 39582,0 39676,1 39679,0 39722,1 39813,0 39881,1 39923,0 39960,1 39968,0 39999,1 40014,0 40092,1 40149,0 40249,1 40314,0 40369,1 40413,0 40482,1 40537,0 40581,1 40624,0 40629,1 40695,0 40732,1 40789,0 40824,1 40837,0 40891,1 40915,0 40949,1 41009,0 41100,1 41132,0 41173,1 41206,0 41234,1 41255,0 41348,1 41361,0 41436,1 41476,0 41514,1 41549,0 41587,1 41615,0 41704,1 41790,0 41876,1 41961,0 41963,1 42051,0 42095,1 42130,0 42218,1 42312,0 42383,1 42429,0 42457,1 42507,0 42543,1 42603,0 42645,1 42672,0 42703,1 42751,0 42818,1 42866,0 42868,1 42963,0 42993,1 43019,0 43111,1 43122,0 43138,1 43216,0 43313,1 43363,0 43393,1 43480,0 43543,1 43561,0 43633,1 43704,0 43789,1 43823,0 43846,1 43904,0 43964,1 43975,0 44066,1 44071,0 44147,1 44226,0 44257,1 44356,0 44418,1 44482,0 44560,1 44627,0 44633,1 44698,0 44717,1 44726,0 44751,1 44851,0 44925,1 44929,0 44972,1 44986,0 45077,1 45117,0 45181,1 45253,0 45342,1 45402,0 45465,1 45556,0 45623,1 45723,0 45805,1 45874,0 45884,1 45979,0 46010,1 46046,0 46105,1 46202,0 46217,1 46260,0 46290,1 46325,0 46367,1 46438,0 46483,1 46552,0 46606,1 46638,0 46680,1 46722,0 46778,1 46818,0 46874,1 46921,0 46988,1 47018,0 47056,1 47143,0 47204,1 47207,0 47283,1 47295,0 47369,1 47443,0 47502,1 47575,0 47609,1 47629,0 47638,1 47679,0 47762,1 47848,0 47932,1 48013,0 48043,1 48142,0 48236,1 48323,0 48350,1 48361,0 48364,1 48462,0 48548,1 48625,0 48632,1 48634,0 48651,1 48699,0 48709,1 48782,0 48797,1 48836,0 48846,1 48920,0 48965,1 49004,0 49085,1 49109,0 49208,1 49219,0 49286,1 49374,0 49449,1 49465,0 49510,1 49571,0 49661,1 49705,0 49709,1 49781,0 49845,1 49937,0 49963,1 49974,0 50060,1 50136,0 50155,1 50226,0 50306,1 50365,0 50423,1 50483,0 50515,1 50520,0 50560,1 end initlist b6 0,0 86,1 171,0 191,1 275,0 304,1 383,0 409,1 451,0 478,1 569,0 651,1 687,0 716,1 722,0 761,1 822,0 851,1 946,0 997,1 1042,0 1127,1 1148,0 1218,1 1234,0 1290,1 1342,0 1380,1 1390,0 1474,1 1487,0 1578,1 1620,0 1657,1 1702,0 1725,1 1745,0 1793,1 1848,0 1860,1 1926,0 1990,1 2063,0 2106,1 2172,0 2254,1 2279,0 2358,1 2444,0 2530,1 2617,0 2698,1 2744,0 2826,1 2858,0 2905,1 2929,0 3004,1 3067,0 3134,1 3135,0 3195,1 3221,0 3272,1 3370,0 3419,1 3440,0 3510,1 3592,0 3662,1 3738,0 3778,1 3798,0 3862,1 3937,0 4011,1 4045,0 4094,1 4114,0 4132,1 4202,0 4235,1 4237,0 4327,1 4423,0 4515,1 4596,0 4614,1 4702,0 4721,1 4748,0 4800,1 4859,0 4884,1 4972,0 5036,1 5104,0 5181,1 5184,0 5262,1 5348,0 5426,1 5453,0 5484,1 5533,0 5616,1 5623,0 5679,1 5695,0 5739,1 5835,0 5896,1 5995,0 6019,1 6063,0 6095,1 6172,0 6231,1 6273,0 6351,1 6445,0 6474,1 6564,0 6606,1 6617,0 6695,1 6791,0 6821,1 6911,0 6986,1 7013,0 7020,1 7092,0 7178,1 7230,0 7329,1 7331,0 7390,1 7392,0 7479,1 7579,0 7638,1 7703,0 7729,1 7759,0 7849,1 7883,0 7912,1 7984,0 8073,1 8154,0 8231,1 8274,0 8327,1 8356,0 8455,1 8504,0 8587,1 8653,0 8703,1 8739,0 8750,1 8840,0 8860,1 8939,0 9029,1 9035,0 9049,1 9110,0 9202,1 9253,0 9328,1 9425,0 9463,1 9515,0 9518,1 9569,0 9576,1 9653,0 9683,1 9729,0 9735,1 9813,0 9870,1 9910,0 9936,1 9975,0 10044,1 10053,0 10122,1 10140,0 10178,1 10272,0 10337,1 10414,0 10422,1 10472,0 10561,1 10621,0 10708,1 10803,0 10884,1 10947,0 11001,1 11098,0 11170,1 11254,0 11336,1 11432,0 11520,1 11580,0 11646,1 11729,0 11829,1 11870,0 11893,1 11927,0 11941,1 12019,0 12031,1 12048,0 12143,1 12217,0 12236,1 12258,0 12321,1 12368,0 12394,1 12404,0 12423,1 12455,0 12534,1 12631,0 12684,1 12686,0 12764,1 12778,0 12863,1 12865,0 12944,1 12989,0 13011,1 13044,0 13079,1 13098,0 13114,1 13170,0 13246,1 13308,0 13405,1 13407,0 13428,1 13467,0 13477,1 13478,0 13531,1 13548,0 13643,1 13665,0 13666,1 13737,0 13800,1 13876,0 13893,1 13952,0 14000,1 14038,0 14079,1 14144,0 14186,1 14235,0 14265,1 14340,0 14376,1 14406,0 14492,1 14520,0 14558,1 14594,0 14657,1 14716,0 14729,1 14779,0 14786,1 14787,0 14864,1 14929,0 14978,1 15030,0 15105,1 15153,0 15202,1 15211,0 15280,1 15376,0 15433,1 15449,0 15541,1 15615,0 15694,1 15732,0 15774,1 15873,0 15956,1 16055,0 16068,1 16141,0 16177,1 16185,0 16197,1 16201,0 16211,1 16277,0 16311,1 16338,0 16415,1 16436,0 16530,1 16562,0 16575,1 16608,0 16690,1 16744,0 16798,1 16868,0 16913,1 16930,0 16963,1 16999,0 17035,1 17132,0 17225,1 17324,0 17359,1 17409,0 17467,1 17524,0 17544,1 17548,0 17625,1 17640,0 17704,1 17776,0 17841,1 17939,0 17952,1 17982,0 18047,1 18051,0 18126,1 18201,0 18272,1 18303,0 18344,1 18420,0 18490,1 18538,0 18600,1 18676,0 18737,1 18817,0 18890,1 18988,0 19038,1 19121,0 19151,1 19204,0 19213,1 19303,0 19403,1 19415,0 19444,1 19447,0 19510,1 19565,0 19580,1 19597,0 19649,1 19729,0 19798,1 19843,0 19880,1 19918,0 19955,1 19978,0 20063,1 20160,0 20239,1 20335,0 20366,1 20449,0 20486,1 20488,0 20508,1 20524,0 20538,1 20570,0 20590,1 20611,0 20654,1 20726,0 20802,1 20894,0 20964,1 20971,0 21042,1 21127,0 21152,1 21220,0 21268,1 21358,0 21393,1 21396,0 21433,1 21530,0 21581,1 21593,0 21656,1 21685,0 21752,1 21850,0 21948,1 22037,0 22114,1 22138,0 22231,1 22288,0 22339,1 22348,0 22444,1 22504,0 22562,1 22585,0 22599,1 22678,0 22699,1 22734,0 22772,1 22828,0 22875,1 22885,0 22947,1 22986,0 23033,1 23113,0 23132,1 23211,0 23272,1 23331,0 23354,1 23382,0 23451,1 23535,0 23634,1 23663,0 23715,1 23763,0 23794,1 23821,0 23883,1 23943,0 24033,1 24120,0 24142,1 24217,0 24313,1 24348,0 24353,1 24451,0 24546,1 24615,0 24665,1 24680,0 24740,1 24828,0 24894,1 24963,0 24979,1 25065,0 25150,1 25234,0 25272,1 25320,0 25334,1 25337,0 25384,1 25459,0 25537,1 25583,0 25598,1 25646,0 25739,1 25796,0 25888,1 25954,0 26029,1 26057,0 26118,1 26119,0 26176,1 26231,0 26308,1 26316,0 26332,1 26398,0 26478,1 26578,0 26651,1 26661,0 26710,1 26775,0 26778,1 26876,0 26896,1 26914,0 26970,1 27008,0 27075,1 27132,0 27223,1 27307,0 27351,1 27436,0 27511,1 27595,0 27603,1 27638,0 27721,1 27771,0 27820,1 27821,0 27840,1 27841,0 27893,1 27914,0 27981,1 27999,0 28071,1 28169,0 28233,1 28247,0 28342,1 28432,0 28466,1 28549,0 28611,1 28685,0 28783,1 28865,0 28933,1 28935,0 29007,1 29033,0 29038,1 29095,0 29125,1 29129,0 29212,1 29261,0 29262,1 29338,0 29353,1 29369,0 29441,1 29490,0 29574,1 29601,0 29653,1 29711,0 29770,1 29796,0 29838,1 29933,0 29980,1 30073,0 30122,1 30135,0 30212,1 30310,0 30406,1 30456,0 30525,1 30561,0 30630,1 30698,0 30789,1 30852,0 30874,1 30949,0 31021,1 31033,0 31125,1 31168,0 31210,1 31216,0 31280,1 31357,0 31450,1 31472,0 31534,1 31563,0 31641,1 31700,0 31771,1 31840,0 31878,1 31977,0 32042,1 32073,0 32138,1 32163,0 32233,1 32293,0 32342,1 32442,0 32504,1 32565,0 32583,1 32659,0 32725,1 32765,0 32840,1 32869,0 32929,1 32955,0 32986,1 32993,0 33063,1 33126,0 33180,1 33209,0 33220,1 33277,0 33317,1 33320,0 33341,1 33403,0 33467,1 33483,0 33554,1 33598,0 33668,1 33719,0 33797,1 33838,0 33900,1 33942,0 33969,1 34026,0 34121,1 34196,0 34274,1 34343,0 34357,1 34402,0 34435,1 34453,0 34541,1 34608,0 34654,1 34731,0 34824,1 34856,0 34895,1 34926,0 34988,1 35039,0 35112,1 35196,0 35261,1 35287,0 35324,1 35424,0 35496,1 35501,0 35514,1 35532,0 35603,1 35615,0 35658,1 35698,0 35785,1 35814,0 35908,1 35985,0 36064,1 36067,0 36130,1 36227,0 36310,1 36376,0 36401,1 36470,0 36489,1 36540,0 36630,1 36632,0 36666,1 36697,0 36718,1 36731,0 36745,1 36777,0 36839,1 36909,0 36975,1 37006,0 37062,1 37083,0 37133,1 37166,0 37259,1 37350,0 37382,1 37402,0 37423,1 37510,0 37525,1 37615,0 37693,1 37737,0 37751,1 37822,0 37914,1 37928,0 37986,1 38004,0 38008,1 38031,0 38072,1 38073,0 38103,1 38151,0 38203,1 38210,0 38306,1 38309,0 38389,1 38418,0 38462,1 38532,0 38534,1 38616,0 38633,1 38662,0 38715,1 38746,0 38805,1 38883,0 38966,1 38971,0 39015,1 39071,0 39104,1 39182,0 39193,1 39239,0 39259,1 39338,0 39422,1 39428,0 39456,1 39500,0 39591,1 39655,0 39695,1 39794,0 39796,1 39807,0 39881,1 39886,0 39896,1 39979,0 40022,1 40062,0 40117,1 40209,0 40229,1 40283,0 40342,1 40416,0 40468,1 40473,0 40558,1 40654,0 40740,1 40819,0 40855,1 40913,0 40977,1 40980,0 41060,1 41091,0 41119,1 41125,0 41157,1 41199,0 41256,1 41290,0 41291,1 41294,0 41369,1 41451,0 41480,1 41546,0 41555,1 41611,0 41646,1 41737,0 41748,1 41823,0 41868,1 41882,0 41952,1 42040,0 42053,1 42097,0 42110,1 42142,0 42198,1 42286,0 42291,1 42307,0 42358,1 42426,0 42441,1 42480,0 42513,1 42518,0 42522,1 42601,0 42646,1 42703,0 42713,1 42733,0 42765,1 42783,0 42811,1 42893,0 42959,1 43058,0 43082,1 43163,0 43242,1 43313,0 43380,1 43422,0 43436,1 43525,0 43586,1 43630,0 43670,1 43732,0 43743,1 43784,0 43821,1 43865,0 43898,1 43981,0 44062,1 44075,0 44145,1 44149,0 44229,1 44280,0 44337,1 44434,0 44468,1 44490,0 44496,1 44512,0 44575,1 44600,0 44685,1 44720,0 44806,1 44850,0 44889,1 44924,0 44968,1 44985,0 45034,1 45092,0 45107,1 45145,0 45194,1 45262,0 45276,1 45305,0 45353,1 45403,0 45450,1 45536,0 45631,1 45632,0 45668,1 45684,0 45783,1 45878,0 45907,1 45959,0 46042,1 46059,0 46138,1 46152,0 46154,1 46232,0 46253,1 46257,0 46315,1 46389,0 46467,1 46506,0 46569,1 46630,0 46661,1 46761,0 46774,1 46794,0 46852,1 46924,0 46997,1 47049,0 47143,1 47214,0 47305,1 47405,0 47409,1 47464,0 47466,1 47523,0 47617,1 47684,0 47696,1 47731,0 47807,1 47841,0 47868,1 47869,0 47872,1 47890,0 47958,1 48055,0 48132,1 48150,0 48242,1 48329,0 48405,1 48454,0 48460,1 48519,0 48605,1 48647,0 48667,1 48698,0 48701,1 48736,0 48806,1 48856,0 48901,1 48991,0 49082,1 49120,0 49184,1 49199,0 49295,1 49300,0 49395,1 49485,0 49543,1 49583,0 49664,1 49672,0 49676,1 49717,0 49722,1 49760,0 49850,1 49895,0 49961,1 50009,0 50014,1 50096,0 50116,1 50149,0 50168,1 50200,0 50238,1 50253,0 50278,1 50370,0 50455,1 50519,0 50566,1 50597,0 50611,1 50637,0 50687,1 50747,0 50819,1 50838,0 50880,1 end initlist b7 0,0 40,1 110,0 121,1 218,0 262,1 318,0 387,1 475,0 514,1 603,0 668,1 745,0 807,1 821,0 889,1 960,0 1033,1 1060,0 1145,1 1162,0 1252,1 1287,0 1364,1 1373,0 1462,1 1473,0 1498,1 1522,0 1528,1 1574,0 1600,1 1631,0 1678,1 1707,0 1770,1 1775,0 1794,1 1835,0 1904,1 1936,0 1958,1 1983,0 2053,1 2132,0 2208,1 2217,0 2280,1 2343,0 2411,1 2492,0 2574,1 2588,0 2655,1 2662,0 2743,1 2838,0 2860,1 2942,0 2960,1 3014,0 3032,1 3049,0 3138,1 3171,0 3242,1 3339,0 3417,1 3445,0 3504,1 3585,0 3677,1 3742,0 3773,1 3790,0 3819,1 3828,0 3900,1 3955,0 3956,1 3973,0 4013,1 4039,0 4085,1 4127,0 4222,1 4271,0 4368,1 4388,0 4475,1 4515,0 4525,1 4594,0 4690,1 4787,0 4791,1 4801,0 4865,1 4933,0 5000,1 5051,0 5072,1 5135,0 5166,1 5200,0 5259,1 5282,0 5330,1 5373,0 5407,1 5460,0 5513,1 5521,0 5608,1 5687,0 5710,1 5793,0 5875,1 5951,0 5955,1 6004,0 6057,1 6084,0 6172,1 6193,0 6237,1 6247,0 6256,1 6336,0 6416,1 6458,0 6492,1 6556,0 6596,1 6692,0 6748,1 6797,0 6812,1 6824,0 6844,1 6862,0 6945,1 7017,0 7033,1 7038,0 7076,1 7107,0 7190,1 7274,0 7295,1 7319,0 7360,1 7391,0 7454,1 7480,0 7523,1 7607,0 7617,1 7697,0 7735,1 7799,0 7855,1 7953,0 7979,1 7997,0 8014,1 8045,0 8046,1 8108,0 8118,1 8170,0 8192,1 8198,0 8267,1 8348,0 8352,1 8442,0 8511,1 8588,0 8686,1 8703,0 8742,1 8836,0 8923,1 8996,0 9063,1 9144,0 9199,1 9267,0 9310,1 9386,0 9448,1 9482,0 9535,1 9586,0 9643,1 9703,0 9742,1 9833,0 9874,1 9875,0 9914,1 9938,0 9948,1 9983,0 9991,1 10050,0 10090,1 10185,0 10285,1 10344,0 10378,1 10428,0 10525,1 10552,0 10601,1 10607,0 10662,1 10746,0 10756,1 10757,0 10774,1 10816,0 10870,1 10879,0 10918,1 10945,0 11022,1 11111,0 11189,1 11240,0 11255,1 11270,0 11358,1 11405,0 11471,1 11562,0 11564,1 11579,0 11596,1 11614,0 11668,1 11711,0 11717,1 11779,0 11875,1 11938,0 11968,1 12040,0 12099,1 12178,0 12269,1 12296,0 12364,1 12446,0 12490,1 12537,0 12564,1 12585,0 12610,1 12619,0 12637,1 12675,0 12714,1 12800,0 12833,1 12854,0 12900,1 12980,0 12992,1 13081,0 13132,1 13193,0 13196,1 13211,0 13256,1 13335,0 13372,1 13398,0 13407,1 13424,0 13478,1 13504,0 13599,1 13679,0 13684,1 13713,0 13809,1 13900,0 13947,1 14031,0 14055,1 14148,0 14204,1 14280,0 14352,1 14398,0 14465,1 14541,0 14620,1 14685,0 14694,1 14765,0 14769,1 14810,0 14875,1 14895,0 14924,1 14973,0 15058,1 15067,0 15159,1 15161,0 15191,1 15273,0 15298,1 15360,0 15385,1 15462,0 15540,1 15553,0 15634,1 15716,0 15779,1 15825,0 15864,1 15914,0 15982,1 16040,0 16059,1 16107,0 16169,1 16227,0 16305,1 16392,0 16393,1 16419,0 16422,1 16427,0 16456,1 16488,0 16571,1 16643,0 16728,1 16741,0 16807,1 16854,0 16858,1 16955,0 16961,1 17050,0 17102,1 17103,0 17131,1 17212,0 17224,1 17304,0 17377,1 17399,0 17472,1 17485,0 17486,1 17541,0 17553,1 17653,0 17654,1 17660,0 17677,1 17721,0 17781,1 17795,0 17805,1 17850,0 17923,1 17960,0 17989,1 17991,0 18059,1 18082,0 18151,1 18157,0 18165,1 18230,0 18287,1 18338,0 18376,1 18390,0 18422,1 18504,0 18570,1 18629,0 18649,1 18727,0 18775,1 18777,0 18788,1 18870,0 18963,1 18989,0 19050,1 19065,0 19070,1 19152,0 19209,1 19213,0 19284,1 19297,0 19363,1 19377,0 19389,1 19424,0 19517,1 19556,0 19596,1 19696,0 19707,1 19713,0 19779,1 19855,0 19873,1 19883,0 19928,1 19943,0 20012,1 20076,0 20155,1 20241,0 20249,1 20310,0 20330,1 20399,0 20416,1 20476,0 20487,1 20578,0 20628,1 20659,0 20697,1 20699,0 20757,1 20811,0 20863,1 20938,0 21009,1 21042,0 21094,1 21183,0 21191,1 21286,0 21288,1 21372,0 21401,1 21460,0 21466,1 21492,0 21524,1 21575,0 21636,1 21670,0 21691,1 21710,0 21771,1 21825,0 21923,1 21956,0 22003,1 22015,0 22082,1 22141,0 22161,1 22199,0 22241,1 22275,0 22312,1 22313,0 22356,1 22392,0 22472,1 22499,0 22537,1 22553,0 22576,1 22657,0 22723,1 22798,0 22832,1 22891,0 22943,1 22971,0 23063,1 23091,0 23172,1 23185,0 23249,1 23339,0 23389,1 23410,0 23413,1 23428,0 23463,1 23560,0 23632,1 23646,0 23689,1 23754,0 23836,1 23891,0 23981,1 24025,0 24042,1 24097,0 24186,1 24210,0 24223,1 24226,0 24246,1 24277,0 24341,1 24415,0 24489,1 24580,0 24655,1 24734,0 24819,1 24885,0 24924,1 24962,0 25031,1 25106,0 25125,1 25195,0 25199,1 25296,0 25347,1 25383,0 25391,1 25418,0 25475,1 25518,0 25565,1 25580,0 25628,1 25728,0 25812,1 25878,0 25891,1 25974,0 26050,1 26096,0 26107,1 26143,0 26199,1 26251,0 26284,1 26366,0 26368,1 26424,0 26465,1 26558,0 26625,1 26641,0 26703,1 26706,0 26787,1 26861,0 26867,1 26932,0 26945,1 27023,0 27054,1 27090,0 27093,1 27179,0 27273,1 27341,0 27439,1 27449,0 27482,1 27503,0 27597,1 27671,0 27702,1 27747,0 27824,1 27837,0 27932,1 27942,0 28006,1 28048,0 28050,1 28091,0 28140,1 28193,0 28290,1 28347,0 28424,1 28464,0 28487,1 28574,0 28659,1 28713,0 28739,1 28764,0 28785,1 28862,0 28895,1 28915,0 28923,1 28954,0 29049,1 29144,0 29173,1 29208,0 29270,1 29288,0 29380,1 29427,0 29453,1 29461,0 29490,1 29577,0 29618,1 29648,0 29697,1 29789,0 29796,1 29797,0 29811,1 29891,0 29961,1 30035,0 30130,1 30229,0 30260,1 30262,0 30292,1 30384,0 30416,1 30420,0 30440,1 30529,0 30577,1 30611,0 30655,1 30669,0 30760,1 30842,0 30915,1 30959,0 31004,1 31015,0 31039,1 31055,0 31083,1 31101,0 31170,1 31221,0 31231,1 31274,0 31324,1 31370,0 31373,1 31446,0 31519,1 31604,0 31631,1 31723,0 31772,1 31776,0 31815,1 31898,0 31934,1 31994,0 32090,1 32120,0 32177,1 32274,0 32277,1 32297,0 32301,1 32368,0 32435,1 32501,0 32552,1 32633,0 32667,1 32706,0 32782,1 32848,0 32873,1 32969,0 33033,1 33129,0 33195,1 33269,0 33353,1 33417,0 33488,1 33503,0 33586,1 33634,0 33636,1 33734,0 33827,1 33890,0 33900,1 33921,0 33996,1 34082,0 34138,1 34174,0 34237,1 34303,0 34341,1 34424,0 34515,1 34565,0 34581,1 34619,0 34620,1 34626,0 34656,1 34695,0 34747,1 34793,0 34847,1 34868,0 34898,1 34911,0 35001,1 35100,0 35146,1 35229,0 35276,1 35318,0 35358,1 35397,0 35450,1 35451,0 35519,1 35562,0 35595,1 35661,0 35712,1 35723,0 35725,1 35807,0 35862,1 35868,0 35870,1 35903,0 35910,1 35982,0 36056,1 36099,0 36191,1 36260,0 36333,1 36334,0 36356,1 36369,0 36401,1 36415,0 36467,1 36548,0 36620,1 36684,0 36780,1 36804,0 36889,1 36898,0 36929,1 36944,0 36970,1 36972,0 36988,1 37065,0 37118,1 37192,0 37231,1 37305,0 37320,1 37357,0 37404,1 37417,0 37500,1 37585,0 37598,1 37605,0 37658,1 37722,0 37789,1 37796,0 37830,1 37901,0 37948,1 38012,0 38025,1 38106,0 38144,1 38219,0 38304,1 38349,0 38432,1 38521,0 38619,1 38701,0 38718,1 38767,0 38791,1 38827,0 38855,1 38907,0 38989,1 39000,0 39092,1 39116,0 39127,1 39151,0 39190,1 39224,0 39298,1 39329,0 39351,1 39358,0 39397,1 39431,0 39530,1 39610,0 39626,1 39658,0 39728,1 39826,0 39871,1 39931,0 39984,1 40009,0 40082,1 40154,0 40241,1 40324,0 40377,1 40402,0 40500,1 40580,0 40673,1 40757,0 40820,1 40877,0 40969,1 41042,0 41072,1 41094,0 41124,1 41155,0 41233,1 41309,0 41344,1 41435,0 41460,1 41493,0 41579,1 41602,0 41629,1 41641,0 41731,1 41806,0 41812,1 41834,0 41933,1 41955,0 41993,1 42071,0 42168,1 42247,0 42321,1 42418,0 42463,1 42554,0 42563,1 42577,0 42616,1 42642,0 42643,1 42710,0 42722,1 42746,0 42844,1 42899,0 42940,1 42994,0 43083,1 43117,0 43162,1 43185,0 43241,1 43268,0 43336,1 43415,0 43472,1 43537,0 43587,1 43607,0 43667,1 43679,0 43695,1 43752,0 43836,1 43886,0 43911,1 43996,0 44006,1 44069,0 44108,1 44194,0 44240,1 44259,0 44292,1 44350,0 44440,1 44509,0 44526,1 44530,0 44556,1 44578,0 44633,1 44687,0 44722,1 44783,0 44846,1 44897,0 44916,1 45011,0 45012,1 45020,0 45084,1 45176,0 45181,1 45254,0 45317,1 45404,0 45499,1 45570,0 45590,1 45615,0 45706,1 45754,0 45780,1 45841,0 45906,1 45910,0 45943,1 46018,0 46036,1 46105,0 46147,1 46246,0 46309,1 46340,0 46404,1 46465,0 46542,1 46599,0 46643,1 46714,0 46743,1 46751,0 46770,1 46824,0 46923,1 46989,0 47050,1 47148,0 47150,1 47154,0 47180,1 47264,0 47316,1 47389,0 47460,1 47463,0 47485,1 47516,0 47555,1 47649,0 47720,1 47774,0 47813,1 47847,0 47856,1 47941,0 48041,1 48109,0 48151,1 48234,0 48331,1 48379,0 48472,1 48473,0 48509,1 48600,0 48624,1 end initlist b8 0,0 57,1 157,0 204,1 298,0 315,1 375,0 451,1 473,0 506,1 548,0 571,1 622,0 681,1 747,0 825,1 830,0 918,1 931,0 1019,1 1068,0 1117,1 1180,0 1266,1 1361,0 1391,1 1416,0 1464,1 1517,0 1538,1 1580,0 1604,1 1627,0 1680,1 1706,0 1751,1 1819,0 1830,1 1850,0 1947,1 1973,0 2009,1 2021,0 2038,1 2118,0 2166,1 2235,0 2300,1 2395,0 2436,1 2518,0 2617,1 2660,0 2684,1 2761,0 2856,1 2937,0 2991,1 3044,0 3095,1 3145,0 3244,1 3344,0 3348,1 3370,0 3405,1 3426,0 3444,1 3456,0 3528,1 3573,0 3662,1 3708,0 3731,1 3734,0 3737,1 3794,0 3861,1 3865,0 3938,1 3994,0 4044,1 4132,0 4222,1 4285,0 4289,1 4385,0 4454,1 4481,0 4547,1 4628,0 4701,1 4731,0 4753,1 4776,0 4830,1 4913,0 4995,1 5006,0 5022,1 5110,0 5165,1 5264,0 5307,1 5361,0 5412,1 5450,0 5480,1 5538,0 5542,1 5603,0 5676,1 5739,0 5747,1 5768,0 5814,1 5879,0 5965,1 6025,0 6061,1 6101,0 6172,1 6178,0 6248,1 6283,0 6334,1 6367,0 6409,1 6493,0 6587,1 6606,0 6621,1 6625,0 6716,1 6726,0 6809,1 6890,0 6930,1 6992,0 7035,1 7124,0 7172,1 7235,0 7240,1 7255,0 7332,1 7353,0 7359,1 7435,0 7465,1 7493,0 7532,1 7604,0 7682,1 7724,0 7751,1 7784,0 7821,1 7834,0 7837,1 7925,0 7973,1 8000,0 8062,1 8093,0 8156,1 8171,0 8244,1 8340,0 8353,1 8419,0 8470,1 8510,0 8523,1 8605,0 8684,1 8703,0 8752,1 8758,0 8776,1 8825,0 8843,1 8889,0 8938,1 8949,0 8987,1 9060,0 9129,1 9147,0 9155,1 9159,0 9236,1 9290,0 9333,1 9416,0 9429,1 9435,0 9439,1 9504,0 9594,1 9619,0 9712,1 9790,0 9843,1 9896,0 9936,1 9966,0 9976,1 10002,0 10043,1 10118,0 10139,1 10170,0 10223,1 10226,0 10302,1 10351,0 10412,1 10504,0 10562,1 10605,0 10663,1 10755,0 10759,1 10777,0 10866,1 10878,0 10886,1 10969,0 11032,1 11066,0 11100,1 11167,0 11169,1 11241,0 11307,1 11339,0 11377,1 11438,0 11477,1 11565,0 11605,1 11641,0 11730,1 11829,0 11886,1 11891,0 11913,1 11973,0 12030,1 12117,0 12138,1 12165,0 12257,1 12308,0 12348,1 12366,0 12445,1 12519,0 12572,1 12637,0 12735,1 12820,0 12918,1 12981,0 12988,1 13019,0 13029,1 13089,0 13189,1 13240,0 13338,1 13398,0 13464,1 13474,0 13565,1 13582,0 13596,1 13639,0 13682,1 13745,0 13800,1 13801,0 13855,1 13856,0 13939,1 14002,0 14023,1 14032,0 14041,1 14064,0 14089,1 14176,0 14207,1 14247,0 14320,1 14373,0 14450,1 14479,0 14480,1 14556,0 14617,1 14706,0 14753,1 14779,0 14782,1 14837,0 14862,1 14907,0 14915,1 15002,0 15057,1 15156,0 15208,1 15250,0 15307,1 15324,0 15411,1 15507,0 15559,1 15654,0 15731,1 15750,0 15834,1 15919,0 15951,1 15967,0 15987,1 16077,0 16157,1 16233,0 16320,1 16367,0 16398,1 16443,0 16506,1 16579,0 16620,1 16698,0 16759,1 16840,0 16849,1 16910,0 16943,1 17026,0 17058,1 17135,0 17190,1 17289,0 17354,1 17425,0 17468,1 17537,0 17569,1 17608,0 17633,1 17637,0 17703,1 17756,0 17823,1 17869,0 17964,1 18034,0 18044,1 18141,0 18210,1 18258,0 18262,1 18345,0 18431,1 18489,0 18549,1 18607,0 18655,1 18709,0 18783,1 18862,0 18882,1 18942,0 18977,1 19043,0 19106,1 19177,0 19250,1 19314,0 19318,1 19353,0 19369,1 19373,0 19441,1 19454,0 19537,1 19601,0 19666,1 19684,0 19783,1 19823,0 19856,1 19898,0 19914,1 19995,0 20071,1 20126,0 20131,1 20190,0 20242,1 20247,0 20288,1 20337,0 20343,1 20396,0 20479,1 20563,0 20564,1 20613,0 20711,1 20721,0 20801,1 20900,0 20988,1 21087,0 21172,1 21249,0 21324,1 21335,0 21391,1 21461,0 21550,1 21613,0 21681,1 21738,0 21758,1 21852,0 21927,1 21964,0 21965,1 22065,0 22120,1 22150,0 22218,1 22234,0 22237,1 22320,0 22352,1 22452,0 22472,1 22548,0 22630,1 22641,0 22703,1 22775,0 22784,1 22878,0 22914,1 23014,0 23066,1 23145,0 23218,1 23228,0 23309,1 23332,0 23409,1 23457,0 23500,1 23569,0 23637,1 23727,0 23821,1 23850,0 23923,1 23944,0 24006,1 24016,0 24089,1 24175,0 24177,1 24275,0 24311,1 24397,0 24486,1 24498,0 24573,1 24631,0 24638,1 24695,0 24746,1 24822,0 24846,1 24922,0 24990,1 25055,0 25069,1 25148,0 25171,1 25226,0 25255,1 25256,0 25283,1 25329,0 25384,1 25473,0 25536,1 25618,0 25667,1 25695,0 25786,1 25878,0 25944,1 25983,0 26040,1 26103,0 26180,1 26184,0 26236,1 26321,0 26403,1 26490,0 26508,1 26563,0 26629,1 26702,0 26710,1 26786,0 26875,1 26923,0 26935,1 26966,0 27054,1 27074,0 27170,1 27257,0 27341,1 27438,0 27471,1 27518,0 27539,1 27614,0 27687,1 27779,0 27873,1 27903,0 28001,1 28025,0 28089,1 28095,0 28164,1 28235,0 28295,1 28314,0 28330,1 28399,0 28409,1 28452,0 28494,1 28576,0 28577,1 28677,0 28695,1 28787,0 28823,1 28913,0 28941,1 29026,0 29107,1 29199,0 29242,1 29266,0 29303,1 29318,0 29362,1 29412,0 29448,1 29514,0 29582,1 29625,0 29626,1 29717,0 29780,1 29812,0 29857,1 29880,0 29936,1 29954,0 29964,1 30013,0 30033,1 30096,0 30120,1 30181,0 30264,1 30298,0 30361,1 30428,0 30477,1 30479,0 30514,1 30610,0 30672,1 30702,0 30717,1 30721,0 30795,1 30893,0 30963,1 30971,0 31024,1 31099,0 31102,1 31189,0 31282,1 31284,0 31291,1 31334,0 31433,1 31487,0 31517,1 31547,0 31559,1 31564,0 31663,1 31736,0 31788,1 31853,0 31945,1 32009,0 32088,1 32113,0 32188,1 32233,0 32238,1 32283,0 32359,1 32403,0 32448,1 32519,0 32615,1 32645,0 32708,1 32724,0 32822,1 32845,0 32934,1 33026,0 33091,1 33117,0 33210,1 33240,0 33247,1 33279,0 33365,1 33379,0 33462,1 33514,0 33605,1 33622,0 33699,1 33778,0 33846,1 33920,0 33970,1 33998,0 34029,1 34093,0 34184,1 34191,0 34281,1 34308,0 34408,1 34413,0 34502,1 34568,0 34600,1 34649,0 34688,1 34747,0 34760,1 34854,0 34934,1 34987,0 35024,1 35060,0 35137,1 35196,0 35294,1 35298,0 35342,1 35405,0 35487,1 35517,0 35519,1 35556,0 35622,1 35623,0 35650,1 35713,0 35779,1 35859,0 35928,1 35939,0 35988,1 36050,0 36061,1 36090,0 36177,1 36179,0 36249,1 36264,0 36307,1 36312,0 36339,1 36430,0 36464,1 36503,0 36522,1 36588,0 36623,1 36662,0 36726,1 36743,0 36842,1 36898,0 36916,1 36992,0 37037,1 37047,0 37088,1 37150,0 37192,1 37278,0 37289,1 37388,0 37459,1 37533,0 37556,1 37568,0 37630,1 37677,0 37738,1 37788,0 37885,1 37941,0 37965,1 38054,0 38071,1 38096,0 38165,1 38191,0 38261,1 38308,0 38388,1 38431,0 38485,1 38503,0 38583,1 38648,0 38699,1 38789,0 38801,1 38807,0 38834,1 38857,0 38946,1 39033,0 39094,1 39119,0 39129,1 39190,0 39253,1 39310,0 39365,1 39455,0 39486,1 39564,0 39568,1 39613,0 39678,1 39765,0 39859,1 39935,0 39957,1 40024,0 40080,1 40118,0 40159,1 40228,0 40312,1 40406,0 40440,1 40503,0 40544,1 40586,0 40622,1 40706,0 40777,1 40841,0 40909,1 40914,0 40948,1 40953,0 41008,1 41089,0 41090,1 41160,0 41162,1 41231,0 41264,1 41347,0 41447,1 41492,0 41539,1 41617,0 41648,1 41669,0 41739,1 41773,0 41831,1 41856,0 41865,1 41876,0 41918,1 41938,0 42004,1 42018,0 42100,1 42184,0 42281,1 42303,0 42315,1 42400,0 42483,1 42509,0 42537,1 42577,0 42671,1 42714,0 42777,1 42799,0 42822,1 42915,0 42956,1 42971,0 42979,1 43051,0 43132,1 43171,0 43254,1 43318,0 43380,1 43387,0 43484,1 43512,0 43561,1 43572,0 43643,1 43691,0 43749,1 43824,0 43858,1 43917,0 43997,1 44012,0 44033,1 44071,0 44087,1 44099,0 44145,1 44151,0 44243,1 44334,0 44347,1 44418,0 44504,1 44571,0 44587,1 44625,0 44655,1 44704,0 44745,1 44803,0 44825,1 44906,0 44993,1 45048,0 45099,1 45195,0 45198,1 45265,0 45338,1 45413,0 45468,1 45479,0 45537,1 45546,0 45646,1 45652,0 45692,1 45743,0 45797,1 45855,0 45871,1 45921,0 45994,1 46017,0 46077,1 46116,0 46176,1 46198,0 46297,1 46361,0 46423,1 46519,0 46524,1 46588,0 46662,1 46680,0 46762,1 46783,0 46808,1 46895,0 46984,1 47054,0 47057,1 47140,0 47173,1 47225,0 47308,1 47358,0 47458,1 47550,0 47552,1 47626,0 47703,1 47791,0 47867,1 47929,0 48029,1 48074,0 48143,1 48215,0 48275,1 48300,0 48349,1 48437,0 48483,1 48524,0 48545,1 48634,0 48725,1 48782,0 48853,1 48896,0 48993,1 49029,0 49099,1 49110,0 49143,1 49230,0 49249,1 49259,0 49349,1 49435,0 49491,1 49512,0 49605,1 49612,0 49707,1 49784,0 49881,1 49909,0 49965,1 50005,0 50091,1 50134,0 50230,1 50249,0 50305,1 50341,0 50435,1 50436,0 50484,1 50536,0 50582,1 50583,0 50587,1 50632,0 50695,1 50706,0 50752,1 50785,0 50816,1 50907,0 50967,1 50995,0 51093,1 51168,0 51227,1 51271,0 51335,1 51434,0 51510,1 51521,0 51580,1 end initlist b9 0,0 95,1 194,0 198,1 216,0 232,1 252,0 253,1 313,0 398,1 402,0 455,1 469,0 563,1 625,0 700,1 791,0 859,1 922,0 999,1 1057,0 1113,1 1119,0 1129,1 1174,0 1268,1 1306,0 1307,1 1375,0 1405,1 1448,0 1450,1 1491,0 1494,1 1572,0 1639,1 1712,0 1797,1 1820,0 1876,1 1971,0 2055,1 2134,0 2175,1 2219,0 2271,1 2367,0 2375,1 2411,0 2427,1 2439,0 2539,1 2553,0 2573,1 2579,0 2647,1 2662,0 2744,1 2747,0 2748,1 2842,0 2910,1 2968,0 3052,1 3139,0 3152,1 3221,0 3242,1 3248,0 3308,1 3381,0 3426,1 3486,0 3574,1 3588,0 3622,1 3664,0 3713,1 3793,0 3834,1 3872,0 3922,1 3933,0 4011,1 4102,0 4178,1 4257,0 4313,1 4389,0 4401,1 4464,0 4511,1 4527,0 4532,1 4610,0 4674,1 4728,0 4737,1 4793,0 4839,1 4929,0 4961,1 5011,0 5059,1 5151,0 5200,1 5238,0 5243,1 5278,0 5322,1 5343,0 5417,1 5491,0 5521,1 5530,0 5539,1 5623,0 5649,1 5747,0 5758,1 5796,0 5840,1 5877,0 5895,1 5929,0 5942,1 5973,0 5985,1 6009,0 6088,1 6116,0 6141,1 6229,0 6315,1 6361,0 6368,1 6426,0 6449,1 6456,0 6525,1 6568,0 6614,1 6688,0 6706,1 6755,0 6777,1 6826,0 6854,1 6920,0 6970,1 6985,0 7034,1 7067,0 7166,1 7181,0 7229,1 7278,0 7282,1 7340,0 7390,1 7399,0 7441,1 7447,0 7509,1 7516,0 7534,1 7578,0 7584,1 7609,0 7688,1 7749,0 7827,1 7835,0 7898,1 7976,0 8052,1 8122,0 8146,1 8170,0 8207,1 8281,0 8351,1 8406,0 8452,1 8485,0 8510,1 8582,0 8644,1 8742,0 8827,1 8906,0 8942,1 8997,0 9083,1 9162,0 9213,1 9290,0 9352,1 9433,0 9499,1 9590,0 9633,1 9671,0 9763,1 9771,0 9856,1 9874,0 9920,1 9973,0 10009,1 10056,0 10082,1 10133,0 10194,1 10205,0 10260,1 10325,0 10345,1 10403,0 10492,1 10510,0 10583,1 10620,0 10622,1 10625,0 10703,1 10789,0 10839,1 10862,0 10950,1 10990,0 11087,1 11121,0 11133,1 11156,0 11217,1 11237,0 11280,1 11284,0 11382,1 11475,0 11486,1 11503,0 11518,1 11522,0 11576,1 11580,0 11588,1 11640,0 11697,1 11747,0 11768,1 11840,0 11859,1 11921,0 11999,1 12045,0 12120,1 12132,0 12139,1 12197,0 12226,1 12272,0 12334,1 12359,0 12450,1 12500,0 12571,1 12657,0 12662,1 12755,0 12824,1 12899,0 12948,1 13047,0 13124,1 13129,0 13210,1 13269,0 13321,1 13378,0 13428,1 13509,0 13575,1 13580,0 13664,1 13673,0 13748,1 13792,0 13800,1 13832,0 13928,1 14002,0 14062,1 14141,0 14236,1 14287,0 14302,1 14331,0 14341,1 14352,0 14407,1 14408,0 14442,1 14495,0 14573,1 14672,0 14762,1 14781,0 14800,1 14835,0 14904,1 14962,0 14992,1 15011,0 15048,1 15110,0 15136,1 15158,0 15214,1 15250,0 15322,1 15387,0 15481,1 15533,0 15542,1 15626,0 15666,1 15679,0 15765,1 15803,0 15902,1 15969,0 16061,1 16141,0 16240,1 16297,0 16366,1 16427,0 16493,1 16564,0 16638,1 16710,0 16742,1 16757,0 16825,1 16862,0 16898,1 16930,0 16974,1 17046,0 17106,1 17115,0 17199,1 17279,0 17351,1 17416,0 17452,1 17470,0 17504,1 17528,0 17620,1 17652,0 17688,1 17731,0 17759,1 17839,0 17906,1 17990,0 18034,1 18075,0 18084,1 18125,0 18186,1 18283,0 18329,1 18408,0 18503,1 18529,0 18604,1 18668,0 18690,1 18704,0 18726,1 18786,0 18837,1 18848,0 18887,1 18895,0 18920,1 18996,0 19012,1 19095,0 19141,1 19163,0 19176,1 19257,0 19259,1 19327,0 19347,1 19353,0 19372,1 19395,0 19449,1 19547,0 19577,1 19614,0 19635,1 19720,0 19801,1 19901,0 19993,1 20090,0 20125,1 20151,0 20189,1 20213,0 20311,1 20331,0 20413,1 20430,0 20478,1 20542,0 20627,1 20688,0 20694,1 20764,0 20805,1 20877,0 20965,1 21005,0 21087,1 21150,0 21185,1 21187,0 21214,1 21270,0 21349,1 21356,0 21393,1 21482,0 21484,1 21526,0 21531,1 21599,0 21666,1 21727,0 21756,1 21843,0 21863,1 21936,0 22005,1 22018,0 22072,1 22116,0 22186,1 22232,0 22251,1 22303,0 22347,1 22378,0 22401,1 22490,0 22590,1 22665,0 22696,1 22701,0 22799,1 22883,0 22906,1 22996,0 23028,1 23119,0 23189,1 23237,0 23297,1 23331,0 23402,1 23488,0 23542,1 23612,0 23691,1 23758,0 23805,1 23847,0 23861,1 23893,0 23957,1 23964,0 24000,1 24036,0 24107,1 24144,0 24170,1 24234,0 24329,1 24369,0 24465,1 24555,0 24599,1 24618,0 24660,1 24756,0 24841,1 24845,0 24900,1 24908,0 24926,1 24999,0 25047,1 25080,0 25097,1 25190,0 25224,1 25285,0 25384,1 25417,0 25419,1 25486,0 25548,1 25573,0 25630,1 25665,0 25740,1 25787,0 25832,1 25916,0 25957,1 26011,0 26079,1 26152,0 26156,1 26203,0 26294,1 26314,0 26345,1 26347,0 26407,1 26487,0 26516,1 26614,0 26696,1 26726,0 26748,1 26763,0 26779,1 26845,0 26848,1 26898,0 26927,1 26955,0 27017,1 27051,0 27101,1 27167,0 27169,1 27246,0 27333,1 27377,0 27389,1 27395,0 27411,1 27451,0 27511,1 27596,0 27681,1 27749,0 27809,1 27826,0 27924,1 27934,0 27994,1 28037,0 28107,1 28161,0 28189,1 28241,0 28271,1 28306,0 28350,1 28425,0 28433,1 28462,0 28537,1 28561,0 28658,1 28749,0 28796,1 28859,0 28933,1 29016,0 29067,1 29070,0 29132,1 29217,0 29309,1 29331,0 29375,1 29469,0 29515,1 29535,0 29551,1 29593,0 29690,1 29767,0 29794,1 29854,0 29903,1 29971,0 29980,1 29994,0 30024,1 30095,0 30175,1 30233,0 30330,1 30397,0 30408,1 30468,0 30507,1 30582,0 30671,1 30701,0 30715,1 30790,0 30877,1 30903,0 30968,1 31039,0 31065,1 31159,0 31232,1 31277,0 31301,1 31374,0 31375,1 31452,0 31532,1 31562,0 31610,1 31663,0 31753,1 31845,0 31909,1 31988,0 32053,1 32144,0 32228,1 32229,0 32312,1 32344,0 32413,1 32438,0 32487,1 32509,0 32544,1 32642,0 32726,1 32785,0 32882,1 32959,0 33058,1 33072,0 33154,1 33253,0 33320,1 33415,0 33464,1 33494,0 33523,1 33623,0 33710,1 33772,0 33817,1 33830,0 33841,1 33846,0 33926,1 33985,0 34081,1 34111,0 34113,1 34128,0 34183,1 34205,0 34267,1 34270,0 34331,1 34333,0 34418,1 34503,0 34549,1 34584,0 34601,1 34622,0 34634,1 34646,0 34653,1 34739,0 34755,1 34760,0 34775,1 34782,0 34848,1 34898,0 34927,1 35009,0 35038,1 35066,0 35141,1 35224,0 35269,1 35356,0 35358,1 35421,0 35484,1 35502,0 35512,1 35591,0 35607,1 35611,0 35650,1 35719,0 35809,1 35870,0 35901,1 35987,0 36059,1 36141,0 36189,1 36280,0 36334,1 36375,0 36410,1 36421,0 36433,1 36493,0 36586,1 36629,0 36729,1 36732,0 36770,1 36831,0 36832,1 36847,0 36928,1 36929,0 36972,1 36980,0 36999,1 37073,0 37102,1 37117,0 37188,1 37269,0 37289,1 37372,0 37377,1 37396,0 37495,1 37543,0 37606,1 37652,0 37653,1 37666,0 37742,1 37789,0 37856,1 37876,0 37879,1 37922,0 37931,1 38021,0 38043,1 38072,0 38087,1 38098,0 38149,1 38161,0 38198,1 38218,0 38281,1 38311,0 38397,1 38474,0 38554,1 38617,0 38643,1 38717,0 38779,1 38809,0 38861,1 38928,0 39002,1 39095,0 39188,1 39199,0 39297,1 39333,0 39354,1 39436,0 39467,1 39533,0 39568,1 39634,0 39674,1 39741,0 39835,1 39917,0 39973,1 40017,0 40116,1 40162,0 40203,1 40213,0 40276,1 40355,0 40381,1 40464,0 40560,1 40567,0 40602,1 40640,0 40723,1 40741,0 40771,1 40808,0 40818,1 40913,0 40938,1 40977,0 41021,1 41089,0 41139,1 41204,0 41293,1 41370,0 41446,1 41534,0 41626,1 41694,0 41719,1 41801,0 41878,1 41961,0 42055,1 42099,0 42167,1 42257,0 42312,1 42321,0 42333,1 42393,0 42454,1 42455,0 42513,1 42514,0 42550,1 42551,0 42561,1 42627,0 42720,1 42785,0 42849,1 42917,0 43014,1 43062,0 43122,1 43190,0 43258,1 43321,0 43378,1 43457,0 43547,1 43592,0 43617,1 43621,0 43720,1 43800,0 43866,1 43950,0 43957,1 44030,0 44087,1 44122,0 44185,1 44187,0 44232,1 44307,0 44388,1 44406,0 44422,1 44439,0 44446,1 44469,0 44511,1 44548,0 44598,1 44675,0 44686,1 44727,0 44741,1 44773,0 44859,1 44955,0 44990,1 45025,0 45088,1 45125,0 45221,1 45306,0 45325,1 45404,0 45477,1 45536,0 45547,1 45575,0 45658,1 45705,0 45756,1 45843,0 45863,1 45880,0 45961,1 46053,0 46101,1 46129,0 46222,1 46273,0 46333,1 46344,0 46425,1 46437,0 46474,1 46526,0 46575,1 46662,0 46686,1 46709,0 46776,1 46857,0 46951,1 46983,0 46986,1 47045,0 47069,1 47145,0 47217,1 47235,0 47239,1 47263,0 47298,1 47336,0 47390,1 47443,0 47445,1 47471,0 47568,1 47617,0 47630,1 47684,0 47694,1 47757,0 47797,1 47879,0 47956,1 47989,0 47996,1 48084,0 48128,1 48215,0 48232,1 48252,0 48269,1 48325,0 48370,1 48391,0 48487,1 48538,0 48595,1 48694,0 48715,1 48793,0 48856,1 48891,0 48949,1 48978,0 48999,1 49097,0 49103,1 49119,0 49157,1 49226,0 49246,1 49255,0 49300,1 49306,0 49360,1 49369,0 49379,1 49474,0 49508,1 end initlist b10 0,0 78,1 143,0 234,1 256,0 345,1 378,0 380,1 428,0 447,1 476,0 513,1 515,0 557,1 595,0 689,1 703,0 760,1 831,0 894,1 972,0 1030,1 1044,0 1045,1 1125,0 1223,1 1276,0 1364,1 1406,0 1498,1 1583,0 1610,1 1644,0 1689,1 1757,0 1787,1 1836,0 1894,1 1943,0 1974,1 2036,0 2059,1 2064,0 2136,1 2229,0 2306,1 2380,0 2399,1 2491,0 2510,1 2517,0 2615,1 2623,0 2641,1 2650,0 2745,1 2779,0 2805,1 2844,0 2905,1 2920,0 2988,1 3083,0 3177,1 3185,0 3270,1 3307,0 3392,1 3457,0 3531,1 3602,0 3655,1 3694,0 3706,1 3800,0 3835,1 3857,0 3943,1 3995,0 4024,1 4057,0 4120,1 4204,0 4223,1 4252,0 4335,1 4353,0 4355,1 4441,0 4449,1 4506,0 4605,1 4626,0 4704,1 4713,0 4755,1 4852,0 4908,1 4958,0 4964,1 4987,0 5060,1 5061,0 5151,1 5172,0 5229,1 5234,0 5257,1 5300,0 5321,1 5328,0 5398,1 5476,0 5575,1 5599,0 5624,1 5633,0 5729,1 5753,0 5842,1 5905,0 5911,1 5933,0 5951,1 5962,0 5991,1 6015,0 6114,1 6158,0 6166,1 6251,0 6344,1 6357,0 6415,1 6481,0 6552,1 6560,0 6614,1 6711,0 6787,1 6860,0 6928,1 6934,0 7007,1 7010,0 7038,1 7061,0 7065,1 7124,0 7207,1 7258,0 7309,1 7403,0 7467,1 7494,0 7593,1 7687,0 7690,1 7691,0 7788,1 7835,0 7920,1 7937,0 7970,1 8013,0 8096,1 8130,0 8221,1 8230,0 8282,1 8376,0 8398,1 8476,0 8510,1 8565,0 8658,1 8659,0 8733,1 8781,0 8847,1 8851,0 8920,1 8981,0 9064,1 9114,0 9213,1 9292,0 9296,1 9363,0 9454,1 9518,0 9615,1 9699,0 9739,1 9767,0 9855,1 9953,0 9992,1 10005,0 10056,1 10144,0 10210,1 10250,0 10273,1 10322,0 10419,1 10512,0 10601,1 10667,0 10715,1 10793,0 10838,1 10885,0 10981,1 11039,0 11085,1 11182,0 11274,1 11349,0 11371,1 11423,0 11442,1 11443,0 11537,1 11602,0 11623,1 11712,0 11783,1 11820,0 11916,1 11978,0 11995,1 12032,0 12046,1 12068,0 12148,1 12171,0 12238,1 12263,0 12267,1 12291,0 12310,1 12347,0 12369,1 12468,0 12506,1 12537,0 12624,1 12638,0 12677,1 12771,0 12871,1 12883,0 12892,1 12925,0 12942,1 13004,0 13077,1 13131,0 13210,1 13276,0 13309,1 13393,0 13456,1 13504,0 13549,1 13582,0 13633,1 13634,0 13647,1 13678,0 13745,1 13819,0 13828,1 13889,0 13902,1 13918,0 13939,1 14033,0 14096,1 14119,0 14127,1 14163,0 14164,1 14242,0 14273,1 14360,0 14371,1 14429,0 14436,1 14456,0 14465,1 14506,0 14526,1 14556,0 14594,1 14606,0 14686,1 14785,0 14804,1 14809,0 14904,1 14921,0 15021,1 15082,0 15180,1 15244,0 15336,1 15423,0 15449,1 15532,0 15549,1 15629,0 15673,1 15734,0 15785,1 15842,0 15923,1 15954,0 15979,1 16059,0 16147,1 16153,0 16182,1 16247,0 16250,1 16337,0 16347,1 16365,0 16415,1 16467,0 16544,1 16577,0 16637,1 16686,0 16740,1 16813,0 16871,1 16912,0 16979,1 17013,0 17033,1 17069,0 17118,1 17196,0 17283,1 17373,0 17394,1 17439,0 17493,1 17513,0 17576,1 17627,0 17716,1 17809,0 17851,1 17948,0 17984,1 18062,0 18100,1 18179,0 18234,1 18298,0 18363,1 18420,0 18470,1 18489,0 18532,1 18600,0 18692,1 18755,0 18843,1 18907,0 18952,1 18984,0 19037,1 19060,0 19101,1 19105,0 19190,1 19209,0 19261,1 19356,0 19408,1 19426,0 19492,1 19579,0 19674,1 19738,0 19746,1 19792,0 19810,1 19860,0 19865,1 19890,0 19908,1 19925,0 19995,1 20094,0 20103,1 20116,0 20118,1 20129,0 20155,1 20187,0 20239,1 20260,0 20298,1 20302,0 20349,1 20446,0 20464,1 20508,0 20583,1 20589,0 20668,1 20674,0 20770,1 20808,0 20891,1 20977,0 20999,1 21043,0 21106,1 21194,0 21284,1 21369,0 21440,1 21494,0 21563,1 21592,0 21675,1 21743,0 21805,1 21809,0 21875,1 21935,0 22024,1 22029,0 22049,1 22095,0 22111,1 22147,0 22217,1 22269,0 22320,1 22397,0 22430,1 22481,0 22518,1 22607,0 22705,1 22799,0 22873,1 22886,0 22934,1 23026,0 23059,1 23097,0 23169,1 23211,0 23290,1 23381,0 23461,1 23538,0 23565,1 23634,0 23709,1 23767,0 23794,1 23807,0 23904,1 23968,0 24030,1 24097,0 24181,1 24215,0 24267,1 24361,0 24379,1 24433,0 24481,1 24556,0 24638,1 24717,0 24796,1 24871,0 24967,1 25056,0 25126,1 25203,0 25261,1 25326,0 25397,1 25407,0 25498,1 25596,0 25631,1 25727,0 25817,1 25823,0 25875,1 25899,0 25992,1 26071,0 26163,1 26198,0 26284,1 26295,0 26341,1 26389,0 26471,1 26481,0 26521,1 26573,0 26584,1 26598,0 26693,1 26791,0 26821,1 26920,0 26932,1 27008,0 27036,1 27117,0 27182,1 27237,0 27242,1 27288,0 27339,1 27377,0 27456,1 27498,0 27583,1 27673,0 27766,1 27824,0 27826,1 27873,0 27886,1 27902,0 27937,1 28025,0 28026,1 28094,0 28173,1 28257,0 28346,1 28365,0 28465,1 28549,0 28607,1 28654,0 28689,1 28745,0 28834,1 28875,0 28936,1 28993,0 29021,1 29098,0 29108,1 29114,0 29130,1 29140,0 29212,1 29214,0 29244,1 29246,0 29272,1 29319,0 29347,1 29393,0 29423,1 29455,0 29545,1 29602,0 29621,1 29667,0 29745,1 29845,0 29904,1 29933,0 29963,1 30022,0 30077,1 30153,0 30250,1 30339,0 30356,1 30382,0 30422,1 30500,0 30591,1 30689,0 30724,1 30726,0 30727,1 30786,0 30872,1 30931,0 31025,1 31064,0 31123,1 31161,0 31173,1 31265,0 31333,1 31381,0 31474,1 31572,0 31601,1 31625,0 31676,1 31685,0 31716,1 31807,0 31833,1 31836,0 31899,1 31917,0 31973,1 32070,0 32107,1 32112,0 32207,1 32226,0 32227,1 32301,0 32395,1 32471,0 32496,1 32590,0 32628,1 32644,0 32676,1 32685,0 32714,1 32771,0 32815,1 32899,0 32932,1 33005,0 33061,1 33129,0 33219,1 33251,0 33287,1 33342,0 33364,1 33377,0 33446,1 33462,0 33481,1 33538,0 33554,1 33573,0 33634,1 33685,0 33733,1 33791,0 33808,1 33905,0 33954,1 34026,0 34037,1 34079,0 34107,1 34125,0 34204,1 34284,0 34348,1 34386,0 34429,1 34454,0 34462,1 34476,0 34564,1 34581,0 34589,1 34664,0 34714,1 34780,0 34814,1 34866,0 34904,1 34919,0 34972,1 35052,0 35122,1 35124,0 35168,1 35197,0 35266,1 35318,0 35408,1 35416,0 35473,1 35509,0 35538,1 35634,0 35666,1 35702,0 35777,1 35822,0 35826,1 35830,0 35912,1 35922,0 35952,1 35995,0 36060,1 36098,0 36141,1 36155,0 36252,1 36312,0 36380,1 36432,0 36444,1 36478,0 36577,1 36585,0 36609,1 36697,0 36793,1 36804,0 36816,1 36840,0 36926,1 36939,0 37031,1 37126,0 37161,1 37242,0 37291,1 37355,0 37389,1 37476,0 37517,1 37587,0 37674,1 37693,0 37764,1 37839,0 37919,1 38000,0 38054,1 38125,0 38154,1 38156,0 38206,1 38258,0 38323,1 38336,0 38377,1 38468,0 38537,1 38623,0 38686,1 38759,0 38763,1 38790,0 38805,1 38812,0 38867,1 38940,0 38968,1 38975,0 39053,1 39084,0 39148,1 39208,0 39242,1 39277,0 39287,1 39324,0 39409,1 39493,0 39497,1 39527,0 39540,1 39569,0 39629,1 39700,0 39708,1 39711,0 39806,1 39901,0 39902,1 39932,0 39960,1 40033,0 40081,1 40144,0 40169,1 40173,0 40179,1 40182,0 40210,1 40211,0 40263,1 40353,0 40361,1 40367,0 40378,1 40397,0 40482,1 40488,0 40556,1 40574,0 40624,1 40689,0 40785,1 40810,0 40811,1 40897,0 40972,1 40993,0 41067,1 41118,0 41144,1 41228,0 41264,1 41276,0 41358,1 41400,0 41458,1 41498,0 41516,1 41605,0 41666,1 41691,0 41709,1 41759,0 41858,1 41948,0 42040,1 42123,0 42215,1 42306,0 42332,1 42408,0 42423,1 42468,0 42488,1 42494,0 42566,1 42604,0 42638,1 42666,0 42736,1 42745,0 42750,1 42769,0 42837,1 42885,0 42971,1 43041,0 43110,1 43192,0 43278,1 43351,0 43368,1 43431,0 43447,1 43470,0 43502,1 43580,0 43672,1 43753,0 43778,1 43845,0 43939,1 43991,0 44002,1 44089,0 44164,1 44194,0 44263,1 44324,0 44418,1 44475,0 44494,1 44575,0 44582,1 44612,0 44625,1 44722,0 44733,1 44828,0 44851,1 44950,0 45008,1 45090,0 45155,1 45203,0 45223,1 45290,0 45302,1 45326,0 45408,1 45450,0 45504,1 45603,0 45667,1 45733,0 45749,1 45799,0 45857,1 45868,0 45960,1 45977,0 46036,1 46134,0 46138,1 46144,0 46158,1 46177,0 46215,1 46223,0 46259,1 46278,0 46301,1 46387,0 46399,1 46401,0 46420,1 46436,0 46495,1 46563,0 46648,1 46660,0 46707,1 46735,0 46765,1 46771,0 46806,1 46871,0 46884,1 46969,0 46994,1 47056,0 47083,1 47177,0 47252,1 47342,0 47427,1 47500,0 47599,1 47635,0 47726,1 47748,0 47822,1 47832,0 47853,1 47888,0 47950,1 47954,0 47966,1 48011,0 48066,1 48098,0 48125,1 48203,0 48246,1 48303,0 48373,1 48380,0 48430,1 48496,0 48529,1 48592,0 48611,1 48632,0 48711,1 48806,0 48831,1 48868,0 48966,1 49022,0 49049,1 49057,0 49082,1 49112,0 49208,1 49278,0 49335,1 49385,0 49444,1 49527,0 49568,1 49586,0 49616,1 49668,0 49684,1 49743,0 49753,1 49812,0 49881,1 49896,0 49951,1 end initlist b11 0,0 62,1 123,0 187,1 190,0 207,1 298,0 381,1 393,0 421,1 493,0 590,1 623,0 643,1 706,0 708,1 801,0 806,1 894,0 902,1 924,0 987,1 1010,0 1067,1 1100,0 1189,1 1248,0 1278,1 1349,0 1442,1 1527,0 1535,1 1578,0 1641,1 1685,0 1730,1 1784,0 1802,1 1804,0 1827,1 1911,0 2002,1 2024,0 2025,1 2042,0 2135,1 2199,0 2221,1 2283,0 2331,1 2377,0 2435,1 2494,0 2495,1 2514,0 2601,1 2626,0 2638,1 2644,0 2713,1 2809,0 2906,1 2957,0 3004,1 3032,0 3051,1 3114,0 3179,1 3249,0 3261,1 3353,0 3432,1 3486,0 3527,1 3584,0 3671,1 3694,0 3700,1 3752,0 3846,1 3875,0 3965,1 4049,0 4126,1 4147,0 4206,1 4275,0 4350,1 4446,0 4510,1 4534,0 4541,1 4587,0 4686,1 4759,0 4834,1 4929,0 4998,1 5008,0 5101,1 5140,0 5219,1 5292,0 5294,1 5358,0 5424,1 5488,0 5533,1 5565,0 5588,1 5620,0 5676,1 5768,0 5825,1 5868,0 5916,1 5963,0 6045,1 6134,0 6223,1 6259,0 6347,1 6394,0 6397,1 6483,0 6543,1 6584,0 6644,1 6727,0 6788,1 6810,0 6880,1 6895,0 6982,1 7044,0 7126,1 7163,0 7174,1 7180,0 7230,1 7265,0 7318,1 7387,0 7440,1 7449,0 7548,1 7569,0 7581,1 7621,0 7656,1 7746,0 7788,1 7821,0 7889,1 7978,0 7986,1 8066,0 8150,1 8179,0 8199,1 8251,0 8265,1 8294,0 8353,1 8416,0 8502,1 8602,0 8689,1 8763,0 8855,1 8856,0 8939,1 8966,0 8994,1 9058,0 9092,1 9186,0 9209,1 9267,0 9299,1 9334,0 9388,1 9445,0 9496,1 9530,0 9574,1 9620,0 9676,1 9719,0 9770,1 9784,0 9871,1 9941,0 9991,1 10045,0 10084,1 10090,0 10115,1 10167,0 10230,1 10275,0 10285,1 10294,0 10299,1 10377,0 10382,1 10468,0 10568,1 10642,0 10683,1 10697,0 10730,1 10824,0 10879,1 10921,0 11002,1 11025,0 11055,1 11092,0 11130,1 11220,0 11248,1 11325,0 11391,1 11482,0 11535,1 11559,0 11656,1 11700,0 11762,1 11823,0 11849,1 11870,0 11876,1 11976,0 12021,1 12043,0 12128,1 12228,0 12302,1 12342,0 12401,1 12479,0 12533,1 12536,0 12582,1 12604,0 12609,1 12680,0 12692,1 12748,0 12759,1 12797,0 12884,1 12912,0 12935,1 12991,0 13005,1 13044,0 13107,1 13178,0 13181,1 13252,0 13263,1 13359,0 13456,1 13495,0 13533,1 13559,0 13626,1 13677,0 13703,1 13763,0 13842,1 13899,0 13973,1 14059,0 14072,1 14142,0 14189,1 14287,0 14338,1 14392,0 14472,1 14571,0 14587,1 14596,0 14658,1 14733,0 14830,1 14878,0 14911,1 14979,0 15010,1 15021,0 15036,1 15094,0 15163,1 15202,0 15274,1 15352,0 15356,1 15407,0 15427,1 15526,0 15579,1 15582,0 15641,1 15665,0 15666,1 15764,0 15812,1 15820,0 15879,1 15908,0 15930,1 15955,0 15990,1 16016,0 16064,1 16108,0 16197,1 16283,0 16331,1 16426,0 16491,1 16542,0 16641,1 16689,0 16734,1 16775,0 16867,1 16922,0 16931,1 16945,0 16958,1 17048,0 17082,1 17104,0 17174,1 17268,0 17330,1 17333,0 17337,1 17373,0 17459,1 17511,0 17594,1 17652,0 17747,1 17797,0 17804,1 17837,0 17913,1 17928,0 17984,1 18038,0 18045,1 18053,0 18135,1 18195,0 18199,1 18255,0 18265,1 18270,0 18317,1 18412,0 18491,1 18499,0 18589,1 18602,0 18702,1 18709,0 18725,1 18809,0 18846,1 18915,0 18995,1 19092,0 19106,1 19122,0 19213,1 19272,0 19343,1 19360,0 19456,1 19485,0 19508,1 19561,0 19582,1 19620,0 19708,1 19746,0 19835,1 19873,0 19946,1 19960,0 20050,1 20134,0 20219,1 20226,0 20238,1 20329,0 20400,1 20476,0 20541,1 20615,0 20645,1 20722,0 20776,1 20784,0 20866,1 20960,0 21016,1 21056,0 21065,1 21135,0 21159,1 21219,0 21259,1 21301,0 21401,1 21466,0 21563,1 21578,0 21632,1 21652,0 21687,1 21776,0 21835,1 21928,0 22014,1 22067,0 22153,1 22204,0 22263,1 22333,0 22350,1 22387,0 22388,1 22408,0 22431,1 22504,0 22520,1 22619,0 22689,1 22724,0 22819,1 22827,0 22860,1 22909,0 22979,1 23035,0 23103,1 23110,0 23152,1 23192,0 23196,1 23268,0 23356,1 23374,0 23388,1 23396,0 23477,1 23498,0 23556,1 23557,0 23638,1 23646,0 23724,1 23796,0 23836,1 23901,0 23964,1 23994,0 24031,1 24121,0 24164,1 24213,0 24277,1 24373,0 24459,1 24480,0 24570,1 24582,0 24640,1 24670,0 24678,1 24732,0 24806,1 24839,0 24840,1 24892,0 24935,1 24966,0 25051,1 25137,0 25196,1 25239,0 25242,1 25276,0 25320,1 25411,0 25492,1 25567,0 25591,1 25675,0 25687,1 25758,0 25784,1 25879,0 25887,1 25981,0 25982,1 26000,0 26082,1 26114,0 26155,1 26158,0 26237,1 26288,0 26290,1 26351,0 26358,1 26422,0 26522,1 26603,0 26661,1 26745,0 26778,1 26802,0 26822,1 26859,0 26915,1 26921,0 26963,1 26976,0 27047,1 27100,0 27199,1 27273,0 27358,1 27371,0 27431,1 27514,0 27567,1 27611,0 27620,1 27636,0 27659,1 27745,0 27837,1 27928,0 27969,1 28021,0 28032,1 28061,0 28099,1 28193,0 28242,1 28303,0 28318,1 28351,0 28404,1 28448,0 28519,1 28603,0 28699,1 28716,0 28798,1 28822,0 28840,1 28841,0 28844,1 28857,0 28867,1 28882,0 28930,1 28997,0 29043,1 29071,0 29159,1 29166,0 29202,1 29300,0 29360,1 29445,0 29487,1 29562,0 29651,1 29726,0 29734,1 29827,0 29845,1 29912,0 29925,1 29992,0 30072,1 30082,0 30096,1 30188,0 30256,1 30305,0 30309,1 30362,0 30417,1 30517,0 30531,1 30580,0 30605,1 30626,0 30719,1 30768,0 30789,1 30870,0 30919,1 30921,0 31014,1 31048,0 31066,1 31137,0 31180,1 31235,0 31242,1 31341,0 31408,1 31455,0 31546,1 31562,0 31611,1 31634,0 31667,1 31728,0 31781,1 31814,0 31906,1 31924,0 32024,1 32044,0 32089,1 32106,0 32148,1 32232,0 32280,1 32315,0 32380,1 32402,0 32473,1 32550,0 32619,1 32717,0 32782,1 32849,0 32919,1 33013,0 33030,1 33044,0 33088,1 33187,0 33193,1 33261,0 33273,1 33332,0 33337,1 33388,0 33465,1 33542,0 33629,1 33683,0 33735,1 33826,0 33845,1 33908,0 33996,1 34038,0 34091,1 34129,0 34197,1 34279,0 34379,1 34396,0 34488,1 34500,0 34544,1 34625,0 34674,1 34768,0 34782,1 34854,0 34931,1 35015,0 35099,1 35106,0 35179,1 35241,0 35302,1 35329,0 35392,1 35395,0 35454,1 35473,0 35540,1 35593,0 35669,1 35693,0 35763,1 35795,0 35803,1 35843,0 35903,1 35997,0 36080,1 36088,0 36095,1 36159,0 36195,1 36236,0 36265,1 36320,0 36351,1 36383,0 36425,1 36426,0 36524,1 36533,0 36609,1 36623,0 36686,1 36744,0 36836,1 36879,0 36905,1 36908,0 36916,1 37015,0 37046,1 37123,0 37155,1 37234,0 37291,1 37342,0 37355,1 37402,0 37431,1 37475,0 37484,1 37578,0 37607,1 37671,0 37677,1 37720,0 37754,1 37776,0 37791,1 37819,0 37852,1 37862,0 37935,1 37951,0 38021,1 38065,0 38124,1 38128,0 38193,1 38200,0 38228,1 38259,0 38337,1 38367,0 38422,1 38518,0 38553,1 38560,0 38603,1 38653,0 38708,1 38735,0 38777,1 38790,0 38859,1 38860,0 38889,1 38986,0 39045,1 39072,0 39096,1 39140,0 39152,1 39165,0 39228,1 39328,0 39416,1 39479,0 39509,1 39605,0 39611,1 39633,0 39659,1 39758,0 39829,1 39910,0 39990,1 40086,0 40186,1 40230,0 40322,1 40359,0 40399,1 40418,0 40458,1 40543,0 40549,1 40559,0 40574,1 40627,0 40681,1 40773,0 40831,1 40917,0 40969,1 41046,0 41078,1 41170,0 41209,1 41290,0 41364,1 41407,0 41464,1 41518,0 41544,1 41598,0 41649,1 41667,0 41677,1 41728,0 41738,1 41811,0 41853,1 41916,0 41945,1 42031,0 42089,1 42124,0 42137,1 42237,0 42245,1 42251,0 42347,1 42421,0 42504,1 42592,0 42670,1 42716,0 42775,1 42872,0 42882,1 42971,0 42982,1 43027,0 43039,1 43091,0 43120,1 43216,0 43273,1 43362,0 43410,1 43487,0 43587,1 43607,0 43627,1 43662,0 43698,1 43774,0 43816,1 43848,0 43944,1 44044,0 44078,1 44165,0 44180,1 44277,0 44278,1 44331,0 44397,1 44460,0 44489,1 44538,0 44562,1 44659,0 44680,1 44718,0 44805,1 44888,0 44977,1 45006,0 45077,1 45084,0 45087,1 45145,0 45238,1 45317,0 45352,1 45392,0 45491,1 45589,0 45688,1 45770,0 45837,1 45839,0 45847,1 45926,0 46003,1 46074,0 46100,1 46110,0 46157,1 46177,0 46180,1 46246,0 46336,1 46389,0 46460,1 46556,0 46601,1 46605,0 46658,1 46668,0 46728,1 46768,0 46800,1 46890,0 46906,1 46928,0 47026,1 47030,0 47063,1 47105,0 47199,1 47201,0 47231,1 47261,0 47289,1 47332,0 47416,1 47420,0 47519,1 47521,0 47559,1 47655,0 47661,1 47745,0 47817,1 47841,0 47853,1 47882,0 47924,1 48010,0 48042,1 48058,0 48107,1 48126,0 48184,1 48267,0 48321,1 48345,0 48423,1 48467,0 48503,1 48592,0 48644,1 48653,0 48663,1 48741,0 48770,1 48867,0 48909,1 48993,0 49015,1 49072,0 49105,1 49135,0 49198,1 49289,0 49335,1 49336,0 49423,1 49449,0 49513,1 49546,0 49591,1 49679,0 49762,1 49799,0 49814,1 49877,0 49972,1 50018,0 50066,1 50129,0 50221,1 50286,0 50374,1 end initlist b12 0,0 80,1 82,0 157,1 181,0 271,1 301,0 352,1 383,0 479,1 501,0 578,1 636,0 674,1 738,0 805,1 809,0 909,1 1002,0 1056,1 1130,0 1138,1 1169,0 1242,1 1318,0 1362,1 1394,0 1429,1 1484,0 1512,1 1542,0 1630,1 1671,0 1705,1 1770,0 1794,1 1893,0 1929,1 1973,0 2004,1 2088,0 2106,1 2179,0 2188,1 2230,0 2283,1 2294,0 2375,1 2409,0 2478,1 2530,0 2563,1 2567,0 2610,1 2679,0 2775,1 2779,0 2874,1 2914,0 2993,1 3075,0 3166,1 3243,0 3300,1 3338,0 3424,1 3458,0 3522,1 3525,0 3567,1 3611,0 3691,1 3785,0 3811,1 3846,0 3940,1 3996,0 4027,1 4103,0 4138,1 4202,0 4243,1 4326,0 4369,1 4450,0 4477,1 4490,0 4494,1 4577,0 4656,1 4672,0 4748,1 4794,0 4795,1 4860,0 4894,1 4950,0 4971,1 5052,0 5055,1 5138,0 5234,1 5305,0 5378,1 5449,0 5476,1 5490,0 5505,1 5515,0 5543,1 5547,0 5572,1 5644,0 5681,1 5688,0 5754,1 5790,0 5802,1 5831,0 5864,1 5948,0 6035,1 6037,0 6104,1 6180,0 6233,1 6272,0 6340,1 6361,0 6393,1 6475,0 6559,1 6577,0 6627,1 6698,0 6703,1 6718,0 6794,1 6854,0 6929,1 7010,0 7034,1 7105,0 7197,1 7264,0 7284,1 7304,0 7361,1 7402,0 7451,1 7537,0 7547,1 7646,0 7688,1 7742,0 7815,1 7845,0 7868,1 7879,0 7890,1 7990,0 8083,1 8130,0 8142,1 8146,0 8205,1 8296,0 8342,1 8357,0 8448,1 8479,0 8516,1 8572,0 8576,1 8613,0 8687,1 8731,0 8790,1 8851,0 8859,1 8893,0 8940,1 9038,0 9108,1 9119,0 9121,1 9127,0 9129,1 9221,0 9275,1 9299,0 9381,1 9417,0 9505,1 9557,0 9571,1 9599,0 9619,1 9693,0 9790,1 9886,0 9899,1 9971,0 10025,1 10124,0 10222,1 10239,0 10277,1 10287,0 10381,1 10398,0 10460,1 10519,0 10575,1 10675,0 10694,1 10733,0 10758,1 10838,0 10901,1 10910,0 10926,1 10976,0 10988,1 11055,0 11124,1 11150,0 11224,1 11323,0 11389,1 11422,0 11431,1 11507,0 11547,1 11610,0 11639,1 11708,0 11743,1 11783,0 11798,1 11813,0 11861,1 11878,0 11902,1 11992,0 12020,1 12037,0 12101,1 12115,0 12159,1 12248,0 12286,1 12294,0 12312,1 12321,0 12364,1 12460,0 12543,1 12594,0 12673,1 12738,0 12795,1 12816,0 12913,1 12988,0 13087,1 13175,0 13243,1 13293,0 13360,1 13380,0 13394,1 13455,0 13487,1 13526,0 13547,1 13619,0 13627,1 13691,0 13774,1 13805,0 13902,1 13981,0 14056,1 14108,0 14111,1 14130,0 14145,1 14186,0 14205,1 14217,0 14275,1 14366,0 14394,1 14474,0 14494,1 14515,0 14516,1 14590,0 14656,1 14698,0 14701,1 14715,0 14761,1 14782,0 14879,1 14898,0 14963,1 14991,0 15088,1 15127,0 15193,1 15226,0 15294,1 15368,0 15398,1 15477,0 15565,1 15624,0 15720,1 15756,0 15784,1 15843,0 15870,1 15890,0 15923,1 16017,0 16072,1 16092,0 16121,1 16166,0 16245,1 16308,0 16318,1 16414,0 16438,1 16463,0 16540,1 16621,0 16679,1 16680,0 16724,1 16779,0 16876,1 16943,0 17025,1 17085,0 17116,1 17190,0 17271,1 17351,0 17354,1 17373,0 17430,1 17451,0 17472,1 17567,0 17618,1 17619,0 17655,1 17677,0 17682,1 17730,0 17762,1 17767,0 17791,1 17801,0 17870,1 17929,0 18018,1 18063,0 18160,1 18217,0 18237,1 18293,0 18297,1 18375,0 18388,1 18452,0 18550,1 18577,0 18633,1 18644,0 18712,1 18767,0 18831,1 18859,0 18899,1 18963,0 19044,1 19073,0 19165,1 19209,0 19307,1 19405,0 19423,1 19427,0 19459,1 19513,0 19609,1 19646,0 19663,1 19742,0 19780,1 19798,0 19806,1 19877,0 19924,1 19995,0 20042,1 20115,0 20187,1 20217,0 20218,1 20239,0 20332,1 20395,0 20441,1 20537,0 20613,1 20656,0 20754,1 20844,0 20885,1 20978,0 20986,1 21080,0 21105,1 21179,0 21242,1 21271,0 21278,1 21362,0 21409,1 21428,0 21471,1 21531,0 21610,1 21669,0 21755,1 21767,0 21822,1 21881,0 21897,1 21946,0 21962,1 22044,0 22100,1 22174,0 22212,1 22216,0 22275,1 22352,0 22363,1 22441,0 22531,1 22577,0 22663,1 22711,0 22769,1 22807,0 22853,1 22872,0 22930,1 23014,0 23110,1 23142,0 23230,1 23272,0 23366,1 23455,0 23528,1 23626,0 23652,1 23685,0 23696,1 23738,0 23830,1 23903,0 23999,1 24078,0 24114,1 24159,0 24239,1 24275,0 24342,1 24391,0 24482,1 24515,0 24557,1 24647,0 24737,1 24772,0 24855,1 24905,0 24947,1 24995,0 25087,1 25141,0 25203,1 25302,0 25380,1 25394,0 25428,1 25491,0 25589,1 25593,0 25622,1 25674,0 25714,1 25716,0 25772,1 25799,0 25892,1 25963,0 26003,1 26026,0 26086,1 26179,0 26181,1 26255,0 26330,1 26420,0 26427,1 26450,0 26534,1 26599,0 26638,1 26684,0 26725,1 26786,0 26809,1 26870,0 26897,1 26965,0 27034,1 27091,0 27155,1 27234,0 27242,1 27286,0 27383,1 27441,0 27445,1 27452,0 27477,1 27478,0 27539,1 27558,0 27654,1 27739,0 27836,1 27850,0 27948,1 27993,0 28072,1 28122,0 28140,1 28224,0 28308,1 28361,0 28405,1 28427,0 28472,1 28518,0 28603,1 28675,0 28718,1 28775,0 28847,1 28903,0 28994,1 29011,0 29093,1 29171,0 29179,1 29251,0 29252,1 29284,0 29322,1 29353,0 29405,1 29445,0 29537,1 29558,0 29644,1 29737,0 29767,1 29796,0 29825,1 29908,0 29910,1 29976,0 29990,1 30073,0 30090,1 30162,0 30220,1 30279,0 30378,1 30434,0 30522,1 30583,0 30659,1 30719,0 30757,1 30816,0 30914,1 30971,0 31014,1 31022,0 31073,1 31157,0 31252,1 31285,0 31302,1 31379,0 31396,1 31483,0 31516,1 31596,0 31662,1 31712,0 31773,1 31804,0 31834,1 31872,0 31914,1 31958,0 32051,1 32149,0 32206,1 32284,0 32355,1 32436,0 32465,1 32549,0 32556,1 32626,0 32695,1 32726,0 32731,1 32830,0 32837,1 32849,0 32946,1 32980,0 33077,1 33112,0 33153,1 33251,0 33349,1 33426,0 33502,1 33572,0 33667,1 33710,0 33806,1 33827,0 33909,1 33969,0 34061,1 34114,0 34155,1 34229,0 34328,1 34369,0 34374,1 34472,0 34480,1 34496,0 34580,1 34632,0 34697,1 34726,0 34785,1 34882,0 34885,1 34889,0 34977,1 35041,0 35068,1 35146,0 35238,1 35288,0 35303,1 35382,0 35418,1 35472,0 35506,1 35593,0 35600,1 35690,0 35694,1 35719,0 35800,1 35850,0 35861,1 35933,0 35967,1 36028,0 36068,1 36072,0 36082,1 36131,0 36224,1 36243,0 36279,1 36379,0 36386,1 36389,0 36406,1 36470,0 36527,1 36573,0 36625,1 36634,0 36650,1 36696,0 36724,1 36777,0 36865,1 36892,0 36977,1 37062,0 37097,1 37142,0 37200,1 37262,0 37359,1 37387,0 37402,1 37478,0 37565,1 37617,0 37670,1 37676,0 37718,1 37799,0 37862,1 37911,0 37980,1 38044,0 38120,1 38190,0 38276,1 38324,0 38350,1 38368,0 38452,1 38489,0 38534,1 38595,0 38654,1 38710,0 38786,1 38828,0 38874,1 38910,0 38921,1 38972,0 38981,1 39074,0 39148,1 39211,0 39261,1 39268,0 39305,1 39388,0 39487,1 39509,0 39605,1 39619,0 39662,1 39736,0 39762,1 39781,0 39835,1 39861,0 39866,1 39946,0 39988,1 40079,0 40162,1 40253,0 40296,1 40336,0 40415,1 40423,0 40492,1 40523,0 40615,1 40671,0 40691,1 40725,0 40758,1 40830,0 40910,1 40920,0 40986,1 41010,0 41079,1 41179,0 41208,1 41243,0 41298,1 41327,0 41375,1 41395,0 41457,1 41521,0 41615,1 41703,0 41704,1 41789,0 41856,1 41876,0 41894,1 41898,0 41962,1 42010,0 42017,1 42086,0 42175,1 42220,0 42314,1 42364,0 42399,1 42472,0 42517,1 42578,0 42618,1 42634,0 42656,1 42749,0 42778,1 42824,0 42903,1 42988,0 42996,1 43064,0 43162,1 43214,0 43275,1 43350,0 43438,1 43451,0 43484,1 43522,0 43539,1 43603,0 43672,1 43707,0 43761,1 43787,0 43870,1 43905,0 43923,1 43982,0 44075,1 44168,0 44252,1 44286,0 44346,1 44373,0 44437,1 44457,0 44505,1 44554,0 44623,1 44714,0 44787,1 44862,0 44896,1 44912,0 44942,1 44978,0 45072,1 45121,0 45135,1 45138,0 45194,1 45249,0 45335,1 45348,0 45447,1 45495,0 45582,1 45621,0 45658,1 45745,0 45830,1 45854,0 45861,1 45953,0 46021,1 46115,0 46193,1 46264,0 46312,1 46391,0 46487,1 46506,0 46533,1 46580,0 46643,1 46710,0 46768,1 46817,0 46900,1 46933,0 46939,1 47000,0 47051,1 47123,0 47220,1 47306,0 47357,1 47360,0 47372,1 47458,0 47507,1 47601,0 47670,1 47747,0 47825,1 47882,0 47972,1 48071,0 48154,1 48243,0 48254,1 48274,0 48297,1 48364,0 48415,1 48475,0 48493,1 48520,0 48566,1 48631,0 48648,1 48675,0 48720,1 48816,0 48903,1 48916,0 48928,1 49000,0 49045,1 49084,0 49098,1 49171,0 49181,1 49182,0 49243,1 49257,0 49298,1 49373,0 49392,1 49478,0 49547,1 49615,0 49682,1 49703,0 49707,1 49778,0 49784,1 49787,0 49807,1 49870,0 49912,1 50010,0 50051,1 50057,0 50112,1 50137,0 50212,1 50247,0 50300,1 50390,0 50462,1 50527,0 50598,1 50599,0 50694,1 50749,0 50768,1 50786,0 50823,1 50853,0 50936,1 51004,0 51054,1 51153,0 51250,1 51306,0 51317,1 51393,0 51455,1 51468,0 51485,1 end initlist b13 0,0 98,1 170,0 256,1 349,0 365,1 376,0 407,1 471,0 475,1 512,0 518,1 607,0 637,1 681,0 706,1 774,0 866,1 956,0 999,1 1054,0 1121,1 1190,0 1266,1 1352,0 1375,1 1435,0 1511,1 1593,0 1623,1 1670,0 1733,1 1782,0 1819,1 1883,0 1932,1 1996,0 2055,1 2123,0 2164,1 2201,0 2275,1 2286,0 2297,1 2350,0 2385,1 2445,0 2447,1 2457,0 2498,1 2567,0 2575,1 2651,0 2710,1 2736,0 2737,1 2764,0 2813,1 2905,0 2929,1 2942,0 2973,1 3011,0 3078,1 3178,0 3244,1 3251,0 3272,1 3359,0 3420,1 3435,0 3475,1 3543,0 3584,1 3664,0 3732,1 3767,0 3802,1 3882,0 3929,1 3985,0 4013,1 4034,0 4102,1 4161,0 4233,1 4252,0 4324,1 4353,0 4422,1 4457,0 4484,1 4534,0 4628,1 4694,0 4714,1 4796,0 4861,1 4957,0 5035,1 5114,0 5166,1 5256,0 5289,1 5346,0 5388,1 5479,0 5563,1 5620,0 5698,1 5797,0 5883,1 5972,0 5988,1 5999,0 6019,1 6029,0 6115,1 6188,0 6219,1 6308,0 6340,1 6372,0 6424,1 6458,0 6532,1 6601,0 6656,1 6658,0 6753,1 6762,0 6797,1 6801,0 6837,1 6848,0 6886,1 6914,0 6933,1 6942,0 6989,1 6999,0 7028,1 7053,0 7077,1 7120,0 7165,1 7260,0 7356,1 7453,0 7469,1 7530,0 7575,1 7629,0 7662,1 7709,0 7760,1 7816,0 7823,1 7879,0 7929,1 7991,0 7993,1 8073,0 8124,1 8223,0 8297,1 8381,0 8414,1 8421,0 8449,1 8495,0 8589,1 8685,0 8725,1 8807,0 8906,1 8970,0 8985,1 9015,0 9111,1 9160,0 9238,1 9321,0 9331,1 9375,0 9417,1 9486,0 9540,1 9590,0 9604,1 9628,0 9661,1 9708,0 9797,1 9895,0 9984,1 9993,0 10040,1 10055,0 10084,1 10145,0 10171,1 10259,0 10306,1 10356,0 10455,1 10457,0 10517,1 10595,0 10655,1 10688,0 10779,1 10877,0 10939,1 11024,0 11117,1 11168,0 11227,1 11249,0 11311,1 11313,0 11329,1 11405,0 11458,1 11494,0 11503,1 11603,0 11697,1 11698,0 11750,1 11754,0 11853,1 11869,0 11953,1 12025,0 12093,1 12177,0 12196,1 12235,0 12264,1 12285,0 12360,1 12420,0 12500,1 12510,0 12561,1 12638,0 12714,1 12774,0 12784,1 12851,0 12934,1 13031,0 13041,1 13045,0 13082,1 13088,0 13117,1 13210,0 13231,1 13304,0 13360,1 13405,0 13440,1 13479,0 13569,1 13625,0 13721,1 13734,0 13758,1 13830,0 13915,1 13988,0 14009,1 14057,0 14068,1 14123,0 14164,1 14256,0 14282,1 14319,0 14377,1 14391,0 14462,1 14545,0 14609,1 14672,0 14692,1 14757,0 14762,1 14835,0 14918,1 14962,0 15058,1 15059,0 15118,1 15216,0 15295,1 15342,0 15436,1 15442,0 15499,1 15530,0 15563,1 15613,0 15708,1 15765,0 15825,1 15887,0 15902,1 15929,0 15993,1 16028,0 16094,1 16111,0 16119,1 16191,0 16258,1 16274,0 16334,1 16402,0 16439,1 16507,0 16556,1 16602,0 16638,1 16730,0 16788,1 16870,0 16913,1 16933,0 17012,1 17026,0 17114,1 17116,0 17209,1 17219,0 17293,1 17381,0 17450,1 17474,0 17485,1 17532,0 17610,1 17691,0 17764,1 17850,0 17930,1 17986,0 18085,1 18155,0 18177,1 18243,0 18281,1 18357,0 18419,1 18512,0 18574,1 18627,0 18708,1 18715,0 18794,1 18883,0 18950,1 18974,0 19031,1 19103,0 19182,1 19193,0 19211,1 19212,0 19257,1 19340,0 19387,1 19448,0 19468,1 19541,0 19562,1 19642,0 19654,1 19720,0 19779,1 19855,0 19910,1 19951,0 20018,1 20054,0 20058,1 20111,0 20158,1 20165,0 20220,1 20293,0 20305,1 20385,0 20481,1 20573,0 20574,1 20615,0 20712,1 20789,0 20847,1 20947,0 20967,1 21025,0 21066,1 21118,0 21167,1 21220,0 21307,1 21321,0 21409,1 21444,0 21453,1 21483,0 21510,1 21583,0 21676,1 21763,0 21848,1 21937,0 21978,1 21991,0 22056,1 22072,0 22125,1 22170,0 22233,1 22331,0 22358,1 22431,0 22455,1 22484,0 22519,1 22546,0 22608,1 22668,0 22755,1 22854,0 22914,1 22916,0 22997,1 23051,0 23076,1 23095,0 23175,1 23206,0 23270,1 23354,0 23369,1 23428,0 23508,1 23523,0 23563,1 23583,0 23632,1 23635,0 23672,1 23755,0 23800,1 23890,0 23951,1 23977,0 23994,1 24013,0 24039,1 24057,0 24125,1 24179,0 24201,1 24239,0 24303,1 24401,0 24440,1 24459,0 24499,1 24507,0 24596,1 24639,0 24678,1 24706,0 24719,1 24777,0 24861,1 24882,0 24957,1 25053,0 25115,1 25139,0 25235,1 25237,0 25268,1 25304,0 25353,1 25362,0 25365,1 25384,0 25404,1 25476,0 25558,1 25657,0 25713,1 25730,0 25772,1 25779,0 25859,1 25929,0 25999,1 26001,0 26021,1 26033,0 26103,1 26153,0 26211,1 26289,0 26308,1 26406,0 26489,1 26566,0 26622,1 26655,0 26666,1 26755,0 26786,1 26860,0 26892,1 26911,0 26999,1 27025,0 27112,1 27190,0 27199,1 27235,0 27329,1 27422,0 27483,1 27514,0 27586,1 27604,0 27688,1 27768,0 27789,1 27878,0 27943,1 28036,0 28086,1 28096,0 28156,1 28202,0 28299,1 28374,0 28395,1 28475,0 28566,1 28586,0 28597,1 28667,0 28738,1 28751,0 28809,1 28832,0 28919,1 28975,0 29038,1 29102,0 29110,1 29136,0 29198,1 29287,0 29329,1 29335,0 29378,1 29402,0 29462,1 29471,0 29548,1 29619,0 29637,1 29712,0 29725,1 29805,0 29820,1 29831,0 29878,1 29969,0 30016,1 30092,0 30187,1 30254,0 30304,1 30361,0 30456,1 30496,0 30574,1 30633,0 30720,1 30772,0 30785,1 30792,0 30797,1 30857,0 30866,1 30878,0 30939,1 30983,0 31075,1 31143,0 31149,1 31240,0 31283,1 31337,0 31341,1 31357,0 31451,1 31464,0 31517,1 31560,0 31641,1 31642,0 31729,1 31783,0 31808,1 31908,0 31990,1 32076,0 32145,1 32228,0 32257,1 32303,0 32397,1 32484,0 32571,1 32625,0 32687,1 32718,0 32729,1 32788,0 32887,1 32957,0 32969,1 33019,0 33069,1 33120,0 33152,1 33206,0 33227,1 33257,0 33282,1 33368,0 33439,1 33503,0 33579,1 33591,0 33645,1 33684,0 33715,1 33798,0 33858,1 33903,0 33984,1 33993,0 34021,1 34064,0 34088,1 34129,0 34178,1 34259,0 34284,1 34356,0 34383,1 34443,0 34516,1 34583,0 34602,1 34640,0 34671,1 34712,0 34714,1 34731,0 34759,1 34818,0 34896,1 34964,0 35013,1 35104,0 35175,1 35180,0 35271,1 35323,0 35354,1 35420,0 35488,1 35541,0 35605,1 35646,0 35745,1 35765,0 35787,1 35860,0 35905,1 35911,0 35915,1 35944,0 35997,1 36094,0 36153,1 36195,0 36279,1 36320,0 36357,1 36391,0 36421,1 36473,0 36511,1 36570,0 36662,1 36721,0 36762,1 36793,0 36878,1 36898,0 36929,1 36946,0 36961,1 36978,0 37073,1 37110,0 37182,1 37223,0 37312,1 37334,0 37408,1 37442,0 37495,1 37508,0 37532,1 37612,0 37627,1 37642,0 37700,1 37771,0 37784,1 37800,0 37893,1 37957,0 38044,1 38124,0 38219,1 38300,0 38363,1 38418,0 38440,1 38517,0 38613,1 38694,0 38745,1 38767,0 38854,1 38927,0 38997,1 39055,0 39077,1 39089,0 39154,1 39221,0 39305,1 39359,0 39443,1 39515,0 39545,1 39589,0 39679,1 39726,0 39802,1 39859,0 39937,1 39947,0 40015,1 40045,0 40094,1 40170,0 40217,1 40313,0 40359,1 40399,0 40477,1 40545,0 40642,1 40718,0 40724,1 40742,0 40761,1 40806,0 40879,1 40882,0 40901,1 40942,0 41026,1 41086,0 41122,1 41134,0 41168,1 41210,0 41298,1 41303,0 41327,1 41391,0 41409,1 41425,0 41491,1 41557,0 41605,1 41700,0 41745,1 41811,0 41864,1 41945,0 41950,1 41996,0 42083,1 42146,0 42240,1 42335,0 42403,1 42448,0 42492,1 42588,0 42609,1 42665,0 42751,1 42776,0 42845,1 42911,0 43011,1 43089,0 43179,1 43204,0 43285,1 43315,0 43323,1 43390,0 43414,1 43423,0 43496,1 43583,0 43636,1 43691,0 43735,1 43795,0 43838,1 43876,0 43954,1 44027,0 44077,1 44135,0 44193,1 44266,0 44331,1 44370,0 44444,1 44460,0 44493,1 44546,0 44637,1 44649,0 44667,1 44765,0 44796,1 44824,0 44917,1 44986,0 45045,1 45092,0 45191,1 45283,0 45383,1 45461,0 45527,1 45584,0 45637,1 45653,0 45753,1 45771,0 45862,1 45884,0 45938,1 45994,0 46069,1 46125,0 46157,1 46243,0 46333,1 46360,0 46384,1 46417,0 46479,1 46481,0 46523,1 46593,0 46667,1 46745,0 46747,1 46824,0 46893,1 46920,0 47011,1 47025,0 47094,1 47132,0 47144,1 47207,0 47211,1 47274,0 47294,1 47377,0 47415,1 47425,0 47523,1 47565,0 47614,1 47645,0 47689,1 47690,0 47756,1 47841,0 47893,1 47919,0 48012,1 48070,0 48119,1 48151,0 48197,1 48261,0 48299,1 48348,0 48406,1 48452,0 48458,1 48498,0 48586,1 48656,0 48682,1 48779,0 48828,1 48885,0 48914,1 48938,0 49023,1 49094,0 49160,1 49236,0 49279,1 49351,0 49358,1 49378,0 49389,1 49420,0 49445,1 49449,0 49478,1 49535,0 49613,1 49672,0 49709,1 49786,0 49885,1 49911,0 49936,1 49973,0 49975,1 50072,0 50073,1 50150,0 50162,1 50183,0 50215,1 50267,0 50336,1 50401,0 50499,1 50559,0 50568,1 50634,0 50713,1 50797,0 50828,1 50874,0 50951,1 51046,0 51134,1 51222,0 51230,1 51272,0 51347,1 51380,0 51387,1 51455,0 51499,1 51503,0 51563,1 51620,0 51686,1 end initlist b14 0,0 24,1 107,0 163,1 205,0 281,1 311,0 341,1 420,0 432,1 455,0 483,1 565,0 573,1 636,0 654,1 754,0 766,1 793,0 893,1 900,0 952,1 955,0 974,1 994,0 1026,1 1081,0 1091,1 1160,0 1216,1 1303,0 1354,1 1427,0 1444,1 1447,0 1518,1 1566,0 1570,1 1597,0 1629,1 1698,0 1760,1 1814,0 1857,1 1923,0 1984,1 2029,0 2084,1 2118,0 2189,1 2198,0 2259,1 2334,0 2361,1 2394,0 2484,1 2546,0 2570,1 2666,0 2695,1 2701,0 2729,1 2785,0 2802,1 2878,0 2904,1 2919,0 2965,1 3008,0 3104,1 3167,0 3216,1 3251,0 3278,1 3313,0 3404,1 3458,0 3479,1 3551,0 3569,1 3583,0 3645,1 3713,0 3759,1 3832,0 3888,1 3953,0 4015,1 4047,0 4128,1 4224,0 4274,1 4372,0 4426,1 4493,0 4515,1 4590,0 4634,1 4647,0 4690,1 4725,0 4746,1 4759,0 4779,1 4859,0 4871,1 4912,0 4939,1 4970,0 5007,1 5084,0 5129,1 5148,0 5241,1 5310,0 5338,1 5383,0 5442,1 5524,0 5621,1 5689,0 5777,1 5799,0 5805,1 5901,0 5933,1 5983,0 5986,1 6012,0 6068,1 6084,0 6150,1 6233,0 6323,1 6365,0 6456,1 6515,0 6530,1 6536,0 6543,1 6546,0 6558,1 6629,0 6717,1 6724,0 6728,1 6779,0 6877,1 6917,0 6971,1 7014,0 7057,1 7074,0 7161,1 7206,0 7264,1 7303,0 7321,1 7383,0 7405,1 7426,0 7503,1 7528,0 7561,1 7593,0 7686,1 7783,0 7860,1 7902,0 7978,1 7996,0 8057,1 8091,0 8149,1 8213,0 8297,1 8311,0 8365,1 8455,0 8528,1 8589,0 8668,1 8673,0 8765,1 8811,0 8818,1 8878,0 8965,1 9016,0 9114,1 9171,0 9185,1 9192,0 9233,1 9326,0 9416,1 9508,0 9579,1 9641,0 9730,1 9829,0 9878,1 9948,0 10008,1 10027,0 10064,1 10147,0 10188,1 10191,0 10265,1 10270,0 10328,1 10413,0 10488,1 10531,0 10563,1 10596,0 10624,1 10684,0 10780,1 10797,0 10860,1 10921,0 11001,1 11086,0 11180,1 11259,0 11345,1 11348,0 11412,1 11470,0 11534,1 11628,0 11655,1 11731,0 11751,1 11829,0 11869,1 11895,0 11898,1 11922,0 11975,1 12037,0 12052,1 12136,0 12197,1 12224,0 12249,1 12317,0 12353,1 12374,0 12449,1 12536,0 12598,1 12619,0 12696,1 12733,0 12765,1 12783,0 12870,1 12909,0 13004,1 13016,0 13070,1 13089,0 13170,1 13207,0 13298,1 13376,0 13450,1 13469,0 13494,1 13522,0 13619,1 13644,0 13721,1 13743,0 13829,1 13831,0 13896,1 13925,0 13937,1 13988,0 14071,1 14121,0 14188,1 14259,0 14311,1 14352,0 14383,1 14447,0 14509,1 14605,0 14634,1 14688,0 14713,1 14731,0 14795,1 14875,0 14967,1 15040,0 15111,1 15207,0 15239,1 15325,0 15326,1 15329,0 15395,1 15451,0 15514,1 15531,0 15613,1 15689,0 15691,1 15733,0 15827,1 15867,0 15878,1 15934,0 16008,1 16022,0 16066,1 16121,0 16216,1 16240,0 16301,1 16400,0 16416,1 16476,0 16494,1 16533,0 16565,1 16653,0 16661,1 16747,0 16832,1 16902,0 16913,1 16961,0 17026,1 17027,0 17098,1 17163,0 17178,1 17190,0 17226,1 17314,0 17371,1 17380,0 17416,1 17496,0 17506,1 17540,0 17615,1 17667,0 17744,1 17788,0 17879,1 17932,0 18029,1 18036,0 18089,1 18112,0 18185,1 18283,0 18342,1 18376,0 18402,1 18438,0 18535,1 18580,0 18672,1 18686,0 18750,1 18821,0 18847,1 18909,0 18929,1 18935,0 18958,1 18990,0 19007,1 19023,0 19121,1 19221,0 19240,1 19241,0 19263,1 19363,0 19387,1 19484,0 19583,1 19603,0 19630,1 19635,0 19712,1 19778,0 19818,1 19827,0 19871,1 19936,0 19943,1 19997,0 20019,1 20049,0 20075,1 20163,0 20260,1 20289,0 20359,1 20385,0 20466,1 20554,0 20650,1 20683,0 20746,1 20814,0 20904,1 20963,0 21025,1 21029,0 21076,1 21176,0 21214,1 21279,0 21372,1 21390,0 21489,1 21567,0 21572,1 21637,0 21645,1 21655,0 21695,1 21743,0 21757,1 21781,0 21817,1 21856,0 21913,1 21973,0 22012,1 22094,0 22154,1 22213,0 22302,1 22393,0 22424,1 22445,0 22451,1 22509,0 22578,1 22592,0 22638,1 22653,0 22665,1 22724,0 22783,1 22842,0 22909,1 22936,0 22958,1 23037,0 23057,1 23060,0 23157,1 23251,0 23342,1 23368,0 23458,1 23528,0 23623,1 23710,0 23773,1 23839,0 23894,1 23907,0 23914,1 23958,0 24050,1 24072,0 24138,1 24162,0 24215,1 24220,0 24311,1 24406,0 24495,1 24513,0 24515,1 24521,0 24620,1 24720,0 24721,1 24763,0 24808,1 24872,0 24925,1 24964,0 24984,1 25033,0 25055,1 25110,0 25113,1 25195,0 25210,1 25303,0 25403,1 25409,0 25458,1 25482,0 25532,1 25627,0 25706,1 25735,0 25819,1 25892,0 25952,1 26049,0 26120,1 26156,0 26158,1 26201,0 26212,1 26223,0 26237,1 26269,0 26324,1 26394,0 26399,1 26437,0 26480,1 26569,0 26659,1 26660,0 26668,1 26756,0 26834,1 26861,0 26933,1 26998,0 27004,1 27026,0 27052,1 27145,0 27239,1 27255,0 27354,1 27387,0 27430,1 27435,0 27487,1 27555,0 27587,1 27680,0 27749,1 27790,0 27840,1 27873,0 27920,1 27948,0 27990,1 28069,0 28082,1 28109,0 28164,1 28174,0 28206,1 28268,0 28277,1 28286,0 28333,1 28423,0 28463,1 28517,0 28572,1 28663,0 28734,1 28771,0 28800,1 28843,0 28911,1 28953,0 28997,1 29056,0 29116,1 29183,0 29205,1 29229,0 29303,1 29349,0 29430,1 29434,0 29522,1 29580,0 29659,1 29661,0 29684,1 29727,0 29761,1 29854,0 29903,1 29960,0 30042,1 30079,0 30153,1 30182,0 30209,1 30274,0 30337,1 30410,0 30414,1 30449,0 30463,1 30563,0 30566,1 30623,0 30635,1 30646,0 30727,1 30759,0 30776,1 30810,0 30899,1 30967,0 31041,1 31090,0 31166,1 31256,0 31349,1 31388,0 31481,1 31515,0 31517,1 31580,0 31629,1 31651,0 31704,1 31792,0 31816,1 31819,0 31852,1 31923,0 32011,1 32072,0 32127,1 32181,0 32202,1 32279,0 32331,1 32411,0 32495,1 32509,0 32576,1 32645,0 32648,1 32729,0 32805,1 32828,0 32891,1 32946,0 32997,1 33030,0 33095,1 33105,0 33171,1 33231,0 33325,1 33330,0 33353,1 33415,0 33422,1 33516,0 33600,1 33654,0 33741,1 33790,0 33870,1 33877,0 33897,1 33958,0 33968,1 33971,0 33975,1 34011,0 34109,1 34115,0 34173,1 34270,0 34354,1 34418,0 34486,1 34585,0 34668,1 34705,0 34784,1 34818,0 34861,1 34955,0 35009,1 35105,0 35182,1 35272,0 35364,1 35419,0 35444,1 35500,0 35587,1 35667,0 35708,1 35717,0 35725,1 35802,0 35842,1 35915,0 35957,1 36022,0 36116,1 36180,0 36191,1 36215,0 36256,1 36287,0 36366,1 36458,0 36487,1 36499,0 36514,1 36522,0 36605,1 36659,0 36752,1 36788,0 36805,1 36865,0 36941,1 36972,0 37015,1 37040,0 37108,1 37170,0 37262,1 37265,0 37306,1 37320,0 37341,1 37376,0 37438,1 37499,0 37516,1 37552,0 37583,1 37668,0 37672,1 37688,0 37730,1 37732,0 37783,1 37785,0 37799,1 37823,0 37846,1 37862,0 37959,1 37965,0 38049,1 38055,0 38112,1 38146,0 38170,1 38220,0 38264,1 38302,0 38346,1 38403,0 38450,1 38472,0 38555,1 38652,0 38669,1 38685,0 38745,1 38838,0 38852,1 38893,0 38981,1 39037,0 39046,1 39138,0 39193,1 39267,0 39340,1 39395,0 39446,1 39490,0 39580,1 39592,0 39601,1 39635,0 39637,1 39696,0 39764,1 39828,0 39910,1 39996,0 40005,1 40021,0 40071,1 40119,0 40204,1 40236,0 40246,1 40337,0 40390,1 40420,0 40484,1 40500,0 40518,1 40552,0 40640,1 40668,0 40680,1 40779,0 40850,1 40894,0 40961,1 40966,0 40975,1 41063,0 41091,1 41093,0 41100,1 41138,0 41198,1 41260,0 41306,1 41357,0 41431,1 41472,0 41535,1 41544,0 41556,1 41572,0 41621,1 41632,0 41685,1 41691,0 41692,1 41775,0 41850,1 41880,0 41923,1 41980,0 42025,1 42076,0 42154,1 42235,0 42309,1 42344,0 42437,1 42523,0 42535,1 42559,0 42566,1 42629,0 42663,1 42761,0 42777,1 42847,0 42897,1 42963,0 43044,1 43111,0 43136,1 43176,0 43213,1 43262,0 43344,1 43363,0 43389,1 43445,0 43488,1 43562,0 43563,1 43653,0 43661,1 43711,0 43715,1 43802,0 43858,1 43881,0 43928,1 44008,0 44082,1 44118,0 44194,1 44253,0 44336,1 44436,0 44480,1 44511,0 44568,1 44612,0 44645,1 44690,0 44722,1 44799,0 44856,1 44926,0 44982,1 45058,0 45086,1 45118,0 45172,1 45211,0 45215,1 45265,0 45299,1 45311,0 45330,1 45400,0 45496,1 45550,0 45553,1 45608,0 45692,1 45771,0 45851,1 45870,0 45952,1 46010,0 46081,1 46105,0 46188,1 46206,0 46256,1 46294,0 46304,1 46314,0 46407,1 46480,0 46534,1 46536,0 46575,1 46628,0 46662,1 46697,0 46771,1 46803,0 46877,1 46929,0 46948,1 46950,0 47023,1 47079,0 47139,1 47153,0 47208,1 47259,0 47281,1 47368,0 47410,1 47448,0 47532,1 47559,0 47636,1 47700,0 47779,1 47841,0 47891,1 47904,0 47940,1 48020,0 48103,1 48145,0 48173,1 48181,0 48222,1 48275,0 48287,1 48318,0 48321,1 48412,0 48476,1 48541,0 48548,1 48561,0 48594,1 48660,0 48708,1 48775,0 48801,1 48812,0 48886,1 48949,0 48996,1 49075,0 49098,1 49172,0 49189,1 49201,0 49250,1 end initlist b15 0,0 8,1 49,0 81,1 167,0 171,1 225,0 282,1 295,0 393,1 412,0 492,1 515,0 530,1 589,0 605,1 680,0 763,1 829,0 863,1 908,0 1004,1 1037,0 1073,1 1172,0 1189,1 1242,0 1338,1 1381,0 1388,1 1480,0 1523,1 1550,0 1611,1 1676,0 1701,1 1737,0 1826,1 1872,0 1876,1 1880,0 1959,1 2015,0 2058,1 2085,0 2126,1 2136,0 2152,1 2230,0 2310,1 2370,0 2413,1 2447,0 2449,1 2474,0 2547,1 2607,0 2633,1 2694,0 2760,1 2833,0 2910,1 2973,0 3041,1 3139,0 3196,1 3237,0 3295,1 3381,0 3448,1 3498,0 3571,1 3597,0 3684,1 3693,0 3730,1 3791,0 3821,1 3838,0 3926,1 4012,0 4077,1 4144,0 4175,1 4244,0 4309,1 4366,0 4368,1 4439,0 4497,1 4550,0 4643,1 4728,0 4739,1 4811,0 4893,1 4947,0 4962,1 5015,0 5037,1 5130,0 5173,1 5273,0 5323,1 5408,0 5440,1 5447,0 5450,1 5499,0 5511,1 5567,0 5604,1 5622,0 5714,1 5808,0 5845,1 5887,0 5889,1 5917,0 5973,1 6055,0 6146,1 6222,0 6243,1 6316,0 6362,1 6365,0 6452,1 6461,0 6551,1 6594,0 6694,1 6697,0 6759,1 6815,0 6841,1 6864,0 6926,1 6970,0 7063,1 7084,0 7143,1 7221,0 7308,1 7327,0 7396,1 7474,0 7486,1 7513,0 7583,1 7635,0 7673,1 7754,0 7767,1 7770,0 7865,1 7941,0 8033,1 8037,0 8101,1 8157,0 8256,1 8260,0 8262,1 8277,0 8281,1 8348,0 8444,1 8487,0 8531,1 8578,0 8607,1 8695,0 8753,1 8764,0 8861,1 8918,0 8996,1 9067,0 9073,1 9108,0 9180,1 9253,0 9271,1 9368,0 9454,1 9527,0 9544,1 9629,0 9667,1 9681,0 9718,1 9804,0 9848,1 9871,0 9886,1 9982,0 10007,1 10106,0 10173,1 10233,0 10264,1 10315,0 10374,1 10407,0 10456,1 10535,0 10621,1 10644,0 10648,1 10738,0 10823,1 10870,0 10905,1 10977,0 11039,1 11092,0 11127,1 11189,0 11224,1 11295,0 11314,1 11362,0 11438,1 11454,0 11516,1 11519,0 11616,1 11699,0 11786,1 11879,0 11901,1 11918,0 12003,1 12026,0 12117,1 12171,0 12228,1 12243,0 12275,1 12330,0 12349,1 12431,0 12446,1 12500,0 12506,1 12534,0 12576,1 12598,0 12608,1 12636,0 12655,1 12656,0 12686,1 12779,0 12782,1 12862,0 12926,1 12958,0 13029,1 13061,0 13083,1 13162,0 13252,1 13286,0 13375,1 13468,0 13498,1 13505,0 13582,1 13583,0 13676,1 13729,0 13818,1 13871,0 13951,1 14021,0 14032,1 14097,0 14179,1 14201,0 14272,1 14352,0 14430,1 14509,0 14515,1 14575,0 14611,1 14642,0 14647,1 14683,0 14753,1 14809,0 14811,1 14840,0 14914,1 14938,0 14954,1 14983,0 15066,1 15075,0 15147,1 15240,0 15327,1 15361,0 15385,1 15397,0 15465,1 15526,0 15552,1 15608,0 15685,1 15701,0 15740,1 15771,0 15835,1 15907,0 15939,1 15982,0 16008,1 16011,0 16054,1 16129,0 16213,1 16223,0 16256,1 16321,0 16403,1 16439,0 16523,1 16544,0 16618,1 16663,0 16674,1 16754,0 16756,1 16822,0 16873,1 16955,0 17041,1 17086,0 17110,1 17118,0 17170,1 17235,0 17317,1 17389,0 17399,1 17458,0 17496,1 17536,0 17585,1 17671,0 17700,1 17727,0 17782,1 17841,0 17896,1 17989,0 18011,1 18083,0 18151,1 18165,0 18189,1 18221,0 18246,1 18273,0 18345,1 18386,0 18423,1 18441,0 18495,1 18498,0 18527,1 18535,0 18537,1 18606,0 18664,1 18687,0 18753,1 18820,0 18835,1 18913,0 18987,1 19050,0 19133,1 19145,0 19219,1 19224,0 19294,1 19310,0 19405,1 19433,0 19437,1 19477,0 19519,1 19602,0 19605,1 19654,0 19720,1 19760,0 19793,1 19891,0 19906,1 19970,0 20011,1 20066,0 20120,1 20188,0 20280,1 20297,0 20355,1 20389,0 20404,1 20503,0 20596,1 20652,0 20660,1 20666,0 20695,1 20784,0 20855,1 20908,0 20958,1 20965,0 21007,1 21016,0 21097,1 21127,0 21130,1 21195,0 21253,1 21278,0 21344,1 21365,0 21396,1 21401,0 21476,1 21517,0 21541,1 21575,0 21595,1 21648,0 21698,1 21751,0 21828,1 21882,0 21917,1 21952,0 22033,1 22124,0 22175,1 22222,0 22230,1 22268,0 22312,1 22368,0 22461,1 22559,0 22564,1 22616,0 22622,1 22720,0 22721,1 22744,0 22791,1 22869,0 22963,1 22977,0 23044,1 23068,0 23163,1 23176,0 23233,1 23317,0 23348,1 23390,0 23419,1 23473,0 23497,1 23533,0 23620,1 23719,0 23730,1 23783,0 23826,1 23864,0 23925,1 24003,0 24036,1 24124,0 24143,1 24198,0 24281,1 24321,0 24408,1 24456,0 24494,1 24523,0 24545,1 24628,0 24721,1 24777,0 24863,1 24935,0 24967,1 25040,0 25042,1 25045,0 25070,1 25100,0 25139,1 25184,0 25219,1 25312,0 25334,1 25343,0 25396,1 25441,0 25472,1 25542,0 25632,1 25643,0 25658,1 25722,0 25732,1 25798,0 25807,1 25808,0 25838,1 25886,0 25962,1 26016,0 26075,1 26171,0 26214,1 26299,0 26356,1 26438,0 26527,1 26627,0 26681,1 26731,0 26739,1 26828,0 26834,1 26873,0 26955,1 26979,0 26991,1 27069,0 27085,1 27115,0 27203,1 27247,0 27323,1 27382,0 27469,1 27492,0 27502,1 27521,0 27599,1 27684,0 27733,1 27823,0 27829,1 27900,0 27917,1 27943,0 27998,1 28039,0 28094,1 28121,0 28204,1 28252,0 28255,1 28345,0 28435,1 28451,0 28478,1 28515,0 28543,1 28610,0 28701,1 28790,0 28879,1 28882,0 28976,1 29005,0 29018,1 29072,0 29104,1 29200,0 29247,1 29333,0 29419,1 29438,0 29513,1 29556,0 29631,1 29640,0 29661,1 29694,0 29733,1 29833,0 29906,1 29911,0 29988,1 30016,0 30067,1 30081,0 30110,1 30141,0 30201,1 30257,0 30349,1 30371,0 30447,1 30544,0 30603,1 30672,0 30734,1 30737,0 30788,1 30840,0 30856,1 30892,0 30971,1 31050,0 31146,1 31153,0 31244,1 31267,0 31313,1 31380,0 31472,1 31501,0 31530,1 31572,0 31669,1 31740,0 31828,1 31904,0 31999,1 32093,0 32177,1 32246,0 32310,1 32385,0 32422,1 32497,0 32542,1 32632,0 32643,1 32704,0 32727,1 32811,0 32910,1 32968,0 33050,1 33100,0 33139,1 33230,0 33293,1 33310,0 33381,1 33454,0 33501,1 33529,0 33552,1 33627,0 33642,1 33653,0 33674,1 33699,0 33717,1 33783,0 33824,1 33829,0 33898,1 33969,0 34064,1 34091,0 34164,1 34249,0 34328,1 34411,0 34508,1 34557,0 34571,1 34604,0 34612,1 34704,0 34785,1 34792,0 34815,1 34907,0 34916,1 34987,0 35062,1 35152,0 35204,1 35273,0 35315,1 35379,0 35443,1 35477,0 35505,1 35539,0 35578,1 35677,0 35775,1 35813,0 35851,1 35947,0 36032,1 36121,0 36131,1 36183,0 36236,1 36280,0 36353,1 36431,0 36476,1 36525,0 36563,1 36652,0 36722,1 36750,0 36841,1 36916,0 37002,1 37011,0 37080,1 37138,0 37198,1 37275,0 37311,1 37392,0 37484,1 37501,0 37531,1 37538,0 37578,1 37593,0 37686,1 37712,0 37781,1 37790,0 37855,1 37866,0 37874,1 37883,0 37905,1 37953,0 38009,1 38090,0 38109,1 38189,0 38275,1 38295,0 38377,1 38445,0 38450,1 38521,0 38562,1 38630,0 38659,1 38664,0 38714,1 38764,0 38778,1 38874,0 38916,1 38976,0 39039,1 39111,0 39210,1 39238,0 39252,1 39301,0 39370,1 39414,0 39447,1 39474,0 39477,1 39567,0 39662,1 39714,0 39752,1 39771,0 39856,1 39918,0 39941,1 39944,0 39947,1 40024,0 40120,1 40125,0 40166,1 40255,0 40304,1 40316,0 40404,1 40437,0 40531,1 40569,0 40612,1 40626,0 40652,1 40735,0 40749,1 40842,0 40897,1 40924,0 40981,1 41039,0 41098,1 41123,0 41126,1 41171,0 41216,1 41281,0 41329,1 41351,0 41394,1 41479,0 41577,1 41626,0 41713,1 41755,0 41818,1 41824,0 41837,1 41896,0 41949,1 41982,0 42039,1 42053,0 42060,1 42063,0 42156,1 42218,0 42313,1 42407,0 42475,1 42497,0 42563,1 42615,0 42681,1 42761,0 42792,1 42831,0 42860,1 42886,0 42962,1 43038,0 43128,1 43208,0 43219,1 43283,0 43321,1 43393,0 43425,1 43444,0 43451,1 43462,0 43550,1 43553,0 43651,1 43674,0 43701,1 43759,0 43789,1 43874,0 43971,1 43987,0 44057,1 44100,0 44195,1 44207,0 44222,1 44271,0 44305,1 44306,0 44330,1 44355,0 44398,1 44435,0 44478,1 44574,0 44667,1 44738,0 44762,1 44827,0 44860,1 44957,0 44975,1 45053,0 45075,1 45125,0 45203,1 45301,0 45326,1 45400,0 45445,1 45537,0 45609,1 45692,0 45787,1 45860,0 45881,1 45908,0 45909,1 45916,0 46010,1 46067,0 46161,1 46230,0 46295,1 46323,0 46360,1 46455,0 46462,1 46490,0 46509,1 46594,0 46627,1 46671,0 46686,1 46784,0 46869,1 46940,0 46967,1 46992,0 47024,1 47042,0 47068,1 47123,0 47172,1 47254,0 47272,1 47314,0 47352,1 47410,0 47493,1 47538,0 47557,1 47625,0 47655,1 47716,0 47777,1 47837,0 47903,1 47985,0 48067,1 48104,0 48190,1 48205,0 48209,1 48296,0 48306,1 48334,0 48392,1 48478,0 48546,1 48621,0 48677,1 48725,0 48776,1 48780,0 48782,1 48855,0 48918,1 48974,0 49012,1 49107,0 49151,1 49215,0 49276,1 49355,0 49359,1 49363,0 49402,1 49461,0 49466,1 49487,0 49504,1 49594,0 49624,1 49662,0 49746,1 49822,0 49860,1 49870,0 49952,1 50019,0 50053,1 50104,0 50107,1 50114,0 50156,1 end initlist b16 0,0 99,1 191,0 241,1 268,0 271,1 349,0 411,1 425,0 519,1 537,0 626,1 683,0 740,1 805,0 889,1 897,0 921,1 987,0 995,1 1087,0 1118,1 1161,0 1213,1 1244,0 1335,1 1397,0 1401,1 1419,0 1427,1 1435,0 1474,1 1487,0 1587,1 1603,0 1614,1 1665,0 1753,1 1802,0 1805,1 1808,0 1870,1 1925,0 2005,1 2040,0 2125,1 2195,0 2201,1 2225,0 2296,1 2358,0 2363,1 2382,0 2394,1 2481,0 2495,1 2520,0 2538,1 2555,0 2624,1 2644,0 2738,1 2760,0 2838,1 2908,0 3004,1 3021,0 3101,1 3196,0 3253,1 3280,0 3283,1 3378,0 3466,1 3470,0 3540,1 3591,0 3638,1 3668,0 3743,1 3831,0 3839,1 3873,0 3906,1 3961,0 4059,1 4117,0 4175,1 4225,0 4312,1 4351,0 4368,1 4404,0 4463,1 4467,0 4534,1 4539,0 4574,1 4586,0 4626,1 4697,0 4752,1 4786,0 4787,1 4835,0 4872,1 4960,0 4997,1 5008,0 5103,1 5182,0 5224,1 5258,0 5325,1 5378,0 5436,1 5457,0 5477,1 5550,0 5571,1 5628,0 5695,1 5795,0 5881,1 5912,0 6001,1 6072,0 6111,1 6150,0 6248,1 6328,0 6338,1 6408,0 6468,1 6543,0 6575,1 6631,0 6724,1 6744,0 6791,1 6849,0 6852,1 6864,0 6939,1 7020,0 7088,1 7160,0 7172,1 7188,0 7237,1 7305,0 7395,1 7423,0 7499,1 7552,0 7587,1 7649,0 7657,1 7712,0 7749,1 7811,0 7900,1 7962,0 8004,1 8059,0 8115,1 8206,0 8268,1 8292,0 8380,1 8407,0 8473,1 8549,0 8551,1 8558,0 8589,1 8623,0 8667,1 8672,0 8754,1 8854,0 8930,1 9005,0 9028,1 9049,0 9089,1 9181,0 9254,1 9338,0 9339,1 9355,0 9450,1 9469,0 9532,1 9559,0 9617,1 9666,0 9758,1 9838,0 9891,1 9987,0 10041,1 10093,0 10168,1 10185,0 10242,1 10281,0 10301,1 10374,0 10419,1 10508,0 10580,1 10585,0 10589,1 10689,0 10714,1 10716,0 10804,1 10813,0 10850,1 10852,0 10858,1 10918,0 10966,1 11061,0 11124,1 11172,0 11174,1 11251,0 11315,1 11357,0 11380,1 11480,0 11513,1 11593,0 11660,1 11746,0 11783,1 11805,0 11826,1 11872,0 11942,1 12029,0 12031,1 12054,0 12148,1 12191,0 12233,1 12240,0 12288,1 12387,0 12444,1 12459,0 12491,1 12509,0 12526,1 12571,0 12581,1 12625,0 12670,1 12683,0 12772,1 12857,0 12890,1 12933,0 12940,1 12976,0 13023,1 13079,0 13117,1 13147,0 13242,1 13290,0 13365,1 13442,0 13521,1 13545,0 13568,1 13577,0 13592,1 13687,0 13757,1 13825,0 13892,1 13985,0 14028,1 14054,0 14072,1 14099,0 14190,1 14218,0 14310,1 14395,0 14407,1 14464,0 14528,1 14559,0 14651,1 14665,0 14674,1 14702,0 14797,1 14848,0 14898,1 14913,0 14917,1 14999,0 15005,1 15059,0 15061,1 15133,0 15175,1 15207,0 15255,1 15348,0 15353,1 15410,0 15473,1 15539,0 15576,1 15648,0 15650,1 15680,0 15727,1 15802,0 15892,1 15940,0 15975,1 16006,0 16042,1 16121,0 16152,1 16182,0 16224,1 16253,0 16255,1 16347,0 16350,1 16437,0 16502,1 16558,0 16650,1 16670,0 16677,1 16735,0 16808,1 16883,0 16943,1 17033,0 17086,1 17101,0 17143,1 17205,0 17294,1 17314,0 17399,1 17475,0 17489,1 17493,0 17591,1 17646,0 17746,1 17840,0 17870,1 17933,0 18003,1 18030,0 18116,1 18143,0 18203,1 18291,0 18326,1 18406,0 18498,1 18557,0 18569,1 18661,0 18743,1 18798,0 18804,1 18845,0 18853,1 18894,0 18952,1 19000,0 19049,1 19149,0 19221,1 19279,0 19293,1 19309,0 19386,1 19388,0 19425,1 19445,0 19487,1 19562,0 19587,1 19667,0 19731,1 19760,0 19777,1 19816,0 19903,1 19907,0 19933,1 20031,0 20110,1 20132,0 20177,1 20195,0 20280,1 20357,0 20386,1 20407,0 20480,1 20549,0 20570,1 20583,0 20679,1 20758,0 20854,1 20881,0 20973,1 20977,0 21017,1 21065,0 21132,1 21228,0 21236,1 21311,0 21397,1 21455,0 21471,1 21500,0 21509,1 21564,0 21652,1 21739,0 21800,1 21829,0 21870,1 21923,0 22001,1 22017,0 22022,1 22120,0 22128,1 22146,0 22187,1 22191,0 22246,1 22250,0 22312,1 22317,0 22331,1 22372,0 22387,1 22487,0 22515,1 22604,0 22620,1 22634,0 22680,1 22757,0 22770,1 22820,0 22831,1 22874,0 22879,1 22924,0 22931,1 23024,0 23093,1 23108,0 23129,1 23136,0 23215,1 23278,0 23302,1 23304,0 23396,1 23402,0 23443,1 23519,0 23584,1 23627,0 23643,1 23697,0 23796,1 23854,0 23862,1 23932,0 24015,1 24027,0 24112,1 24151,0 24182,1 24185,0 24248,1 24324,0 24366,1 24397,0 24448,1 24484,0 24541,1 24574,0 24583,1 24586,0 24609,1 24687,0 24782,1 24834,0 24840,1 24920,0 25010,1 25105,0 25149,1 25166,0 25214,1 25243,0 25254,1 25323,0 25412,1 25451,0 25512,1 25579,0 25582,1 25614,0 25694,1 25784,0 25796,1 25807,0 25838,1 25855,0 25906,1 25961,0 25966,1 25987,0 26037,1 26102,0 26194,1 26207,0 26211,1 26243,0 26313,1 26383,0 26411,1 26451,0 26546,1 26619,0 26629,1 26714,0 26769,1 26841,0 26915,1 26999,0 27004,1 27080,0 27085,1 27142,0 27145,1 27193,0 27218,1 27291,0 27341,1 27432,0 27478,1 27555,0 27573,1 27613,0 27622,1 27692,0 27789,1 27830,0 27843,1 27935,0 28019,1 28045,0 28122,1 28132,0 28160,1 28237,0 28294,1 28315,0 28358,1 28368,0 28383,1 28476,0 28568,1 28587,0 28646,1 28720,0 28733,1 28796,0 28811,1 28825,0 28835,1 28905,0 28979,1 28991,0 29069,1 29129,0 29216,1 29267,0 29310,1 29347,0 29411,1 29430,0 29453,1 29485,0 29552,1 29554,0 29598,1 29686,0 29771,1 29848,0 29932,1 29981,0 29999,1 30038,0 30086,1 30169,0 30262,1 30333,0 30369,1 30404,0 30406,1 30444,0 30448,1 30494,0 30586,1 30620,0 30628,1 30696,0 30699,1 30730,0 30825,1 30856,0 30902,1 30937,0 30979,1 30982,0 31081,1 31086,0 31103,1 31201,0 31262,1 31314,0 31395,1 31489,0 31546,1 31621,0 31635,1 31699,0 31799,1 31802,0 31854,1 31867,0 31910,1 31975,0 32036,1 32066,0 32143,1 32190,0 32262,1 32348,0 32365,1 32464,0 32475,1 32549,0 32636,1 32730,0 32825,1 32915,0 32928,1 32968,0 33056,1 33146,0 33183,1 33212,0 33311,1 33328,0 33388,1 33390,0 33395,1 33398,0 33480,1 33539,0 33583,1 33669,0 33674,1 33741,0 33798,1 33839,0 33854,1 33940,0 34011,1 34040,0 34076,1 34148,0 34244,1 34300,0 34323,1 34350,0 34447,1 34501,0 34520,1 34530,0 34584,1 34653,0 34751,1 34819,0 34861,1 34920,0 34933,1 34979,0 35005,1 35105,0 35106,1 35200,0 35241,1 35292,0 35296,1 35334,0 35378,1 35464,0 35533,1 35540,0 35606,1 35674,0 35750,1 35759,0 35787,1 35818,0 35905,1 35983,0 36076,1 36123,0 36146,1 36243,0 36332,1 36340,0 36438,1 36535,0 36536,1 36604,0 36636,1 36641,0 36708,1 36773,0 36849,1 36938,0 37013,1 37032,0 37123,1 37159,0 37178,1 37268,0 37318,1 37321,0 37326,1 37372,0 37380,1 37480,0 37484,1 37485,0 37561,1 37657,0 37733,1 37791,0 37803,1 37868,0 37910,1 37977,0 38011,1 38089,0 38099,1 38105,0 38153,1 38165,0 38226,1 38271,0 38346,1 38428,0 38447,1 38463,0 38560,1 38618,0 38640,1 38652,0 38704,1 38719,0 38798,1 38890,0 38936,1 38949,0 39004,1 39008,0 39048,1 39067,0 39076,1 39151,0 39198,1 39219,0 39299,1 39326,0 39331,1 39395,0 39466,1 39541,0 39606,1 39667,0 39693,1 39779,0 39842,1 39858,0 39916,1 39930,0 39962,1 40056,0 40133,1 40145,0 40240,1 40310,0 40384,1 40466,0 40501,1 40519,0 40604,1 40666,0 40707,1 40710,0 40808,1 40811,0 40819,1 40887,0 40986,1 41082,0 41084,1 41120,0 41208,1 41241,0 41273,1 41328,0 41383,1 41461,0 41506,1 41575,0 41603,1 41657,0 41699,1 41705,0 41750,1 41760,0 41795,1 41803,0 41858,1 41863,0 41936,1 41998,0 42075,1 42105,0 42147,1 42204,0 42269,1 42271,0 42313,1 42341,0 42424,1 42460,0 42555,1 42586,0 42660,1 42683,0 42769,1 42779,0 42785,1 42811,0 42865,1 42962,0 43046,1 43052,0 43063,1 43152,0 43193,1 43278,0 43361,1 43399,0 43448,1 43526,0 43560,1 43587,0 43611,1 43620,0 43688,1 43703,0 43780,1 43863,0 43936,1 43989,0 44023,1 44075,0 44125,1 44171,0 44234,1 44319,0 44328,1 44416,0 44451,1 44460,0 44505,1 44561,0 44614,1 44633,0 44670,1 44727,0 44777,1 44855,0 44934,1 45026,0 45086,1 45148,0 45171,1 45208,0 45235,1 45292,0 45378,1 45391,0 45466,1 45487,0 45495,1 45593,0 45638,1 45646,0 45675,1 45712,0 45806,1 45891,0 45944,1 46029,0 46048,1 46114,0 46151,1 46192,0 46291,1 46295,0 46334,1 46345,0 46357,1 46384,0 46474,1 46569,0 46644,1 46672,0 46705,1 46754,0 46769,1 46836,0 46904,1 46913,0 46966,1 46991,0 46998,1 47095,0 47143,1 47152,0 47186,1 47276,0 47282,1 47312,0 47399,1 47438,0 47477,1 47543,0 47588,1 47591,0 47674,1 47684,0 47727,1 47762,0 47765,1 47773,0 47829,1 47865,0 47878,1 47899,0 47943,1 48033,0 48069,1 48110,0 48178,1 48180,0 48225,1 48254,0 48305,1 48392,0 48394,1 48492,0 48526,1 48622,0 48719,1 end initlist b17 0,0 2,1 5,0 12,1 54,0 64,1 135,0 215,1 247,0 281,1 282,0 349,1 431,0 439,1 498,0 563,1 622,0 700,1 706,0 785,1 853,0 882,1 963,0 1062,1 1115,0 1153,1 1223,0 1268,1 1327,0 1359,1 1381,0 1465,1 1561,0 1627,1 1678,0 1732,1 1791,0 1804,1 1897,0 1907,1 2007,0 2029,1 2115,0 2118,1 2165,0 2169,1 2211,0 2289,1 2329,0 2372,1 2445,0 2446,1 2449,0 2520,1 2539,0 2614,1 2703,0 2794,1 2867,0 2935,1 3004,0 3072,1 3146,0 3216,1 3223,0 3229,1 3261,0 3267,1 3287,0 3305,1 3400,0 3460,1 3504,0 3510,1 3532,0 3609,1 3655,0 3733,1 3783,0 3817,1 3904,0 3944,1 3972,0 4030,1 4077,0 4170,1 4237,0 4324,1 4387,0 4474,1 4508,0 4572,1 4630,0 4650,1 4675,0 4733,1 4792,0 4832,1 4844,0 4874,1 4878,0 4971,1 5071,0 5098,1 5187,0 5217,1 5308,0 5376,1 5470,0 5498,1 5526,0 5586,1 5632,0 5663,1 5714,0 5786,1 5882,0 5898,1 5956,0 6035,1 6107,0 6128,1 6211,0 6307,1 6359,0 6399,1 6448,0 6507,1 6532,0 6586,1 6588,0 6650,1 6748,0 6806,1 6866,0 6932,1 6936,0 6947,1 7015,0 7109,1 7163,0 7189,1 7212,0 7305,1 7368,0 7412,1 7483,0 7557,1 7586,0 7603,1 7627,0 7666,1 7709,0 7798,1 7852,0 7874,1 7950,0 8013,1 8074,0 8134,1 8184,0 8196,1 8259,0 8331,1 8424,0 8518,1 8547,0 8631,1 8706,0 8797,1 8838,0 8857,1 8880,0 8946,1 9009,0 9104,1 9129,0 9215,1 9290,0 9326,1 9399,0 9496,1 9568,0 9618,1 9697,0 9795,1 9831,0 9833,1 9921,0 9994,1 10009,0 10025,1 10079,0 10176,1 10241,0 10316,1 10393,0 10478,1 10577,0 10641,1 10728,0 10759,1 10817,0 10873,1 10950,0 11011,1 11044,0 11062,1 11139,0 11149,1 11249,0 11338,1 11428,0 11436,1 11467,0 11557,1 11610,0 11655,1 11731,0 11823,1 11919,0 11956,1 11989,0 12074,1 12113,0 12135,1 12213,0 12286,1 12362,0 12400,1 12425,0 12476,1 12566,0 12644,1 12698,0 12781,1 12803,0 12830,1 12849,0 12894,1 12979,0 13069,1 13137,0 13230,1 13262,0 13347,1 13371,0 13397,1 13406,0 13410,1 13505,0 13511,1 13520,0 13580,1 13606,0 13698,1 13762,0 13829,1 13848,0 13906,1 13995,0 14038,1 14043,0 14116,1 14213,0 14304,1 14314,0 14366,1 14371,0 14391,1 14454,0 14519,1 14609,0 14646,1 14665,0 14750,1 14767,0 14800,1 14816,0 14880,1 14890,0 14972,1 15025,0 15101,1 15173,0 15183,1 15224,0 15257,1 15296,0 15393,1 15418,0 15441,1 15511,0 15513,1 15572,0 15594,1 15646,0 15679,1 15771,0 15783,1 15820,0 15879,1 15956,0 15995,1 16092,0 16111,1 16190,0 16267,1 16348,0 16372,1 16452,0 16537,1 16629,0 16710,1 16731,0 16791,1 16821,0 16878,1 16887,0 16892,1 16967,0 17061,1 17148,0 17205,1 17209,0 17210,1 17259,0 17321,1 17344,0 17365,1 17381,0 17404,1 17469,0 17569,1 17641,0 17734,1 17790,0 17823,1 17850,0 17892,1 17934,0 17984,1 18031,0 18065,1 18133,0 18162,1 18167,0 18230,1 18313,0 18400,1 18413,0 18498,1 18552,0 18631,1 18638,0 18674,1 18703,0 18758,1 18766,0 18784,1 18868,0 18916,1 19012,0 19102,1 19164,0 19261,1 19304,0 19309,1 19390,0 19463,1 19464,0 19505,1 19547,0 19627,1 19693,0 19703,1 19737,0 19758,1 19840,0 19848,1 19911,0 19943,1 20000,0 20027,1 20091,0 20136,1 20155,0 20251,1 20309,0 20405,1 20416,0 20483,1 20491,0 20544,1 20571,0 20653,1 20719,0 20734,1 20807,0 20823,1 20882,0 20936,1 21035,0 21075,1 21079,0 21153,1 21205,0 21297,1 21323,0 21344,1 21430,0 21436,1 21444,0 21514,1 21577,0 21587,1 21631,0 21708,1 21737,0 21747,1 21784,0 21811,1 21859,0 21885,1 21934,0 22007,1 22044,0 22116,1 22155,0 22184,1 22273,0 22308,1 22408,0 22441,1 22463,0 22533,1 22600,0 22611,1 22658,0 22736,1 22819,0 22899,1 22997,0 23082,1 23137,0 23180,1 23235,0 23240,1 23340,0 23430,1 23452,0 23493,1 23503,0 23526,1 23571,0 23610,1 23659,0 23695,1 23774,0 23837,1 23906,0 23983,1 24021,0 24093,1 24168,0 24248,1 24252,0 24331,1 24364,0 24422,1 24483,0 24536,1 24593,0 24609,1 24702,0 24724,1 24753,0 24800,1 24879,0 24973,1 25000,0 25044,1 25132,0 25138,1 25160,0 25260,1 25343,0 25396,1 25409,0 25451,1 25551,0 25589,1 25686,0 25781,1 25798,0 25861,1 25954,0 26005,1 26101,0 26119,1 26210,0 26276,1 26310,0 26384,1 26411,0 26420,1 26515,0 26541,1 26595,0 26632,1 26648,0 26652,1 26656,0 26744,1 26757,0 26758,1 26777,0 26808,1 26873,0 26884,1 26909,0 26989,1 27025,0 27116,1 27200,0 27207,1 27228,0 27252,1 27321,0 27330,1 27361,0 27392,1 27453,0 27457,1 27529,0 27612,1 27678,0 27729,1 27811,0 27837,1 27893,0 27897,1 27920,0 28016,1 28114,0 28191,1 28281,0 28337,1 28436,0 28462,1 28551,0 28563,1 28591,0 28624,1 28717,0 28799,1 28805,0 28808,1 28854,0 28942,1 28971,0 29023,1 29063,0 29135,1 29140,0 29150,1 29161,0 29194,1 29202,0 29222,1 29322,0 29334,1 29429,0 29504,1 29567,0 29638,1 29671,0 29680,1 29777,0 29817,1 29866,0 29923,1 29979,0 30079,1 30122,0 30147,1 30203,0 30281,1 30369,0 30431,1 30442,0 30526,1 30533,0 30613,1 30669,0 30689,1 30750,0 30848,1 30895,0 30944,1 31013,0 31023,1 31050,0 31129,1 31208,0 31276,1 31350,0 31376,1 31453,0 31503,1 31594,0 31689,1 31727,0 31790,1 31882,0 31906,1 31958,0 32005,1 32081,0 32098,1 32159,0 32232,1 32264,0 32361,1 32442,0 32515,1 32575,0 32612,1 32663,0 32731,1 32826,0 32924,1 32992,0 33065,1 33116,0 33146,1 33161,0 33247,1 33265,0 33294,1 33382,0 33450,1 33523,0 33548,1 33646,0 33724,1 33732,0 33752,1 33770,0 33803,1 33893,0 33943,1 34013,0 34107,1 34120,0 34180,1 34275,0 34289,1 34312,0 34325,1 34328,0 34403,1 34427,0 34522,1 34622,0 34651,1 34743,0 34813,1 34856,0 34920,1 34996,0 35045,1 35126,0 35187,1 35251,0 35265,1 35319,0 35369,1 35433,0 35493,1 35571,0 35584,1 35603,0 35618,1 35707,0 35718,1 35818,0 35855,1 35884,0 35901,1 35991,0 36043,1 36091,0 36092,1 36102,0 36116,1 36131,0 36217,1 36254,0 36322,1 36417,0 36459,1 36481,0 36577,1 36627,0 36719,1 36778,0 36872,1 36925,0 37013,1 37095,0 37127,1 37192,0 37200,1 37298,0 37386,1 37387,0 37422,1 37464,0 37496,1 37543,0 37637,1 37692,0 37745,1 37785,0 37879,1 37946,0 37991,1 38033,0 38052,1 38081,0 38095,1 38146,0 38155,1 38186,0 38207,1 38224,0 38237,1 38325,0 38370,1 38398,0 38489,1 38540,0 38629,1 38631,0 38648,1 38731,0 38792,1 38872,0 38972,1 38988,0 39083,1 39175,0 39215,1 39290,0 39316,1 39355,0 39356,1 39455,0 39498,1 39518,0 39589,1 39646,0 39676,1 39692,0 39749,1 39834,0 39859,1 39894,0 39902,1 39952,0 40000,1 40070,0 40077,1 40170,0 40184,1 40214,0 40250,1 40343,0 40345,1 40377,0 40477,1 40537,0 40585,1 40657,0 40709,1 40797,0 40803,1 40826,0 40887,1 40916,0 40948,1 41029,0 41039,1 41047,0 41135,1 41223,0 41243,1 41244,0 41277,1 41287,0 41302,1 41366,0 41431,1 41472,0 41548,1 41564,0 41632,1 41640,0 41703,1 41730,0 41771,1 41819,0 41840,1 41912,0 41921,1 41997,0 42056,1 42116,0 42216,1 42280,0 42294,1 42342,0 42441,1 42473,0 42573,1 42586,0 42662,1 42717,0 42731,1 42788,0 42859,1 42943,0 43007,1 43097,0 43170,1 43248,0 43253,1 43277,0 43330,1 43369,0 43423,1 43436,0 43468,1 43478,0 43499,1 43517,0 43563,1 43656,0 43753,1 43786,0 43821,1 43853,0 43906,1 43950,0 43993,1 44083,0 44117,1 44181,0 44258,1 44334,0 44393,1 44437,0 44440,1 44481,0 44489,1 44550,0 44578,1 44629,0 44650,1 44668,0 44717,1 44797,0 44845,1 44884,0 44935,1 44946,0 45043,1 45045,0 45054,1 45110,0 45196,1 45211,0 45246,1 45306,0 45398,1 45443,0 45456,1 45479,0 45565,1 45584,0 45672,1 45768,0 45784,1 45801,0 45886,1 45953,0 46014,1 46099,0 46181,1 46188,0 46247,1 46305,0 46376,1 46445,0 46491,1 46503,0 46566,1 46591,0 46596,1 46638,0 46647,1 46734,0 46792,1 46851,0 46853,1 46892,0 46978,1 47026,0 47028,1 47063,0 47080,1 47156,0 47212,1 47258,0 47348,1 47418,0 47488,1 47516,0 47539,1 47613,0 47636,1 47710,0 47743,1 47751,0 47758,1 47797,0 47866,1 47962,0 47991,1 48088,0 48152,1 48173,0 48245,1 48319,0 48404,1 48490,0 48515,1 48595,0 48655,1 48714,0 48742,1 48801,0 48802,1 48843,0 48902,1 48972,0 49033,1 49037,0 49067,1 49086,0 49110,1 49133,0 49216,1 49260,0 49292,1 49337,0 49402,1 49452,0 49509,1 49592,0 49669,1 49748,0 49762,1 49791,0 49823,1 49869,0 49924,1 49926,0 50018,1 50111,0 50206,1 50226,0 50296,1 50298,0 50307,1 50369,0 50462,1 50504,0 50575,1 50603,0 50635,1 50651,0 50701,1 50723,0 50776,1 50788,0 50793,1 50848,0 50853,1 50860,0 50916,1 end initlist b18 0,0 42,1 60,0 142,1 204,0 294,1 304,0 377,1 432,0 492,1 526,0 572,1 589,0 634,1 637,0 725,1 733,0 792,1 805,0 819,1 864,0 916,1 941,0 1041,1 1128,0 1159,1 1233,0 1244,1 1318,0 1404,1 1485,0 1577,1 1616,0 1714,1 1738,0 1821,1 1895,0 1972,1 1995,0 2068,1 2165,0 2168,1 2233,0 2265,1 2313,0 2361,1 2431,0 2487,1 2513,0 2526,1 2602,0 2648,1 2714,0 2724,1 2818,0 2916,1 2963,0 3026,1 3066,0 3152,1 3181,0 3274,1 3344,0 3436,1 3459,0 3553,1 3601,0 3642,1 3702,0 3709,1 3793,0 3836,1 3881,0 3950,1 4011,0 4030,1 4089,0 4164,1 4226,0 4288,1 4312,0 4369,1 4410,0 4478,1 4564,0 4634,1 4644,0 4722,1 4735,0 4789,1 4853,0 4924,1 4979,0 5020,1 5028,0 5060,1 5076,0 5156,1 5172,0 5246,1 5252,0 5287,1 5316,0 5409,1 5410,0 5476,1 5504,0 5519,1 5599,0 5625,1 5664,0 5687,1 5721,0 5754,1 5822,0 5852,1 5938,0 6025,1 6079,0 6148,1 6214,0 6246,1 6308,0 6315,1 6355,0 6451,1 6459,0 6461,1 6516,0 6596,1 6643,0 6679,1 6775,0 6793,1 6829,0 6835,1 6914,0 6923,1 6944,0 7044,1 7067,0 7159,1 7210,0 7289,1 7298,0 7332,1 7403,0 7484,1 7559,0 7592,1 7631,0 7669,1 7700,0 7761,1 7772,0 7829,1 7845,0 7917,1 8015,0 8021,1 8103,0 8199,1 8254,0 8317,1 8401,0 8483,1 8561,0 8658,1 8699,0 8739,1 8777,0 8863,1 8915,0 8982,1 8988,0 9081,1 9120,0 9142,1 9223,0 9256,1 9302,0 9371,1 9374,0 9463,1 9467,0 9474,1 9479,0 9546,1 9627,0 9704,1 9733,0 9815,1 9823,0 9910,1 9985,0 10004,1 10054,0 10113,1 10166,0 10177,1 10199,0 10289,1 10356,0 10403,1 10469,0 10559,1 10592,0 10648,1 10723,0 10763,1 10816,0 10871,1 10924,0 10926,1 11025,0 11042,1 11142,0 11208,1 11305,0 11330,1 11380,0 11381,1 11393,0 11450,1 11463,0 11541,1 11614,0 11618,1 11634,0 11662,1 11722,0 11725,1 11741,0 11777,1 11800,0 11860,1 11898,0 11947,1 12041,0 12092,1 12111,0 12188,1 12273,0 12332,1 12393,0 12475,1 12533,0 12618,1 12699,0 12706,1 12749,0 12807,1 12901,0 12912,1 12926,0 13000,1 13040,0 13091,1 13172,0 13240,1 13276,0 13297,1 13347,0 13416,1 13473,0 13477,1 13498,0 13529,1 13586,0 13607,1 13703,0 13716,1 13741,0 13786,1 13868,0 13874,1 13885,0 13960,1 14010,0 14070,1 14072,0 14162,1 14181,0 14217,1 14222,0 14315,1 14406,0 14456,1 14471,0 14537,1 14547,0 14634,1 14686,0 14727,1 14748,0 14799,1 14847,0 14902,1 14941,0 14971,1 15005,0 15084,1 15128,0 15167,1 15234,0 15244,1 15277,0 15285,1 15340,0 15424,1 15439,0 15508,1 15550,0 15648,1 15698,0 15708,1 15749,0 15835,1 15923,0 15929,1 15999,0 16057,1 16149,0 16192,1 16215,0 16253,1 16338,0 16339,1 16438,0 16464,1 16500,0 16505,1 16509,0 16534,1 16632,0 16635,1 16647,0 16669,1 16702,0 16755,1 16770,0 16820,1 16914,0 16925,1 16979,0 17014,1 17022,0 17079,1 17091,0 17166,1 17218,0 17247,1 17336,0 17411,1 17417,0 17480,1 17496,0 17596,1 17683,0 17698,1 17703,0 17754,1 17793,0 17801,1 17896,0 17988,1 18058,0 18085,1 18153,0 18160,1 18174,0 18196,1 18197,0 18289,1 18317,0 18407,1 18495,0 18538,1 18563,0 18623,1 18661,0 18736,1 18771,0 18776,1 18832,0 18911,1 18931,0 18999,1 19078,0 19081,1 19172,0 19192,1 19221,0 19256,1 19345,0 19346,1 19443,0 19525,1 19552,0 19597,1 19627,0 19688,1 19717,0 19750,1 19809,0 19838,1 19902,0 19915,1 19965,0 20053,1 20125,0 20218,1 20260,0 20327,1 20332,0 20420,1 20447,0 20541,1 20568,0 20650,1 20714,0 20786,1 20801,0 20844,1 20886,0 20901,1 20974,0 21052,1 21144,0 21205,1 21237,0 21264,1 21265,0 21364,1 21398,0 21466,1 21548,0 21593,1 21610,0 21708,1 21731,0 21793,1 21846,0 21891,1 21918,0 21952,1 21983,0 22017,1 22019,0 22042,1 22137,0 22178,1 22220,0 22225,1 22265,0 22293,1 22341,0 22405,1 22495,0 22552,1 22638,0 22733,1 22825,0 22924,1 22946,0 22954,1 22985,0 23025,1 23066,0 23099,1 23146,0 23195,1 23221,0 23273,1 23339,0 23381,1 23463,0 23506,1 23507,0 23579,1 23605,0 23606,1 23615,0 23684,1 23748,0 23758,1 23821,0 23848,1 23925,0 24012,1 24031,0 24122,1 24123,0 24169,1 24211,0 24231,1 24291,0 24352,1 24365,0 24398,1 24481,0 24564,1 24658,0 24704,1 24739,0 24766,1 24849,0 24865,1 24932,0 24960,1 25056,0 25106,1 25192,0 25216,1 25244,0 25305,1 25318,0 25416,1 25443,0 25493,1 25556,0 25622,1 25642,0 25702,1 25777,0 25875,1 25913,0 25971,1 25989,0 26017,1 26073,0 26158,1 26217,0 26267,1 26289,0 26388,1 26435,0 26531,1 26619,0 26689,1 26729,0 26750,1 26752,0 26754,1 26789,0 26800,1 26833,0 26851,1 26855,0 26944,1 27035,0 27123,1 27208,0 27295,1 27323,0 27392,1 27404,0 27461,1 27547,0 27563,1 27564,0 27608,1 27630,0 27681,1 27683,0 27743,1 27765,0 27777,1 27874,0 27950,1 27989,0 28073,1 28122,0 28203,1 28286,0 28385,1 28403,0 28447,1 28540,0 28634,1 28709,0 28794,1 28876,0 28959,1 29057,0 29075,1 29167,0 29193,1 29240,0 29317,1 29398,0 29463,1 29560,0 29650,1 29663,0 29755,1 29799,0 29805,1 29832,0 29854,1 29879,0 29916,1 30009,0 30031,1 30106,0 30180,1 30259,0 30283,1 30304,0 30345,1 30363,0 30370,1 30395,0 30442,1 30526,0 30618,1 30639,0 30716,1 30814,0 30855,1 30917,0 30968,1 31048,0 31076,1 31099,0 31117,1 31146,0 31205,1 31292,0 31365,1 31454,0 31496,1 31592,0 31646,1 31692,0 31774,1 31812,0 31859,1 31941,0 31963,1 31984,0 31990,1 32026,0 32073,1 32115,0 32152,1 32159,0 32235,1 32259,0 32299,1 32341,0 32432,1 32443,0 32479,1 32559,0 32618,1 32694,0 32780,1 32855,0 32858,1 32863,0 32922,1 32977,0 33047,1 33106,0 33146,1 33186,0 33230,1 33279,0 33340,1 33367,0 33449,1 33511,0 33519,1 33566,0 33617,1 33695,0 33766,1 33866,0 33961,1 34024,0 34072,1 34153,0 34161,1 34260,0 34305,1 34348,0 34432,1 34494,0 34545,1 34625,0 34694,1 34699,0 34722,1 34741,0 34764,1 34846,0 34928,1 35016,0 35076,1 35114,0 35123,1 35180,0 35272,1 35305,0 35353,1 35365,0 35446,1 35467,0 35499,1 35535,0 35565,1 35585,0 35630,1 35670,0 35709,1 35782,0 35851,1 35867,0 35906,1 35924,0 35987,1 36049,0 36073,1 36084,0 36108,1 36175,0 36192,1 36291,0 36344,1 36404,0 36448,1 36458,0 36554,1 36568,0 36590,1 36657,0 36703,1 36715,0 36781,1 36786,0 36882,1 36926,0 36929,1 37016,0 37041,1 37140,0 37164,1 37227,0 37290,1 37291,0 37348,1 37365,0 37377,1 37379,0 37449,1 37471,0 37568,1 37665,0 37745,1 37795,0 37838,1 37930,0 37933,1 38021,0 38027,1 38125,0 38207,1 38250,0 38261,1 38303,0 38345,1 38361,0 38378,1 38397,0 38426,1 38482,0 38488,1 38515,0 38562,1 38599,0 38669,1 38685,0 38748,1 38818,0 38906,1 38971,0 39056,1 39139,0 39152,1 39189,0 39208,1 39241,0 39292,1 39344,0 39412,1 39501,0 39531,1 39581,0 39594,1 39610,0 39660,1 39744,0 39809,1 39856,0 39884,1 39951,0 40015,1 40074,0 40081,1 40083,0 40091,1 40092,0 40094,1 40107,0 40125,1 40225,0 40315,1 40348,0 40403,1 40428,0 40505,1 40533,0 40632,1 40671,0 40673,1 40704,0 40773,1 40846,0 40925,1 40934,0 40980,1 41021,0 41061,1 41161,0 41178,1 41218,0 41316,1 41354,0 41444,1 41447,0 41507,1 41585,0 41647,1 41671,0 41732,1 41816,0 41880,1 41906,0 41945,1 42027,0 42057,1 42086,0 42096,1 42114,0 42214,1 42222,0 42246,1 42342,0 42346,1 42382,0 42444,1 42530,0 42628,1 42658,0 42705,1 42720,0 42801,1 42878,0 42882,1 42970,0 43056,1 43117,0 43139,1 43177,0 43259,1 43358,0 43380,1 43402,0 43423,1 43432,0 43483,1 43554,0 43627,1 43681,0 43753,1 43766,0 43838,1 43901,0 43949,1 44007,0 44065,1 44135,0 44181,1 44196,0 44230,1 44232,0 44249,1 44268,0 44286,1 44348,0 44407,1 44444,0 44488,1 44550,0 44574,1 44664,0 44758,1 44784,0 44831,1 44903,0 44994,1 45008,0 45020,1 45102,0 45133,1 45223,0 45289,1 45325,0 45388,1 45454,0 45529,1 45535,0 45548,1 45618,0 45697,1 45725,0 45794,1 45859,0 45951,1 46006,0 46014,1 46067,0 46129,1 46174,0 46246,1 46278,0 46294,1 46349,0 46378,1 46420,0 46489,1 46523,0 46528,1 46557,0 46566,1 46623,0 46624,1 46694,0 46774,1 46828,0 46894,1 46952,0 47009,1 47069,0 47076,1 47087,0 47088,1 47182,0 47213,1 47304,0 47323,1 47351,0 47442,1 47520,0 47616,1 47705,0 47741,1 47771,0 47821,1 47915,0 47960,1 48029,0 48128,1 48192,0 48273,1 48278,0 48343,1 48344,0 48368,1 48383,0 48401,1 48406,0 48424,1 48433,0 48483,1 48571,0 48655,1 48716,0 48729,1 48817,0 48883,1 48911,0 48990,1 48992,0 49067,1 49074,0 49121,1 49186,0 49277,1 49321,0 49382,1 end initlist b19 0,0 27,1 105,0 107,1 120,0 136,1 163,0 216,1 246,0 320,1 374,0 412,1 477,0 565,1 589,0 652,1 735,0 775,1 875,0 952,1 990,0 1022,1 1035,0 1129,1 1228,0 1240,1 1286,0 1292,1 1374,0 1452,1 1507,0 1585,1 1674,0 1768,1 1820,0 1841,1 1896,0 1988,1 2040,0 2095,1 2172,0 2225,1 2302,0 2370,1 2408,0 2477,1 2521,0 2611,1 2704,0 2748,1 2758,0 2788,1 2820,0 2871,1 2874,0 2893,1 2989,0 3062,1 3100,0 3146,1 3183,0 3249,1 3314,0 3410,1 3499,0 3503,1 3521,0 3567,1 3586,0 3612,1 3632,0 3669,1 3723,0 3802,1 3902,0 3948,1 4021,0 4058,1 4145,0 4170,1 4248,0 4274,1 4289,0 4302,1 4401,0 4413,1 4456,0 4526,1 4620,0 4715,1 4729,0 4829,1 4892,0 4902,1 4986,0 5048,1 5142,0 5169,1 5231,0 5239,1 5292,0 5368,1 5387,0 5447,1 5485,0 5559,1 5636,0 5680,1 5681,0 5756,1 5833,0 5861,1 5882,0 5967,1 6063,0 6144,1 6190,0 6263,1 6280,0 6286,1 6372,0 6472,1 6473,0 6560,1 6654,0 6732,1 6816,0 6849,1 6903,0 6985,1 7016,0 7087,1 7123,0 7184,1 7253,0 7320,1 7368,0 7420,1 7440,0 7481,1 7538,0 7628,1 7662,0 7682,1 7710,0 7807,1 7899,0 7970,1 8018,0 8036,1 8111,0 8148,1 8203,0 8251,1 8284,0 8288,1 8352,0 8405,1 8485,0 8540,1 8580,0 8633,1 8666,0 8730,1 8814,0 8903,1 8943,0 8991,1 9051,0 9137,1 9180,0 9210,1 9290,0 9346,1 9359,0 9405,1 9438,0 9512,1 9597,0 9652,1 9702,0 9802,1 9842,0 9849,1 9895,0 9949,1 10009,0 10023,1 10066,0 10161,1 10209,0 10307,1 10322,0 10333,1 10387,0 10453,1 10473,0 10512,1 10533,0 10598,1 10678,0 10757,1 10840,0 10929,1 10972,0 10980,1 11042,0 11053,1 11077,0 11122,1 11141,0 11215,1 11289,0 11358,1 11454,0 11528,1 11531,0 11559,1 11612,0 11626,1 11659,0 11751,1 11830,0 11838,1 11911,0 11978,1 12029,0 12033,1 12109,0 12150,1 12235,0 12325,1 12344,0 12433,1 12498,0 12572,1 12644,0 12699,1 12744,0 12784,1 12818,0 12918,1 12936,0 12943,1 13021,0 13034,1 13037,0 13056,1 13099,0 13191,1 13267,0 13326,1 13398,0 13441,1 13473,0 13568,1 13615,0 13631,1 13692,0 13789,1 13858,0 13953,1 13968,0 13977,1 13999,0 14051,1 14092,0 14164,1 14171,0 14222,1 14298,0 14320,1 14370,0 14422,1 14477,0 14489,1 14496,0 14573,1 14660,0 14713,1 14726,0 14759,1 14826,0 14900,1 14906,0 14928,1 14946,0 14978,1 15058,0 15092,1 15175,0 15195,1 15290,0 15389,1 15414,0 15449,1 15461,0 15533,1 15601,0 15689,1 15728,0 15796,1 15817,0 15882,1 15973,0 16040,1 16047,0 16058,1 16155,0 16254,1 16314,0 16367,1 16430,0 16455,1 16523,0 16533,1 16595,0 16679,1 16756,0 16851,1 16926,0 16973,1 17053,0 17068,1 17168,0 17180,1 17216,0 17302,1 17374,0 17472,1 17536,0 17627,1 17716,0 17755,1 17769,0 17811,1 17911,0 18011,1 18078,0 18129,1 18204,0 18231,1 18242,0 18335,1 18355,0 18444,1 18517,0 18616,1 18711,0 18763,1 18856,0 18865,1 18955,0 19012,1 19063,0 19071,1 19149,0 19174,1 19229,0 19303,1 19354,0 19417,1 19419,0 19496,1 19574,0 19579,1 19611,0 19661,1 19670,0 19685,1 19727,0 19819,1 19831,0 19878,1 19913,0 19920,1 19993,0 20013,1 20043,0 20087,1 20122,0 20159,1 20161,0 20208,1 20242,0 20295,1 20320,0 20414,1 20449,0 20519,1 20520,0 20581,1 20588,0 20619,1 20704,0 20716,1 20738,0 20762,1 20855,0 20907,1 20925,0 21025,1 21027,0 21110,1 21181,0 21272,1 21295,0 21338,1 21389,0 21447,1 21499,0 21515,1 21518,0 21565,1 21599,0 21621,1 21713,0 21774,1 21800,0 21811,1 21897,0 21933,1 21970,0 21994,1 22065,0 22151,1 22205,0 22289,1 22311,0 22399,1 22412,0 22454,1 22494,0 22559,1 22581,0 22654,1 22660,0 22726,1 22824,0 22880,1 22902,0 22922,1 23006,0 23088,1 23122,0 23148,1 23196,0 23230,1 23285,0 23371,1 23426,0 23515,1 23533,0 23557,1 23614,0 23696,1 23752,0 23786,1 23866,0 23893,1 23983,0 23984,1 24064,0 24144,1 24211,0 24258,1 24332,0 24420,1 24479,0 24533,1 24542,0 24627,1 24707,0 24782,1 24862,0 24899,1 24963,0 25046,1 25054,0 25070,1 25154,0 25157,1 25208,0 25301,1 25386,0 25486,1 25552,0 25594,1 25666,0 25721,1 25809,0 25878,1 25935,0 26001,1 26088,0 26154,1 26158,0 26242,1 26249,0 26310,1 26313,0 26348,1 26415,0 26488,1 26545,0 26634,1 26675,0 26748,1 26773,0 26827,1 26869,0 26904,1 26978,0 27001,1 27064,0 27089,1 27154,0 27158,1 27178,0 27179,1 27182,0 27240,1 27306,0 27347,1 27364,0 27398,1 27487,0 27561,1 27578,0 27582,1 27665,0 27690,1 27780,0 27859,1 27906,0 27974,1 27987,0 27990,1 28045,0 28094,1 28100,0 28142,1 28192,0 28274,1 28323,0 28340,1 28437,0 28476,1 28530,0 28573,1 28638,0 28701,1 28781,0 28871,1 28877,0 28888,1 28954,0 29012,1 29027,0 29046,1 29096,0 29179,1 29278,0 29327,1 29374,0 29442,1 29470,0 29539,1 29605,0 29692,1 29693,0 29792,1 29814,0 29817,1 29906,0 29934,1 30001,0 30018,1 30102,0 30104,1 30127,0 30171,1 30198,0 30221,1 30235,0 30287,1 30316,0 30403,1 30471,0 30484,1 30486,0 30491,1 30554,0 30564,1 30623,0 30673,1 30733,0 30816,1 30913,0 30970,1 31060,0 31083,1 31142,0 31179,1 31223,0 31234,1 31245,0 31310,1 31357,0 31426,1 31450,0 31524,1 31533,0 31627,1 31631,0 31689,1 31724,0 31783,1 31824,0 31857,1 31864,0 31883,1 31970,0 32053,1 32083,0 32117,1 32161,0 32202,1 32225,0 32239,1 32330,0 32393,1 32445,0 32512,1 32587,0 32596,1 32637,0 32693,1 32775,0 32784,1 32792,0 32862,1 32896,0 32929,1 32998,0 33032,1 33047,0 33131,1 33213,0 33230,1 33306,0 33370,1 33456,0 33488,1 33506,0 33605,1 33670,0 33677,1 33701,0 33757,1 33831,0 33880,1 33889,0 33912,1 33934,0 33973,1 34013,0 34044,1 34133,0 34163,1 34203,0 34300,1 34339,0 34388,1 34477,0 34493,1 34558,0 34604,1 34646,0 34671,1 34674,0 34714,1 34783,0 34833,1 34933,0 34967,1 34994,0 35056,1 35060,0 35072,1 35137,0 35149,1 35235,0 35310,1 35368,0 35443,1 35465,0 35558,1 35582,0 35660,1 35737,0 35783,1 35832,0 35869,1 35928,0 35966,1 36032,0 36038,1 36061,0 36152,1 36184,0 36229,1 36235,0 36317,1 36329,0 36429,1 36482,0 36577,1 36597,0 36682,1 36697,0 36793,1 36881,0 36925,1 36979,0 37038,1 37102,0 37142,1 37187,0 37200,1 37218,0 37285,1 37378,0 37422,1 37506,0 37563,1 37598,0 37682,1 37749,0 37791,1 37802,0 37846,1 37942,0 38038,1 38055,0 38070,1 38116,0 38167,1 38222,0 38256,1 38285,0 38339,1 38408,0 38478,1 38493,0 38576,1 38604,0 38654,1 38681,0 38723,1 38733,0 38825,1 38859,0 38941,1 38945,0 38974,1 38988,0 38994,1 39068,0 39120,1 39180,0 39246,1 39341,0 39411,1 39474,0 39495,1 39587,0 39598,1 39634,0 39675,1 39740,0 39787,1 39864,0 39938,1 39966,0 39991,1 40057,0 40064,1 40120,0 40170,1 40204,0 40224,1 40323,0 40352,1 40368,0 40461,1 40472,0 40567,1 40585,0 40639,1 40708,0 40779,1 40873,0 40966,1 40984,0 40988,1 41024,0 41103,1 41140,0 41224,1 41299,0 41392,1 41404,0 41444,1 41457,0 41492,1 41502,0 41525,1 41578,0 41605,1 41664,0 41674,1 41690,0 41756,1 41774,0 41796,1 41803,0 41819,1 41824,0 41908,1 41999,0 42041,1 42077,0 42146,1 42177,0 42204,1 42254,0 42334,1 42426,0 42453,1 42531,0 42558,1 42632,0 42697,1 42748,0 42774,1 42833,0 42894,1 42952,0 43040,1 43055,0 43109,1 43132,0 43230,1 43299,0 43367,1 43409,0 43480,1 43503,0 43581,1 43672,0 43701,1 43796,0 43831,1 43921,0 43967,1 44015,0 44106,1 44174,0 44222,1 44223,0 44240,1 44280,0 44288,1 44379,0 44410,1 44426,0 44453,1 44468,0 44545,1 44630,0 44708,1 44761,0 44858,1 44881,0 44970,1 44981,0 45056,1 45145,0 45217,1 45303,0 45317,1 45338,0 45372,1 45465,0 45488,1 45507,0 45554,1 45618,0 45624,1 45625,0 45672,1 45748,0 45803,1 45885,0 45952,1 45979,0 45997,1 46094,0 46137,1 46228,0 46282,1 46319,0 46379,1 46387,0 46432,1 46491,0 46517,1 46528,0 46589,1 46663,0 46699,1 46769,0 46833,1 46921,0 46955,1 46981,0 47003,1 47094,0 47159,1 47198,0 47286,1 47295,0 47365,1 47408,0 47482,1 47515,0 47585,1 47663,0 47733,1 47745,0 47765,1 47856,0 47940,1 47960,0 48027,1 48061,0 48140,1 48172,0 48179,1 48224,0 48246,1 48343,0 48426,1 48522,0 48537,1 48568,0 48665,1 48745,0 48772,1 48841,0 48887,1 48967,0 49053,1 49079,0 49159,1 49213,0 49283,1 49366,0 49427,1 49473,0 49552,1 49563,0 49652,1 49671,0 49694,1 49740,0 49793,1 49813,0 49877,1 49901,0 49938,1 49968,0 50026,1 50126,0 50195,1 50239,0 50273,1 50277,0 50279,1 50364,0 50430,1 50482,0 50505,1 50544,0 50587,1 50624,0 50646,1 50745,0 50795,1 50882,0 50953,1 end initlist b20 0,0 6,1 42,0 107,1 116,0 167,1 231,0 276,1 303,0 310,1 385,0 412,1 424,0 514,1 614,0 684,1 777,0 793,1 837,0 889,1 948,0 966,1 967,0 986,1 1039,0 1052,1 1151,0 1166,1 1246,0 1326,1 1365,0 1379,1 1412,0 1449,1 1497,0 1597,1 1663,0 1674,1 1756,0 1757,1 1853,0 1901,1 1905,0 1968,1 2037,0 2124,1 2146,0 2153,1 2175,0 2189,1 2191,0 2244,1 2255,0 2286,1 2319,0 2332,1 2418,0 2445,1 2458,0 2556,1 2590,0 2669,1 2682,0 2688,1 2732,0 2829,1 2910,0 2914,1 3005,0 3028,1 3039,0 3083,1 3166,0 3231,1 3232,0 3298,1 3355,0 3446,1 3533,0 3566,1 3576,0 3647,1 3660,0 3727,1 3798,0 3873,1 3929,0 3947,1 3977,0 4006,1 4040,0 4070,1 4133,0 4210,1 4286,0 4379,1 4413,0 4496,1 4557,0 4641,1 4675,0 4747,1 4834,0 4906,1 4950,0 5002,1 5091,0 5142,1 5227,0 5247,1 5333,0 5406,1 5441,0 5535,1 5576,0 5626,1 5668,0 5734,1 5746,0 5820,1 5877,0 5940,1 6021,0 6044,1 6091,0 6177,1 6244,0 6255,1 6347,0 6358,1 6366,0 6463,1 6504,0 6535,1 6561,0 6594,1 6668,0 6745,1 6767,0 6804,1 6893,0 6902,1 6915,0 6990,1 7003,0 7061,1 7123,0 7200,1 7275,0 7306,1 7400,0 7494,1 7588,0 7644,1 7723,0 7727,1 7741,0 7758,1 7776,0 7851,1 7940,0 8038,1 8064,0 8092,1 8093,0 8191,1 8258,0 8282,1 8288,0 8310,1 8322,0 8391,1 8463,0 8519,1 8545,0 8644,1 8696,0 8717,1 8736,0 8762,1 8772,0 8781,1 8834,0 8848,1 8911,0 8995,1 8997,0 9073,1 9157,0 9220,1 9253,0 9309,1 9368,0 9427,1 9449,0 9493,1 9591,0 9599,1 9652,0 9717,1 9811,0 9836,1 9837,0 9925,1 9995,0 10091,1 10142,0 10189,1 10257,0 10341,1 10350,0 10426,1 10477,0 10499,1 10548,0 10588,1 10598,0 10646,1 10720,0 10778,1 10840,0 10868,1 10893,0 10912,1 10991,0 10994,1 11081,0 11178,1 11199,0 11243,1 11317,0 11399,1 11402,0 11471,1 11474,0 11476,1 11558,0 11608,1 11676,0 11741,1 11790,0 11858,1 11932,0 11998,1 12025,0 12028,1 12044,0 12084,1 12151,0 12182,1 12256,0 12299,1 12329,0 12387,1 12452,0 12513,1 12526,0 12573,1 12577,0 12675,1 12763,0 12793,1 12840,0 12901,1 12965,0 13021,1 13104,0 13202,1 13230,0 13231,1 13271,0 13349,1 13426,0 13468,1 13502,0 13560,1 13649,0 13651,1 13710,0 13732,1 13753,0 13821,1 13822,0 13862,1 13944,0 13970,1 13972,0 14071,1 14115,0 14143,1 14157,0 14200,1 14227,0 14247,1 14309,0 14331,1 14382,0 14425,1 14444,0 14508,1 14590,0 14637,1 14659,0 14669,1 14767,0 14836,1 14845,0 14920,1 15008,0 15047,1 15113,0 15173,1 15180,0 15272,1 15312,0 15340,1 15396,0 15413,1 15497,0 15576,1 15647,0 15682,1 15696,0 15708,1 15772,0 15844,1 15905,0 15963,1 15983,0 16043,1 16136,0 16189,1 16209,0 16295,1 16318,0 16341,1 16393,0 16394,1 16484,0 16522,1 16613,0 16651,1 16715,0 16728,1 16828,0 16928,1 17021,0 17117,1 17137,0 17205,1 17257,0 17279,1 17288,0 17323,1 17336,0 17348,1 17430,0 17444,1 17532,0 17622,1 17687,0 17764,1 17827,0 17873,1 17918,0 17985,1 18019,0 18064,1 18113,0 18198,1 18205,0 18274,1 18356,0 18367,1 18441,0 18521,1 18575,0 18657,1 18664,0 18756,1 18806,0 18812,1 18853,0 18939,1 18973,0 18998,1 19013,0 19020,1 19092,0 19187,1 19251,0 19343,1 19381,0 19456,1 19527,0 19592,1 19626,0 19708,1 19726,0 19753,1 19763,0 19793,1 19824,0 19832,1 19925,0 19946,1 19970,0 20025,1 20043,0 20129,1 20196,0 20258,1 20309,0 20348,1 20395,0 20475,1 20516,0 20589,1 20657,0 20734,1 20798,0 20835,1 20877,0 20914,1 21004,0 21052,1 21077,0 21166,1 21219,0 21239,1 21306,0 21382,1 21424,0 21503,1 21583,0 21669,1 21697,0 21790,1 21843,0 21866,1 21872,0 21907,1 22000,0 22100,1 22187,0 22238,1 22242,0 22329,1 22380,0 22461,1 22489,0 22560,1 22606,0 22662,1 22741,0 22742,1 22815,0 22832,1 22854,0 22861,1 22864,0 22925,1 22936,0 22959,1 23053,0 23094,1 23161,0 23175,1 23187,0 23195,1 23265,0 23309,1 23360,0 23443,1 23531,0 23612,1 23658,0 23707,1 23736,0 23766,1 23789,0 23840,1 23843,0 23938,1 24004,0 24101,1 24196,0 24289,1 24349,0 24424,1 24469,0 24555,1 24584,0 24624,1 24633,0 24700,1 24737,0 24767,1 24804,0 24832,1 24868,0 24911,1 24928,0 25011,1 25110,0 25139,1 25143,0 25152,1 25166,0 25173,1 25243,0 25303,1 25319,0 25381,1 25384,0 25464,1 25488,0 25525,1 25572,0 25623,1 25654,0 25690,1 25786,0 25858,1 25915,0 25952,1 26026,0 26077,1 26101,0 26161,1 26215,0 26270,1 26293,0 26383,1 26454,0 26490,1 26491,0 26545,1 26598,0 26644,1 26727,0 26798,1 26831,0 26917,1 26978,0 27022,1 27091,0 27187,1 27218,0 27312,1 27394,0 27446,1 27522,0 27553,1 27562,0 27564,1 27664,0 27715,1 27814,0 27833,1 27912,0 27970,1 28048,0 28074,1 28167,0 28195,1 28258,0 28349,1 28388,0 28423,1 28453,0 28518,1 28586,0 28640,1 28641,0 28659,1 28738,0 28823,1 28843,0 28884,1 28971,0 28981,1 29000,0 29094,1 29156,0 29248,1 29342,0 29402,1 29490,0 29581,1 29586,0 29588,1 29652,0 29673,1 29766,0 29780,1 29832,0 29907,1 29939,0 30027,1 30074,0 30146,1 30243,0 30311,1 30377,0 30472,1 30510,0 30565,1 30575,0 30588,1 30649,0 30731,1 30732,0 30773,1 30873,0 30964,1 30980,0 31069,1 31133,0 31160,1 31233,0 31285,1 31374,0 31454,1 31531,0 31622,1 31638,0 31664,1 31737,0 31817,1 31902,0 31919,1 31991,0 32082,1 32147,0 32188,1 32200,0 32212,1 32298,0 32392,1 32480,0 32500,1 32520,0 32584,1 32619,0 32636,1 32706,0 32747,1 32825,0 32886,1 32979,0 33071,1 33120,0 33136,1 33137,0 33222,1 33245,0 33330,1 33397,0 33404,1 33411,0 33422,1 33436,0 33448,1 33471,0 33533,1 33570,0 33639,1 33722,0 33732,1 33772,0 33849,1 33876,0 33938,1 33989,0 34058,1 34158,0 34170,1 34206,0 34215,1 34278,0 34366,1 34424,0 34471,1 34521,0 34549,1 34568,0 34639,1 34658,0 34695,1 34714,0 34723,1 34801,0 34875,1 34975,0 35063,1 35130,0 35227,1 35286,0 35373,1 35473,0 35561,1 35588,0 35645,1 35699,0 35798,1 35849,0 35906,1 35975,0 36056,1 36097,0 36170,1 36268,0 36333,1 36338,0 36382,1 36454,0 36553,1 36601,0 36625,1 36700,0 36790,1 36887,0 36950,1 36969,0 36994,1 37075,0 37140,1 37152,0 37210,1 37234,0 37331,1 37408,0 37413,1 37466,0 37474,1 37525,0 37536,1 37591,0 37632,1 37671,0 37684,1 37708,0 37804,1 37868,0 37888,1 37896,0 37938,1 37995,0 38085,1 38108,0 38156,1 38158,0 38160,1 38239,0 38264,1 38353,0 38379,1 38390,0 38431,1 38462,0 38504,1 38591,0 38602,1 38668,0 38707,1 38762,0 38812,1 38856,0 38910,1 38955,0 39005,1 39020,0 39061,1 39161,0 39222,1 39238,0 39263,1 39313,0 39321,1 39335,0 39352,1 39390,0 39468,1 39472,0 39486,1 39510,0 39531,1 39552,0 39634,1 39708,0 39762,1 39841,0 39928,1 39960,0 40032,1 40084,0 40090,1 40120,0 40138,1 40142,0 40238,1 40262,0 40295,1 40340,0 40418,1 40434,0 40456,1 40465,0 40521,1 40612,0 40626,1 40726,0 40762,1 40827,0 40908,1 41001,0 41016,1 41027,0 41089,1 41152,0 41178,1 41271,0 41360,1 41406,0 41454,1 41504,0 41592,1 41633,0 41706,1 41767,0 41817,1 41910,0 41995,1 42015,0 42053,1 42118,0 42125,1 42159,0 42185,1 42281,0 42324,1 42389,0 42471,1 42501,0 42560,1 42576,0 42657,1 42739,0 42815,1 42828,0 42891,1 42936,0 43021,1 43121,0 43195,1 43207,0 43293,1 43361,0 43414,1 43513,0 43543,1 43560,0 43575,1 43596,0 43597,1 43646,0 43688,1 43702,0 43794,1 43881,0 43934,1 43973,0 44051,1 44113,0 44146,1 44200,0 44238,1 44326,0 44389,1 44403,0 44489,1 44557,0 44590,1 44628,0 44718,1 44813,0 44835,1 44865,0 44911,1 45005,0 45088,1 45175,0 45236,1 45297,0 45357,1 45406,0 45451,1 45456,0 45508,1 45551,0 45600,1 45664,0 45681,1 45770,0 45773,1 45806,0 45883,1 45946,0 46029,1 46074,0 46089,1 46149,0 46201,1 46293,0 46357,1 46400,0 46481,1 46543,0 46610,1 46616,0 46648,1 46655,0 46685,1 46730,0 46795,1 46817,0 46915,1 46918,0 46922,1 46932,0 46989,1 47084,0 47120,1 47185,0 47279,1 47356,0 47411,1 47503,0 47514,1 47578,0 47632,1 47728,0 47766,1 47818,0 47913,1 48002,0 48094,1 48163,0 48199,1 48280,0 48312,1 48338,0 48412,1 48474,0 48488,1 48554,0 48638,1 48720,0 48738,1 48774,0 48829,1 48921,0 48975,1 49071,0 49073,1 49159,0 49170,1 49248,0 49250,1 49283,0 49339,1 49411,0 49493,1 49593,0 49595,1 49687,0 49709,1 49712,0 49776,1 49816,0 49824,1 49921,0 49928,1 49986,0 49989,1 50041,0 50081,1 50112,0 50189,1 50208,0 50239,1 50334,0 50386,1 50414,0 50434,1 50527,0 50586,1 50666,0 50719,1 50804,0 50831,1 end initlist b21 0,0 39,1 42,0 125,1 190,0 255,1 317,0 408,1 499,0 565,1 636,0 728,1 815,0 897,1 950,0 964,1 965,0 1030,1 1056,0 1082,1 1182,0 1257,1 1296,0 1341,1 1384,0 1392,1 1453,0 1469,1 1474,0 1509,1 1553,0 1601,1 1606,0 1627,1 1722,0 1790,1 1881,0 1967,1 1993,0 2076,1 2116,0 2204,1 2284,0 2287,1 2346,0 2399,1 2408,0 2499,1 2567,0 2586,1 2600,0 2617,1 2655,0 2726,1 2770,0 2859,1 2930,0 2994,1 3002,0 3096,1 3172,0 3214,1 3248,0 3289,1 3317,0 3352,1 3378,0 3407,1 3446,0 3512,1 3594,0 3668,1 3697,0 3737,1 3785,0 3792,1 3793,0 3879,1 3918,0 3970,1 4039,0 4118,1 4218,0 4235,1 4272,0 4322,1 4396,0 4446,1 4455,0 4478,1 4566,0 4644,1 4698,0 4771,1 4836,0 4914,1 4938,0 4974,1 5043,0 5136,1 5143,0 5223,1 5296,0 5356,1 5386,0 5477,1 5501,0 5544,1 5613,0 5696,1 5763,0 5771,1 5862,0 5911,1 5951,0 5954,1 6042,0 6118,1 6175,0 6225,1 6307,0 6333,1 6374,0 6403,1 6491,0 6537,1 6587,0 6641,1 6665,0 6672,1 6688,0 6752,1 6768,0 6792,1 6834,0 6919,1 6949,0 6970,1 7004,0 7094,1 7115,0 7156,1 7218,0 7249,1 7326,0 7391,1 7472,0 7500,1 7514,0 7555,1 7557,0 7605,1 7616,0 7685,1 7704,0 7714,1 7804,0 7811,1 7826,0 7884,1 7906,0 7933,1 7996,0 8006,1 8047,0 8049,1 8056,0 8125,1 8126,0 8224,1 8284,0 8321,1 8354,0 8420,1 8429,0 8494,1 8569,0 8611,1 8671,0 8754,1 8764,0 8810,1 8844,0 8919,1 8976,0 8985,1 9002,0 9048,1 9077,0 9173,1 9241,0 9328,1 9410,0 9424,1 9517,0 9526,1 9547,0 9647,1 9666,0 9730,1 9788,0 9819,1 9909,0 9941,1 9996,0 10090,1 10119,0 10191,1 10258,0 10284,1 10319,0 10373,1 10454,0 10540,1 10579,0 10607,1 10687,0 10781,1 10785,0 10868,1 10876,0 10903,1 10931,0 10971,1 11012,0 11018,1 11028,0 11055,1 11148,0 11152,1 11206,0 11302,1 11400,0 11486,1 11565,0 11642,1 11690,0 11745,1 11830,0 11902,1 11914,0 11929,1 12012,0 12037,1 12076,0 12080,1 12135,0 12200,1 12297,0 12355,1 12424,0 12441,1 12478,0 12537,1 12611,0 12628,1 12688,0 12706,1 12773,0 12842,1 12845,0 12940,1 13016,0 13048,1 13078,0 13154,1 13218,0 13313,1 13390,0 13435,1 13470,0 13499,1 13557,0 13626,1 13653,0 13736,1 13827,0 13876,1 13955,0 14012,1 14073,0 14111,1 14190,0 14218,1 14307,0 14380,1 14443,0 14540,1 14601,0 14632,1 14683,0 14723,1 14772,0 14864,1 14897,0 14915,1 14986,0 14997,1 14998,0 15040,1 15115,0 15158,1 15234,0 15251,1 15332,0 15424,1 15455,0 15521,1 15613,0 15621,1 15639,0 15673,1 15703,0 15760,1 15808,0 15879,1 15931,0 15975,1 16037,0 16054,1 16080,0 16150,1 16208,0 16305,1 16398,0 16477,1 16519,0 16578,1 16627,0 16664,1 16719,0 16819,1 16878,0 16911,1 16943,0 16979,1 17066,0 17076,1 17104,0 17116,1 17206,0 17252,1 17308,0 17406,1 17477,0 17509,1 17521,0 17604,1 17666,0 17688,1 17742,0 17768,1 17842,0 17846,1 17869,0 17872,1 17881,0 17948,1 18039,0 18108,1 18174,0 18187,1 18191,0 18291,1 18321,0 18388,1 18419,0 18435,1 18482,0 18493,1 18501,0 18547,1 18573,0 18576,1 18641,0 18671,1 18709,0 18752,1 18783,0 18827,1 18864,0 18865,1 18917,0 18976,1 19075,0 19108,1 19155,0 19229,1 19326,0 19376,1 19402,0 19449,1 19511,0 19605,1 19612,0 19652,1 19668,0 19713,1 19741,0 19803,1 19888,0 19980,1 20024,0 20107,1 20144,0 20159,1 20190,0 20242,1 20337,0 20364,1 20439,0 20493,1 20578,0 20582,1 20673,0 20735,1 20827,0 20833,1 20902,0 20928,1 20963,0 21056,1 21132,0 21173,1 21221,0 21268,1 21343,0 21371,1 21372,0 21396,1 21417,0 21507,1 21512,0 21571,1 21657,0 21711,1 21725,0 21815,1 21845,0 21940,1 21950,0 21992,1 22048,0 22109,1 22132,0 22183,1 22213,0 22263,1 22279,0 22298,1 22344,0 22361,1 22362,0 22374,1 22416,0 22449,1 22489,0 22558,1 22576,0 22591,1 22684,0 22733,1 22741,0 22744,1 22818,0 22855,1 22929,0 22980,1 23030,0 23129,1 23136,0 23157,1 23252,0 23294,1 23330,0 23341,1 23397,0 23442,1 23466,0 23487,1 23561,0 23608,1 23680,0 23773,1 23798,0 23888,1 23920,0 23925,1 23974,0 24016,1 24102,0 24164,1 24250,0 24267,1 24300,0 24362,1 24398,0 24432,1 24464,0 24470,1 24527,0 24558,1 24576,0 24618,1 24634,0 24669,1 24748,0 24791,1 24873,0 24912,1 24928,0 25013,1 25036,0 25091,1 25094,0 25109,1 25125,0 25206,1 25272,0 25305,1 25393,0 25486,1 25571,0 25662,1 25722,0 25774,1 25856,0 25949,1 26040,0 26056,1 26140,0 26212,1 26282,0 26342,1 26408,0 26410,1 26460,0 26502,1 26586,0 26591,1 26639,0 26666,1 26756,0 26827,1 26910,0 26956,1 26980,0 26988,1 27004,0 27057,1 27073,0 27133,1 27164,0 27246,1 27342,0 27413,1 27476,0 27504,1 27573,0 27659,1 27755,0 27786,1 27829,0 27878,1 27889,0 27960,1 27963,0 28017,1 28027,0 28072,1 28131,0 28161,1 28188,0 28197,1 28250,0 28280,1 28373,0 28453,1 28475,0 28556,1 28590,0 28606,1 28628,0 28723,1 28801,0 28804,1 28867,0 28956,1 29001,0 29088,1 29147,0 29187,1 29223,0 29271,1 29291,0 29304,1 29359,0 29370,1 29400,0 29498,1 29517,0 29554,1 29628,0 29638,1 29702,0 29783,1 29852,0 29879,1 29941,0 29978,1 29982,0 30050,1 30053,0 30147,1 30192,0 30290,1 30376,0 30390,1 30471,0 30525,1 30598,0 30613,1 30705,0 30798,1 30820,0 30867,1 30883,0 30968,1 31012,0 31098,1 31152,0 31168,1 31223,0 31275,1 31337,0 31382,1 31408,0 31414,1 31439,0 31466,1 31533,0 31587,1 31599,0 31640,1 31658,0 31734,1 31821,0 31905,1 31907,0 31972,1 32031,0 32123,1 32208,0 32223,1 32265,0 32359,1 32405,0 32426,1 32457,0 32557,1 32561,0 32647,1 32699,0 32763,1 32796,0 32804,1 32899,0 32988,1 33013,0 33015,1 33073,0 33139,1 33181,0 33276,1 33370,0 33422,1 33517,0 33529,1 33590,0 33601,1 33656,0 33734,1 33817,0 33883,1 33924,0 33954,1 34030,0 34099,1 34172,0 34197,1 34242,0 34266,1 34283,0 34343,1 34430,0 34498,1 34573,0 34600,1 34601,0 34668,1 34721,0 34731,1 34828,0 34853,1 34875,0 34880,1 34943,0 34981,1 34996,0 35093,1 35114,0 35210,1 35270,0 35280,1 35325,0 35412,1 35416,0 35482,1 35531,0 35558,1 35648,0 35691,1 35721,0 35792,1 35885,0 35902,1 35932,0 36002,1 36007,0 36068,1 36138,0 36226,1 36305,0 36392,1 36471,0 36547,1 36617,0 36709,1 36725,0 36776,1 36862,0 36946,1 36978,0 36984,1 37058,0 37126,1 37213,0 37276,1 37292,0 37360,1 37457,0 37512,1 37599,0 37603,1 37633,0 37693,1 37784,0 37864,1 37902,0 37984,1 38016,0 38018,1 38106,0 38142,1 38205,0 38282,1 38362,0 38402,1 38465,0 38559,1 38602,0 38667,1 38757,0 38857,1 38880,0 38965,1 39031,0 39043,1 39140,0 39161,1 39175,0 39269,1 39336,0 39390,1 39487,0 39498,1 39567,0 39643,1 39691,0 39746,1 39784,0 39875,1 39943,0 40041,1 40113,0 40166,1 40199,0 40201,1 40209,0 40227,1 40289,0 40364,1 40454,0 40456,1 40510,0 40593,1 40656,0 40708,1 40749,0 40759,1 40784,0 40863,1 40895,0 40934,1 40976,0 41046,1 41114,0 41128,1 41156,0 41230,1 41285,0 41352,1 41416,0 41482,1 41506,0 41557,1 41578,0 41667,1 41747,0 41776,1 41800,0 41831,1 41868,0 41873,1 41893,0 41920,1 42013,0 42035,1 42054,0 42084,1 42160,0 42238,1 42296,0 42385,1 42431,0 42492,1 42507,0 42569,1 42667,0 42678,1 42727,0 42811,1 42848,0 42850,1 42949,0 42972,1 43016,0 43038,1 43112,0 43181,1 43193,0 43264,1 43287,0 43315,1 43398,0 43468,1 43490,0 43560,1 43649,0 43671,1 43717,0 43773,1 43785,0 43858,1 43861,0 43885,1 43890,0 43949,1 43992,0 44054,1 44150,0 44230,1 44245,0 44303,1 44388,0 44406,1 44478,0 44569,1 44586,0 44597,1 44686,0 44693,1 44720,0 44768,1 44802,0 44813,1 44893,0 44957,1 44975,0 44994,1 45034,0 45104,1 45163,0 45179,1 45233,0 45303,1 45337,0 45382,1 45384,0 45429,1 45480,0 45559,1 45565,0 45605,1 45653,0 45676,1 45766,0 45836,1 45900,0 45927,1 45955,0 46015,1 46033,0 46068,1 46114,0 46204,1 46294,0 46322,1 46376,0 46389,1 46408,0 46442,1 46482,0 46506,1 46534,0 46592,1 46618,0 46715,1 46766,0 46770,1 46811,0 46888,1 46922,0 47008,1 47071,0 47128,1 47212,0 47282,1 47308,0 47396,1 47459,0 47505,1 47595,0 47609,1 47620,0 47718,1 47786,0 47789,1 47800,0 47875,1 47954,0 48033,1 48116,0 48151,1 48183,0 48186,1 48245,0 48286,1 48331,0 48379,1 48479,0 48515,1 48546,0 48623,1 48710,0 48769,1 48778,0 48834,1 48908,0 48956,1 48996,0 49073,1 49103,0 49194,1 49199,0 49215,1 49227,0 49275,1 49352,0 49421,1 49482,0 49557,1 49635,0 49735,1 49753,0 49765,1 49856,0 49865,1 49870,0 49921,1 49963,0 50016,1 end initlist b22 0,0 1,1 76,0 158,1 176,0 217,1 316,0 351,1 447,0 502,1 509,0 600,1 680,0 695,1 711,0 727,1 782,0 871,1 876,0 955,1 966,0 982,1 1041,0 1107,1 1113,0 1199,1 1203,0 1289,1 1325,0 1376,1 1432,0 1524,1 1563,0 1608,1 1676,0 1709,1 1804,0 1842,1 1938,0 2033,1 2079,0 2127,1 2155,0 2247,1 2295,0 2374,1 2394,0 2479,1 2525,0 2574,1 2599,0 2690,1 2786,0 2791,1 2820,0 2915,1 2986,0 3041,1 3048,0 3109,1 3128,0 3167,1 3199,0 3213,1 3239,0 3330,1 3342,0 3412,1 3468,0 3559,1 3648,0 3684,1 3707,0 3734,1 3745,0 3746,1 3824,0 3900,1 3983,0 4044,1 4119,0 4211,1 4241,0 4290,1 4294,0 4358,1 4378,0 4414,1 4456,0 4504,1 4549,0 4551,1 4623,0 4687,1 4708,0 4769,1 4803,0 4839,1 4926,0 5013,1 5043,0 5141,1 5200,0 5201,1 5230,0 5241,1 5297,0 5316,1 5376,0 5410,1 5467,0 5538,1 5597,0 5648,1 5692,0 5774,1 5800,0 5861,1 5905,0 5969,1 5977,0 6023,1 6097,0 6123,1 6182,0 6189,1 6257,0 6343,1 6361,0 6449,1 6459,0 6493,1 6501,0 6543,1 6565,0 6622,1 6674,0 6712,1 6803,0 6839,1 6930,0 7025,1 7083,0 7092,1 7173,0 7239,1 7331,0 7428,1 7466,0 7504,1 7544,0 7630,1 7671,0 7755,1 7804,0 7852,1 7909,0 7947,1 8035,0 8036,1 8043,0 8048,1 8139,0 8144,1 8161,0 8195,1 8251,0 8335,1 8408,0 8457,1 8553,0 8631,1 8731,0 8788,1 8806,0 8850,1 8892,0 8939,1 8949,0 8981,1 9079,0 9098,1 9190,0 9253,1 9325,0 9326,1 9345,0 9418,1 9478,0 9543,1 9545,0 9554,1 9638,0 9682,1 9689,0 9701,1 9758,0 9807,1 9829,0 9924,1 9946,0 10007,1 10085,0 10099,1 10131,0 10203,1 10233,0 10252,1 10332,0 10401,1 10408,0 10428,1 10448,0 10482,1 10546,0 10630,1 10684,0 10767,1 10858,0 10929,1 10990,0 11037,1 11052,0 11081,1 11140,0 11207,1 11277,0 11283,1 11307,0 11314,1 11338,0 11358,1 11409,0 11460,1 11501,0 11554,1 11607,0 11660,1 11720,0 11800,1 11813,0 11874,1 11924,0 11945,1 12018,0 12036,1 12038,0 12062,1 12110,0 12170,1 12188,0 12259,1 12340,0 12388,1 12453,0 12543,1 12631,0 12701,1 12731,0 12814,1 12912,0 12956,1 13020,0 13034,1 13088,0 13110,1 13111,0 13114,1 13124,0 13153,1 13201,0 13293,1 13337,0 13360,1 13453,0 13519,1 13575,0 13595,1 13644,0 13706,1 13803,0 13805,1 13864,0 13901,1 13983,0 14046,1 14144,0 14176,1 14262,0 14320,1 14380,0 14405,1 14420,0 14444,1 14481,0 14511,1 14514,0 14603,1 14608,0 14634,1 14646,0 14659,1 14733,0 14819,1 14912,0 14949,1 14978,0 15043,1 15142,0 15223,1 15253,0 15335,1 15365,0 15421,1 15481,0 15553,1 15571,0 15653,1 15682,0 15741,1 15825,0 15867,1 15942,0 15981,1 15989,0 16039,1 16047,0 16072,1 16107,0 16148,1 16236,0 16283,1 16346,0 16362,1 16383,0 16466,1 16561,0 16566,1 16663,0 16693,1 16727,0 16760,1 16809,0 16839,1 16884,0 16976,1 16988,0 17080,1 17157,0 17188,1 17215,0 17222,1 17299,0 17396,1 17433,0 17466,1 17496,0 17504,1 17551,0 17573,1 17618,0 17643,1 17680,0 17747,1 17765,0 17841,1 17936,0 18001,1 18014,0 18098,1 18191,0 18258,1 18260,0 18323,1 18378,0 18435,1 18460,0 18555,1 18578,0 18615,1 18670,0 18707,1 18786,0 18852,1 18876,0 18899,1 18996,0 19069,1 19112,0 19125,1 19164,0 19168,1 19204,0 19207,1 19300,0 19323,1 19423,0 19456,1 19504,0 19521,1 19547,0 19596,1 19648,0 19721,1 19744,0 19839,1 19861,0 19880,1 19922,0 19971,1 20039,0 20088,1 20110,0 20192,1 20272,0 20284,1 20316,0 20395,1 20416,0 20512,1 20608,0 20701,1 20747,0 20818,1 20900,0 20937,1 20995,0 21051,1 21071,0 21088,1 21139,0 21146,1 21179,0 21226,1 21258,0 21266,1 21268,0 21304,1 21400,0 21459,1 21537,0 21615,1 21677,0 21761,1 21787,0 21873,1 21880,0 21977,1 22069,0 22088,1 22130,0 22224,1 22285,0 22348,1 22399,0 22423,1 22461,0 22506,1 22552,0 22577,1 22655,0 22737,1 22810,0 22859,1 22889,0 22972,1 23030,0 23103,1 23104,0 23154,1 23213,0 23262,1 23310,0 23394,1 23398,0 23497,1 23582,0 23644,1 23664,0 23714,1 23720,0 23811,1 23827,0 23880,1 23942,0 23991,1 24044,0 24056,1 24119,0 24197,1 24226,0 24251,1 24311,0 24369,1 24387,0 24486,1 24585,0 24685,1 24764,0 24820,1 24869,0 24955,1 25011,0 25026,1 25056,0 25084,1 25122,0 25186,1 25198,0 25207,1 25243,0 25270,1 25327,0 25381,1 25470,0 25538,1 25601,0 25699,1 25741,0 25754,1 25852,0 25931,1 25964,0 26027,1 26033,0 26075,1 26133,0 26167,1 26238,0 26324,1 26407,0 26499,1 26509,0 26543,1 26585,0 26604,1 26608,0 26631,1 26727,0 26778,1 26815,0 26901,1 26941,0 27021,1 27099,0 27145,1 27216,0 27228,1 27280,0 27311,1 27337,0 27403,1 27452,0 27507,1 27542,0 27568,1 27657,0 27667,1 27689,0 27753,1 27766,0 27839,1 27862,0 27955,1 28047,0 28091,1 28182,0 28208,1 28303,0 28359,1 28414,0 28471,1 28528,0 28535,1 28602,0 28682,1 28741,0 28813,1 28840,0 28921,1 28993,0 29088,1 29128,0 29173,1 29205,0 29237,1 29334,0 29338,1 29397,0 29467,1 29559,0 29589,1 29658,0 29729,1 29827,0 29905,1 29932,0 29996,1 30021,0 30048,1 30070,0 30102,1 30174,0 30267,1 30347,0 30373,1 30390,0 30435,1 30485,0 30535,1 30599,0 30686,1 30743,0 30791,1 30792,0 30878,1 30892,0 30923,1 30929,0 30953,1 31052,0 31084,1 31131,0 31160,1 31199,0 31289,1 31341,0 31424,1 31493,0 31536,1 31541,0 31587,1 31650,0 31697,1 31734,0 31739,1 31749,0 31795,1 31844,0 31876,1 31889,0 31956,1 32006,0 32041,1 32061,0 32106,1 32159,0 32206,1 32232,0 32247,1 32307,0 32326,1 32365,0 32390,1 32405,0 32433,1 32445,0 32540,1 32566,0 32645,1 32720,0 32776,1 32816,0 32823,1 32829,0 32897,1 32996,0 33072,1 33078,0 33090,1 33189,0 33222,1 33283,0 33379,1 33394,0 33438,1 33474,0 33535,1 33589,0 33621,1 33687,0 33750,1 33798,0 33814,1 33904,0 33926,1 34003,0 34012,1 34038,0 34085,1 34107,0 34158,1 34174,0 34267,1 34332,0 34416,1 34449,0 34517,1 34536,0 34587,1 34684,0 34713,1 34793,0 34821,1 34865,0 34896,1 34984,0 35039,1 35116,0 35126,1 35174,0 35211,1 35282,0 35297,1 35378,0 35445,1 35484,0 35504,1 35578,0 35675,1 35772,0 35861,1 35887,0 35985,1 36030,0 36094,1 36123,0 36124,1 36210,0 36258,1 36345,0 36378,1 36450,0 36516,1 36527,0 36583,1 36617,0 36689,1 36710,0 36791,1 36845,0 36851,1 36939,0 37009,1 37102,0 37149,1 37164,0 37242,1 37295,0 37322,1 37388,0 37410,1 37471,0 37475,1 37520,0 37613,1 37627,0 37709,1 37761,0 37796,1 37859,0 37871,1 37941,0 37963,1 37975,0 38062,1 38086,0 38113,1 38156,0 38188,1 38235,0 38274,1 38368,0 38381,1 38425,0 38508,1 38532,0 38544,1 38573,0 38575,1 38625,0 38722,1 38822,0 38886,1 38980,0 39001,1 39098,0 39157,1 39205,0 39252,1 39351,0 39399,1 39491,0 39541,1 39566,0 39576,1 39586,0 39646,1 39741,0 39802,1 39850,0 39852,1 39869,0 39901,1 39940,0 39983,1 40031,0 40121,1 40161,0 40169,1 40262,0 40287,1 40369,0 40452,1 40475,0 40506,1 40548,0 40552,1 40565,0 40574,1 40626,0 40639,1 40660,0 40695,1 40744,0 40796,1 40834,0 40859,1 40891,0 40893,1 40954,0 41026,1 41074,0 41094,1 41180,0 41194,1 41268,0 41310,1 41352,0 41441,1 41533,0 41555,1 41641,0 41646,1 41726,0 41755,1 41764,0 41781,1 41811,0 41886,1 41891,0 41895,1 41990,0 42051,1 42057,0 42058,1 42099,0 42138,1 42174,0 42206,1 42263,0 42359,1 42421,0 42483,1 42511,0 42525,1 42588,0 42682,1 42751,0 42776,1 42830,0 42892,1 42898,0 42994,1 43009,0 43023,1 43036,0 43116,1 43147,0 43150,1 43231,0 43255,1 43289,0 43356,1 43370,0 43419,1 43421,0 43462,1 43496,0 43525,1 43543,0 43617,1 43682,0 43728,1 43788,0 43871,1 43924,0 43972,1 43989,0 44022,1 44089,0 44180,1 44255,0 44258,1 44300,0 44366,1 44439,0 44475,1 44482,0 44523,1 44560,0 44587,1 44596,0 44657,1 44700,0 44719,1 44818,0 44891,1 44948,0 45017,1 45072,0 45085,1 45147,0 45233,1 45241,0 45252,1 45338,0 45432,1 45500,0 45528,1 45581,0 45660,1 45734,0 45831,1 45900,0 45902,1 45963,0 45988,1 45990,0 46046,1 46130,0 46174,1 46261,0 46262,1 46292,0 46335,1 46336,0 46415,1 46513,0 46610,1 46626,0 46660,1 46690,0 46758,1 46809,0 46844,1 46861,0 46919,1 46991,0 47075,1 47112,0 47139,1 47167,0 47255,1 47349,0 47362,1 47443,0 47504,1 47543,0 47605,1 47606,0 47623,1 47676,0 47742,1 47826,0 47827,1 47870,0 47919,1 47923,0 47997,1 47999,0 48003,1 48049,0 48136,1 48137,0 48216,1 48289,0 48328,1 48329,0 48342,1 48345,0 48445,1 48520,0 48587,1 48640,0 48733,1 48809,0 48831,1 48912,0 48987,1 48989,0 49011,1 end initlist b23 0,0 27,1 90,0 113,1 170,0 237,1 333,0 362,1 397,0 484,1 501,0 554,1 564,0 582,1 627,0 704,1 711,0 754,1 762,0 844,1 873,0 928,1 966,0 992,1 998,0 1026,1 1076,0 1170,1 1182,0 1185,1 1222,0 1225,1 1267,0 1317,1 1358,0 1436,1 1453,0 1553,1 1612,0 1632,1 1658,0 1752,1 1851,0 1877,1 1973,0 1981,1 1982,0 2044,1 2095,0 2192,1 2262,0 2279,1 2316,0 2370,1 2405,0 2442,1 2444,0 2506,1 2543,0 2588,1 2607,0 2629,1 2642,0 2661,1 2670,0 2770,1 2782,0 2841,1 2929,0 2949,1 2957,0 3043,1 3138,0 3198,1 3243,0 3287,1 3300,0 3368,1 3387,0 3408,1 3474,0 3483,1 3502,0 3564,1 3593,0 3615,1 3641,0 3713,1 3782,0 3809,1 3841,0 3929,1 3977,0 3996,1 4032,0 4128,1 4222,0 4289,1 4386,0 4400,1 4489,0 4574,1 4609,0 4702,1 4782,0 4835,1 4916,0 4970,1 5069,0 5070,1 5162,0 5185,1 5259,0 5338,1 5375,0 5390,1 5411,0 5452,1 5455,0 5476,1 5488,0 5585,1 5623,0 5707,1 5753,0 5852,1 5923,0 6022,1 6030,0 6119,1 6163,0 6222,1 6286,0 6364,1 6429,0 6506,1 6588,0 6612,1 6687,0 6732,1 6794,0 6816,1 6899,0 6916,1 6944,0 6989,1 7039,0 7050,1 7096,0 7104,1 7141,0 7200,1 7263,0 7290,1 7377,0 7463,1 7534,0 7619,1 7621,0 7652,1 7684,0 7782,1 7812,0 7816,1 7899,0 7915,1 7917,0 8008,1 8016,0 8034,1 8116,0 8144,1 8235,0 8246,1 8261,0 8351,1 8423,0 8488,1 8546,0 8633,1 8656,0 8666,1 8674,0 8763,1 8841,0 8846,1 8945,0 8980,1 9071,0 9134,1 9225,0 9267,1 9339,0 9393,1 9473,0 9562,1 9611,0 9614,1 9714,0 9782,1 9872,0 9963,1 10021,0 10071,1 10090,0 10144,1 10203,0 10259,1 10311,0 10334,1 10422,0 10424,1 10484,0 10559,1 10648,0 10686,1 10739,0 10791,1 10805,0 10903,1 10990,0 11004,1 11057,0 11066,1 11153,0 11187,1 11209,0 11293,1 11351,0 11353,1 11380,0 11436,1 11486,0 11581,1 11670,0 11749,1 11768,0 11853,1 11918,0 11949,1 11973,0 11981,1 12011,0 12046,1 12086,0 12148,1 12190,0 12233,1 12326,0 12423,1 12501,0 12516,1 12611,0 12700,1 12707,0 12721,1 12761,0 12773,1 12836,0 12839,1 12904,0 12950,1 13006,0 13076,1 13121,0 13187,1 13271,0 13287,1 13342,0 13441,1 13530,0 13557,1 13568,0 13580,1 13677,0 13699,1 13731,0 13755,1 13829,0 13911,1 14008,0 14101,1 14107,0 14194,1 14231,0 14306,1 14350,0 14430,1 14455,0 14546,1 14642,0 14721,1 14728,0 14790,1 14831,0 14844,1 14891,0 14963,1 15046,0 15128,1 15189,0 15274,1 15344,0 15388,1 15450,0 15454,1 15515,0 15597,1 15675,0 15766,1 15858,0 15957,1 15961,0 15973,1 16065,0 16140,1 16141,0 16239,1 16306,0 16323,1 16339,0 16367,1 16395,0 16449,1 16474,0 16518,1 16547,0 16562,1 16584,0 16657,1 16682,0 16709,1 16790,0 16809,1 16901,0 16985,1 17037,0 17060,1 17079,0 17163,1 17189,0 17239,1 17268,0 17339,1 17386,0 17468,1 17476,0 17514,1 17522,0 17544,1 17595,0 17618,1 17709,0 17719,1 17767,0 17795,1 17848,0 17878,1 17925,0 17974,1 17998,0 18038,1 18075,0 18101,1 18125,0 18200,1 18207,0 18254,1 18347,0 18393,1 18428,0 18525,1 18549,0 18585,1 18653,0 18728,1 18804,0 18805,1 18845,0 18927,1 18952,0 19038,1 19115,0 19203,1 19280,0 19307,1 19404,0 19431,1 19529,0 19562,1 19595,0 19648,1 19744,0 19832,1 19919,0 20001,1 20100,0 20102,1 20141,0 20202,1 20283,0 20360,1 20362,0 20442,1 20498,0 20509,1 20539,0 20633,1 20713,0 20805,1 20820,0 20873,1 20943,0 20979,1 21059,0 21121,1 21194,0 21280,1 21282,0 21312,1 21395,0 21473,1 21514,0 21548,1 21644,0 21700,1 21740,0 21764,1 21817,0 21837,1 21882,0 21976,1 22027,0 22035,1 22132,0 22189,1 22244,0 22315,1 22382,0 22399,1 22483,0 22522,1 22586,0 22615,1 22672,0 22764,1 22842,0 22864,1 22961,0 22996,1 23090,0 23098,1 23194,0 23282,1 23368,0 23450,1 23461,0 23476,1 23575,0 23589,1 23675,0 23750,1 23814,0 23909,1 23986,0 23991,1 24036,0 24074,1 24122,0 24147,1 24160,0 24247,1 24292,0 24351,1 24432,0 24505,1 24540,0 24548,1 24556,0 24655,1 24755,0 24773,1 24867,0 24894,1 24983,0 25059,1 25125,0 25182,1 25190,0 25207,1 25245,0 25283,1 25360,0 25381,1 25394,0 25413,1 25484,0 25541,1 25611,0 25631,1 25705,0 25718,1 25768,0 25807,1 25829,0 25889,1 25907,0 25976,1 26052,0 26133,1 26178,0 26195,1 26206,0 26248,1 26338,0 26403,1 26491,0 26580,1 26604,0 26700,1 26773,0 26845,1 26864,0 26888,1 26976,0 27029,1 27116,0 27197,1 27226,0 27290,1 27364,0 27389,1 27431,0 27523,1 27541,0 27626,1 27670,0 27701,1 27766,0 27791,1 27831,0 27867,1 27903,0 27978,1 28032,0 28116,1 28190,0 28282,1 28333,0 28395,1 28483,0 28570,1 28655,0 28723,1 28732,0 28761,1 28834,0 28907,1 28996,0 29094,1 29177,0 29257,1 29342,0 29378,1 29439,0 29497,1 29549,0 29642,1 29690,0 29709,1 29787,0 29857,1 29861,0 29924,1 29930,0 29982,1 30069,0 30161,1 30234,0 30296,1 30333,0 30347,1 30391,0 30455,1 30530,0 30542,1 30613,0 30666,1 30726,0 30731,1 30803,0 30856,1 30948,0 31036,1 31079,0 31138,1 31144,0 31185,1 31244,0 31253,1 31283,0 31324,1 31414,0 31508,1 31568,0 31615,1 31697,0 31751,1 31769,0 31815,1 31855,0 31919,1 31950,0 32006,1 32103,0 32169,1 32191,0 32219,1 32280,0 32316,1 32372,0 32414,1 32431,0 32478,1 32519,0 32564,1 32614,0 32692,1 32751,0 32787,1 32803,0 32872,1 32918,0 32996,1 33060,0 33065,1 33141,0 33166,1 33260,0 33339,1 33377,0 33474,1 33514,0 33609,1 33674,0 33725,1 33785,0 33812,1 33851,0 33914,1 34013,0 34081,1 34091,0 34139,1 34146,0 34230,1 34312,0 34363,1 34421,0 34472,1 34556,0 34558,1 34577,0 34645,1 34684,0 34691,1 34729,0 34745,1 34783,0 34836,1 34923,0 34955,1 34994,0 35068,1 35160,0 35249,1 35254,0 35331,1 35363,0 35381,1 35470,0 35522,1 35571,0 35653,1 35753,0 35830,1 35882,0 35915,1 35988,0 36072,1 36103,0 36195,1 36273,0 36274,1 36321,0 36328,1 36343,0 36359,1 36459,0 36514,1 36552,0 36648,1 36665,0 36714,1 36759,0 36833,1 36846,0 36902,1 36939,0 36980,1 37080,0 37106,1 37196,0 37292,1 37351,0 37425,1 37509,0 37575,1 37579,0 37600,1 37678,0 37746,1 37774,0 37855,1 37914,0 37917,1 37989,0 38085,1 38124,0 38179,1 38243,0 38245,1 38297,0 38319,1 38372,0 38449,1 38473,0 38474,1 38487,0 38585,1 38594,0 38598,1 38633,0 38723,1 38785,0 38786,1 38812,0 38906,1 38978,0 39012,1 39036,0 39052,1 39100,0 39200,1 39271,0 39354,1 39381,0 39416,1 39512,0 39557,1 39643,0 39710,1 39792,0 39838,1 39906,0 39939,1 40000,0 40060,1 40079,0 40091,1 40180,0 40198,1 40276,0 40322,1 40335,0 40391,1 40441,0 40460,1 40479,0 40541,1 40606,0 40662,1 40698,0 40729,1 40796,0 40810,1 40846,0 40928,1 40985,0 41077,1 41102,0 41107,1 41114,0 41179,1 41216,0 41297,1 41391,0 41472,1 41474,0 41559,1 41615,0 41710,1 41786,0 41794,1 41810,0 41861,1 41885,0 41898,1 41988,0 42044,1 42058,0 42121,1 42126,0 42167,1 42200,0 42219,1 42302,0 42303,1 42324,0 42344,1 42418,0 42507,1 42577,0 42669,1 42727,0 42806,1 42896,0 42903,1 42926,0 42962,1 42969,0 42998,1 43075,0 43135,1 43136,0 43180,1 43191,0 43224,1 43237,0 43271,1 43330,0 43420,1 43520,0 43586,1 43591,0 43684,1 43765,0 43854,1 43953,0 44020,1 44063,0 44126,1 44183,0 44268,1 44359,0 44429,1 44463,0 44512,1 44516,0 44593,1 44674,0 44710,1 44773,0 44841,1 44880,0 44945,1 45022,0 45064,1 45100,0 45171,1 45270,0 45364,1 45430,0 45472,1 45569,0 45586,1 45671,0 45742,1 45802,0 45818,1 45877,0 45932,1 45938,0 46001,1 46023,0 46059,1 46119,0 46136,1 46204,0 46304,1 46316,0 46369,1 46385,0 46469,1 46551,0 46640,1 46688,0 46731,1 46747,0 46778,1 46792,0 46889,1 46928,0 46934,1 46956,0 47021,1 47054,0 47112,1 47191,0 47218,1 47229,0 47303,1 47380,0 47464,1 47473,0 47524,1 47563,0 47597,1 47677,0 47713,1 47759,0 47806,1 47886,0 47986,1 48077,0 48107,1 48188,0 48249,1 48310,0 48394,1 48478,0 48561,1 48603,0 48688,1 48751,0 48777,1 48825,0 48910,1 48956,0 48979,1 49045,0 49099,1 49116,0 49168,1 49245,0 49322,1 49334,0 49356,1 49378,0 49438,1 49442,0 49512,1 49585,0 49677,1 49773,0 49866,1 49872,0 49970,1 50005,0 50016,1 50022,0 50120,1 50175,0 50240,1 50257,0 50355,1 50402,0 50476,1 50552,0 50612,1 50653,0 50712,1 50771,0 50772,1 50864,0 50867,1 50935,0 51026,1 51072,0 51130,1 51186,0 51217,1 51241,0 51289,1 51351,0 51401,1 51466,0 51533,1 51557,0 51566,1 51620,0 51680,1 51771,0 51814,1 51841,0 51885,1 51907,0 51940,1 52014,0 52043,1 52123,0 52213,1 end initlist b24 0,0 66,1 85,0 102,1 109,0 116,1 195,0 225,1 260,0 354,1 391,0 491,1 554,0 615,1 647,0 719,1 783,0 812,1 878,0 906,1 935,0 964,1 1020,0 1040,1 1078,0 1108,1 1119,0 1128,1 1154,0 1174,1 1215,0 1308,1 1355,0 1407,1 1491,0 1514,1 1608,0 1622,1 1707,0 1745,1 1748,0 1840,1 1918,0 1941,1 1963,0 1981,1 1990,0 2059,1 2109,0 2194,1 2246,0 2329,1 2358,0 2452,1 2533,0 2628,1 2655,0 2750,1 2819,0 2868,1 2921,0 2948,1 2959,0 3021,1 3071,0 3136,1 3197,0 3278,1 3366,0 3384,1 3413,0 3510,1 3592,0 3612,1 3693,0 3709,1 3808,0 3838,1 3913,0 3953,1 3985,0 4024,1 4123,0 4155,1 4224,0 4293,1 4337,0 4374,1 4419,0 4437,1 4463,0 4539,1 4633,0 4643,1 4735,0 4827,1 4896,0 4923,1 4925,0 5004,1 5095,0 5138,1 5233,0 5247,1 5324,0 5332,1 5430,0 5469,1 5530,0 5622,1 5685,0 5709,1 5720,0 5773,1 5828,0 5916,1 5996,0 6008,1 6055,0 6135,1 6154,0 6231,1 6290,0 6379,1 6466,0 6513,1 6570,0 6594,1 6664,0 6714,1 6717,0 6788,1 6869,0 6912,1 6913,0 6987,1 7003,0 7031,1 7125,0 7169,1 7206,0 7279,1 7345,0 7442,1 7453,0 7479,1 7568,0 7633,1 7723,0 7773,1 7823,0 7913,1 7995,0 8048,1 8139,0 8205,1 8257,0 8258,1 8349,0 8442,1 8526,0 8555,1 8583,0 8607,1 8681,0 8688,1 8773,0 8843,1 8915,0 8921,1 8969,0 9000,1 9077,0 9083,1 9086,0 9165,1 9237,0 9303,1 9402,0 9411,1 9444,0 9472,1 9567,0 9625,1 9646,0 9652,1 9672,0 9693,1 9698,0 9721,1 9766,0 9804,1 9830,0 9885,1 9886,0 9971,1 10071,0 10087,1 10165,0 10185,1 10245,0 10260,1 10298,0 10380,1 10422,0 10498,1 10579,0 10672,1 10690,0 10699,1 10712,0 10773,1 10780,0 10808,1 10842,0 10863,1 10894,0 10938,1 11016,0 11093,1 11123,0 11219,1 11231,0 11313,1 11344,0 11439,1 11477,0 11494,1 11541,0 11633,1 11639,0 11681,1 11734,0 11830,1 11896,0 11921,1 11994,0 12064,1 12164,0 12202,1 12268,0 12281,1 12329,0 12353,1 12370,0 12378,1 12393,0 12438,1 12449,0 12500,1 12536,0 12625,1 12685,0 12737,1 12816,0 12871,1 12914,0 12992,1 13030,0 13076,1 13097,0 13183,1 13255,0 13283,1 13357,0 13406,1 13481,0 13561,1 13647,0 13680,1 13731,0 13758,1 13773,0 13781,1 13842,0 13906,1 13970,0 13986,1 14066,0 14110,1 14170,0 14188,1 14223,0 14293,1 14294,0 14327,1 14411,0 14419,1 14441,0 14496,1 14506,0 14591,1 14664,0 14741,1 14811,0 14870,1 14877,0 14940,1 15032,0 15067,1 15115,0 15202,1 15264,0 15293,1 15365,0 15387,1 15445,0 15453,1 15473,0 15495,1 15503,0 15573,1 15590,0 15607,1 15677,0 15756,1 15825,0 15847,1 15905,0 15960,1 15961,0 16023,1 16099,0 16167,1 16205,0 16207,1 16292,0 16320,1 16403,0 16410,1 16484,0 16584,1 16666,0 16716,1 16748,0 16830,1 16895,0 16944,1 17041,0 17122,1 17171,0 17186,1 17262,0 17282,1 17289,0 17379,1 17475,0 17480,1 17553,0 17576,1 17647,0 17653,1 17715,0 17775,1 17863,0 17917,1 17964,0 18053,1 18073,0 18080,1 18167,0 18233,1 18315,0 18404,1 18449,0 18474,1 18491,0 18499,1 18585,0 18604,1 18649,0 18689,1 18702,0 18735,1 18805,0 18832,1 18852,0 18929,1 19017,0 19034,1 19045,0 19053,1 19114,0 19151,1 19215,0 19298,1 19334,0 19383,1 19428,0 19462,1 19467,0 19478,1 19517,0 19553,1 19597,0 19690,1 19733,0 19815,1 19915,0 20010,1 20032,0 20118,1 20156,0 20203,1 20231,0 20285,1 20291,0 20356,1 20358,0 20413,1 20433,0 20440,1 20445,0 20458,1 20529,0 20571,1 20658,0 20705,1 20774,0 20872,1 20960,0 21036,1 21077,0 21094,1 21184,0 21246,1 21305,0 21373,1 21392,0 21405,1 21423,0 21511,1 21531,0 21555,1 21638,0 21676,1 21776,0 21784,1 21790,0 21826,1 21906,0 21933,1 21940,0 22037,1 22095,0 22097,1 22160,0 22187,1 22220,0 22299,1 22397,0 22483,1 22525,0 22539,1 22560,0 22634,1 22636,0 22677,1 22763,0 22776,1 22845,0 22930,1 23000,0 23041,1 23079,0 23135,1 23204,0 23232,1 23244,0 23311,1 23390,0 23467,1 23564,0 23572,1 23626,0 23675,1 23722,0 23799,1 23843,0 23926,1 23962,0 23975,1 23998,0 24019,1 24078,0 24098,1 24185,0 24257,1 24298,0 24355,1 24428,0 24505,1 24544,0 24602,1 24681,0 24767,1 24795,0 24860,1 24884,0 24903,1 24997,0 25045,1 25107,0 25146,1 25232,0 25303,1 25377,0 25405,1 25436,0 25498,1 25567,0 25572,1 25603,0 25695,1 25726,0 25742,1 25807,0 25810,1 25874,0 25972,1 26020,0 26115,1 26189,0 26231,1 26283,0 26288,1 26329,0 26382,1 26386,0 26445,1 26517,0 26557,1 26597,0 26688,1 26757,0 26852,1 26892,0 26978,1 26993,0 27065,1 27071,0 27097,1 27154,0 27244,1 27282,0 27320,1 27349,0 27408,1 27419,0 27479,1 27511,0 27561,1 27586,0 27665,1 27765,0 27806,1 27812,0 27906,1 27931,0 27939,1 27990,0 28003,1 28046,0 28132,1 28146,0 28201,1 28288,0 28304,1 28341,0 28361,1 28418,0 28433,1 28504,0 28592,1 28673,0 28745,1 28845,0 28885,1 28928,0 29010,1 29056,0 29138,1 29211,0 29256,1 29259,0 29341,1 29405,0 29455,1 29469,0 29548,1 29611,0 29665,1 29671,0 29730,1 29814,0 29912,1 30008,0 30096,1 30190,0 30266,1 30322,0 30357,1 30364,0 30381,1 30419,0 30470,1 30540,0 30587,1 30621,0 30626,1 30671,0 30681,1 30731,0 30780,1 30834,0 30913,1 30936,0 31014,1 31071,0 31091,1 31095,0 31141,1 31223,0 31264,1 31356,0 31413,1 31426,0 31460,1 31477,0 31492,1 31510,0 31537,1 31577,0 31609,1 31686,0 31738,1 31789,0 31815,1 31903,0 31931,1 31970,0 31986,1 32046,0 32070,1 32159,0 32230,1 32320,0 32402,1 32501,0 32553,1 32572,0 32648,1 32715,0 32787,1 32824,0 32855,1 32870,0 32883,1 32968,0 33055,1 33098,0 33193,1 33206,0 33208,1 33271,0 33280,1 33335,0 33428,1 33488,0 33571,1 33598,0 33695,1 33713,0 33782,1 33872,0 33959,1 33991,0 34022,1 34058,0 34085,1 34175,0 34228,1 34272,0 34330,1 34397,0 34430,1 34510,0 34599,1 34614,0 34698,1 34795,0 34884,1 34924,0 34931,1 35020,0 35104,1 35141,0 35201,1 35255,0 35312,1 35407,0 35498,1 35571,0 35651,1 35705,0 35713,1 35739,0 35835,1 35918,0 35985,1 36055,0 36086,1 36145,0 36158,1 36229,0 36263,1 36356,0 36389,1 36419,0 36437,1 36530,0 36551,1 36554,0 36617,1 36705,0 36800,1 36846,0 36856,1 36872,0 36954,1 37020,0 37078,1 37173,0 37258,1 37345,0 37364,1 37366,0 37404,1 37471,0 37565,1 37649,0 37699,1 37794,0 37805,1 37848,0 37947,1 37963,0 38012,1 38092,0 38172,1 38257,0 38277,1 38347,0 38349,1 38421,0 38486,1 38566,0 38609,1 38677,0 38716,1 38773,0 38808,1 38890,0 38902,1 38942,0 38963,1 39021,0 39098,1 39135,0 39179,1 39213,0 39219,1 39246,0 39261,1 39292,0 39331,1 39334,0 39375,1 39470,0 39518,1 39578,0 39655,1 39678,0 39689,1 39726,0 39734,1 39785,0 39854,1 39922,0 39938,1 39960,0 40007,1 40072,0 40168,1 40188,0 40229,1 40266,0 40329,1 40403,0 40428,1 40439,0 40519,1 40616,0 40651,1 40693,0 40769,1 40806,0 40844,1 40933,0 41016,1 41090,0 41124,1 41223,0 41292,1 41349,0 41395,1 41432,0 41510,1 41585,0 41633,1 41726,0 41750,1 41765,0 41767,1 41862,0 41938,1 41965,0 42011,1 42020,0 42072,1 42136,0 42206,1 42280,0 42347,1 42425,0 42509,1 42599,0 42698,1 42710,0 42795,1 42878,0 42896,1 42916,0 42920,1 42971,0 43067,1 43143,0 43153,1 43185,0 43207,1 43289,0 43378,1 43442,0 43497,1 43553,0 43603,1 43650,0 43678,1 43756,0 43828,1 43866,0 43873,1 43926,0 43999,1 44099,0 44160,1 44247,0 44285,1 44313,0 44372,1 44406,0 44466,1 44529,0 44572,1 44654,0 44670,1 44769,0 44776,1 44808,0 44828,1 44832,0 44834,1 44906,0 44916,1 44936,0 44965,1 45037,0 45124,1 45134,0 45149,1 45202,0 45236,1 45250,0 45268,1 45366,0 45458,1 45532,0 45561,1 45586,0 45657,1 45747,0 45803,1 45874,0 45969,1 46007,0 46102,1 46160,0 46194,1 46218,0 46302,1 46329,0 46412,1 46453,0 46520,1 46594,0 46609,1 46647,0 46671,1 46711,0 46761,1 46762,0 46842,1 46860,0 46909,1 46938,0 46993,1 47023,0 47044,1 47138,0 47237,1 47256,0 47267,1 47302,0 47313,1 47346,0 47412,1 47418,0 47432,1 47442,0 47450,1 47495,0 47513,1 47545,0 47616,1 47678,0 47755,1 47811,0 47852,1 47884,0 47907,1 47973,0 48051,1 48105,0 48164,1 48235,0 48255,1 48342,0 48421,1 48493,0 48559,1 48581,0 48594,1 48620,0 48655,1 48660,0 48682,1 48780,0 48876,1 48957,0 49036,1 49091,0 49116,1 49216,0 49218,1 49229,0 49284,1 49302,0 49355,1 49396,0 49444,1 49537,0 49564,1 49637,0 49641,1 49646,0 49651,1 49652,0 49678,1 49735,0 49811,1 49889,0 49985,1 50042,0 50096,1 50164,0 50183,1 50238,0 50245,1 50322,0 50413,1 50465,0 50541,1 end initlist b25 0,0 4,1 5,0 96,1 166,0 255,1 304,0 337,1 374,0 443,1 450,0 465,1 560,0 611,1 630,0 653,1 717,0 729,1 798,0 831,1 905,0 940,1 983,0 1042,1 1123,0 1160,1 1175,0 1273,1 1368,0 1424,1 1513,0 1516,1 1557,0 1637,1 1683,0 1753,1 1811,0 1814,1 1834,0 1871,1 1944,0 2008,1 2028,0 2096,1 2149,0 2152,1 2203,0 2245,1 2289,0 2345,1 2369,0 2420,1 2514,0 2603,1 2686,0 2772,1 2805,0 2839,1 2928,0 2942,1 2959,0 3027,1 3078,0 3136,1 3166,0 3247,1 3307,0 3404,1 3417,0 3429,1 3433,0 3448,1 3535,0 3580,1 3621,0 3681,1 3699,0 3762,1 3797,0 3830,1 3878,0 3907,1 3951,0 3955,1 4047,0 4086,1 4141,0 4232,1 4276,0 4349,1 4432,0 4510,1 4542,0 4594,1 4643,0 4649,1 4711,0 4735,1 4745,0 4774,1 4787,0 4876,1 4962,0 5023,1 5029,0 5078,1 5116,0 5157,1 5161,0 5165,1 5254,0 5340,1 5437,0 5526,1 5598,0 5612,1 5631,0 5681,1 5739,0 5764,1 5789,0 5806,1 5844,0 5892,1 5953,0 5992,1 6000,0 6040,1 6137,0 6175,1 6213,0 6296,1 6347,0 6410,1 6501,0 6555,1 6620,0 6706,1 6752,0 6846,1 6880,0 6892,1 6968,0 6991,1 7007,0 7026,1 7031,0 7038,1 7116,0 7147,1 7148,0 7159,1 7218,0 7305,1 7344,0 7423,1 7482,0 7505,1 7550,0 7616,1 7701,0 7733,1 7782,0 7819,1 7835,0 7892,1 7927,0 7950,1 8000,0 8014,1 8075,0 8148,1 8187,0 8255,1 8338,0 8361,1 8376,0 8399,1 8466,0 8506,1 8516,0 8557,1 8579,0 8588,1 8648,0 8747,1 8773,0 8864,1 8949,0 9010,1 9064,0 9113,1 9156,0 9164,1 9190,0 9287,1 9328,0 9393,1 9486,0 9534,1 9570,0 9622,1 9655,0 9683,1 9746,0 9829,1 9908,0 9989,1 10011,0 10082,1 10116,0 10148,1 10206,0 10264,1 10319,0 10380,1 10430,0 10502,1 10526,0 10593,1 10611,0 10667,1 10761,0 10771,1 10781,0 10842,1 10871,0 10874,1 10933,0 10957,1 10973,0 11013,1 11078,0 11174,1 11268,0 11338,1 11388,0 11424,1 11516,0 11596,1 11617,0 11677,1 11741,0 11793,1 11864,0 11929,1 12008,0 12039,1 12133,0 12196,1 12233,0 12333,1 12401,0 12472,1 12494,0 12560,1 12589,0 12605,1 12625,0 12634,1 12643,0 12679,1 12754,0 12820,1 12826,0 12914,1 12997,0 13030,1 13074,0 13153,1 13218,0 13313,1 13356,0 13400,1 13485,0 13487,1 13576,0 13589,1 13689,0 13699,1 13756,0 13840,1 13904,0 13976,1 14010,0 14037,1 14067,0 14093,1 14097,0 14153,1 14227,0 14319,1 14380,0 14454,1 14509,0 14555,1 14616,0 14700,1 14713,0 14781,1 14842,0 14880,1 14909,0 14910,1 14962,0 15029,1 15115,0 15182,1 15241,0 15337,1 15366,0 15399,1 15417,0 15449,1 15528,0 15620,1 15673,0 15702,1 15726,0 15747,1 15832,0 15913,1 15927,0 15967,1 16060,0 16104,1 16167,0 16265,1 16326,0 16394,1 16422,0 16461,1 16549,0 16627,1 16685,0 16715,1 16807,0 16873,1 16935,0 16988,1 17025,0 17122,1 17206,0 17261,1 17266,0 17270,1 17303,0 17348,1 17351,0 17424,1 17432,0 17529,1 17564,0 17626,1 17655,0 17721,1 17797,0 17827,1 17926,0 17982,1 18077,0 18154,1 18162,0 18210,1 18256,0 18326,1 18364,0 18389,1 18416,0 18502,1 18569,0 18659,1 18682,0 18738,1 18827,0 18855,1 18945,0 18979,1 18995,0 19014,1 19110,0 19201,1 19214,0 19253,1 19264,0 19292,1 19314,0 19318,1 19337,0 19428,1 19468,0 19499,1 19534,0 19599,1 19660,0 19721,1 19794,0 19813,1 19835,0 19867,1 19909,0 19963,1 19981,0 20018,1 20095,0 20098,1 20102,0 20157,1 20158,0 20164,1 20211,0 20247,1 20261,0 20335,1 20359,0 20417,1 20455,0 20502,1 20539,0 20573,1 20597,0 20645,1 20724,0 20774,1 20872,0 20944,1 21005,0 21076,1 21159,0 21251,1 21348,0 21355,1 21395,0 21467,1 21477,0 21507,1 21577,0 21591,1 21632,0 21667,1 21763,0 21854,1 21874,0 21933,1 21982,0 22002,1 22067,0 22077,1 22176,0 22212,1 22231,0 22312,1 22405,0 22423,1 22504,0 22544,1 22642,0 22689,1 22764,0 22813,1 22858,0 22869,1 22903,0 22953,1 23042,0 23110,1 23190,0 23241,1 23261,0 23294,1 23312,0 23396,1 23452,0 23515,1 23593,0 23597,1 23682,0 23760,1 23826,0 23904,1 23907,0 23972,1 24022,0 24068,1 24118,0 24157,1 24256,0 24341,1 24375,0 24442,1 24482,0 24526,1 24551,0 24598,1 24652,0 24707,1 24787,0 24846,1 24925,0 24961,1 25014,0 25030,1 25130,0 25183,1 25219,0 25254,1 25302,0 25335,1 25403,0 25413,1 25509,0 25594,1 25680,0 25681,1 25695,0 25710,1 25729,0 25769,1 25868,0 25890,1 25963,0 25966,1 25986,0 26050,1 26110,0 26180,1 26255,0 26348,1 26376,0 26459,1 26559,0 26650,1 26713,0 26751,1 26824,0 26836,1 26870,0 26946,1 27042,0 27088,1 27124,0 27164,1 27249,0 27319,1 27401,0 27432,1 27486,0 27582,1 27588,0 27598,1 27648,0 27677,1 27747,0 27845,1 27866,0 27872,1 27967,0 27980,1 28057,0 28154,1 28229,0 28268,1 28277,0 28343,1 28427,0 28459,1 28469,0 28517,1 28544,0 28593,1 28643,0 28696,1 28729,0 28769,1 28865,0 28961,1 28987,0 29020,1 29061,0 29096,1 29144,0 29145,1 29168,0 29204,1 29279,0 29361,1 29446,0 29520,1 29563,0 29643,1 29689,0 29789,1 29847,0 29936,1 29967,0 29994,1 30061,0 30139,1 30205,0 30214,1 30231,0 30256,1 30292,0 30346,1 30421,0 30508,1 30607,0 30629,1 30660,0 30688,1 30723,0 30782,1 30840,0 30876,1 30927,0 30955,1 31039,0 31136,1 31173,0 31212,1 31227,0 31301,1 31338,0 31400,1 31458,0 31537,1 31582,0 31662,1 31735,0 31767,1 31834,0 31909,1 31952,0 31980,1 32072,0 32161,1 32172,0 32231,1 32322,0 32324,1 32417,0 32491,1 32569,0 32570,1 32614,0 32669,1 32672,0 32753,1 32830,0 32899,1 32914,0 33000,1 33073,0 33146,1 33160,0 33209,1 33229,0 33244,1 33271,0 33278,1 33337,0 33347,1 33374,0 33448,1 33457,0 33502,1 33589,0 33688,1 33710,0 33720,1 33733,0 33788,1 33860,0 33901,1 33955,0 34004,1 34023,0 34077,1 34092,0 34175,1 34268,0 34345,1 34396,0 34405,1 34456,0 34473,1 34485,0 34491,1 34553,0 34611,1 34617,0 34666,1 34759,0 34851,1 34913,0 34930,1 35003,0 35076,1 35092,0 35153,1 35184,0 35264,1 35290,0 35348,1 35350,0 35386,1 35481,0 35559,1 35642,0 35718,1 35753,0 35844,1 35944,0 36025,1 36064,0 36154,1 36249,0 36296,1 36372,0 36453,1 36497,0 36576,1 36645,0 36735,1 36790,0 36794,1 36822,0 36912,1 36966,0 36998,1 37007,0 37038,1 37081,0 37162,1 37231,0 37240,1 37316,0 37322,1 37377,0 37384,1 37389,0 37473,1 37506,0 37576,1 37578,0 37616,1 37666,0 37690,1 37773,0 37829,1 37847,0 37888,1 37925,0 37951,1 38023,0 38026,1 38094,0 38105,1 38160,0 38213,1 38215,0 38221,1 38233,0 38293,1 38384,0 38403,1 38485,0 38499,1 38559,0 38637,1 38657,0 38691,1 38760,0 38850,1 38863,0 38928,1 38958,0 39043,1 39077,0 39112,1 39165,0 39259,1 39313,0 39359,1 39397,0 39457,1 39469,0 39562,1 39576,0 39658,1 39672,0 39677,1 39759,0 39825,1 39901,0 39918,1 39941,0 40037,1 40056,0 40102,1 40182,0 40279,1 40377,0 40382,1 40404,0 40474,1 40569,0 40637,1 40721,0 40724,1 40794,0 40821,1 40831,0 40910,1 40972,0 40977,1 41074,0 41168,1 41263,0 41356,1 41440,0 41511,1 41579,0 41630,1 41653,0 41660,1 41687,0 41778,1 41863,0 41907,1 41917,0 41946,1 41987,0 42077,1 42111,0 42168,1 42252,0 42281,1 42286,0 42293,1 42348,0 42396,1 42403,0 42437,1 42489,0 42555,1 42568,0 42658,1 42746,0 42748,1 42815,0 42886,1 42898,0 42975,1 43038,0 43075,1 43157,0 43225,1 43265,0 43360,1 43413,0 43452,1 43477,0 43564,1 43585,0 43612,1 43626,0 43713,1 43781,0 43835,1 43861,0 43889,1 43975,0 44049,1 44093,0 44097,1 44165,0 44187,1 44214,0 44261,1 44346,0 44388,1 44431,0 44512,1 44546,0 44553,1 44559,0 44644,1 44714,0 44793,1 44884,0 44929,1 44986,0 45037,1 45126,0 45149,1 45238,0 45254,1 45345,0 45352,1 45405,0 45421,1 45479,0 45486,1 45519,0 45526,1 45534,0 45617,1 45665,0 45722,1 45724,0 45772,1 45863,0 45897,1 45994,0 46017,1 46062,0 46087,1 46158,0 46159,1 46256,0 46330,1 46351,0 46404,1 46456,0 46529,1 46615,0 46681,1 46683,0 46766,1 46857,0 46878,1 46947,0 47013,1 47062,0 47114,1 47165,0 47185,1 47257,0 47282,1 47362,0 47426,1 47496,0 47542,1 47609,0 47669,1 47724,0 47782,1 47858,0 47867,1 47872,0 47949,1 48026,0 48068,1 48138,0 48224,1 48308,0 48385,1 48405,0 48448,1 48482,0 48579,1 48639,0 48724,1 48764,0 48836,1 48859,0 48893,1 48975,0 49037,1 49100,0 49113,1 49163,0 49175,1 49197,0 49272,1 49285,0 49305,1 49347,0 49366,1 49424,0 49503,1 49560,0 49627,1 49676,0 49715,1 49742,0 49780,1 49785,0 49846,1 49924,0 49943,1 50016,0 50093,1 50167,0 50257,1 50292,0 50342,1 50423,0 50431,1 50506,0 50587,1 end initlist b26 0,0 19,1 22,0 51,1 103,0 163,1 210,0 261,1 267,0 302,1 385,0 409,1 458,0 460,1 524,0 587,1 630,0 677,1 752,0 830,1 850,0 880,1 942,0 993,1 1031,0 1128,1 1160,0 1233,1 1278,0 1285,1 1349,0 1444,1 1447,0 1480,1 1549,0 1612,1 1681,0 1702,1 1799,0 1864,1 1899,0 1972,1 2020,0 2108,1 2151,0 2249,1 2288,0 2369,1 2433,0 2523,1 2611,0 2644,1 2647,0 2685,1 2769,0 2819,1 2847,0 2849,1 2948,0 2991,1 2992,0 3031,1 3096,0 3177,1 3184,0 3224,1 3310,0 3365,1 3415,0 3442,1 3467,0 3499,1 3595,0 3659,1 3710,0 3772,1 3805,0 3834,1 3925,0 3965,1 4064,0 4087,1 4102,0 4116,1 4214,0 4226,1 4322,0 4353,1 4452,0 4490,1 4539,0 4619,1 4691,0 4741,1 4765,0 4844,1 4896,0 4897,1 4901,0 4947,1 4956,0 4964,1 5049,0 5065,1 5128,0 5191,1 5196,0 5246,1 5287,0 5373,1 5430,0 5463,1 5511,0 5550,1 5635,0 5715,1 5718,0 5776,1 5817,0 5864,1 5933,0 5997,1 6005,0 6050,1 6090,0 6178,1 6233,0 6261,1 6270,0 6293,1 6359,0 6440,1 6448,0 6494,1 6568,0 6625,1 6639,0 6675,1 6755,0 6838,1 6910,0 6944,1 6973,0 7021,1 7084,0 7132,1 7147,0 7235,1 7260,0 7346,1 7396,0 7474,1 7493,0 7512,1 7559,0 7628,1 7686,0 7715,1 7785,0 7809,1 7843,0 7923,1 7931,0 8025,1 8075,0 8172,1 8234,0 8251,1 8272,0 8365,1 8454,0 8485,1 8486,0 8500,1 8531,0 8565,1 8633,0 8717,1 8756,0 8792,1 8854,0 8861,1 8927,0 8969,1 9047,0 9124,1 9218,0 9318,1 9326,0 9423,1 9479,0 9511,1 9562,0 9628,1 9644,0 9702,1 9765,0 9803,1 9828,0 9850,1 9898,0 9920,1 9951,0 10003,1 10093,0 10124,1 10138,0 10152,1 10161,0 10235,1 10322,0 10414,1 10432,0 10517,1 10609,0 10647,1 10699,0 10718,1 10733,0 10748,1 10832,0 10915,1 10999,0 11086,1 11163,0 11213,1 11270,0 11328,1 11382,0 11460,1 11484,0 11546,1 11558,0 11631,1 11662,0 11682,1 11752,0 11833,1 11927,0 11955,1 12031,0 12066,1 12161,0 12235,1 12331,0 12416,1 12430,0 12491,1 12521,0 12619,1 12652,0 12683,1 12767,0 12804,1 12812,0 12836,1 12889,0 12958,1 13017,0 13056,1 13116,0 13123,1 13203,0 13291,1 13347,0 13404,1 13447,0 13541,1 13584,0 13648,1 13666,0 13699,1 13751,0 13782,1 13848,0 13870,1 13896,0 13964,1 14007,0 14054,1 14094,0 14123,1 14141,0 14226,1 14263,0 14327,1 14422,0 14436,1 14463,0 14478,1 14564,0 14634,1 14696,0 14701,1 14796,0 14861,1 14953,0 15044,1 15092,0 15150,1 15202,0 15231,1 15310,0 15328,1 15362,0 15408,1 15469,0 15489,1 15563,0 15656,1 15685,0 15778,1 15860,0 15913,1 15925,0 15934,1 15963,0 16051,1 16094,0 16119,1 16148,0 16210,1 16257,0 16336,1 16337,0 16424,1 16502,0 16527,1 16574,0 16629,1 16637,0 16646,1 16719,0 16729,1 16770,0 16853,1 16938,0 16971,1 17019,0 17026,1 17107,0 17161,1 17163,0 17169,1 17174,0 17221,1 17245,0 17325,1 17396,0 17415,1 17445,0 17524,1 17526,0 17616,1 17711,0 17722,1 17776,0 17790,1 17794,0 17864,1 17941,0 18038,1 18062,0 18076,1 18149,0 18246,1 18275,0 18313,1 18371,0 18446,1 18514,0 18557,1 18642,0 18675,1 18751,0 18777,1 18850,0 18944,1 19006,0 19065,1 19124,0 19210,1 19261,0 19310,1 19349,0 19397,1 19476,0 19532,1 19547,0 19577,1 19664,0 19745,1 19841,0 19888,1 19938,0 19950,1 20037,0 20131,1 20156,0 20211,1 20257,0 20267,1 20334,0 20395,1 20472,0 20557,1 20644,0 20723,1 20788,0 20887,1 20929,0 20936,1 21022,0 21107,1 21195,0 21239,1 21296,0 21307,1 21375,0 21469,1 21503,0 21574,1 21658,0 21735,1 21798,0 21890,1 21898,0 21987,1 22054,0 22063,1 22087,0 22136,1 22140,0 22221,1 22270,0 22343,1 22375,0 22409,1 22505,0 22511,1 22573,0 22651,1 22669,0 22762,1 22799,0 22879,1 22944,0 22977,1 23059,0 23138,1 23175,0 23194,1 23255,0 23259,1 23272,0 23347,1 23429,0 23471,1 23523,0 23617,1 23668,0 23705,1 23805,0 23816,1 23821,0 23873,1 23957,0 24022,1 24101,0 24113,1 24125,0 24144,1 24223,0 24303,1 24305,0 24379,1 24417,0 24439,1 24477,0 24534,1 24616,0 24685,1 24711,0 24785,1 24829,0 24862,1 24863,0 24867,1 24942,0 25007,1 25053,0 25089,1 25181,0 25257,1 25291,0 25354,1 25417,0 25454,1 25500,0 25543,1 25589,0 25686,1 25780,0 25812,1 25889,0 25971,1 25973,0 26042,1 26135,0 26162,1 26232,0 26318,1 26415,0 26464,1 26515,0 26579,1 26623,0 26653,1 26696,0 26714,1 26762,0 26778,1 26865,0 26877,1 26897,0 26925,1 26973,0 27046,1 27130,0 27230,1 27235,0 27305,1 27351,0 27356,1 27429,0 27450,1 27466,0 27491,1 27538,0 27545,1 27613,0 27677,1 27718,0 27778,1 27802,0 27870,1 27871,0 27956,1 28049,0 28093,1 28096,0 28159,1 28203,0 28236,1 28270,0 28289,1 28353,0 28390,1 28393,0 28481,1 28574,0 28646,1 28688,0 28742,1 28773,0 28845,1 28889,0 28950,1 29049,0 29072,1 29107,0 29176,1 29245,0 29250,1 29291,0 29362,1 29461,0 29482,1 29562,0 29590,1 29660,0 29690,1 29699,0 29749,1 29836,0 29860,1 29951,0 29954,1 30046,0 30063,1 30163,0 30191,1 30281,0 30318,1 30346,0 30372,1 30462,0 30556,1 30636,0 30726,1 30772,0 30775,1 30834,0 30933,1 30994,0 31085,1 31086,0 31122,1 31154,0 31169,1 31206,0 31305,1 31328,0 31381,1 31383,0 31451,1 31456,0 31479,1 31574,0 31659,1 31685,0 31697,1 31747,0 31844,1 31915,0 31950,1 31967,0 32036,1 32060,0 32116,1 32138,0 32185,1 32251,0 32277,1 32346,0 32360,1 32447,0 32498,1 32501,0 32507,1 32546,0 32616,1 32650,0 32665,1 32677,0 32691,1 32766,0 32781,1 32837,0 32878,1 32929,0 32953,1 33028,0 33069,1 33115,0 33176,1 33262,0 33290,1 33299,0 33337,1 33387,0 33411,1 33501,0 33546,1 33603,0 33641,1 33643,0 33722,1 33749,0 33788,1 33823,0 33892,1 33922,0 33945,1 33959,0 33974,1 34065,0 34120,1 34189,0 34255,1 34276,0 34349,1 34430,0 34494,1 34526,0 34612,1 34613,0 34643,1 34710,0 34801,1 34829,0 34859,1 34952,0 34969,1 35032,0 35039,1 35043,0 35142,1 35191,0 35279,1 35327,0 35355,1 35373,0 35463,1 35551,0 35611,1 35613,0 35658,1 35671,0 35752,1 35805,0 35858,1 35868,0 35889,1 35908,0 35920,1 36017,0 36078,1 36164,0 36182,1 36260,0 36325,1 36384,0 36429,1 36431,0 36477,1 36564,0 36608,1 36611,0 36658,1 36754,0 36758,1 36767,0 36788,1 36865,0 36904,1 36914,0 36968,1 37068,0 37134,1 37213,0 37274,1 37339,0 37432,1 37463,0 37516,1 37523,0 37622,1 37685,0 37704,1 37746,0 37756,1 37806,0 37837,1 37853,0 37951,1 38003,0 38044,1 38092,0 38093,1 38178,0 38217,1 38312,0 38315,1 38361,0 38374,1 38468,0 38528,1 38569,0 38606,1 38629,0 38653,1 38657,0 38707,1 38747,0 38763,1 38832,0 38919,1 38974,0 39051,1 39078,0 39121,1 39210,0 39301,1 39332,0 39382,1 39442,0 39464,1 39545,0 39574,1 39648,0 39680,1 39747,0 39766,1 39780,0 39864,1 39880,0 39960,1 40055,0 40087,1 40145,0 40216,1 40241,0 40296,1 40328,0 40416,1 40508,0 40560,1 40589,0 40606,1 40701,0 40796,1 40860,0 40937,1 40939,0 41034,1 41051,0 41070,1 41111,0 41132,1 41231,0 41242,1 41248,0 41300,1 41302,0 41373,1 41387,0 41464,1 41482,0 41493,1 41516,0 41580,1 41639,0 41694,1 41762,0 41806,1 41864,0 41881,1 41967,0 41979,1 42076,0 42123,1 42215,0 42227,1 42254,0 42299,1 42392,0 42411,1 42419,0 42518,1 42527,0 42540,1 42581,0 42671,1 42763,0 42779,1 42836,0 42837,1 42841,0 42863,1 42940,0 43009,1 43054,0 43138,1 43234,0 43262,1 43341,0 43359,1 43374,0 43452,1 43519,0 43544,1 43601,0 43683,1 43743,0 43837,1 43845,0 43940,1 43994,0 44039,1 44078,0 44132,1 44164,0 44191,1 44279,0 44378,1 44431,0 44508,1 44589,0 44685,1 44715,0 44757,1 44765,0 44863,1 44907,0 44975,1 44993,0 45011,1 45065,0 45070,1 45126,0 45157,1 45236,0 45313,1 45336,0 45360,1 45388,0 45425,1 45452,0 45496,1 45510,0 45542,1 45577,0 45643,1 45731,0 45815,1 45846,0 45912,1 45980,0 46046,1 46067,0 46086,1 46120,0 46208,1 46237,0 46288,1 46331,0 46380,1 46433,0 46510,1 46552,0 46561,1 46562,0 46604,1 46634,0 46733,1 46768,0 46791,1 46803,0 46884,1 46966,0 47018,1 47065,0 47086,1 47130,0 47191,1 47263,0 47301,1 47315,0 47411,1 47454,0 47508,1 47515,0 47593,1 47642,0 47721,1 47788,0 47867,1 47889,0 47970,1 47971,0 48032,1 48115,0 48181,1 48270,0 48274,1 48336,0 48399,1 48468,0 48496,1 48536,0 48591,1 48618,0 48698,1 48795,0 48799,1 48892,0 48896,1 48957,0 49057,1 49157,0 49246,1 49330,0 49368,1 49462,0 49489,1 49557,0 49569,1 49584,0 49609,1 49670,0 49750,1 49816,0 49821,1 49849,0 49858,1 49939,0 49963,1 50024,0 50047,1 50053,0 50056,1 end initlist b27 0,0 80,1 84,0 90,1 178,0 238,1 245,0 264,1 276,0 282,1 297,0 332,1 390,0 448,1 454,0 534,1 584,0 626,1 698,0 768,1 854,0 922,1 932,0 934,1 973,0 976,1 990,0 1069,1 1107,0 1177,1 1240,0 1258,1 1296,0 1319,1 1368,0 1391,1 1414,0 1490,1 1528,0 1557,1 1594,0 1678,1 1711,0 1737,1 1742,0 1813,1 1838,0 1903,1 1973,0 2032,1 2037,0 2063,1 2144,0 2197,1 2253,0 2348,1 2441,0 2507,1 2569,0 2664,1 2762,0 2804,1 2895,0 2908,1 2930,0 2999,1 3031,0 3097,1 3129,0 3211,1 3263,0 3296,1 3356,0 3423,1 3447,0 3460,1 3541,0 3553,1 3567,0 3666,1 3710,0 3760,1 3854,0 3913,1 3998,0 4067,1 4104,0 4164,1 4217,0 4315,1 4382,0 4411,1 4493,0 4591,1 4637,0 4734,1 4751,0 4813,1 4904,0 4963,1 5038,0 5109,1 5185,0 5285,1 5350,0 5408,1 5498,0 5567,1 5576,0 5608,1 5639,0 5706,1 5788,0 5861,1 5863,0 5914,1 5987,0 5990,1 6002,0 6076,1 6176,0 6272,1 6309,0 6409,1 6491,0 6517,1 6562,0 6659,1 6749,0 6787,1 6811,0 6890,1 6953,0 6969,1 7019,0 7115,1 7127,0 7166,1 7191,0 7268,1 7366,0 7449,1 7502,0 7565,1 7615,0 7640,1 7652,0 7668,1 7688,0 7736,1 7755,0 7776,1 7874,0 7970,1 8062,0 8154,1 8165,0 8249,1 8284,0 8377,1 8427,0 8443,1 8523,0 8620,1 8708,0 8710,1 8744,0 8781,1 8877,0 8969,1 9035,0 9085,1 9091,0 9179,1 9249,0 9348,1 9350,0 9385,1 9419,0 9482,1 9506,0 9507,1 9518,0 9598,1 9672,0 9767,1 9780,0 9827,1 9912,0 9954,1 9961,0 9983,1 10016,0 10017,1 10053,0 10135,1 10225,0 10237,1 10265,0 10295,1 10309,0 10341,1 10435,0 10452,1 10457,0 10533,1 10593,0 10599,1 10694,0 10779,1 10798,0 10855,1 10932,0 10989,1 11011,0 11028,1 11063,0 11074,1 11130,0 11201,1 11232,0 11260,1 11353,0 11438,1 11444,0 11480,1 11489,0 11516,1 11523,0 11557,1 11615,0 11646,1 11744,0 11746,1 11773,0 11830,1 11924,0 11969,1 12062,0 12129,1 12154,0 12158,1 12182,0 12206,1 12261,0 12295,1 12327,0 12355,1 12441,0 12471,1 12560,0 12657,1 12725,0 12746,1 12782,0 12806,1 12818,0 12876,1 12922,0 12968,1 13032,0 13050,1 13124,0 13202,1 13274,0 13367,1 13429,0 13529,1 13537,0 13634,1 13645,0 13692,1 13745,0 13845,1 13941,0 13990,1 14060,0 14141,1 14208,0 14287,1 14373,0 14377,1 14477,0 14522,1 14532,0 14564,1 14608,0 14617,1 14646,0 14654,1 14707,0 14792,1 14838,0 14882,1 14895,0 14949,1 15022,0 15045,1 15055,0 15127,1 15208,0 15299,1 15334,0 15385,1 15446,0 15509,1 15513,0 15532,1 15563,0 15583,1 15669,0 15766,1 15859,0 15887,1 15909,0 15963,1 16007,0 16055,1 16064,0 16151,1 16230,0 16276,1 16279,0 16290,1 16300,0 16359,1 16438,0 16462,1 16552,0 16587,1 16667,0 16679,1 16680,0 16752,1 16796,0 16874,1 16950,0 16951,1 17039,0 17097,1 17159,0 17237,1 17251,0 17318,1 17377,0 17447,1 17482,0 17490,1 17523,0 17581,1 17599,0 17644,1 17691,0 17707,1 17788,0 17796,1 17877,0 17888,1 17973,0 18068,1 18136,0 18195,1 18250,0 18277,1 18297,0 18316,1 18408,0 18411,1 18450,0 18500,1 18561,0 18571,1 18614,0 18662,1 18718,0 18788,1 18803,0 18883,1 18966,0 18992,1 19083,0 19121,1 19146,0 19183,1 19232,0 19250,1 19256,0 19310,1 19394,0 19442,1 19453,0 19506,1 19543,0 19636,1 19651,0 19675,1 19734,0 19804,1 19893,0 19954,1 20000,0 20016,1 20035,0 20050,1 20148,0 20186,1 20245,0 20275,1 20370,0 20422,1 20488,0 20539,1 20622,0 20646,1 20664,0 20689,1 20701,0 20734,1 20830,0 20839,1 20908,0 20941,1 20964,0 20990,1 21089,0 21138,1 21196,0 21276,1 21343,0 21410,1 21429,0 21487,1 21507,0 21604,1 21614,0 21637,1 21645,0 21699,1 21759,0 21767,1 21823,0 21888,1 21936,0 21945,1 22042,0 22081,1 22119,0 22193,1 22195,0 22243,1 22247,0 22322,1 22380,0 22389,1 22401,0 22423,1 22464,0 22473,1 22537,0 22621,1 22688,0 22757,1 22788,0 22856,1 22920,0 22948,1 22964,0 22978,1 23052,0 23122,1 23190,0 23283,1 23323,0 23399,1 23439,0 23495,1 23539,0 23553,1 23564,0 23638,1 23701,0 23740,1 23838,0 23915,1 24013,0 24089,1 24181,0 24273,1 24280,0 24341,1 24395,0 24416,1 24486,0 24579,1 24636,0 24718,1 24762,0 24770,1 24854,0 24904,1 25002,0 25026,1 25072,0 25121,1 25149,0 25248,1 25252,0 25351,1 25376,0 25434,1 25446,0 25461,1 25469,0 25524,1 25544,0 25553,1 25581,0 25616,1 25633,0 25700,1 25798,0 25831,1 25929,0 25960,1 26026,0 26056,1 26059,0 26086,1 26138,0 26197,1 26271,0 26302,1 26326,0 26339,1 26363,0 26423,1 26463,0 26482,1 26503,0 26518,1 26550,0 26570,1 26622,0 26695,1 26709,0 26767,1 26842,0 26846,1 26900,0 26931,1 26990,0 27015,1 27047,0 27058,1 27073,0 27075,1 27158,0 27228,1 27306,0 27345,1 27444,0 27496,1 27554,0 27639,1 27728,0 27737,1 27741,0 27766,1 27786,0 27798,1 27886,0 27912,1 27921,0 27930,1 27931,0 28001,1 28078,0 28140,1 28149,0 28217,1 28262,0 28329,1 28333,0 28361,1 28383,0 28442,1 28467,0 28509,1 28537,0 28552,1 28641,0 28651,1 28738,0 28818,1 28852,0 28918,1 28954,0 29026,1 29034,0 29086,1 29155,0 29244,1 29327,0 29412,1 29463,0 29465,1 29488,0 29526,1 29593,0 29621,1 29635,0 29671,1 29692,0 29707,1 29712,0 29799,1 29823,0 29833,1 29919,0 30007,1 30103,0 30106,1 30173,0 30257,1 30271,0 30358,1 30451,0 30530,1 30570,0 30653,1 30661,0 30669,1 30744,0 30791,1 30838,0 30852,1 30921,0 31020,1 31078,0 31123,1 31161,0 31228,1 31254,0 31354,1 31432,0 31532,1 31594,0 31597,1 31601,0 31678,1 31766,0 31858,1 31913,0 31924,1 31993,0 32028,1 32084,0 32130,1 32224,0 32240,1 32332,0 32410,1 32412,0 32475,1 32546,0 32591,1 32632,0 32687,1 32762,0 32844,1 32848,0 32889,1 32938,0 33025,1 33066,0 33114,1 33212,0 33296,1 33350,0 33381,1 33446,0 33470,1 33505,0 33544,1 33546,0 33624,1 33637,0 33718,1 33798,0 33802,1 33805,0 33828,1 33924,0 33931,1 34009,0 34095,1 34100,0 34185,1 34206,0 34275,1 34329,0 34346,1 34407,0 34468,1 34501,0 34554,1 34586,0 34667,1 34760,0 34772,1 34864,0 34887,1 34892,0 34950,1 35027,0 35077,1 35078,0 35174,1 35252,0 35347,1 35385,0 35442,1 35478,0 35547,1 35577,0 35655,1 35670,0 35716,1 35751,0 35778,1 35868,0 35916,1 35963,0 36017,1 36081,0 36123,1 36199,0 36293,1 36378,0 36423,1 36466,0 36540,1 36576,0 36668,1 36695,0 36775,1 36809,0 36821,1 36903,0 36934,1 36976,0 37021,1 37112,0 37118,1 37175,0 37229,1 37241,0 37278,1 37354,0 37409,1 37435,0 37531,1 37589,0 37673,1 37687,0 37760,1 37836,0 37841,1 37889,0 37903,1 37926,0 37954,1 38016,0 38034,1 38058,0 38115,1 38192,0 38253,1 38324,0 38419,1 38445,0 38457,1 38549,0 38570,1 38582,0 38621,1 38712,0 38731,1 38767,0 38805,1 38844,0 38863,1 38953,0 38981,1 39068,0 39108,1 39125,0 39153,1 39234,0 39284,1 39325,0 39388,1 39454,0 39542,1 39594,0 39669,1 39737,0 39742,1 39789,0 39864,1 39927,0 40019,1 40033,0 40076,1 40137,0 40148,1 40166,0 40261,1 40351,0 40440,1 40449,0 40488,1 40505,0 40544,1 40558,0 40571,1 40617,0 40698,1 40782,0 40823,1 40853,0 40861,1 40922,0 40927,1 40999,0 41034,1 41133,0 41182,1 41247,0 41285,1 41380,0 41438,1 41447,0 41501,1 41564,0 41649,1 41693,0 41745,1 41833,0 41887,1 41901,0 41920,1 41978,0 42067,1 42089,0 42091,1 42123,0 42195,1 42239,0 42249,1 42339,0 42427,1 42514,0 42528,1 42555,0 42592,1 42601,0 42646,1 42693,0 42706,1 42772,0 42812,1 42845,0 42868,1 42908,0 42951,1 42966,0 43029,1 43065,0 43092,1 43192,0 43195,1 43252,0 43333,1 43379,0 43424,1 43434,0 43475,1 43568,0 43600,1 43676,0 43740,1 43751,0 43790,1 43814,0 43852,1 43871,0 43895,1 43910,0 43947,1 43962,0 44024,1 44096,0 44114,1 44146,0 44245,1 44322,0 44396,1 44419,0 44465,1 44521,0 44570,1 44633,0 44670,1 44768,0 44812,1 44857,0 44937,1 45012,0 45086,1 45153,0 45187,1 45237,0 45248,1 45259,0 45345,1 45376,0 45406,1 45449,0 45521,1 45606,0 45674,1 45773,0 45851,1 45930,0 46002,1 46095,0 46122,1 46198,0 46287,1 46381,0 46428,1 46516,0 46591,1 46655,0 46689,1 46785,0 46786,1 46813,0 46833,1 46857,0 46868,1 46912,0 46951,1 46975,0 46984,1 47075,0 47106,1 47165,0 47194,1 47231,0 47247,1 47294,0 47295,1 47300,0 47362,1 47411,0 47451,1 47494,0 47580,1 47608,0 47617,1 47632,0 47729,1 47735,0 47757,1 47762,0 47818,1 47820,0 47907,1 47919,0 47987,1 48085,0 48139,1 48222,0 48294,1 48317,0 48387,1 48457,0 48512,1 48593,0 48674,1 48765,0 48821,1 48890,0 48981,1 49056,0 49115,1 49158,0 49224,1 49312,0 49381,1 end initlist b28 0,0 51,1 70,0 116,1 154,0 177,1 184,0 253,1 290,0 315,1 359,0 385,1 449,0 528,1 571,0 612,1 669,0 737,1 813,0 850,1 902,0 997,1 1025,0 1048,1 1145,0 1195,1 1233,0 1283,1 1346,0 1412,1 1458,0 1546,1 1631,0 1655,1 1693,0 1790,1 1882,0 1896,1 1981,0 2039,1 2129,0 2139,1 2219,0 2248,1 2276,0 2311,1 2326,0 2379,1 2472,0 2555,1 2565,0 2592,1 2639,0 2673,1 2772,0 2823,1 2870,0 2907,1 2967,0 2976,1 2989,0 3063,1 3159,0 3166,1 3194,0 3216,1 3230,0 3291,1 3343,0 3419,1 3438,0 3513,1 3515,0 3581,1 3647,0 3686,1 3723,0 3783,1 3879,0 3885,1 3909,0 3927,1 3965,0 4038,1 4102,0 4130,1 4202,0 4233,1 4243,0 4285,1 4323,0 4381,1 4446,0 4452,1 4453,0 4520,1 4573,0 4672,1 4680,0 4728,1 4771,0 4823,1 4863,0 4935,1 4983,0 4998,1 5036,0 5072,1 5162,0 5209,1 5223,0 5273,1 5315,0 5361,1 5458,0 5534,1 5631,0 5695,1 5743,0 5836,1 5879,0 5951,1 6029,0 6124,1 6183,0 6251,1 6335,0 6414,1 6442,0 6495,1 6497,0 6557,1 6563,0 6654,1 6698,0 6736,1 6823,0 6908,1 6942,0 7002,1 7006,0 7063,1 7103,0 7105,1 7198,0 7276,1 7322,0 7376,1 7400,0 7402,1 7486,0 7521,1 7525,0 7583,1 7622,0 7640,1 7699,0 7739,1 7788,0 7877,1 7973,0 8029,1 8126,0 8196,1 8250,0 8332,1 8410,0 8473,1 8567,0 8591,1 8620,0 8704,1 8801,0 8822,1 8873,0 8972,1 8982,0 9033,1 9046,0 9062,1 9077,0 9168,1 9210,0 9230,1 9299,0 9307,1 9394,0 9406,1 9500,0 9542,1 9603,0 9695,1 9700,0 9764,1 9800,0 9854,1 9910,0 9926,1 9991,0 10021,1 10077,0 10140,1 10154,0 10240,1 10249,0 10283,1 10310,0 10346,1 10399,0 10432,1 10444,0 10447,1 10542,0 10577,1 10677,0 10706,1 10741,0 10788,1 10800,0 10882,1 10941,0 10960,1 11046,0 11108,1 11160,0 11241,1 11251,0 11260,1 11340,0 11362,1 11375,0 11469,1 11482,0 11573,1 11641,0 11736,1 11833,0 11924,1 11980,0 12030,1 12105,0 12111,1 12164,0 12226,1 12323,0 12393,1 12469,0 12492,1 12585,0 12675,1 12742,0 12806,1 12841,0 12929,1 12993,0 13046,1 13145,0 13162,1 13261,0 13297,1 13372,0 13404,1 13469,0 13551,1 13612,0 13704,1 13779,0 13818,1 13896,0 13908,1 13997,0 14095,1 14181,0 14240,1 14261,0 14344,1 14411,0 14489,1 14504,0 14557,1 14651,0 14749,1 14824,0 14901,1 14954,0 15052,1 15115,0 15126,1 15221,0 15308,1 15399,0 15404,1 15413,0 15440,1 15476,0 15556,1 15651,0 15729,1 15765,0 15823,1 15870,0 15970,1 16062,0 16134,1 16195,0 16259,1 16310,0 16383,1 16448,0 16464,1 16554,0 16633,1 16704,0 16770,1 16828,0 16886,1 16972,0 17032,1 17078,0 17143,1 17218,0 17233,1 17266,0 17353,1 17395,0 17495,1 17584,0 17635,1 17664,0 17761,1 17784,0 17809,1 17844,0 17938,1 17993,0 18009,1 18043,0 18102,1 18169,0 18259,1 18271,0 18363,1 18424,0 18468,1 18533,0 18628,1 18659,0 18695,1 18780,0 18863,1 18883,0 18902,1 18968,0 19045,1 19113,0 19180,1 19248,0 19254,1 19350,0 19373,1 19413,0 19445,1 19472,0 19509,1 19561,0 19627,1 19720,0 19796,1 19829,0 19846,1 19869,0 19878,1 19911,0 19953,1 20010,0 20064,1 20070,0 20169,1 20186,0 20279,1 20312,0 20395,1 20410,0 20439,1 20505,0 20542,1 20636,0 20653,1 20722,0 20756,1 20797,0 20816,1 20910,0 20986,1 21041,0 21046,1 21105,0 21201,1 21205,0 21253,1 21261,0 21283,1 21291,0 21357,1 21413,0 21472,1 21478,0 21488,1 21583,0 21674,1 21707,0 21765,1 21824,0 21924,1 21953,0 22041,1 22074,0 22113,1 22131,0 22199,1 22258,0 22315,1 22320,0 22383,1 22481,0 22577,1 22591,0 22607,1 22637,0 22734,1 22756,0 22821,1 22921,0 22944,1 22988,0 22997,1 23090,0 23119,1 23213,0 23261,1 23304,0 23310,1 23400,0 23487,1 23545,0 23631,1 23635,0 23712,1 23756,0 23842,1 23870,0 23893,1 23931,0 23937,1 24036,0 24046,1 24082,0 24156,1 24201,0 24301,1 24351,0 24371,1 24399,0 24483,1 24487,0 24496,1 24554,0 24601,1 24687,0 24696,1 24770,0 24802,1 24809,0 24817,1 24887,0 24975,1 25047,0 25144,1 25221,0 25260,1 25328,0 25392,1 25450,0 25526,1 25544,0 25574,1 25644,0 25711,1 25735,0 25776,1 25823,0 25884,1 25975,0 25984,1 26037,0 26042,1 26103,0 26154,1 26197,0 26294,1 26327,0 26347,1 26444,0 26499,1 26585,0 26608,1 26621,0 26639,1 26721,0 26783,1 26839,0 26858,1 26866,0 26938,1 27015,0 27092,1 27171,0 27239,1 27301,0 27334,1 27389,0 27468,1 27517,0 27535,1 27567,0 27604,1 27641,0 27730,1 27790,0 27857,1 27949,0 27977,1 28051,0 28130,1 28230,0 28320,1 28338,0 28403,1 28484,0 28513,1 28575,0 28633,1 28702,0 28722,1 28778,0 28862,1 28925,0 29020,1 29112,0 29125,1 29173,0 29203,1 29267,0 29291,1 29363,0 29372,1 29425,0 29510,1 29593,0 29613,1 29675,0 29733,1 29760,0 29772,1 29842,0 29882,1 29890,0 29942,1 29975,0 30065,1 30104,0 30198,1 30232,0 30283,1 30325,0 30353,1 30364,0 30382,1 30390,0 30425,1 30487,0 30584,1 30598,0 30651,1 30724,0 30760,1 30799,0 30804,1 30879,0 30888,1 30958,0 31013,1 31041,0 31102,1 31189,0 31246,1 31274,0 31363,1 31364,0 31375,1 31377,0 31408,1 31505,0 31578,1 31673,0 31729,1 31780,0 31832,1 31856,0 31898,1 31904,0 31949,1 32001,0 32049,1 32072,0 32082,1 32149,0 32217,1 32291,0 32375,1 32451,0 32501,1 32561,0 32580,1 32665,0 32746,1 32773,0 32837,1 32860,0 32896,1 32989,0 33001,1 33050,0 33121,1 33210,0 33267,1 33309,0 33360,1 33459,0 33496,1 33593,0 33678,1 33746,0 33825,1 33843,0 33923,1 33943,0 34028,1 34077,0 34175,1 34230,0 34251,1 34296,0 34323,1 34375,0 34466,1 34542,0 34577,1 34650,0 34701,1 34772,0 34829,1 34904,0 34951,1 35011,0 35108,1 35207,0 35267,1 35332,0 35352,1 35420,0 35511,1 35513,0 35597,1 35622,0 35679,1 35704,0 35766,1 35786,0 35869,1 35885,0 35957,1 36005,0 36039,1 36062,0 36137,1 36185,0 36223,1 36286,0 36354,1 36430,0 36442,1 36536,0 36583,1 36647,0 36686,1 36736,0 36823,1 36850,0 36942,1 36991,0 37040,1 37137,0 37214,1 37286,0 37317,1 37376,0 37449,1 37531,0 37535,1 37577,0 37587,1 37615,0 37710,1 37805,0 37851,1 37925,0 37998,1 38055,0 38087,1 38097,0 38195,1 38225,0 38264,1 38303,0 38321,1 38349,0 38422,1 38451,0 38532,1 38540,0 38603,1 38630,0 38667,1 38704,0 38730,1 38828,0 38899,1 38915,0 39015,1 39065,0 39098,1 39124,0 39150,1 39238,0 39282,1 39375,0 39376,1 39423,0 39427,1 39434,0 39452,1 39467,0 39487,1 39585,0 39659,1 39746,0 39845,1 39853,0 39890,1 39914,0 39996,1 40057,0 40141,1 40199,0 40281,1 40307,0 40327,1 40427,0 40513,1 40561,0 40611,1 40681,0 40767,1 40851,0 40878,1 40894,0 40921,1 40936,0 40939,1 41003,0 41018,1 41025,0 41096,1 41122,0 41159,1 41246,0 41278,1 41292,0 41383,1 41403,0 41419,1 41426,0 41476,1 41477,0 41570,1 41619,0 41686,1 41736,0 41822,1 41832,0 41862,1 41908,0 41935,1 41999,0 42079,1 42130,0 42151,1 42192,0 42249,1 42280,0 42284,1 42286,0 42293,1 42297,0 42394,1 42402,0 42467,1 42506,0 42557,1 42602,0 42624,1 42677,0 42770,1 42839,0 42852,1 42923,0 43003,1 43101,0 43124,1 43139,0 43204,1 43225,0 43284,1 43375,0 43403,1 43468,0 43488,1 43546,0 43560,1 43635,0 43718,1 43783,0 43795,1 43799,0 43820,1 43915,0 43939,1 44026,0 44076,1 44143,0 44155,1 44221,0 44275,1 44317,0 44319,1 44326,0 44403,1 44450,0 44484,1 44577,0 44672,1 44678,0 44767,1 44821,0 44832,1 44931,0 44982,1 44989,0 45058,1 45067,0 45159,1 45178,0 45208,1 45262,0 45320,1 45398,0 45457,1 45499,0 45537,1 45586,0 45647,1 45658,0 45743,1 45759,0 45851,1 45903,0 45993,1 46050,0 46111,1 46167,0 46257,1 46274,0 46360,1 46428,0 46467,1 46558,0 46627,1 46716,0 46757,1 46804,0 46859,1 46939,0 46964,1 47006,0 47097,1 47143,0 47211,1 47237,0 47335,1 47364,0 47374,1 47393,0 47398,1 47437,0 47489,1 47529,0 47578,1 47594,0 47626,1 47662,0 47676,1 47746,0 47747,1 47767,0 47867,1 47925,0 47929,1 47950,0 48036,1 48074,0 48117,1 48173,0 48226,1 48246,0 48302,1 48394,0 48433,1 48525,0 48536,1 48599,0 48641,1 48667,0 48736,1 48827,0 48838,1 48902,0 48944,1 48982,0 48985,1 49083,0 49133,1 49164,0 49236,1 49249,0 49255,1 49350,0 49413,1 49443,0 49469,1 49525,0 49619,1 49685,0 49687,1 49719,0 49810,1 49893,0 49905,1 49988,0 50072,1 50161,0 50201,1 50272,0 50331,1 50334,0 50397,1 50436,0 50467,1 50477,0 50536,1 50587,0 50604,1 50617,0 50704,1 50802,0 50894,1 50933,0 50958,1 50977,0 51028,1 51118,0 51161,1 51220,0 51283,1 51284,0 51341,1 51425,0 51461,1 51505,0 51513,1 51525,0 51574,1 end initlist b29 0,0 8,1 19,0 48,1 118,0 158,1 221,0 298,1 317,0 404,1 416,0 475,1 532,0 590,1 680,0 693,1 713,0 748,1 797,0 892,1 975,0 1054,1 1074,0 1117,1 1173,0 1249,1 1341,0 1384,1 1390,0 1455,1 1522,0 1579,1 1675,0 1743,1 1744,0 1836,1 1847,0 1940,1 2007,0 2012,1 2037,0 2066,1 2106,0 2119,1 2173,0 2184,1 2229,0 2250,1 2299,0 2380,1 2439,0 2503,1 2534,0 2561,1 2638,0 2717,1 2745,0 2758,1 2836,0 2876,1 2934,0 2969,1 2997,0 3094,1 3162,0 3176,1 3270,0 3311,1 3359,0 3418,1 3450,0 3548,1 3608,0 3635,1 3678,0 3751,1 3835,0 3873,1 3889,0 3939,1 4037,0 4079,1 4117,0 4138,1 4231,0 4270,1 4274,0 4353,1 4376,0 4404,1 4472,0 4481,1 4486,0 4544,1 4632,0 4650,1 4731,0 4756,1 4833,0 4911,1 4984,0 5067,1 5082,0 5170,1 5256,0 5284,1 5382,0 5472,1 5558,0 5623,1 5663,0 5675,1 5759,0 5778,1 5790,0 5881,1 5962,0 6015,1 6092,0 6179,1 6192,0 6223,1 6317,0 6377,1 6385,0 6406,1 6417,0 6458,1 6491,0 6516,1 6613,0 6710,1 6755,0 6837,1 6883,0 6966,1 7040,0 7078,1 7172,0 7255,1 7342,0 7407,1 7438,0 7516,1 7541,0 7567,1 7653,0 7669,1 7740,0 7760,1 7814,0 7852,1 7889,0 7932,1 7934,0 8015,1 8110,0 8123,1 8204,0 8240,1 8301,0 8334,1 8362,0 8462,1 8477,0 8480,1 8576,0 8655,1 8735,0 8814,1 8857,0 8929,1 9011,0 9015,1 9048,0 9082,1 9108,0 9141,1 9148,0 9151,1 9224,0 9293,1 9374,0 9411,1 9496,0 9504,1 9604,0 9704,1 9764,0 9775,1 9800,0 9853,1 9870,0 9887,1 9889,0 9975,1 10072,0 10163,1 10251,0 10262,1 10360,0 10416,1 10431,0 10524,1 10532,0 10535,1 10614,0 10627,1 10721,0 10750,1 10772,0 10850,1 10909,0 10993,1 11062,0 11065,1 11137,0 11167,1 11208,0 11290,1 11375,0 11403,1 11475,0 11519,1 11613,0 11688,1 11736,0 11821,1 11844,0 11850,1 11851,0 11855,1 11879,0 11959,1 12002,0 12081,1 12161,0 12221,1 12233,0 12242,1 12285,0 12339,1 12405,0 12408,1 12417,0 12487,1 12572,0 12592,1 12659,0 12747,1 12763,0 12854,1 12892,0 12917,1 13007,0 13014,1 13075,0 13105,1 13201,0 13274,1 13313,0 13348,1 13366,0 13415,1 13420,0 13515,1 13571,0 13591,1 13612,0 13700,1 13701,0 13767,1 13795,0 13843,1 13881,0 13883,1 13904,0 13938,1 13957,0 14025,1 14034,0 14128,1 14220,0 14294,1 14302,0 14386,1 14440,0 14448,1 14514,0 14566,1 14656,0 14673,1 14765,0 14828,1 14890,0 14975,1 15070,0 15135,1 15220,0 15305,1 15352,0 15366,1 15387,0 15435,1 15498,0 15571,1 15588,0 15633,1 15668,0 15714,1 15771,0 15831,1 15908,0 15926,1 15968,0 15991,1 15992,0 16040,1 16131,0 16167,1 16198,0 16283,1 16346,0 16360,1 16413,0 16450,1 16529,0 16541,1 16627,0 16694,1 16786,0 16819,1 16873,0 16964,1 16993,0 17078,1 17151,0 17204,1 17260,0 17305,1 17331,0 17359,1 17390,0 17440,1 17485,0 17546,1 17583,0 17636,1 17712,0 17728,1 17786,0 17815,1 17833,0 17848,1 17871,0 17929,1 17964,0 18048,1 18058,0 18063,1 18129,0 18168,1 18240,0 18313,1 18369,0 18442,1 18448,0 18450,1 18478,0 18558,1 18583,0 18597,1 18695,0 18706,1 18787,0 18841,1 18937,0 19029,1 19055,0 19110,1 19164,0 19178,1 19179,0 19215,1 19315,0 19343,1 19441,0 19532,1 19578,0 19607,1 19617,0 19673,1 19711,0 19747,1 19828,0 19849,1 19877,0 19881,1 19975,0 19994,1 20006,0 20050,1 20076,0 20100,1 20161,0 20184,1 20272,0 20311,1 20330,0 20365,1 20433,0 20505,1 20555,0 20563,1 20606,0 20663,1 20749,0 20771,1 20773,0 20869,1 20900,0 20964,1 21021,0 21039,1 21107,0 21147,1 21185,0 21192,1 21288,0 21355,1 21450,0 21491,1 21561,0 21589,1 21645,0 21680,1 21687,0 21739,1 21761,0 21786,1 21846,0 21864,1 21931,0 21976,1 22064,0 22072,1 22119,0 22122,1 22181,0 22281,1 22328,0 22396,1 22454,0 22466,1 22467,0 22551,1 22648,0 22732,1 22777,0 22853,1 22883,0 22934,1 23003,0 23013,1 23113,0 23137,1 23185,0 23213,1 23275,0 23309,1 23368,0 23428,1 23494,0 23569,1 23616,0 23701,1 23741,0 23746,1 23766,0 23812,1 23883,0 23904,1 23983,0 24004,1 24091,0 24144,1 24156,0 24220,1 24298,0 24321,1 24412,0 24449,1 24546,0 24620,1 24715,0 24773,1 24784,0 24805,1 24860,0 24959,1 24998,0 25010,1 25026,0 25028,1 25103,0 25112,1 25149,0 25160,1 25202,0 25301,1 25385,0 25474,1 25519,0 25551,1 25620,0 25703,1 25787,0 25824,1 25887,0 25977,1 26058,0 26074,1 26146,0 26158,1 26160,0 26186,1 26214,0 26224,1 26256,0 26260,1 26275,0 26337,1 26410,0 26439,1 26491,0 26564,1 26565,0 26566,1 26659,0 26677,1 26711,0 26774,1 26866,0 26887,1 26923,0 26979,1 27000,0 27023,1 27048,0 27104,1 27115,0 27142,1 27164,0 27232,1 27316,0 27343,1 27437,0 27506,1 27525,0 27623,1 27713,0 27743,1 27800,0 27816,1 27869,0 27956,1 28043,0 28071,1 28134,0 28231,1 28262,0 28273,1 28360,0 28455,1 28462,0 28555,1 28556,0 28620,1 28651,0 28710,1 28741,0 28755,1 28777,0 28793,1 28854,0 28928,1 28976,0 28979,1 29043,0 29097,1 29132,0 29151,1 29181,0 29202,1 29289,0 29304,1 29337,0 29378,1 29470,0 29559,1 29576,0 29598,1 29693,0 29756,1 29800,0 29811,1 29838,0 29916,1 29942,0 30042,1 30111,0 30124,1 30128,0 30176,1 30256,0 30264,1 30283,0 30303,1 30305,0 30405,1 30406,0 30506,1 30542,0 30549,1 30563,0 30588,1 30606,0 30607,1 30650,0 30707,1 30797,0 30890,1 30914,0 30994,1 31034,0 31085,1 31129,0 31151,1 31231,0 31292,1 31351,0 31443,1 31458,0 31493,1 31585,0 31633,1 31680,0 31723,1 31790,0 31883,1 31898,0 31944,1 31996,0 32077,1 32135,0 32185,1 32240,0 32337,1 32420,0 32471,1 32551,0 32560,1 32589,0 32602,1 32622,0 32709,1 32756,0 32757,1 32835,0 32884,1 32934,0 32936,1 32946,0 32958,1 32969,0 33044,1 33098,0 33126,1 33142,0 33163,1 33199,0 33245,1 33328,0 33352,1 33374,0 33459,1 33507,0 33523,1 33558,0 33605,1 33683,0 33756,1 33759,0 33797,1 33870,0 33956,1 33987,0 34069,1 34120,0 34141,1 34155,0 34186,1 34277,0 34307,1 34354,0 34386,1 34452,0 34484,1 34537,0 34633,1 34727,0 34731,1 34732,0 34801,1 34845,0 34895,1 34987,0 35066,1 35073,0 35098,1 35148,0 35159,1 35164,0 35191,1 35283,0 35328,1 35388,0 35402,1 35483,0 35553,1 35562,0 35606,1 35654,0 35718,1 35779,0 35797,1 35854,0 35871,1 35957,0 35995,1 36042,0 36124,1 36224,0 36248,1 36325,0 36345,1 36408,0 36413,1 36489,0 36527,1 36614,0 36653,1 36703,0 36791,1 36829,0 36918,1 36947,0 37004,1 37076,0 37156,1 37203,0 37253,1 37324,0 37375,1 37420,0 37451,1 37492,0 37575,1 37593,0 37614,1 37664,0 37699,1 37716,0 37767,1 37846,0 37864,1 37959,0 38018,1 38067,0 38120,1 38209,0 38299,1 38394,0 38480,1 38580,0 38678,1 38761,0 38798,1 38836,0 38854,1 38940,0 38962,1 38975,0 39045,1 39140,0 39149,1 39237,0 39309,1 39392,0 39455,1 39478,0 39495,1 39505,0 39578,1 39660,0 39746,1 39778,0 39843,1 39935,0 39972,1 40011,0 40031,1 40091,0 40109,1 40154,0 40159,1 40189,0 40198,1 40270,0 40363,1 40402,0 40459,1 40484,0 40521,1 40586,0 40654,1 40726,0 40817,1 40837,0 40875,1 40916,0 40947,1 40962,0 40995,1 41040,0 41048,1 41107,0 41158,1 41231,0 41288,1 41364,0 41464,1 41474,0 41532,1 41583,0 41666,1 41694,0 41729,1 41751,0 41831,1 41876,0 41951,1 42020,0 42096,1 42188,0 42227,1 42308,0 42348,1 42431,0 42441,1 42445,0 42532,1 42560,0 42638,1 42717,0 42738,1 42767,0 42787,1 42791,0 42814,1 42902,0 42963,1 42975,0 43016,1 43079,0 43145,1 43171,0 43174,1 43196,0 43205,1 43273,0 43352,1 43415,0 43419,1 43437,0 43460,1 43473,0 43513,1 43588,0 43685,1 43757,0 43782,1 43847,0 43910,1 43963,0 43991,1 44037,0 44063,1 44122,0 44150,1 44153,0 44164,1 44194,0 44224,1 44295,0 44358,1 44390,0 44489,1 44513,0 44558,1 44577,0 44582,1 44660,0 44674,1 44688,0 44719,1 44744,0 44825,1 44874,0 44965,1 44992,0 45035,1 45088,0 45168,1 45220,0 45236,1 45328,0 45363,1 45413,0 45414,1 45509,0 45541,1 45584,0 45616,1 45626,0 45719,1 45730,0 45824,1 45887,0 45921,1 46006,0 46094,1 46194,0 46287,1 46343,0 46380,1 46433,0 46446,1 46538,0 46575,1 46603,0 46651,1 46711,0 46756,1 46784,0 46884,1 46973,0 46984,1 47022,0 47024,1 47120,0 47129,1 47193,0 47238,1 47265,0 47350,1 47380,0 47478,1 47501,0 47520,1 47543,0 47571,1 47641,0 47728,1 47749,0 47795,1 47812,0 47878,1 47905,0 47913,1 47979,0 48055,1 48097,0 48190,1 48214,0 48242,1 48287,0 48306,1 48343,0 48416,1 48493,0 48576,1 48663,0 48739,1 48808,0 48862,1 48942,0 49018,1 49028,0 49063,1 49156,0 49212,1 end initlist b30 0,0 79,1 97,0 140,1 152,0 198,1 242,0 330,1 408,0 443,1 462,0 485,1 536,0 598,1 677,0 684,1 740,0 802,1 884,0 931,1 949,0 995,1 1009,0 1067,1 1104,0 1169,1 1240,0 1328,1 1373,0 1425,1 1435,0 1481,1 1525,0 1527,1 1559,0 1611,1 1698,0 1794,1 1836,0 1871,1 1887,0 1969,1 2030,0 2064,1 2139,0 2163,1 2204,0 2263,1 2301,0 2352,1 2411,0 2444,1 2470,0 2499,1 2518,0 2584,1 2603,0 2650,1 2667,0 2702,1 2743,0 2749,1 2751,0 2849,1 2943,0 2983,1 3017,0 3072,1 3078,0 3116,1 3144,0 3228,1 3299,0 3356,1 3434,0 3464,1 3557,0 3582,1 3598,0 3650,1 3677,0 3688,1 3732,0 3756,1 3856,0 3873,1 3919,0 4010,1 4042,0 4131,1 4219,0 4293,1 4389,0 4460,1 4527,0 4620,1 4654,0 4679,1 4751,0 4809,1 4857,0 4955,1 5007,0 5072,1 5152,0 5162,1 5232,0 5270,1 5347,0 5442,1 5478,0 5514,1 5551,0 5572,1 5636,0 5677,1 5739,0 5753,1 5838,0 5937,1 6026,0 6039,1 6101,0 6188,1 6244,0 6332,1 6360,0 6404,1 6426,0 6472,1 6546,0 6548,1 6615,0 6628,1 6668,0 6713,1 6806,0 6861,1 6949,0 6986,1 7080,0 7162,1 7197,0 7244,1 7296,0 7395,1 7466,0 7517,1 7556,0 7570,1 7576,0 7578,1 7607,0 7704,1 7789,0 7876,1 7880,0 7963,1 7972,0 8031,1 8090,0 8136,1 8179,0 8223,1 8309,0 8401,1 8477,0 8568,1 8631,0 8699,1 8726,0 8788,1 8794,0 8800,1 8822,0 8825,1 8887,0 8890,1 8938,0 8993,1 9076,0 9085,1 9174,0 9263,1 9348,0 9364,1 9457,0 9466,1 9505,0 9600,1 9662,0 9742,1 9801,0 9896,1 9983,0 9986,1 10044,0 10086,1 10168,0 10191,1 10289,0 10302,1 10391,0 10435,1 10474,0 10501,1 10569,0 10620,1 10702,0 10739,1 10832,0 10872,1 10957,0 11038,1 11104,0 11158,1 11198,0 11224,1 11244,0 11284,1 11340,0 11389,1 11416,0 11514,1 11545,0 11635,1 11703,0 11801,1 11842,0 11927,1 11974,0 12061,1 12097,0 12159,1 12213,0 12309,1 12387,0 12475,1 12537,0 12545,1 12549,0 12550,1 12571,0 12640,1 12661,0 12682,1 12737,0 12829,1 12863,0 12934,1 12978,0 13015,1 13084,0 13111,1 13207,0 13287,1 13298,0 13318,1 13393,0 13435,1 13466,0 13502,1 13570,0 13598,1 13694,0 13740,1 13839,0 13864,1 13909,0 13975,1 14054,0 14101,1 14126,0 14172,1 14215,0 14259,1 14348,0 14373,1 14391,0 14488,1 14544,0 14595,1 14601,0 14689,1 14735,0 14805,1 14806,0 14883,1 14889,0 14954,1 14965,0 15004,1 15019,0 15111,1 15152,0 15232,1 15266,0 15359,1 15407,0 15408,1 15496,0 15498,1 15521,0 15601,1 15615,0 15683,1 15743,0 15839,1 15923,0 15954,1 16048,0 16067,1 16160,0 16249,1 16331,0 16390,1 16472,0 16557,1 16570,0 16617,1 16705,0 16765,1 16785,0 16813,1 16891,0 16956,1 17008,0 17061,1 17140,0 17146,1 17208,0 17255,1 17319,0 17356,1 17428,0 17514,1 17570,0 17579,1 17619,0 17670,1 17728,0 17749,1 17813,0 17843,1 17904,0 17982,1 18003,0 18085,1 18168,0 18251,1 18314,0 18361,1 18365,0 18453,1 18467,0 18501,1 18535,0 18562,1 18588,0 18629,1 18713,0 18737,1 18786,0 18874,1 18901,0 18924,1 18927,0 18960,1 18989,0 18996,1 19000,0 19023,1 19045,0 19111,1 19208,0 19257,1 19343,0 19367,1 19397,0 19428,1 19519,0 19541,1 19608,0 19659,1 19693,0 19741,1 19782,0 19851,1 19856,0 19867,1 19945,0 19968,1 20015,0 20035,1 20066,0 20083,1 20093,0 20143,1 20165,0 20215,1 20276,0 20316,1 20414,0 20502,1 20535,0 20578,1 20597,0 20674,1 20753,0 20810,1 20853,0 20895,1 20916,0 20999,1 21083,0 21120,1 21178,0 21219,1 21282,0 21319,1 21351,0 21363,1 21383,0 21476,1 21530,0 21613,1 21638,0 21667,1 21687,0 21727,1 21795,0 21886,1 21910,0 21929,1 22003,0 22083,1 22103,0 22192,1 22256,0 22336,1 22390,0 22444,1 22458,0 22473,1 22507,0 22545,1 22620,0 22711,1 22798,0 22833,1 22899,0 22984,1 23014,0 23060,1 23125,0 23198,1 23279,0 23321,1 23395,0 23452,1 23465,0 23521,1 23552,0 23598,1 23601,0 23687,1 23743,0 23808,1 23906,0 23932,1 23982,0 24081,1 24123,0 24144,1 24157,0 24221,1 24244,0 24314,1 24402,0 24488,1 24575,0 24627,1 24705,0 24769,1 24837,0 24852,1 24942,0 25000,1 25031,0 25106,1 25205,0 25297,1 25391,0 25477,1 25506,0 25554,1 25653,0 25707,1 25725,0 25770,1 25788,0 25811,1 25854,0 25949,1 25994,0 26077,1 26115,0 26164,1 26207,0 26286,1 26335,0 26414,1 26484,0 26512,1 26544,0 26579,1 26588,0 26614,1 26616,0 26666,1 26690,0 26734,1 26736,0 26833,1 26926,0 26960,1 26972,0 26996,1 27012,0 27063,1 27103,0 27137,1 27146,0 27185,1 27219,0 27245,1 27334,0 27383,1 27407,0 27456,1 27498,0 27524,1 27610,0 27693,1 27783,0 27882,1 27906,0 27988,1 28046,0 28061,1 28119,0 28134,1 28154,0 28189,1 28274,0 28373,1 28438,0 28528,1 28554,0 28599,1 28674,0 28681,1 28765,0 28830,1 28883,0 28974,1 28983,0 29043,1 29059,0 29125,1 29206,0 29237,1 29281,0 29362,1 29406,0 29457,1 29550,0 29609,1 29627,0 29701,1 29784,0 29809,1 29891,0 29928,1 30028,0 30044,1 30068,0 30163,1 30229,0 30237,1 30329,0 30347,1 30362,0 30407,1 30449,0 30523,1 30573,0 30575,1 30616,0 30629,1 30708,0 30767,1 30790,0 30840,1 30870,0 30874,1 30918,0 30961,1 31036,0 31078,1 31132,0 31162,1 31200,0 31291,1 31340,0 31430,1 31503,0 31599,1 31656,0 31667,1 31721,0 31779,1 31833,0 31909,1 31933,0 31953,1 31964,0 31971,1 31996,0 32083,1 32141,0 32180,1 32247,0 32309,1 32331,0 32372,1 32445,0 32470,1 32502,0 32505,1 32601,0 32680,1 32772,0 32807,1 32863,0 32942,1 32996,0 33003,1 33053,0 33059,1 33085,0 33174,1 33241,0 33333,1 33377,0 33389,1 33435,0 33491,1 33522,0 33530,1 33543,0 33552,1 33599,0 33624,1 33665,0 33687,1 33743,0 33798,1 33868,0 33927,1 33993,0 34002,1 34004,0 34080,1 34149,0 34210,1 34262,0 34292,1 34347,0 34418,1 34453,0 34536,1 34576,0 34610,1 34637,0 34713,1 34720,0 34732,1 34761,0 34788,1 34843,0 34877,1 34970,0 35041,1 35069,0 35117,1 35215,0 35227,1 35314,0 35391,1 35417,0 35440,1 35441,0 35491,1 35494,0 35566,1 35654,0 35688,1 35778,0 35840,1 35940,0 36036,1 36129,0 36204,1 36283,0 36349,1 36359,0 36408,1 36455,0 36486,1 36533,0 36583,1 36667,0 36707,1 36711,0 36800,1 36865,0 36906,1 36948,0 37048,1 37073,0 37162,1 37200,0 37289,1 37297,0 37364,1 37422,0 37435,1 37447,0 37457,1 37520,0 37591,1 37615,0 37658,1 37683,0 37722,1 37752,0 37809,1 37869,0 37905,1 37945,0 38008,1 38065,0 38074,1 38104,0 38106,1 38200,0 38288,1 38335,0 38350,1 38440,0 38479,1 38505,0 38526,1 38555,0 38585,1 38671,0 38686,1 38700,0 38704,1 38712,0 38811,1 38845,0 38937,1 38975,0 38983,1 39004,0 39084,1 39149,0 39207,1 39264,0 39354,1 39414,0 39476,1 39515,0 39611,1 39655,0 39665,1 39738,0 39825,1 39831,0 39921,1 40000,0 40009,1 40085,0 40124,1 40208,0 40219,1 40236,0 40237,1 40291,0 40377,1 40456,0 40546,1 40637,0 40701,1 40779,0 40838,1 40869,0 40934,1 40970,0 40980,1 41009,0 41102,1 41173,0 41226,1 41290,0 41375,1 41453,0 41540,1 41622,0 41632,1 41637,0 41719,1 41733,0 41809,1 41816,0 41845,1 41880,0 41953,1 41965,0 42001,1 42007,0 42090,1 42141,0 42171,1 42240,0 42289,1 42342,0 42381,1 42385,0 42470,1 42502,0 42563,1 42589,0 42673,1 42710,0 42802,1 42849,0 42864,1 42869,0 42960,1 43031,0 43103,1 43167,0 43172,1 43177,0 43189,1 43194,0 43205,1 43249,0 43306,1 43399,0 43462,1 43510,0 43589,1 43646,0 43652,1 43726,0 43784,1 43835,0 43855,1 43899,0 43992,1 44035,0 44082,1 44108,0 44150,1 44245,0 44268,1 44295,0 44313,1 44383,0 44418,1 44516,0 44523,1 44576,0 44598,1 44659,0 44680,1 44721,0 44771,1 44814,0 44833,1 44906,0 44910,1 44988,0 45046,1 45108,0 45184,1 45267,0 45297,1 45343,0 45370,1 45406,0 45496,1 45575,0 45664,1 45679,0 45681,1 45731,0 45808,1 45844,0 45894,1 45909,0 46003,1 46031,0 46096,1 46120,0 46130,1 46195,0 46229,1 46230,0 46235,1 46303,0 46398,1 46471,0 46545,1 46636,0 46719,1 46811,0 46815,1 46866,0 46884,1 46943,0 47041,1 47140,0 47225,1 47235,0 47290,1 47385,0 47408,1 47437,0 47504,1 47598,0 47657,1 47676,0 47709,1 47773,0 47817,1 47836,0 47919,1 47921,0 47930,1 47964,0 48026,1 48073,0 48124,1 48155,0 48179,1 48185,0 48219,1 48227,0 48273,1 48348,0 48373,1 48391,0 48423,1 48517,0 48613,1 48666,0 48704,1 48763,0 48847,1 48901,0 48933,1 49017,0 49087,1 49103,0 49113,1 49176,0 49177,1 49276,0 49299,1 49374,0 49471,1 49473,0 49489,1 49574,0 49654,1 49705,0 49748,1 49752,0 49829,1 49904,0 49940,1 50023,0 50080,1 50164,0 50229,1 50290,0 50336,1 end initlist b31 0,0 83,1 174,0 176,1 222,0 304,1 380,0 445,1 447,0 478,1 491,0 591,1 685,0 747,1 811,0 879,1 895,0 949,1 986,0 990,1 1077,0 1119,1 1216,0 1242,1 1254,0 1336,1 1368,0 1441,1 1456,0 1523,1 1557,0 1582,1 1662,0 1748,1 1835,0 1836,1 1863,0 1923,1 1973,0 2038,1 2131,0 2226,1 2293,0 2302,1 2307,0 2392,1 2484,0 2491,1 2580,0 2665,1 2734,0 2816,1 2840,0 2847,1 2865,0 2936,1 2967,0 3023,1 3076,0 3155,1 3160,0 3259,1 3325,0 3342,1 3422,0 3462,1 3497,0 3519,1 3568,0 3614,1 3643,0 3741,1 3813,0 3886,1 3960,0 4029,1 4117,0 4157,1 4257,0 4313,1 4401,0 4437,1 4472,0 4508,1 4516,0 4521,1 4556,0 4608,1 4672,0 4701,1 4775,0 4861,1 4958,0 4977,1 5038,0 5103,1 5113,0 5156,1 5173,0 5174,1 5177,0 5224,1 5266,0 5341,1 5371,0 5444,1 5468,0 5540,1 5544,0 5594,1 5644,0 5661,1 5711,0 5783,1 5847,0 5863,1 5954,0 6030,1 6088,0 6152,1 6190,0 6279,1 6304,0 6372,1 6464,0 6563,1 6663,0 6671,1 6723,0 6780,1 6862,0 6916,1 6991,0 7010,1 7098,0 7133,1 7172,0 7242,1 7277,0 7317,1 7397,0 7405,1 7498,0 7563,1 7654,0 7655,1 7673,0 7715,1 7734,0 7772,1 7867,0 7870,1 7888,0 7985,1 8020,0 8100,1 8138,0 8221,1 8260,0 8333,1 8408,0 8416,1 8477,0 8536,1 8636,0 8726,1 8732,0 8798,1 8865,0 8872,1 8948,0 8960,1 9015,0 9057,1 9157,0 9243,1 9334,0 9405,1 9462,0 9506,1 9532,0 9567,1 9599,0 9691,1 9757,0 9843,1 9928,0 10004,1 10067,0 10140,1 10178,0 10255,1 10345,0 10445,1 10489,0 10552,1 10626,0 10670,1 10703,0 10757,1 10807,0 10828,1 10834,0 10922,1 10967,0 11007,1 11055,0 11104,1 11191,0 11199,1 11287,0 11340,1 11377,0 11453,1 11492,0 11560,1 11640,0 11654,1 11662,0 11737,1 11786,0 11812,1 11882,0 11976,1 12020,0 12105,1 12177,0 12245,1 12334,0 12354,1 12370,0 12385,1 12441,0 12470,1 12567,0 12613,1 12616,0 12638,1 12656,0 12743,1 12772,0 12806,1 12870,0 12957,1 13052,0 13063,1 13105,0 13176,1 13221,0 13235,1 13330,0 13378,1 13397,0 13491,1 13555,0 13601,1 13700,0 13744,1 13833,0 13874,1 13907,0 13989,1 14002,0 14058,1 14155,0 14206,1 14293,0 14300,1 14396,0 14471,1 14519,0 14521,1 14561,0 14585,1 14642,0 14740,1 14838,0 14938,1 14958,0 15049,1 15124,0 15214,1 15262,0 15331,1 15413,0 15491,1 15523,0 15575,1 15623,0 15651,1 15671,0 15766,1 15778,0 15779,1 15822,0 15841,1 15885,0 15982,1 16081,0 16161,1 16226,0 16252,1 16345,0 16430,1 16483,0 16527,1 16614,0 16622,1 16685,0 16709,1 16779,0 16802,1 16866,0 16875,1 16917,0 16991,1 17065,0 17096,1 17127,0 17142,1 17157,0 17169,1 17267,0 17269,1 17300,0 17304,1 17333,0 17393,1 17487,0 17564,1 17662,0 17716,1 17742,0 17832,1 17880,0 17944,1 17984,0 18010,1 18040,0 18042,1 18136,0 18220,1 18313,0 18392,1 18409,0 18453,1 18482,0 18571,1 18633,0 18694,1 18699,0 18757,1 18851,0 18951,1 18968,0 19046,1 19049,0 19089,1 19181,0 19186,1 19208,0 19292,1 19311,0 19377,1 19410,0 19457,1 19534,0 19588,1 19605,0 19631,1 19700,0 19723,1 19810,0 19855,1 19907,0 20007,1 20013,0 20023,1 20078,0 20139,1 20186,0 20281,1 20340,0 20432,1 20503,0 20551,1 20598,0 20691,1 20707,0 20717,1 20752,0 20790,1 20888,0 20891,1 20915,0 20934,1 21018,0 21115,1 21210,0 21261,1 21315,0 21336,1 21366,0 21375,1 21404,0 21474,1 21524,0 21563,1 21661,0 21713,1 21735,0 21800,1 21831,0 21871,1 21894,0 21945,1 22033,0 22078,1 22137,0 22195,1 22219,0 22235,1 22309,0 22384,1 22478,0 22562,1 22597,0 22677,1 22683,0 22729,1 22800,0 22820,1 22869,0 22952,1 23020,0 23058,1 23099,0 23188,1 23265,0 23296,1 23300,0 23327,1 23377,0 23390,1 23465,0 23467,1 23509,0 23549,1 23640,0 23641,1 23662,0 23697,1 23703,0 23775,1 23843,0 23909,1 23949,0 23994,1 24086,0 24103,1 24166,0 24231,1 24303,0 24322,1 24329,0 24426,1 24455,0 24478,1 24488,0 24557,1 24639,0 24677,1 24685,0 24716,1 24717,0 24746,1 24774,0 24777,1 24828,0 24889,1 24894,0 24993,1 24995,0 25023,1 25058,0 25095,1 25187,0 25262,1 25344,0 25388,1 25485,0 25514,1 25565,0 25651,1 25684,0 25717,1 25810,0 25867,1 25930,0 25932,1 25997,0 26017,1 26027,0 26119,1 26135,0 26165,1 26260,0 26304,1 26352,0 26413,1 26501,0 26553,1 26568,0 26619,1 26663,0 26753,1 26777,0 26783,1 26787,0 26791,1 26878,0 26949,1 27019,0 27024,1 27044,0 27110,1 27179,0 27216,1 27297,0 27394,1 27413,0 27498,1 27547,0 27636,1 27700,0 27790,1 27868,0 27901,1 27981,0 28021,1 28109,0 28171,1 28255,0 28353,1 28416,0 28436,1 28489,0 28503,1 28586,0 28610,1 28674,0 28756,1 28802,0 28823,1 28919,0 28999,1 29078,0 29169,1 29179,0 29241,1 29316,0 29331,1 29413,0 29507,1 29538,0 29636,1 29672,0 29679,1 29715,0 29778,1 29786,0 29805,1 29881,0 29977,1 30064,0 30121,1 30166,0 30211,1 30252,0 30298,1 30344,0 30405,1 30443,0 30444,1 30473,0 30548,1 30639,0 30664,1 30689,0 30738,1 30817,0 30818,1 30859,0 30876,1 30877,0 30941,1 30948,0 31026,1 31089,0 31149,1 31195,0 31271,1 31330,0 31360,1 31426,0 31511,1 31586,0 31650,1 31686,0 31722,1 31820,0 31893,1 31911,0 31921,1 31981,0 32003,1 32038,0 32105,1 32151,0 32171,1 32228,0 32261,1 32354,0 32366,1 32458,0 32518,1 32571,0 32602,1 32651,0 32685,1 32726,0 32798,1 32819,0 32899,1 32970,0 32979,1 33054,0 33135,1 33230,0 33272,1 33282,0 33349,1 33368,0 33406,1 33488,0 33530,1 33613,0 33634,1 33726,0 33794,1 33796,0 33871,1 33894,0 33927,1 33941,0 34003,1 34095,0 34120,1 34121,0 34204,1 34249,0 34256,1 34334,0 34342,1 34393,0 34489,1 34504,0 34587,1 34678,0 34724,1 34811,0 34904,1 34990,0 35026,1 35071,0 35098,1 35134,0 35216,1 35290,0 35303,1 35362,0 35400,1 35498,0 35528,1 35564,0 35602,1 35607,0 35678,1 35700,0 35769,1 35852,0 35853,1 35934,0 36013,1 36016,0 36115,1 36161,0 36177,1 36255,0 36339,1 36417,0 36426,1 36473,0 36475,1 36544,0 36575,1 36652,0 36736,1 36816,0 36868,1 36876,0 36878,1 36950,0 36957,1 37002,0 37101,1 37136,0 37170,1 37226,0 37314,1 37365,0 37384,1 37390,0 37451,1 37466,0 37530,1 37630,0 37671,1 37722,0 37741,1 37841,0 37873,1 37911,0 37915,1 37981,0 37993,1 38014,0 38076,1 38170,0 38176,1 38219,0 38247,1 38256,0 38284,1 38374,0 38397,1 38476,0 38572,1 38582,0 38603,1 38607,0 38685,1 38757,0 38806,1 38866,0 38891,1 38986,0 39027,1 39044,0 39133,1 39220,0 39288,1 39289,0 39311,1 39389,0 39471,1 39474,0 39493,1 39519,0 39613,1 39656,0 39708,1 39761,0 39822,1 39905,0 39934,1 40030,0 40060,1 40105,0 40111,1 40183,0 40192,1 40214,0 40253,1 40304,0 40395,1 40433,0 40523,1 40591,0 40673,1 40765,0 40772,1 40837,0 40906,1 40982,0 41065,1 41095,0 41103,1 41150,0 41184,1 41264,0 41312,1 41350,0 41386,1 41434,0 41456,1 41556,0 41649,1 41734,0 41739,1 41789,0 41826,1 41920,0 41968,1 41983,0 42003,1 42038,0 42066,1 42148,0 42183,1 42217,0 42234,1 42281,0 42314,1 42336,0 42352,1 42433,0 42477,1 42561,0 42587,1 42591,0 42654,1 42735,0 42740,1 42770,0 42816,1 42850,0 42950,1 43017,0 43059,1 43071,0 43104,1 43151,0 43165,1 43248,0 43277,1 43340,0 43420,1 43490,0 43521,1 43555,0 43577,1 43665,0 43755,1 43764,0 43859,1 43897,0 43988,1 44060,0 44125,1 44189,0 44209,1 44284,0 44349,1 44389,0 44463,1 44545,0 44578,1 44655,0 44686,1 44739,0 44834,1 44867,0 44909,1 45007,0 45068,1 45105,0 45124,1 45214,0 45262,1 45345,0 45410,1 45419,0 45507,1 45519,0 45579,1 45674,0 45707,1 45772,0 45830,1 45881,0 45962,1 45980,0 46011,1 46074,0 46088,1 46183,0 46250,1 46270,0 46297,1 46350,0 46430,1 46436,0 46501,1 46598,0 46664,1 46723,0 46739,1 46763,0 46837,1 46916,0 46929,1 47006,0 47055,1 47125,0 47223,1 47275,0 47361,1 47386,0 47466,1 47506,0 47509,1 47570,0 47575,1 47635,0 47711,1 47773,0 47820,1 47868,0 47907,1 47995,0 48029,1 48046,0 48093,1 48107,0 48138,1 48171,0 48248,1 48293,0 48338,1 48387,0 48463,1 48556,0 48581,1 48663,0 48747,1 48786,0 48881,1 48922,0 48984,1 49082,0 49130,1 49148,0 49223,1 49301,0 49355,1 49373,0 49394,1 49476,0 49492,1 49585,0 49616,1 49690,0 49739,1 49782,0 49817,1 49883,0 49940,1 50034,0 50081,1 50106,0 50182,1 50229,0 50286,1 50354,0 50383,1 50402,0 50426,1 50522,0 50616,1 50631,0 50667,1 50765,0 50841,1 50919,0 50991,1 51059,0 51085,1 51122,0 51181,1 51238,0 51258,1 51340,0 51415,1 51465,0 51517,1 51595,0 51634,1 51691,0 51761,1 51851,0 51921,1 end initlist c0 0,0 86,1 128,0 186,1 226,0 326,1 421,0 450,1 485,0 502,1 588,0 661,1 732,0 789,1 860,0 914,1 936,0 967,1 1061,0 1146,1 1185,0 1270,1 1322,0 1398,1 1411,0 1479,1 1503,0 1569,1 1662,0 1749,1 1843,0 1920,1 1936,0 1967,1 2011,0 2039,1 2110,0 2207,1 2303,0 2314,1 2392,0 2397,1 2483,0 2506,1 2508,0 2563,1 2588,0 2629,1 2646,0 2650,1 2720,0 2736,1 2738,0 2791,1 2802,0 2834,1 2903,0 2991,1 3037,0 3125,1 3166,0 3171,1 3217,0 3257,1 3311,0 3362,1 3373,0 3467,1 3536,0 3574,1 3649,0 3668,1 3754,0 3809,1 3895,0 3974,1 4002,0 4081,1 4102,0 4123,1 4163,0 4235,1 4306,0 4345,1 4411,0 4500,1 4545,0 4620,1 4656,0 4705,1 4718,0 4788,1 4855,0 4913,1 4987,0 5017,1 5114,0 5138,1 5238,0 5240,1 5301,0 5393,1 5455,0 5529,1 5601,0 5619,1 5671,0 5714,1 5808,0 5813,1 5821,0 5888,1 5926,0 5942,1 5995,0 6035,1 6054,0 6063,1 6110,0 6120,1 6142,0 6214,1 6246,0 6254,1 6305,0 6375,1 6449,0 6545,1 6565,0 6658,1 6730,0 6824,1 6867,0 6908,1 6986,0 7020,1 7044,0 7134,1 7164,0 7202,1 7227,0 7281,1 7353,0 7424,1 7520,0 7599,1 7658,0 7670,1 7731,0 7816,1 7901,0 7918,1 8018,0 8037,1 8078,0 8141,1 8217,0 8247,1 8287,0 8354,1 8454,0 8521,1 8545,0 8585,1 8604,0 8667,1 8757,0 8837,1 8869,0 8875,1 8967,0 8991,1 9028,0 9096,1 9172,0 9210,1 9270,0 9342,1 9373,0 9405,1 9461,0 9466,1 9557,0 9640,1 9668,0 9734,1 9739,0 9811,1 9879,0 9898,1 9990,0 10019,1 10046,0 10047,1 10135,0 10170,1 10243,0 10272,1 10328,0 10385,1 10485,0 10546,1 10639,0 10705,1 10804,0 10856,1 10951,0 10967,1 11015,0 11103,1 11129,0 11186,1 11214,0 11273,1 11350,0 11372,1 11442,0 11488,1 11524,0 11546,1 11634,0 11671,1 11712,0 11773,1 11812,0 11819,1 11906,0 11944,1 11953,0 12000,1 12014,0 12046,1 12143,0 12170,1 12241,0 12326,1 12406,0 12448,1 12463,0 12555,1 12574,0 12641,1 12648,0 12710,1 12780,0 12795,1 12805,0 12835,1 12915,0 12916,1 13008,0 13061,1 13109,0 13178,1 13206,0 13264,1 13293,0 13327,1 13393,0 13480,1 13515,0 13538,1 13607,0 13618,1 13703,0 13712,1 13762,0 13824,1 13865,0 13909,1 13944,0 13955,1 13988,0 14047,1 14087,0 14177,1 14180,0 14204,1 14223,0 14247,1 14344,0 14444,1 14540,0 14556,1 14645,0 14700,1 14707,0 14718,1 14793,0 14875,1 14944,0 14984,1 14994,0 15070,1 15089,0 15154,1 15246,0 15335,1 15430,0 15452,1 15468,0 15555,1 15583,0 15656,1 15713,0 15763,1 15815,0 15870,1 15904,0 15913,1 15973,0 15999,1 16095,0 16166,1 16199,0 16255,1 16334,0 16434,1 16526,0 16608,1 16646,0 16733,1 16829,0 16831,1 16863,0 16931,1 17012,0 17036,1 17094,0 17102,1 17164,0 17241,1 17275,0 17330,1 17337,0 17391,1 17470,0 17543,1 17552,0 17602,1 17676,0 17765,1 17770,0 17788,1 17844,0 17849,1 17924,0 17987,1 18062,0 18143,1 18197,0 18223,1 18313,0 18352,1 18356,0 18435,1 18528,0 18605,1 18658,0 18732,1 18759,0 18803,1 18808,0 18851,1 18884,0 18918,1 18965,0 19058,1 19110,0 19196,1 19247,0 19258,1 19318,0 19400,1 19500,0 19551,1 19629,0 19685,1 19762,0 19796,1 19893,0 19993,1 20080,0 20102,1 20107,0 20180,1 20277,0 20290,1 20366,0 20464,1 20543,0 20564,1 20580,0 20599,1 20677,0 20693,1 20707,0 20740,1 20758,0 20777,1 20827,0 20872,1 20915,0 21002,1 21023,0 21068,1 21112,0 21139,1 21159,0 21189,1 21191,0 21201,1 21277,0 21312,1 21325,0 21361,1 21443,0 21531,1 21578,0 21626,1 21640,0 21727,1 21780,0 21845,1 21867,0 21871,1 21966,0 21995,1 22084,0 22106,1 22173,0 22201,1 22267,0 22299,1 22384,0 22443,1 22502,0 22602,1 22633,0 22657,1 22746,0 22812,1 22829,0 22855,1 22865,0 22895,1 22956,0 23056,1 23085,0 23128,1 23135,0 23207,1 23303,0 23320,1 23338,0 23372,1 23383,0 23445,1 23523,0 23581,1 23644,0 23691,1 23708,0 23720,1 23725,0 23802,1 23843,0 23920,1 23998,0 24080,1 24099,0 24102,1 24146,0 24243,1 24263,0 24295,1 24389,0 24480,1 24565,0 24593,1 24675,0 24753,1 24817,0 24911,1 24947,0 25047,1 25056,0 25088,1 25138,0 25215,1 25281,0 25298,1 25313,0 25372,1 25381,0 25415,1 25443,0 25489,1 25513,0 25545,1 25560,0 25643,1 25703,0 25761,1 25819,0 25835,1 25872,0 25899,1 25956,0 25973,1 26035,0 26072,1 26159,0 26175,1 26253,0 26353,1 26432,0 26436,1 26527,0 26572,1 26583,0 26608,1 26629,0 26631,1 26647,0 26662,1 26727,0 26776,1 26866,0 26882,1 26982,0 27040,1 27069,0 27091,1 27149,0 27192,1 27281,0 27292,1 27341,0 27405,1 27479,0 27513,1 27530,0 27541,1 27546,0 27636,1 27692,0 27729,1 27809,0 27848,1 27888,0 27950,1 27970,0 28005,1 28092,0 28106,1 28142,0 28148,1 28247,0 28335,1 28364,0 28379,1 28432,0 28497,1 28585,0 28684,1 28771,0 28817,1 28829,0 28846,1 28936,0 29012,1 29101,0 29172,1 29209,0 29282,1 29378,0 29423,1 29440,0 29517,1 29538,0 29584,1 29605,0 29656,1 29741,0 29829,1 29869,0 29911,1 30010,0 30056,1 30092,0 30156,1 30205,0 30259,1 30316,0 30411,1 30430,0 30517,1 30552,0 30591,1 30652,0 30676,1 30753,0 30809,1 30810,0 30844,1 30854,0 30952,1 30967,0 31036,1 31133,0 31147,1 31240,0 31287,1 31292,0 31349,1 31414,0 31420,1 31422,0 31448,1 31470,0 31560,1 31647,0 31708,1 31761,0 31776,1 31798,0 31821,1 31866,0 31964,1 31980,0 32050,1 32079,0 32085,1 32089,0 32163,1 32238,0 32262,1 32310,0 32333,1 32425,0 32428,1 32464,0 32505,1 32523,0 32622,1 32707,0 32756,1 32771,0 32850,1 32892,0 32956,1 33053,0 33069,1 33105,0 33142,1 33210,0 33254,1 33297,0 33363,1 33460,0 33550,1 33648,0 33692,1 33772,0 33786,1 33862,0 33908,1 33920,0 33974,1 34019,0 34037,1 34060,0 34131,1 34138,0 34189,1 34233,0 34244,1 34276,0 34366,1 34439,0 34524,1 34565,0 34587,1 34653,0 34689,1 34764,0 34770,1 34797,0 34885,1 34905,0 34955,1 34966,0 35021,1 35023,0 35054,1 35073,0 35156,1 35161,0 35188,1 35224,0 35227,1 35237,0 35280,1 35321,0 35416,1 35448,0 35473,1 35544,0 35610,1 35663,0 35719,1 35749,0 35796,1 35841,0 35909,1 35944,0 36012,1 36066,0 36113,1 36148,0 36192,1 36272,0 36349,1 36434,0 36475,1 36494,0 36566,1 36637,0 36638,1 36679,0 36749,1 36797,0 36876,1 36915,0 36973,1 36981,0 37015,1 37052,0 37102,1 37154,0 37158,1 37238,0 37318,1 37351,0 37429,1 37504,0 37522,1 37602,0 37636,1 37717,0 37795,1 37892,0 37942,1 38017,0 38064,1 38110,0 38164,1 38167,0 38178,1 38203,0 38296,1 38369,0 38374,1 38471,0 38486,1 38546,0 38582,1 38654,0 38750,1 38844,0 38856,1 38881,0 38889,1 38954,0 38999,1 39071,0 39141,1 39178,0 39190,1 39284,0 39315,1 39348,0 39407,1 39437,0 39522,1 39605,0 39701,1 39761,0 39855,1 39924,0 39943,1 40023,0 40097,1 40153,0 40237,1 40253,0 40323,1 40343,0 40360,1 40420,0 40504,1 40601,0 40620,1 40647,0 40703,1 40717,0 40813,1 40821,0 40888,1 40969,0 41056,1 41079,0 41095,1 41117,0 41190,1 41222,0 41243,1 41319,0 41389,1 41442,0 41524,1 41601,0 41655,1 41713,0 41724,1 41740,0 41782,1 41854,0 41923,1 41970,0 42040,1 42070,0 42083,1 42118,0 42133,1 42158,0 42232,1 42250,0 42261,1 42338,0 42419,1 42479,0 42570,1 42617,0 42688,1 42756,0 42777,1 42818,0 42886,1 42889,0 42911,1 42991,0 42998,1 43018,0 43023,1 43044,0 43097,1 43177,0 43203,1 43289,0 43332,1 43371,0 43466,1 43519,0 43576,1 43669,0 43675,1 43718,0 43769,1 43789,0 43871,1 43907,0 44005,1 44045,0 44137,1 44187,0 44262,1 44289,0 44290,1 44337,0 44420,1 44446,0 44500,1 44502,0 44566,1 44658,0 44732,1 44782,0 44856,1 44933,0 44979,1 45045,0 45060,1 45110,0 45141,1 45207,0 45279,1 45325,0 45411,1 45412,0 45473,1 45563,0 45624,1 45712,0 45731,1 45746,0 45774,1 45800,0 45864,1 45893,0 45895,1 45995,0 46069,1 46155,0 46222,1 46237,0 46265,1 46335,0 46382,1 46419,0 46496,1 46565,0 46652,1 46661,0 46736,1 46826,0 46833,1 46874,0 46921,1 47015,0 47089,1 47128,0 47171,1 47202,0 47212,1 47260,0 47358,1 47419,0 47468,1 47556,0 47651,1 47721,0 47798,1 47858,0 47915,1 47928,0 47996,1 48079,0 48083,1 48147,0 48238,1 48269,0 48289,1 48346,0 48389,1 48402,0 48413,1 48433,0 48529,1 48568,0 48598,1 48674,0 48722,1 48799,0 48892,1 48978,0 49003,1 49092,0 49101,1 49103,0 49105,1 49108,0 49201,1 49211,0 49251,1 49303,0 49320,1 49383,0 49458,1 49480,0 49495,1 49589,0 49643,1 49741,0 49745,1 49754,0 49771,1 49835,0 49864,1 49934,0 49951,1 50024,0 50107,1 50137,0 50231,1 50268,0 50273,1 50360,0 50417,1 50441,0 50456,1 end initlist c1 0,0 21,1 30,0 63,1 76,0 107,1 142,0 205,1 220,0 230,1 318,0 407,1 478,0 500,1 586,0 624,1 690,0 758,1 799,0 826,1 844,0 888,1 920,0 973,1 985,0 1023,1 1073,0 1082,1 1114,0 1116,1 1119,0 1190,1 1254,0 1326,1 1416,0 1422,1 1494,0 1592,1 1620,0 1659,1 1666,0 1723,1 1778,0 1805,1 1876,0 1897,1 1949,0 1964,1 2017,0 2100,1 2156,0 2176,1 2192,0 2247,1 2346,0 2391,1 2419,0 2426,1 2490,0 2578,1 2673,0 2690,1 2697,0 2757,1 2842,0 2886,1 2956,0 3038,1 3045,0 3126,1 3201,0 3227,1 3232,0 3234,1 3332,0 3344,1 3436,0 3531,1 3617,0 3659,1 3757,0 3772,1 3795,0 3879,1 3893,0 3932,1 3949,0 3961,1 4037,0 4078,1 4127,0 4167,1 4176,0 4200,1 4222,0 4236,1 4250,0 4268,1 4310,0 4369,1 4464,0 4539,1 4554,0 4570,1 4615,0 4639,1 4683,0 4733,1 4740,0 4774,1 4797,0 4879,1 4942,0 5008,1 5093,0 5130,1 5196,0 5202,1 5226,0 5292,1 5295,0 5345,1 5398,0 5446,1 5503,0 5548,1 5627,0 5699,1 5717,0 5807,1 5817,0 5890,1 5893,0 5985,1 6015,0 6041,1 6050,0 6080,1 6092,0 6171,1 6256,0 6282,1 6355,0 6359,1 6457,0 6549,1 6611,0 6641,1 6675,0 6742,1 6835,0 6840,1 6934,0 6978,1 6997,0 7083,1 7166,0 7216,1 7243,0 7340,1 7395,0 7471,1 7552,0 7590,1 7595,0 7634,1 7673,0 7765,1 7806,0 7818,1 7918,0 7953,1 7986,0 8081,1 8161,0 8208,1 8277,0 8309,1 8313,0 8393,1 8431,0 8527,1 8601,0 8658,1 8696,0 8766,1 8837,0 8910,1 8944,0 8967,1 9042,0 9057,1 9076,0 9158,1 9206,0 9276,1 9291,0 9365,1 9421,0 9515,1 9540,0 9611,1 9643,0 9742,1 9749,0 9758,1 9774,0 9826,1 9914,0 9929,1 9993,0 10005,1 10049,0 10125,1 10164,0 10176,1 10247,0 10283,1 10362,0 10411,1 10430,0 10455,1 10555,0 10594,1 10626,0 10690,1 10709,0 10775,1 10874,0 10925,1 11005,0 11097,1 11153,0 11203,1 11213,0 11237,1 11308,0 11407,1 11469,0 11567,1 11588,0 11686,1 11726,0 11793,1 11843,0 11910,1 11984,0 12051,1 12097,0 12160,1 12221,0 12261,1 12278,0 12367,1 12432,0 12466,1 12489,0 12536,1 12565,0 12622,1 12623,0 12656,1 12709,0 12806,1 12878,0 12912,1 12929,0 12973,1 13001,0 13058,1 13087,0 13180,1 13182,0 13252,1 13284,0 13316,1 13339,0 13407,1 13476,0 13517,1 13595,0 13638,1 13692,0 13735,1 13737,0 13760,1 13856,0 13911,1 13951,0 13988,1 13997,0 14017,1 14061,0 14069,1 14112,0 14160,1 14236,0 14294,1 14323,0 14370,1 14463,0 14508,1 14564,0 14651,1 14664,0 14754,1 14824,0 14856,1 14882,0 14886,1 14942,0 14964,1 14986,0 15005,1 15028,0 15123,1 15140,0 15187,1 15267,0 15302,1 15366,0 15457,1 15491,0 15556,1 15607,0 15665,1 15670,0 15703,1 15726,0 15811,1 15895,0 15947,1 15985,0 16068,1 16124,0 16158,1 16240,0 16334,1 16390,0 16424,1 16514,0 16605,1 16659,0 16737,1 16754,0 16814,1 16865,0 16930,1 16994,0 17025,1 17033,0 17077,1 17127,0 17204,1 17223,0 17296,1 17327,0 17370,1 17429,0 17438,1 17536,0 17622,1 17668,0 17701,1 17787,0 17828,1 17867,0 17935,1 17975,0 18006,1 18083,0 18109,1 18194,0 18238,1 18284,0 18377,1 18447,0 18520,1 18573,0 18600,1 18652,0 18726,1 18771,0 18861,1 18926,0 19020,1 19032,0 19053,1 19150,0 19180,1 19230,0 19295,1 19351,0 19448,1 19486,0 19540,1 19609,0 19629,1 19706,0 19747,1 19847,0 19921,1 19953,0 19956,1 19994,0 20048,1 20123,0 20201,1 20206,0 20209,1 20283,0 20350,1 20396,0 20472,1 20526,0 20528,1 20591,0 20683,1 20706,0 20758,1 20802,0 20846,1 20866,0 20953,1 21007,0 21081,1 21149,0 21203,1 21243,0 21272,1 21325,0 21391,1 21480,0 21535,1 21566,0 21595,1 21634,0 21639,1 21711,0 21807,1 21857,0 21925,1 21941,0 22001,1 22080,0 22137,1 22167,0 22218,1 22268,0 22300,1 22346,0 22373,1 22425,0 22482,1 22552,0 22619,1 22661,0 22685,1 22703,0 22734,1 22782,0 22837,1 22882,0 22903,1 22910,0 22988,1 22992,0 22994,1 22999,0 23067,1 23162,0 23232,1 23321,0 23411,1 23457,0 23534,1 23609,0 23675,1 23773,0 23826,1 23915,0 23974,1 24003,0 24032,1 24093,0 24098,1 24128,0 24142,1 24193,0 24231,1 24266,0 24357,1 24419,0 24453,1 24552,0 24620,1 24661,0 24713,1 24801,0 24900,1 24926,0 24960,1 24966,0 24971,1 25024,0 25075,1 25111,0 25189,1 25216,0 25258,1 25282,0 25288,1 25377,0 25397,1 25428,0 25481,1 25545,0 25582,1 25595,0 25599,1 25641,0 25739,1 25814,0 25901,1 25971,0 26068,1 26107,0 26129,1 26229,0 26235,1 26259,0 26285,1 26351,0 26366,1 26423,0 26511,1 26592,0 26642,1 26717,0 26742,1 26821,0 26881,1 26965,0 26981,1 27028,0 27106,1 27130,0 27164,1 27238,0 27335,1 27423,0 27460,1 27503,0 27588,1 27645,0 27668,1 27682,0 27724,1 27782,0 27824,1 27833,0 27858,1 27882,0 27921,1 27980,0 28072,1 28091,0 28095,1 28100,0 28189,1 28211,0 28286,1 28361,0 28385,1 28428,0 28479,1 28539,0 28626,1 28713,0 28783,1 28790,0 28829,1 28859,0 28892,1 28940,0 28998,1 29068,0 29123,1 29129,0 29189,1 29241,0 29308,1 29330,0 29395,1 29447,0 29530,1 29577,0 29613,1 29623,0 29654,1 29676,0 29727,1 29756,0 29763,1 29774,0 29836,1 29838,0 29925,1 30022,0 30078,1 30124,0 30212,1 30253,0 30320,1 30411,0 30440,1 30460,0 30506,1 30586,0 30631,1 30711,0 30810,1 30846,0 30923,1 31020,0 31108,1 31190,0 31280,1 31294,0 31352,1 31426,0 31480,1 31564,0 31578,1 31582,0 31602,1 31646,0 31696,1 31746,0 31831,1 31872,0 31943,1 32040,0 32135,1 32225,0 32242,1 32289,0 32314,1 32346,0 32442,1 32444,0 32469,1 32492,0 32571,1 32668,0 32671,1 32754,0 32830,1 32893,0 32894,1 32964,0 33014,1 33070,0 33117,1 33185,0 33240,1 33286,0 33353,1 33366,0 33410,1 33489,0 33541,1 33629,0 33644,1 33728,0 33800,1 33856,0 33914,1 33981,0 34008,1 34038,0 34080,1 34149,0 34156,1 34204,0 34244,1 34280,0 34333,1 34413,0 34487,1 34544,0 34593,1 34619,0 34671,1 34702,0 34790,1 34866,0 34955,1 34965,0 35025,1 35042,0 35092,1 35104,0 35143,1 35166,0 35204,1 35264,0 35330,1 35423,0 35466,1 35523,0 35550,1 35578,0 35609,1 35667,0 35766,1 35804,0 35854,1 35896,0 35987,1 35992,0 36091,1 36185,0 36245,1 36262,0 36359,1 36384,0 36420,1 36425,0 36525,1 36588,0 36597,1 36695,0 36782,1 36873,0 36894,1 36935,0 36963,1 37060,0 37069,1 37118,0 37180,1 37207,0 37307,1 37328,0 37394,1 37419,0 37499,1 37531,0 37568,1 37623,0 37655,1 37676,0 37757,1 37852,0 37870,1 37892,0 37989,1 38079,0 38114,1 38163,0 38167,1 38222,0 38260,1 38346,0 38444,1 38520,0 38538,1 38593,0 38625,1 38707,0 38752,1 38778,0 38846,1 38880,0 38908,1 38948,0 38958,1 39045,0 39111,1 39203,0 39292,1 39357,0 39455,1 39549,0 39631,1 39641,0 39690,1 39716,0 39816,1 39890,0 39979,1 40059,0 40065,1 40144,0 40173,1 40226,0 40278,1 40284,0 40375,1 40422,0 40500,1 40562,0 40643,1 40652,0 40739,1 40785,0 40821,1 40833,0 40933,1 40954,0 40999,1 41003,0 41077,1 41176,0 41250,1 41347,0 41380,1 41406,0 41473,1 41552,0 41643,1 41688,0 41749,1 41798,0 41889,1 41950,0 41994,1 42013,0 42104,1 42175,0 42257,1 42261,0 42306,1 42387,0 42429,1 42447,0 42454,1 42535,0 42601,1 42674,0 42706,1 42708,0 42713,1 42770,0 42796,1 42837,0 42874,1 42914,0 42961,1 43053,0 43095,1 43098,0 43159,1 43168,0 43211,1 43282,0 43285,1 43313,0 43390,1 43465,0 43539,1 43584,0 43616,1 43713,0 43751,1 43802,0 43864,1 43895,0 43952,1 44023,0 44078,1 44159,0 44207,1 44273,0 44288,1 44350,0 44403,1 44441,0 44523,1 44585,0 44654,1 44667,0 44697,1 44791,0 44808,1 44885,0 44929,1 44958,0 45025,1 45029,0 45112,1 45169,0 45228,1 45260,0 45298,1 45346,0 45355,1 45382,0 45446,1 45470,0 45522,1 45619,0 45673,1 45757,0 45853,1 45859,0 45876,1 45930,0 45944,1 45991,0 46009,1 46043,0 46128,1 46184,0 46198,1 46265,0 46338,1 46374,0 46436,1 46503,0 46593,1 46685,0 46723,1 46753,0 46837,1 46909,0 47004,1 47041,0 47123,1 47143,0 47229,1 47317,0 47354,1 47402,0 47453,1 47540,0 47637,1 47730,0 47796,1 47814,0 47827,1 47894,0 47961,1 47993,0 48058,1 48090,0 48114,1 48213,0 48280,1 48343,0 48408,1 48504,0 48510,1 48590,0 48664,1 48697,0 48790,1 48848,0 48916,1 49010,0 49034,1 49132,0 49224,1 49286,0 49287,1 49350,0 49383,1 49455,0 49533,1 49572,0 49647,1 49659,0 49726,1 49826,0 49852,1 49869,0 49953,1 50044,0 50106,1 50123,0 50189,1 50226,0 50276,1 50363,0 50375,1 50407,0 50452,1 50482,0 50532,1 50545,0 50599,1 50639,0 50659,1 50698,0 50728,1 50762,0 50840,1 50918,0 50972,1 50988,0 50998,1 end initlist c2 0,0 71,1 84,0 94,1 181,0 191,1 231,0 321,1 384,0 464,1 559,0 642,1 741,0 751,1 781,0 867,1 896,0 898,1 970,0 989,1 995,0 1078,1 1154,0 1165,1 1264,0 1330,1 1407,0 1481,1 1505,0 1574,1 1618,0 1692,1 1718,0 1776,1 1781,0 1820,1 1850,0 1859,1 1888,0 1938,1 2025,0 2053,1 2121,0 2143,1 2214,0 2277,1 2356,0 2367,1 2435,0 2476,1 2488,0 2535,1 2584,0 2672,1 2733,0 2750,1 2805,0 2839,1 2867,0 2890,1 2978,0 3075,1 3093,0 3137,1 3168,0 3211,1 3302,0 3343,1 3417,0 3453,1 3485,0 3510,1 3557,0 3652,1 3733,0 3783,1 3797,0 3819,1 3835,0 3901,1 3921,0 3938,1 3952,0 4045,1 4057,0 4140,1 4199,0 4201,1 4227,0 4232,1 4303,0 4316,1 4363,0 4412,1 4446,0 4450,1 4541,0 4575,1 4659,0 4684,1 4741,0 4805,1 4811,0 4824,1 4887,0 4918,1 4997,0 5037,1 5049,0 5112,1 5160,0 5205,1 5246,0 5276,1 5369,0 5411,1 5473,0 5557,1 5592,0 5628,1 5694,0 5759,1 5770,0 5827,1 5864,0 5947,1 5988,0 6022,1 6047,0 6139,1 6219,0 6265,1 6306,0 6311,1 6346,0 6435,1 6459,0 6477,1 6490,0 6585,1 6648,0 6727,1 6770,0 6824,1 6898,0 6948,1 7039,0 7075,1 7113,0 7213,1 7222,0 7315,1 7389,0 7421,1 7495,0 7546,1 7605,0 7661,1 7744,0 7748,1 7815,0 7897,1 7973,0 8043,1 8077,0 8118,1 8120,0 8145,1 8158,0 8170,1 8182,0 8239,1 8261,0 8292,1 8361,0 8372,1 8427,0 8460,1 8526,0 8547,1 8637,0 8673,1 8745,0 8826,1 8844,0 8860,1 8925,0 8986,1 9058,0 9140,1 9237,0 9290,1 9328,0 9352,1 9391,0 9467,1 9516,0 9559,1 9626,0 9704,1 9750,0 9817,1 9845,0 9860,1 9933,0 9990,1 10055,0 10131,1 10194,0 10270,1 10318,0 10372,1 10421,0 10516,1 10554,0 10600,1 10613,0 10672,1 10679,0 10695,1 10748,0 10795,1 10848,0 10875,1 10950,0 10954,1 11032,0 11065,1 11077,0 11113,1 11120,0 11209,1 11306,0 11376,1 11462,0 11520,1 11606,0 11684,1 11755,0 11809,1 11861,0 11901,1 11945,0 11967,1 11971,0 12021,1 12104,0 12133,1 12230,0 12255,1 12278,0 12360,1 12427,0 12495,1 12497,0 12513,1 12600,0 12684,1 12757,0 12773,1 12778,0 12811,1 12878,0 12925,1 12968,0 13011,1 13026,0 13055,1 13057,0 13112,1 13206,0 13237,1 13263,0 13275,1 13276,0 13292,1 13304,0 13329,1 13349,0 13350,1 13408,0 13490,1 13506,0 13558,1 13639,0 13646,1 13710,0 13753,1 13809,0 13881,1 13882,0 13889,1 13959,0 13982,1 14047,0 14115,1 14201,0 14264,1 14344,0 14360,1 14365,0 14402,1 14437,0 14518,1 14617,0 14666,1 14677,0 14694,1 14706,0 14742,1 14794,0 14843,1 14907,0 14932,1 15008,0 15016,1 15115,0 15136,1 15145,0 15201,1 15270,0 15365,1 15390,0 15411,1 15447,0 15482,1 15495,0 15535,1 15631,0 15686,1 15774,0 15816,1 15835,0 15902,1 15947,0 15948,1 16041,0 16079,1 16167,0 16201,1 16275,0 16320,1 16390,0 16431,1 16470,0 16561,1 16656,0 16661,1 16702,0 16787,1 16886,0 16955,1 17053,0 17078,1 17154,0 17178,1 17186,0 17226,1 17322,0 17400,1 17438,0 17531,1 17541,0 17548,1 17639,0 17719,1 17770,0 17796,1 17818,0 17873,1 17950,0 18002,1 18053,0 18127,1 18152,0 18188,1 18232,0 18253,1 18261,0 18282,1 18323,0 18355,1 18369,0 18382,1 18482,0 18499,1 18593,0 18674,1 18764,0 18804,1 18865,0 18914,1 18932,0 19010,1 19080,0 19097,1 19103,0 19161,1 19165,0 19233,1 19255,0 19293,1 19331,0 19378,1 19447,0 19481,1 19524,0 19607,1 19610,0 19615,1 19651,0 19686,1 19775,0 19846,1 19876,0 19902,1 19984,0 20078,1 20155,0 20236,1 20292,0 20385,1 20445,0 20453,1 20458,0 20484,1 20526,0 20585,1 20665,0 20736,1 20738,0 20771,1 20828,0 20879,1 20943,0 21039,1 21051,0 21058,1 21077,0 21135,1 21168,0 21252,1 21316,0 21383,1 21473,0 21505,1 21604,0 21661,1 21734,0 21774,1 21844,0 21853,1 21916,0 21945,1 21959,0 21960,1 22038,0 22067,1 22090,0 22172,1 22260,0 22342,1 22370,0 22437,1 22509,0 22581,1 22652,0 22704,1 22757,0 22807,1 22859,0 22951,1 22978,0 23008,1 23015,0 23064,1 23136,0 23216,1 23283,0 23301,1 23364,0 23417,1 23494,0 23580,1 23594,0 23687,1 23714,0 23788,1 23842,0 23873,1 23889,0 23899,1 23973,0 24011,1 24082,0 24155,1 24186,0 24249,1 24268,0 24297,1 24377,0 24428,1 24485,0 24522,1 24552,0 24629,1 24660,0 24715,1 24723,0 24774,1 24871,0 24902,1 24952,0 25046,1 25051,0 25107,1 25158,0 25238,1 25253,0 25316,1 25349,0 25420,1 25502,0 25564,1 25653,0 25671,1 25731,0 25792,1 25885,0 25955,1 25971,0 26012,1 26072,0 26076,1 26098,0 26120,1 26191,0 26235,1 26282,0 26346,1 26435,0 26508,1 26544,0 26585,1 26646,0 26743,1 26771,0 26813,1 26828,0 26839,1 26931,0 27012,1 27037,0 27084,1 27091,0 27099,1 27111,0 27185,1 27260,0 27334,1 27406,0 27410,1 27454,0 27503,1 27510,0 27548,1 27583,0 27634,1 27729,0 27827,1 27885,0 27966,1 27968,0 28062,1 28141,0 28158,1 28228,0 28314,1 28412,0 28461,1 28483,0 28565,1 28630,0 28711,1 28809,0 28851,1 28884,0 28913,1 28921,0 28948,1 29026,0 29064,1 29109,0 29160,1 29224,0 29297,1 29380,0 29444,1 29506,0 29589,1 29634,0 29644,1 29739,0 29830,1 29906,0 29907,1 29989,0 30001,1 30094,0 30133,1 30193,0 30234,1 30247,0 30311,1 30406,0 30434,1 30440,0 30515,1 30522,0 30542,1 30598,0 30656,1 30676,0 30768,1 30803,0 30862,1 30919,0 30922,1 30926,0 31005,1 31105,0 31167,1 31206,0 31261,1 31349,0 31423,1 31440,0 31488,1 31559,0 31588,1 31674,0 31739,1 31758,0 31812,1 31831,0 31911,1 31972,0 32008,1 32043,0 32052,1 32150,0 32235,1 32258,0 32303,1 32367,0 32407,1 32449,0 32515,1 32549,0 32621,1 32701,0 32782,1 32845,0 32872,1 32879,0 32885,1 32922,0 32969,1 32986,0 33057,1 33153,0 33179,1 33194,0 33230,1 33244,0 33338,1 33436,0 33458,1 33543,0 33565,1 33599,0 33690,1 33717,0 33799,1 33807,0 33814,1 33902,0 33993,1 34051,0 34141,1 34220,0 34264,1 34325,0 34377,1 34442,0 34511,1 34534,0 34599,1 34619,0 34691,1 34749,0 34763,1 34853,0 34889,1 34919,0 34931,1 34974,0 35040,1 35129,0 35181,1 35250,0 35275,1 35340,0 35385,1 35447,0 35510,1 35533,0 35621,1 35622,0 35631,1 35649,0 35717,1 35789,0 35833,1 35845,0 35886,1 35907,0 35976,1 36062,0 36153,1 36240,0 36329,1 36408,0 36447,1 36510,0 36544,1 36549,0 36590,1 36680,0 36765,1 36799,0 36841,1 36932,0 36964,1 36991,0 37083,1 37117,0 37176,1 37231,0 37278,1 37319,0 37378,1 37422,0 37487,1 37525,0 37541,1 37636,0 37655,1 37702,0 37787,1 37789,0 37860,1 37864,0 37880,1 37924,0 37981,1 37990,0 37992,1 38087,0 38134,1 38149,0 38173,1 38200,0 38300,1 38311,0 38390,1 38403,0 38438,1 38449,0 38509,1 38568,0 38661,1 38751,0 38814,1 38835,0 38844,1 38918,0 38940,1 39031,0 39073,1 39160,0 39182,1 39205,0 39287,1 39367,0 39443,1 39515,0 39543,1 39585,0 39638,1 39690,0 39770,1 39800,0 39841,1 39862,0 39889,1 39924,0 39980,1 40012,0 40070,1 40170,0 40211,1 40244,0 40261,1 40320,0 40365,1 40432,0 40452,1 40460,0 40521,1 40535,0 40602,1 40627,0 40669,1 40745,0 40840,1 40884,0 40965,1 41038,0 41130,1 41177,0 41230,1 41283,0 41355,1 41403,0 41448,1 41508,0 41578,1 41666,0 41753,1 41820,0 41821,1 41823,0 41911,1 41936,0 42014,1 42015,0 42111,1 42145,0 42199,1 42232,0 42270,1 42341,0 42438,1 42476,0 42542,1 42590,0 42663,1 42664,0 42718,1 42752,0 42821,1 42887,0 42982,1 43073,0 43119,1 43137,0 43174,1 43256,0 43261,1 43314,0 43330,1 43332,0 43376,1 43468,0 43528,1 43548,0 43633,1 43724,0 43744,1 43746,0 43784,1 43853,0 43901,1 43917,0 43985,1 44010,0 44025,1 44100,0 44108,1 44149,0 44162,1 44186,0 44271,1 44356,0 44432,1 44516,0 44548,1 44579,0 44671,1 44710,0 44714,1 44729,0 44792,1 44867,0 44928,1 44987,0 45043,1 45104,0 45131,1 45167,0 45170,1 45182,0 45211,1 45219,0 45234,1 45284,0 45345,1 45424,0 45461,1 45532,0 45592,1 45625,0 45694,1 45736,0 45808,1 45878,0 45901,1 45943,0 45976,1 45986,0 46007,1 46089,0 46133,1 46193,0 46280,1 46285,0 46382,1 46452,0 46479,1 46529,0 46532,1 46576,0 46640,1 46719,0 46775,1 46861,0 46897,1 46905,0 46976,1 47013,0 47092,1 47163,0 47189,1 47247,0 47258,1 47339,0 47427,1 47527,0 47557,1 47603,0 47607,1 47681,0 47744,1 47817,0 47819,1 47914,0 47939,1 47991,0 47994,1 48085,0 48159,1 48241,0 48243,1 48275,0 48302,1 48357,0 48446,1 48473,0 48564,1 48567,0 48649,1 48715,0 48757,1 48766,0 48777,1 48814,0 48911,1 48957,0 48973,1 49016,0 49049,1 49142,0 49222,1 49308,0 49376,1 49437,0 49517,1 49537,0 49571,1 49614,0 49710,1 end initlist c3 0,0 27,1 33,0 90,1 170,0 258,1 336,0 402,1 497,0 522,1 575,0 624,1 640,0 682,1 766,0 775,1 810,0 910,1 933,0 1011,1 1097,0 1131,1 1229,0 1284,1 1294,0 1366,1 1369,0 1445,1 1470,0 1479,1 1485,0 1513,1 1601,0 1634,1 1715,0 1746,1 1830,0 1905,1 1944,0 2043,1 2056,0 2156,1 2217,0 2257,1 2336,0 2386,1 2486,0 2511,1 2552,0 2596,1 2607,0 2639,1 2706,0 2806,1 2863,0 2958,1 3007,0 3037,1 3089,0 3188,1 3265,0 3322,1 3413,0 3424,1 3446,0 3482,1 3582,0 3622,1 3701,0 3790,1 3816,0 3888,1 3909,0 3992,1 3994,0 4014,1 4091,0 4172,1 4230,0 4298,1 4334,0 4367,1 4435,0 4505,1 4592,0 4672,1 4718,0 4720,1 4772,0 4870,1 4911,0 4953,1 4965,0 4997,1 5086,0 5092,1 5177,0 5198,1 5297,0 5359,1 5384,0 5435,1 5467,0 5503,1 5525,0 5601,1 5649,0 5738,1 5780,0 5837,1 5844,0 5849,1 5880,0 5968,1 6031,0 6033,1 6055,0 6147,1 6244,0 6329,1 6354,0 6384,1 6435,0 6440,1 6452,0 6536,1 6591,0 6660,1 6701,0 6740,1 6813,0 6869,1 6913,0 6981,1 7069,0 7149,1 7171,0 7221,1 7321,0 7340,1 7359,0 7398,1 7436,0 7476,1 7497,0 7517,1 7599,0 7635,1 7654,0 7754,1 7780,0 7865,1 7945,0 7960,1 8019,0 8067,1 8095,0 8170,1 8235,0 8291,1 8309,0 8387,1 8402,0 8440,1 8484,0 8496,1 8545,0 8599,1 8623,0 8631,1 8728,0 8827,1 8890,0 8971,1 8998,0 9052,1 9108,0 9159,1 9253,0 9343,1 9419,0 9444,1 9525,0 9565,1 9608,0 9618,1 9688,0 9720,1 9799,0 9853,1 9859,0 9909,1 9937,0 9987,1 10073,0 10106,1 10149,0 10231,1 10288,0 10289,1 10307,0 10398,1 10425,0 10508,1 10605,0 10658,1 10677,0 10721,1 10785,0 10866,1 10962,0 11062,1 11126,0 11184,1 11270,0 11345,1 11420,0 11440,1 11515,0 11595,1 11628,0 11684,1 11701,0 11729,1 11775,0 11816,1 11901,0 11966,1 11999,0 12073,1 12106,0 12114,1 12198,0 12250,1 12347,0 12425,1 12509,0 12520,1 12525,0 12537,1 12586,0 12627,1 12700,0 12796,1 12808,0 12822,1 12863,0 12910,1 12946,0 13028,1 13124,0 13133,1 13162,0 13208,1 13264,0 13348,1 13354,0 13438,1 13507,0 13525,1 13576,0 13611,1 13655,0 13711,1 13802,0 13862,1 13878,0 13906,1 13967,0 14017,1 14049,0 14105,1 14155,0 14241,1 14273,0 14349,1 14364,0 14454,1 14474,0 14476,1 14543,0 14550,1 14613,0 14693,1 14772,0 14859,1 14887,0 14981,1 15051,0 15147,1 15208,0 15252,1 15347,0 15382,1 15481,0 15490,1 15506,0 15595,1 15621,0 15665,1 15742,0 15823,1 15833,0 15840,1 15921,0 16010,1 16065,0 16107,1 16131,0 16195,1 16219,0 16223,1 16236,0 16257,1 16329,0 16342,1 16361,0 16423,1 16443,0 16492,1 16501,0 16522,1 16532,0 16568,1 16608,0 16616,1 16635,0 16716,1 16760,0 16787,1 16842,0 16864,1 16867,0 16876,1 16926,0 16997,1 17016,0 17078,1 17103,0 17144,1 17195,0 17288,1 17321,0 17385,1 17453,0 17514,1 17598,0 17626,1 17656,0 17754,1 17771,0 17782,1 17839,0 17895,1 17941,0 17991,1 17994,0 18017,1 18054,0 18103,1 18107,0 18179,1 18196,0 18208,1 18252,0 18288,1 18388,0 18408,1 18486,0 18564,1 18632,0 18694,1 18749,0 18812,1 18827,0 18872,1 18929,0 19003,1 19099,0 19150,1 19157,0 19222,1 19234,0 19287,1 19363,0 19441,1 19515,0 19603,1 19611,0 19629,1 19701,0 19756,1 19835,0 19881,1 19906,0 19984,1 20003,0 20050,1 20064,0 20147,1 20185,0 20217,1 20290,0 20329,1 20376,0 20408,1 20441,0 20508,1 20547,0 20619,1 20675,0 20714,1 20723,0 20794,1 20893,0 20906,1 21003,0 21051,1 21126,0 21162,1 21255,0 21320,1 21353,0 21390,1 21437,0 21536,1 21595,0 21695,1 21741,0 21780,1 21792,0 21878,1 21929,0 22019,1 22042,0 22053,1 22122,0 22140,1 22143,0 22231,1 22283,0 22367,1 22420,0 22496,1 22544,0 22571,1 22638,0 22671,1 22739,0 22761,1 22803,0 22866,1 22893,0 22894,1 22994,0 23054,1 23061,0 23094,1 23144,0 23219,1 23314,0 23342,1 23426,0 23522,1 23523,0 23604,1 23611,0 23705,1 23706,0 23795,1 23850,0 23935,1 24010,0 24083,1 24126,0 24213,1 24278,0 24292,1 24358,0 24379,1 24459,0 24494,1 24514,0 24577,1 24644,0 24728,1 24752,0 24823,1 24849,0 24857,1 24869,0 24928,1 24979,0 25070,1 25145,0 25158,1 25213,0 25295,1 25343,0 25442,1 25480,0 25579,1 25632,0 25642,1 25676,0 25719,1 25780,0 25804,1 25841,0 25855,1 25941,0 26025,1 26030,0 26128,1 26210,0 26290,1 26307,0 26328,1 26347,0 26405,1 26483,0 26561,1 26649,0 26651,1 26681,0 26781,1 26800,0 26859,1 26908,0 26948,1 27043,0 27110,1 27201,0 27221,1 27321,0 27369,1 27390,0 27401,1 27463,0 27526,1 27602,0 27653,1 27750,0 27841,1 27842,0 27901,1 27916,0 27969,1 28005,0 28022,1 28088,0 28118,1 28218,0 28219,1 28274,0 28305,1 28323,0 28402,1 28457,0 28484,1 28561,0 28648,1 28700,0 28753,1 28817,0 28838,1 28855,0 28902,1 28966,0 29040,1 29090,0 29170,1 29232,0 29320,1 29330,0 29341,1 29379,0 29466,1 29503,0 29560,1 29603,0 29703,1 29707,0 29806,1 29845,0 29926,1 29959,0 29985,1 30051,0 30108,1 30190,0 30209,1 30226,0 30325,1 30384,0 30407,1 30461,0 30508,1 30512,0 30565,1 30571,0 30606,1 30637,0 30679,1 30742,0 30781,1 30876,0 30948,1 31035,0 31046,1 31062,0 31128,1 31205,0 31266,1 31306,0 31397,1 31420,0 31508,1 31563,0 31598,1 31691,0 31740,1 31755,0 31800,1 31846,0 31884,1 31893,0 31993,1 32015,0 32057,1 32121,0 32137,1 32169,0 32199,1 32261,0 32325,1 32415,0 32450,1 32467,0 32471,1 32504,0 32592,1 32634,0 32636,1 32679,0 32757,1 32803,0 32853,1 32868,0 32876,1 32924,0 33015,1 33073,0 33098,1 33161,0 33174,1 33182,0 33228,1 33254,0 33283,1 33376,0 33448,1 33479,0 33480,1 33490,0 33500,1 33524,0 33615,1 33654,0 33662,1 33702,0 33801,1 33851,0 33874,1 33951,0 33962,1 33984,0 34030,1 34102,0 34177,1 34270,0 34334,1 34396,0 34464,1 34501,0 34510,1 34520,0 34594,1 34658,0 34677,1 34745,0 34825,1 34849,0 34942,1 34978,0 35045,1 35125,0 35150,1 35230,0 35275,1 35347,0 35372,1 35412,0 35459,1 35554,0 35574,1 35644,0 35671,1 35742,0 35838,1 35882,0 35933,1 35949,0 36026,1 36049,0 36082,1 36146,0 36216,1 36249,0 36318,1 36409,0 36439,1 36539,0 36619,1 36623,0 36640,1 36735,0 36793,1 36843,0 36905,1 36973,0 37064,1 37143,0 37179,1 37260,0 37266,1 37335,0 37422,1 37477,0 37541,1 37612,0 37637,1 37722,0 37734,1 37748,0 37847,1 37876,0 37916,1 37998,0 38043,1 38143,0 38167,1 38237,0 38276,1 38365,0 38444,1 38460,0 38486,1 38514,0 38569,1 38621,0 38707,1 38782,0 38860,1 38941,0 39027,1 39043,0 39080,1 39081,0 39142,1 39238,0 39329,1 39406,0 39409,1 39424,0 39520,1 39587,0 39658,1 39720,0 39745,1 39802,0 39842,1 39867,0 39912,1 39932,0 39977,1 40041,0 40085,1 40120,0 40205,1 40304,0 40348,1 40441,0 40479,1 40527,0 40617,1 40633,0 40664,1 40703,0 40772,1 40862,0 40962,1 40999,0 41033,1 41055,0 41056,1 41131,0 41166,1 41264,0 41331,1 41388,0 41420,1 41423,0 41500,1 41591,0 41654,1 41675,0 41706,1 41711,0 41802,1 41894,0 41989,1 42082,0 42125,1 42197,0 42228,1 42312,0 42383,1 42449,0 42464,1 42524,0 42566,1 42640,0 42735,1 42822,0 42890,1 42893,0 42984,1 43015,0 43052,1 43120,0 43184,1 43265,0 43315,1 43381,0 43400,1 43434,0 43518,1 43602,0 43649,1 43746,0 43783,1 43846,0 43898,1 43904,0 43948,1 44042,0 44046,1 44100,0 44175,1 44237,0 44293,1 44335,0 44405,1 44462,0 44496,1 44499,0 44532,1 44571,0 44639,1 44645,0 44745,1 44824,0 44912,1 44977,0 45055,1 45078,0 45107,1 45206,0 45288,1 45295,0 45378,1 45384,0 45385,1 45423,0 45475,1 45552,0 45573,1 45617,0 45692,1 45706,0 45776,1 45813,0 45913,1 45967,0 46047,1 46114,0 46115,1 46138,0 46174,1 46180,0 46229,1 46312,0 46331,1 46404,0 46495,1 46545,0 46639,1 46678,0 46696,1 46742,0 46842,1 46923,0 47012,1 47039,0 47056,1 47058,0 47140,1 47172,0 47215,1 47276,0 47329,1 47370,0 47449,1 47502,0 47571,1 47657,0 47740,1 47804,0 47830,1 47922,0 48005,1 48041,0 48124,1 48166,0 48192,1 48249,0 48253,1 48339,0 48407,1 48445,0 48471,1 48512,0 48608,1 48690,0 48770,1 48820,0 48918,1 48919,0 48998,1 49070,0 49129,1 49203,0 49255,1 49319,0 49393,1 49468,0 49551,1 49630,0 49643,1 49727,0 49784,1 49819,0 49914,1 49923,0 49972,1 50038,0 50065,1 50165,0 50188,1 50233,0 50297,1 50331,0 50416,1 50506,0 50594,1 50605,0 50690,1 50691,0 50702,1 50730,0 50793,1 50858,0 50947,1 50985,0 51037,1 51053,0 51055,1 51077,0 51164,1 51183,0 51278,1 51313,0 51413,1 51433,0 51481,1 51570,0 51630,1 51717,0 51782,1 51854,0 51925,1 end initlist c4 0,0 85,1 174,0 247,1 268,0 322,1 382,0 405,1 490,0 589,1 597,0 677,1 714,0 810,1 891,0 916,1 991,0 1069,1 1142,0 1204,1 1238,0 1289,1 1375,0 1396,1 1465,0 1541,1 1549,0 1622,1 1676,0 1768,1 1846,0 1903,1 1987,0 2019,1 2054,0 2089,1 2128,0 2144,1 2197,0 2198,1 2294,0 2380,1 2441,0 2484,1 2557,0 2563,1 2643,0 2666,1 2670,0 2724,1 2789,0 2879,1 2963,0 3011,1 3054,0 3081,1 3091,0 3191,1 3273,0 3344,1 3437,0 3507,1 3601,0 3695,1 3780,0 3787,1 3858,0 3911,1 3952,0 3979,1 3998,0 4016,1 4052,0 4131,1 4187,0 4232,1 4277,0 4278,1 4341,0 4431,1 4443,0 4467,1 4476,0 4517,1 4576,0 4578,1 4646,0 4673,1 4704,0 4714,1 4781,0 4880,1 4928,0 4956,1 4972,0 4976,1 5054,0 5130,1 5148,0 5236,1 5269,0 5367,1 5438,0 5489,1 5532,0 5622,1 5717,0 5762,1 5830,0 5871,1 5949,0 5955,1 5995,0 6034,1 6116,0 6208,1 6214,0 6289,1 6366,0 6423,1 6432,0 6531,1 6545,0 6558,1 6656,0 6694,1 6729,0 6772,1 6800,0 6843,1 6921,0 6934,1 6997,0 7073,1 7153,0 7229,1 7301,0 7369,1 7419,0 7497,1 7572,0 7576,1 7635,0 7728,1 7814,0 7905,1 7976,0 8076,1 8102,0 8171,1 8210,0 8212,1 8215,0 8243,1 8330,0 8377,1 8476,0 8534,1 8582,0 8616,1 8674,0 8743,1 8798,0 8866,1 8908,0 8972,1 9049,0 9060,1 9106,0 9117,1 9144,0 9186,1 9284,0 9316,1 9357,0 9384,1 9419,0 9441,1 9506,0 9529,1 9538,0 9593,1 9646,0 9705,1 9747,0 9766,1 9812,0 9906,1 9993,0 10075,1 10170,0 10204,1 10243,0 10272,1 10284,0 10300,1 10309,0 10336,1 10340,0 10396,1 10481,0 10483,1 10573,0 10615,1 10705,0 10747,1 10795,0 10810,1 10817,0 10832,1 10833,0 10913,1 10938,0 10958,1 11044,0 11052,1 11072,0 11165,1 11183,0 11273,1 11310,0 11377,1 11477,0 11554,1 11653,0 11748,1 11786,0 11853,1 11921,0 11964,1 12030,0 12099,1 12186,0 12195,1 12276,0 12352,1 12399,0 12433,1 12521,0 12591,1 12639,0 12654,1 12701,0 12703,1 12737,0 12817,1 12864,0 12924,1 12990,0 12991,1 13080,0 13129,1 13189,0 13276,1 13313,0 13360,1 13373,0 13437,1 13480,0 13491,1 13564,0 13599,1 13629,0 13665,1 13757,0 13772,1 13780,0 13854,1 13937,0 13990,1 14001,0 14045,1 14071,0 14108,1 14144,0 14151,1 14196,0 14197,1 14230,0 14244,1 14267,0 14273,1 14364,0 14450,1 14512,0 14573,1 14668,0 14703,1 14722,0 14726,1 14783,0 14795,1 14878,0 14928,1 14960,0 15045,1 15139,0 15146,1 15181,0 15262,1 15354,0 15399,1 15485,0 15555,1 15642,0 15645,1 15680,0 15755,1 15848,0 15938,1 16034,0 16119,1 16213,0 16266,1 16277,0 16284,1 16312,0 16322,1 16394,0 16413,1 16433,0 16486,1 16556,0 16567,1 16634,0 16657,1 16679,0 16770,1 16806,0 16904,1 16928,0 17027,1 17091,0 17173,1 17202,0 17252,1 17260,0 17330,1 17401,0 17451,1 17527,0 17530,1 17624,0 17680,1 17691,0 17786,1 17869,0 17945,1 18027,0 18121,1 18182,0 18216,1 18221,0 18247,1 18312,0 18410,1 18493,0 18577,1 18602,0 18629,1 18685,0 18696,1 18791,0 18854,1 18952,0 19019,1 19079,0 19136,1 19139,0 19220,1 19305,0 19338,1 19429,0 19434,1 19493,0 19578,1 19639,0 19643,1 19661,0 19712,1 19771,0 19844,1 19919,0 19983,1 20038,0 20120,1 20220,0 20309,1 20405,0 20454,1 20491,0 20495,1 20507,0 20592,1 20623,0 20703,1 20760,0 20772,1 20778,0 20865,1 20905,0 20913,1 20961,0 20969,1 21013,0 21076,1 21125,0 21162,1 21193,0 21229,1 21235,0 21241,1 21306,0 21346,1 21404,0 21418,1 21493,0 21593,1 21669,0 21730,1 21811,0 21868,1 21903,0 21956,1 22017,0 22076,1 22171,0 22176,1 22204,0 22207,1 22238,0 22253,1 22255,0 22276,1 22278,0 22336,1 22398,0 22483,1 22496,0 22584,1 22607,0 22693,1 22752,0 22759,1 22803,0 22895,1 22927,0 22946,1 22953,0 22963,1 23020,0 23030,1 23088,0 23180,1 23205,0 23208,1 23226,0 23289,1 23296,0 23375,1 23399,0 23421,1 23441,0 23456,1 23514,0 23562,1 23629,0 23643,1 23707,0 23792,1 23838,0 23874,1 23951,0 24043,1 24071,0 24155,1 24181,0 24252,1 24290,0 24317,1 24382,0 24417,1 24498,0 24557,1 24571,0 24617,1 24618,0 24619,1 24679,0 24775,1 24794,0 24891,1 24976,0 25050,1 25130,0 25202,1 25289,0 25347,1 25414,0 25507,1 25552,0 25564,1 25625,0 25710,1 25780,0 25815,1 25870,0 25923,1 26020,0 26050,1 26055,0 26067,1 26126,0 26215,1 26229,0 26313,1 26375,0 26448,1 26494,0 26514,1 26540,0 26548,1 26600,0 26650,1 26674,0 26737,1 26836,0 26893,1 26894,0 26935,1 26961,0 27031,1 27048,0 27133,1 27166,0 27217,1 27239,0 27321,1 27331,0 27373,1 27407,0 27486,1 27508,0 27581,1 27616,0 27703,1 27801,0 27895,1 27974,0 28050,1 28093,0 28110,1 28160,0 28229,1 28274,0 28364,1 28439,0 28506,1 28534,0 28544,1 28570,0 28575,1 28662,0 28701,1 28768,0 28771,1 28850,0 28875,1 28949,0 28975,1 29026,0 29082,1 29155,0 29217,1 29245,0 29300,1 29307,0 29316,1 29364,0 29401,1 29485,0 29577,1 29599,0 29674,1 29762,0 29807,1 29852,0 29916,1 29999,0 30069,1 30084,0 30151,1 30236,0 30308,1 30395,0 30402,1 30461,0 30523,1 30526,0 30592,1 30670,0 30742,1 30818,0 30866,1 30907,0 30910,1 30918,0 30975,1 30981,0 31053,1 31089,0 31135,1 31231,0 31245,1 31268,0 31366,1 31456,0 31510,1 31532,0 31611,1 31707,0 31802,1 31859,0 31866,1 31903,0 31996,1 32068,0 32145,1 32212,0 32253,1 32328,0 32377,1 32434,0 32454,1 32551,0 32586,1 32600,0 32685,1 32704,0 32769,1 32780,0 32847,1 32873,0 32892,1 32925,0 33020,1 33120,0 33206,1 33261,0 33297,1 33326,0 33366,1 33465,0 33552,1 33566,0 33603,1 33616,0 33673,1 33732,0 33797,1 33845,0 33943,1 34021,0 34062,1 34138,0 34228,1 34231,0 34249,1 34296,0 34396,1 34397,0 34465,1 34481,0 34576,1 34671,0 34712,1 34803,0 34807,1 34835,0 34902,1 34939,0 35038,1 35107,0 35113,1 35165,0 35264,1 35303,0 35401,1 35412,0 35443,1 35478,0 35486,1 35523,0 35559,1 35643,0 35684,1 35768,0 35815,1 35866,0 35910,1 35932,0 35967,1 35999,0 36006,1 36068,0 36135,1 36143,0 36173,1 36229,0 36290,1 36348,0 36353,1 36385,0 36471,1 36496,0 36521,1 36588,0 36618,1 36681,0 36697,1 36793,0 36867,1 36882,0 36885,1 36984,0 37061,1 37068,0 37100,1 37170,0 37240,1 37278,0 37350,1 37427,0 37454,1 37521,0 37612,1 37622,0 37632,1 37712,0 37750,1 37760,0 37777,1 37854,0 37923,1 37936,0 37940,1 38031,0 38121,1 38213,0 38275,1 38277,0 38339,1 38386,0 38485,1 38505,0 38538,1 38625,0 38632,1 38710,0 38720,1 38802,0 38816,1 38824,0 38911,1 38959,0 39003,1 39020,0 39085,1 39168,0 39201,1 39284,0 39353,1 39412,0 39434,1 39450,0 39527,1 39578,0 39663,1 39725,0 39800,1 39833,0 39892,1 39914,0 39980,1 39993,0 40000,1 40029,0 40062,1 40127,0 40158,1 40255,0 40279,1 40349,0 40370,1 40408,0 40415,1 40506,0 40560,1 40574,0 40607,1 40651,0 40751,1 40801,0 40848,1 40903,0 40932,1 40989,0 41084,1 41168,0 41180,1 41213,0 41298,1 41375,0 41427,1 41443,0 41481,1 41502,0 41561,1 41608,0 41648,1 41686,0 41779,1 41788,0 41877,1 41962,0 41989,1 42044,0 42096,1 42115,0 42121,1 42138,0 42172,1 42220,0 42279,1 42300,0 42312,1 42365,0 42464,1 42556,0 42580,1 42650,0 42714,1 42759,0 42843,1 42910,0 43002,1 43049,0 43086,1 43171,0 43201,1 43241,0 43318,1 43360,0 43373,1 43435,0 43441,1 43442,0 43456,1 43494,0 43589,1 43607,0 43610,1 43611,0 43692,1 43715,0 43801,1 43886,0 43950,1 43994,0 44019,1 44100,0 44128,1 44210,0 44247,1 44298,0 44352,1 44416,0 44509,1 44513,0 44571,1 44646,0 44742,1 44837,0 44867,1 44909,0 44994,1 45069,0 45135,1 45136,0 45188,1 45236,0 45312,1 45393,0 45478,1 45566,0 45608,1 45640,0 45718,1 45780,0 45799,1 45831,0 45902,1 45967,0 46024,1 46124,0 46204,1 46234,0 46250,1 46317,0 46350,1 46364,0 46426,1 46505,0 46510,1 46552,0 46604,1 46699,0 46792,1 46795,0 46851,1 46930,0 46931,1 46974,0 46980,1 46993,0 47001,1 47065,0 47153,1 47212,0 47273,1 47357,0 47396,1 47490,0 47515,1 47585,0 47599,1 47635,0 47644,1 47653,0 47736,1 47760,0 47816,1 47895,0 47912,1 47944,0 48024,1 48124,0 48186,1 48205,0 48294,1 48300,0 48340,1 48347,0 48437,1 48456,0 48481,1 48547,0 48581,1 48616,0 48706,1 48786,0 48841,1 48859,0 48913,1 48981,0 49044,1 49119,0 49129,1 49184,0 49216,1 49259,0 49341,1 49430,0 49456,1 49521,0 49611,1 49647,0 49654,1 49747,0 49822,1 49842,0 49924,1 49934,0 49992,1 50012,0 50070,1 50113,0 50170,1 50208,0 50213,1 50285,0 50359,1 50414,0 50458,1 50539,0 50604,1 50642,0 50679,1 50744,0 50808,1 50844,0 50895,1 end initlist c5 0,0 2,1 5,0 86,1 167,0 175,1 228,0 269,1 323,0 402,1 424,0 455,1 459,0 541,1 634,0 701,1 783,0 786,1 798,0 893,1 940,0 1029,1 1055,0 1060,1 1069,0 1073,1 1114,0 1152,1 1214,0 1261,1 1359,0 1384,1 1473,0 1485,1 1509,0 1599,1 1638,0 1723,1 1754,0 1780,1 1857,0 1914,1 1915,0 1930,1 2004,0 2092,1 2141,0 2215,1 2268,0 2323,1 2413,0 2486,1 2528,0 2540,1 2602,0 2618,1 2683,0 2772,1 2863,0 2920,1 2957,0 3015,1 3085,0 3110,1 3184,0 3188,1 3239,0 3314,1 3328,0 3423,1 3490,0 3527,1 3578,0 3662,1 3682,0 3751,1 3789,0 3862,1 3865,0 3944,1 3988,0 4079,1 4109,0 4200,1 4234,0 4326,1 4363,0 4376,1 4434,0 4437,1 4477,0 4545,1 4603,0 4633,1 4637,0 4718,1 4776,0 4801,1 4843,0 4856,1 4925,0 4927,1 4961,0 4985,1 5082,0 5149,1 5225,0 5318,1 5338,0 5350,1 5425,0 5502,1 5534,0 5625,1 5690,0 5737,1 5751,0 5842,1 5874,0 5955,1 6027,0 6102,1 6167,0 6210,1 6280,0 6330,1 6389,0 6393,1 6493,0 6535,1 6581,0 6630,1 6714,0 6810,1 6867,0 6902,1 6931,0 7006,1 7019,0 7091,1 7128,0 7129,1 7192,0 7230,1 7241,0 7252,1 7266,0 7294,1 7315,0 7336,1 7403,0 7448,1 7537,0 7574,1 7623,0 7633,1 7641,0 7715,1 7806,0 7897,1 7963,0 7982,1 8009,0 8094,1 8164,0 8174,1 8261,0 8275,1 8368,0 8380,1 8406,0 8413,1 8439,0 8441,1 8533,0 8567,1 8611,0 8658,1 8745,0 8843,1 8875,0 8939,1 8942,0 9030,1 9093,0 9143,1 9235,0 9319,1 9397,0 9435,1 9495,0 9572,1 9583,0 9673,1 9770,0 9841,1 9929,0 9984,1 10066,0 10113,1 10150,0 10172,1 10218,0 10287,1 10331,0 10365,1 10405,0 10442,1 10468,0 10500,1 10527,0 10529,1 10601,0 10629,1 10692,0 10742,1 10793,0 10877,1 10909,0 10950,1 10978,0 11002,1 11031,0 11113,1 11183,0 11272,1 11308,0 11351,1 11366,0 11382,1 11424,0 11442,1 11504,0 11556,1 11616,0 11619,1 11691,0 11717,1 11791,0 11818,1 11894,0 11913,1 11970,0 12022,1 12026,0 12122,1 12165,0 12215,1 12260,0 12349,1 12381,0 12455,1 12509,0 12531,1 12535,0 12542,1 12567,0 12662,1 12693,0 12754,1 12771,0 12835,1 12885,0 12903,1 12908,0 12943,1 12968,0 13015,1 13103,0 13202,1 13256,0 13333,1 13372,0 13463,1 13536,0 13559,1 13601,0 13610,1 13654,0 13741,1 13818,0 13824,1 13895,0 13978,1 13982,0 14026,1 14091,0 14096,1 14191,0 14214,1 14297,0 14385,1 14457,0 14477,1 14543,0 14593,1 14610,0 14663,1 14670,0 14677,1 14737,0 14765,1 14825,0 14867,1 14891,0 14941,1 14981,0 15015,1 15063,0 15102,1 15198,0 15271,1 15285,0 15362,1 15369,0 15420,1 15436,0 15474,1 15519,0 15528,1 15617,0 15644,1 15694,0 15762,1 15856,0 15908,1 15939,0 16036,1 16091,0 16097,1 16113,0 16158,1 16247,0 16268,1 16347,0 16368,1 16408,0 16457,1 16489,0 16529,1 16578,0 16675,1 16771,0 16812,1 16841,0 16843,1 16883,0 16937,1 16978,0 17034,1 17133,0 17173,1 17264,0 17325,1 17379,0 17438,1 17449,0 17459,1 17476,0 17566,1 17639,0 17696,1 17768,0 17791,1 17876,0 17956,1 17974,0 18006,1 18088,0 18179,1 18250,0 18253,1 18287,0 18323,1 18365,0 18448,1 18513,0 18592,1 18638,0 18695,1 18711,0 18727,1 18738,0 18799,1 18804,0 18848,1 18860,0 18910,1 18954,0 19050,1 19144,0 19168,1 19207,0 19301,1 19361,0 19426,1 19517,0 19605,1 19679,0 19734,1 19742,0 19812,1 19832,0 19914,1 19991,0 20071,1 20158,0 20228,1 20297,0 20397,1 20409,0 20451,1 20469,0 20489,1 20491,0 20511,1 20535,0 20616,1 20667,0 20704,1 20741,0 20826,1 20868,0 20959,1 20998,0 21061,1 21082,0 21148,1 21180,0 21241,1 21275,0 21366,1 21429,0 21521,1 21593,0 21595,1 21634,0 21688,1 21766,0 21858,1 21882,0 21915,1 21961,0 21986,1 22049,0 22117,1 22188,0 22227,1 22304,0 22401,1 22433,0 22524,1 22613,0 22672,1 22745,0 22793,1 22801,0 22820,1 22845,0 22867,1 22892,0 22935,1 22968,0 23053,1 23151,0 23174,1 23255,0 23288,1 23384,0 23427,1 23446,0 23530,1 23579,0 23634,1 23717,0 23720,1 23807,0 23832,1 23873,0 23955,1 24038,0 24052,1 24113,0 24184,1 24226,0 24236,1 24243,0 24250,1 24302,0 24347,1 24435,0 24450,1 24549,0 24606,1 24639,0 24705,1 24741,0 24765,1 24771,0 24822,1 24863,0 24903,1 24927,0 25005,1 25007,0 25077,1 25141,0 25231,1 25308,0 25398,1 25433,0 25515,1 25602,0 25652,1 25668,0 25709,1 25774,0 25824,1 25876,0 25942,1 26038,0 26130,1 26201,0 26207,1 26297,0 26395,1 26464,0 26519,1 26556,0 26570,1 26661,0 26682,1 26700,0 26737,1 26827,0 26861,1 26900,0 26984,1 27007,0 27090,1 27173,0 27184,1 27235,0 27276,1 27290,0 27359,1 27408,0 27436,1 27527,0 27613,1 27656,0 27702,1 27723,0 27811,1 27821,0 27915,1 27954,0 28044,1 28059,0 28144,1 28241,0 28257,1 28308,0 28355,1 28382,0 28481,1 28537,0 28633,1 28718,0 28778,1 28808,0 28829,1 28899,0 28901,1 28979,0 29061,1 29150,0 29179,1 29194,0 29275,1 29339,0 29350,1 29429,0 29518,1 29552,0 29616,1 29664,0 29741,1 29805,0 29878,1 29890,0 29983,1 30043,0 30079,1 30080,0 30127,1 30191,0 30267,1 30357,0 30393,1 30457,0 30484,1 30539,0 30608,1 30674,0 30689,1 30696,0 30785,1 30871,0 30874,1 30947,0 31020,1 31045,0 31095,1 31118,0 31165,1 31176,0 31229,1 31312,0 31391,1 31429,0 31498,1 31521,0 31538,1 31596,0 31618,1 31711,0 31712,1 31742,0 31745,1 31805,0 31819,1 31853,0 31933,1 32019,0 32109,1 32151,0 32155,1 32238,0 32328,1 32364,0 32456,1 32462,0 32471,1 32479,0 32508,1 32510,0 32545,1 32636,0 32640,1 32660,0 32741,1 32779,0 32841,1 32885,0 32960,1 33022,0 33075,1 33168,0 33189,1 33261,0 33306,1 33330,0 33353,1 33433,0 33456,1 33516,0 33575,1 33661,0 33706,1 33751,0 33775,1 33846,0 33849,1 33876,0 33944,1 34033,0 34132,1 34196,0 34279,1 34315,0 34381,1 34428,0 34449,1 34455,0 34524,1 34562,0 34609,1 34675,0 34688,1 34747,0 34841,1 34936,0 34954,1 34971,0 35038,1 35058,0 35067,1 35121,0 35171,1 35186,0 35243,1 35262,0 35321,1 35345,0 35374,1 35469,0 35525,1 35559,0 35634,1 35672,0 35713,1 35750,0 35847,1 35852,0 35944,1 36017,0 36039,1 36082,0 36109,1 36185,0 36283,1 36354,0 36396,1 36410,0 36465,1 36517,0 36526,1 36591,0 36612,1 36707,0 36773,1 36848,0 36919,1 37009,0 37104,1 37164,0 37256,1 37270,0 37367,1 37463,0 37504,1 37555,0 37646,1 37739,0 37768,1 37860,0 37869,1 37969,0 38004,1 38091,0 38181,1 38223,0 38320,1 38377,0 38438,1 38501,0 38562,1 38572,0 38623,1 38709,0 38758,1 38778,0 38829,1 38913,0 39011,1 39044,0 39051,1 39121,0 39206,1 39256,0 39282,1 39303,0 39366,1 39418,0 39425,1 39457,0 39527,1 39578,0 39658,1 39742,0 39831,1 39905,0 39938,1 40019,0 40029,1 40097,0 40180,1 40231,0 40233,1 40292,0 40384,1 40427,0 40438,1 40494,0 40531,1 40592,0 40643,1 40661,0 40743,1 40836,0 40909,1 40938,0 40962,1 41062,0 41130,1 41217,0 41242,1 41250,0 41309,1 41406,0 41449,1 41523,0 41526,1 41618,0 41635,1 41687,0 41739,1 41794,0 41894,1 41976,0 42058,1 42110,0 42131,1 42152,0 42220,1 42275,0 42349,1 42444,0 42511,1 42587,0 42685,1 42690,0 42695,1 42747,0 42806,1 42833,0 42869,1 42949,0 43010,1 43047,0 43094,1 43123,0 43128,1 43183,0 43200,1 43282,0 43371,1 43397,0 43475,1 43563,0 43585,1 43591,0 43655,1 43707,0 43782,1 43806,0 43887,1 43934,0 43936,1 43942,0 44017,1 44059,0 44151,1 44176,0 44255,1 44342,0 44405,1 44412,0 44467,1 44538,0 44572,1 44586,0 44638,1 44718,0 44763,1 44810,0 44871,1 44901,0 44913,1 45010,0 45011,1 45092,0 45192,1 45240,0 45308,1 45352,0 45389,1 45464,0 45533,1 45581,0 45675,1 45720,0 45791,1 45840,0 45904,1 45905,0 45917,1 45999,0 46018,1 46080,0 46164,1 46222,0 46268,1 46326,0 46347,1 46400,0 46430,1 46495,0 46539,1 46564,0 46629,1 46720,0 46751,1 46812,0 46890,1 46953,0 46972,1 47046,0 47055,1 47134,0 47234,1 47319,0 47368,1 47445,0 47482,1 47499,0 47585,1 47593,0 47661,1 47718,0 47801,1 47803,0 47890,1 47984,0 48046,1 48098,0 48171,1 48260,0 48342,1 48441,0 48461,1 48492,0 48548,1 48574,0 48575,1 48617,0 48624,1 48690,0 48763,1 48824,0 48837,1 48925,0 49013,1 49089,0 49150,1 49164,0 49228,1 49304,0 49339,1 49358,0 49456,1 49474,0 49485,1 49563,0 49636,1 49726,0 49769,1 49774,0 49828,1 49857,0 49924,1 49976,0 50057,1 50087,0 50090,1 50150,0 50180,1 50216,0 50306,1 50399,0 50487,1 50541,0 50612,1 50644,0 50668,1 50696,0 50719,1 50748,0 50777,1 50861,0 50892,1 50894,0 50921,1 50958,0 50991,1 51000,0 51003,1 51073,0 51156,1 51256,0 51321,1 end initlist c6 0,0 5,1 32,0 128,1 147,0 232,1 263,0 350,1 406,0 483,1 581,0 616,1 692,0 745,1 755,0 803,1 812,0 903,1 922,0 937,1 996,0 1094,1 1100,0 1179,1 1232,0 1304,1 1323,0 1413,1 1423,0 1459,1 1462,0 1545,1 1552,0 1575,1 1617,0 1711,1 1737,0 1802,1 1836,0 1867,1 1877,0 1962,1 1967,0 1970,1 1971,0 2044,1 2099,0 2179,1 2207,0 2233,1 2281,0 2310,1 2375,0 2396,1 2467,0 2481,1 2488,0 2529,1 2627,0 2696,1 2772,0 2855,1 2902,0 2922,1 3015,0 3093,1 3127,0 3161,1 3213,0 3305,1 3358,0 3442,1 3506,0 3536,1 3633,0 3697,1 3756,0 3836,1 3875,0 3949,1 3963,0 3997,1 4032,0 4107,1 4165,0 4168,1 4189,0 4251,1 4260,0 4301,1 4370,0 4386,1 4418,0 4440,1 4463,0 4467,1 4554,0 4612,1 4703,0 4727,1 4734,0 4785,1 4806,0 4846,1 4868,0 4914,1 4917,0 4927,1 5021,0 5081,1 5180,0 5220,1 5285,0 5381,1 5456,0 5543,1 5570,0 5601,1 5631,0 5684,1 5773,0 5793,1 5861,0 5909,1 5919,0 5980,1 6043,0 6077,1 6079,0 6163,1 6210,0 6220,1 6241,0 6263,1 6287,0 6362,1 6440,0 6487,1 6587,0 6591,1 6604,0 6671,1 6770,0 6792,1 6839,0 6915,1 6978,0 7012,1 7025,0 7089,1 7178,0 7207,1 7220,0 7309,1 7328,0 7380,1 7395,0 7476,1 7501,0 7531,1 7557,0 7592,1 7664,0 7719,1 7764,0 7846,1 7875,0 7895,1 7914,0 7997,1 8037,0 8080,1 8103,0 8109,1 8139,0 8157,1 8204,0 8233,1 8291,0 8321,1 8355,0 8409,1 8445,0 8465,1 8529,0 8531,1 8578,0 8644,1 8706,0 8787,1 8788,0 8820,1 8830,0 8840,1 8865,0 8888,1 8901,0 8912,1 8934,0 9020,1 9022,0 9027,1 9069,0 9084,1 9154,0 9242,1 9279,0 9299,1 9312,0 9393,1 9424,0 9499,1 9509,0 9527,1 9548,0 9622,1 9650,0 9703,1 9777,0 9834,1 9847,0 9862,1 9943,0 9975,1 10055,0 10133,1 10143,0 10190,1 10233,0 10318,1 10338,0 10416,1 10477,0 10546,1 10566,0 10631,1 10640,0 10658,1 10691,0 10693,1 10743,0 10754,1 10804,0 10890,1 10930,0 11028,1 11100,0 11120,1 11163,0 11225,1 11300,0 11354,1 11449,0 11542,1 11561,0 11651,1 11667,0 11727,1 11728,0 11818,1 11820,0 11891,1 11988,0 12045,1 12051,0 12103,1 12173,0 12225,1 12284,0 12353,1 12383,0 12407,1 12502,0 12601,1 12649,0 12724,1 12800,0 12862,1 12952,0 13046,1 13095,0 13165,1 13188,0 13267,1 13282,0 13365,1 13416,0 13497,1 13550,0 13555,1 13621,0 13708,1 13711,0 13808,1 13878,0 13978,1 14016,0 14017,1 14106,0 14130,1 14136,0 14214,1 14269,0 14355,1 14405,0 14487,1 14515,0 14517,1 14570,0 14572,1 14621,0 14712,1 14808,0 14823,1 14905,0 14940,1 14991,0 15058,1 15077,0 15103,1 15148,0 15239,1 15300,0 15395,1 15471,0 15508,1 15519,0 15522,1 15587,0 15679,1 15738,0 15813,1 15896,0 15921,1 16016,0 16017,1 16116,0 16192,1 16239,0 16325,1 16339,0 16412,1 16434,0 16519,1 16578,0 16612,1 16617,0 16710,1 16750,0 16761,1 16808,0 16869,1 16924,0 16948,1 16974,0 16975,1 17039,0 17105,1 17119,0 17200,1 17229,0 17264,1 17323,0 17350,1 17445,0 17489,1 17508,0 17520,1 17597,0 17602,1 17645,0 17730,1 17816,0 17836,1 17845,0 17915,1 17925,0 17957,1 18022,0 18053,1 18102,0 18176,1 18197,0 18274,1 18281,0 18348,1 18394,0 18455,1 18547,0 18577,1 18665,0 18676,1 18707,0 18782,1 18824,0 18913,1 18941,0 18953,1 18979,0 19014,1 19040,0 19135,1 19173,0 19208,1 19270,0 19327,1 19332,0 19404,1 19501,0 19580,1 19678,0 19752,1 19793,0 19830,1 19854,0 19862,1 19929,0 19984,1 20003,0 20087,1 20156,0 20240,1 20252,0 20328,1 20407,0 20454,1 20500,0 20542,1 20641,0 20709,1 20786,0 20827,1 20828,0 20904,1 20992,0 21057,1 21080,0 21110,1 21159,0 21239,1 21314,0 21396,1 21482,0 21572,1 21584,0 21664,1 21734,0 21828,1 21912,0 21960,1 22045,0 22092,1 22144,0 22193,1 22194,0 22246,1 22265,0 22289,1 22354,0 22359,1 22451,0 22462,1 22512,0 22575,1 22639,0 22683,1 22783,0 22838,1 22912,0 22936,1 22967,0 23017,1 23071,0 23149,1 23183,0 23268,1 23313,0 23379,1 23477,0 23553,1 23606,0 23679,1 23742,0 23804,1 23856,0 23892,1 23940,0 24026,1 24028,0 24048,1 24097,0 24118,1 24149,0 24185,1 24264,0 24312,1 24344,0 24388,1 24391,0 24478,1 24496,0 24565,1 24635,0 24668,1 24760,0 24762,1 24765,0 24813,1 24827,0 24906,1 24969,0 25047,1 25096,0 25191,1 25240,0 25308,1 25311,0 25397,1 25470,0 25499,1 25526,0 25612,1 25688,0 25715,1 25757,0 25792,1 25806,0 25834,1 25842,0 25942,1 26031,0 26063,1 26097,0 26177,1 26231,0 26294,1 26296,0 26375,1 26410,0 26412,1 26429,0 26494,1 26579,0 26601,1 26679,0 26760,1 26786,0 26863,1 26921,0 27003,1 27047,0 27103,1 27118,0 27176,1 27216,0 27263,1 27319,0 27362,1 27432,0 27474,1 27536,0 27605,1 27701,0 27728,1 27741,0 27836,1 27888,0 27963,1 27975,0 28064,1 28085,0 28089,1 28144,0 28181,1 28182,0 28205,1 28304,0 28404,1 28434,0 28477,1 28545,0 28616,1 28628,0 28666,1 28740,0 28743,1 28769,0 28833,1 28926,0 28984,1 29077,0 29143,1 29149,0 29196,1 29271,0 29361,1 29444,0 29497,1 29578,0 29674,1 29709,0 29767,1 29846,0 29897,1 29939,0 30010,1 30077,0 30098,1 30161,0 30166,1 30190,0 30281,1 30358,0 30418,1 30426,0 30433,1 30517,0 30533,1 30619,0 30634,1 30723,0 30808,1 30821,0 30831,1 30843,0 30938,1 31028,0 31057,1 31148,0 31216,1 31272,0 31313,1 31406,0 31423,1 31488,0 31519,1 31579,0 31650,1 31719,0 31814,1 31836,0 31890,1 31934,0 31998,1 32095,0 32125,1 32191,0 32256,1 32328,0 32339,1 32347,0 32416,1 32428,0 32503,1 32527,0 32537,1 32563,0 32580,1 32584,0 32671,1 32755,0 32795,1 32879,0 32882,1 32930,0 33027,1 33118,0 33200,1 33242,0 33272,1 33355,0 33362,1 33420,0 33436,1 33471,0 33499,1 33510,0 33523,1 33622,0 33713,1 33724,0 33792,1 33885,0 33911,1 33922,0 34000,1 34038,0 34127,1 34149,0 34204,1 34303,0 34379,1 34418,0 34481,1 34530,0 34571,1 34659,0 34739,1 34825,0 34827,1 34832,0 34882,1 34922,0 34956,1 35037,0 35056,1 35122,0 35220,1 35265,0 35351,1 35355,0 35452,1 35464,0 35532,1 35543,0 35641,1 35696,0 35780,1 35850,0 35873,1 35927,0 35975,1 36056,0 36106,1 36205,0 36282,1 36318,0 36373,1 36400,0 36492,1 36546,0 36605,1 36613,0 36676,1 36720,0 36753,1 36798,0 36872,1 36913,0 36938,1 37006,0 37049,1 37071,0 37141,1 37174,0 37264,1 37343,0 37357,1 37370,0 37470,1 37477,0 37538,1 37591,0 37685,1 37708,0 37782,1 37832,0 37837,1 37887,0 37959,1 38010,0 38068,1 38153,0 38204,1 38267,0 38283,1 38381,0 38463,1 38497,0 38542,1 38622,0 38623,1 38696,0 38765,1 38788,0 38858,1 38942,0 39039,1 39045,0 39046,1 39061,0 39151,1 39248,0 39307,1 39319,0 39401,1 39487,0 39509,1 39515,0 39555,1 39629,0 39638,1 39718,0 39802,1 39854,0 39932,1 39997,0 40047,1 40122,0 40186,1 40251,0 40350,1 40449,0 40471,1 40542,0 40636,1 40685,0 40703,1 40755,0 40828,1 40896,0 40992,1 41054,0 41118,1 41137,0 41207,1 41230,0 41257,1 41335,0 41407,1 41449,0 41474,1 41487,0 41541,1 41620,0 41634,1 41701,0 41751,1 41833,0 41874,1 41973,0 42002,1 42068,0 42165,1 42226,0 42298,1 42374,0 42432,1 42512,0 42544,1 42560,0 42623,1 42672,0 42702,1 42709,0 42745,1 42834,0 42875,1 42877,0 42950,1 42953,0 42993,1 43019,0 43085,1 43173,0 43185,1 43266,0 43277,1 43305,0 43319,1 43378,0 43423,1 43502,0 43589,1 43654,0 43722,1 43750,0 43818,1 43819,0 43866,1 43926,0 43981,1 44070,0 44126,1 44136,0 44182,1 44278,0 44290,1 44319,0 44390,1 44451,0 44459,1 44496,0 44596,1 44599,0 44649,1 44666,0 44754,1 44819,0 44827,1 44841,0 44858,1 44941,0 45037,1 45080,0 45173,1 45228,0 45247,1 45326,0 45346,1 45384,0 45431,1 45477,0 45514,1 45557,0 45629,1 45650,0 45732,1 45804,0 45869,1 45950,0 46022,1 46098,0 46129,1 46219,0 46263,1 46345,0 46443,1 46477,0 46496,1 46537,0 46626,1 46706,0 46792,1 46857,0 46870,1 46899,0 46952,1 47028,0 47064,1 47096,0 47152,1 47214,0 47272,1 47287,0 47386,1 47451,0 47545,1 47573,0 47669,1 47711,0 47742,1 47833,0 47929,1 48021,0 48063,1 48071,0 48106,1 48172,0 48182,1 48184,0 48229,1 48317,0 48356,1 48448,0 48495,1 48577,0 48634,1 48713,0 48735,1 48798,0 48811,1 48841,0 48902,1 48908,0 48945,1 49036,0 49095,1 49191,0 49288,1 49367,0 49422,1 49431,0 49527,1 49546,0 49609,1 49640,0 49723,1 49778,0 49875,1 49963,0 50023,1 50091,0 50134,1 50142,0 50161,1 50232,0 50285,1 50314,0 50410,1 50495,0 50531,1 50547,0 50626,1 50662,0 50744,1 50812,0 50815,1 50858,0 50900,1 50902,0 50938,1 end initlist c7 0,0 85,1 143,0 202,1 203,0 240,1 292,0 331,1 333,0 365,1 457,0 556,1 629,0 637,1 713,0 735,1 752,0 824,1 890,0 933,1 960,0 996,1 1015,0 1058,1 1107,0 1195,1 1237,0 1329,1 1383,0 1470,1 1508,0 1530,1 1551,0 1594,1 1631,0 1658,1 1694,0 1737,1 1833,0 1862,1 1927,0 2004,1 2046,0 2098,1 2152,0 2164,1 2193,0 2283,1 2300,0 2369,1 2399,0 2426,1 2523,0 2552,1 2581,0 2594,1 2663,0 2722,1 2751,0 2816,1 2880,0 2946,1 3007,0 3062,1 3107,0 3192,1 3269,0 3273,1 3333,0 3401,1 3442,0 3505,1 3595,0 3601,1 3638,0 3673,1 3678,0 3738,1 3783,0 3853,1 3903,0 3987,1 4001,0 4051,1 4138,0 4209,1 4299,0 4383,1 4481,0 4569,1 4654,0 4659,1 4744,0 4783,1 4827,0 4849,1 4865,0 4867,1 4889,0 4919,1 4924,0 5021,1 5026,0 5066,1 5101,0 5135,1 5216,0 5228,1 5311,0 5352,1 5404,0 5405,1 5470,0 5482,1 5516,0 5566,1 5660,0 5700,1 5750,0 5804,1 5871,0 5875,1 5951,0 6012,1 6040,0 6080,1 6122,0 6185,1 6213,0 6299,1 6302,0 6331,1 6335,0 6415,1 6418,0 6432,1 6438,0 6470,1 6501,0 6510,1 6566,0 6627,1 6719,0 6746,1 6815,0 6911,1 6961,0 6968,1 7041,0 7093,1 7120,0 7190,1 7280,0 7309,1 7369,0 7467,1 7516,0 7563,1 7632,0 7649,1 7689,0 7738,1 7781,0 7803,1 7804,0 7868,1 7947,0 7962,1 7976,0 8045,1 8119,0 8215,1 8310,0 8405,1 8443,0 8481,1 8580,0 8676,1 8725,0 8746,1 8826,0 8902,1 8989,0 9057,1 9100,0 9174,1 9207,0 9307,1 9324,0 9348,1 9386,0 9416,1 9515,0 9569,1 9660,0 9755,1 9854,0 9863,1 9951,0 9965,1 10021,0 10110,1 10202,0 10236,1 10303,0 10326,1 10344,0 10406,1 10468,0 10480,1 10566,0 10628,1 10702,0 10761,1 10766,0 10837,1 10935,0 10940,1 11021,0 11073,1 11159,0 11237,1 11281,0 11326,1 11389,0 11425,1 11460,0 11494,1 11568,0 11595,1 11695,0 11771,1 11820,0 11892,1 11961,0 11965,1 12025,0 12041,1 12058,0 12129,1 12134,0 12225,1 12250,0 12276,1 12300,0 12395,1 12453,0 12472,1 12497,0 12512,1 12612,0 12659,1 12702,0 12778,1 12823,0 12850,1 12919,0 12945,1 12975,0 12992,1 13024,0 13027,1 13077,0 13143,1 13220,0 13253,1 13339,0 13438,1 13448,0 13457,1 13553,0 13584,1 13633,0 13733,1 13769,0 13827,1 13889,0 13900,1 13906,0 13960,1 14007,0 14065,1 14093,0 14163,1 14235,0 14318,1 14402,0 14472,1 14483,0 14543,1 14566,0 14648,1 14685,0 14733,1 14833,0 14872,1 14876,0 14973,1 15029,0 15044,1 15108,0 15121,1 15210,0 15283,1 15340,0 15418,1 15507,0 15589,1 15648,0 15741,1 15742,0 15778,1 15846,0 15932,1 15979,0 15982,1 16065,0 16133,1 16144,0 16170,1 16223,0 16231,1 16316,0 16350,1 16427,0 16448,1 16514,0 16599,1 16688,0 16709,1 16755,0 16840,1 16881,0 16899,1 16905,0 16914,1 16983,0 17029,1 17032,0 17035,1 17072,0 17095,1 17173,0 17196,1 17241,0 17299,1 17392,0 17403,1 17465,0 17484,1 17534,0 17564,1 17611,0 17681,1 17716,0 17764,1 17863,0 17949,1 17989,0 18047,1 18120,0 18211,1 18254,0 18279,1 18311,0 18357,1 18385,0 18450,1 18517,0 18530,1 18625,0 18641,1 18739,0 18809,1 18897,0 18963,1 19010,0 19056,1 19087,0 19134,1 19220,0 19253,1 19313,0 19360,1 19366,0 19465,1 19544,0 19642,1 19730,0 19780,1 19864,0 19920,1 19990,0 20048,1 20054,0 20070,1 20161,0 20239,1 20336,0 20392,1 20396,0 20422,1 20506,0 20581,1 20586,0 20667,1 20670,0 20752,1 20795,0 20806,1 20857,0 20897,1 20953,0 20964,1 21008,0 21108,1 21171,0 21267,1 21304,0 21389,1 21405,0 21427,1 21447,0 21540,1 21561,0 21621,1 21680,0 21682,1 21758,0 21799,1 21802,0 21890,1 21958,0 21977,1 22068,0 22152,1 22219,0 22244,1 22307,0 22349,1 22433,0 22511,1 22533,0 22633,1 22733,0 22765,1 22815,0 22856,1 22946,0 22975,1 23063,0 23157,1 23180,0 23238,1 23328,0 23342,1 23405,0 23478,1 23549,0 23575,1 23648,0 23720,1 23790,0 23886,1 23900,0 23911,1 24010,0 24052,1 24131,0 24176,1 24178,0 24203,1 24220,0 24303,1 24363,0 24370,1 24460,0 24492,1 24516,0 24601,1 24610,0 24625,1 24722,0 24768,1 24848,0 24874,1 24886,0 24893,1 24943,0 24996,1 25078,0 25150,1 25219,0 25248,1 25275,0 25278,1 25297,0 25394,1 25403,0 25408,1 25479,0 25542,1 25550,0 25644,1 25733,0 25756,1 25823,0 25838,1 25865,0 25917,1 25968,0 26063,1 26118,0 26154,1 26221,0 26305,1 26387,0 26449,1 26453,0 26508,1 26606,0 26618,1 26625,0 26683,1 26699,0 26791,1 26882,0 26911,1 26923,0 27016,1 27065,0 27078,1 27083,0 27165,1 27228,0 27273,1 27353,0 27415,1 27493,0 27539,1 27589,0 27596,1 27645,0 27679,1 27718,0 27742,1 27812,0 27857,1 27877,0 27916,1 27930,0 28015,1 28097,0 28171,1 28263,0 28290,1 28328,0 28333,1 28361,0 28371,1 28404,0 28473,1 28560,0 28583,1 28666,0 28712,1 28739,0 28806,1 28838,0 28895,1 28969,0 29061,1 29161,0 29178,1 29229,0 29287,1 29340,0 29400,1 29402,0 29476,1 29558,0 29586,1 29589,0 29651,1 29698,0 29768,1 29820,0 29906,1 29934,0 29944,1 29971,0 30041,1 30094,0 30131,1 30225,0 30238,1 30248,0 30258,1 30347,0 30424,1 30432,0 30463,1 30476,0 30483,1 30500,0 30549,1 30591,0 30676,1 30761,0 30819,1 30834,0 30862,1 30898,0 30978,1 31018,0 31094,1 31176,0 31192,1 31242,0 31298,1 31389,0 31407,1 31458,0 31460,1 31494,0 31530,1 31541,0 31634,1 31689,0 31739,1 31805,0 31880,1 31920,0 31993,1 32011,0 32028,1 32116,0 32155,1 32238,0 32336,1 32408,0 32468,1 32549,0 32557,1 32602,0 32691,1 32750,0 32820,1 32822,0 32853,1 32917,0 32975,1 33052,0 33130,1 33134,0 33138,1 33187,0 33244,1 33308,0 33389,1 33468,0 33555,1 33631,0 33691,1 33699,0 33776,1 33867,0 33872,1 33901,0 33913,1 33998,0 34027,1 34085,0 34099,1 34125,0 34214,1 34270,0 34353,1 34371,0 34438,1 34531,0 34557,1 34655,0 34665,1 34725,0 34806,1 34881,0 34910,1 34947,0 35021,1 35106,0 35199,1 35254,0 35315,1 35362,0 35438,1 35453,0 35461,1 35539,0 35566,1 35588,0 35672,1 35753,0 35830,1 35831,0 35893,1 35989,0 36073,1 36097,0 36192,1 36209,0 36249,1 36320,0 36368,1 36446,0 36515,1 36520,0 36578,1 36673,0 36748,1 36768,0 36784,1 36869,0 36962,1 37018,0 37025,1 37037,0 37059,1 37150,0 37169,1 37227,0 37325,1 37401,0 37471,1 37506,0 37509,1 37581,0 37596,1 37694,0 37788,1 37805,0 37863,1 37892,0 37967,1 38066,0 38153,1 38242,0 38321,1 38400,0 38414,1 38484,0 38488,1 38542,0 38585,1 38607,0 38669,1 38703,0 38792,1 38825,0 38902,1 38986,0 39065,1 39159,0 39162,1 39215,0 39280,1 39339,0 39399,1 39413,0 39445,1 39513,0 39612,1 39656,0 39741,1 39825,0 39899,1 39913,0 39951,1 39954,0 40013,1 40071,0 40137,1 40167,0 40262,1 40313,0 40371,1 40407,0 40424,1 40493,0 40524,1 40533,0 40633,1 40722,0 40785,1 40881,0 40972,1 40985,0 41017,1 41081,0 41086,1 41175,0 41266,1 41280,0 41317,1 41390,0 41462,1 41525,0 41590,1 41609,0 41640,1 41681,0 41685,1 41759,0 41761,1 41821,0 41842,1 41863,0 41892,1 41957,0 42018,1 42028,0 42036,1 42054,0 42105,1 42170,0 42220,1 42273,0 42355,1 42381,0 42446,1 42461,0 42501,1 42583,0 42648,1 42742,0 42758,1 42828,0 42910,1 42962,0 43003,1 43090,0 43096,1 43130,0 43158,1 43209,0 43260,1 43292,0 43368,1 43462,0 43514,1 43546,0 43625,1 43705,0 43742,1 43788,0 43860,1 43943,0 44025,1 44098,0 44160,1 44162,0 44225,1 44253,0 44290,1 44388,0 44473,1 44530,0 44553,1 44577,0 44636,1 44637,0 44737,1 44756,0 44829,1 44840,0 44851,1 44943,0 45024,1 45053,0 45059,1 45117,0 45126,1 45152,0 45212,1 45294,0 45317,1 45357,0 45454,1 45521,0 45551,1 45647,0 45742,1 45829,0 45902,1 45964,0 46057,1 46066,0 46078,1 46103,0 46163,1 46165,0 46181,1 46225,0 46260,1 46284,0 46380,1 46472,0 46563,1 46613,0 46706,1 46781,0 46879,1 46959,0 47036,1 47066,0 47136,1 47197,0 47202,1 47255,0 47280,1 47344,0 47366,1 47380,0 47395,1 47474,0 47521,1 47580,0 47650,1 47658,0 47748,1 47792,0 47866,1 47943,0 48000,1 48024,0 48029,1 48079,0 48155,1 48157,0 48225,1 48271,0 48328,1 48370,0 48454,1 48497,0 48532,1 48594,0 48644,1 48714,0 48774,1 48792,0 48804,1 48812,0 48895,1 48951,0 48989,1 48999,0 49061,1 49141,0 49201,1 49296,0 49316,1 49381,0 49410,1 49506,0 49579,1 49659,0 49721,1 49758,0 49818,1 49909,0 49952,1 50033,0 50064,1 50139,0 50226,1 50290,0 50305,1 50362,0 50428,1 50522,0 50534,1 50541,0 50580,1 50595,0 50625,1 50720,0 50777,1 50822,0 50888,1 50969,0 51008,1 51088,0 51090,1 51186,0 51242,1 51264,0 51331,1 51372,0 51436,1 51454,0 51489,1 end initlist c8 0,0 85,1 156,0 241,1 278,0 368,1 454,0 479,1 533,0 595,1 674,0 750,1 833,0 853,1 942,0 1005,1 1082,0 1092,1 1148,0 1199,1 1276,0 1372,1 1418,0 1438,1 1444,0 1536,1 1583,0 1590,1 1652,0 1727,1 1768,0 1812,1 1872,0 1900,1 1955,0 2022,1 2032,0 2126,1 2155,0 2247,1 2334,0 2403,1 2480,0 2578,1 2644,0 2705,1 2709,0 2727,1 2735,0 2804,1 2806,0 2887,1 2895,0 2947,1 3000,0 3067,1 3075,0 3089,1 3126,0 3172,1 3205,0 3257,1 3298,0 3363,1 3448,0 3509,1 3558,0 3654,1 3752,0 3820,1 3881,0 3927,1 3972,0 4038,1 4054,0 4126,1 4159,0 4206,1 4256,0 4289,1 4336,0 4407,1 4470,0 4497,1 4551,0 4643,1 4696,0 4753,1 4806,0 4821,1 4844,0 4903,1 4921,0 4981,1 5020,0 5041,1 5134,0 5231,1 5232,0 5319,1 5374,0 5455,1 5457,0 5552,1 5648,0 5676,1 5702,0 5779,1 5837,0 5932,1 5992,0 6084,1 6181,0 6191,1 6288,0 6378,1 6473,0 6505,1 6547,0 6644,1 6733,0 6736,1 6804,0 6861,1 6919,0 6949,1 6970,0 7064,1 7106,0 7136,1 7139,0 7160,1 7228,0 7297,1 7330,0 7333,1 7415,0 7428,1 7461,0 7474,1 7567,0 7618,1 7708,0 7747,1 7834,0 7926,1 8001,0 8019,1 8086,0 8113,1 8143,0 8151,1 8176,0 8216,1 8264,0 8300,1 8319,0 8342,1 8371,0 8448,1 8481,0 8513,1 8608,0 8669,1 8746,0 8778,1 8818,0 8821,1 8829,0 8843,1 8883,0 8981,1 9020,0 9111,1 9163,0 9207,1 9283,0 9366,1 9438,0 9500,1 9544,0 9615,1 9639,0 9701,1 9758,0 9759,1 9845,0 9893,1 9927,0 9950,1 10034,0 10132,1 10193,0 10290,1 10349,0 10358,1 10400,0 10411,1 10478,0 10501,1 10525,0 10531,1 10554,0 10632,1 10715,0 10784,1 10840,0 10890,1 10960,0 10963,1 11046,0 11144,1 11238,0 11337,1 11394,0 11460,1 11479,0 11557,1 11573,0 11579,1 11615,0 11699,1 11769,0 11828,1 11839,0 11907,1 11979,0 12038,1 12131,0 12204,1 12222,0 12315,1 12370,0 12421,1 12506,0 12596,1 12620,0 12654,1 12682,0 12744,1 12841,0 12887,1 12910,0 12978,1 13021,0 13053,1 13144,0 13195,1 13205,0 13249,1 13297,0 13368,1 13371,0 13464,1 13561,0 13595,1 13619,0 13622,1 13678,0 13765,1 13787,0 13867,1 13940,0 14012,1 14043,0 14046,1 14079,0 14107,1 14177,0 14269,1 14316,0 14336,1 14426,0 14492,1 14531,0 14619,1 14631,0 14651,1 14698,0 14700,1 14732,0 14794,1 14854,0 14916,1 14918,0 15004,1 15020,0 15098,1 15110,0 15147,1 15225,0 15264,1 15339,0 15409,1 15468,0 15519,1 15578,0 15642,1 15647,0 15715,1 15734,0 15776,1 15824,0 15836,1 15872,0 15937,1 15948,0 16020,1 16083,0 16112,1 16142,0 16235,1 16251,0 16305,1 16389,0 16441,1 16483,0 16554,1 16585,0 16589,1 16638,0 16711,1 16763,0 16819,1 16893,0 16903,1 16926,0 17007,1 17106,0 17147,1 17172,0 17268,1 17281,0 17332,1 17375,0 17440,1 17467,0 17530,1 17599,0 17630,1 17647,0 17670,1 17742,0 17814,1 17870,0 17875,1 17902,0 17995,1 18010,0 18025,1 18072,0 18132,1 18229,0 18306,1 18397,0 18497,1 18530,0 18600,1 18670,0 18741,1 18823,0 18884,1 18888,0 18977,1 19054,0 19065,1 19085,0 19166,1 19242,0 19307,1 19396,0 19472,1 19556,0 19650,1 19715,0 19750,1 19773,0 19821,1 19900,0 19917,1 19986,0 20023,1 20037,0 20114,1 20139,0 20234,1 20294,0 20308,1 20328,0 20402,1 20403,0 20411,1 20439,0 20517,1 20585,0 20588,1 20615,0 20644,1 20695,0 20751,1 20792,0 20797,1 20813,0 20815,1 20879,0 20965,1 20987,0 21048,1 21148,0 21214,1 21280,0 21356,1 21408,0 21459,1 21484,0 21508,1 21560,0 21638,1 21711,0 21788,1 21792,0 21849,1 21856,0 21921,1 21930,0 21970,1 22010,0 22030,1 22103,0 22201,1 22271,0 22302,1 22311,0 22411,1 22468,0 22550,1 22606,0 22675,1 22695,0 22732,1 22820,0 22899,1 22977,0 23027,1 23112,0 23144,1 23235,0 23259,1 23338,0 23364,1 23367,0 23371,1 23419,0 23431,1 23508,0 23519,1 23530,0 23586,1 23629,0 23721,1 23797,0 23801,1 23883,0 23922,1 24010,0 24074,1 24079,0 24111,1 24153,0 24249,1 24327,0 24364,1 24398,0 24454,1 24503,0 24601,1 24622,0 24651,1 24730,0 24814,1 24875,0 24919,1 24951,0 24990,1 25077,0 25116,1 25170,0 25183,1 25226,0 25241,1 25295,0 25340,1 25351,0 25368,1 25391,0 25471,1 25536,0 25585,1 25621,0 25709,1 25787,0 25811,1 25824,0 25922,1 25958,0 26057,1 26072,0 26148,1 26172,0 26261,1 26287,0 26370,1 26425,0 26441,1 26445,0 26531,1 26583,0 26662,1 26666,0 26721,1 26766,0 26769,1 26853,0 26944,1 27027,0 27038,1 27094,0 27179,1 27244,0 27277,1 27308,0 27370,1 27430,0 27447,1 27471,0 27513,1 27575,0 27636,1 27650,0 27749,1 27781,0 27822,1 27833,0 27908,1 27916,0 28001,1 28029,0 28065,1 28151,0 28209,1 28245,0 28273,1 28309,0 28388,1 28401,0 28487,1 28533,0 28603,1 28625,0 28642,1 28716,0 28755,1 28829,0 28830,1 28832,0 28931,1 29002,0 29007,1 29054,0 29093,1 29165,0 29232,1 29278,0 29366,1 29381,0 29432,1 29461,0 29523,1 29610,0 29645,1 29738,0 29752,1 29790,0 29837,1 29909,0 29954,1 29994,0 29999,1 30075,0 30103,1 30126,0 30182,1 30255,0 30264,1 30340,0 30364,1 30439,0 30443,1 30512,0 30515,1 30527,0 30618,1 30649,0 30688,1 30783,0 30836,1 30862,0 30871,1 30967,0 30998,1 31085,0 31134,1 31224,0 31252,1 31308,0 31353,1 31390,0 31468,1 31561,0 31618,1 31664,0 31755,1 31818,0 31845,1 31879,0 31972,1 32043,0 32119,1 32189,0 32259,1 32334,0 32342,1 32399,0 32429,1 32487,0 32560,1 32599,0 32640,1 32678,0 32773,1 32817,0 32905,1 32922,0 32984,1 33071,0 33114,1 33206,0 33290,1 33335,0 33388,1 33447,0 33471,1 33526,0 33619,1 33636,0 33640,1 33655,0 33660,1 33705,0 33747,1 33773,0 33801,1 33804,0 33870,1 33935,0 33988,1 34086,0 34184,1 34222,0 34272,1 34365,0 34411,1 34508,0 34582,1 34633,0 34713,1 34783,0 34874,1 34925,0 34970,1 35044,0 35068,1 35138,0 35174,1 35236,0 35268,1 35329,0 35386,1 35413,0 35508,1 35540,0 35629,1 35695,0 35735,1 35755,0 35771,1 35868,0 35903,1 35915,0 35994,1 36054,0 36154,1 36176,0 36272,1 36343,0 36387,1 36442,0 36504,1 36520,0 36619,1 36620,0 36659,1 36672,0 36680,1 36684,0 36749,1 36824,0 36867,1 36896,0 36985,1 36992,0 37073,1 37111,0 37174,1 37185,0 37214,1 37291,0 37350,1 37441,0 37498,1 37553,0 37643,1 37703,0 37711,1 37734,0 37834,1 37861,0 37890,1 37936,0 37996,1 38001,0 38010,1 38092,0 38185,1 38233,0 38252,1 38302,0 38370,1 38406,0 38461,1 38496,0 38591,1 38634,0 38730,1 38774,0 38794,1 38893,0 38951,1 38966,0 38989,1 39036,0 39048,1 39085,0 39173,1 39264,0 39351,1 39392,0 39401,1 39497,0 39533,1 39577,0 39664,1 39733,0 39806,1 39833,0 39895,1 39936,0 40035,1 40120,0 40154,1 40224,0 40301,1 40312,0 40340,1 40364,0 40368,1 40400,0 40408,1 40485,0 40585,1 40593,0 40673,1 40698,0 40731,1 40762,0 40768,1 40864,0 40951,1 41032,0 41097,1 41141,0 41174,1 41257,0 41343,1 41377,0 41445,1 41485,0 41493,1 41561,0 41576,1 41591,0 41681,1 41708,0 41774,1 41798,0 41877,1 41911,0 41938,1 42020,0 42096,1 42104,0 42163,1 42253,0 42310,1 42332,0 42334,1 42390,0 42417,1 42441,0 42496,1 42526,0 42580,1 42608,0 42688,1 42703,0 42745,1 42748,0 42830,1 42906,0 42918,1 42961,0 42999,1 43024,0 43034,1 43123,0 43164,1 43264,0 43327,1 43395,0 43429,1 43431,0 43483,1 43523,0 43608,1 43613,0 43617,1 43680,0 43765,1 43776,0 43867,1 43889,0 43939,1 43950,0 44018,1 44089,0 44138,1 44211,0 44290,1 44318,0 44337,1 44420,0 44474,1 44571,0 44666,1 44764,0 44844,1 44911,0 44971,1 44997,0 45026,1 45124,0 45176,1 45205,0 45233,1 45329,0 45362,1 45409,0 45461,1 45537,0 45579,1 45667,0 45746,1 45815,0 45882,1 45918,0 45951,1 45990,0 46068,1 46092,0 46101,1 46128,0 46203,1 46252,0 46267,1 46316,0 46320,1 46362,0 46427,1 46491,0 46540,1 46608,0 46668,1 46725,0 46756,1 46813,0 46841,1 46868,0 46885,1 46910,0 46935,1 47013,0 47079,1 47106,0 47137,1 47206,0 47219,1 47221,0 47266,1 47309,0 47327,1 47407,0 47475,1 47565,0 47601,1 47701,0 47761,1 47791,0 47868,1 47951,0 47987,1 48022,0 48023,1 48082,0 48092,1 48171,0 48206,1 48243,0 48321,1 48403,0 48418,1 48436,0 48486,1 48526,0 48625,1 48683,0 48721,1 48813,0 48818,1 48900,0 48967,1 48991,0 49011,1 49018,0 49111,1 49134,0 49182,1 49197,0 49235,1 49331,0 49344,1 49412,0 49509,1 49609,0 49626,1 49628,0 49654,1 49700,0 49788,1 49796,0 49851,1 49897,0 49960,1 50012,0 50026,1 50096,0 50171,1 50251,0 50324,1 50400,0 50409,1 50470,0 50512,1 50595,0 50608,1 50694,0 50695,1 50781,0 50782,1 50870,0 50930,1 51027,0 51075,1 end initlist c9 0,0 31,1 103,0 167,1 190,0 240,1 248,0 249,1 288,0 387,1 436,0 524,1 526,0 590,1 613,0 687,1 723,0 750,1 843,0 915,1 918,0 983,1 1044,0 1128,1 1143,0 1211,1 1307,0 1381,1 1477,0 1483,1 1582,0 1620,1 1629,0 1707,1 1800,0 1889,1 1915,0 2014,1 2070,0 2136,1 2229,0 2285,1 2378,0 2461,1 2472,0 2570,1 2575,0 2608,1 2692,0 2770,1 2844,0 2902,1 2989,0 3019,1 3065,0 3165,1 3205,0 3296,1 3378,0 3463,1 3481,0 3551,1 3614,0 3702,1 3717,0 3742,1 3788,0 3855,1 3908,0 3959,1 4006,0 4027,1 4075,0 4126,1 4132,0 4173,1 4269,0 4353,1 4373,0 4429,1 4527,0 4572,1 4605,0 4690,1 4695,0 4769,1 4863,0 4903,1 4944,0 5028,1 5040,0 5073,1 5162,0 5204,1 5299,0 5387,1 5472,0 5530,1 5550,0 5603,1 5618,0 5716,1 5723,0 5817,1 5828,0 5835,1 5853,0 5867,1 5936,0 5975,1 5983,0 6036,1 6124,0 6133,1 6199,0 6204,1 6234,0 6242,1 6274,0 6287,1 6332,0 6365,1 6393,0 6438,1 6482,0 6509,1 6552,0 6558,1 6650,0 6699,1 6711,0 6803,1 6871,0 6944,1 6959,0 6967,1 6979,0 6984,1 7075,0 7081,1 7152,0 7216,1 7262,0 7347,1 7368,0 7402,1 7482,0 7499,1 7545,0 7582,1 7615,0 7686,1 7710,0 7749,1 7799,0 7808,1 7873,0 7952,1 8010,0 8093,1 8118,0 8207,1 8243,0 8252,1 8343,0 8367,1 8457,0 8499,1 8594,0 8607,1 8637,0 8693,1 8791,0 8852,1 8898,0 8925,1 9002,0 9033,1 9082,0 9086,1 9087,0 9102,1 9145,0 9242,1 9301,0 9335,1 9388,0 9393,1 9446,0 9502,1 9563,0 9605,1 9606,0 9688,1 9779,0 9876,1 9941,0 9993,1 10017,0 10065,1 10083,0 10177,1 10269,0 10309,1 10373,0 10411,1 10468,0 10483,1 10559,0 10653,1 10700,0 10792,1 10851,0 10937,1 11009,0 11077,1 11117,0 11203,1 11288,0 11367,1 11421,0 11501,1 11538,0 11609,1 11683,0 11739,1 11767,0 11827,1 11896,0 11967,1 12058,0 12136,1 12154,0 12190,1 12269,0 12300,1 12365,0 12409,1 12422,0 12429,1 12468,0 12558,1 12574,0 12660,1 12674,0 12746,1 12838,0 12897,1 12958,0 13029,1 13111,0 13123,1 13144,0 13204,1 13206,0 13284,1 13290,0 13319,1 13395,0 13454,1 13523,0 13561,1 13658,0 13733,1 13823,0 13879,1 13913,0 13993,1 14083,0 14165,1 14249,0 14266,1 14289,0 14318,1 14333,0 14372,1 14383,0 14440,1 14539,0 14566,1 14611,0 14639,1 14663,0 14688,1 14719,0 14734,1 14832,0 14856,1 14884,0 14977,1 15052,0 15063,1 15099,0 15198,1 15216,0 15283,1 15315,0 15352,1 15370,0 15432,1 15454,0 15517,1 15583,0 15658,1 15740,0 15807,1 15899,0 15995,1 16021,0 16030,1 16118,0 16154,1 16224,0 16299,1 16381,0 16457,1 16493,0 16549,1 16598,0 16613,1 16679,0 16742,1 16798,0 16893,1 16944,0 16951,1 17023,0 17049,1 17055,0 17087,1 17182,0 17221,1 17311,0 17341,1 17424,0 17480,1 17485,0 17494,1 17539,0 17610,1 17665,0 17670,1 17755,0 17813,1 17838,0 17863,1 17871,0 17970,1 18051,0 18131,1 18190,0 18272,1 18328,0 18362,1 18398,0 18405,1 18445,0 18503,1 18577,0 18613,1 18669,0 18764,1 18850,0 18939,1 18951,0 18973,1 19002,0 19035,1 19120,0 19160,1 19165,0 19258,1 19317,0 19411,1 19501,0 19520,1 19579,0 19627,1 19650,0 19687,1 19722,0 19732,1 19801,0 19821,1 19842,0 19848,1 19911,0 19932,1 20021,0 20119,1 20156,0 20174,1 20224,0 20319,1 20366,0 20414,1 20504,0 20519,1 20530,0 20531,1 20588,0 20635,1 20641,0 20737,1 20755,0 20808,1 20901,0 20920,1 20995,0 21028,1 21063,0 21071,1 21076,0 21126,1 21170,0 21182,1 21224,0 21236,1 21301,0 21304,1 21306,0 21351,1 21399,0 21468,1 21547,0 21589,1 21594,0 21614,1 21708,0 21808,1 21847,0 21873,1 21946,0 22028,1 22108,0 22178,1 22224,0 22319,1 22401,0 22500,1 22598,0 22607,1 22671,0 22742,1 22804,0 22900,1 22935,0 22943,1 23034,0 23057,1 23112,0 23139,1 23173,0 23255,1 23343,0 23399,1 23476,0 23479,1 23501,0 23506,1 23605,0 23641,1 23661,0 23723,1 23766,0 23771,1 23806,0 23860,1 23867,0 23926,1 23953,0 24032,1 24035,0 24091,1 24093,0 24121,1 24161,0 24209,1 24271,0 24371,1 24425,0 24483,1 24527,0 24578,1 24636,0 24709,1 24747,0 24772,1 24870,0 24901,1 24915,0 25005,1 25011,0 25049,1 25146,0 25236,1 25252,0 25327,1 25388,0 25488,1 25587,0 25644,1 25717,0 25761,1 25775,0 25847,1 25910,0 25925,1 25981,0 26065,1 26135,0 26176,1 26190,0 26242,1 26250,0 26333,1 26352,0 26395,1 26410,0 26472,1 26488,0 26565,1 26568,0 26627,1 26650,0 26700,1 26785,0 26825,1 26846,0 26868,1 26884,0 26955,1 26993,0 27001,1 27090,0 27094,1 27150,0 27187,1 27270,0 27311,1 27315,0 27357,1 27370,0 27435,1 27471,0 27519,1 27572,0 27590,1 27609,0 27686,1 27786,0 27862,1 27940,0 27964,1 27985,0 28049,1 28083,0 28123,1 28185,0 28202,1 28256,0 28314,1 28362,0 28374,1 28380,0 28395,1 28426,0 28521,1 28608,0 28641,1 28649,0 28661,1 28723,0 28773,1 28782,0 28835,1 28932,0 28977,1 29025,0 29089,1 29173,0 29269,1 29272,0 29300,1 29387,0 29487,1 29529,0 29546,1 29555,0 29642,1 29693,0 29710,1 29736,0 29812,1 29899,0 29949,1 30048,0 30087,1 30158,0 30224,1 30299,0 30359,1 30383,0 30482,1 30558,0 30630,1 30649,0 30746,1 30774,0 30834,1 30886,0 30913,1 30978,0 31016,1 31028,0 31107,1 31140,0 31150,1 31229,0 31276,1 31299,0 31396,1 31456,0 31510,1 31557,0 31647,1 31723,0 31805,1 31852,0 31872,1 31901,0 31993,1 32055,0 32154,1 32236,0 32329,1 32392,0 32400,1 32498,0 32505,1 32603,0 32655,1 32755,0 32759,1 32782,0 32806,1 32881,0 32977,1 33027,0 33076,1 33173,0 33246,1 33255,0 33349,1 33358,0 33420,1 33505,0 33564,1 33638,0 33714,1 33742,0 33825,1 33897,0 33980,1 34049,0 34136,1 34201,0 34209,1 34295,0 34390,1 34466,0 34488,1 34497,0 34560,1 34656,0 34677,1 34728,0 34760,1 34836,0 34901,1 34936,0 34976,1 35070,0 35108,1 35116,0 35167,1 35186,0 35208,1 35258,0 35306,1 35307,0 35369,1 35415,0 35514,1 35537,0 35557,1 35647,0 35675,1 35720,0 35791,1 35837,0 35910,1 35916,0 35980,1 36015,0 36029,1 36088,0 36166,1 36232,0 36275,1 36317,0 36384,1 36460,0 36504,1 36506,0 36573,1 36646,0 36745,1 36836,0 36895,1 36950,0 37034,1 37080,0 37130,1 37153,0 37187,1 37219,0 37296,1 37318,0 37335,1 37423,0 37470,1 37516,0 37571,1 37610,0 37701,1 37768,0 37792,1 37866,0 37919,1 37972,0 37981,1 38017,0 38076,1 38129,0 38227,1 38279,0 38367,1 38426,0 38492,1 38526,0 38589,1 38598,0 38638,1 38661,0 38682,1 38717,0 38757,1 38813,0 38896,1 38990,0 38995,1 39039,0 39109,1 39191,0 39239,1 39311,0 39405,1 39417,0 39503,1 39600,0 39699,1 39774,0 39862,1 39953,0 39978,1 40022,0 40050,1 40108,0 40173,1 40240,0 40242,1 40340,0 40414,1 40495,0 40512,1 40607,0 40660,1 40733,0 40780,1 40783,0 40842,1 40862,0 40931,1 41020,0 41118,1 41212,0 41300,1 41323,0 41418,1 41507,0 41560,1 41631,0 41636,1 41664,0 41758,1 41783,0 41803,1 41809,0 41894,1 41964,0 41968,1 42041,0 42075,1 42123,0 42131,1 42223,0 42275,1 42306,0 42326,1 42375,0 42468,1 42552,0 42555,1 42614,0 42649,1 42699,0 42772,1 42815,0 42844,1 42916,0 43009,1 43088,0 43182,1 43268,0 43319,1 43392,0 43418,1 43512,0 43607,1 43667,0 43732,1 43776,0 43842,1 43857,0 43953,1 43999,0 44029,1 44117,0 44147,1 44193,0 44219,1 44236,0 44289,1 44322,0 44366,1 44367,0 44458,1 44535,0 44549,1 44614,0 44652,1 44688,0 44690,1 44770,0 44827,1 44883,0 44909,1 44914,0 44922,1 44955,0 44964,1 45014,0 45053,1 45131,0 45190,1 45258,0 45263,1 45334,0 45409,1 45444,0 45458,1 45528,0 45536,1 45587,0 45594,1 45621,0 45667,1 45714,0 45780,1 45793,0 45794,1 45825,0 45870,1 45878,0 45920,1 45930,0 45931,1 45975,0 46016,1 46114,0 46213,1 46247,0 46270,1 46277,0 46352,1 46418,0 46450,1 46515,0 46518,1 46562,0 46580,1 46673,0 46757,1 46847,0 46928,1 46955,0 46961,1 47044,0 47127,1 47162,0 47254,1 47348,0 47352,1 47447,0 47453,1 47484,0 47507,1 47519,0 47551,1 47646,0 47746,1 47842,0 47868,1 47874,0 47956,1 48044,0 48115,1 48137,0 48181,1 48199,0 48242,1 48249,0 48336,1 48352,0 48446,1 48481,0 48526,1 48599,0 48683,1 48732,0 48797,1 48836,0 48870,1 48924,0 48929,1 48973,0 48989,1 49021,0 49100,1 49113,0 49125,1 49144,0 49220,1 49293,0 49375,1 49450,0 49528,1 49544,0 49622,1 49639,0 49684,1 49763,0 49808,1 49895,0 49926,1 49961,0 49994,1 50027,0 50063,1 50076,0 50131,1 50200,0 50227,1 50254,0 50257,1 50320,0 50368,1 50407,0 50435,1 50526,0 50626,1 50711,0 50783,1 50872,0 50907,1 50944,0 50991,1 51058,0 51064,1 51065,0 51098,1 end initlist c10 0,0 90,1 118,0 122,1 220,0 244,1 265,0 322,1 337,0 432,1 478,0 564,1 630,0 686,1 764,0 860,1 896,0 963,1 1062,0 1120,1 1158,0 1239,1 1245,0 1301,1 1396,0 1479,1 1547,0 1558,1 1632,0 1666,1 1753,0 1813,1 1892,0 1962,1 2052,0 2106,1 2137,0 2221,1 2240,0 2289,1 2346,0 2433,1 2507,0 2564,1 2597,0 2619,1 2631,0 2677,1 2737,0 2798,1 2830,0 2852,1 2917,0 2945,1 2968,0 2993,1 2999,0 3038,1 3114,0 3165,1 3263,0 3321,1 3324,0 3335,1 3340,0 3410,1 3472,0 3570,1 3590,0 3625,1 3697,0 3744,1 3844,0 3873,1 3930,0 4027,1 4061,0 4087,1 4154,0 4208,1 4231,0 4292,1 4301,0 4339,1 4435,0 4486,1 4494,0 4520,1 4551,0 4610,1 4669,0 4712,1 4723,0 4820,1 4904,0 4983,1 5047,0 5142,1 5200,0 5261,1 5339,0 5346,1 5420,0 5463,1 5476,0 5547,1 5575,0 5645,1 5726,0 5805,1 5873,0 5948,1 5960,0 5977,1 5987,0 5999,1 6031,0 6051,1 6115,0 6215,1 6277,0 6305,1 6359,0 6396,1 6454,0 6468,1 6482,0 6544,1 6557,0 6581,1 6668,0 6731,1 6809,0 6823,1 6879,0 6972,1 7010,0 7013,1 7065,0 7134,1 7183,0 7244,1 7341,0 7380,1 7406,0 7421,1 7464,0 7543,1 7639,0 7728,1 7740,0 7750,1 7840,0 7914,1 7994,0 8059,1 8062,0 8110,1 8202,0 8225,1 8256,0 8356,1 8437,0 8449,1 8499,0 8562,1 8602,0 8615,1 8635,0 8679,1 8769,0 8844,1 8935,0 9035,1 9093,0 9182,1 9235,0 9266,1 9364,0 9379,1 9421,0 9480,1 9527,0 9593,1 9644,0 9687,1 9729,0 9813,1 9824,0 9884,1 9982,0 10012,1 10078,0 10174,1 10262,0 10346,1 10367,0 10393,1 10418,0 10511,1 10589,0 10649,1 10697,0 10760,1 10762,0 10824,1 10892,0 10895,1 10990,0 11055,1 11151,0 11209,1 11235,0 11241,1 11299,0 11398,1 11427,0 11457,1 11481,0 11497,1 11499,0 11528,1 11557,0 11585,1 11629,0 11724,1 11810,0 11864,1 11889,0 11983,1 12022,0 12108,1 12170,0 12234,1 12278,0 12295,1 12370,0 12373,1 12412,0 12472,1 12560,0 12587,1 12663,0 12667,1 12746,0 12784,1 12815,0 12849,1 12930,0 12935,1 12987,0 12994,1 13015,0 13041,1 13081,0 13139,1 13163,0 13199,1 13255,0 13277,1 13331,0 13426,1 13441,0 13478,1 13526,0 13568,1 13630,0 13641,1 13643,0 13676,1 13766,0 13860,1 13940,0 13952,1 14025,0 14051,1 14093,0 14118,1 14124,0 14145,1 14161,0 14169,1 14219,0 14300,1 14383,0 14408,1 14446,0 14453,1 14459,0 14543,1 14619,0 14702,1 14787,0 14887,1 14925,0 14998,1 15018,0 15083,1 15112,0 15202,1 15266,0 15301,1 15348,0 15433,1 15439,0 15459,1 15495,0 15555,1 15655,0 15707,1 15738,0 15800,1 15893,0 15929,1 15980,0 15997,1 16027,0 16028,1 16029,0 16041,1 16126,0 16185,1 16267,0 16361,1 16404,0 16490,1 16505,0 16537,1 16632,0 16661,1 16737,0 16748,1 16825,0 16832,1 16908,0 16952,1 16968,0 17030,1 17070,0 17086,1 17165,0 17211,1 17270,0 17366,1 17445,0 17538,1 17552,0 17569,1 17633,0 17700,1 17739,0 17818,1 17881,0 17967,1 18006,0 18094,1 18131,0 18221,1 18243,0 18306,1 18333,0 18403,1 18424,0 18522,1 18541,0 18595,1 18600,0 18636,1 18734,0 18750,1 18787,0 18839,1 18890,0 18918,1 18968,0 19046,1 19068,0 19113,1 19209,0 19212,1 19303,0 19399,1 19481,0 19552,1 19554,0 19571,1 19654,0 19733,1 19775,0 19794,1 19857,0 19909,1 19967,0 19983,1 20018,0 20063,1 20075,0 20174,1 20246,0 20332,1 20387,0 20464,1 20563,0 20643,1 20728,0 20766,1 20780,0 20797,1 20881,0 20905,1 20925,0 21025,1 21067,0 21140,1 21151,0 21158,1 21193,0 21259,1 21336,0 21354,1 21403,0 21457,1 21469,0 21501,1 21549,0 21565,1 21605,0 21643,1 21729,0 21779,1 21844,0 21883,1 21967,0 22002,1 22101,0 22131,1 22151,0 22234,1 22284,0 22301,1 22388,0 22432,1 22437,0 22486,1 22496,0 22541,1 22557,0 22586,1 22608,0 22618,1 22654,0 22697,1 22749,0 22754,1 22822,0 22832,1 22887,0 22987,1 23060,0 23085,1 23087,0 23170,1 23269,0 23361,1 23364,0 23432,1 23520,0 23568,1 23649,0 23709,1 23750,0 23807,1 23834,0 23902,1 23999,0 24005,1 24060,0 24157,1 24253,0 24329,1 24392,0 24403,1 24465,0 24537,1 24556,0 24619,1 24709,0 24790,1 24877,0 24894,1 24986,0 24991,1 25048,0 25129,1 25196,0 25275,1 25353,0 25409,1 25418,0 25469,1 25478,0 25480,1 25516,0 25610,1 25706,0 25788,1 25836,0 25909,1 25938,0 25961,1 26047,0 26081,1 26132,0 26140,1 26193,0 26290,1 26383,0 26388,1 26439,0 26499,1 26506,0 26511,1 26564,0 26628,1 26665,0 26756,1 26790,0 26829,1 26928,0 26930,1 26934,0 26950,1 26997,0 27096,1 27181,0 27279,1 27345,0 27367,1 27373,0 27385,1 27456,0 27479,1 27509,0 27597,1 27686,0 27702,1 27722,0 27740,1 27809,0 27901,1 27963,0 28062,1 28078,0 28118,1 28138,0 28167,1 28236,0 28273,1 28293,0 28318,1 28382,0 28472,1 28535,0 28561,1 28590,0 28633,1 28705,0 28804,1 28895,0 28906,1 28964,0 29055,1 29077,0 29172,1 29241,0 29288,1 29332,0 29341,1 29416,0 29492,1 29506,0 29525,1 29546,0 29568,1 29645,0 29665,1 29712,0 29783,1 29790,0 29836,1 29838,0 29840,1 29844,0 29880,1 29938,0 29991,1 30023,0 30065,1 30156,0 30244,1 30310,0 30351,1 30417,0 30436,1 30441,0 30503,1 30597,0 30678,1 30739,0 30740,1 30775,0 30807,1 30864,0 30932,1 30968,0 31016,1 31047,0 31064,1 31159,0 31185,1 31208,0 31242,1 31262,0 31347,1 31360,0 31440,1 31468,0 31562,1 31587,0 31655,1 31677,0 31687,1 31691,0 31765,1 31840,0 31844,1 31870,0 31951,1 32051,0 32073,1 32094,0 32109,1 32197,0 32238,1 32256,0 32354,1 32420,0 32451,1 32491,0 32566,1 32592,0 32659,1 32693,0 32701,1 32704,0 32770,1 32798,0 32874,1 32919,0 32961,1 33049,0 33116,1 33171,0 33193,1 33267,0 33350,1 33356,0 33362,1 33412,0 33506,1 33507,0 33586,1 33642,0 33695,1 33775,0 33845,1 33864,0 33912,1 33948,0 34028,1 34061,0 34134,1 34156,0 34242,1 34270,0 34293,1 34377,0 34458,1 34468,0 34488,1 34516,0 34535,1 34559,0 34659,1 34669,0 34708,1 34756,0 34771,1 34785,0 34797,1 34883,0 34942,1 35007,0 35026,1 35030,0 35069,1 35135,0 35147,1 35167,0 35245,1 35321,0 35332,1 35407,0 35438,1 35524,0 35560,1 35591,0 35645,1 35702,0 35769,1 35843,0 35911,1 35957,0 35991,1 36027,0 36085,1 36088,0 36136,1 36155,0 36244,1 36289,0 36294,1 36343,0 36367,1 36460,0 36521,1 36554,0 36643,1 36719,0 36772,1 36813,0 36827,1 36857,0 36924,1 36958,0 37043,1 37116,0 37195,1 37266,0 37298,1 37306,0 37361,1 37378,0 37382,1 37441,0 37454,1 37460,0 37559,1 37572,0 37575,1 37600,0 37620,1 37670,0 37726,1 37762,0 37843,1 37865,0 37902,1 37989,0 38019,1 38065,0 38085,1 38106,0 38147,1 38234,0 38309,1 38392,0 38492,1 38586,0 38678,1 38762,0 38844,1 38929,0 38988,1 38994,0 39091,1 39146,0 39187,1 39227,0 39281,1 39373,0 39471,1 39508,0 39589,1 39685,0 39690,1 39766,0 39829,1 39905,0 39967,1 39981,0 40034,1 40105,0 40195,1 40239,0 40336,1 40425,0 40495,1 40581,0 40641,1 40694,0 40780,1 40793,0 40826,1 40883,0 40979,1 41032,0 41130,1 41155,0 41241,1 41245,0 41315,1 41389,0 41403,1 41467,0 41547,1 41585,0 41662,1 41757,0 41776,1 41813,0 41886,1 41905,0 41931,1 41946,0 42032,1 42047,0 42055,1 42108,0 42160,1 42191,0 42280,1 42340,0 42414,1 42470,0 42503,1 42602,0 42605,1 42657,0 42690,1 42717,0 42756,1 42787,0 42797,1 42832,0 42876,1 42893,0 42981,1 43072,0 43145,1 43198,0 43235,1 43306,0 43392,1 43476,0 43502,1 43549,0 43567,1 43570,0 43600,1 43672,0 43693,1 43733,0 43781,1 43857,0 43916,1 43921,0 43948,1 44020,0 44110,1 44117,0 44155,1 44253,0 44271,1 44296,0 44389,1 44429,0 44527,1 44612,0 44688,1 44741,0 44748,1 44847,0 44885,1 44943,0 44950,1 44976,0 45013,1 45046,0 45073,1 45093,0 45132,1 45169,0 45203,1 45225,0 45295,1 45328,0 45394,1 45418,0 45464,1 45494,0 45576,1 45595,0 45680,1 45731,0 45740,1 45770,0 45864,1 45917,0 45995,1 46074,0 46173,1 46210,0 46221,1 46311,0 46334,1 46431,0 46495,1 46513,0 46584,1 46636,0 46703,1 46792,0 46807,1 46838,0 46878,1 46898,0 46967,1 47049,0 47149,1 47184,0 47245,1 47257,0 47259,1 47327,0 47378,1 47391,0 47449,1 47547,0 47625,1 47653,0 47694,1 47777,0 47872,1 47925,0 48010,1 48055,0 48146,1 48148,0 48155,1 48201,0 48247,1 48321,0 48406,1 48434,0 48515,1 48555,0 48604,1 48686,0 48762,1 48786,0 48828,1 48860,0 48898,1 48973,0 49015,1 49059,0 49143,1 49200,0 49298,1 49314,0 49316,1 49372,0 49392,1 49464,0 49497,1 49591,0 49618,1 49663,0 49668,1 49743,0 49757,1 49791,0 49888,1 49943,0 49996,1 50031,0 50062,1 50108,0 50176,1 50211,0 50280,1 end initlist c11 0,0 65,1 138,0 238,1 307,0 314,1 390,0 475,1 479,0 552,1 595,0 641,1 685,0 696,1 748,0 789,1 856,0 931,1 1022,0 1094,1 1131,0 1206,1 1275,0 1372,1 1410,0 1507,1 1589,0 1674,1 1695,0 1731,1 1799,0 1883,1 1899,0 1952,1 1989,0 2064,1 2164,0 2238,1 2296,0 2356,1 2456,0 2489,1 2588,0 2598,1 2601,0 2638,1 2685,0 2783,1 2829,0 2907,1 2947,0 2958,1 3014,0 3070,1 3117,0 3188,1 3240,0 3268,1 3364,0 3391,1 3438,0 3521,1 3552,0 3560,1 3568,0 3607,1 3639,0 3734,1 3766,0 3819,1 3884,0 3936,1 4010,0 4101,1 4153,0 4242,1 4268,0 4305,1 4370,0 4438,1 4466,0 4512,1 4527,0 4589,1 4682,0 4694,1 4766,0 4830,1 4881,0 4922,1 5017,0 5114,1 5192,0 5244,1 5264,0 5352,1 5374,0 5396,1 5437,0 5442,1 5469,0 5471,1 5495,0 5592,1 5662,0 5742,1 5812,0 5892,1 5898,0 5904,1 5953,0 6015,1 6066,0 6153,1 6159,0 6195,1 6246,0 6324,1 6407,0 6496,1 6535,0 6590,1 6652,0 6675,1 6757,0 6832,1 6860,0 6889,1 6947,0 6964,1 7048,0 7087,1 7160,0 7174,1 7255,0 7270,1 7319,0 7368,1 7446,0 7503,1 7508,0 7572,1 7621,0 7678,1 7685,0 7709,1 7751,0 7811,1 7910,0 7958,1 8022,0 8038,1 8097,0 8137,1 8206,0 8263,1 8274,0 8329,1 8380,0 8391,1 8408,0 8416,1 8436,0 8501,1 8572,0 8672,1 8737,0 8837,1 8898,0 8985,1 9045,0 9130,1 9181,0 9217,1 9228,0 9272,1 9344,0 9401,1 9469,0 9523,1 9619,0 9664,1 9762,0 9765,1 9817,0 9874,1 9901,0 9991,1 10062,0 10093,1 10135,0 10174,1 10217,0 10239,1 10304,0 10316,1 10384,0 10450,1 10526,0 10530,1 10577,0 10668,1 10689,0 10737,1 10797,0 10824,1 10880,0 10958,1 10999,0 11068,1 11133,0 11164,1 11178,0 11186,1 11257,0 11305,1 11380,0 11448,1 11484,0 11583,1 11639,0 11717,1 11808,0 11826,1 11837,0 11927,1 11986,0 12031,1 12048,0 12065,1 12148,0 12225,1 12278,0 12306,1 12384,0 12411,1 12439,0 12484,1 12504,0 12506,1 12524,0 12566,1 12599,0 12655,1 12741,0 12773,1 12873,0 12898,1 12949,0 13004,1 13077,0 13151,1 13218,0 13287,1 13365,0 13397,1 13485,0 13509,1 13560,0 13594,1 13680,0 13732,1 13774,0 13872,1 13937,0 13968,1 13986,0 14079,1 14132,0 14155,1 14243,0 14325,1 14336,0 14361,1 14389,0 14424,1 14467,0 14490,1 14518,0 14557,1 14632,0 14643,1 14722,0 14801,1 14890,0 14955,1 15014,0 15056,1 15075,0 15167,1 15202,0 15267,1 15352,0 15440,1 15459,0 15529,1 15583,0 15674,1 15749,0 15792,1 15813,0 15904,1 15995,0 16090,1 16174,0 16183,1 16253,0 16322,1 16413,0 16425,1 16446,0 16499,1 16545,0 16592,1 16692,0 16784,1 16849,0 16924,1 16948,0 17037,1 17044,0 17141,1 17235,0 17285,1 17339,0 17412,1 17453,0 17455,1 17506,0 17596,1 17681,0 17739,1 17769,0 17801,1 17893,0 17938,1 17945,0 17990,1 18077,0 18102,1 18176,0 18250,1 18293,0 18342,1 18400,0 18458,1 18463,0 18541,1 18553,0 18592,1 18677,0 18701,1 18707,0 18765,1 18774,0 18852,1 18909,0 18939,1 18983,0 19033,1 19059,0 19083,1 19137,0 19145,1 19218,0 19224,1 19255,0 19285,1 19360,0 19437,1 19480,0 19559,1 19625,0 19640,1 19678,0 19741,1 19757,0 19773,1 19845,0 19890,1 19939,0 20023,1 20062,0 20093,1 20101,0 20103,1 20173,0 20231,1 20278,0 20371,1 20427,0 20484,1 20584,0 20648,1 20745,0 20811,1 20866,0 20916,1 20991,0 21018,1 21033,0 21057,1 21157,0 21232,1 21289,0 21350,1 21428,0 21461,1 21479,0 21499,1 21551,0 21580,1 21642,0 21741,1 21801,0 21887,1 21941,0 21988,1 22036,0 22046,1 22076,0 22144,1 22217,0 22257,1 22311,0 22326,1 22333,0 22412,1 22492,0 22534,1 22546,0 22586,1 22646,0 22709,1 22767,0 22828,1 22904,0 22912,1 22937,0 22980,1 23030,0 23093,1 23178,0 23240,1 23311,0 23399,1 23465,0 23467,1 23491,0 23492,1 23565,0 23613,1 23616,0 23699,1 23769,0 23847,1 23928,0 23935,1 24015,0 24059,1 24121,0 24174,1 24227,0 24284,1 24311,0 24381,1 24418,0 24449,1 24543,0 24633,1 24692,0 24767,1 24822,0 24895,1 24912,0 24985,1 25035,0 25074,1 25087,0 25106,1 25165,0 25220,1 25291,0 25300,1 25392,0 25471,1 25479,0 25537,1 25563,0 25651,1 25726,0 25772,1 25781,0 25831,1 25913,0 25992,1 26036,0 26097,1 26134,0 26184,1 26249,0 26343,1 26362,0 26407,1 26420,0 26480,1 26533,0 26600,1 26642,0 26712,1 26780,0 26853,1 26920,0 27008,1 27021,0 27094,1 27154,0 27229,1 27299,0 27307,1 27384,0 27428,1 27464,0 27560,1 27596,0 27690,1 27703,0 27751,1 27837,0 27928,1 27954,0 28040,1 28101,0 28197,1 28205,0 28267,1 28363,0 28394,1 28406,0 28445,1 28467,0 28562,1 28569,0 28575,1 28624,0 28688,1 28703,0 28735,1 28757,0 28830,1 28930,0 29023,1 29063,0 29091,1 29127,0 29154,1 29195,0 29279,1 29372,0 29423,1 29491,0 29539,1 29563,0 29585,1 29617,0 29665,1 29683,0 29743,1 29778,0 29810,1 29839,0 29908,1 29971,0 30033,1 30123,0 30193,1 30209,0 30258,1 30311,0 30357,1 30380,0 30430,1 30501,0 30504,1 30568,0 30578,1 30671,0 30771,1 30790,0 30796,1 30808,0 30838,1 30879,0 30892,1 30901,0 30981,1 31039,0 31121,1 31129,0 31193,1 31249,0 31284,1 31328,0 31374,1 31420,0 31435,1 31501,0 31560,1 31588,0 31599,1 31633,0 31684,1 31708,0 31791,1 31836,0 31933,1 31981,0 32016,1 32025,0 32093,1 32131,0 32151,1 32211,0 32267,1 32307,0 32318,1 32328,0 32342,1 32382,0 32451,1 32457,0 32477,1 32509,0 32575,1 32622,0 32701,1 32772,0 32800,1 32849,0 32885,1 32904,0 32951,1 33020,0 33075,1 33129,0 33182,1 33256,0 33298,1 33304,0 33316,1 33391,0 33425,1 33466,0 33516,1 33608,0 33624,1 33666,0 33688,1 33724,0 33753,1 33826,0 33914,1 33992,0 34051,1 34060,0 34134,1 34149,0 34181,1 34201,0 34257,1 34282,0 34376,1 34423,0 34511,1 34527,0 34611,1 34682,0 34776,1 34867,0 34875,1 34882,0 34978,1 35077,0 35163,1 35196,0 35214,1 35254,0 35319,1 35397,0 35495,1 35578,0 35636,1 35690,0 35749,1 35845,0 35874,1 35915,0 35955,1 36044,0 36095,1 36107,0 36176,1 36216,0 36222,1 36249,0 36281,1 36305,0 36320,1 36403,0 36424,1 36462,0 36521,1 36596,0 36612,1 36616,0 36635,1 36707,0 36783,1 36809,0 36896,1 36944,0 36970,1 37047,0 37119,1 37201,0 37281,1 37371,0 37435,1 37534,0 37563,1 37620,0 37630,1 37643,0 37742,1 37746,0 37763,1 37857,0 37918,1 37950,0 38006,1 38091,0 38182,1 38267,0 38364,1 38431,0 38517,1 38567,0 38594,1 38647,0 38737,1 38773,0 38795,1 38887,0 38987,1 38990,0 39036,1 39129,0 39159,1 39259,0 39272,1 39364,0 39444,1 39518,0 39569,1 39611,0 39672,1 39753,0 39768,1 39815,0 39890,1 39976,0 40003,1 40054,0 40107,1 40196,0 40199,1 40202,0 40264,1 40284,0 40379,1 40383,0 40394,1 40477,0 40481,1 40548,0 40595,1 40655,0 40707,1 40779,0 40853,1 40953,0 40961,1 41023,0 41065,1 41149,0 41194,1 41218,0 41318,1 41324,0 41372,1 41391,0 41409,1 41411,0 41485,1 41528,0 41559,1 41597,0 41632,1 41715,0 41806,1 41840,0 41890,1 41950,0 41956,1 41989,0 42052,1 42131,0 42183,1 42191,0 42209,1 42227,0 42261,1 42293,0 42390,1 42484,0 42525,1 42604,0 42648,1 42697,0 42704,1 42775,0 42802,1 42833,0 42858,1 42910,0 42994,1 43069,0 43159,1 43201,0 43221,1 43272,0 43369,1 43398,0 43416,1 43474,0 43549,1 43574,0 43616,1 43635,0 43674,1 43711,0 43721,1 43800,0 43869,1 43877,0 43890,1 43977,0 43984,1 44052,0 44110,1 44179,0 44238,1 44284,0 44345,1 44419,0 44463,1 44555,0 44597,1 44694,0 44736,1 44746,0 44842,1 44889,0 44951,1 45013,0 45051,1 45065,0 45086,1 45136,0 45207,1 45261,0 45320,1 45354,0 45430,1 45468,0 45481,1 45504,0 45513,1 45568,0 45583,1 45660,0 45676,1 45680,0 45707,1 45782,0 45874,1 45949,0 46047,1 46058,0 46140,1 46173,0 46202,1 46262,0 46325,1 46332,0 46375,1 46455,0 46537,1 46548,0 46566,1 46590,0 46648,1 46672,0 46698,1 46768,0 46785,1 46853,0 46876,1 46914,0 46933,1 47018,0 47112,1 47163,0 47220,1 47311,0 47325,1 47421,0 47475,1 47559,0 47572,1 47605,0 47691,1 47723,0 47770,1 47801,0 47874,1 47923,0 48010,1 48028,0 48061,1 48133,0 48157,1 48178,0 48223,1 48319,0 48376,1 48450,0 48472,1 48516,0 48602,1 48673,0 48678,1 48699,0 48757,1 48763,0 48773,1 48807,0 48866,1 48907,0 48935,1 48989,0 49073,1 49097,0 49167,1 49250,0 49305,1 49329,0 49357,1 49365,0 49446,1 49505,0 49573,1 49626,0 49714,1 49718,0 49789,1 49804,0 49873,1 49919,0 49941,1 49963,0 50002,1 50057,0 50073,1 50076,0 50166,1 50233,0 50323,1 50423,0 50487,1 50550,0 50588,1 50628,0 50642,1 50708,0 50727,1 50766,0 50779,1 50818,0 50843,1 50903,0 50997,1 end initlist c12 0,0 21,1 119,0 123,1 138,0 142,1 146,0 170,1 250,0 296,1 315,0 383,1 430,0 441,1 468,0 510,1 563,0 624,1 719,0 738,1 833,0 869,1 891,0 972,1 1054,0 1085,1 1101,0 1103,1 1112,0 1156,1 1162,0 1251,1 1315,0 1327,1 1343,0 1409,1 1424,0 1436,1 1516,0 1591,1 1649,0 1667,1 1694,0 1760,1 1848,0 1938,1 1949,0 1994,1 2060,0 2061,1 2082,0 2111,1 2120,0 2207,1 2266,0 2285,1 2379,0 2395,1 2409,0 2430,1 2452,0 2497,1 2547,0 2593,1 2664,0 2672,1 2772,0 2804,1 2814,0 2823,1 2832,0 2834,1 2909,0 3009,1 3095,0 3160,1 3260,0 3275,1 3348,0 3414,1 3500,0 3512,1 3573,0 3593,1 3634,0 3638,1 3704,0 3790,1 3848,0 3934,1 3937,0 3986,1 4052,0 4134,1 4208,0 4262,1 4317,0 4415,1 4438,0 4470,1 4501,0 4512,1 4607,0 4707,1 4729,0 4794,1 4886,0 4898,1 4942,0 4948,1 4968,0 4996,1 5069,0 5134,1 5174,0 5201,1 5229,0 5296,1 5338,0 5368,1 5403,0 5482,1 5501,0 5516,1 5589,0 5613,1 5692,0 5792,1 5815,0 5866,1 5887,0 5888,1 5953,0 6008,1 6020,0 6077,1 6096,0 6138,1 6141,0 6163,1 6175,0 6183,1 6186,0 6237,1 6290,0 6332,1 6361,0 6384,1 6479,0 6539,1 6545,0 6566,1 6596,0 6608,1 6658,0 6712,1 6765,0 6769,1 6869,0 6943,1 7036,0 7092,1 7158,0 7217,1 7220,0 7316,1 7318,0 7408,1 7487,0 7568,1 7623,0 7653,1 7712,0 7793,1 7875,0 7936,1 7998,0 8004,1 8091,0 8154,1 8222,0 8231,1 8286,0 8366,1 8413,0 8464,1 8549,0 8598,1 8601,0 8633,1 8733,0 8734,1 8774,0 8857,1 8951,0 9024,1 9051,0 9102,1 9133,0 9171,1 9253,0 9340,1 9395,0 9485,1 9575,0 9593,1 9663,0 9671,1 9765,0 9782,1 9877,0 9896,1 9955,0 10051,1 10081,0 10177,1 10259,0 10344,1 10400,0 10436,1 10518,0 10580,1 10655,0 10664,1 10736,0 10744,1 10792,0 10831,1 10834,0 10876,1 10929,0 10988,1 11082,0 11177,1 11265,0 11309,1 11360,0 11373,1 11472,0 11523,1 11548,0 11582,1 11591,0 11661,1 11730,0 11732,1 11736,0 11805,1 11896,0 11961,1 11986,0 12002,1 12039,0 12080,1 12180,0 12181,1 12184,0 12252,1 12315,0 12356,1 12368,0 12369,1 12418,0 12501,1 12599,0 12630,1 12725,0 12769,1 12859,0 12909,1 12974,0 13041,1 13088,0 13165,1 13166,0 13261,1 13331,0 13354,1 13422,0 13456,1 13546,0 13587,1 13654,0 13691,1 13699,0 13794,1 13872,0 13927,1 13991,0 14070,1 14143,0 14171,1 14262,0 14328,1 14397,0 14469,1 14541,0 14640,1 14711,0 14762,1 14781,0 14839,1 14936,0 14960,1 15027,0 15101,1 15136,0 15138,1 15143,0 15160,1 15212,0 15224,1 15250,0 15318,1 15412,0 15489,1 15550,0 15561,1 15602,0 15635,1 15642,0 15723,1 15788,0 15861,1 15868,0 15905,1 15945,0 15972,1 16045,0 16103,1 16132,0 16200,1 16244,0 16320,1 16321,0 16391,1 16421,0 16476,1 16494,0 16560,1 16620,0 16649,1 16676,0 16727,1 16815,0 16824,1 16898,0 16992,1 17013,0 17068,1 17119,0 17136,1 17185,0 17233,1 17276,0 17326,1 17363,0 17391,1 17478,0 17489,1 17565,0 17588,1 17679,0 17749,1 17842,0 17929,1 17954,0 18044,1 18140,0 18188,1 18274,0 18292,1 18351,0 18385,1 18445,0 18526,1 18609,0 18619,1 18716,0 18804,1 18825,0 18901,1 18953,0 19002,1 19010,0 19031,1 19078,0 19161,1 19256,0 19331,1 19347,0 19367,1 19378,0 19440,1 19474,0 19532,1 19550,0 19613,1 19623,0 19706,1 19754,0 19768,1 19839,0 19859,1 19894,0 19964,1 20004,0 20069,1 20120,0 20187,1 20217,0 20239,1 20292,0 20352,1 20369,0 20375,1 20455,0 20471,1 20552,0 20580,1 20632,0 20675,1 20687,0 20749,1 20812,0 20827,1 20898,0 20907,1 21000,0 21073,1 21131,0 21140,1 21187,0 21268,1 21367,0 21368,1 21382,0 21469,1 21526,0 21598,1 21655,0 21723,1 21746,0 21799,1 21843,0 21903,1 21956,0 22031,1 22035,0 22080,1 22176,0 22194,1 22202,0 22292,1 22392,0 22479,1 22545,0 22546,1 22637,0 22696,1 22782,0 22797,1 22874,0 22916,1 22939,0 22959,1 23033,0 23122,1 23208,0 23287,1 23342,0 23370,1 23375,0 23402,1 23501,0 23531,1 23547,0 23623,1 23628,0 23690,1 23762,0 23775,1 23854,0 23893,1 23951,0 23979,1 23993,0 24021,1 24077,0 24137,1 24157,0 24223,1 24249,0 24346,1 24396,0 24401,1 24419,0 24443,1 24527,0 24615,1 24693,0 24736,1 24770,0 24775,1 24811,0 24902,1 25002,0 25100,1 25190,0 25209,1 25210,0 25211,1 25240,0 25271,1 25371,0 25449,1 25453,0 25486,1 25518,0 25611,1 25635,0 25707,1 25761,0 25785,1 25827,0 25875,1 25960,0 25974,1 26026,0 26053,1 26153,0 26209,1 26231,0 26238,1 26271,0 26352,1 26409,0 26450,1 26469,0 26533,1 26595,0 26611,1 26625,0 26626,1 26638,0 26648,1 26715,0 26809,1 26882,0 26951,1 26981,0 27046,1 27074,0 27091,1 27098,0 27143,1 27145,0 27227,1 27314,0 27404,1 27453,0 27470,1 27569,0 27603,1 27628,0 27728,1 27785,0 27822,1 27863,0 27929,1 28007,0 28084,1 28108,0 28112,1 28171,0 28258,1 28341,0 28401,1 28434,0 28496,1 28564,0 28615,1 28701,0 28752,1 28754,0 28765,1 28799,0 28893,1 28916,0 29000,1 29099,0 29192,1 29279,0 29280,1 29351,0 29421,1 29448,0 29530,1 29614,0 29648,1 29709,0 29741,1 29744,0 29811,1 29878,0 29945,1 30042,0 30128,1 30228,0 30304,1 30321,0 30365,1 30394,0 30411,1 30419,0 30466,1 30489,0 30571,1 30635,0 30637,1 30714,0 30769,1 30853,0 30870,1 30878,0 30939,1 30999,0 31095,1 31163,0 31175,1 31191,0 31203,1 31205,0 31223,1 31259,0 31355,1 31370,0 31424,1 31517,0 31617,1 31697,0 31728,1 31798,0 31829,1 31866,0 31915,1 31936,0 31981,1 32061,0 32083,1 32097,0 32108,1 32178,0 32252,1 32316,0 32327,1 32370,0 32428,1 32506,0 32507,1 32548,0 32642,1 32660,0 32739,1 32837,0 32892,1 32945,0 33017,1 33065,0 33112,1 33178,0 33205,1 33212,0 33261,1 33322,0 33331,1 33341,0 33342,1 33407,0 33463,1 33558,0 33636,1 33647,0 33666,1 33685,0 33712,1 33812,0 33872,1 33883,0 33910,1 33974,0 34024,1 34078,0 34117,1 34207,0 34232,1 34286,0 34313,1 34326,0 34394,1 34453,0 34462,1 34558,0 34631,1 34654,0 34748,1 34762,0 34764,1 34819,0 34889,1 34948,0 35028,1 35079,0 35104,1 35194,0 35240,1 35242,0 35287,1 35322,0 35407,1 35432,0 35461,1 35476,0 35487,1 35561,0 35576,1 35607,0 35623,1 35712,0 35789,1 35799,0 35813,1 35907,0 35986,1 36015,0 36017,1 36085,0 36116,1 36159,0 36193,1 36206,0 36284,1 36360,0 36450,1 36522,0 36591,1 36599,0 36697,1 36699,0 36708,1 36781,0 36798,1 36867,0 36950,1 37000,0 37021,1 37106,0 37126,1 37166,0 37186,1 37247,0 37321,1 37388,0 37474,1 37501,0 37551,1 37582,0 37671,1 37675,0 37684,1 37747,0 37815,1 37863,0 37864,1 37945,0 38003,1 38005,0 38042,1 38070,0 38131,1 38156,0 38226,1 38252,0 38331,1 38422,0 38479,1 38534,0 38590,1 38619,0 38649,1 38654,0 38665,1 38689,0 38774,1 38794,0 38865,1 38891,0 38986,1 39033,0 39036,1 39125,0 39139,1 39225,0 39293,1 39334,0 39432,1 39516,0 39520,1 39568,0 39665,1 39692,0 39774,1 39794,0 39829,1 39918,0 39959,1 40015,0 40064,1 40132,0 40180,1 40240,0 40316,1 40344,0 40351,1 40409,0 40420,1 40476,0 40506,1 40546,0 40614,1 40617,0 40711,1 40741,0 40779,1 40872,0 40908,1 40933,0 40934,1 40985,0 41064,1 41079,0 41146,1 41206,0 41296,1 41356,0 41421,1 41514,0 41609,1 41636,0 41647,1 41679,0 41683,1 41754,0 41853,1 41895,0 41976,1 42004,0 42025,1 42055,0 42085,1 42173,0 42238,1 42256,0 42267,1 42356,0 42384,1 42479,0 42550,1 42567,0 42663,1 42700,0 42773,1 42774,0 42823,1 42882,0 42981,1 43014,0 43048,1 43122,0 43211,1 43311,0 43387,1 43480,0 43550,1 43601,0 43631,1 43692,0 43701,1 43727,0 43783,1 43828,0 43916,1 43983,0 44034,1 44089,0 44116,1 44187,0 44234,1 44301,0 44302,1 44306,0 44369,1 44437,0 44502,1 44598,0 44648,1 44739,0 44789,1 44886,0 44897,1 44928,0 45018,1 45078,0 45104,1 45170,0 45262,1 45265,0 45313,1 45332,0 45426,1 45466,0 45499,1 45507,0 45579,1 45634,0 45682,1 45768,0 45860,1 45920,0 45933,1 46009,0 46051,1 46071,0 46085,1 46137,0 46218,1 46247,0 46287,1 46323,0 46360,1 46395,0 46397,1 46398,0 46403,1 46408,0 46462,1 46510,0 46545,1 46639,0 46701,1 46755,0 46781,1 46874,0 46886,1 46926,0 46941,1 46988,0 47086,1 47177,0 47263,1 47303,0 47352,1 47425,0 47457,1 47526,0 47614,1 47652,0 47664,1 47692,0 47781,1 47821,0 47893,1 47972,0 47975,1 47981,0 48002,1 48083,0 48158,1 48256,0 48348,1 48421,0 48498,1 48566,0 48576,1 48602,0 48668,1 48752,0 48844,1 48913,0 48985,1 49059,0 49077,1 49135,0 49153,1 49240,0 49318,1 49370,0 49411,1 49511,0 49541,1 49562,0 49597,1 end initlist c13 0,0 81,1 117,0 157,1 178,0 216,1 236,0 328,1 362,0 423,1 465,0 475,1 555,0 587,1 623,0 669,1 683,0 726,1 730,0 770,1 835,0 853,1 860,0 945,1 1007,0 1088,1 1183,0 1220,1 1316,0 1390,1 1455,0 1507,1 1548,0 1554,1 1615,0 1714,1 1729,0 1733,1 1736,0 1746,1 1801,0 1862,1 1877,0 1889,1 1892,0 1972,1 1999,0 2011,1 2074,0 2101,1 2134,0 2135,1 2170,0 2215,1 2232,0 2242,1 2267,0 2276,1 2326,0 2352,1 2438,0 2454,1 2536,0 2579,1 2659,0 2746,1 2755,0 2761,1 2848,0 2857,1 2941,0 3012,1 3102,0 3143,1 3240,0 3294,1 3315,0 3354,1 3364,0 3454,1 3553,0 3587,1 3679,0 3778,1 3803,0 3826,1 3903,0 3927,1 4018,0 4050,1 4143,0 4213,1 4270,0 4289,1 4308,0 4373,1 4382,0 4432,1 4508,0 4547,1 4551,0 4559,1 4566,0 4636,1 4645,0 4714,1 4749,0 4839,1 4855,0 4896,1 4969,0 5014,1 5114,0 5146,1 5201,0 5237,1 5269,0 5350,1 5395,0 5450,1 5544,0 5586,1 5594,0 5676,1 5743,0 5784,1 5805,0 5861,1 5930,0 5945,1 6035,0 6110,1 6181,0 6266,1 6285,0 6318,1 6412,0 6498,1 6598,0 6679,1 6754,0 6840,1 6895,0 6903,1 6999,0 7078,1 7162,0 7231,1 7290,0 7355,1 7423,0 7508,1 7554,0 7597,1 7630,0 7725,1 7766,0 7866,1 7909,0 7960,1 8036,0 8050,1 8093,0 8110,1 8137,0 8143,1 8216,0 8315,1 8380,0 8413,1 8447,0 8543,1 8610,0 8691,1 8697,0 8770,1 8814,0 8858,1 8883,0 8967,1 8978,0 9076,1 9157,0 9167,1 9206,0 9239,1 9254,0 9276,1 9305,0 9384,1 9424,0 9482,1 9517,0 9539,1 9544,0 9581,1 9583,0 9682,1 9775,0 9844,1 9865,0 9873,1 9933,0 9974,1 10011,0 10031,1 10119,0 10188,1 10242,0 10305,1 10314,0 10324,1 10399,0 10495,1 10593,0 10684,1 10754,0 10804,1 10827,0 10884,1 10892,0 10988,1 11019,0 11057,1 11109,0 11168,1 11253,0 11324,1 11413,0 11423,1 11476,0 11553,1 11557,0 11563,1 11643,0 11693,1 11780,0 11838,1 11886,0 11948,1 11983,0 11984,1 12010,0 12028,1 12076,0 12150,1 12201,0 12250,1 12277,0 12295,1 12395,0 12474,1 12568,0 12653,1 12706,0 12751,1 12811,0 12823,1 12888,0 12917,1 12996,0 13080,1 13111,0 13126,1 13205,0 13295,1 13323,0 13329,1 13407,0 13420,1 13446,0 13486,1 13568,0 13614,1 13707,0 13755,1 13800,0 13811,1 13825,0 13875,1 13882,0 13941,1 14023,0 14121,1 14126,0 14167,1 14247,0 14314,1 14365,0 14390,1 14471,0 14535,1 14549,0 14566,1 14640,0 14726,1 14775,0 14820,1 14842,0 14874,1 14889,0 14952,1 14993,0 15015,1 15107,0 15113,1 15115,0 15147,1 15200,0 15211,1 15287,0 15311,1 15409,0 15507,1 15546,0 15550,1 15572,0 15650,1 15688,0 15698,1 15714,0 15723,1 15810,0 15857,1 15859,0 15900,1 15937,0 15954,1 16020,0 16083,1 16143,0 16150,1 16198,0 16279,1 16287,0 16330,1 16349,0 16394,1 16457,0 16501,1 16572,0 16587,1 16590,0 16678,1 16760,0 16799,1 16891,0 16947,1 16951,0 17000,1 17086,0 17090,1 17182,0 17202,1 17253,0 17263,1 17307,0 17387,1 17420,0 17508,1 17597,0 17603,1 17623,0 17668,1 17733,0 17785,1 17816,0 17890,1 17939,0 17955,1 17976,0 18007,1 18100,0 18116,1 18159,0 18257,1 18271,0 18306,1 18363,0 18441,1 18449,0 18527,1 18620,0 18669,1 18696,0 18756,1 18799,0 18888,1 18920,0 18948,1 19001,0 19032,1 19074,0 19084,1 19088,0 19098,1 19197,0 19230,1 19266,0 19283,1 19314,0 19354,1 19428,0 19523,1 19598,0 19619,1 19645,0 19743,1 19756,0 19784,1 19841,0 19933,1 19987,0 20047,1 20120,0 20186,1 20215,0 20253,1 20313,0 20347,1 20403,0 20416,1 20425,0 20461,1 20473,0 20532,1 20618,0 20710,1 20725,0 20824,1 20895,0 20924,1 20934,0 21004,1 21067,0 21105,1 21153,0 21167,1 21170,0 21179,1 21213,0 21291,1 21353,0 21408,1 21409,0 21474,1 21503,0 21511,1 21570,0 21632,1 21661,0 21686,1 21763,0 21836,1 21869,0 21905,1 21947,0 22045,1 22053,0 22064,1 22098,0 22127,1 22175,0 22197,1 22226,0 22237,1 22298,0 22359,1 22374,0 22446,1 22527,0 22536,1 22584,0 22654,1 22656,0 22698,1 22761,0 22778,1 22821,0 22890,1 22985,0 23077,1 23134,0 23182,1 23195,0 23214,1 23222,0 23320,1 23398,0 23427,1 23493,0 23582,1 23597,0 23674,1 23731,0 23831,1 23860,0 23885,1 23921,0 23953,1 24043,0 24120,1 24215,0 24271,1 24281,0 24288,1 24388,0 24412,1 24456,0 24527,1 24609,0 24657,1 24692,0 24704,1 24764,0 24848,1 24944,0 24960,1 25011,0 25093,1 25193,0 25222,1 25282,0 25333,1 25417,0 25499,1 25510,0 25569,1 25585,0 25673,1 25689,0 25695,1 25721,0 25806,1 25888,0 25983,1 26009,0 26083,1 26170,0 26266,1 26271,0 26336,1 26386,0 26400,1 26484,0 26563,1 26593,0 26649,1 26682,0 26724,1 26751,0 26772,1 26781,0 26845,1 26876,0 26969,1 26995,0 27061,1 27140,0 27176,1 27201,0 27234,1 27251,0 27260,1 27342,0 27428,1 27517,0 27532,1 27544,0 27549,1 27581,0 27680,1 27728,0 27812,1 27862,0 27895,1 27966,0 28046,1 28137,0 28216,1 28256,0 28330,1 28355,0 28413,1 28418,0 28437,1 28487,0 28558,1 28565,0 28636,1 28674,0 28690,1 28746,0 28786,1 28875,0 28952,1 29035,0 29060,1 29136,0 29228,1 29286,0 29288,1 29340,0 29435,1 29483,0 29558,1 29559,0 29645,1 29697,0 29766,1 29854,0 29940,1 30027,0 30071,1 30117,0 30125,1 30132,0 30157,1 30165,0 30231,1 30312,0 30392,1 30403,0 30486,1 30493,0 30521,1 30534,0 30601,1 30612,0 30625,1 30688,0 30762,1 30836,0 30899,1 30942,0 30974,1 31055,0 31148,1 31204,0 31254,1 31296,0 31310,1 31374,0 31417,1 31423,0 31452,1 31525,0 31607,1 31686,0 31689,1 31741,0 31813,1 31825,0 31910,1 31945,0 31986,1 32056,0 32133,1 32150,0 32154,1 32250,0 32348,1 32418,0 32473,1 32519,0 32593,1 32677,0 32740,1 32753,0 32846,1 32929,0 33009,1 33048,0 33068,1 33141,0 33184,1 33203,0 33209,1 33252,0 33277,1 33370,0 33373,1 33397,0 33449,1 33527,0 33554,1 33563,0 33628,1 33663,0 33718,1 33770,0 33789,1 33825,0 33854,1 33951,0 34045,1 34116,0 34210,1 34278,0 34332,1 34418,0 34464,1 34502,0 34547,1 34617,0 34681,1 34759,0 34856,1 34879,0 34924,1 35018,0 35043,1 35129,0 35194,1 35235,0 35254,1 35260,0 35353,1 35422,0 35459,1 35512,0 35597,1 35673,0 35689,1 35707,0 35782,1 35880,0 35906,1 35917,0 35926,1 35932,0 35984,1 36039,0 36052,1 36062,0 36124,1 36151,0 36162,1 36251,0 36340,1 36434,0 36494,1 36528,0 36561,1 36637,0 36700,1 36783,0 36872,1 36954,0 37038,1 37086,0 37183,1 37186,0 37192,1 37292,0 37319,1 37386,0 37427,1 37525,0 37528,1 37540,0 37625,1 37677,0 37714,1 37744,0 37779,1 37837,0 37929,1 37966,0 38000,1 38084,0 38129,1 38188,0 38195,1 38262,0 38316,1 38371,0 38460,1 38484,0 38540,1 38617,0 38652,1 38715,0 38803,1 38826,0 38906,1 38960,0 39059,1 39151,0 39188,1 39190,0 39231,1 39286,0 39368,1 39371,0 39398,1 39464,0 39544,1 39549,0 39585,1 39594,0 39607,1 39673,0 39723,1 39793,0 39829,1 39873,0 39919,1 39965,0 39971,1 40034,0 40073,1 40144,0 40152,1 40231,0 40248,1 40293,0 40386,1 40484,0 40549,1 40618,0 40665,1 40711,0 40810,1 40876,0 40947,1 40973,0 41058,1 41122,0 41134,1 41178,0 41261,1 41285,0 41339,1 41348,0 41438,1 41497,0 41584,1 41666,0 41762,1 41801,0 41842,1 41847,0 41900,1 41984,0 42024,1 42037,0 42039,1 42127,0 42224,1 42283,0 42343,1 42357,0 42403,1 42445,0 42496,1 42548,0 42558,1 42613,0 42674,1 42683,0 42694,1 42785,0 42845,1 42940,0 43011,1 43049,0 43090,1 43183,0 43227,1 43321,0 43327,1 43415,0 43477,1 43518,0 43566,1 43661,0 43724,1 43731,0 43777,1 43844,0 43890,1 43915,0 43918,1 44010,0 44031,1 44097,0 44195,1 44205,0 44233,1 44247,0 44293,1 44319,0 44341,1 44392,0 44435,1 44511,0 44599,1 44696,0 44771,1 44772,0 44803,1 44898,0 44938,1 45030,0 45103,1 45174,0 45251,1 45338,0 45410,1 45446,0 45531,1 45575,0 45662,1 45705,0 45739,1 45761,0 45802,1 45835,0 45908,1 45959,0 46021,1 46033,0 46095,1 46168,0 46215,1 46242,0 46305,1 46343,0 46361,1 46414,0 46439,1 46457,0 46528,1 46545,0 46643,1 46670,0 46679,1 46719,0 46748,1 46811,0 46888,1 46988,0 47062,1 47069,0 47095,1 47187,0 47206,1 47222,0 47246,1 47272,0 47360,1 47362,0 47364,1 47428,0 47482,1 47532,0 47600,1 47650,0 47720,1 47811,0 47863,1 47947,0 48000,1 48081,0 48159,1 48161,0 48208,1 48282,0 48330,1 48333,0 48421,1 48518,0 48611,1 48648,0 48686,1 48777,0 48835,1 48888,0 48891,1 48904,0 48965,1 48968,0 49034,1 49053,0 49147,1 49231,0 49261,1 49312,0 49334,1 49383,0 49387,1 49470,0 49489,1 49496,0 49587,1 49645,0 49662,1 49663,0 49738,1 49830,0 49842,1 end initlist c14 0,0 7,1 74,0 129,1 150,0 173,1 241,0 257,1 332,0 385,1 421,0 461,1 494,0 553,1 575,0 655,1 706,0 708,1 800,0 818,1 913,0 952,1 957,0 988,1 1059,0 1149,1 1226,0 1249,1 1346,0 1394,1 1396,0 1479,1 1578,0 1588,1 1645,0 1693,1 1754,0 1756,1 1834,0 1915,1 1944,0 1954,1 1999,0 2082,1 2170,0 2246,1 2274,0 2368,1 2380,0 2438,1 2465,0 2518,1 2589,0 2642,1 2692,0 2736,1 2764,0 2765,1 2826,0 2882,1 2919,0 2972,1 2989,0 2999,1 3090,0 3097,1 3153,0 3213,1 3231,0 3321,1 3328,0 3393,1 3476,0 3522,1 3602,0 3677,1 3681,0 3693,1 3720,0 3803,1 3824,0 3836,1 3916,0 3939,1 3943,0 4028,1 4045,0 4109,1 4160,0 4204,1 4221,0 4231,1 4284,0 4338,1 4414,0 4419,1 4424,0 4520,1 4533,0 4633,1 4678,0 4697,1 4782,0 4870,1 4880,0 4890,1 4897,0 4989,1 5010,0 5098,1 5124,0 5202,1 5254,0 5294,1 5380,0 5408,1 5454,0 5544,1 5622,0 5629,1 5707,0 5735,1 5750,0 5828,1 5855,0 5949,1 5962,0 5984,1 5995,0 6046,1 6099,0 6136,1 6207,0 6257,1 6297,0 6376,1 6459,0 6517,1 6588,0 6664,1 6718,0 6734,1 6779,0 6879,1 6923,0 6964,1 7054,0 7117,1 7205,0 7287,1 7309,0 7334,1 7417,0 7444,1 7447,0 7493,1 7589,0 7655,1 7679,0 7773,1 7869,0 7909,1 7924,0 7983,1 8053,0 8076,1 8151,0 8153,1 8164,0 8216,1 8223,0 8277,1 8348,0 8364,1 8407,0 8451,1 8546,0 8573,1 8601,0 8630,1 8700,0 8794,1 8797,0 8853,1 8951,0 9026,1 9077,0 9115,1 9137,0 9208,1 9272,0 9297,1 9395,0 9438,1 9504,0 9510,1 9527,0 9616,1 9691,0 9784,1 9855,0 9868,1 9896,0 9992,1 10059,0 10142,1 10236,0 10282,1 10341,0 10372,1 10458,0 10519,1 10613,0 10654,1 10677,0 10684,1 10749,0 10793,1 10889,0 10930,1 11009,0 11051,1 11055,0 11137,1 11219,0 11233,1 11276,0 11309,1 11391,0 11455,1 11551,0 11600,1 11677,0 11766,1 11819,0 11874,1 11958,0 11997,1 12049,0 12118,1 12119,0 12214,1 12238,0 12325,1 12334,0 12368,1 12401,0 12422,1 12468,0 12530,1 12591,0 12631,1 12656,0 12754,1 12771,0 12809,1 12894,0 12946,1 13001,0 13054,1 13066,0 13135,1 13216,0 13250,1 13302,0 13389,1 13400,0 13461,1 13496,0 13528,1 13582,0 13637,1 13697,0 13769,1 13855,0 13864,1 13871,0 13876,1 13952,0 14025,1 14082,0 14099,1 14171,0 14187,1 14280,0 14329,1 14346,0 14347,1 14354,0 14367,1 14389,0 14390,1 14437,0 14537,1 14588,0 14624,1 14662,0 14668,1 14762,0 14850,1 14932,0 14957,1 14976,0 14978,1 15046,0 15063,1 15127,0 15147,1 15222,0 15308,1 15353,0 15410,1 15485,0 15582,1 15622,0 15679,1 15738,0 15766,1 15788,0 15884,1 15956,0 15973,1 16044,0 16119,1 16151,0 16227,1 16257,0 16290,1 16296,0 16344,1 16422,0 16497,1 16505,0 16537,1 16619,0 16626,1 16697,0 16781,1 16835,0 16869,1 16937,0 17023,1 17104,0 17201,1 17256,0 17268,1 17317,0 17357,1 17393,0 17485,1 17565,0 17606,1 17633,0 17653,1 17721,0 17735,1 17796,0 17814,1 17858,0 17880,1 17979,0 18000,1 18093,0 18117,1 18158,0 18198,1 18224,0 18265,1 18281,0 18291,1 18354,0 18416,1 18460,0 18495,1 18584,0 18631,1 18655,0 18716,1 18726,0 18747,1 18791,0 18826,1 18838,0 18904,1 18926,0 18990,1 19001,0 19039,1 19046,0 19054,1 19105,0 19156,1 19242,0 19264,1 19334,0 19381,1 19464,0 19543,1 19591,0 19666,1 19705,0 19725,1 19737,0 19830,1 19836,0 19860,1 19955,0 19980,1 20070,0 20147,1 20166,0 20257,1 20260,0 20332,1 20351,0 20381,1 20398,0 20491,1 20546,0 20571,1 20670,0 20749,1 20801,0 20814,1 20856,0 20870,1 20896,0 20994,1 21076,0 21158,1 21181,0 21231,1 21235,0 21333,1 21418,0 21441,1 21454,0 21457,1 21474,0 21498,1 21523,0 21537,1 21616,0 21664,1 21665,0 21704,1 21712,0 21799,1 21876,0 21935,1 21936,0 21999,1 22075,0 22157,1 22176,0 22218,1 22254,0 22333,1 22362,0 22406,1 22418,0 22506,1 22507,0 22605,1 22667,0 22764,1 22843,0 22935,1 23035,0 23117,1 23196,0 23262,1 23321,0 23340,1 23366,0 23400,1 23496,0 23557,1 23642,0 23680,1 23775,0 23851,1 23863,0 23892,1 23976,0 24062,1 24084,0 24163,1 24221,0 24295,1 24300,0 24327,1 24424,0 24464,1 24466,0 24560,1 24616,0 24623,1 24720,0 24787,1 24853,0 24947,1 24983,0 25009,1 25057,0 25091,1 25112,0 25194,1 25271,0 25311,1 25366,0 25406,1 25503,0 25583,1 25587,0 25630,1 25694,0 25753,1 25814,0 25846,1 25883,0 25934,1 25960,0 26028,1 26064,0 26085,1 26134,0 26212,1 26248,0 26303,1 26341,0 26370,1 26437,0 26489,1 26544,0 26548,1 26616,0 26712,1 26761,0 26796,1 26866,0 26872,1 26874,0 26877,1 26957,0 26988,1 27035,0 27083,1 27156,0 27232,1 27327,0 27331,1 27340,0 27425,1 27453,0 27504,1 27592,0 27675,1 27770,0 27866,1 27895,0 27976,1 28019,0 28035,1 28116,0 28190,1 28276,0 28345,1 28406,0 28472,1 28550,0 28620,1 28720,0 28810,1 28882,0 28919,1 28949,0 28966,1 29021,0 29095,1 29188,0 29197,1 29287,0 29314,1 29389,0 29459,1 29484,0 29544,1 29585,0 29613,1 29695,0 29702,1 29724,0 29754,1 29776,0 29837,1 29912,0 30012,1 30016,0 30055,1 30072,0 30114,1 30140,0 30235,1 30330,0 30389,1 30421,0 30512,1 30584,0 30590,1 30675,0 30697,1 30779,0 30824,1 30873,0 30925,1 30930,0 30949,1 30997,0 31091,1 31137,0 31202,1 31205,0 31229,1 31321,0 31348,1 31396,0 31481,1 31530,0 31602,1 31644,0 31694,1 31710,0 31725,1 31816,0 31872,1 31926,0 32004,1 32042,0 32083,1 32084,0 32181,1 32196,0 32221,1 32230,0 32318,1 32387,0 32435,1 32471,0 32502,1 32573,0 32600,1 32643,0 32669,1 32768,0 32779,1 32830,0 32895,1 32924,0 33022,1 33100,0 33122,1 33203,0 33252,1 33346,0 33353,1 33444,0 33451,1 33497,0 33526,1 33598,0 33670,1 33720,0 33739,1 33783,0 33823,1 33850,0 33937,1 34012,0 34075,1 34089,0 34156,1 34233,0 34291,1 34333,0 34395,1 34440,0 34446,1 34488,0 34569,1 34612,0 34649,1 34676,0 34678,1 34722,0 34798,1 34868,0 34915,1 34972,0 34973,1 35057,0 35111,1 35207,0 35212,1 35242,0 35273,1 35332,0 35348,1 35386,0 35431,1 35521,0 35608,1 35635,0 35721,1 35821,0 35917,1 36016,0 36107,1 36187,0 36210,1 36255,0 36293,1 36354,0 36378,1 36455,0 36491,1 36540,0 36618,1 36622,0 36654,1 36700,0 36740,1 36759,0 36821,1 36892,0 36916,1 36925,0 36993,1 37024,0 37110,1 37200,0 37263,1 37335,0 37411,1 37502,0 37596,1 37604,0 37643,1 37694,0 37726,1 37756,0 37815,1 37851,0 37852,1 37871,0 37932,1 37942,0 37955,1 38005,0 38014,1 38028,0 38054,1 38060,0 38097,1 38118,0 38178,1 38266,0 38307,1 38377,0 38465,1 38543,0 38582,1 38650,0 38706,1 38794,0 38882,1 38900,0 38954,1 39026,0 39117,1 39157,0 39242,1 39309,0 39395,1 39455,0 39472,1 39563,0 39601,1 39611,0 39706,1 39759,0 39813,1 39831,0 39876,1 39927,0 39977,1 40047,0 40090,1 40165,0 40229,1 40234,0 40302,1 40359,0 40375,1 40390,0 40392,1 40459,0 40528,1 40568,0 40576,1 40637,0 40702,1 40799,0 40800,1 40861,0 40916,1 40966,0 41051,1 41053,0 41136,1 41165,0 41236,1 41250,0 41298,1 41342,0 41415,1 41419,0 41446,1 41482,0 41489,1 41496,0 41504,1 41585,0 41680,1 41697,0 41785,1 41838,0 41916,1 41988,0 42044,1 42059,0 42120,1 42155,0 42189,1 42213,0 42312,1 42390,0 42462,1 42526,0 42565,1 42612,0 42635,1 42695,0 42720,1 42727,0 42748,1 42801,0 42879,1 42918,0 42932,1 43010,0 43037,1 43131,0 43133,1 43178,0 43190,1 43277,0 43332,1 43357,0 43369,1 43435,0 43467,1 43558,0 43630,1 43690,0 43752,1 43775,0 43844,1 43903,0 43904,1 43972,0 43985,1 44037,0 44128,1 44208,0 44260,1 44346,0 44373,1 44417,0 44463,1 44552,0 44626,1 44643,0 44699,1 44777,0 44814,1 44826,0 44885,1 44914,0 44940,1 44984,0 45016,1 45104,0 45194,1 45246,0 45256,1 45270,0 45348,1 45377,0 45404,1 45452,0 45482,1 45516,0 45536,1 45567,0 45605,1 45701,0 45786,1 45794,0 45803,1 45869,0 45887,1 45950,0 46035,1 46075,0 46164,1 46261,0 46281,1 46360,0 46421,1 46432,0 46456,1 46520,0 46548,1 46573,0 46634,1 46646,0 46669,1 46697,0 46740,1 46830,0 46881,1 46892,0 46950,1 47040,0 47056,1 47152,0 47247,1 47315,0 47387,1 47436,0 47479,1 47484,0 47534,1 47555,0 47588,1 47661,0 47704,1 47773,0 47836,1 47861,0 47881,1 47942,0 48012,1 48058,0 48068,1 48167,0 48207,1 48217,0 48280,1 48293,0 48345,1 48399,0 48466,1 48554,0 48614,1 48691,0 48770,1 48826,0 48866,1 48896,0 48956,1 49038,0 49057,1 49144,0 49216,1 49277,0 49361,1 49444,0 49452,1 49485,0 49562,1 49601,0 49652,1 49687,0 49778,1 49843,0 49926,1 49969,0 50050,1 50087,0 50115,1 end initlist c15 0,0 14,1 42,0 139,1 168,0 216,1 283,0 350,1 417,0 490,1 500,0 586,1 621,0 681,1 686,0 742,1 814,0 877,1 939,0 995,1 1009,0 1028,1 1128,0 1161,1 1181,0 1242,1 1248,0 1344,1 1352,0 1450,1 1540,0 1607,1 1666,0 1727,1 1776,0 1834,1 1869,0 1942,1 1956,0 2034,1 2131,0 2139,1 2163,0 2172,1 2239,0 2283,1 2323,0 2388,1 2458,0 2505,1 2605,0 2606,1 2671,0 2741,1 2777,0 2864,1 2895,0 2900,1 2941,0 2988,1 3085,0 3176,1 3262,0 3287,1 3346,0 3386,1 3464,0 3488,1 3531,0 3574,1 3591,0 3652,1 3752,0 3769,1 3823,0 3835,1 3845,0 3885,1 3900,0 3936,1 3971,0 4056,1 4150,0 4172,1 4265,0 4359,1 4386,0 4455,1 4461,0 4471,1 4491,0 4562,1 4642,0 4684,1 4746,0 4805,1 4861,0 4927,1 4945,0 4959,1 4981,0 5037,1 5050,0 5125,1 5222,0 5263,1 5357,0 5379,1 5382,0 5474,1 5558,0 5603,1 5680,0 5710,1 5741,0 5768,1 5843,0 5912,1 5936,0 6032,1 6056,0 6108,1 6188,0 6215,1 6219,0 6270,1 6282,0 6324,1 6422,0 6496,1 6562,0 6572,1 6573,0 6612,1 6639,0 6673,1 6725,0 6776,1 6864,0 6895,1 6927,0 6997,1 7060,0 7133,1 7219,0 7315,1 7344,0 7345,1 7418,0 7490,1 7498,0 7570,1 7620,0 7699,1 7766,0 7782,1 7801,0 7811,1 7866,0 7948,1 8039,0 8045,1 8145,0 8241,1 8301,0 8306,1 8309,0 8361,1 8408,0 8492,1 8547,0 8588,1 8684,0 8705,1 8758,0 8830,1 8878,0 8934,1 8973,0 8988,1 9026,0 9099,1 9103,0 9158,1 9174,0 9235,1 9292,0 9359,1 9445,0 9541,1 9573,0 9641,1 9702,0 9731,1 9794,0 9836,1 9845,0 9939,1 9999,0 10051,1 10082,0 10106,1 10172,0 10262,1 10287,0 10306,1 10364,0 10370,1 10373,0 10468,1 10531,0 10532,1 10565,0 10609,1 10645,0 10656,1 10658,0 10675,1 10730,0 10732,1 10801,0 10890,1 10988,0 10999,1 11070,0 11105,1 11182,0 11270,1 11289,0 11353,1 11372,0 11441,1 11533,0 11619,1 11649,0 11727,1 11731,0 11797,1 11822,0 11833,1 11924,0 11999,1 12036,0 12097,1 12120,0 12151,1 12236,0 12332,1 12396,0 12463,1 12480,0 12523,1 12577,0 12655,1 12732,0 12762,1 12814,0 12900,1 12956,0 13038,1 13073,0 13135,1 13187,0 13212,1 13219,0 13269,1 13287,0 13353,1 13408,0 13410,1 13486,0 13504,1 13530,0 13586,1 13614,0 13655,1 13735,0 13784,1 13877,0 13898,1 13959,0 14010,1 14067,0 14073,1 14125,0 14208,1 14239,0 14276,1 14367,0 14392,1 14442,0 14457,1 14493,0 14538,1 14630,0 14631,1 14640,0 14719,1 14726,0 14804,1 14825,0 14890,1 14959,0 14963,1 15030,0 15063,1 15158,0 15199,1 15262,0 15299,1 15350,0 15398,1 15431,0 15507,1 15579,0 15613,1 15644,0 15705,1 15782,0 15839,1 15877,0 15921,1 16008,0 16016,1 16108,0 16196,1 16276,0 16343,1 16377,0 16474,1 16531,0 16603,1 16608,0 16663,1 16704,0 16706,1 16723,0 16750,1 16817,0 16912,1 16921,0 16951,1 17000,0 17071,1 17146,0 17173,1 17223,0 17239,1 17265,0 17310,1 17329,0 17377,1 17445,0 17465,1 17510,0 17512,1 17566,0 17600,1 17666,0 17685,1 17773,0 17835,1 17840,0 17865,1 17882,0 17934,1 18021,0 18062,1 18073,0 18164,1 18242,0 18317,1 18410,0 18411,1 18421,0 18441,1 18501,0 18511,1 18513,0 18556,1 18636,0 18692,1 18728,0 18792,1 18847,0 18940,1 18960,0 19051,1 19099,0 19135,1 19179,0 19257,1 19345,0 19425,1 19431,0 19506,1 19579,0 19617,1 19637,0 19684,1 19728,0 19794,1 19823,0 19898,1 19902,0 19915,1 19990,0 20047,1 20111,0 20172,1 20246,0 20305,1 20373,0 20415,1 20493,0 20507,1 20518,0 20546,1 20581,0 20644,1 20645,0 20681,1 20730,0 20813,1 20846,0 20869,1 20939,0 21022,1 21024,0 21096,1 21166,0 21231,1 21307,0 21371,1 21372,0 21389,1 21485,0 21529,1 21610,0 21709,1 21746,0 21824,1 21905,0 21945,1 21988,0 21991,1 22013,0 22072,1 22102,0 22113,1 22142,0 22227,1 22291,0 22331,1 22409,0 22466,1 22503,0 22594,1 22654,0 22703,1 22706,0 22772,1 22827,0 22881,1 22968,0 23058,1 23150,0 23183,1 23228,0 23246,1 23333,0 23351,1 23422,0 23450,1 23473,0 23538,1 23615,0 23650,1 23685,0 23697,1 23701,0 23731,1 23829,0 23929,1 24010,0 24041,1 24125,0 24190,1 24288,0 24361,1 24449,0 24503,1 24516,0 24537,1 24632,0 24726,1 24730,0 24822,1 24837,0 24909,1 24995,0 25011,1 25105,0 25187,1 25212,0 25283,1 25309,0 25337,1 25349,0 25411,1 25504,0 25578,1 25614,0 25704,1 25718,0 25772,1 25819,0 25894,1 25980,0 26018,1 26051,0 26103,1 26165,0 26213,1 26240,0 26298,1 26307,0 26378,1 26452,0 26510,1 26519,0 26604,1 26659,0 26745,1 26755,0 26828,1 26864,0 26928,1 26984,0 27020,1 27031,0 27119,1 27131,0 27201,1 27229,0 27244,1 27337,0 27383,1 27387,0 27453,1 27504,0 27602,1 27641,0 27653,1 27688,0 27757,1 27783,0 27795,1 27830,0 27904,1 27926,0 27956,1 27973,0 28006,1 28017,0 28054,1 28071,0 28103,1 28193,0 28273,1 28342,0 28382,1 28406,0 28443,1 28479,0 28503,1 28573,0 28655,1 28699,0 28711,1 28753,0 28815,1 28817,0 28864,1 28894,0 28982,1 28992,0 28999,1 29050,0 29069,1 29116,0 29178,1 29217,0 29292,1 29370,0 29439,1 29502,0 29537,1 29611,0 29707,1 29796,0 29799,1 29829,0 29890,1 29931,0 29938,1 29969,0 30003,1 30099,0 30141,1 30204,0 30223,1 30251,0 30316,1 30403,0 30453,1 30547,0 30564,1 30605,0 30701,1 30797,0 30863,1 30959,0 31014,1 31079,0 31144,1 31226,0 31275,1 31354,0 31426,1 31445,0 31499,1 31562,0 31608,1 31670,0 31722,1 31799,0 31822,1 31863,0 31949,1 32000,0 32075,1 32092,0 32093,1 32131,0 32220,1 32297,0 32386,1 32412,0 32444,1 32534,0 32596,1 32642,0 32682,1 32718,0 32807,1 32809,0 32830,1 32872,0 32888,1 32985,0 33031,1 33056,0 33156,1 33240,0 33276,1 33347,0 33389,1 33421,0 33517,1 33566,0 33632,1 33649,0 33676,1 33738,0 33744,1 33775,0 33844,1 33876,0 33892,1 33980,0 34037,1 34122,0 34203,1 34223,0 34251,1 34336,0 34428,1 34446,0 34506,1 34531,0 34543,1 34558,0 34576,1 34615,0 34715,1 34743,0 34771,1 34870,0 34900,1 34980,0 35058,1 35153,0 35163,1 35214,0 35303,1 35359,0 35441,1 35446,0 35509,1 35597,0 35658,1 35691,0 35740,1 35770,0 35776,1 35854,0 35883,1 35951,0 35981,1 36063,0 36071,1 36077,0 36136,1 36233,0 36299,1 36374,0 36430,1 36468,0 36556,1 36608,0 36659,1 36709,0 36748,1 36759,0 36819,1 36907,0 36959,1 36968,0 37040,1 37051,0 37146,1 37156,0 37206,1 37272,0 37306,1 37321,0 37325,1 37348,0 37356,1 37450,0 37520,1 37610,0 37630,1 37711,0 37786,1 37825,0 37852,1 37950,0 38046,1 38078,0 38175,1 38237,0 38333,1 38350,0 38370,1 38371,0 38419,1 38466,0 38468,1 38489,0 38547,1 38597,0 38684,1 38759,0 38841,1 38908,0 38999,1 39080,0 39137,1 39198,0 39262,1 39277,0 39291,1 39316,0 39375,1 39465,0 39520,1 39582,0 39620,1 39680,0 39718,1 39730,0 39761,1 39773,0 39781,1 39876,0 39894,1 39934,0 40024,1 40033,0 40034,1 40099,0 40196,1 40206,0 40236,1 40253,0 40257,1 40302,0 40344,1 40431,0 40504,1 40575,0 40620,1 40639,0 40692,1 40699,0 40784,1 40801,0 40889,1 40955,0 41005,1 41030,0 41031,1 41054,0 41113,1 41116,0 41139,1 41182,0 41230,1 41254,0 41267,1 41362,0 41459,1 41509,0 41529,1 41535,0 41590,1 41690,0 41746,1 41811,0 41882,1 41907,0 41969,1 41994,0 42063,1 42069,0 42156,1 42226,0 42235,1 42328,0 42368,1 42377,0 42438,1 42478,0 42561,1 42568,0 42584,1 42672,0 42764,1 42823,0 42860,1 42896,0 42975,1 42993,0 43018,1 43054,0 43080,1 43134,0 43168,1 43222,0 43228,1 43323,0 43384,1 43424,0 43452,1 43464,0 43563,1 43658,0 43724,1 43760,0 43807,1 43873,0 43940,1 43981,0 43986,1 43997,0 44078,1 44088,0 44187,1 44225,0 44275,1 44279,0 44368,1 44429,0 44488,1 44522,0 44559,1 44584,0 44605,1 44645,0 44727,1 44764,0 44822,1 44854,0 44917,1 44919,0 44936,1 44960,0 44979,1 45001,0 45101,1 45123,0 45165,1 45259,0 45265,1 45335,0 45404,1 45415,0 45502,1 45589,0 45620,1 45701,0 45766,1 45769,0 45858,1 45874,0 45966,1 46029,0 46051,1 46053,0 46118,1 46152,0 46240,1 46307,0 46362,1 46408,0 46478,1 46560,0 46644,1 46680,0 46747,1 46807,0 46896,1 46925,0 47017,1 47103,0 47185,1 47270,0 47337,1 47429,0 47445,1 47496,0 47548,1 47622,0 47651,1 47730,0 47803,1 47839,0 47932,1 47946,0 48005,1 48066,0 48132,1 48222,0 48274,1 48348,0 48392,1 48396,0 48430,1 48501,0 48521,1 48578,0 48646,1 48677,0 48698,1 48769,0 48807,1 48882,0 48886,1 48890,0 48927,1 48973,0 48993,1 49023,0 49104,1 49147,0 49182,1 49249,0 49287,1 49354,0 49410,1 49492,0 49545,1 49613,0 49689,1 49787,0 49835,1 49859,0 49905,1 49918,0 50002,1 end initlist c16 0,0 15,1 106,0 171,1 194,0 241,1 329,0 421,1 487,0 529,1 601,0 682,1 778,0 827,1 855,0 918,1 1016,0 1075,1 1165,0 1218,1 1243,0 1262,1 1362,0 1407,1 1412,0 1434,1 1472,0 1492,1 1584,0 1643,1 1727,0 1770,1 1861,0 1948,1 1992,0 2012,1 2013,0 2046,1 2120,0 2136,1 2196,0 2260,1 2331,0 2372,1 2388,0 2454,1 2523,0 2524,1 2525,0 2611,1 2638,0 2641,1 2670,0 2698,1 2704,0 2732,1 2807,0 2850,1 2875,0 2949,1 2988,0 3003,1 3019,0 3079,1 3102,0 3176,1 3196,0 3260,1 3344,0 3436,1 3497,0 3581,1 3653,0 3671,1 3755,0 3828,1 3898,0 3937,1 3970,0 4027,1 4109,0 4165,1 4200,0 4209,1 4300,0 4373,1 4378,0 4455,1 4520,0 4582,1 4625,0 4635,1 4712,0 4765,1 4790,0 4844,1 4904,0 4911,1 4947,0 5030,1 5046,0 5084,1 5086,0 5116,1 5168,0 5176,1 5259,0 5306,1 5390,0 5420,1 5423,0 5474,1 5557,0 5580,1 5678,0 5706,1 5726,0 5728,1 5782,0 5881,1 5885,0 5927,1 5954,0 5975,1 6037,0 6107,1 6124,0 6196,1 6291,0 6389,1 6464,0 6544,1 6546,0 6624,1 6643,0 6681,1 6763,0 6812,1 6853,0 6948,1 7010,0 7062,1 7087,0 7093,1 7155,0 7197,1 7253,0 7297,1 7381,0 7403,1 7459,0 7461,1 7513,0 7603,1 7685,0 7748,1 7794,0 7813,1 7887,0 7918,1 8005,0 8030,1 8071,0 8158,1 8179,0 8246,1 8305,0 8346,1 8421,0 8491,1 8520,0 8534,1 8564,0 8615,1 8678,0 8720,1 8760,0 8787,1 8850,0 8860,1 8905,0 8990,1 9072,0 9082,1 9182,0 9196,1 9235,0 9331,1 9369,0 9381,1 9396,0 9458,1 9472,0 9495,1 9524,0 9529,1 9606,0 9705,1 9788,0 9791,1 9873,0 9954,1 9981,0 10008,1 10040,0 10125,1 10200,0 10221,1 10294,0 10327,1 10405,0 10426,1 10481,0 10528,1 10554,0 10632,1 10732,0 10793,1 10839,0 10879,1 10942,0 10974,1 10985,0 11002,1 11067,0 11090,1 11143,0 11216,1 11284,0 11365,1 11381,0 11419,1 11476,0 11526,1 11546,0 11623,1 11684,0 11723,1 11806,0 11897,1 11982,0 12002,1 12051,0 12121,1 12217,0 12240,1 12305,0 12382,1 12460,0 12558,1 12626,0 12681,1 12745,0 12772,1 12783,0 12788,1 12826,0 12925,1 13015,0 13079,1 13178,0 13220,1 13233,0 13250,1 13288,0 13342,1 13350,0 13422,1 13464,0 13515,1 13578,0 13651,1 13683,0 13720,1 13748,0 13778,1 13868,0 13875,1 13926,0 14011,1 14100,0 14187,1 14223,0 14247,1 14331,0 14346,1 14367,0 14371,1 14454,0 14510,1 14597,0 14624,1 14627,0 14653,1 14659,0 14667,1 14743,0 14775,1 14784,0 14841,1 14875,0 14942,1 14969,0 15023,1 15062,0 15149,1 15229,0 15247,1 15282,0 15379,1 15391,0 15428,1 15473,0 15566,1 15664,0 15738,1 15742,0 15806,1 15897,0 15987,1 16023,0 16057,1 16138,0 16168,1 16182,0 16192,1 16248,0 16253,1 16342,0 16356,1 16424,0 16481,1 16485,0 16492,1 16521,0 16544,1 16594,0 16617,1 16644,0 16733,1 16765,0 16847,1 16929,0 17027,1 17120,0 17205,1 17218,0 17314,1 17373,0 17470,1 17528,0 17575,1 17583,0 17637,1 17717,0 17782,1 17827,0 17844,1 17930,0 18023,1 18085,0 18141,1 18193,0 18217,1 18225,0 18290,1 18348,0 18361,1 18425,0 18434,1 18514,0 18522,1 18547,0 18577,1 18615,0 18697,1 18757,0 18829,1 18885,0 18982,1 18985,0 19043,1 19139,0 19238,1 19308,0 19374,1 19432,0 19489,1 19505,0 19559,1 19583,0 19680,1 19746,0 19790,1 19862,0 19930,1 19978,0 19987,1 20044,0 20127,1 20208,0 20232,1 20240,0 20298,1 20329,0 20372,1 20443,0 20537,1 20588,0 20623,1 20687,0 20741,1 20801,0 20806,1 20831,0 20841,1 20922,0 20978,1 20993,0 21017,1 21107,0 21142,1 21164,0 21235,1 21265,0 21278,1 21354,0 21444,1 21476,0 21508,1 21537,0 21545,1 21570,0 21598,1 21599,0 21618,1 21711,0 21727,1 21785,0 21811,1 21830,0 21927,1 22019,0 22027,1 22048,0 22123,1 22145,0 22161,1 22179,0 22229,1 22273,0 22320,1 22380,0 22419,1 22511,0 22584,1 22614,0 22638,1 22701,0 22799,1 22813,0 22902,1 22975,0 22983,1 23076,0 23140,1 23200,0 23286,1 23297,0 23348,1 23424,0 23497,1 23569,0 23645,1 23650,0 23694,1 23722,0 23789,1 23880,0 23908,1 23957,0 24024,1 24094,0 24186,1 24225,0 24276,1 24283,0 24352,1 24384,0 24451,1 24539,0 24564,1 24607,0 24692,1 24791,0 24875,1 24942,0 24975,1 25060,0 25122,1 25132,0 25216,1 25224,0 25321,1 25390,0 25474,1 25563,0 25590,1 25689,0 25780,1 25822,0 25876,1 25883,0 25965,1 26055,0 26093,1 26098,0 26131,1 26159,0 26195,1 26239,0 26254,1 26324,0 26351,1 26426,0 26487,1 26567,0 26667,1 26728,0 26729,1 26824,0 26905,1 26976,0 27046,1 27141,0 27158,1 27208,0 27224,1 27319,0 27337,1 27386,0 27438,1 27459,0 27464,1 27475,0 27508,1 27599,0 27658,1 27708,0 27790,1 27885,0 27976,1 28013,0 28017,1 28117,0 28212,1 28219,0 28239,1 28315,0 28379,1 28405,0 28479,1 28518,0 28532,1 28538,0 28612,1 28696,0 28744,1 28787,0 28860,1 28955,0 28992,1 29036,0 29121,1 29173,0 29185,1 29265,0 29303,1 29368,0 29382,1 29460,0 29481,1 29522,0 29531,1 29592,0 29661,1 29712,0 29741,1 29816,0 29869,1 29875,0 29928,1 30017,0 30025,1 30068,0 30070,1 30074,0 30094,1 30113,0 30173,1 30191,0 30269,1 30355,0 30377,1 30431,0 30462,1 30498,0 30527,1 30627,0 30682,1 30778,0 30867,1 30883,0 30950,1 31019,0 31100,1 31138,0 31139,1 31222,0 31257,1 31324,0 31331,1 31413,0 31461,1 31521,0 31617,1 31660,0 31731,1 31733,0 31783,1 31804,0 31899,1 31917,0 31950,1 32036,0 32061,1 32103,0 32167,1 32215,0 32268,1 32352,0 32401,1 32463,0 32509,1 32575,0 32618,1 32676,0 32728,1 32774,0 32837,1 32895,0 32988,1 32991,0 33046,1 33134,0 33140,1 33198,0 33270,1 33335,0 33413,1 33459,0 33500,1 33521,0 33616,1 33639,0 33699,1 33794,0 33799,1 33845,0 33905,1 33908,0 33924,1 34004,0 34017,1 34110,0 34136,1 34207,0 34270,1 34296,0 34298,1 34378,0 34401,1 34443,0 34477,1 34506,0 34510,1 34552,0 34590,1 34602,0 34607,1 34687,0 34720,1 34787,0 34815,1 34894,0 34984,1 34989,0 35079,1 35122,0 35182,1 35281,0 35293,1 35312,0 35323,1 35406,0 35492,1 35536,0 35591,1 35621,0 35679,1 35703,0 35713,1 35725,0 35779,1 35804,0 35891,1 35974,0 35979,1 36054,0 36088,1 36178,0 36192,1 36197,0 36253,1 36300,0 36389,1 36444,0 36544,1 36562,0 36592,1 36690,0 36743,1 36789,0 36881,1 36923,0 37000,1 37078,0 37104,1 37138,0 37151,1 37167,0 37245,1 37335,0 37385,1 37400,0 37444,1 37464,0 37515,1 37582,0 37586,1 37593,0 37679,1 37765,0 37819,1 37910,0 37919,1 37924,0 37959,1 38026,0 38125,1 38185,0 38265,1 38332,0 38417,1 38513,0 38575,1 38648,0 38671,1 38771,0 38855,1 38951,0 39048,1 39098,0 39131,1 39159,0 39242,1 39337,0 39409,1 39496,0 39522,1 39618,0 39709,1 39761,0 39820,1 39868,0 39911,1 39959,0 40024,1 40093,0 40152,1 40248,0 40335,1 40426,0 40462,1 40514,0 40564,1 40635,0 40651,1 40711,0 40722,1 40751,0 40782,1 40870,0 40918,1 40991,0 41007,1 41060,0 41139,1 41222,0 41319,1 41346,0 41408,1 41463,0 41559,1 41651,0 41718,1 41778,0 41830,1 41887,0 41936,1 42003,0 42097,1 42184,0 42211,1 42227,0 42255,1 42263,0 42307,1 42394,0 42488,1 42572,0 42650,1 42731,0 42817,1 42835,0 42913,1 42996,0 43053,1 43109,0 43134,1 43173,0 43192,1 43206,0 43289,1 43312,0 43390,1 43391,0 43478,1 43535,0 43565,1 43586,0 43601,1 43608,0 43636,1 43727,0 43813,1 43827,0 43880,1 43922,0 43983,1 44019,0 44029,1 44043,0 44063,1 44121,0 44214,1 44251,0 44307,1 44369,0 44429,1 44466,0 44535,1 44549,0 44590,1 44679,0 44699,1 44719,0 44780,1 44819,0 44901,1 44915,0 44920,1 44924,0 44925,1 45004,0 45032,1 45035,0 45084,1 45132,0 45179,1 45205,0 45234,1 45236,0 45294,1 45357,0 45362,1 45443,0 45450,1 45486,0 45579,1 45643,0 45722,1 45785,0 45843,1 45862,0 45872,1 45956,0 45972,1 45983,0 46048,1 46126,0 46193,1 46240,0 46248,1 46254,0 46267,1 46303,0 46327,1 46371,0 46408,1 46419,0 46461,1 46511,0 46556,1 46629,0 46662,1 46758,0 46816,1 46897,0 46925,1 46933,0 47024,1 47030,0 47097,1 47180,0 47280,1 47341,0 47401,1 47427,0 47475,1 47505,0 47591,1 47606,0 47682,1 47778,0 47856,1 47888,0 47981,1 47988,0 48083,1 48120,0 48203,1 48259,0 48329,1 48406,0 48454,1 48544,0 48569,1 48627,0 48700,1 48780,0 48812,1 48846,0 48934,1 48945,0 49016,1 49094,0 49119,1 49198,0 49227,1 49290,0 49308,1 49379,0 49444,1 49457,0 49535,1 49559,0 49653,1 49740,0 49750,1 49834,0 49856,1 49880,0 49907,1 49969,0 50015,1 50069,0 50155,1 50243,0 50277,1 50319,0 50411,1 50439,0 50505,1 50520,0 50582,1 50639,0 50737,1 50800,0 50869,1 50920,0 51005,1 end initlist c17 0,0 59,1 117,0 211,1 220,0 245,1 336,0 430,1 510,0 583,1 621,0 661,1 704,0 789,1 860,0 941,1 942,0 958,1 984,0 1065,1 1121,0 1197,1 1217,0 1241,1 1273,0 1299,1 1345,0 1420,1 1441,0 1467,1 1524,0 1525,1 1540,0 1568,1 1570,0 1665,1 1671,0 1716,1 1761,0 1826,1 1868,0 1882,1 1947,0 1973,1 2040,0 2133,1 2170,0 2195,1 2293,0 2340,1 2397,0 2428,1 2515,0 2580,1 2678,0 2777,1 2808,0 2843,1 2926,0 2979,1 3047,0 3066,1 3080,0 3151,1 3189,0 3221,1 3307,0 3404,1 3487,0 3538,1 3579,0 3635,1 3712,0 3782,1 3852,0 3949,1 4045,0 4112,1 4211,0 4245,1 4337,0 4373,1 4403,0 4473,1 4475,0 4507,1 4521,0 4606,1 4613,0 4643,1 4646,0 4744,1 4785,0 4867,1 4935,0 5035,1 5104,0 5109,1 5208,0 5308,1 5373,0 5443,1 5510,0 5550,1 5566,0 5664,1 5711,0 5722,1 5734,0 5802,1 5820,0 5902,1 5973,0 6058,1 6059,0 6158,1 6210,0 6233,1 6311,0 6350,1 6393,0 6403,1 6448,0 6540,1 6562,0 6590,1 6673,0 6739,1 6746,0 6811,1 6876,0 6930,1 7001,0 7028,1 7033,0 7043,1 7075,0 7159,1 7254,0 7320,1 7379,0 7471,1 7507,0 7571,1 7620,0 7641,1 7649,0 7686,1 7715,0 7733,1 7762,0 7817,1 7874,0 7964,1 8050,0 8060,1 8069,0 8116,1 8197,0 8232,1 8320,0 8351,1 8439,0 8533,1 8552,0 8578,1 8665,0 8723,1 8814,0 8845,1 8892,0 8897,1 8992,0 8994,1 9089,0 9107,1 9142,0 9197,1 9240,0 9299,1 9359,0 9454,1 9458,0 9496,1 9549,0 9618,1 9642,0 9679,1 9716,0 9803,1 9810,0 9881,1 9923,0 9958,1 9969,0 10062,1 10122,0 10141,1 10198,0 10233,1 10296,0 10318,1 10394,0 10453,1 10502,0 10559,1 10657,0 10694,1 10749,0 10787,1 10856,0 10931,1 10994,0 10998,1 11047,0 11104,1 11177,0 11186,1 11259,0 11300,1 11333,0 11377,1 11443,0 11500,1 11528,0 11574,1 11625,0 11702,1 11726,0 11818,1 11891,0 11924,1 11999,0 12026,1 12054,0 12117,1 12148,0 12236,1 12332,0 12344,1 12394,0 12470,1 12496,0 12595,1 12621,0 12718,1 12802,0 12863,1 12961,0 13040,1 13140,0 13185,1 13234,0 13263,1 13277,0 13347,1 13420,0 13496,1 13538,0 13600,1 13602,0 13652,1 13666,0 13699,1 13730,0 13826,1 13867,0 13967,1 14025,0 14086,1 14120,0 14175,1 14202,0 14240,1 14319,0 14380,1 14443,0 14504,1 14508,0 14591,1 14647,0 14658,1 14741,0 14803,1 14841,0 14891,1 14909,0 14984,1 15066,0 15076,1 15128,0 15180,1 15204,0 15224,1 15255,0 15339,1 15402,0 15491,1 15580,0 15609,1 15640,0 15733,1 15734,0 15802,1 15886,0 15903,1 15969,0 15975,1 16055,0 16070,1 16123,0 16219,1 16298,0 16315,1 16324,0 16344,1 16346,0 16409,1 16473,0 16542,1 16602,0 16609,1 16626,0 16683,1 16769,0 16810,1 16814,0 16858,1 16914,0 17013,1 17024,0 17057,1 17086,0 17140,1 17188,0 17274,1 17366,0 17458,1 17538,0 17577,1 17600,0 17607,1 17624,0 17686,1 17748,0 17773,1 17862,0 17914,1 17996,0 18040,1 18087,0 18132,1 18227,0 18265,1 18304,0 18377,1 18451,0 18539,1 18580,0 18633,1 18639,0 18643,1 18707,0 18761,1 18811,0 18829,1 18847,0 18906,1 18955,0 18996,1 19041,0 19101,1 19135,0 19203,1 19298,0 19332,1 19406,0 19476,1 19497,0 19585,1 19611,0 19643,1 19743,0 19748,1 19812,0 19896,1 19900,0 19983,1 20008,0 20080,1 20156,0 20230,1 20279,0 20294,1 20355,0 20408,1 20477,0 20484,1 20516,0 20541,1 20631,0 20683,1 20723,0 20757,1 20849,0 20929,1 21021,0 21069,1 21138,0 21141,1 21198,0 21288,1 21381,0 21464,1 21468,0 21560,1 21654,0 21725,1 21796,0 21811,1 21909,0 21987,1 22007,0 22060,1 22077,0 22137,1 22174,0 22221,1 22274,0 22350,1 22440,0 22442,1 22512,0 22595,1 22606,0 22670,1 22732,0 22821,1 22905,0 22974,1 23032,0 23093,1 23129,0 23135,1 23173,0 23179,1 23218,0 23293,1 23337,0 23414,1 23485,0 23515,1 23591,0 23669,1 23680,0 23738,1 23815,0 23865,1 23962,0 24037,1 24116,0 24118,1 24151,0 24236,1 24238,0 24270,1 24295,0 24385,1 24407,0 24443,1 24456,0 24487,1 24557,0 24609,1 24615,0 24682,1 24715,0 24718,1 24741,0 24791,1 24840,0 24900,1 24977,0 25040,1 25111,0 25193,1 25199,0 25233,1 25324,0 25415,1 25505,0 25549,1 25564,0 25565,1 25581,0 25638,1 25711,0 25751,1 25772,0 25865,1 25877,0 25915,1 25965,0 25989,1 26061,0 26159,1 26175,0 26262,1 26330,0 26423,1 26500,0 26592,1 26669,0 26742,1 26841,0 26927,1 27005,0 27071,1 27152,0 27189,1 27242,0 27323,1 27391,0 27397,1 27406,0 27462,1 27505,0 27508,1 27511,0 27528,1 27625,0 27655,1 27699,0 27773,1 27853,0 27932,1 28025,0 28123,1 28222,0 28249,1 28336,0 28381,1 28474,0 28501,1 28557,0 28643,1 28673,0 28709,1 28726,0 28757,1 28829,0 28911,1 28968,0 29010,1 29080,0 29086,1 29121,0 29200,1 29210,0 29257,1 29357,0 29452,1 29549,0 29616,1 29662,0 29699,1 29771,0 29774,1 29867,0 29913,1 29940,0 29991,1 30001,0 30082,1 30103,0 30162,1 30168,0 30172,1 30199,0 30260,1 30284,0 30336,1 30355,0 30427,1 30467,0 30511,1 30604,0 30669,1 30715,0 30781,1 30794,0 30873,1 30913,0 31013,1 31047,0 31095,1 31158,0 31238,1 31296,0 31301,1 31343,0 31413,1 31467,0 31505,1 31583,0 31588,1 31643,0 31646,1 31692,0 31788,1 31838,0 31865,1 31907,0 31953,1 32013,0 32053,1 32104,0 32168,1 32252,0 32293,1 32381,0 32387,1 32457,0 32470,1 32523,0 32585,1 32597,0 32653,1 32746,0 32776,1 32875,0 32946,1 32991,0 33018,1 33042,0 33049,1 33147,0 33241,1 33290,0 33374,1 33383,0 33384,1 33402,0 33451,1 33501,0 33535,1 33553,0 33626,1 33723,0 33759,1 33779,0 33791,1 33810,0 33884,1 33977,0 34012,1 34046,0 34080,1 34161,0 34178,1 34259,0 34260,1 34322,0 34369,1 34439,0 34454,1 34537,0 34615,1 34619,0 34631,1 34652,0 34694,1 34716,0 34785,1 34823,0 34899,1 34990,0 35011,1 35056,0 35105,1 35124,0 35157,1 35173,0 35224,1 35313,0 35385,1 35472,0 35554,1 35609,0 35666,1 35764,0 35861,1 35903,0 35971,1 36058,0 36108,1 36138,0 36185,1 36228,0 36283,1 36294,0 36383,1 36476,0 36575,1 36577,0 36643,1 36690,0 36696,1 36746,0 36822,1 36877,0 36933,1 36970,0 37015,1 37024,0 37034,1 37063,0 37129,1 37224,0 37228,1 37236,0 37259,1 37278,0 37309,1 37358,0 37403,1 37463,0 37556,1 37623,0 37659,1 37713,0 37762,1 37763,0 37790,1 37810,0 37846,1 37860,0 37869,1 37893,0 37951,1 37972,0 37996,1 38014,0 38037,1 38073,0 38163,1 38239,0 38242,1 38333,0 38397,1 38464,0 38531,1 38574,0 38671,1 38757,0 38811,1 38858,0 38879,1 38952,0 39001,1 39085,0 39129,1 39159,0 39173,1 39265,0 39329,1 39378,0 39401,1 39452,0 39531,1 39549,0 39609,1 39632,0 39664,1 39703,0 39734,1 39747,0 39756,1 39791,0 39796,1 39805,0 39895,1 39979,0 40015,1 40055,0 40082,1 40145,0 40209,1 40244,0 40245,1 40248,0 40262,1 40345,0 40392,1 40473,0 40498,1 40534,0 40603,1 40674,0 40747,1 40812,0 40868,1 40916,0 40924,1 40935,0 40961,1 40962,0 41004,1 41066,0 41077,1 41143,0 41172,1 41177,0 41179,1 41268,0 41361,1 41441,0 41458,1 41515,0 41599,1 41667,0 41675,1 41739,0 41755,1 41809,0 41868,1 41963,0 42038,1 42045,0 42142,1 42148,0 42185,1 42212,0 42238,1 42247,0 42284,1 42319,0 42402,1 42490,0 42494,1 42527,0 42619,1 42642,0 42684,1 42693,0 42695,1 42788,0 42829,1 42872,0 42965,1 43051,0 43110,1 43138,0 43224,1 43306,0 43333,1 43400,0 43468,1 43502,0 43512,1 43528,0 43596,1 43671,0 43700,1 43740,0 43766,1 43830,0 43890,1 43979,0 44038,1 44119,0 44193,1 44207,0 44208,1 44280,0 44325,1 44368,0 44461,1 44536,0 44578,1 44580,0 44600,1 44636,0 44681,1 44706,0 44771,1 44823,0 44836,1 44847,0 44888,1 44968,0 45047,1 45061,0 45073,1 45082,0 45173,1 45247,0 45295,1 45328,0 45350,1 45363,0 45365,1 45390,0 45405,1 45502,0 45594,1 45600,0 45695,1 45793,0 45824,1 45884,0 45926,1 45988,0 46009,1 46075,0 46116,1 46171,0 46195,1 46201,0 46291,1 46332,0 46364,1 46446,0 46478,1 46506,0 46543,1 46584,0 46669,1 46730,0 46811,1 46878,0 46897,1 46983,0 47073,1 47145,0 47162,1 47226,0 47237,1 47328,0 47424,1 47514,0 47529,1 47625,0 47653,1 47729,0 47775,1 47872,0 47885,1 47975,0 47999,1 48063,0 48082,1 48156,0 48222,1 48288,0 48310,1 48382,0 48445,1 48484,0 48516,1 48522,0 48543,1 48574,0 48612,1 48676,0 48728,1 48730,0 48820,1 48876,0 48949,1 49048,0 49075,1 49076,0 49156,1 49254,0 49323,1 49332,0 49373,1 49429,0 49483,1 49516,0 49550,1 49558,0 49567,1 49655,0 49677,1 49725,0 49787,1 49793,0 49869,1 49893,0 49962,1 50026,0 50038,1 50088,0 50142,1 50160,0 50186,1 50190,0 50265,1 50330,0 50410,1 end initlist c18 0,0 64,1 100,0 199,1 224,0 324,1 421,0 514,1 582,0 681,1 720,0 815,1 841,0 865,1 920,0 990,1 1080,0 1176,1 1258,0 1319,1 1371,0 1394,1 1455,0 1483,1 1540,0 1629,1 1683,0 1696,1 1790,0 1842,1 1874,0 1878,1 1896,0 1914,1 1990,0 2043,1 2086,0 2162,1 2226,0 2238,1 2262,0 2348,1 2371,0 2413,1 2475,0 2550,1 2634,0 2707,1 2741,0 2746,1 2793,0 2808,1 2907,0 2912,1 2937,0 3021,1 3080,0 3158,1 3174,0 3260,1 3308,0 3337,1 3385,0 3389,1 3393,0 3451,1 3466,0 3477,1 3566,0 3626,1 3673,0 3760,1 3774,0 3819,1 3841,0 3907,1 3963,0 4009,1 4048,0 4063,1 4085,0 4109,1 4178,0 4213,1 4279,0 4345,1 4357,0 4440,1 4472,0 4550,1 4565,0 4635,1 4673,0 4730,1 4750,0 4837,1 4847,0 4945,1 5010,0 5095,1 5141,0 5182,1 5202,0 5294,1 5312,0 5391,1 5435,0 5457,1 5480,0 5486,1 5554,0 5642,1 5707,0 5792,1 5874,0 5942,1 6020,0 6101,1 6103,0 6169,1 6216,0 6310,1 6393,0 6402,1 6459,0 6522,1 6578,0 6647,1 6678,0 6725,1 6733,0 6831,1 6869,0 6926,1 7005,0 7073,1 7087,0 7154,1 7161,0 7248,1 7251,0 7306,1 7363,0 7380,1 7403,0 7496,1 7507,0 7607,1 7643,0 7655,1 7710,0 7733,1 7773,0 7795,1 7893,0 7919,1 8019,0 8074,1 8124,0 8163,1 8202,0 8265,1 8297,0 8327,1 8351,0 8407,1 8447,0 8514,1 8516,0 8521,1 8615,0 8709,1 8784,0 8870,1 8929,0 8947,1 8969,0 8986,1 8987,0 9051,1 9081,0 9167,1 9241,0 9337,1 9394,0 9443,1 9470,0 9548,1 9607,0 9649,1 9731,0 9789,1 9864,0 9908,1 9967,0 10002,1 10057,0 10132,1 10205,0 10299,1 10369,0 10408,1 10419,0 10501,1 10545,0 10571,1 10643,0 10654,1 10686,0 10721,1 10770,0 10784,1 10816,0 10839,1 10866,0 10875,1 10942,0 11028,1 11122,0 11189,1 11289,0 11345,1 11431,0 11479,1 11510,0 11606,1 11700,0 11754,1 11763,0 11825,1 11852,0 11934,1 12007,0 12054,1 12124,0 12139,1 12158,0 12256,1 12270,0 12305,1 12366,0 12456,1 12543,0 12594,1 12599,0 12638,1 12719,0 12780,1 12788,0 12840,1 12850,0 12884,1 12951,0 12966,1 13010,0 13107,1 13170,0 13204,1 13259,0 13354,1 13433,0 13466,1 13547,0 13606,1 13657,0 13663,1 13740,0 13770,1 13829,0 13884,1 13928,0 13939,1 13950,0 14045,1 14116,0 14129,1 14203,0 14295,1 14385,0 14413,1 14510,0 14604,1 14621,0 14636,1 14712,0 14809,1 14858,0 14901,1 14905,0 14961,1 14992,0 15008,1 15060,0 15130,1 15220,0 15277,1 15332,0 15337,1 15388,0 15432,1 15451,0 15498,1 15583,0 15598,1 15645,0 15689,1 15708,0 15723,1 15748,0 15761,1 15860,0 15894,1 15972,0 16025,1 16027,0 16101,1 16132,0 16182,1 16272,0 16363,1 16364,0 16417,1 16437,0 16505,1 16540,0 16578,1 16632,0 16639,1 16657,0 16707,1 16749,0 16845,1 16903,0 16951,1 17037,0 17131,1 17157,0 17240,1 17301,0 17363,1 17430,0 17503,1 17508,0 17548,1 17584,0 17654,1 17683,0 17781,1 17809,0 17821,1 17839,0 17840,1 17890,0 17990,1 18083,0 18132,1 18202,0 18274,1 18357,0 18428,1 18458,0 18471,1 18555,0 18598,1 18648,0 18668,1 18756,0 18843,1 18886,0 18965,1 18998,0 19094,1 19116,0 19149,1 19177,0 19261,1 19303,0 19345,1 19370,0 19447,1 19536,0 19608,1 19627,0 19628,1 19694,0 19768,1 19807,0 19815,1 19911,0 19968,1 20057,0 20130,1 20195,0 20265,1 20308,0 20403,1 20453,0 20495,1 20532,0 20535,1 20574,0 20623,1 20705,0 20738,1 20808,0 20847,1 20888,0 20942,1 21011,0 21016,1 21018,0 21056,1 21134,0 21166,1 21237,0 21326,1 21364,0 21413,1 21450,0 21518,1 21528,0 21615,1 21681,0 21739,1 21740,0 21828,1 21829,0 21830,1 21902,0 21967,1 22056,0 22150,1 22169,0 22263,1 22280,0 22303,1 22329,0 22422,1 22433,0 22440,1 22477,0 22559,1 22581,0 22645,1 22694,0 22718,1 22741,0 22784,1 22812,0 22843,1 22848,0 22947,1 23009,0 23031,1 23035,0 23085,1 23181,0 23276,1 23316,0 23392,1 23414,0 23460,1 23528,0 23610,1 23648,0 23731,1 23804,0 23808,1 23888,0 23957,1 23958,0 23978,1 24010,0 24056,1 24154,0 24225,1 24297,0 24308,1 24345,0 24371,1 24419,0 24482,1 24566,0 24569,1 24620,0 24638,1 24728,0 24768,1 24837,0 24840,1 24893,0 24974,1 25003,0 25097,1 25115,0 25207,1 25300,0 25351,1 25373,0 25453,1 25510,0 25517,1 25595,0 25683,1 25734,0 25792,1 25840,0 25912,1 26006,0 26062,1 26126,0 26135,1 26223,0 26287,1 26378,0 26433,1 26499,0 26557,1 26595,0 26672,1 26689,0 26706,1 26771,0 26806,1 26857,0 26865,1 26870,0 26899,1 26984,0 27026,1 27111,0 27198,1 27245,0 27298,1 27381,0 27433,1 27452,0 27466,1 27539,0 27628,1 27712,0 27784,1 27865,0 27934,1 27955,0 28005,1 28013,0 28068,1 28085,0 28135,1 28144,0 28223,1 28271,0 28357,1 28431,0 28523,1 28591,0 28607,1 28618,0 28684,1 28773,0 28837,1 28844,0 28938,1 28992,0 29067,1 29079,0 29160,1 29199,0 29261,1 29356,0 29418,1 29423,0 29457,1 29519,0 29541,1 29591,0 29674,1 29720,0 29757,1 29768,0 29802,1 29870,0 29926,1 29983,0 30035,1 30135,0 30180,1 30223,0 30233,1 30316,0 30392,1 30480,0 30578,1 30604,0 30684,1 30696,0 30721,1 30774,0 30849,1 30856,0 30899,1 30912,0 30915,1 30984,0 31066,1 31076,0 31101,1 31147,0 31246,1 31285,0 31366,1 31391,0 31446,1 31462,0 31515,1 31613,0 31650,1 31717,0 31808,1 31897,0 31986,1 32057,0 32130,1 32153,0 32161,1 32163,0 32214,1 32240,0 32321,1 32361,0 32386,1 32448,0 32537,1 32567,0 32613,1 32637,0 32713,1 32734,0 32742,1 32756,0 32824,1 32841,0 32938,1 32959,0 32998,1 33064,0 33156,1 33173,0 33198,1 33273,0 33298,1 33386,0 33470,1 33490,0 33589,1 33591,0 33606,1 33651,0 33690,1 33763,0 33788,1 33842,0 33939,1 33947,0 33996,1 34081,0 34122,1 34145,0 34196,1 34207,0 34294,1 34355,0 34389,1 34392,0 34491,1 34545,0 34583,1 34584,0 34642,1 34721,0 34803,1 34821,0 34822,1 34841,0 34844,1 34901,0 34915,1 34936,0 34999,1 35099,0 35129,1 35158,0 35171,1 35222,0 35294,1 35350,0 35422,1 35488,0 35532,1 35557,0 35572,1 35645,0 35741,1 35831,0 35916,1 36012,0 36064,1 36092,0 36177,1 36243,0 36301,1 36342,0 36419,1 36510,0 36527,1 36572,0 36626,1 36649,0 36694,1 36748,0 36799,1 36833,0 36917,1 36984,0 37061,1 37095,0 37100,1 37150,0 37169,1 37191,0 37249,1 37324,0 37380,1 37382,0 37383,1 37470,0 37570,1 37647,0 37667,1 37707,0 37709,1 37752,0 37792,1 37831,0 37870,1 37904,0 37968,1 37973,0 38059,1 38063,0 38086,1 38134,0 38203,1 38276,0 38350,1 38415,0 38426,1 38468,0 38516,1 38530,0 38561,1 38617,0 38677,1 38698,0 38783,1 38828,0 38870,1 38916,0 38947,1 39042,0 39117,1 39193,0 39228,1 39294,0 39379,1 39388,0 39394,1 39469,0 39473,1 39532,0 39539,1 39549,0 39638,1 39728,0 39809,1 39862,0 39886,1 39978,0 39980,1 39981,0 40066,1 40140,0 40167,1 40194,0 40278,1 40284,0 40375,1 40395,0 40442,1 40522,0 40585,1 40665,0 40676,1 40770,0 40803,1 40819,0 40865,1 40886,0 40908,1 40913,0 40924,1 40969,0 40998,1 41051,0 41138,1 41215,0 41238,1 41249,0 41319,1 41328,0 41363,1 41442,0 41479,1 41487,0 41542,1 41556,0 41646,1 41741,0 41773,1 41833,0 41913,1 41985,0 41989,1 42027,0 42046,1 42102,0 42155,1 42206,0 42283,1 42343,0 42363,1 42415,0 42454,1 42543,0 42624,1 42688,0 42705,1 42759,0 42807,1 42897,0 42903,1 42941,0 42990,1 42995,0 43067,1 43134,0 43210,1 43217,0 43305,1 43392,0 43430,1 43457,0 43514,1 43528,0 43579,1 43652,0 43722,1 43772,0 43789,1 43815,0 43914,1 44013,0 44069,1 44160,0 44220,1 44246,0 44294,1 44316,0 44406,1 44474,0 44558,1 44648,0 44717,1 44774,0 44837,1 44931,0 45022,1 45048,0 45052,1 45105,0 45153,1 45204,0 45254,1 45307,0 45404,1 45482,0 45577,1 45663,0 45720,1 45781,0 45865,1 45904,0 45958,1 45997,0 46023,1 46069,0 46082,1 46154,0 46240,1 46251,0 46281,1 46361,0 46400,1 46430,0 46526,1 46579,0 46632,1 46670,0 46688,1 46698,0 46764,1 46791,0 46859,1 46909,0 46978,1 47022,0 47069,1 47154,0 47254,1 47257,0 47296,1 47326,0 47408,1 47481,0 47485,1 47518,0 47550,1 47585,0 47627,1 47632,0 47690,1 47783,0 47865,1 47954,0 47970,1 48029,0 48053,1 48060,0 48069,1 48168,0 48231,1 48270,0 48307,1 48368,0 48392,1 48486,0 48530,1 48548,0 48579,1 48584,0 48595,1 48679,0 48735,1 48802,0 48855,1 48915,0 48929,1 48998,0 49037,1 49041,0 49075,1 49081,0 49127,1 49143,0 49217,1 49241,0 49326,1 49394,0 49467,1 49501,0 49522,1 49591,0 49682,1 49740,0 49821,1 49914,0 49988,1 50063,0 50132,1 50138,0 50220,1 50265,0 50310,1 50367,0 50401,1 50444,0 50502,1 50542,0 50618,1 50672,0 50745,1 end initlist c19 0,0 1,1 47,0 48,1 131,0 157,1 229,0 274,1 325,0 386,1 439,0 495,1 566,0 598,1 664,0 750,1 818,0 905,1 963,0 997,1 1013,0 1093,1 1190,0 1266,1 1280,0 1313,1 1383,0 1427,1 1519,0 1567,1 1592,0 1636,1 1651,0 1698,1 1738,0 1802,1 1867,0 1886,1 1985,0 1992,1 2080,0 2109,1 2172,0 2207,1 2244,0 2338,1 2435,0 2476,1 2482,0 2539,1 2581,0 2591,1 2673,0 2722,1 2787,0 2838,1 2860,0 2907,1 2911,0 2913,1 2981,0 3076,1 3166,0 3242,1 3276,0 3313,1 3408,0 3430,1 3512,0 3611,1 3656,0 3698,1 3771,0 3842,1 3866,0 3893,1 3896,0 3916,1 3975,0 4070,1 4111,0 4180,1 4233,0 4250,1 4324,0 4410,1 4445,0 4502,1 4599,0 4682,1 4745,0 4829,1 4926,0 4996,1 5036,0 5088,1 5103,0 5149,1 5186,0 5210,1 5234,0 5311,1 5349,0 5444,1 5514,0 5540,1 5626,0 5636,1 5731,0 5753,1 5776,0 5870,1 5942,0 5992,1 6060,0 6070,1 6162,0 6177,1 6222,0 6276,1 6277,0 6297,1 6307,0 6375,1 6421,0 6459,1 6521,0 6545,1 6572,0 6634,1 6676,0 6685,1 6694,0 6764,1 6772,0 6850,1 6884,0 6943,1 7020,0 7042,1 7049,0 7124,1 7177,0 7196,1 7233,0 7302,1 7396,0 7471,1 7543,0 7575,1 7663,0 7719,1 7790,0 7852,1 7902,0 7965,1 8062,0 8132,1 8169,0 8191,1 8277,0 8297,1 8353,0 8387,1 8478,0 8525,1 8537,0 8629,1 8678,0 8717,1 8749,0 8825,1 8886,0 8959,1 8972,0 8978,1 8995,0 9029,1 9123,0 9128,1 9141,0 9228,1 9284,0 9381,1 9422,0 9515,1 9555,0 9579,1 9650,0 9704,1 9754,0 9850,1 9911,0 9987,1 10079,0 10090,1 10177,0 10247,1 10301,0 10350,1 10441,0 10527,1 10583,0 10675,1 10733,0 10743,1 10790,0 10794,1 10796,0 10845,1 10855,0 10863,1 10932,0 11032,1 11132,0 11168,1 11258,0 11275,1 11343,0 11359,1 11422,0 11468,1 11555,0 11649,1 11721,0 11785,1 11826,0 11921,1 11995,0 12080,1 12143,0 12214,1 12251,0 12263,1 12328,0 12425,1 12480,0 12491,1 12553,0 12652,1 12734,0 12825,1 12856,0 12947,1 12967,0 13009,1 13089,0 13138,1 13213,0 13227,1 13258,0 13322,1 13358,0 13361,1 13442,0 13490,1 13514,0 13517,1 13572,0 13655,1 13675,0 13687,1 13751,0 13840,1 13913,0 13930,1 14003,0 14047,1 14092,0 14172,1 14259,0 14333,1 14432,0 14490,1 14543,0 14629,1 14645,0 14683,1 14720,0 14781,1 14872,0 14962,1 15036,0 15088,1 15120,0 15168,1 15207,0 15221,1 15270,0 15364,1 15422,0 15493,1 15572,0 15647,1 15657,0 15675,1 15746,0 15835,1 15881,0 15883,1 15940,0 16040,1 16078,0 16109,1 16131,0 16154,1 16248,0 16295,1 16390,0 16433,1 16468,0 16531,1 16545,0 16587,1 16623,0 16639,1 16675,0 16704,1 16712,0 16713,1 16786,0 16836,1 16851,0 16860,1 16877,0 16913,1 16927,0 16958,1 17018,0 17077,1 17080,0 17144,1 17193,0 17244,1 17295,0 17347,1 17433,0 17492,1 17588,0 17671,1 17740,0 17786,1 17830,0 17895,1 17963,0 17974,1 18035,0 18115,1 18175,0 18275,1 18315,0 18375,1 18462,0 18491,1 18524,0 18549,1 18557,0 18633,1 18661,0 18670,1 18728,0 18789,1 18877,0 18901,1 18942,0 19024,1 19053,0 19076,1 19127,0 19211,1 19287,0 19362,1 19462,0 19500,1 19584,0 19633,1 19713,0 19772,1 19775,0 19862,1 19944,0 20043,1 20126,0 20198,1 20256,0 20351,1 20378,0 20424,1 20477,0 20545,1 20573,0 20666,1 20671,0 20706,1 20795,0 20865,1 20894,0 20986,1 21040,0 21135,1 21160,0 21225,1 21296,0 21317,1 21340,0 21344,1 21357,0 21399,1 21459,0 21484,1 21491,0 21562,1 21660,0 21710,1 21783,0 21865,1 21895,0 21980,1 21989,0 22069,1 22145,0 22148,1 22202,0 22210,1 22264,0 22312,1 22339,0 22396,1 22432,0 22512,1 22526,0 22536,1 22543,0 22584,1 22618,0 22685,1 22762,0 22858,1 22933,0 23023,1 23086,0 23094,1 23174,0 23203,1 23242,0 23301,1 23362,0 23399,1 23470,0 23570,1 23615,0 23617,1 23661,0 23673,1 23716,0 23808,1 23876,0 23939,1 24027,0 24111,1 24163,0 24254,1 24343,0 24405,1 24407,0 24419,1 24435,0 24497,1 24571,0 24585,1 24674,0 24739,1 24816,0 24849,1 24889,0 24923,1 25018,0 25058,1 25083,0 25159,1 25169,0 25172,1 25209,0 25211,1 25264,0 25293,1 25316,0 25410,1 25474,0 25477,1 25507,0 25559,1 25566,0 25599,1 25659,0 25681,1 25724,0 25772,1 25780,0 25781,1 25856,0 25925,1 25928,0 25991,1 25992,0 26036,1 26088,0 26127,1 26224,0 26250,1 26280,0 26294,1 26311,0 26358,1 26426,0 26457,1 26510,0 26573,1 26575,0 26654,1 26732,0 26815,1 26846,0 26882,1 26915,0 27013,1 27091,0 27094,1 27184,0 27237,1 27297,0 27397,1 27405,0 27473,1 27560,0 27591,1 27630,0 27700,1 27739,0 27769,1 27792,0 27804,1 27876,0 27959,1 28039,0 28139,1 28219,0 28231,1 28262,0 28270,1 28285,0 28290,1 28355,0 28389,1 28404,0 28430,1 28493,0 28539,1 28583,0 28666,1 28708,0 28767,1 28832,0 28880,1 28972,0 29039,1 29132,0 29231,1 29319,0 29346,1 29440,0 29514,1 29566,0 29660,1 29722,0 29792,1 29806,0 29812,1 29822,0 29876,1 29902,0 29951,1 30021,0 30023,1 30046,0 30136,1 30148,0 30237,1 30246,0 30340,1 30402,0 30475,1 30494,0 30568,1 30591,0 30688,1 30695,0 30744,1 30793,0 30821,1 30868,0 30965,1 31014,0 31015,1 31049,0 31074,1 31075,0 31081,1 31157,0 31199,1 31253,0 31275,1 31293,0 31320,1 31364,0 31384,1 31443,0 31509,1 31515,0 31516,1 31607,0 31679,1 31778,0 31818,1 31877,0 31933,1 31995,0 32018,1 32074,0 32147,1 32168,0 32233,1 32240,0 32268,1 32325,0 32422,1 32448,0 32521,1 32613,0 32668,1 32679,0 32694,1 32696,0 32708,1 32746,0 32835,1 32919,0 33010,1 33074,0 33077,1 33082,0 33173,1 33207,0 33287,1 33297,0 33370,1 33456,0 33499,1 33547,0 33582,1 33673,0 33721,1 33735,0 33761,1 33839,0 33865,1 33893,0 33917,1 33948,0 33951,1 33996,0 34052,1 34151,0 34196,1 34284,0 34376,1 34431,0 34520,1 34580,0 34630,1 34677,0 34687,1 34696,0 34763,1 34779,0 34795,1 34880,0 34894,1 34984,0 34991,1 35034,0 35081,1 35101,0 35173,1 35214,0 35280,1 35364,0 35425,1 35500,0 35548,1 35554,0 35603,1 35622,0 35683,1 35721,0 35818,1 35833,0 35867,1 35948,0 36038,1 36055,0 36126,1 36195,0 36252,1 36350,0 36398,1 36494,0 36593,1 36641,0 36657,1 36738,0 36811,1 36868,0 36964,1 37042,0 37050,1 37072,0 37169,1 37172,0 37238,1 37256,0 37356,1 37430,0 37446,1 37498,0 37525,1 37551,0 37650,1 37655,0 37674,1 37732,0 37738,1 37820,0 37887,1 37919,0 37995,1 38006,0 38080,1 38160,0 38226,1 38312,0 38391,1 38448,0 38494,1 38543,0 38580,1 38666,0 38677,1 38733,0 38812,1 38885,0 38933,1 39029,0 39068,1 39075,0 39146,1 39181,0 39188,1 39266,0 39365,1 39372,0 39407,1 39471,0 39524,1 39594,0 39694,1 39773,0 39787,1 39845,0 39874,1 39945,0 40016,1 40040,0 40053,1 40093,0 40111,1 40135,0 40200,1 40267,0 40366,1 40398,0 40459,1 40493,0 40587,1 40626,0 40681,1 40687,0 40755,1 40826,0 40916,1 40960,0 40980,1 41019,0 41063,1 41153,0 41184,1 41234,0 41289,1 41330,0 41422,1 41431,0 41471,1 41527,0 41572,1 41605,0 41672,1 41701,0 41778,1 41845,0 41872,1 41927,0 42006,1 42105,0 42109,1 42166,0 42263,1 42305,0 42374,1 42436,0 42495,1 42573,0 42618,1 42682,0 42732,1 42825,0 42868,1 42915,0 42935,1 43031,0 43060,1 43156,0 43166,1 43190,0 43277,1 43362,0 43430,1 43519,0 43613,1 43637,0 43731,1 43817,0 43875,1 43930,0 43938,1 44017,0 44063,1 44152,0 44208,1 44215,0 44290,1 44295,0 44327,1 44401,0 44413,1 44427,0 44451,1 44517,0 44609,1 44654,0 44662,1 44673,0 44753,1 44831,0 44895,1 44955,0 45047,1 45122,0 45217,1 45267,0 45354,1 45416,0 45429,1 45520,0 45525,1 45526,0 45544,1 45592,0 45642,1 45730,0 45747,1 45833,0 45908,1 45945,0 45990,1 46000,0 46096,1 46099,0 46151,1 46203,0 46245,1 46338,0 46370,1 46407,0 46497,1 46591,0 46604,1 46620,0 46634,1 46649,0 46650,1 46654,0 46695,1 46720,0 46741,1 46813,0 46891,1 46958,0 47024,1 47069,0 47160,1 47248,0 47330,1 47414,0 47476,1 47535,0 47623,1 47712,0 47720,1 47771,0 47800,1 47867,0 47892,1 47966,0 48015,1 48039,0 48130,1 48228,0 48278,1 48335,0 48365,1 48456,0 48534,1 48557,0 48645,1 48709,0 48733,1 48752,0 48836,1 48905,0 48961,1 49024,0 49060,1 49097,0 49148,1 49216,0 49311,1 49382,0 49411,1 49431,0 49440,1 49460,0 49553,1 49592,0 49639,1 49689,0 49710,1 49808,0 49813,1 49874,0 49897,1 49972,0 49988,1 49998,0 50040,1 50121,0 50181,1 50272,0 50364,1 50414,0 50508,1 50532,0 50617,1 50675,0 50731,1 50804,0 50844,1 50886,0 50904,1 50977,0 50979,1 51049,0 51054,1 51087,0 51162,1 51176,0 51211,1 51236,0 51272,1 51357,0 51401,1 51410,0 51476,1 end initlist c20 0,0 30,1 45,0 102,1 109,0 208,1 236,0 323,1 345,0 411,1 500,0 501,1 562,0 609,1 635,0 713,1 745,0 765,1 835,0 874,1 944,0 992,1 1034,0 1069,1 1151,0 1193,1 1194,0 1249,1 1275,0 1310,1 1337,0 1393,1 1472,0 1499,1 1510,0 1544,1 1604,0 1639,1 1703,0 1785,1 1851,0 1868,1 1910,0 1936,1 1973,0 1993,1 2062,0 2116,1 2119,0 2183,1 2233,0 2325,1 2352,0 2438,1 2483,0 2527,1 2606,0 2684,1 2733,0 2742,1 2788,0 2881,1 2936,0 3033,1 3045,0 3119,1 3200,0 3240,1 3242,0 3250,1 3331,0 3375,1 3444,0 3451,1 3528,0 3609,1 3637,0 3673,1 3752,0 3847,1 3921,0 3949,1 4007,0 4051,1 4141,0 4187,1 4258,0 4312,1 4324,0 4376,1 4475,0 4543,1 4571,0 4651,1 4652,0 4655,1 4660,0 4733,1 4793,0 4830,1 4924,0 4995,1 5089,0 5136,1 5223,0 5318,1 5378,0 5439,1 5481,0 5532,1 5624,0 5698,1 5747,0 5807,1 5810,0 5863,1 5882,0 5918,1 6018,0 6041,1 6051,0 6117,1 6181,0 6274,1 6278,0 6300,1 6367,0 6442,1 6469,0 6566,1 6642,0 6692,1 6760,0 6768,1 6831,0 6877,1 6882,0 6927,1 7002,0 7016,1 7101,0 7110,1 7145,0 7161,1 7235,0 7247,1 7328,0 7357,1 7377,0 7424,1 7453,0 7553,1 7603,0 7661,1 7695,0 7715,1 7730,0 7809,1 7856,0 7955,1 8030,0 8130,1 8141,0 8196,1 8238,0 8331,1 8386,0 8415,1 8447,0 8512,1 8545,0 8591,1 8685,0 8757,1 8776,0 8780,1 8861,0 8873,1 8890,0 8954,1 9046,0 9137,1 9161,0 9218,1 9304,0 9388,1 9401,0 9421,1 9484,0 9516,1 9573,0 9632,1 9699,0 9701,1 9723,0 9725,1 9726,0 9785,1 9870,0 9946,1 9952,0 9954,1 10006,0 10025,1 10053,0 10076,1 10094,0 10156,1 10209,0 10245,1 10337,0 10354,1 10404,0 10478,1 10536,0 10587,1 10634,0 10710,1 10781,0 10880,1 10954,0 11017,1 11093,0 11148,1 11149,0 11172,1 11255,0 11281,1 11361,0 11400,1 11482,0 11576,1 11648,0 11668,1 11750,0 11839,1 11842,0 11938,1 12024,0 12091,1 12166,0 12212,1 12222,0 12229,1 12318,0 12375,1 12393,0 12480,1 12482,0 12500,1 12543,0 12594,1 12691,0 12789,1 12843,0 12915,1 12922,0 13004,1 13009,0 13102,1 13119,0 13134,1 13164,0 13234,1 13300,0 13335,1 13339,0 13398,1 13474,0 13555,1 13619,0 13659,1 13669,0 13705,1 13778,0 13854,1 13879,0 13943,1 14038,0 14058,1 14137,0 14230,1 14274,0 14328,1 14331,0 14371,1 14396,0 14456,1 14510,0 14556,1 14617,0 14653,1 14657,0 14695,1 14727,0 14810,1 14884,0 14926,1 14987,0 15055,1 15123,0 15182,1 15203,0 15278,1 15331,0 15358,1 15442,0 15501,1 15581,0 15647,1 15681,0 15727,1 15803,0 15853,1 15885,0 15914,1 15950,0 16016,1 16108,0 16172,1 16241,0 16291,1 16382,0 16401,1 16408,0 16460,1 16515,0 16558,1 16560,0 16641,1 16715,0 16801,1 16855,0 16868,1 16952,0 16991,1 17004,0 17088,1 17144,0 17156,1 17204,0 17226,1 17308,0 17354,1 17358,0 17400,1 17481,0 17505,1 17556,0 17572,1 17591,0 17656,1 17753,0 17807,1 17830,0 17925,1 18020,0 18115,1 18209,0 18300,1 18313,0 18325,1 18413,0 18465,1 18535,0 18602,1 18610,0 18616,1 18693,0 18770,1 18827,0 18881,1 18970,0 19063,1 19151,0 19164,1 19195,0 19283,1 19300,0 19377,1 19390,0 19426,1 19512,0 19578,1 19655,0 19742,1 19802,0 19901,1 19920,0 19927,1 19946,0 19968,1 20053,0 20073,1 20168,0 20184,1 20187,0 20282,1 20317,0 20387,1 20388,0 20452,1 20512,0 20587,1 20608,0 20611,1 20710,0 20734,1 20790,0 20890,1 20938,0 21032,1 21113,0 21147,1 21206,0 21304,1 21364,0 21385,1 21477,0 21503,1 21518,0 21520,1 21556,0 21626,1 21648,0 21681,1 21781,0 21810,1 21904,0 21975,1 22059,0 22150,1 22225,0 22246,1 22268,0 22317,1 22354,0 22447,1 22459,0 22464,1 22552,0 22584,1 22645,0 22658,1 22703,0 22769,1 22793,0 22858,1 22894,0 22919,1 22991,0 23033,1 23090,0 23147,1 23183,0 23201,1 23299,0 23369,1 23423,0 23452,1 23466,0 23545,1 23580,0 23597,1 23621,0 23707,1 23776,0 23785,1 23791,0 23798,1 23819,0 23862,1 23914,0 23922,1 23944,0 24020,1 24081,0 24128,1 24159,0 24164,1 24185,0 24242,1 24254,0 24344,1 24367,0 24435,1 24497,0 24559,1 24614,0 24705,1 24736,0 24811,1 24883,0 24949,1 25001,0 25039,1 25121,0 25180,1 25204,0 25239,1 25258,0 25328,1 25349,0 25431,1 25526,0 25581,1 25615,0 25706,1 25735,0 25736,1 25737,0 25740,1 25772,0 25811,1 25865,0 25888,1 25906,0 25918,1 25970,0 25983,1 26001,0 26101,1 26183,0 26273,1 26354,0 26414,1 26501,0 26522,1 26621,0 26633,1 26656,0 26663,1 26670,0 26682,1 26687,0 26754,1 26787,0 26811,1 26906,0 26916,1 26990,0 27001,1 27047,0 27054,1 27084,0 27147,1 27195,0 27226,1 27241,0 27323,1 27332,0 27377,1 27462,0 27490,1 27507,0 27542,1 27600,0 27619,1 27647,0 27721,1 27741,0 27798,1 27875,0 27935,1 27938,0 28004,1 28019,0 28102,1 28180,0 28198,1 28224,0 28298,1 28369,0 28402,1 28460,0 28464,1 28525,0 28606,1 28620,0 28718,1 28760,0 28794,1 28841,0 28920,1 28940,0 29018,1 29094,0 29194,1 29283,0 29344,1 29378,0 29466,1 29565,0 29584,1 29619,0 29627,1 29712,0 29738,1 29834,0 29862,1 29887,0 29983,1 30072,0 30172,1 30237,0 30337,1 30437,0 30531,1 30577,0 30604,1 30615,0 30663,1 30756,0 30851,1 30909,0 30928,1 30950,0 31001,1 31024,0 31058,1 31078,0 31092,1 31099,0 31114,1 31202,0 31273,1 31357,0 31436,1 31489,0 31564,1 31658,0 31746,1 31758,0 31759,1 31838,0 31859,1 31901,0 31983,1 32050,0 32075,1 32160,0 32187,1 32267,0 32297,1 32388,0 32477,1 32538,0 32557,1 32564,0 32595,1 32628,0 32701,1 32719,0 32767,1 32815,0 32834,1 32891,0 32968,1 33010,0 33017,1 33110,0 33176,1 33236,0 33283,1 33313,0 33366,1 33373,0 33439,1 33536,0 33588,1 33649,0 33681,1 33683,0 33717,1 33728,0 33814,1 33874,0 33903,1 33976,0 33981,1 34035,0 34093,1 34192,0 34212,1 34270,0 34300,1 34358,0 34420,1 34507,0 34596,1 34600,0 34637,1 34712,0 34797,1 34802,0 34900,1 34924,0 34991,1 35042,0 35048,1 35095,0 35192,1 35214,0 35244,1 35250,0 35306,1 35370,0 35424,1 35484,0 35500,1 35552,0 35580,1 35651,0 35695,1 35720,0 35747,1 35825,0 35887,1 35911,0 35978,1 35980,0 36039,1 36109,0 36205,1 36241,0 36298,1 36345,0 36431,1 36464,0 36502,1 36508,0 36533,1 36577,0 36615,1 36696,0 36704,1 36800,0 36806,1 36837,0 36900,1 36932,0 36944,1 37015,0 37089,1 37111,0 37206,1 37263,0 37281,1 37339,0 37378,1 37418,0 37433,1 37500,0 37503,1 37531,0 37597,1 37692,0 37734,1 37753,0 37805,1 37824,0 37873,1 37971,0 38036,1 38068,0 38161,1 38228,0 38317,1 38391,0 38438,1 38485,0 38541,1 38640,0 38661,1 38727,0 38821,1 38894,0 38963,1 39047,0 39063,1 39132,0 39220,1 39240,0 39259,1 39282,0 39358,1 39385,0 39413,1 39471,0 39535,1 39606,0 39622,1 39665,0 39714,1 39810,0 39905,1 39910,0 39963,1 39997,0 40082,1 40092,0 40155,1 40187,0 40198,1 40281,0 40319,1 40326,0 40330,1 40336,0 40371,1 40450,0 40469,1 40520,0 40553,1 40599,0 40624,1 40723,0 40727,1 40818,0 40831,1 40884,0 40925,1 40946,0 41000,1 41026,0 41080,1 41167,0 41223,1 41232,0 41233,1 41278,0 41287,1 41299,0 41310,1 41406,0 41490,1 41563,0 41569,1 41614,0 41617,1 41663,0 41738,1 41758,0 41831,1 41888,0 41924,1 41931,0 41933,1 41981,0 42009,1 42039,0 42049,1 42101,0 42143,1 42160,0 42176,1 42231,0 42245,1 42303,0 42329,1 42372,0 42409,1 42483,0 42580,1 42627,0 42643,1 42713,0 42764,1 42778,0 42825,1 42915,0 42970,1 43021,0 43103,1 43143,0 43237,1 43256,0 43325,1 43396,0 43451,1 43521,0 43620,1 43719,0 43813,1 43842,0 43884,1 43917,0 43956,1 44034,0 44040,1 44069,0 44130,1 44138,0 44192,1 44262,0 44341,1 44410,0 44449,1 44549,0 44628,1 44669,0 44673,1 44725,0 44814,1 44843,0 44850,1 44913,0 45002,1 45093,0 45150,1 45202,0 45219,1 45274,0 45365,1 45406,0 45417,1 45516,0 45531,1 45612,0 45709,1 45748,0 45841,1 45939,0 45996,1 46045,0 46063,1 46091,0 46150,1 46247,0 46328,1 46386,0 46471,1 46512,0 46553,1 46577,0 46649,1 46655,0 46754,1 46822,0 46850,1 46858,0 46908,1 46914,0 46994,1 47002,0 47064,1 47153,0 47223,1 47316,0 47327,1 47388,0 47442,1 47451,0 47455,1 47495,0 47588,1 47641,0 47734,1 47765,0 47813,1 47912,0 47988,1 48023,0 48057,1 48115,0 48179,1 48203,0 48297,1 48321,0 48407,1 48440,0 48448,1 48476,0 48554,1 48578,0 48671,1 48677,0 48704,1 48747,0 48754,1 48778,0 48858,1 48880,0 48927,1 48977,0 49071,1 49086,0 49177,1 49209,0 49287,1 49288,0 49292,1 49321,0 49332,1 49366,0 49384,1 49402,0 49412,1 49486,0 49506,1 49601,0 49665,1 end initlist c21 0,0 18,1 97,0 175,1 196,0 251,1 255,0 282,1 378,0 390,1 438,0 514,1 595,0 660,1 732,0 812,1 818,0 845,1 894,0 959,1 1050,0 1063,1 1088,0 1154,1 1183,0 1234,1 1313,0 1322,1 1359,0 1408,1 1472,0 1548,1 1566,0 1589,1 1641,0 1736,1 1803,0 1825,1 1895,0 1906,1 1915,0 1946,1 1990,0 2077,1 2108,0 2159,1 2163,0 2231,1 2257,0 2357,1 2364,0 2395,1 2445,0 2464,1 2511,0 2519,1 2587,0 2650,1 2656,0 2729,1 2825,0 2878,1 2907,0 2917,1 2967,0 3047,1 3117,0 3187,1 3279,0 3355,1 3360,0 3460,1 3496,0 3534,1 3543,0 3610,1 3657,0 3715,1 3736,0 3765,1 3806,0 3904,1 3976,0 4064,1 4082,0 4127,1 4130,0 4200,1 4285,0 4373,1 4459,0 4518,1 4520,0 4589,1 4650,0 4730,1 4773,0 4799,1 4869,0 4942,1 4959,0 4992,1 4997,0 5003,1 5087,0 5121,1 5147,0 5239,1 5257,0 5293,1 5347,0 5405,1 5479,0 5540,1 5624,0 5679,1 5714,0 5800,1 5875,0 5907,1 5914,0 5980,1 6003,0 6083,1 6161,0 6199,1 6277,0 6308,1 6336,0 6342,1 6439,0 6441,1 6533,0 6588,1 6591,0 6646,1 6710,0 6800,1 6860,0 6902,1 6982,0 7003,1 7052,0 7099,1 7143,0 7239,1 7281,0 7319,1 7336,0 7414,1 7427,0 7526,1 7596,0 7606,1 7613,0 7651,1 7663,0 7671,1 7678,0 7689,1 7784,0 7850,1 7864,0 7964,1 8024,0 8036,1 8042,0 8106,1 8163,0 8219,1 8252,0 8273,1 8291,0 8329,1 8382,0 8441,1 8531,0 8600,1 8661,0 8711,1 8755,0 8828,1 8883,0 8885,1 8975,0 9045,1 9105,0 9154,1 9232,0 9245,1 9342,0 9411,1 9507,0 9571,1 9636,0 9730,1 9772,0 9863,1 9920,0 10016,1 10071,0 10170,1 10182,0 10190,1 10257,0 10316,1 10322,0 10398,1 10416,0 10476,1 10576,0 10661,1 10670,0 10752,1 10849,0 10862,1 10881,0 10954,1 10981,0 11022,1 11090,0 11113,1 11160,0 11242,1 11341,0 11415,1 11448,0 11458,1 11462,0 11548,1 11634,0 11669,1 11761,0 11812,1 11868,0 11967,1 12010,0 12076,1 12148,0 12246,1 12269,0 12296,1 12310,0 12394,1 12461,0 12491,1 12569,0 12577,1 12605,0 12684,1 12729,0 12774,1 12869,0 12896,1 12994,0 13029,1 13064,0 13080,1 13131,0 13138,1 13190,0 13213,1 13294,0 13348,1 13396,0 13484,1 13563,0 13641,1 13716,0 13776,1 13833,0 13868,1 13889,0 13902,1 13986,0 14037,1 14066,0 14138,1 14147,0 14186,1 14268,0 14277,1 14329,0 14390,1 14399,0 14481,1 14526,0 14552,1 14641,0 14713,1 14717,0 14802,1 14898,0 14984,1 15030,0 15128,1 15178,0 15191,1 15257,0 15333,1 15397,0 15465,1 15542,0 15569,1 15633,0 15709,1 15772,0 15835,1 15905,0 15928,1 15945,0 15994,1 16034,0 16118,1 16204,0 16231,1 16299,0 16391,1 16414,0 16447,1 16536,0 16562,1 16652,0 16668,1 16719,0 16785,1 16873,0 16927,1 16968,0 17045,1 17054,0 17122,1 17166,0 17170,1 17183,0 17254,1 17324,0 17390,1 17393,0 17428,1 17505,0 17559,1 17598,0 17603,1 17650,0 17693,1 17706,0 17750,1 17791,0 17858,1 17954,0 18053,1 18095,0 18190,1 18263,0 18306,1 18313,0 18318,1 18400,0 18449,1 18495,0 18593,1 18692,0 18735,1 18804,0 18835,1 18850,0 18931,1 18951,0 18961,1 18962,0 19033,1 19041,0 19135,1 19154,0 19226,1 19273,0 19352,1 19398,0 19417,1 19473,0 19567,1 19596,0 19677,1 19742,0 19826,1 19912,0 19919,1 19951,0 20032,1 20097,0 20114,1 20124,0 20144,1 20177,0 20201,1 20202,0 20274,1 20365,0 20401,1 20486,0 20545,1 20567,0 20638,1 20738,0 20741,1 20808,0 20903,1 20996,0 21027,1 21029,0 21093,1 21173,0 21273,1 21340,0 21355,1 21410,0 21439,1 21474,0 21516,1 21561,0 21634,1 21649,0 21660,1 21689,0 21758,1 21834,0 21897,1 21930,0 21950,1 21996,0 22070,1 22082,0 22112,1 22160,0 22193,1 22266,0 22316,1 22330,0 22367,1 22447,0 22466,1 22504,0 22505,1 22554,0 22584,1 22671,0 22722,1 22789,0 22853,1 22902,0 22997,1 23024,0 23094,1 23152,0 23229,1 23282,0 23336,1 23380,0 23449,1 23549,0 23551,1 23555,0 23634,1 23678,0 23697,1 23786,0 23885,1 23984,0 24044,1 24078,0 24096,1 24162,0 24183,1 24215,0 24249,1 24272,0 24371,1 24437,0 24537,1 24565,0 24643,1 24674,0 24689,1 24784,0 24850,1 24901,0 24969,1 25059,0 25120,1 25158,0 25191,1 25221,0 25258,1 25343,0 25347,1 25444,0 25454,1 25489,0 25493,1 25552,0 25624,1 25681,0 25689,1 25713,0 25806,1 25849,0 25874,1 25974,0 26053,1 26068,0 26112,1 26162,0 26261,1 26317,0 26388,1 26401,0 26493,1 26593,0 26623,1 26688,0 26778,1 26876,0 26949,1 27036,0 27091,1 27156,0 27239,1 27309,0 27355,1 27424,0 27491,1 27552,0 27610,1 27658,0 27680,1 27759,0 27801,1 27816,0 27849,1 27894,0 27944,1 27976,0 28050,1 28138,0 28196,1 28266,0 28295,1 28372,0 28409,1 28468,0 28491,1 28588,0 28673,1 28686,0 28760,1 28813,0 28815,1 28894,0 28989,1 29007,0 29009,1 29016,0 29100,1 29157,0 29213,1 29300,0 29371,1 29450,0 29476,1 29534,0 29594,1 29682,0 29770,1 29794,0 29872,1 29968,0 30057,1 30094,0 30165,1 30191,0 30198,1 30249,0 30258,1 30284,0 30297,1 30339,0 30397,1 30490,0 30502,1 30526,0 30531,1 30576,0 30598,1 30615,0 30677,1 30689,0 30758,1 30762,0 30778,1 30820,0 30839,1 30914,0 30974,1 30998,0 31013,1 31061,0 31120,1 31146,0 31156,1 31238,0 31303,1 31337,0 31408,1 31488,0 31572,1 31624,0 31660,1 31663,0 31702,1 31773,0 31836,1 31933,0 31990,1 32065,0 32118,1 32170,0 32227,1 32302,0 32374,1 32392,0 32464,1 32513,0 32515,1 32581,0 32637,1 32735,0 32823,1 32831,0 32840,1 32862,0 32892,1 32979,0 33053,1 33075,0 33120,1 33186,0 33262,1 33289,0 33308,1 33371,0 33386,1 33431,0 33527,1 33556,0 33611,1 33649,0 33696,1 33765,0 33820,1 33821,0 33903,1 33939,0 33962,1 33969,0 33981,1 34060,0 34075,1 34157,0 34211,1 34298,0 34304,1 34370,0 34414,1 34500,0 34527,1 34577,0 34641,1 34701,0 34776,1 34845,0 34892,1 34893,0 34939,1 34946,0 34974,1 35035,0 35112,1 35139,0 35195,1 35253,0 35307,1 35386,0 35436,1 35487,0 35569,1 35625,0 35645,1 35679,0 35717,1 35751,0 35785,1 35820,0 35894,1 35902,0 35964,1 35967,0 35985,1 36026,0 36121,1 36214,0 36259,1 36271,0 36341,1 36411,0 36469,1 36480,0 36498,1 36509,0 36606,1 36681,0 36779,1 36838,0 36924,1 36928,0 37027,1 37124,0 37185,1 37235,0 37310,1 37407,0 37411,1 37471,0 37554,1 37631,0 37689,1 37746,0 37751,1 37847,0 37922,1 37999,0 38029,1 38032,0 38096,1 38183,0 38237,1 38269,0 38314,1 38353,0 38382,1 38469,0 38497,1 38507,0 38527,1 38619,0 38663,1 38725,0 38818,1 38831,0 38923,1 39003,0 39069,1 39098,0 39123,1 39172,0 39242,1 39329,0 39393,1 39444,0 39499,1 39544,0 39595,1 39612,0 39640,1 39729,0 39764,1 39811,0 39885,1 39978,0 40072,1 40132,0 40179,1 40268,0 40341,1 40358,0 40377,1 40441,0 40497,1 40551,0 40609,1 40662,0 40709,1 40780,0 40830,1 40912,0 40978,1 40992,0 41038,1 41125,0 41149,1 41238,0 41302,1 41343,0 41428,1 41434,0 41467,1 41522,0 41554,1 41556,0 41650,1 41662,0 41663,1 41689,0 41786,1 41845,0 41853,1 41942,0 42014,1 42019,0 42067,1 42104,0 42121,1 42137,0 42161,1 42181,0 42193,1 42263,0 42330,1 42337,0 42356,1 42361,0 42373,1 42418,0 42429,1 42451,0 42546,1 42641,0 42679,1 42746,0 42777,1 42796,0 42894,1 42903,0 42926,1 42984,0 42993,1 43006,0 43060,1 43136,0 43160,1 43228,0 43292,1 43293,0 43382,1 43394,0 43415,1 43431,0 43507,1 43591,0 43623,1 43660,0 43682,1 43734,0 43824,1 43860,0 43894,1 43905,0 43934,1 43984,0 44022,1 44032,0 44082,1 44102,0 44119,1 44162,0 44168,1 44237,0 44318,1 44347,0 44349,1 44378,0 44454,1 44518,0 44594,1 44654,0 44660,1 44711,0 44786,1 44873,0 44922,1 45015,0 45034,1 45099,0 45195,1 45268,0 45282,1 45367,0 45459,1 45461,0 45510,1 45593,0 45604,1 45665,0 45756,1 45807,0 45901,1 45998,0 46059,1 46139,0 46143,1 46160,0 46173,1 46219,0 46257,1 46316,0 46364,1 46453,0 46535,1 46609,0 46610,1 46646,0 46675,1 46752,0 46754,1 46757,0 46808,1 46813,0 46864,1 46886,0 46899,1 46938,0 47021,1 47079,0 47176,1 47221,0 47312,1 47357,0 47400,1 47425,0 47437,1 47514,0 47587,1 47623,0 47694,1 47790,0 47872,1 47879,0 47971,1 48036,0 48040,1 48137,0 48218,1 48229,0 48260,1 48311,0 48341,1 48426,0 48478,1 48495,0 48570,1 48665,0 48736,1 48789,0 48790,1 48819,0 48832,1 48858,0 48922,1 48976,0 49035,1 49048,0 49137,1 49188,0 49245,1 49251,0 49277,1 49344,0 49399,1 49443,0 49515,1 49577,0 49663,1 49669,0 49732,1 49788,0 49873,1 49894,0 49947,1 49991,0 50075,1 50126,0 50190,1 50203,0 50251,1 50342,0 50404,1 50454,0 50506,1 50577,0 50642,1 50725,0 50744,1 end initlist c22 0,0 97,1 193,0 274,1 343,0 399,1 465,0 541,1 640,0 659,1 665,0 705,1 731,0 790,1 798,0 887,1 941,0 973,1 1031,0 1096,1 1131,0 1172,1 1248,0 1336,1 1356,0 1455,1 1536,0 1553,1 1571,0 1622,1 1658,0 1745,1 1764,0 1858,1 1884,0 1894,1 1978,0 2046,1 2144,0 2154,1 2177,0 2267,1 2286,0 2384,1 2424,0 2467,1 2510,0 2589,1 2601,0 2646,1 2707,0 2747,1 2811,0 2861,1 2892,0 2925,1 2957,0 3054,1 3130,0 3212,1 3275,0 3293,1 3371,0 3445,1 3466,0 3564,1 3610,0 3664,1 3721,0 3790,1 3849,0 3876,1 3967,0 4011,1 4096,0 4113,1 4207,0 4240,1 4308,0 4348,1 4404,0 4411,1 4426,0 4525,1 4608,0 4679,1 4745,0 4783,1 4786,0 4797,1 4824,0 4919,1 4961,0 4972,1 4975,0 5038,1 5069,0 5150,1 5179,0 5183,1 5277,0 5283,1 5298,0 5384,1 5439,0 5535,1 5558,0 5622,1 5636,0 5649,1 5714,0 5730,1 5806,0 5860,1 5927,0 5973,1 5999,0 6041,1 6045,0 6054,1 6066,0 6162,1 6178,0 6207,1 6277,0 6321,1 6336,0 6391,1 6465,0 6525,1 6592,0 6660,1 6681,0 6747,1 6760,0 6808,1 6812,0 6820,1 6911,0 7003,1 7101,0 7193,1 7254,0 7353,1 7398,0 7498,1 7535,0 7599,1 7634,0 7675,1 7760,0 7849,1 7863,0 7878,1 7959,0 7982,1 7995,0 8021,1 8089,0 8149,1 8169,0 8245,1 8259,0 8358,1 8363,0 8461,1 8474,0 8559,1 8623,0 8706,1 8725,0 8820,1 8911,0 8999,1 9094,0 9123,1 9208,0 9272,1 9320,0 9355,1 9381,0 9463,1 9484,0 9518,1 9558,0 9568,1 9623,0 9628,1 9695,0 9755,1 9808,0 9842,1 9934,0 9959,1 9982,0 10051,1 10126,0 10189,1 10255,0 10337,1 10345,0 10426,1 10476,0 10541,1 10625,0 10627,1 10665,0 10693,1 10739,0 10821,1 10891,0 10914,1 10990,0 11084,1 11090,0 11172,1 11198,0 11227,1 11237,0 11284,1 11354,0 11421,1 11485,0 11557,1 11590,0 11606,1 11613,0 11637,1 11730,0 11815,1 11899,0 11932,1 11954,0 11966,1 11986,0 12086,1 12146,0 12206,1 12223,0 12239,1 12292,0 12349,1 12372,0 12444,1 12536,0 12543,1 12598,0 12661,1 12691,0 12736,1 12826,0 12916,1 12927,0 13022,1 13114,0 13121,1 13173,0 13249,1 13344,0 13428,1 13452,0 13501,1 13546,0 13581,1 13657,0 13709,1 13747,0 13761,1 13828,0 13882,1 13974,0 14033,1 14113,0 14208,1 14298,0 14363,1 14462,0 14472,1 14572,0 14584,1 14655,0 14683,1 14735,0 14835,1 14906,0 14969,1 15068,0 15143,1 15167,0 15243,1 15258,0 15291,1 15353,0 15431,1 15529,0 15608,1 15658,0 15686,1 15703,0 15800,1 15843,0 15882,1 15920,0 15926,1 16009,0 16080,1 16168,0 16176,1 16180,0 16208,1 16211,0 16235,1 16292,0 16306,1 16399,0 16499,1 16552,0 16624,1 16641,0 16722,1 16806,0 16817,1 16884,0 16928,1 16975,0 17039,1 17040,0 17068,1 17143,0 17179,1 17273,0 17356,1 17421,0 17456,1 17534,0 17585,1 17648,0 17743,1 17793,0 17854,1 17947,0 18008,1 18046,0 18051,1 18095,0 18120,1 18206,0 18233,1 18279,0 18336,1 18365,0 18390,1 18448,0 18545,1 18572,0 18671,1 18713,0 18804,1 18858,0 18865,1 18886,0 18910,1 18917,0 18980,1 19026,0 19109,1 19128,0 19216,1 19302,0 19401,1 19467,0 19471,1 19564,0 19612,1 19699,0 19767,1 19839,0 19924,1 20021,0 20092,1 20182,0 20197,1 20275,0 20313,1 20410,0 20436,1 20475,0 20515,1 20518,0 20610,1 20684,0 20751,1 20847,0 20852,1 20914,0 20919,1 20981,0 20990,1 21037,0 21123,1 21157,0 21181,1 21219,0 21268,1 21332,0 21421,1 21423,0 21448,1 21483,0 21569,1 21594,0 21629,1 21688,0 21753,1 21807,0 21883,1 21929,0 21964,1 22001,0 22025,1 22032,0 22039,1 22096,0 22165,1 22166,0 22205,1 22252,0 22273,1 22303,0 22345,1 22366,0 22428,1 22444,0 22475,1 22562,0 22640,1 22709,0 22807,1 22893,0 22921,1 22959,0 23015,1 23019,0 23092,1 23143,0 23227,1 23235,0 23253,1 23270,0 23302,1 23362,0 23462,1 23531,0 23614,1 23696,0 23737,1 23832,0 23874,1 23927,0 23970,1 24068,0 24102,1 24121,0 24197,1 24201,0 24209,1 24287,0 24329,1 24396,0 24405,1 24438,0 24537,1 24614,0 24681,1 24722,0 24785,1 24787,0 24865,1 24909,0 24937,1 25035,0 25076,1 25167,0 25254,1 25278,0 25336,1 25348,0 25397,1 25404,0 25474,1 25500,0 25541,1 25552,0 25593,1 25684,0 25700,1 25734,0 25742,1 25837,0 25910,1 25988,0 25998,1 26092,0 26107,1 26111,0 26164,1 26179,0 26223,1 26321,0 26350,1 26397,0 26418,1 26480,0 26576,1 26668,0 26758,1 26854,0 26856,1 26884,0 26931,1 27000,0 27022,1 27057,0 27114,1 27188,0 27288,1 27355,0 27364,1 27396,0 27469,1 27510,0 27574,1 27653,0 27692,1 27792,0 27869,1 27899,0 27970,1 27976,0 28066,1 28081,0 28158,1 28237,0 28328,1 28340,0 28402,1 28464,0 28465,1 28490,0 28525,1 28583,0 28627,1 28719,0 28740,1 28810,0 28883,1 28971,0 29044,1 29105,0 29129,1 29228,0 29231,1 29308,0 29366,1 29439,0 29440,1 29443,0 29479,1 29573,0 29629,1 29721,0 29777,1 29834,0 29908,1 29918,0 29962,1 29994,0 29996,1 30089,0 30135,1 30227,0 30228,1 30273,0 30312,1 30368,0 30384,1 30434,0 30435,1 30531,0 30618,1 30655,0 30660,1 30687,0 30782,1 30873,0 30880,1 30962,0 31013,1 31103,0 31109,1 31192,0 31231,1 31298,0 31351,1 31377,0 31455,1 31482,0 31570,1 31643,0 31711,1 31760,0 31771,1 31869,0 31894,1 31904,0 31984,1 32040,0 32104,1 32172,0 32177,1 32265,0 32297,1 32371,0 32449,1 32525,0 32560,1 32575,0 32620,1 32640,0 32734,1 32737,0 32768,1 32787,0 32832,1 32870,0 32969,1 33047,0 33067,1 33135,0 33172,1 33206,0 33250,1 33283,0 33305,1 33339,0 33356,1 33408,0 33505,1 33558,0 33582,1 33627,0 33667,1 33697,0 33759,1 33846,0 33857,1 33930,0 33997,1 34050,0 34068,1 34152,0 34205,1 34237,0 34276,1 34360,0 34419,1 34456,0 34554,1 34577,0 34580,1 34619,0 34686,1 34778,0 34783,1 34880,0 34882,1 34896,0 34965,1 35004,0 35049,1 35130,0 35167,1 35188,0 35226,1 35267,0 35324,1 35369,0 35403,1 35484,0 35584,1 35655,0 35695,1 35721,0 35778,1 35799,0 35845,1 35871,0 35947,1 35954,0 36049,1 36059,0 36140,1 36197,0 36283,1 36304,0 36342,1 36366,0 36439,1 36537,0 36630,1 36676,0 36705,1 36771,0 36795,1 36842,0 36934,1 37030,0 37112,1 37165,0 37177,1 37258,0 37358,1 37458,0 37463,1 37516,0 37608,1 37647,0 37707,1 37800,0 37806,1 37822,0 37880,1 37925,0 37995,1 38065,0 38118,1 38177,0 38248,1 38300,0 38347,1 38418,0 38468,1 38539,0 38586,1 38678,0 38736,1 38760,0 38859,1 38940,0 38950,1 38981,0 39070,1 39108,0 39133,1 39221,0 39234,1 39324,0 39396,1 39468,0 39488,1 39546,0 39625,1 39659,0 39696,1 39704,0 39742,1 39753,0 39773,1 39838,0 39902,1 39985,0 40038,1 40059,0 40085,1 40096,0 40191,1 40276,0 40336,1 40378,0 40477,1 40550,0 40590,1 40632,0 40703,1 40766,0 40805,1 40881,0 40951,1 41037,0 41116,1 41190,0 41233,1 41295,0 41391,1 41431,0 41480,1 41577,0 41596,1 41622,0 41636,1 41662,0 41678,1 41705,0 41769,1 41833,0 41931,1 41941,0 41946,1 41987,0 42058,1 42120,0 42188,1 42258,0 42337,1 42375,0 42461,1 42532,0 42593,1 42613,0 42704,1 42783,0 42803,1 42845,0 42850,1 42900,0 42982,1 43079,0 43123,1 43190,0 43211,1 43239,0 43283,1 43334,0 43362,1 43385,0 43430,1 43510,0 43549,1 43610,0 43659,1 43735,0 43778,1 43876,0 43894,1 43937,0 43961,1 44003,0 44092,1 44126,0 44136,1 44172,0 44247,1 44346,0 44393,1 44441,0 44469,1 44505,0 44586,1 44634,0 44729,1 44829,0 44878,1 44915,0 44970,1 44986,0 45061,1 45068,0 45081,1 45164,0 45191,1 45283,0 45340,1 45357,0 45368,1 45410,0 45446,1 45492,0 45592,1 45642,0 45678,1 45697,0 45776,1 45865,0 45952,1 45987,0 45991,1 46086,0 46091,1 46135,0 46195,1 46289,0 46348,1 46421,0 46439,1 46485,0 46582,1 46678,0 46730,1 46786,0 46801,1 46808,0 46889,1 46985,0 47003,1 47014,0 47095,1 47192,0 47232,1 47276,0 47281,1 47351,0 47352,1 47390,0 47483,1 47495,0 47512,1 47551,0 47579,1 47614,0 47641,1 47729,0 47783,1 47862,0 47942,1 47995,0 48087,1 48144,0 48188,1 48239,0 48253,1 48322,0 48332,1 48365,0 48464,1 48518,0 48611,1 48694,0 48792,1 48832,0 48913,1 49010,0 49017,1 49098,0 49170,1 49239,0 49252,1 49314,0 49354,1 49451,0 49536,1 49540,0 49587,1 49616,0 49627,1 49686,0 49739,1 49826,0 49830,1 49889,0 49921,1 50016,0 50107,1 50141,0 50227,1 50245,0 50288,1 50382,0 50482,1 50491,0 50525,1 50528,0 50565,1 50629,0 50680,1 50711,0 50793,1 50891,0 50907,1 50915,0 50960,1 50988,0 51043,1 51064,0 51116,1 51182,0 51272,1 51362,0 51385,1 51413,0 51418,1 51495,0 51543,1 51559,0 51568,1 51598,0 51662,1 51741,0 51743,1 51786,0 51808,1 51844,0 51896,1 end initlist c23 0,0 80,1 161,0 225,1 237,0 288,1 311,0 336,1 352,0 410,1 498,0 556,1 607,0 614,1 682,0 690,1 741,0 828,1 891,0 938,1 1036,0 1084,1 1112,0 1201,1 1272,0 1282,1 1327,0 1400,1 1413,0 1436,1 1519,0 1533,1 1628,0 1678,1 1703,0 1755,1 1820,0 1834,1 1925,0 2019,1 2094,0 2109,1 2198,0 2220,1 2314,0 2380,1 2451,0 2528,1 2531,0 2536,1 2608,0 2696,1 2788,0 2869,1 2882,0 2914,1 2965,0 2989,1 3035,0 3058,1 3121,0 3154,1 3204,0 3293,1 3336,0 3371,1 3411,0 3472,1 3572,0 3668,1 3686,0 3778,1 3819,0 3896,1 3963,0 4002,1 4011,0 4098,1 4134,0 4227,1 4267,0 4363,1 4421,0 4425,1 4472,0 4514,1 4531,0 4591,1 4642,0 4665,1 4736,0 4795,1 4838,0 4915,1 5012,0 5102,1 5200,0 5258,1 5318,0 5369,1 5416,0 5419,1 5452,0 5513,1 5594,0 5649,1 5669,0 5678,1 5772,0 5776,1 5863,0 5954,1 5990,0 6074,1 6111,0 6145,1 6188,0 6204,1 6254,0 6327,1 6395,0 6493,1 6571,0 6663,1 6748,0 6827,1 6925,0 7012,1 7060,0 7114,1 7161,0 7187,1 7245,0 7332,1 7342,0 7433,1 7481,0 7534,1 7566,0 7660,1 7756,0 7838,1 7928,0 7945,1 7976,0 7988,1 8012,0 8083,1 8113,0 8114,1 8161,0 8213,1 8231,0 8238,1 8321,0 8322,1 8371,0 8411,1 8497,0 8540,1 8582,0 8651,1 8708,0 8770,1 8855,0 8879,1 8925,0 8942,1 8973,0 9020,1 9056,0 9072,1 9139,0 9199,1 9241,0 9305,1 9376,0 9392,1 9426,0 9490,1 9499,0 9582,1 9644,0 9732,1 9813,0 9847,1 9895,0 9960,1 9962,0 10052,1 10084,0 10120,1 10173,0 10187,1 10241,0 10337,1 10363,0 10454,1 10481,0 10581,1 10626,0 10663,1 10763,0 10799,1 10825,0 10839,1 10845,0 10923,1 10968,0 11037,1 11112,0 11120,1 11212,0 11240,1 11301,0 11314,1 11410,0 11442,1 11463,0 11557,1 11590,0 11664,1 11667,0 11740,1 11791,0 11804,1 11837,0 11868,1 11932,0 11936,1 11956,0 11969,1 11973,0 12072,1 12142,0 12196,1 12292,0 12382,1 12427,0 12429,1 12496,0 12540,1 12599,0 12674,1 12767,0 12835,1 12918,0 12986,1 13065,0 13067,1 13118,0 13135,1 13205,0 13237,1 13264,0 13334,1 13399,0 13496,1 13581,0 13586,1 13655,0 13701,1 13754,0 13766,1 13803,0 13804,1 13832,0 13922,1 13975,0 14019,1 14111,0 14114,1 14181,0 14234,1 14327,0 14355,1 14454,0 14455,1 14458,0 14527,1 14617,0 14676,1 14727,0 14788,1 14817,0 14845,1 14886,0 14925,1 14978,0 15076,1 15151,0 15214,1 15218,0 15282,1 15311,0 15320,1 15400,0 15428,1 15450,0 15532,1 15585,0 15641,1 15670,0 15699,1 15717,0 15723,1 15818,0 15895,1 15965,0 16047,1 16101,0 16120,1 16142,0 16170,1 16222,0 16312,1 16382,0 16434,1 16485,0 16513,1 16572,0 16661,1 16725,0 16734,1 16815,0 16876,1 16897,0 16926,1 16941,0 17007,1 17008,0 17078,1 17140,0 17195,1 17295,0 17339,1 17411,0 17459,1 17547,0 17570,1 17591,0 17623,1 17681,0 17694,1 17740,0 17771,1 17860,0 17897,1 17974,0 18055,1 18126,0 18193,1 18278,0 18300,1 18335,0 18389,1 18417,0 18456,1 18555,0 18630,1 18717,0 18815,1 18837,0 18933,1 18998,0 19014,1 19043,0 19044,1 19085,0 19093,1 19119,0 19156,1 19187,0 19223,1 19237,0 19316,1 19383,0 19483,1 19565,0 19656,1 19704,0 19728,1 19804,0 19877,1 19918,0 19928,1 20001,0 20038,1 20046,0 20099,1 20146,0 20217,1 20280,0 20338,1 20401,0 20484,1 20571,0 20632,1 20707,0 20797,1 20872,0 20902,1 20988,0 21014,1 21052,0 21108,1 21207,0 21235,1 21280,0 21363,1 21419,0 21500,1 21518,0 21521,1 21546,0 21609,1 21630,0 21643,1 21688,0 21744,1 21789,0 21802,1 21901,0 21918,1 21992,0 22083,1 22095,0 22137,1 22221,0 22264,1 22353,0 22380,1 22471,0 22490,1 22587,0 22631,1 22685,0 22723,1 22744,0 22783,1 22806,0 22889,1 22936,0 22948,1 23022,0 23054,1 23068,0 23088,1 23132,0 23196,1 23228,0 23289,1 23290,0 23381,1 23457,0 23474,1 23566,0 23652,1 23709,0 23761,1 23811,0 23843,1 23857,0 23868,1 23869,0 23935,1 23976,0 24060,1 24132,0 24166,1 24246,0 24280,1 24297,0 24373,1 24426,0 24430,1 24450,0 24487,1 24573,0 24641,1 24672,0 24767,1 24831,0 24894,1 24958,0 25043,1 25089,0 25116,1 25117,0 25215,1 25268,0 25331,1 25425,0 25497,1 25581,0 25609,1 25700,0 25790,1 25872,0 25880,1 25973,0 25987,1 26083,0 26092,1 26114,0 26187,1 26258,0 26333,1 26358,0 26421,1 26498,0 26500,1 26544,0 26558,1 26563,0 26663,1 26751,0 26830,1 26894,0 26961,1 27055,0 27106,1 27203,0 27279,1 27308,0 27364,1 27427,0 27450,1 27539,0 27592,1 27664,0 27735,1 27778,0 27872,1 27907,0 27957,1 28033,0 28091,1 28161,0 28192,1 28214,0 28235,1 28252,0 28279,1 28339,0 28413,1 28458,0 28481,1 28515,0 28580,1 28635,0 28695,1 28761,0 28797,1 28862,0 28916,1 28954,0 29018,1 29102,0 29117,1 29215,0 29217,1 29303,0 29377,1 29382,0 29437,1 29534,0 29631,1 29660,0 29729,1 29792,0 29796,1 29892,0 29928,1 29992,0 30043,1 30049,0 30138,1 30172,0 30213,1 30290,0 30349,1 30421,0 30452,1 30485,0 30558,1 30628,0 30727,1 30773,0 30791,1 30824,0 30906,1 30918,0 30992,1 31019,0 31033,1 31085,0 31169,1 31184,0 31282,1 31372,0 31426,1 31433,0 31519,1 31529,0 31548,1 31552,0 31638,1 31669,0 31723,1 31752,0 31828,1 31833,0 31916,1 32009,0 32044,1 32092,0 32181,1 32260,0 32320,1 32393,0 32397,1 32424,0 32514,1 32603,0 32637,1 32706,0 32771,1 32859,0 32950,1 32958,0 32972,1 33035,0 33108,1 33111,0 33134,1 33168,0 33218,1 33289,0 33298,1 33342,0 33347,1 33435,0 33524,1 33607,0 33645,1 33741,0 33784,1 33829,0 33873,1 33923,0 33941,1 34030,0 34036,1 34077,0 34173,1 34199,0 34277,1 34343,0 34392,1 34480,0 34542,1 34587,0 34601,1 34668,0 34741,1 34770,0 34868,1 34876,0 34960,1 34995,0 35014,1 35092,0 35169,1 35233,0 35246,1 35263,0 35300,1 35374,0 35432,1 35508,0 35586,1 35612,0 35701,1 35751,0 35767,1 35793,0 35874,1 35945,0 36004,1 36101,0 36152,1 36205,0 36289,1 36354,0 36366,1 36416,0 36427,1 36490,0 36565,1 36566,0 36627,1 36651,0 36717,1 36741,0 36759,1 36811,0 36856,1 36931,0 36973,1 36995,0 37091,1 37170,0 37181,1 37231,0 37242,1 37288,0 37332,1 37409,0 37481,1 37529,0 37621,1 37700,0 37705,1 37762,0 37764,1 37770,0 37870,1 37943,0 37989,1 38036,0 38071,1 38080,0 38128,1 38222,0 38293,1 38391,0 38477,1 38521,0 38585,1 38598,0 38649,1 38720,0 38800,1 38831,0 38885,1 38928,0 38977,1 38992,0 39003,1 39099,0 39189,1 39206,0 39273,1 39289,0 39331,1 39348,0 39402,1 39498,0 39530,1 39533,0 39615,1 39656,0 39725,1 39779,0 39860,1 39904,0 39921,1 39994,0 39998,1 40024,0 40122,1 40175,0 40267,1 40362,0 40374,1 40422,0 40502,1 40595,0 40678,1 40754,0 40799,1 40896,0 40976,1 41025,0 41078,1 41096,0 41100,1 41143,0 41174,1 41217,0 41305,1 41372,0 41456,1 41473,0 41538,1 41553,0 41588,1 41672,0 41706,1 41743,0 41755,1 41839,0 41852,1 41926,0 41997,1 42051,0 42113,1 42171,0 42180,1 42192,0 42207,1 42243,0 42296,1 42307,0 42382,1 42412,0 42417,1 42469,0 42477,1 42500,0 42524,1 42618,0 42714,1 42735,0 42769,1 42803,0 42854,1 42914,0 42916,1 42947,0 42996,1 43023,0 43080,1 43141,0 43198,1 43245,0 43259,1 43283,0 43306,1 43324,0 43368,1 43374,0 43427,1 43526,0 43624,1 43661,0 43702,1 43786,0 43849,1 43912,0 44008,1 44093,0 44180,1 44275,0 44313,1 44383,0 44452,1 44521,0 44557,1 44570,0 44665,1 44742,0 44784,1 44871,0 44963,1 44974,0 45003,1 45090,0 45169,1 45222,0 45309,1 45327,0 45353,1 45364,0 45385,1 45447,0 45502,1 45586,0 45638,1 45665,0 45718,1 45751,0 45770,1 45856,0 45947,1 45959,0 45967,1 45983,0 46042,1 46062,0 46063,1 46088,0 46138,1 46211,0 46263,1 46359,0 46375,1 46388,0 46483,1 46531,0 46588,1 46597,0 46688,1 46703,0 46744,1 46786,0 46832,1 46843,0 46912,1 46973,0 47022,1 47058,0 47136,1 47142,0 47154,1 47241,0 47242,1 47300,0 47357,1 47408,0 47471,1 47531,0 47620,1 47692,0 47761,1 47849,0 47947,1 47970,0 47978,1 48057,0 48089,1 48120,0 48154,1 48205,0 48284,1 48343,0 48385,1 48392,0 48461,1 48558,0 48652,1 48718,0 48747,1 48798,0 48814,1 48859,0 48871,1 48928,0 48955,1 49037,0 49124,1 49194,0 49215,1 49293,0 49344,1 49403,0 49457,1 49541,0 49592,1 49648,0 49666,1 49689,0 49714,1 49763,0 49818,1 49910,0 49949,1 50005,0 50035,1 50066,0 50096,1 50121,0 50156,1 50175,0 50188,1 50280,0 50287,1 50353,0 50401,1 50451,0 50464,1 50526,0 50566,1 50610,0 50650,1 50704,0 50792,1 50855,0 50933,1 51002,0 51019,1 51073,0 51120,1 51138,0 51218,1 51307,0 51345,1 51437,0 51490,1 51499,0 51540,1 end initlist c24 0,0 57,1 135,0 142,1 203,0 287,1 340,0 349,1 394,0 493,1 582,0 605,1 700,0 759,1 785,0 789,1 889,0 919,1 957,0 1017,1 1070,0 1132,1 1203,0 1274,1 1350,0 1374,1 1474,0 1506,1 1606,0 1638,1 1660,0 1667,1 1765,0 1811,1 1872,0 1912,1 1950,0 1998,1 2013,0 2056,1 2111,0 2135,1 2200,0 2226,1 2325,0 2405,1 2452,0 2537,1 2592,0 2611,1 2691,0 2701,1 2734,0 2771,1 2773,0 2779,1 2873,0 2972,1 3049,0 3133,1 3159,0 3183,1 3282,0 3377,1 3448,0 3498,1 3537,0 3583,1 3606,0 3693,1 3787,0 3817,1 3901,0 3937,1 3969,0 3993,1 3995,0 4089,1 4161,0 4247,1 4314,0 4315,1 4382,0 4403,1 4417,0 4495,1 4511,0 4541,1 4617,0 4691,1 4729,0 4786,1 4835,0 4840,1 4850,0 4923,1 5014,0 5015,1 5081,0 5111,1 5182,0 5264,1 5276,0 5282,1 5354,0 5440,1 5464,0 5466,1 5503,0 5566,1 5658,0 5740,1 5762,0 5823,1 5902,0 5964,1 6036,0 6054,1 6094,0 6121,1 6167,0 6194,1 6208,0 6257,1 6339,0 6399,1 6472,0 6568,1 6655,0 6713,1 6725,0 6734,1 6755,0 6784,1 6831,0 6887,1 6925,0 6975,1 7020,0 7116,1 7182,0 7208,1 7242,0 7299,1 7382,0 7397,1 7410,0 7477,1 7566,0 7651,1 7737,0 7757,1 7764,0 7771,1 7838,0 7934,1 7983,0 8018,1 8023,0 8120,1 8186,0 8261,1 8303,0 8360,1 8440,0 8537,1 8583,0 8656,1 8698,0 8771,1 8813,0 8819,1 8905,0 9000,1 9062,0 9158,1 9188,0 9262,1 9339,0 9425,1 9452,0 9477,1 9502,0 9516,1 9565,0 9628,1 9657,0 9665,1 9744,0 9815,1 9845,0 9851,1 9870,0 9898,1 9936,0 9951,1 10039,0 10115,1 10178,0 10227,1 10297,0 10336,1 10362,0 10402,1 10418,0 10423,1 10441,0 10523,1 10548,0 10553,1 10592,0 10608,1 10693,0 10744,1 10752,0 10766,1 10781,0 10800,1 10805,0 10884,1 10976,0 11016,1 11091,0 11191,1 11263,0 11321,1 11405,0 11425,1 11520,0 11599,1 11687,0 11773,1 11862,0 11889,1 11958,0 11996,1 11997,0 12073,1 12139,0 12203,1 12281,0 12299,1 12370,0 12463,1 12470,0 12520,1 12527,0 12597,1 12660,0 12723,1 12816,0 12906,1 12953,0 13047,1 13117,0 13154,1 13215,0 13298,1 13379,0 13384,1 13479,0 13510,1 13609,0 13640,1 13662,0 13740,1 13794,0 13816,1 13829,0 13862,1 13938,0 13965,1 13995,0 14052,1 14097,0 14157,1 14224,0 14248,1 14346,0 14438,1 14511,0 14582,1 14639,0 14711,1 14802,0 14815,1 14839,0 14874,1 14929,0 14947,1 14985,0 14997,1 15088,0 15101,1 15104,0 15140,1 15147,0 15201,1 15297,0 15327,1 15389,0 15419,1 15420,0 15453,1 15488,0 15509,1 15538,0 15625,1 15637,0 15729,1 15792,0 15879,1 15931,0 15981,1 16005,0 16077,1 16138,0 16213,1 16231,0 16262,1 16356,0 16420,1 16508,0 16583,1 16597,0 16687,1 16688,0 16731,1 16790,0 16807,1 16822,0 16904,1 17001,0 17040,1 17139,0 17201,1 17271,0 17347,1 17383,0 17462,1 17543,0 17560,1 17604,0 17685,1 17773,0 17793,1 17830,0 17907,1 17996,0 18015,1 18087,0 18162,1 18250,0 18255,1 18334,0 18353,1 18418,0 18419,1 18462,0 18548,1 18571,0 18655,1 18740,0 18762,1 18797,0 18835,1 18885,0 18911,1 18939,0 18948,1 19018,0 19050,1 19123,0 19127,1 19225,0 19273,1 19372,0 19378,1 19400,0 19437,1 19497,0 19528,1 19551,0 19565,1 19587,0 19669,1 19756,0 19784,1 19802,0 19825,1 19832,0 19864,1 19902,0 19913,1 19949,0 20039,1 20100,0 20169,1 20185,0 20272,1 20324,0 20396,1 20417,0 20492,1 20497,0 20512,1 20531,0 20558,1 20586,0 20662,1 20683,0 20736,1 20814,0 20837,1 20914,0 20930,1 20955,0 21022,1 21034,0 21065,1 21109,0 21113,1 21176,0 21197,1 21273,0 21330,1 21355,0 21430,1 21492,0 21585,1 21681,0 21715,1 21764,0 21822,1 21893,0 21949,1 21959,0 22022,1 22083,0 22139,1 22181,0 22270,1 22301,0 22363,1 22445,0 22484,1 22565,0 22630,1 22673,0 22682,1 22775,0 22827,1 22923,0 22998,1 23071,0 23133,1 23140,0 23206,1 23267,0 23270,1 23312,0 23322,1 23349,0 23433,1 23474,0 23553,1 23587,0 23615,1 23640,0 23655,1 23671,0 23753,1 23822,0 23907,1 23925,0 24001,1 24063,0 24107,1 24172,0 24186,1 24267,0 24364,1 24365,0 24449,1 24464,0 24476,1 24538,0 24558,1 24587,0 24624,1 24635,0 24732,1 24792,0 24878,1 24952,0 24979,1 25076,0 25147,1 25154,0 25220,1 25243,0 25318,1 25320,0 25413,1 25453,0 25535,1 25562,0 25596,1 25633,0 25684,1 25777,0 25783,1 25825,0 25905,1 25961,0 25985,1 26084,0 26183,1 26215,0 26270,1 26295,0 26308,1 26349,0 26420,1 26470,0 26503,1 26569,0 26666,1 26673,0 26769,1 26844,0 26930,1 26964,0 27047,1 27053,0 27079,1 27153,0 27182,1 27255,0 27258,1 27287,0 27314,1 27414,0 27457,1 27494,0 27502,1 27523,0 27553,1 27639,0 27668,1 27718,0 27776,1 27872,0 27922,1 27974,0 27979,1 28045,0 28055,1 28089,0 28184,1 28218,0 28298,1 28301,0 28303,1 28308,0 28398,1 28434,0 28531,1 28594,0 28646,1 28675,0 28762,1 28855,0 28886,1 28920,0 28952,1 28955,0 28988,1 29008,0 29048,1 29056,0 29063,1 29133,0 29176,1 29180,0 29191,1 29240,0 29288,1 29299,0 29363,1 29439,0 29469,1 29471,0 29517,1 29607,0 29681,1 29739,0 29782,1 29807,0 29815,1 29914,0 29976,1 30064,0 30148,1 30202,0 30246,1 30317,0 30393,1 30465,0 30493,1 30526,0 30546,1 30605,0 30700,1 30738,0 30764,1 30768,0 30810,1 30909,0 30912,1 31002,0 31099,1 31138,0 31151,1 31224,0 31302,1 31323,0 31328,1 31406,0 31462,1 31509,0 31579,1 31585,0 31639,1 31673,0 31735,1 31827,0 31847,1 31903,0 31951,1 32010,0 32075,1 32090,0 32156,1 32183,0 32236,1 32265,0 32329,1 32411,0 32479,1 32507,0 32546,1 32587,0 32665,1 32686,0 32761,1 32814,0 32891,1 32953,0 32977,1 32981,0 33067,1 33152,0 33164,1 33176,0 33242,1 33315,0 33392,1 33424,0 33451,1 33453,0 33549,1 33560,0 33578,1 33669,0 33699,1 33744,0 33772,1 33831,0 33915,1 33991,0 34063,1 34067,0 34156,1 34157,0 34228,1 34313,0 34343,1 34432,0 34497,1 34564,0 34581,1 34634,0 34725,1 34733,0 34737,1 34763,0 34804,1 34887,0 34888,1 34980,0 35003,1 35020,0 35066,1 35120,0 35136,1 35210,0 35228,1 35233,0 35269,1 35309,0 35376,1 35393,0 35488,1 35546,0 35616,1 35656,0 35675,1 35688,0 35755,1 35847,0 35914,1 35943,0 35985,1 36023,0 36026,1 36031,0 36087,1 36138,0 36168,1 36188,0 36195,1 36222,0 36232,1 36326,0 36354,1 36367,0 36391,1 36456,0 36551,1 36641,0 36731,1 36735,0 36766,1 36804,0 36824,1 36920,0 37010,1 37047,0 37080,1 37125,0 37209,1 37264,0 37299,1 37327,0 37328,1 37353,0 37431,1 37458,0 37500,1 37507,0 37518,1 37563,0 37617,1 37650,0 37675,1 37701,0 37799,1 37834,0 37913,1 37983,0 38050,1 38124,0 38150,1 38222,0 38276,1 38287,0 38363,1 38409,0 38490,1 38508,0 38554,1 38630,0 38686,1 38785,0 38854,1 38892,0 38979,1 39062,0 39115,1 39194,0 39294,1 39389,0 39442,1 39445,0 39480,1 39531,0 39543,1 39629,0 39724,1 39795,0 39841,1 39938,0 40015,1 40048,0 40123,1 40214,0 40222,1 40273,0 40297,1 40388,0 40403,1 40442,0 40509,1 40546,0 40587,1 40591,0 40660,1 40687,0 40778,1 40856,0 40948,1 40974,0 41026,1 41079,0 41157,1 41184,0 41203,1 41229,0 41258,1 41283,0 41362,1 41435,0 41470,1 41551,0 41617,1 41642,0 41666,1 41681,0 41715,1 41764,0 41834,1 41880,0 41926,1 41963,0 41965,1 41988,0 42003,1 42082,0 42160,1 42171,0 42256,1 42302,0 42341,1 42394,0 42491,1 42563,0 42647,1 42746,0 42808,1 42876,0 42913,1 42958,0 42966,1 43009,0 43043,1 43120,0 43177,1 43264,0 43296,1 43353,0 43371,1 43442,0 43489,1 43508,0 43545,1 43558,0 43633,1 43653,0 43713,1 43725,0 43795,1 43803,0 43865,1 43891,0 43938,1 43969,0 44005,1 44101,0 44161,1 44179,0 44187,1 44257,0 44277,1 44362,0 44370,1 44372,0 44381,1 44465,0 44468,1 44564,0 44601,1 44683,0 44700,1 44778,0 44815,1 44820,0 44836,1 44926,0 44937,1 45002,0 45065,1 45124,0 45142,1 45184,0 45244,1 45309,0 45336,1 45377,0 45435,1 45515,0 45582,1 45625,0 45681,1 45705,0 45801,1 45881,0 45948,1 45955,0 45967,1 46010,0 46061,1 46108,0 46114,1 46188,0 46267,1 46296,0 46354,1 46435,0 46440,1 46448,0 46479,1 46493,0 46574,1 46586,0 46598,1 46644,0 46673,1 46750,0 46818,1 46819,0 46879,1 46917,0 46919,1 46959,0 46988,1 47082,0 47134,1 47170,0 47195,1 47283,0 47342,1 47405,0 47485,1 47579,0 47665,1 47705,0 47725,1 47817,0 47902,1 47927,0 48017,1 48106,0 48202,1 48244,0 48259,1 48270,0 48328,1 48346,0 48443,1 48530,0 48607,1 48663,0 48704,1 48747,0 48779,1 48876,0 48972,1 49066,0 49132,1 49210,0 49307,1 49346,0 49367,1 49381,0 49430,1 49446,0 49545,1 49635,0 49728,1 49770,0 49818,1 end initlist c25 0,0 32,1 98,0 132,1 200,0 245,1 288,0 318,1 339,0 416,1 485,0 503,1 593,0 663,1 672,0 690,1 707,0 753,1 757,0 775,1 839,0 852,1 933,0 953,1 1033,0 1088,1 1107,0 1145,1 1177,0 1236,1 1243,0 1306,1 1354,0 1416,1 1425,0 1521,1 1545,0 1627,1 1694,0 1698,1 1753,0 1820,1 1847,0 1914,1 1919,0 1994,1 2069,0 2153,1 2246,0 2299,1 2356,0 2425,1 2483,0 2551,1 2559,0 2580,1 2674,0 2710,1 2796,0 2867,1 2937,0 3033,1 3082,0 3126,1 3192,0 3274,1 3307,0 3395,1 3475,0 3488,1 3509,0 3552,1 3626,0 3689,1 3756,0 3784,1 3866,0 3893,1 3957,0 4053,1 4106,0 4128,1 4135,0 4185,1 4203,0 4240,1 4306,0 4335,1 4374,0 4388,1 4476,0 4503,1 4535,0 4633,1 4682,0 4760,1 4842,0 4881,1 4955,0 5018,1 5094,0 5175,1 5265,0 5339,1 5353,0 5380,1 5413,0 5507,1 5575,0 5596,1 5695,0 5725,1 5808,0 5863,1 5963,0 6015,1 6040,0 6051,1 6128,0 6195,1 6246,0 6310,1 6336,0 6371,1 6416,0 6433,1 6480,0 6525,1 6608,0 6637,1 6694,0 6716,1 6777,0 6864,1 6954,0 7024,1 7054,0 7122,1 7211,0 7227,1 7320,0 7327,1 7339,0 7409,1 7502,0 7534,1 7557,0 7654,1 7716,0 7729,1 7775,0 7804,1 7843,0 7940,1 7994,0 8029,1 8048,0 8052,1 8061,0 8074,1 8166,0 8260,1 8350,0 8357,1 8402,0 8414,1 8474,0 8495,1 8580,0 8624,1 8714,0 8753,1 8831,0 8902,1 8931,0 8967,1 8977,0 9027,1 9034,0 9123,1 9207,0 9219,1 9274,0 9358,1 9376,0 9441,1 9525,0 9611,1 9675,0 9704,1 9746,0 9759,1 9835,0 9851,1 9891,0 9910,1 9965,0 9992,1 10008,0 10085,1 10166,0 10240,1 10323,0 10408,1 10435,0 10451,1 10525,0 10540,1 10606,0 10681,1 10720,0 10728,1 10749,0 10804,1 10843,0 10927,1 11023,0 11107,1 11171,0 11202,1 11208,0 11250,1 11306,0 11337,1 11418,0 11461,1 11498,0 11507,1 11558,0 11614,1 11626,0 11664,1 11737,0 11829,1 11849,0 11880,1 11910,0 12009,1 12063,0 12100,1 12138,0 12197,1 12221,0 12244,1 12312,0 12372,1 12374,0 12416,1 12498,0 12538,1 12604,0 12697,1 12742,0 12744,1 12769,0 12851,1 12893,0 12901,1 12964,0 12973,1 13019,0 13043,1 13113,0 13131,1 13161,0 13170,1 13265,0 13282,1 13323,0 13404,1 13463,0 13510,1 13604,0 13675,1 13731,0 13770,1 13777,0 13817,1 13830,0 13832,1 13886,0 13900,1 13949,0 13969,1 13982,0 14034,1 14133,0 14230,1 14255,0 14333,1 14397,0 14428,1 14519,0 14577,1 14591,0 14646,1 14727,0 14745,1 14828,0 14887,1 14959,0 14987,1 15036,0 15063,1 15151,0 15234,1 15276,0 15346,1 15351,0 15439,1 15485,0 15573,1 15624,0 15707,1 15740,0 15805,1 15881,0 15944,1 15959,0 16045,1 16082,0 16083,1 16130,0 16131,1 16192,0 16266,1 16334,0 16429,1 16526,0 16534,1 16554,0 16643,1 16710,0 16731,1 16777,0 16789,1 16848,0 16926,1 16955,0 16998,1 17059,0 17141,1 17142,0 17191,1 17205,0 17256,1 17304,0 17317,1 17344,0 17366,1 17418,0 17444,1 17517,0 17598,1 17605,0 17672,1 17677,0 17691,1 17761,0 17777,1 17851,0 17868,1 17946,0 18041,1 18125,0 18145,1 18167,0 18225,1 18303,0 18322,1 18415,0 18440,1 18456,0 18519,1 18583,0 18655,1 18714,0 18767,1 18860,0 18898,1 18931,0 19021,1 19110,0 19125,1 19158,0 19208,1 19238,0 19279,1 19281,0 19353,1 19389,0 19430,1 19471,0 19569,1 19645,0 19649,1 19709,0 19751,1 19840,0 19841,1 19842,0 19866,1 19892,0 19980,1 19996,0 20027,1 20078,0 20174,1 20273,0 20351,1 20419,0 20440,1 20514,0 20612,1 20627,0 20682,1 20753,0 20822,1 20854,0 20867,1 20941,0 21012,1 21060,0 21134,1 21204,0 21229,1 21317,0 21362,1 21452,0 21537,1 21617,0 21686,1 21757,0 21773,1 21854,0 21943,1 21986,0 21990,1 22081,0 22181,1 22268,0 22348,1 22367,0 22447,1 22469,0 22496,1 22523,0 22623,1 22635,0 22661,1 22736,0 22835,1 22843,0 22871,1 22968,0 23003,1 23020,0 23025,1 23121,0 23185,1 23259,0 23325,1 23370,0 23457,1 23485,0 23556,1 23576,0 23671,1 23757,0 23762,1 23855,0 23938,1 23968,0 23972,1 24028,0 24103,1 24132,0 24143,1 24233,0 24268,1 24280,0 24343,1 24353,0 24418,1 24456,0 24521,1 24554,0 24571,1 24627,0 24668,1 24698,0 24721,1 24816,0 24831,1 24852,0 24886,1 24946,0 24991,1 25016,0 25035,1 25133,0 25145,1 25198,0 25216,1 25220,0 25312,1 25398,0 25418,1 25464,0 25493,1 25580,0 25599,1 25673,0 25770,1 25776,0 25854,1 25886,0 25902,1 25989,0 26025,1 26078,0 26166,1 26222,0 26269,1 26326,0 26398,1 26430,0 26522,1 26590,0 26690,1 26790,0 26795,1 26873,0 26905,1 26946,0 26957,1 27002,0 27014,1 27024,0 27092,1 27138,0 27166,1 27184,0 27239,1 27249,0 27326,1 27330,0 27370,1 27411,0 27487,1 27585,0 27600,1 27628,0 27700,1 27750,0 27803,1 27851,0 27897,1 27951,0 27994,1 28067,0 28069,1 28111,0 28125,1 28169,0 28208,1 28237,0 28251,1 28296,0 28362,1 28405,0 28412,1 28506,0 28529,1 28532,0 28564,1 28636,0 28667,1 28724,0 28770,1 28822,0 28864,1 28963,0 29008,1 29062,0 29159,1 29179,0 29206,1 29281,0 29356,1 29365,0 29437,1 29470,0 29496,1 29504,0 29574,1 29607,0 29642,1 29649,0 29709,1 29732,0 29750,1 29850,0 29874,1 29880,0 29916,1 29950,0 30035,1 30038,0 30082,1 30174,0 30198,1 30202,0 30209,1 30225,0 30319,1 30373,0 30381,1 30403,0 30493,1 30513,0 30558,1 30594,0 30595,1 30599,0 30628,1 30670,0 30678,1 30768,0 30844,1 30873,0 30920,1 30923,0 30928,1 31026,0 31115,1 31176,0 31181,1 31194,0 31230,1 31310,0 31341,1 31402,0 31502,1 31506,0 31544,1 31581,0 31670,1 31696,0 31753,1 31765,0 31772,1 31833,0 31851,1 31929,0 31966,1 31977,0 32008,1 32013,0 32083,1 32171,0 32196,1 32248,0 32282,1 32335,0 32399,1 32427,0 32522,1 32525,0 32566,1 32627,0 32674,1 32746,0 32794,1 32807,0 32851,1 32866,0 32965,1 33043,0 33080,1 33147,0 33161,1 33254,0 33332,1 33354,0 33368,1 33416,0 33472,1 33539,0 33603,1 33661,0 33669,1 33694,0 33758,1 33763,0 33767,1 33820,0 33863,1 33902,0 33925,1 34015,0 34067,1 34069,0 34121,1 34199,0 34285,1 34339,0 34384,1 34420,0 34501,1 34519,0 34553,1 34585,0 34664,1 34676,0 34761,1 34847,0 34947,1 34965,0 35052,1 35142,0 35171,1 35226,0 35274,1 35341,0 35374,1 35426,0 35450,1 35459,0 35492,1 35493,0 35566,1 35611,0 35614,1 35631,0 35641,1 35736,0 35740,1 35772,0 35835,1 35889,0 35944,1 35993,0 35996,1 36077,0 36130,1 36166,0 36182,1 36219,0 36252,1 36334,0 36382,1 36464,0 36483,1 36574,0 36616,1 36677,0 36711,1 36795,0 36874,1 36972,0 37044,1 37115,0 37118,1 37156,0 37221,1 37301,0 37329,1 37390,0 37443,1 37448,0 37457,1 37551,0 37592,1 37669,0 37690,1 37760,0 37852,1 37935,0 37974,1 38036,0 38054,1 38093,0 38166,1 38263,0 38315,1 38359,0 38444,1 38535,0 38591,1 38690,0 38693,1 38757,0 38843,1 38883,0 38925,1 39009,0 39093,1 39147,0 39158,1 39180,0 39219,1 39255,0 39260,1 39295,0 39297,1 39342,0 39421,1 39450,0 39482,1 39519,0 39582,1 39666,0 39680,1 39738,0 39827,1 39902,0 39974,1 40065,0 40100,1 40113,0 40183,1 40209,0 40287,1 40328,0 40419,1 40506,0 40523,1 40590,0 40629,1 40709,0 40785,1 40866,0 40931,1 41004,0 41077,1 41106,0 41153,1 41163,0 41190,1 41265,0 41363,1 41376,0 41418,1 41476,0 41523,1 41583,0 41675,1 41740,0 41799,1 41809,0 41891,1 41913,0 41952,1 41971,0 42012,1 42037,0 42069,1 42075,0 42117,1 42189,0 42219,1 42235,0 42236,1 42307,0 42329,1 42384,0 42484,1 42562,0 42631,1 42666,0 42718,1 42746,0 42820,1 42827,0 42892,1 42989,0 43077,1 43149,0 43213,1 43226,0 43326,1 43380,0 43400,1 43404,0 43504,1 43511,0 43559,1 43639,0 43727,1 43779,0 43808,1 43869,0 43918,1 43998,0 44027,1 44032,0 44091,1 44186,0 44219,1 44245,0 44328,1 44369,0 44417,1 44464,0 44528,1 44620,0 44717,1 44772,0 44802,1 44818,0 44916,1 44950,0 45028,1 45042,0 45122,1 45145,0 45213,1 45229,0 45279,1 45368,0 45380,1 45431,0 45493,1 45531,0 45607,1 45636,0 45650,1 45706,0 45803,1 45806,0 45861,1 45961,0 45962,1 46031,0 46039,1 46111,0 46124,1 46135,0 46234,1 46278,0 46298,1 46356,0 46412,1 46470,0 46491,1 46540,0 46598,1 46683,0 46686,1 46716,0 46747,1 46779,0 46818,1 46845,0 46931,1 47000,0 47068,1 47123,0 47145,1 47152,0 47182,1 47263,0 47347,1 47414,0 47422,1 47429,0 47444,1 47445,0 47466,1 47471,0 47472,1 47486,0 47492,1 47582,0 47623,1 47683,0 47746,1 47766,0 47767,1 47812,0 47813,1 47859,0 47909,1 47936,0 47956,1 47958,0 48021,1 48114,0 48184,1 48195,0 48259,1 48295,0 48353,1 48404,0 48458,1 48500,0 48582,1 48608,0 48664,1 48711,0 48725,1 end initlist c26 0,0 36,1 90,0 146,1 182,0 265,1 364,0 414,1 485,0 554,1 650,0 739,1 792,0 846,1 894,0 972,1 1009,0 1015,1 1062,0 1136,1 1148,0 1197,1 1198,0 1271,1 1287,0 1346,1 1374,0 1384,1 1385,0 1461,1 1489,0 1539,1 1546,0 1604,1 1638,0 1715,1 1773,0 1838,1 1871,0 1936,1 2019,0 2035,1 2046,0 2094,1 2114,0 2127,1 2188,0 2285,1 2323,0 2384,1 2403,0 2464,1 2500,0 2506,1 2570,0 2658,1 2696,0 2714,1 2793,0 2798,1 2800,0 2896,1 2972,0 3040,1 3065,0 3135,1 3163,0 3255,1 3344,0 3411,1 3465,0 3476,1 3483,0 3486,1 3530,0 3537,1 3619,0 3675,1 3773,0 3807,1 3853,0 3934,1 3977,0 4056,1 4060,0 4136,1 4192,0 4240,1 4243,0 4264,1 4275,0 4372,1 4401,0 4485,1 4500,0 4506,1 4525,0 4548,1 4616,0 4706,1 4786,0 4791,1 4827,0 4831,1 4867,0 4913,1 4929,0 4960,1 4962,0 5048,1 5069,0 5144,1 5146,0 5181,1 5266,0 5297,1 5339,0 5390,1 5461,0 5472,1 5501,0 5592,1 5645,0 5675,1 5704,0 5783,1 5874,0 5921,1 5960,0 5973,1 6025,0 6046,1 6090,0 6111,1 6122,0 6197,1 6222,0 6264,1 6343,0 6433,1 6498,0 6507,1 6599,0 6649,1 6723,0 6759,1 6812,0 6842,1 6904,0 6944,1 7026,0 7115,1 7164,0 7173,1 7254,0 7340,1 7381,0 7383,1 7403,0 7408,1 7507,0 7520,1 7528,0 7578,1 7661,0 7722,1 7796,0 7853,1 7933,0 8010,1 8079,0 8082,1 8107,0 8156,1 8182,0 8194,1 8290,0 8379,1 8473,0 8512,1 8526,0 8583,1 8642,0 8686,1 8710,0 8781,1 8800,0 8885,1 8911,0 8924,1 8993,0 9077,1 9175,0 9186,1 9231,0 9267,1 9351,0 9369,1 9385,0 9432,1 9443,0 9541,1 9611,0 9687,1 9723,0 9823,1 9829,0 9856,1 9937,0 9998,1 10015,0 10067,1 10090,0 10178,1 10233,0 10289,1 10337,0 10362,1 10434,0 10445,1 10538,0 10562,1 10577,0 10640,1 10682,0 10757,1 10809,0 10888,1 10899,0 10901,1 10977,0 11026,1 11126,0 11209,1 11230,0 11298,1 11387,0 11456,1 11459,0 11484,1 11544,0 11567,1 11641,0 11710,1 11768,0 11791,1 11803,0 11825,1 11912,0 11952,1 11984,0 12071,1 12145,0 12171,1 12215,0 12296,1 12308,0 12329,1 12412,0 12500,1 12553,0 12638,1 12660,0 12743,1 12764,0 12827,1 12864,0 12903,1 12929,0 12981,1 13042,0 13113,1 13213,0 13308,1 13369,0 13391,1 13469,0 13549,1 13595,0 13622,1 13629,0 13684,1 13699,0 13761,1 13846,0 13927,1 13960,0 14013,1 14046,0 14063,1 14145,0 14166,1 14257,0 14324,1 14363,0 14454,1 14546,0 14607,1 14685,0 14723,1 14794,0 14888,1 14981,0 15079,1 15116,0 15195,1 15284,0 15371,1 15388,0 15462,1 15507,0 15555,1 15598,0 15654,1 15734,0 15786,1 15823,0 15838,1 15903,0 15985,1 15987,0 16075,1 16079,0 16124,1 16130,0 16149,1 16214,0 16307,1 16379,0 16453,1 16476,0 16541,1 16568,0 16659,1 16688,0 16744,1 16841,0 16931,1 16990,0 17047,1 17089,0 17182,1 17232,0 17262,1 17313,0 17347,1 17417,0 17511,1 17548,0 17631,1 17663,0 17670,1 17671,0 17724,1 17797,0 17864,1 17871,0 17919,1 17935,0 17987,1 18066,0 18135,1 18232,0 18306,1 18405,0 18477,1 18557,0 18579,1 18611,0 18680,1 18695,0 18786,1 18836,0 18853,1 18903,0 18996,1 19095,0 19169,1 19206,0 19263,1 19302,0 19344,1 19414,0 19453,1 19528,0 19590,1 19621,0 19703,1 19707,0 19741,1 19810,0 19888,1 19960,0 19984,1 19986,0 20041,1 20119,0 20142,1 20203,0 20231,1 20272,0 20276,1 20285,0 20316,1 20360,0 20399,1 20448,0 20457,1 20509,0 20531,1 20621,0 20679,1 20759,0 20841,1 20921,0 20965,1 20969,0 21044,1 21075,0 21076,1 21173,0 21269,1 21300,0 21351,1 21392,0 21479,1 21579,0 21630,1 21683,0 21779,1 21801,0 21853,1 21859,0 21885,1 21913,0 22006,1 22043,0 22077,1 22142,0 22160,1 22245,0 22331,1 22359,0 22399,1 22471,0 22541,1 22625,0 22628,1 22649,0 22677,1 22697,0 22785,1 22803,0 22827,1 22894,0 22973,1 23038,0 23116,1 23120,0 23174,1 23255,0 23304,1 23345,0 23367,1 23380,0 23396,1 23439,0 23459,1 23503,0 23524,1 23612,0 23621,1 23712,0 23725,1 23824,0 23883,1 23959,0 24018,1 24082,0 24106,1 24146,0 24197,1 24256,0 24332,1 24407,0 24452,1 24468,0 24542,1 24623,0 24629,1 24644,0 24686,1 24776,0 24855,1 24880,0 24969,1 25058,0 25142,1 25164,0 25186,1 25189,0 25277,1 25348,0 25379,1 25402,0 25498,1 25529,0 25551,1 25582,0 25588,1 25630,0 25667,1 25696,0 25765,1 25806,0 25808,1 25874,0 25930,1 25989,0 26052,1 26064,0 26096,1 26166,0 26260,1 26298,0 26388,1 26458,0 26467,1 26494,0 26560,1 26617,0 26682,1 26758,0 26857,1 26945,0 27034,1 27064,0 27130,1 27137,0 27178,1 27243,0 27288,1 27319,0 27346,1 27425,0 27475,1 27517,0 27526,1 27606,0 27683,1 27763,0 27782,1 27797,0 27840,1 27880,0 27917,1 28015,0 28060,1 28094,0 28187,1 28208,0 28291,1 28350,0 28404,1 28484,0 28547,1 28560,0 28613,1 28634,0 28642,1 28739,0 28783,1 28849,0 28933,1 28972,0 29032,1 29069,0 29116,1 29187,0 29262,1 29337,0 29428,1 29511,0 29538,1 29622,0 29703,1 29734,0 29814,1 29828,0 29882,1 29948,0 30018,1 30107,0 30132,1 30201,0 30266,1 30276,0 30371,1 30449,0 30508,1 30533,0 30595,1 30637,0 30728,1 30760,0 30814,1 30857,0 30907,1 30928,0 31010,1 31067,0 31073,1 31119,0 31213,1 31307,0 31372,1 31447,0 31521,1 31559,0 31637,1 31705,0 31758,1 31808,0 31823,1 31838,0 31934,1 31967,0 32034,1 32112,0 32137,1 32180,0 32204,1 32292,0 32343,1 32439,0 32486,1 32557,0 32624,1 32629,0 32638,1 32642,0 32660,1 32685,0 32740,1 32803,0 32828,1 32850,0 32879,1 32965,0 32991,1 32998,0 33081,1 33108,0 33121,1 33219,0 33310,1 33380,0 33462,1 33558,0 33653,1 33701,0 33714,1 33765,0 33810,1 33862,0 33950,1 33961,0 34033,1 34035,0 34085,1 34154,0 34196,1 34278,0 34358,1 34375,0 34385,1 34389,0 34414,1 34420,0 34483,1 34537,0 34541,1 34588,0 34612,1 34710,0 34751,1 34822,0 34877,1 34928,0 35010,1 35073,0 35092,1 35186,0 35191,1 35282,0 35306,1 35386,0 35405,1 35496,0 35555,1 35639,0 35709,1 35806,0 35837,1 35841,0 35905,1 35907,0 36005,1 36058,0 36114,1 36138,0 36181,1 36193,0 36286,1 36328,0 36400,1 36460,0 36473,1 36510,0 36593,1 36601,0 36663,1 36730,0 36780,1 36821,0 36913,1 36962,0 37032,1 37096,0 37134,1 37216,0 37301,1 37361,0 37400,1 37489,0 37542,1 37640,0 37730,1 37758,0 37830,1 37831,0 37891,1 37973,0 38031,1 38096,0 38142,1 38167,0 38208,1 38223,0 38320,1 38381,0 38431,1 38516,0 38584,1 38601,0 38655,1 38696,0 38712,1 38775,0 38801,1 38870,0 38912,1 38945,0 38964,1 38988,0 39004,1 39034,0 39131,1 39178,0 39229,1 39292,0 39295,1 39300,0 39377,1 39440,0 39484,1 39500,0 39591,1 39641,0 39704,1 39705,0 39714,1 39751,0 39785,1 39825,0 39892,1 39940,0 39944,1 39970,0 40046,1 40115,0 40188,1 40260,0 40312,1 40407,0 40450,1 40548,0 40627,1 40664,0 40674,1 40740,0 40836,1 40916,0 40971,1 41022,0 41122,1 41189,0 41217,1 41242,0 41286,1 41302,0 41315,1 41346,0 41402,1 41444,0 41522,1 41616,0 41664,1 41714,0 41743,1 41841,0 41925,1 41982,0 42048,1 42079,0 42159,1 42245,0 42267,1 42313,0 42322,1 42345,0 42389,1 42417,0 42435,1 42464,0 42537,1 42615,0 42708,1 42712,0 42721,1 42731,0 42812,1 42911,0 43006,1 43009,0 43029,1 43071,0 43143,1 43192,0 43234,1 43235,0 43246,1 43341,0 43356,1 43456,0 43496,1 43545,0 43611,1 43708,0 43797,1 43878,0 43902,1 43961,0 43987,1 44082,0 44151,1 44207,0 44256,1 44260,0 44301,1 44378,0 44434,1 44508,0 44512,1 44548,0 44632,1 44648,0 44669,1 44681,0 44775,1 44814,0 44828,1 44905,0 44978,1 45071,0 45084,1 45097,0 45146,1 45216,0 45260,1 45329,0 45415,1 45438,0 45479,1 45547,0 45586,1 45680,0 45763,1 45770,0 45870,1 45884,0 45951,1 45967,0 46016,1 46106,0 46184,1 46195,0 46227,1 46302,0 46320,1 46333,0 46403,1 46450,0 46516,1 46584,0 46602,1 46689,0 46778,1 46853,0 46926,1 46990,0 47088,1 47089,0 47107,1 47149,0 47233,1 47331,0 47353,1 47449,0 47483,1 47557,0 47582,1 47630,0 47707,1 47718,0 47742,1 47744,0 47801,1 47896,0 47916,1 48014,0 48019,1 48103,0 48196,1 48252,0 48263,1 48329,0 48390,1 48396,0 48467,1 48547,0 48614,1 48670,0 48707,1 48742,0 48794,1 48849,0 48865,1 48902,0 48974,1 49018,0 49101,1 49140,0 49217,1 49267,0 49349,1 49439,0 49509,1 49593,0 49672,1 49763,0 49850,1 49948,0 49977,1 50061,0 50124,1 50195,0 50263,1 50334,0 50339,1 50344,0 50399,1 50456,0 50526,1 50559,0 50614,1 50684,0 50727,1 50732,0 50752,1 50760,0 50842,1 50928,0 51003,1 51051,0 51058,1 51085,0 51117,1 51211,0 51239,1 51258,0 51311,1 end initlist c27 0,0 31,1 128,0 217,1 225,0 281,1 368,0 435,1 449,0 504,1 524,0 620,1 719,0 732,1 787,0 884,1 908,0 967,1 1067,0 1166,1 1168,0 1267,1 1334,0 1383,1 1410,0 1492,1 1524,0 1577,1 1616,0 1713,1 1758,0 1789,1 1801,0 1881,1 1961,0 2017,1 2089,0 2130,1 2225,0 2240,1 2308,0 2357,1 2413,0 2468,1 2491,0 2539,1 2583,0 2586,1 2646,0 2673,1 2746,0 2771,1 2823,0 2908,1 2939,0 2963,1 3015,0 3087,1 3156,0 3249,1 3261,0 3295,1 3318,0 3357,1 3424,0 3508,1 3525,0 3566,1 3572,0 3577,1 3596,0 3623,1 3653,0 3750,1 3811,0 3871,1 3922,0 4015,1 4075,0 4106,1 4134,0 4204,1 4297,0 4325,1 4335,0 4406,1 4430,0 4526,1 4612,0 4711,1 4803,0 4879,1 4952,0 5012,1 5040,0 5112,1 5123,0 5158,1 5162,0 5168,1 5182,0 5210,1 5302,0 5385,1 5430,0 5444,1 5489,0 5505,1 5560,0 5580,1 5633,0 5688,1 5704,0 5792,1 5813,0 5876,1 5881,0 5915,1 5953,0 6024,1 6072,0 6110,1 6168,0 6245,1 6334,0 6354,1 6447,0 6538,1 6578,0 6655,1 6700,0 6713,1 6792,0 6892,1 6990,0 7072,1 7102,0 7131,1 7162,0 7167,1 7218,0 7292,1 7338,0 7379,1 7429,0 7517,1 7570,0 7580,1 7673,0 7763,1 7851,0 7914,1 7915,0 8008,1 8070,0 8121,1 8213,0 8271,1 8353,0 8435,1 8452,0 8480,1 8515,0 8580,1 8636,0 8713,1 8770,0 8834,1 8858,0 8886,1 8948,0 8975,1 9062,0 9137,1 9206,0 9244,1 9325,0 9349,1 9387,0 9460,1 9529,0 9580,1 9623,0 9693,1 9738,0 9809,1 9854,0 9940,1 9945,0 9973,1 10016,0 10072,1 10117,0 10158,1 10231,0 10311,1 10361,0 10408,1 10461,0 10524,1 10624,0 10692,1 10785,0 10843,1 10928,0 10977,1 10991,0 10994,1 11003,0 11008,1 11058,0 11079,1 11155,0 11170,1 11203,0 11215,1 11233,0 11284,1 11327,0 11421,1 11474,0 11526,1 11558,0 11573,1 11575,0 11656,1 11711,0 11732,1 11769,0 11828,1 11922,0 11955,1 12053,0 12065,1 12109,0 12116,1 12196,0 12220,1 12283,0 12304,1 12382,0 12426,1 12496,0 12527,1 12618,0 12655,1 12665,0 12723,1 12743,0 12834,1 12927,0 12954,1 13052,0 13119,1 13137,0 13167,1 13236,0 13285,1 13294,0 13348,1 13408,0 13464,1 13486,0 13585,1 13607,0 13631,1 13661,0 13752,1 13760,0 13811,1 13865,0 13916,1 13930,0 14005,1 14030,0 14100,1 14107,0 14152,1 14235,0 14248,1 14296,0 14320,1 14384,0 14423,1 14467,0 14504,1 14557,0 14637,1 14659,0 14671,1 14673,0 14745,1 14819,0 14890,1 14940,0 15024,1 15085,0 15166,1 15218,0 15315,1 15408,0 15506,1 15520,0 15595,1 15622,0 15627,1 15666,0 15739,1 15828,0 15857,1 15863,0 15961,1 16024,0 16026,1 16086,0 16141,1 16206,0 16245,1 16288,0 16297,1 16326,0 16411,1 16503,0 16540,1 16604,0 16637,1 16694,0 16754,1 16827,0 16878,1 16953,0 17030,1 17112,0 17180,1 17201,0 17272,1 17330,0 17371,1 17406,0 17467,1 17499,0 17573,1 17621,0 17707,1 17760,0 17783,1 17825,0 17828,1 17839,0 17857,1 17924,0 17965,1 18057,0 18075,1 18124,0 18216,1 18229,0 18262,1 18355,0 18432,1 18516,0 18608,1 18664,0 18687,1 18768,0 18851,1 18901,0 18982,1 19081,0 19127,1 19179,0 19243,1 19332,0 19400,1 19403,0 19439,1 19473,0 19478,1 19498,0 19542,1 19578,0 19605,1 19705,0 19710,1 19721,0 19755,1 19782,0 19878,1 19925,0 20022,1 20083,0 20099,1 20160,0 20169,1 20234,0 20305,1 20341,0 20436,1 20468,0 20485,1 20525,0 20602,1 20622,0 20696,1 20698,0 20756,1 20848,0 20925,1 20978,0 21024,1 21093,0 21161,1 21258,0 21272,1 21356,0 21393,1 21479,0 21554,1 21557,0 21575,1 21593,0 21616,1 21618,0 21635,1 21733,0 21767,1 21820,0 21911,1 21931,0 22003,1 22011,0 22066,1 22069,0 22116,1 22151,0 22251,1 22347,0 22426,1 22430,0 22522,1 22546,0 22579,1 22591,0 22678,1 22759,0 22773,1 22784,0 22861,1 22894,0 22990,1 23046,0 23110,1 23186,0 23209,1 23258,0 23291,1 23362,0 23426,1 23445,0 23453,1 23509,0 23606,1 23699,0 23758,1 23761,0 23826,1 23828,0 23898,1 23991,0 24012,1 24035,0 24087,1 24151,0 24179,1 24204,0 24296,1 24302,0 24382,1 24429,0 24468,1 24527,0 24596,1 24628,0 24688,1 24764,0 24793,1 24887,0 24946,1 24959,0 24987,1 25001,0 25002,1 25058,0 25110,1 25136,0 25144,1 25231,0 25245,1 25330,0 25349,1 25424,0 25509,1 25609,0 25666,1 25728,0 25743,1 25755,0 25771,1 25812,0 25830,1 25894,0 25989,1 26019,0 26051,1 26088,0 26154,1 26222,0 26230,1 26255,0 26341,1 26390,0 26393,1 26441,0 26479,1 26572,0 26582,1 26628,0 26673,1 26681,0 26771,1 26776,0 26803,1 26869,0 26939,1 26947,0 26964,1 27019,0 27034,1 27040,0 27085,1 27089,0 27153,1 27176,0 27192,1 27196,0 27245,1 27261,0 27308,1 27339,0 27371,1 27438,0 27470,1 27530,0 27592,1 27635,0 27725,1 27806,0 27817,1 27862,0 27888,1 27961,0 28050,1 28110,0 28160,1 28233,0 28277,1 28320,0 28359,1 28390,0 28455,1 28487,0 28539,1 28621,0 28681,1 28736,0 28765,1 28833,0 28855,1 28921,0 28992,1 29077,0 29142,1 29240,0 29338,1 29341,0 29419,1 29495,0 29572,1 29672,0 29729,1 29775,0 29874,1 29900,0 29959,1 30053,0 30147,1 30185,0 30236,1 30247,0 30313,1 30349,0 30416,1 30511,0 30579,1 30607,0 30687,1 30689,0 30729,1 30754,0 30758,1 30784,0 30864,1 30908,0 30913,1 30985,0 31079,1 31136,0 31183,1 31257,0 31355,1 31380,0 31453,1 31511,0 31585,1 31597,0 31682,1 31762,0 31845,1 31899,0 31904,1 31958,0 31971,1 31989,0 32083,1 32125,0 32203,1 32279,0 32327,1 32379,0 32439,1 32526,0 32590,1 32601,0 32668,1 32723,0 32761,1 32774,0 32778,1 32810,0 32887,1 32987,0 33075,1 33171,0 33271,1 33332,0 33367,1 33428,0 33482,1 33536,0 33611,1 33698,0 33715,1 33779,0 33831,1 33896,0 33974,1 34012,0 34070,1 34105,0 34115,1 34147,0 34155,1 34188,0 34252,1 34272,0 34304,1 34377,0 34427,1 34440,0 34447,1 34544,0 34639,1 34727,0 34787,1 34876,0 34927,1 34991,0 35020,1 35087,0 35131,1 35196,0 35259,1 35324,0 35326,1 35371,0 35377,1 35463,0 35508,1 35527,0 35561,1 35566,0 35662,1 35758,0 35772,1 35828,0 35909,1 35989,0 36047,1 36068,0 36117,1 36127,0 36170,1 36249,0 36265,1 36335,0 36416,1 36463,0 36464,1 36559,0 36564,1 36652,0 36750,1 36828,0 36861,1 36938,0 36968,1 37020,0 37102,1 37186,0 37218,1 37280,0 37361,1 37427,0 37460,1 37533,0 37626,1 37704,0 37738,1 37812,0 37863,1 37949,0 37997,1 38061,0 38102,1 38172,0 38202,1 38255,0 38276,1 38363,0 38398,1 38458,0 38490,1 38512,0 38532,1 38620,0 38627,1 38654,0 38711,1 38789,0 38800,1 38871,0 38930,1 38953,0 38997,1 39090,0 39149,1 39160,0 39187,1 39253,0 39322,1 39326,0 39425,1 39431,0 39490,1 39500,0 39575,1 39589,0 39647,1 39736,0 39782,1 39865,0 39892,1 39930,0 39992,1 40019,0 40074,1 40163,0 40192,1 40204,0 40289,1 40318,0 40357,1 40436,0 40511,1 40516,0 40520,1 40561,0 40636,1 40714,0 40729,1 40827,0 40870,1 40902,0 40907,1 40996,0 41036,1 41054,0 41055,1 41154,0 41171,1 41262,0 41342,1 41366,0 41461,1 41509,0 41582,1 41589,0 41682,1 41740,0 41793,1 41839,0 41860,1 41898,0 41912,1 41919,0 41980,1 42068,0 42127,1 42187,0 42189,1 42245,0 42275,1 42317,0 42378,1 42435,0 42472,1 42487,0 42550,1 42572,0 42587,1 42616,0 42675,1 42721,0 42729,1 42763,0 42827,1 42870,0 42926,1 42963,0 43016,1 43103,0 43172,1 43184,0 43239,1 43302,0 43331,1 43398,0 43411,1 43494,0 43550,1 43625,0 43708,1 43807,0 43851,1 43940,0 43962,1 44041,0 44085,1 44172,0 44203,1 44262,0 44344,1 44350,0 44368,1 44440,0 44494,1 44584,0 44603,1 44682,0 44773,1 44835,0 44935,1 44968,0 44994,1 45051,0 45085,1 45122,0 45180,1 45248,0 45321,1 45374,0 45407,1 45409,0 45493,1 45578,0 45641,1 45723,0 45736,1 45825,0 45919,1 45970,0 45979,1 46057,0 46058,1 46134,0 46166,1 46236,0 46335,1 46421,0 46485,1 46506,0 46557,1 46590,0 46619,1 46636,0 46732,1 46748,0 46815,1 46910,0 46960,1 47059,0 47102,1 47169,0 47185,1 47207,0 47241,1 47262,0 47285,1 47298,0 47308,1 47355,0 47440,1 47508,0 47529,1 47585,0 47625,1 47632,0 47706,1 47732,0 47802,1 47894,0 47962,1 47972,0 47982,1 47996,0 48090,1 48134,0 48170,1 48254,0 48265,1 48310,0 48331,1 48377,0 48428,1 48433,0 48454,1 48550,0 48626,1 48675,0 48682,1 48699,0 48727,1 48821,0 48885,1 48948,0 48988,1 49078,0 49166,1 49181,0 49229,1 49235,0 49306,1 49379,0 49397,1 49468,0 49537,1 49567,0 49568,1 49633,0 49724,1 49732,0 49831,1 49863,0 49955,1 49960,0 50057,1 50059,0 50078,1 50119,0 50173,1 50184,0 50199,1 50219,0 50299,1 50340,0 50370,1 50381,0 50441,1 50529,0 50530,1 50555,0 50566,1 end initlist c28 0,0 92,1 177,0 272,1 331,0 422,1 514,0 600,1 634,0 694,1 788,0 822,1 872,0 909,1 941,0 984,1 1032,0 1085,1 1184,0 1217,1 1317,0 1324,1 1377,0 1378,1 1466,0 1564,1 1605,0 1621,1 1678,0 1718,1 1773,0 1865,1 1912,0 1937,1 1955,0 2042,1 2088,0 2114,1 2172,0 2189,1 2254,0 2329,1 2336,0 2405,1 2413,0 2478,1 2531,0 2574,1 2593,0 2633,1 2728,0 2818,1 2890,0 2898,1 2981,0 3078,1 3171,0 3255,1 3257,0 3275,1 3302,0 3391,1 3477,0 3511,1 3583,0 3663,1 3683,0 3783,1 3856,0 3939,1 3957,0 3984,1 4069,0 4134,1 4194,0 4201,1 4276,0 4352,1 4450,0 4548,1 4549,0 4578,1 4592,0 4660,1 4748,0 4822,1 4905,0 4930,1 4956,0 5026,1 5093,0 5182,1 5199,0 5280,1 5331,0 5377,1 5466,0 5515,1 5549,0 5563,1 5585,0 5616,1 5697,0 5743,1 5762,0 5861,1 5888,0 5944,1 6016,0 6021,1 6110,0 6203,1 6273,0 6369,1 6395,0 6438,1 6439,0 6459,1 6540,0 6587,1 6663,0 6666,1 6675,0 6747,1 6781,0 6798,1 6861,0 6882,1 6955,0 7017,1 7052,0 7095,1 7184,0 7272,1 7364,0 7437,1 7499,0 7569,1 7577,0 7616,1 7705,0 7720,1 7786,0 7819,1 7865,0 7873,1 7929,0 7935,1 8015,0 8102,1 8186,0 8239,1 8254,0 8319,1 8332,0 8425,1 8472,0 8549,1 8607,0 8646,1 8662,0 8669,1 8760,0 8853,1 8874,0 8911,1 8954,0 9005,1 9012,0 9077,1 9121,0 9221,1 9288,0 9339,1 9424,0 9486,1 9530,0 9570,1 9605,0 9640,1 9673,0 9734,1 9821,0 9908,1 9934,0 9954,1 9986,0 10009,1 10067,0 10123,1 10148,0 10228,1 10313,0 10407,1 10422,0 10437,1 10478,0 10494,1 10570,0 10591,1 10675,0 10718,1 10746,0 10813,1 10879,0 10900,1 10907,0 10931,1 10984,0 11039,1 11095,0 11195,1 11224,0 11225,1 11309,0 11396,1 11478,0 11563,1 11636,0 11653,1 11738,0 11800,1 11879,0 11880,1 11932,0 11947,1 11988,0 11996,1 12078,0 12112,1 12137,0 12235,1 12328,0 12398,1 12468,0 12506,1 12573,0 12651,1 12699,0 12718,1 12743,0 12748,1 12840,0 12866,1 12935,0 12942,1 12989,0 13062,1 13098,0 13186,1 13224,0 13318,1 13413,0 13447,1 13539,0 13567,1 13604,0 13656,1 13744,0 13762,1 13862,0 13931,1 13971,0 14014,1 14072,0 14137,1 14176,0 14191,1 14250,0 14283,1 14304,0 14403,1 14492,0 14497,1 14506,0 14596,1 14644,0 14649,1 14664,0 14715,1 14766,0 14832,1 14928,0 14930,1 14983,0 15002,1 15060,0 15079,1 15097,0 15175,1 15223,0 15317,1 15327,0 15419,1 15475,0 15524,1 15582,0 15584,1 15651,0 15712,1 15775,0 15832,1 15865,0 15922,1 15984,0 16008,1 16059,0 16153,1 16225,0 16296,1 16346,0 16400,1 16451,0 16486,1 16505,0 16520,1 16556,0 16625,1 16662,0 16706,1 16760,0 16764,1 16831,0 16863,1 16948,0 17006,1 17051,0 17067,1 17159,0 17177,1 17211,0 17221,1 17258,0 17293,1 17371,0 17433,1 17438,0 17490,1 17510,0 17561,1 17629,0 17695,1 17794,0 17803,1 17810,0 17909,1 17944,0 17974,1 18017,0 18111,1 18126,0 18159,1 18238,0 18261,1 18303,0 18380,1 18474,0 18516,1 18523,0 18580,1 18600,0 18685,1 18690,0 18784,1 18802,0 18892,1 18978,0 19055,1 19118,0 19203,1 19217,0 19274,1 19315,0 19332,1 19361,0 19404,1 19449,0 19492,1 19549,0 19631,1 19709,0 19751,1 19795,0 19834,1 19840,0 19939,1 19955,0 19972,1 20065,0 20099,1 20150,0 20226,1 20255,0 20340,1 20396,0 20420,1 20467,0 20530,1 20598,0 20634,1 20685,0 20764,1 20843,0 20920,1 20951,0 21051,1 21112,0 21114,1 21203,0 21262,1 21283,0 21338,1 21375,0 21404,1 21416,0 21487,1 21494,0 21545,1 21638,0 21671,1 21725,0 21798,1 21806,0 21893,1 21977,0 22024,1 22069,0 22164,1 22197,0 22274,1 22289,0 22385,1 22413,0 22440,1 22450,0 22461,1 22474,0 22558,1 22641,0 22662,1 22685,0 22735,1 22742,0 22779,1 22831,0 22927,1 23006,0 23050,1 23145,0 23228,1 23270,0 23308,1 23364,0 23417,1 23460,0 23462,1 23464,0 23554,1 23638,0 23675,1 23772,0 23804,1 23895,0 23938,1 23951,0 23955,1 24014,0 24097,1 24099,0 24160,1 24222,0 24228,1 24229,0 24306,1 24371,0 24411,1 24461,0 24481,1 24527,0 24623,1 24706,0 24720,1 24743,0 24819,1 24826,0 24884,1 24974,0 25033,1 25043,0 25064,1 25106,0 25193,1 25245,0 25253,1 25340,0 25425,1 25519,0 25558,1 25566,0 25567,1 25660,0 25706,1 25735,0 25795,1 25848,0 25924,1 25943,0 26024,1 26096,0 26147,1 26242,0 26267,1 26323,0 26368,1 26377,0 26389,1 26417,0 26485,1 26574,0 26596,1 26620,0 26670,1 26728,0 26750,1 26821,0 26907,1 26971,0 27063,1 27136,0 27187,1 27223,0 27263,1 27273,0 27336,1 27403,0 27429,1 27489,0 27512,1 27597,0 27627,1 27723,0 27724,1 27783,0 27872,1 27880,0 27907,1 27935,0 28005,1 28074,0 28076,1 28129,0 28146,1 28161,0 28216,1 28299,0 28301,1 28383,0 28460,1 28512,0 28538,1 28548,0 28554,1 28608,0 28617,1 28716,0 28809,1 28883,0 28959,1 28974,0 29045,1 29112,0 29117,1 29142,0 29200,1 29260,0 29288,1 29383,0 29461,1 29547,0 29628,1 29719,0 29749,1 29772,0 29817,1 29912,0 29972,1 29997,0 30067,1 30128,0 30206,1 30257,0 30267,1 30366,0 30417,1 30456,0 30481,1 30493,0 30515,1 30542,0 30550,1 30604,0 30628,1 30684,0 30734,1 30815,0 30870,1 30952,0 31004,1 31058,0 31147,1 31181,0 31244,1 31314,0 31332,1 31395,0 31420,1 31509,0 31576,1 31615,0 31684,1 31726,0 31749,1 31831,0 31929,1 31971,0 32033,1 32062,0 32139,1 32185,0 32221,1 32238,0 32239,1 32318,0 32415,1 32433,0 32481,1 32546,0 32611,1 32620,0 32664,1 32704,0 32782,1 32786,0 32801,1 32885,0 32923,1 32968,0 32987,1 33021,0 33121,1 33124,0 33142,1 33173,0 33246,1 33276,0 33357,1 33415,0 33481,1 33503,0 33507,1 33585,0 33609,1 33701,0 33773,1 33813,0 33815,1 33900,0 33925,1 33944,0 33990,1 34089,0 34124,1 34150,0 34192,1 34273,0 34323,1 34325,0 34351,1 34416,0 34501,1 34551,0 34559,1 34608,0 34611,1 34649,0 34743,1 34793,0 34881,1 34972,0 35053,1 35087,0 35135,1 35179,0 35213,1 35281,0 35369,1 35383,0 35408,1 35430,0 35512,1 35564,0 35580,1 35602,0 35698,1 35721,0 35775,1 35832,0 35864,1 35932,0 36024,1 36079,0 36089,1 36135,0 36204,1 36283,0 36305,1 36309,0 36384,1 36450,0 36478,1 36528,0 36560,1 36622,0 36658,1 36671,0 36692,1 36740,0 36823,1 36875,0 36908,1 36922,0 36946,1 37023,0 37102,1 37136,0 37228,1 37289,0 37339,1 37357,0 37416,1 37504,0 37583,1 37611,0 37689,1 37694,0 37756,1 37786,0 37832,1 37892,0 37930,1 37952,0 37978,1 38027,0 38109,1 38112,0 38144,1 38166,0 38225,1 38230,0 38262,1 38272,0 38334,1 38353,0 38369,1 38371,0 38445,1 38468,0 38529,1 38619,0 38693,1 38703,0 38751,1 38754,0 38837,1 38847,0 38858,1 38954,0 38994,1 39024,0 39066,1 39134,0 39216,1 39247,0 39248,1 39324,0 39361,1 39443,0 39450,1 39539,0 39585,1 39665,0 39696,1 39746,0 39789,1 39832,0 39865,1 39903,0 39987,1 40060,0 40117,1 40162,0 40165,1 40204,0 40268,1 40346,0 40357,1 40372,0 40414,1 40473,0 40536,1 40540,0 40546,1 40550,0 40571,1 40650,0 40690,1 40760,0 40831,1 40866,0 40965,1 41053,0 41121,1 41162,0 41187,1 41221,0 41225,1 41308,0 41344,1 41408,0 41472,1 41486,0 41494,1 41521,0 41552,1 41600,0 41652,1 41713,0 41720,1 41721,0 41793,1 41821,0 41863,1 41928,0 41986,1 42003,0 42063,1 42090,0 42096,1 42118,0 42138,1 42236,0 42314,1 42327,0 42386,1 42442,0 42492,1 42570,0 42586,1 42671,0 42720,1 42819,0 42845,1 42939,0 42988,1 43043,0 43087,1 43122,0 43140,1 43211,0 43224,1 43296,0 43351,1 43378,0 43417,1 43475,0 43519,1 43546,0 43607,1 43670,0 43718,1 43794,0 43892,1 43948,0 44047,1 44142,0 44157,1 44185,0 44210,1 44217,0 44227,1 44308,0 44365,1 44399,0 44446,1 44468,0 44532,1 44554,0 44589,1 44628,0 44632,1 44686,0 44785,1 44846,0 44905,1 45000,0 45072,1 45166,0 45175,1 45185,0 45233,1 45286,0 45334,1 45405,0 45492,1 45584,0 45655,1 45668,0 45681,1 45723,0 45775,1 45836,0 45874,1 45910,0 45912,1 45994,0 46030,1 46071,0 46073,1 46105,0 46133,1 46204,0 46222,1 46281,0 46312,1 46363,0 46427,1 46515,0 46601,1 46629,0 46700,1 46712,0 46812,1 46860,0 46923,1 46995,0 47036,1 47039,0 47042,1 47093,0 47171,1 47250,0 47316,1 47326,0 47332,1 47399,0 47409,1 47485,0 47502,1 47579,0 47585,1 47627,0 47657,1 47679,0 47738,1 47832,0 47932,1 48025,0 48059,1 48075,0 48098,1 48126,0 48187,1 48243,0 48330,1 48414,0 48421,1 48464,0 48531,1 48542,0 48615,1 48672,0 48724,1 48761,0 48855,1 48872,0 48926,1 49008,0 49010,1 49092,0 49167,1 49176,0 49191,1 49263,0 49360,1 49455,0 49546,1 49641,0 49735,1 49784,0 49808,1 49859,0 49919,1 end initlist c29 0,0 100,1 176,0 249,1 341,0 379,1 409,0 417,1 439,0 477,1 547,0 589,1 606,0 626,1 699,0 707,1 714,0 804,1 853,0 931,1 951,0 968,1 1045,0 1084,1 1118,0 1149,1 1165,0 1241,1 1278,0 1309,1 1371,0 1438,1 1482,0 1573,1 1663,0 1691,1 1762,0 1843,1 1876,0 1933,1 2016,0 2102,1 2166,0 2253,1 2276,0 2311,1 2372,0 2469,1 2533,0 2555,1 2560,0 2591,1 2603,0 2662,1 2697,0 2741,1 2831,0 2891,1 2892,0 2986,1 3045,0 3122,1 3189,0 3247,1 3345,0 3394,1 3472,0 3547,1 3561,0 3646,1 3730,0 3773,1 3810,0 3886,1 3927,0 4012,1 4068,0 4128,1 4148,0 4155,1 4227,0 4261,1 4345,0 4384,1 4387,0 4402,1 4429,0 4516,1 4524,0 4556,1 4648,0 4736,1 4779,0 4792,1 4834,0 4919,1 4941,0 5011,1 5012,0 5110,1 5136,0 5161,1 5229,0 5247,1 5293,0 5379,1 5453,0 5541,1 5566,0 5579,1 5663,0 5717,1 5748,0 5765,1 5781,0 5870,1 5910,0 5972,1 6028,0 6065,1 6129,0 6213,1 6304,0 6351,1 6443,0 6497,1 6597,0 6599,1 6662,0 6755,1 6759,0 6844,1 6858,0 6896,1 6933,0 6989,1 7011,0 7066,1 7122,0 7123,1 7209,0 7303,1 7305,0 7334,1 7415,0 7499,1 7541,0 7605,1 7691,0 7718,1 7795,0 7826,1 7875,0 7963,1 7983,0 8022,1 8109,0 8202,1 8269,0 8275,1 8362,0 8446,1 8515,0 8608,1 8618,0 8695,1 8790,0 8818,1 8902,0 8987,1 9051,0 9123,1 9199,0 9238,1 9311,0 9345,1 9369,0 9439,1 9441,0 9507,1 9511,0 9568,1 9619,0 9645,1 9700,0 9727,1 9769,0 9841,1 9901,0 9928,1 9948,0 10022,1 10035,0 10108,1 10197,0 10239,1 10311,0 10326,1 10412,0 10471,1 10502,0 10513,1 10609,0 10634,1 10731,0 10758,1 10797,0 10817,1 10848,0 10858,1 10904,0 11003,1 11059,0 11134,1 11150,0 11225,1 11228,0 11283,1 11359,0 11380,1 11424,0 11493,1 11593,0 11613,1 11663,0 11740,1 11838,0 11929,1 11974,0 12031,1 12042,0 12070,1 12156,0 12218,1 12247,0 12344,1 12347,0 12361,1 12446,0 12532,1 12611,0 12635,1 12680,0 12740,1 12804,0 12854,1 12880,0 12947,1 13005,0 13097,1 13157,0 13238,1 13299,0 13306,1 13367,0 13404,1 13502,0 13568,1 13576,0 13636,1 13726,0 13819,1 13870,0 13930,1 13987,0 14083,1 14137,0 14158,1 14194,0 14214,1 14309,0 14381,1 14450,0 14534,1 14560,0 14648,1 14737,0 14786,1 14796,0 14878,1 14888,0 14983,1 15005,0 15096,1 15171,0 15208,1 15296,0 15358,1 15412,0 15448,1 15464,0 15487,1 15555,0 15613,1 15635,0 15692,1 15770,0 15795,1 15825,0 15827,1 15894,0 15926,1 15935,0 15945,1 16033,0 16122,1 16129,0 16156,1 16231,0 16250,1 16345,0 16360,1 16386,0 16448,1 16535,0 16612,1 16687,0 16733,1 16795,0 16817,1 16895,0 16905,1 16924,0 16972,1 16979,0 17016,1 17046,0 17073,1 17132,0 17142,1 17164,0 17209,1 17295,0 17365,1 17401,0 17481,1 17519,0 17535,1 17587,0 17633,1 17634,0 17665,1 17713,0 17724,1 17794,0 17813,1 17902,0 17979,1 18021,0 18096,1 18184,0 18198,1 18262,0 18305,1 18392,0 18405,1 18414,0 18491,1 18556,0 18596,1 18614,0 18669,1 18717,0 18793,1 18893,0 18957,1 19035,0 19052,1 19067,0 19158,1 19188,0 19258,1 19261,0 19323,1 19409,0 19480,1 19483,0 19526,1 19561,0 19635,1 19667,0 19691,1 19754,0 19804,1 19874,0 19942,1 19992,0 20053,1 20097,0 20139,1 20227,0 20321,1 20346,0 20407,1 20421,0 20435,1 20507,0 20509,1 20608,0 20629,1 20685,0 20705,1 20797,0 20867,1 20879,0 20926,1 20931,0 21002,1 21039,0 21093,1 21158,0 21173,1 21220,0 21265,1 21289,0 21335,1 21400,0 21435,1 21485,0 21524,1 21615,0 21690,1 21749,0 21751,1 21773,0 21857,1 21921,0 21962,1 22038,0 22112,1 22122,0 22145,1 22177,0 22228,1 22281,0 22342,1 22392,0 22449,1 22521,0 22568,1 22647,0 22699,1 22753,0 22794,1 22814,0 22884,1 22904,0 22981,1 22997,0 22999,1 23094,0 23166,1 23228,0 23233,1 23297,0 23382,1 23442,0 23493,1 23500,0 23512,1 23604,0 23704,1 23802,0 23856,1 23871,0 23969,1 24064,0 24129,1 24178,0 24229,1 24266,0 24365,1 24394,0 24425,1 24453,0 24454,1 24545,0 24573,1 24645,0 24717,1 24721,0 24727,1 24813,0 24832,1 24896,0 24954,1 25028,0 25030,1 25041,0 25128,1 25194,0 25266,1 25274,0 25327,1 25397,0 25461,1 25545,0 25629,1 25692,0 25771,1 25794,0 25850,1 25868,0 25928,1 25993,0 26011,1 26023,0 26098,1 26100,0 26102,1 26157,0 26229,1 26309,0 26400,1 26442,0 26511,1 26569,0 26589,1 26598,0 26664,1 26760,0 26848,1 26853,0 26866,1 26940,0 26995,1 27040,0 27092,1 27103,0 27162,1 27262,0 27265,1 27331,0 27351,1 27444,0 27518,1 27597,0 27603,1 27693,0 27774,1 27839,0 27912,1 27979,0 28013,1 28055,0 28077,1 28081,0 28100,1 28151,0 28242,1 28273,0 28277,1 28362,0 28374,1 28450,0 28482,1 28540,0 28622,1 28679,0 28716,1 28795,0 28821,1 28881,0 28961,1 28969,0 29064,1 29131,0 29185,1 29190,0 29199,1 29206,0 29301,1 29371,0 29470,1 29491,0 29495,1 29560,0 29612,1 29639,0 29723,1 29803,0 29805,1 29848,0 29862,1 29885,0 29902,1 29941,0 29976,1 30031,0 30065,1 30069,0 30119,1 30210,0 30262,1 30330,0 30426,1 30514,0 30600,1 30657,0 30699,1 30795,0 30797,1 30870,0 30922,1 30980,0 31066,1 31094,0 31110,1 31148,0 31218,1 31277,0 31372,1 31404,0 31428,1 31448,0 31501,1 31520,0 31538,1 31548,0 31587,1 31678,0 31695,1 31711,0 31775,1 31875,0 31957,1 32014,0 32101,1 32189,0 32228,1 32267,0 32309,1 32406,0 32496,1 32506,0 32567,1 32589,0 32681,1 32779,0 32855,1 32917,0 32922,1 32930,0 32965,1 33028,0 33058,1 33098,0 33121,1 33178,0 33262,1 33340,0 33358,1 33448,0 33535,1 33599,0 33630,1 33663,0 33697,1 33741,0 33748,1 33834,0 33921,1 33939,0 34011,1 34070,0 34138,1 34145,0 34244,1 34340,0 34367,1 34392,0 34463,1 34519,0 34540,1 34629,0 34678,1 34720,0 34778,1 34831,0 34928,1 35015,0 35073,1 35125,0 35178,1 35212,0 35218,1 35299,0 35382,1 35425,0 35431,1 35529,0 35538,1 35609,0 35651,1 35712,0 35786,1 35839,0 35937,1 35954,0 35977,1 36032,0 36113,1 36123,0 36183,1 36200,0 36251,1 36321,0 36324,1 36422,0 36443,1 36485,0 36514,1 36535,0 36555,1 36630,0 36652,1 36732,0 36797,1 36836,0 36857,1 36902,0 36957,1 36991,0 37070,1 37141,0 37184,1 37238,0 37282,1 37314,0 37394,1 37448,0 37501,1 37507,0 37554,1 37605,0 37693,1 37791,0 37824,1 37908,0 37924,1 38024,0 38048,1 38081,0 38101,1 38114,0 38183,1 38248,0 38340,1 38416,0 38434,1 38464,0 38532,1 38616,0 38714,1 38719,0 38804,1 38855,0 38897,1 38917,0 38949,1 39027,0 39075,1 39117,0 39204,1 39300,0 39380,1 39453,0 39533,1 39562,0 39644,1 39695,0 39727,1 39751,0 39776,1 39864,0 39920,1 39975,0 40025,1 40058,0 40114,1 40143,0 40217,1 40316,0 40338,1 40429,0 40502,1 40522,0 40607,1 40624,0 40685,1 40741,0 40790,1 40799,0 40850,1 40908,0 40981,1 40982,0 41023,1 41058,0 41129,1 41190,0 41254,1 41321,0 41398,1 41463,0 41559,1 41609,0 41615,1 41655,0 41754,1 41772,0 41842,1 41923,0 41934,1 42017,0 42080,1 42145,0 42178,1 42230,0 42275,1 42368,0 42441,1 42483,0 42531,1 42601,0 42663,1 42690,0 42706,1 42752,0 42836,1 42899,0 42999,1 43063,0 43072,1 43165,0 43214,1 43251,0 43295,1 43371,0 43465,1 43519,0 43550,1 43650,0 43681,1 43707,0 43752,1 43763,0 43827,1 43871,0 43963,1 44050,0 44064,1 44071,0 44132,1 44195,0 44215,1 44293,0 44368,1 44385,0 44436,1 44528,0 44556,1 44628,0 44679,1 44702,0 44722,1 44739,0 44832,1 44841,0 44860,1 44868,0 44894,1 44925,0 44978,1 45018,0 45079,1 45118,0 45135,1 45138,0 45192,1 45200,0 45210,1 45263,0 45273,1 45316,0 45320,1 45418,0 45468,1 45524,0 45548,1 45625,0 45668,1 45729,0 45793,1 45800,0 45852,1 45860,0 45884,1 45904,0 45918,1 45955,0 46037,1 46087,0 46186,1 46216,0 46227,1 46312,0 46344,1 46393,0 46431,1 46456,0 46541,1 46603,0 46629,1 46717,0 46787,1 46793,0 46823,1 46854,0 46949,1 46965,0 47059,1 47142,0 47194,1 47222,0 47279,1 47357,0 47378,1 47420,0 47443,1 47448,0 47516,1 47541,0 47613,1 47682,0 47735,1 47824,0 47890,1 47896,0 47985,1 48009,0 48062,1 48109,0 48163,1 48219,0 48248,1 48339,0 48343,1 48400,0 48406,1 48433,0 48460,1 48499,0 48556,1 48578,0 48603,1 48650,0 48730,1 48737,0 48815,1 48846,0 48926,1 48967,0 49061,1 49150,0 49166,1 49174,0 49190,1 49282,0 49293,1 49294,0 49318,1 49415,0 49478,1 49543,0 49572,1 49658,0 49743,1 49763,0 49772,1 49826,0 49921,1 49944,0 50035,1 50036,0 50125,1 50211,0 50274,1 50327,0 50366,1 50440,0 50533,1 50632,0 50639,1 50698,0 50729,1 50777,0 50827,1 50853,0 50946,1 50956,0 50958,1 end initlist c30 0,0 33,1 74,0 173,1 232,0 249,1 273,0 306,1 396,0 455,1 553,0 619,1 661,0 755,1 783,0 869,1 895,0 900,1 905,0 992,1 1024,0 1104,1 1112,0 1198,1 1293,0 1367,1 1429,0 1444,1 1531,0 1568,1 1602,0 1664,1 1706,0 1737,1 1814,0 1861,1 1889,0 1951,1 2032,0 2105,1 2197,0 2236,1 2321,0 2414,1 2447,0 2474,1 2489,0 2547,1 2641,0 2725,1 2810,0 2910,1 3010,0 3104,1 3191,0 3239,1 3275,0 3328,1 3381,0 3398,1 3473,0 3571,1 3628,0 3679,1 3754,0 3774,1 3783,0 3809,1 3868,0 3926,1 3935,0 3971,1 3994,0 4026,1 4104,0 4161,1 4242,0 4312,1 4386,0 4409,1 4481,0 4571,1 4585,0 4673,1 4692,0 4723,1 4773,0 4798,1 4888,0 4891,1 4910,0 4921,1 4948,0 5021,1 5075,0 5085,1 5119,0 5143,1 5162,0 5194,1 5214,0 5314,1 5331,0 5369,1 5387,0 5477,1 5513,0 5520,1 5609,0 5703,1 5796,0 5823,1 5865,0 5899,1 5932,0 6029,1 6095,0 6106,1 6139,0 6141,1 6190,0 6211,1 6289,0 6331,1 6357,0 6416,1 6457,0 6490,1 6588,0 6683,1 6733,0 6744,1 6791,0 6853,1 6861,0 6910,1 6943,0 7006,1 7042,0 7125,1 7162,0 7191,1 7201,0 7272,1 7334,0 7337,1 7424,0 7484,1 7524,0 7568,1 7587,0 7634,1 7676,0 7725,1 7767,0 7850,1 7853,0 7939,1 8035,0 8047,1 8147,0 8158,1 8168,0 8219,1 8314,0 8406,1 8485,0 8526,1 8574,0 8638,1 8728,0 8828,1 8867,0 8874,1 8900,0 8950,1 8978,0 9072,1 9145,0 9153,1 9214,0 9314,1 9327,0 9366,1 9399,0 9498,1 9585,0 9603,1 9703,0 9781,1 9823,0 9882,1 9935,0 9937,1 10014,0 10090,1 10092,0 10106,1 10169,0 10247,1 10327,0 10331,1 10418,0 10514,1 10550,0 10635,1 10702,0 10802,1 10868,0 10959,1 10970,0 10982,1 10990,0 10995,1 11074,0 11141,1 11210,0 11288,1 11349,0 11365,1 11454,0 11543,1 11562,0 11598,1 11618,0 11665,1 11711,0 11807,1 11819,0 11902,1 11987,0 12066,1 12134,0 12217,1 12303,0 12393,1 12450,0 12521,1 12596,0 12687,1 12689,0 12734,1 12816,0 12911,1 12957,0 12974,1 12991,0 13025,1 13037,0 13124,1 13205,0 13249,1 13343,0 13438,1 13533,0 13599,1 13694,0 13793,1 13869,0 13919,1 13939,0 13989,1 14060,0 14079,1 14159,0 14210,1 14225,0 14233,1 14239,0 14276,1 14334,0 14340,1 14408,0 14413,1 14509,0 14588,1 14681,0 14721,1 14737,0 14750,1 14782,0 14805,1 14860,0 14924,1 14983,0 15056,1 15129,0 15185,1 15234,0 15313,1 15398,0 15409,1 15481,0 15555,1 15608,0 15625,1 15705,0 15717,1 15757,0 15784,1 15809,0 15838,1 15900,0 15978,1 16063,0 16104,1 16129,0 16131,1 16200,0 16206,1 16235,0 16255,1 16326,0 16368,1 16465,0 16544,1 16561,0 16582,1 16617,0 16715,1 16783,0 16879,1 16919,0 17005,1 17086,0 17132,1 17165,0 17210,1 17237,0 17253,1 17287,0 17360,1 17448,0 17505,1 17605,0 17619,1 17706,0 17725,1 17791,0 17860,1 17951,0 18044,1 18080,0 18122,1 18196,0 18235,1 18309,0 18371,1 18384,0 18455,1 18531,0 18615,1 18673,0 18714,1 18811,0 18882,1 18885,0 18954,1 19006,0 19044,1 19079,0 19162,1 19178,0 19223,1 19282,0 19283,1 19290,0 19359,1 19371,0 19452,1 19520,0 19591,1 19639,0 19667,1 19698,0 19765,1 19862,0 19948,1 19987,0 20010,1 20031,0 20083,1 20169,0 20170,1 20225,0 20228,1 20264,0 20272,1 20304,0 20337,1 20347,0 20366,1 20417,0 20437,1 20523,0 20620,1 20703,0 20787,1 20840,0 20852,1 20890,0 20951,1 21036,0 21077,1 21095,0 21106,1 21193,0 21280,1 21352,0 21432,1 21524,0 21595,1 21614,0 21648,1 21660,0 21694,1 21783,0 21849,1 21893,0 21983,1 22034,0 22091,1 22179,0 22199,1 22204,0 22268,1 22304,0 22337,1 22394,0 22451,1 22529,0 22573,1 22668,0 22679,1 22686,0 22764,1 22838,0 22863,1 22910,0 23001,1 23054,0 23108,1 23148,0 23162,1 23222,0 23247,1 23319,0 23369,1 23423,0 23439,1 23534,0 23609,1 23709,0 23740,1 23763,0 23796,1 23881,0 23901,1 23956,0 24029,1 24039,0 24099,1 24190,0 24194,1 24201,0 24275,1 24374,0 24378,1 24403,0 24474,1 24478,0 24507,1 24528,0 24627,1 24703,0 24745,1 24834,0 24885,1 24939,0 24941,1 24982,0 25018,1 25097,0 25145,1 25152,0 25161,1 25258,0 25296,1 25361,0 25394,1 25401,0 25428,1 25509,0 25607,1 25687,0 25711,1 25730,0 25777,1 25806,0 25900,1 25946,0 26039,1 26134,0 26218,1 26287,0 26338,1 26391,0 26451,1 26524,0 26611,1 26666,0 26761,1 26830,0 26846,1 26871,0 26951,1 26981,0 26997,1 27059,0 27133,1 27205,0 27251,1 27261,0 27299,1 27399,0 27479,1 27577,0 27661,1 27715,0 27720,1 27726,0 27764,1 27810,0 27829,1 27914,0 28005,1 28047,0 28125,1 28213,0 28215,1 28283,0 28359,1 28377,0 28460,1 28542,0 28586,1 28660,0 28711,1 28771,0 28773,1 28856,0 28942,1 28949,0 29042,1 29119,0 29155,1 29215,0 29296,1 29350,0 29358,1 29412,0 29432,1 29527,0 29600,1 29623,0 29718,1 29792,0 29869,1 29933,0 29979,1 30033,0 30123,1 30218,0 30310,1 30410,0 30443,1 30485,0 30493,1 30542,0 30605,1 30650,0 30656,1 30685,0 30694,1 30785,0 30865,1 30937,0 30997,1 31005,0 31076,1 31158,0 31209,1 31256,0 31274,1 31329,0 31377,1 31436,0 31478,1 31561,0 31614,1 31626,0 31704,1 31709,0 31785,1 31847,0 31940,1 31979,0 31983,1 32069,0 32158,1 32228,0 32240,1 32305,0 32378,1 32443,0 32476,1 32557,0 32559,1 32575,0 32663,1 32676,0 32733,1 32745,0 32790,1 32791,0 32847,1 32893,0 32958,1 32962,0 33054,1 33126,0 33142,1 33230,0 33317,1 33401,0 33434,1 33523,0 33545,1 33603,0 33612,1 33702,0 33767,1 33838,0 33896,1 33929,0 34004,1 34008,0 34011,1 34015,0 34061,1 34071,0 34114,1 34172,0 34270,1 34293,0 34320,1 34329,0 34354,1 34416,0 34455,1 34543,0 34603,1 34634,0 34640,1 34663,0 34678,1 34749,0 34773,1 34855,0 34951,1 35015,0 35100,1 35186,0 35280,1 35337,0 35390,1 35437,0 35528,1 35585,0 35685,1 35742,0 35774,1 35791,0 35890,1 35896,0 35930,1 36024,0 36047,1 36101,0 36172,1 36207,0 36258,1 36295,0 36389,1 36393,0 36469,1 36562,0 36598,1 36607,0 36627,1 36633,0 36671,1 36753,0 36792,1 36879,0 36899,1 36965,0 37026,1 37087,0 37176,1 37212,0 37267,1 37301,0 37336,1 37387,0 37452,1 37552,0 37639,1 37679,0 37698,1 37702,0 37753,1 37812,0 37824,1 37837,0 37886,1 37974,0 37990,1 38053,0 38119,1 38189,0 38192,1 38205,0 38209,1 38294,0 38315,1 38384,0 38433,1 38505,0 38545,1 38567,0 38628,1 38698,0 38752,1 38765,0 38817,1 38846,0 38919,1 38945,0 39018,1 39066,0 39153,1 39248,0 39344,1 39433,0 39443,1 39491,0 39541,1 39608,0 39696,1 39727,0 39766,1 39769,0 39780,1 39846,0 39895,1 39959,0 40014,1 40072,0 40131,1 40221,0 40242,1 40251,0 40322,1 40381,0 40443,1 40510,0 40557,1 40586,0 40623,1 40633,0 40720,1 40806,0 40902,1 40940,0 40961,1 41022,0 41112,1 41129,0 41210,1 41224,0 41242,1 41264,0 41356,1 41377,0 41443,1 41457,0 41549,1 41635,0 41636,1 41713,0 41787,1 41812,0 41849,1 41898,0 41945,1 41990,0 42033,1 42080,0 42118,1 42130,0 42152,1 42238,0 42240,1 42274,0 42355,1 42366,0 42393,1 42480,0 42580,1 42674,0 42724,1 42753,0 42851,1 42918,0 42929,1 42993,0 43044,1 43113,0 43126,1 43223,0 43304,1 43402,0 43466,1 43489,0 43551,1 43585,0 43673,1 43702,0 43709,1 43785,0 43851,1 43901,0 43983,1 44078,0 44117,1 44183,0 44277,1 44362,0 44430,1 44496,0 44568,1 44621,0 44716,1 44776,0 44818,1 44848,0 44939,1 44945,0 45013,1 45047,0 45101,1 45116,0 45149,1 45198,0 45218,1 45276,0 45364,1 45369,0 45391,1 45489,0 45530,1 45550,0 45554,1 45569,0 45579,1 45630,0 45685,1 45747,0 45760,1 45789,0 45886,1 45959,0 46033,1 46081,0 46138,1 46173,0 46226,1 46255,0 46309,1 46353,0 46396,1 46425,0 46480,1 46543,0 46572,1 46601,0 46657,1 46689,0 46712,1 46765,0 46831,1 46927,0 47003,1 47076,0 47127,1 47208,0 47258,1 47298,0 47387,1 47467,0 47509,1 47556,0 47632,1 47701,0 47800,1 47839,0 47932,1 48028,0 48080,1 48084,0 48163,1 48180,0 48193,1 48258,0 48344,1 48436,0 48451,1 48530,0 48609,1 48620,0 48641,1 48720,0 48767,1 48775,0 48805,1 48820,0 48881,1 48961,0 48990,1 49080,0 49122,1 49164,0 49215,1 49308,0 49384,1 49468,0 49484,1 49485,0 49549,1 49591,0 49595,1 49669,0 49764,1 49781,0 49838,1 49868,0 49886,1 49932,0 49957,1 50020,0 50105,1 50167,0 50196,1 50259,0 50283,1 50373,0 50466,1 50551,0 50612,1 50685,0 50734,1 50803,0 50813,1 50906,0 50928,1 50955,0 50987,1 51003,0 51066,1 51140,0 51195,1 51254,0 51273,1 51313,0 51398,1 51426,0 51442,1 51450,0 51543,1 51567,0 51580,1 51680,0 51710,1 51744,0 51824,1 51827,0 51893,1 51903,0 51996,1 52023,0 52025,1 end initlist c31 0,0 75,1 170,0 226,1 265,0 333,1 367,0 411,1 504,0 516,1 520,0 615,1 691,0 771,1 812,0 898,1 947,0 1005,1 1056,0 1070,1 1102,0 1170,1 1225,0 1231,1 1258,0 1303,1 1388,0 1455,1 1494,0 1531,1 1619,0 1672,1 1770,0 1869,1 1876,0 1913,1 1969,0 1999,1 2044,0 2083,1 2103,0 2168,1 2194,0 2273,1 2362,0 2380,1 2395,0 2411,1 2494,0 2590,1 2682,0 2752,1 2784,0 2847,1 2923,0 3017,1 3026,0 3031,1 3115,0 3212,1 3251,0 3283,1 3334,0 3409,1 3415,0 3463,1 3529,0 3613,1 3615,0 3638,1 3658,0 3706,1 3795,0 3879,1 3976,0 4052,1 4071,0 4105,1 4153,0 4246,1 4259,0 4319,1 4347,0 4432,1 4447,0 4501,1 4540,0 4618,1 4641,0 4685,1 4777,0 4821,1 4859,0 4861,1 4942,0 5001,1 5081,0 5106,1 5156,0 5201,1 5247,0 5338,1 5394,0 5425,1 5457,0 5545,1 5616,0 5688,1 5782,0 5860,1 5895,0 5916,1 5961,0 6042,1 6120,0 6206,1 6268,0 6346,1 6414,0 6446,1 6541,0 6627,1 6629,0 6675,1 6759,0 6803,1 6806,0 6850,1 6927,0 6930,1 7022,0 7047,1 7057,0 7069,1 7118,0 7145,1 7233,0 7303,1 7350,0 7428,1 7495,0 7553,1 7643,0 7657,1 7733,0 7799,1 7814,0 7861,1 7953,0 7970,1 7998,0 8060,1 8084,0 8101,1 8191,0 8224,1 8226,0 8281,1 8378,0 8459,1 8494,0 8592,1 8610,0 8688,1 8750,0 8850,1 8912,0 8956,1 9054,0 9143,1 9220,0 9274,1 9334,0 9431,1 9470,0 9488,1 9502,0 9602,1 9668,0 9735,1 9771,0 9827,1 9861,0 9889,1 9925,0 9927,1 9992,0 10086,1 10144,0 10180,1 10191,0 10235,1 10334,0 10344,1 10429,0 10520,1 10550,0 10569,1 10604,0 10636,1 10732,0 10753,1 10788,0 10812,1 10814,0 10818,1 10835,0 10859,1 10919,0 10951,1 11013,0 11070,1 11117,0 11190,1 11218,0 11294,1 11374,0 11376,1 11406,0 11452,1 11466,0 11523,1 11532,0 11592,1 11615,0 11681,1 11776,0 11848,1 11928,0 11997,1 12087,0 12174,1 12229,0 12278,1 12297,0 12326,1 12408,0 12445,1 12469,0 12492,1 12499,0 12595,1 12665,0 12732,1 12741,0 12766,1 12845,0 12873,1 12958,0 12994,1 13085,0 13162,1 13219,0 13240,1 13338,0 13340,1 13358,0 13389,1 13405,0 13442,1 13452,0 13537,1 13622,0 13657,1 13683,0 13700,1 13735,0 13797,1 13892,0 13976,1 14071,0 14127,1 14214,0 14227,1 14298,0 14316,1 14405,0 14481,1 14530,0 14603,1 14645,0 14682,1 14748,0 14848,1 14863,0 14945,1 15041,0 15050,1 15130,0 15150,1 15220,0 15222,1 15244,0 15341,1 15404,0 15450,1 15479,0 15579,1 15672,0 15723,1 15731,0 15764,1 15783,0 15795,1 15840,0 15876,1 15897,0 15980,1 16052,0 16060,1 16145,0 16165,1 16234,0 16296,1 16343,0 16408,1 16448,0 16515,1 16589,0 16660,1 16715,0 16792,1 16829,0 16893,1 16986,0 17003,1 17044,0 17083,1 17128,0 17189,1 17190,0 17207,1 17220,0 17277,1 17348,0 17362,1 17425,0 17497,1 17550,0 17626,1 17679,0 17762,1 17839,0 17896,1 17985,0 18079,1 18149,0 18236,1 18329,0 18382,1 18418,0 18452,1 18544,0 18604,1 18624,0 18723,1 18760,0 18842,1 18847,0 18853,1 18902,0 18917,1 18981,0 19067,1 19074,0 19166,1 19169,0 19223,1 19225,0 19265,1 19340,0 19414,1 19425,0 19518,1 19560,0 19626,1 19713,0 19807,1 19832,0 19871,1 19951,0 19996,1 20081,0 20155,1 20188,0 20274,1 20301,0 20344,1 20404,0 20423,1 20465,0 20492,1 20543,0 20621,1 20700,0 20771,1 20823,0 20855,1 20900,0 20920,1 21020,0 21039,1 21137,0 21200,1 21225,0 21268,1 21340,0 21381,1 21470,0 21516,1 21597,0 21650,1 21749,0 21759,1 21775,0 21864,1 21951,0 22040,1 22058,0 22147,1 22151,0 22223,1 22295,0 22307,1 22387,0 22417,1 22459,0 22468,1 22532,0 22544,1 22598,0 22665,1 22749,0 22772,1 22831,0 22840,1 22934,0 22972,1 22982,0 23051,1 23070,0 23130,1 23181,0 23271,1 23310,0 23321,1 23417,0 23480,1 23521,0 23552,1 23615,0 23685,1 23778,0 23826,1 23849,0 23873,1 23943,0 23996,1 24039,0 24110,1 24198,0 24208,1 24294,0 24378,1 24425,0 24495,1 24580,0 24631,1 24715,0 24717,1 24809,0 24820,1 24894,0 24949,1 25019,0 25035,1 25119,0 25219,1 25295,0 25342,1 25401,0 25431,1 25501,0 25558,1 25617,0 25645,1 25650,0 25692,1 25781,0 25874,1 25955,0 25977,1 26073,0 26108,1 26122,0 26124,1 26153,0 26227,1 26263,0 26297,1 26377,0 26470,1 26477,0 26527,1 26603,0 26612,1 26627,0 26672,1 26743,0 26751,1 26837,0 26847,1 26862,0 26906,1 26925,0 26968,1 27039,0 27134,1 27160,0 27251,1 27329,0 27417,1 27476,0 27535,1 27603,0 27642,1 27703,0 27802,1 27866,0 27900,1 27906,0 27946,1 28022,0 28073,1 28112,0 28141,1 28189,0 28277,1 28311,0 28408,1 28466,0 28560,1 28626,0 28632,1 28645,0 28712,1 28784,0 28824,1 28873,0 28896,1 28905,0 28923,1 28949,0 28979,1 28984,0 29078,1 29080,0 29090,1 29178,0 29227,1 29264,0 29313,1 29405,0 29480,1 29535,0 29586,1 29602,0 29666,1 29730,0 29765,1 29790,0 29803,1 29846,0 29939,1 30015,0 30032,1 30077,0 30155,1 30240,0 30304,1 30385,0 30477,1 30524,0 30563,1 30617,0 30702,1 30773,0 30798,1 30805,0 30901,1 30993,0 31053,1 31056,0 31079,1 31099,0 31157,1 31172,0 31253,1 31290,0 31341,1 31359,0 31411,1 31427,0 31515,1 31600,0 31624,1 31665,0 31674,1 31707,0 31720,1 31814,0 31851,1 31865,0 31921,1 31982,0 32008,1 32049,0 32093,1 32150,0 32184,1 32209,0 32308,1 32370,0 32438,1 32456,0 32457,1 32509,0 32563,1 32651,0 32674,1 32696,0 32731,1 32808,0 32836,1 32930,0 32993,1 33082,0 33174,1 33255,0 33314,1 33324,0 33405,1 33418,0 33485,1 33548,0 33591,1 33689,0 33760,1 33812,0 33861,1 33875,0 33966,1 33995,0 34001,1 34043,0 34051,1 34079,0 34169,1 34200,0 34207,1 34306,0 34378,1 34403,0 34484,1 34530,0 34594,1 34639,0 34672,1 34761,0 34815,1 34886,0 34887,1 34970,0 34974,1 35066,0 35120,1 35206,0 35207,1 35239,0 35319,1 35336,0 35368,1 35441,0 35520,1 35575,0 35668,1 35718,0 35766,1 35839,0 35861,1 35884,0 35919,1 35940,0 35980,1 36054,0 36066,1 36082,0 36133,1 36170,0 36188,1 36274,0 36352,1 36439,0 36483,1 36520,0 36524,1 36617,0 36687,1 36761,0 36841,1 36843,0 36895,1 36995,0 37026,1 37076,0 37092,1 37107,0 37171,1 37187,0 37188,1 37240,0 37328,1 37419,0 37429,1 37494,0 37504,1 37585,0 37624,1 37654,0 37690,1 37699,0 37742,1 37839,0 37906,1 37988,0 37989,1 38011,0 38023,1 38059,0 38124,1 38142,0 38210,1 38261,0 38352,1 38383,0 38416,1 38498,0 38513,1 38552,0 38613,1 38675,0 38765,1 38859,0 38880,1 38940,0 39040,1 39115,0 39189,1 39259,0 39319,1 39349,0 39392,1 39402,0 39488,1 39540,0 39614,1 39663,0 39664,1 39745,0 39773,1 39818,0 39869,1 39948,0 39994,1 40003,0 40099,1 40121,0 40198,1 40231,0 40256,1 40349,0 40354,1 40356,0 40362,1 40363,0 40419,1 40444,0 40447,1 40500,0 40519,1 40594,0 40652,1 40666,0 40755,1 40799,0 40833,1 40933,0 41015,1 41031,0 41036,1 41092,0 41184,1 41259,0 41264,1 41305,0 41313,1 41387,0 41468,1 41511,0 41607,1 41640,0 41659,1 41692,0 41713,1 41811,0 41821,1 41912,0 41934,1 41983,0 42022,1 42109,0 42201,1 42266,0 42330,1 42416,0 42460,1 42521,0 42527,1 42598,0 42677,1 42699,0 42798,1 42836,0 42858,1 42900,0 42955,1 43024,0 43124,1 43161,0 43245,1 43336,0 43350,1 43442,0 43506,1 43542,0 43625,1 43645,0 43669,1 43678,0 43710,1 43800,0 43838,1 43849,0 43874,1 43907,0 43920,1 43931,0 44025,1 44081,0 44167,1 44206,0 44299,1 44326,0 44334,1 44335,0 44383,1 44404,0 44487,1 44529,0 44550,1 44649,0 44651,1 44658,0 44736,1 44776,0 44805,1 44870,0 44911,1 44982,0 45057,1 45102,0 45189,1 45221,0 45298,1 45368,0 45397,1 45408,0 45479,1 45537,0 45584,1 45598,0 45619,1 45665,0 45691,1 45699,0 45775,1 45848,0 45868,1 45926,0 45941,1 46041,0 46087,1 46128,0 46135,1 46234,0 46291,1 46337,0 46420,1 46423,0 46504,1 46516,0 46543,1 46566,0 46653,1 46698,0 46719,1 46732,0 46779,1 46826,0 46886,1 46947,0 46985,1 47048,0 47078,1 47102,0 47142,1 47228,0 47289,1 47378,0 47399,1 47450,0 47473,1 47536,0 47542,1 47628,0 47725,1 47729,0 47793,1 47854,0 47887,1 47921,0 47976,1 48029,0 48087,1 48172,0 48233,1 48273,0 48288,1 48382,0 48470,1 48484,0 48529,1 48579,0 48656,1 48729,0 48807,1 48883,0 48938,1 48973,0 48983,1 49068,0 49098,1 49135,0 49147,1 49208,0 49303,1 49307,0 49337,1 49395,0 49442,1 49483,0 49524,1 49612,0 49659,1 49703,0 49737,1 49789,0 49877,1 49937,0 50006,1 50011,0 50016,1 50101,0 50119,1 50133,0 50139,1 50202,0 50263,1 50327,0 50419,1 50445,0 50487,1 50565,0 50578,1 50629,0 50657,1 50693,0 50723,1 50741,0 50820,1 50828,0 50838,1 end outputs s0, s1, s2, s3, s4, s5, s6, s7, s8, s9, s10, s11, s12, s13, s14, s15, s16, s17, s18, s19, s20, s21, s22, s23, s24, s25, s26, s27, s28, s29, s30, s31 t0, t1, t2, t3, t4, t5, t6, t7, t8, t9, t10, t11, t12, t13, t14, t15, t16, t17, t18, t19, t20, t21, t22, t23, t24, t25, t26, t27, t28, t29, t30, t31 end outvalues s0 1, s1 1, s2 1, s3 1, s4 1, s5 1, s6 1, s7 1, s8 1, s9 1, s10 1, s11 1, s12 1, s13 1, s14 1, s15 1, s16 1, s17 1, s18 1, s19 1, s20 1, s21 1, s22 1, s23 1, s24 1, s25 1, s26 1, s27 1, s28 1, s29 1, s30 1, s31 1, t0 1, t1 1, t2 1, t3 1, t4 1, t5 1, t6 1, t7 1, t8 1, t9 1, t10 1, t11 1, t12 1, t13 1, t14 1, t15 1, t16 1, t17 1, t18 1, t19 1, t20 1, t21 1, t22 1, t23 1, t24 1, t25 1, t26 1, t27 1, t28 1, t29 1, t30 1, t31 1, end netlist inv(a0n,a0)#4 inv(b0n,b0)#4 inv(c0n,c0)#4 and2(a0nb0n,a0n,b0n)#2 and2(a0nb0,a0n,b0)#2 and2(a0b0n,a0,b0n)#2 and2(a0b0,a0,b0)#3 and2(a0b0c0,a0b0,c0)#2 and2(a0nb0nc0,a0nb0n,c0)#2 and2(a0nb0c0n,a0nb0,c0n)#2 and2(a0b0nc0n,a0b0n,c0n)#2 and2(b0c0,b0,c0)#2 and2(a0c0,c0,a0)#2 or2(s0w42,a0b0nc0n,a0nb0c0n)#3 or2(s0w71,a0b0c0, a0nb0nc0)#3 or2(s0,s0w42,s0w71)#3 or2(s0w35, b0c0, a0c0)#3 or2(t0,s0w35,a0b0)#5 end netlist inv(a1n,a1)#4 inv(b1n,b1)#4 inv(c1n,c1)#4 and2(a1nb1n,a1n,b1n)#2 and2(a1nb1,a1n,b1)#2 and2(a1b1n,a1,b1n)#2 and2(a1b1,a1,b1)#3 and2(a1b1c1,a1b1,c1)#2 and2(a1nb1nc1,a1nb1n,c1)#2 and2(a1nb1c1n,a1nb1,c1n)#2 and2(a1b1nc1n,a1b1n,c1n)#2 and2(b1c1,b1,c1)#2 and2(a1c1,c1,a1)#2 or2(s1w42,a1b1nc1n,a1nb1c1n)#3 or2(s1w71,a1b1c1, a1nb1nc1)#3 or2(s1,s1w42,s1w71)#3 or2(s1w35, b1c1, a1c1)#3 or2(t1,s1w35,a1b1)#5 end netlist inv(a2n,a2)#4 inv(b2n,b2)#4 inv(c2n,c2)#4 and2(a2nb2n,a2n,b2n)#2 and2(a2nb2,a2n,b2)#2 and2(a2b2n,a2,b2n)#2 and2(a2b2,a2,b2)#3 and2(a2b2c2,a2b2,c2)#2 and2(a2nb2nc2,a2nb2n,c2)#2 and2(a2nb2c2n,a2nb2,c2n)#2 and2(a2b2nc2n,a2b2n,c2n)#2 and2(b2c2,b2,c2)#2 and2(a2c2,c2,a2)#2 or2(s2w42,a2b2nc2n,a2nb2c2n)#3 or2(s2w71,a2b2c2, a2nb2nc2)#3 or2(s2,s2w42,s2w71)#3 or2(s2w35, b2c2, a2c2)#3 or2(t2,s2w35,a2b2)#5 end netlist inv(a3n,a3)#4 inv(b3n,b3)#4 inv(c3n,c3)#4 and2(a3nb3n,a3n,b3n)#2 and2(a3nb3,a3n,b3)#2 and2(a3b3n,a3,b3n)#2 and2(a3b3,a3,b3)#3 and2(a3b3c3,a3b3,c3)#2 and2(a3nb3nc3,a3nb3n,c3)#2 and2(a3nb3c3n,a3nb3,c3n)#2 and2(a3b3nc3n,a3b3n,c3n)#2 and2(b3c3,b3,c3)#2 and2(a3c3,c3,a3)#2 or2(s3w42,a3b3nc3n,a3nb3c3n)#3 or2(s3w71,a3b3c3, a3nb3nc3)#3 or2(s3,s3w42,s3w71)#3 or2(s3w35, b3c3, a3c3)#3 or2(t3,s3w35,a3b3)#5 end netlist inv(a4n,a4)#4 inv(b4n,b4)#4 inv(c4n,c4)#4 and2(a4nb4n,a4n,b4n)#2 and2(a4nb4,a4n,b4)#2 and2(a4b4n,a4,b4n)#2 and2(a4b4,a4,b4)#3 and2(a4b4c4,a4b4,c4)#2 and2(a4nb4nc4,a4nb4n,c4)#2 and2(a4nb4c4n,a4nb4,c4n)#2 and2(a4b4nc4n,a4b4n,c4n)#2 and2(b4c4,b4,c4)#2 and2(a4c4,c4,a4)#2 or2(s4w42,a4b4nc4n,a4nb4c4n)#3 or2(s4w71,a4b4c4, a4nb4nc4)#3 or2(s4,s4w42,s4w71)#3 or2(s4w35, b4c4, a4c4)#3 or2(t4,s4w35,a4b4)#5 end netlist inv(a5n,a5)#4 inv(b5n,b5)#4 inv(c5n,c5)#4 and2(a5nb5n,a5n,b5n)#2 and2(a5nb5,a5n,b5)#2 and2(a5b5n,a5,b5n)#2 and2(a5b5,a5,b5)#3 and2(a5b5c5,a5b5,c5)#2 and2(a5nb5nc5,a5nb5n,c5)#2 and2(a5nb5c5n,a5nb5,c5n)#2 and2(a5b5nc5n,a5b5n,c5n)#2 and2(b5c5,b5,c5)#2 and2(a5c5,c5,a5)#2 or2(s5w42,a5b5nc5n,a5nb5c5n)#3 or2(s5w71,a5b5c5, a5nb5nc5)#3 or2(s5,s5w42,s5w71)#3 or2(s5w35, b5c5, a5c5)#3 or2(t5,s5w35,a5b5)#5 end netlist inv(a6n,a6)#4 inv(b6n,b6)#4 inv(c6n,c6)#4 and2(a6nb6n,a6n,b6n)#2 and2(a6nb6,a6n,b6)#2 and2(a6b6n,a6,b6n)#2 and2(a6b6,a6,b6)#3 and2(a6b6c6,a6b6,c6)#2 and2(a6nb6nc6,a6nb6n,c6)#2 and2(a6nb6c6n,a6nb6,c6n)#2 and2(a6b6nc6n,a6b6n,c6n)#2 and2(b6c6,b6,c6)#2 and2(a6c6,c6,a6)#2 or2(s6w42,a6b6nc6n,a6nb6c6n)#3 or2(s6w71,a6b6c6, a6nb6nc6)#3 or2(s6,s6w42,s6w71)#3 or2(s6w35, b6c6, a6c6)#3 or2(t6,s6w35,a6b6)#5 end netlist inv(a7n,a7)#4 inv(b7n,b7)#4 inv(c7n,c7)#4 and2(a7nb7n,a7n,b7n)#2 and2(a7nb7,a7n,b7)#2 and2(a7b7n,a7,b7n)#2 and2(a7b7,a7,b7)#3 and2(a7b7c7,a7b7,c7)#2 and2(a7nb7nc7,a7nb7n,c7)#2 and2(a7nb7c7n,a7nb7,c7n)#2 and2(a7b7nc7n,a7b7n,c7n)#2 and2(b7c7,b7,c7)#2 and2(a7c7,c7,a7)#2 or2(s7w42,a7b7nc7n,a7nb7c7n)#3 or2(s7w71,a7b7c7, a7nb7nc7)#3 or2(s7,s7w42,s7w71)#3 or2(s7w35, b7c7, a7c7)#3 or2(t7,s7w35,a7b7)#5 end netlist inv(a8n,a8)#4 inv(b8n,b8)#4 inv(c8n,c8)#4 and2(a8nb8n,a8n,b8n)#2 and2(a8nb8,a8n,b8)#2 and2(a8b8n,a8,b8n)#2 and2(a8b8,a8,b8)#3 and2(a8b8c8,a8b8,c8)#2 and2(a8nb8nc8,a8nb8n,c8)#2 and2(a8nb8c8n,a8nb8,c8n)#2 and2(a8b8nc8n,a8b8n,c8n)#2 and2(b8c8,b8,c8)#2 and2(a8c8,c8,a8)#2 or2(s8w42,a8b8nc8n,a8nb8c8n)#3 or2(s8w71,a8b8c8, a8nb8nc8)#3 or2(s8,s8w42,s8w71)#3 or2(s8w35, b8c8, a8c8)#3 or2(t8,s8w35,a8b8)#5 end netlist inv(a9n,a9)#4 inv(b9n,b9)#4 inv(c9n,c9)#4 and2(a9nb9n,a9n,b9n)#2 and2(a9nb9,a9n,b9)#2 and2(a9b9n,a9,b9n)#2 and2(a9b9,a9,b9)#3 and2(a9b9c9,a9b9,c9)#2 and2(a9nb9nc9,a9nb9n,c9)#2 and2(a9nb9c9n,a9nb9,c9n)#2 and2(a9b9nc9n,a9b9n,c9n)#2 and2(b9c9,b9,c9)#2 and2(a9c9,c9,a9)#2 or2(s9w42,a9b9nc9n,a9nb9c9n)#3 or2(s9w71,a9b9c9, a9nb9nc9)#3 or2(s9,s9w42,s9w71)#3 or2(s9w35, b9c9, a9c9)#3 or2(t9,s9w35,a9b9)#5 end netlist inv(a10n,a10)#4 inv(b10n,b10)#4 inv(c10n,c10)#4 and2(a10nb10n,a10n,b10n)#2 and2(a10nb10,a10n,b10)#2 and2(a10b10n,a10,b10n)#2 and2(a10b10,a10,b10)#3 and2(a10b10c10,a10b10,c10)#2 and2(a10nb10nc10,a10nb10n,c10)#2 and2(a10nb10c10n,a10nb10,c10n)#2 and2(a10b10nc10n,a10b10n,c10n)#2 and2(b10c10,b10,c10)#2 and2(a10c10,c10,a10)#2 or2(s10w42,a10b10nc10n,a10nb10c10n)#3 or2(s10w71,a10b10c10, a10nb10nc10)#3 or2(s10,s10w42,s10w71)#3 or2(s10w35, b10c10, a10c10)#3 or2(t10,s10w35,a10b10)#5 end netlist inv(a11n,a11)#4 inv(b11n,b11)#4 inv(c11n,c11)#4 and2(a11nb11n,a11n,b11n)#2 and2(a11nb11,a11n,b11)#2 and2(a11b11n,a11,b11n)#2 and2(a11b11,a11,b11)#3 and2(a11b11c11,a11b11,c11)#2 and2(a11nb11nc11,a11nb11n,c11)#2 and2(a11nb11c11n,a11nb11,c11n)#2 and2(a11b11nc11n,a11b11n,c11n)#2 and2(b11c11,b11,c11)#2 and2(a11c11,c11,a11)#2 or2(s11w42,a11b11nc11n,a11nb11c11n)#3 or2(s11w71,a11b11c11, a11nb11nc11)#3 or2(s11,s11w42,s11w71)#3 or2(s11w35, b11c11, a11c11)#3 or2(t11,s11w35,a11b11)#5 end netlist inv(a12n,a12)#4 inv(b12n,b12)#4 inv(c12n,c12)#4 and2(a12nb12n,a12n,b12n)#2 and2(a12nb12,a12n,b12)#2 and2(a12b12n,a12,b12n)#2 and2(a12b12,a12,b12)#3 and2(a12b12c12,a12b12,c12)#2 and2(a12nb12nc12,a12nb12n,c12)#2 and2(a12nb12c12n,a12nb12,c12n)#2 and2(a12b12nc12n,a12b12n,c12n)#2 and2(b12c12,b12,c12)#2 and2(a12c12,c12,a12)#2 or2(s12w42,a12b12nc12n,a12nb12c12n)#3 or2(s12w71,a12b12c12, a12nb12nc12)#3 or2(s12,s12w42,s12w71)#3 or2(s12w35, b12c12, a12c12)#3 or2(t12,s12w35,a12b12)#5 end netlist inv(a13n,a13)#4 inv(b13n,b13)#4 inv(c13n,c13)#4 and2(a13nb13n,a13n,b13n)#2 and2(a13nb13,a13n,b13)#2 and2(a13b13n,a13,b13n)#2 and2(a13b13,a13,b13)#3 and2(a13b13c13,a13b13,c13)#2 and2(a13nb13nc13,a13nb13n,c13)#2 and2(a13nb13c13n,a13nb13,c13n)#2 and2(a13b13nc13n,a13b13n,c13n)#2 and2(b13c13,b13,c13)#2 and2(a13c13,c13,a13)#2 or2(s13w42,a13b13nc13n,a13nb13c13n)#3 or2(s13w71,a13b13c13, a13nb13nc13)#3 or2(s13,s13w42,s13w71)#3 or2(s13w35, b13c13, a13c13)#3 or2(t13,s13w35,a13b13)#5 end netlist inv(a14n,a14)#4 inv(b14n,b14)#4 inv(c14n,c14)#4 and2(a14nb14n,a14n,b14n)#2 and2(a14nb14,a14n,b14)#2 and2(a14b14n,a14,b14n)#2 and2(a14b14,a14,b14)#3 and2(a14b14c14,a14b14,c14)#2 and2(a14nb14nc14,a14nb14n,c14)#2 and2(a14nb14c14n,a14nb14,c14n)#2 and2(a14b14nc14n,a14b14n,c14n)#2 and2(b14c14,b14,c14)#2 and2(a14c14,c14,a14)#2 or2(s14w42,a14b14nc14n,a14nb14c14n)#3 or2(s14w71,a14b14c14, a14nb14nc14)#3 or2(s14,s14w42,s14w71)#3 or2(s14w35, b14c14, a14c14)#3 or2(t14,s14w35,a14b14)#5 end netlist inv(a15n,a15)#4 inv(b15n,b15)#4 inv(c15n,c15)#4 and2(a15nb15n,a15n,b15n)#2 and2(a15nb15,a15n,b15)#2 and2(a15b15n,a15,b15n)#2 and2(a15b15,a15,b15)#3 and2(a15b15c15,a15b15,c15)#2 and2(a15nb15nc15,a15nb15n,c15)#2 and2(a15nb15c15n,a15nb15,c15n)#2 and2(a15b15nc15n,a15b15n,c15n)#2 and2(b15c15,b15,c15)#2 and2(a15c15,c15,a15)#2 or2(s15w42,a15b15nc15n,a15nb15c15n)#3 or2(s15w71,a15b15c15, a15nb15nc15)#3 or2(s15,s15w42,s15w71)#3 or2(s15w35, b15c15, a15c15)#3 or2(t15,s15w35,a15b15)#5 end netlist inv(a16n,a16)#4 inv(b16n,b16)#4 inv(c16n,c16)#4 and2(a16nb16n,a16n,b16n)#2 and2(a16nb16,a16n,b16)#2 and2(a16b16n,a16,b16n)#2 and2(a16b16,a16,b16)#3 and2(a16b16c16,a16b16,c16)#2 and2(a16nb16nc16,a16nb16n,c16)#2 and2(a16nb16c16n,a16nb16,c16n)#2 and2(a16b16nc16n,a16b16n,c16n)#2 and2(b16c16,b16,c16)#2 and2(a16c16,c16,a16)#2 or2(s16w42,a16b16nc16n,a16nb16c16n)#3 or2(s16w71,a16b16c16, a16nb16nc16)#3 or2(s16,s16w42,s16w71)#3 or2(s16w35, b16c16, a16c16)#3 or2(t16,s16w35,a16b16)#5 end netlist inv(a17n,a17)#4 inv(b17n,b17)#4 inv(c17n,c17)#4 and2(a17nb17n,a17n,b17n)#2 and2(a17nb17,a17n,b17)#2 and2(a17b17n,a17,b17n)#2 and2(a17b17,a17,b17)#3 and2(a17b17c17,a17b17,c17)#2 and2(a17nb17nc17,a17nb17n,c17)#2 and2(a17nb17c17n,a17nb17,c17n)#2 and2(a17b17nc17n,a17b17n,c17n)#2 and2(b17c17,b17,c17)#2 and2(a17c17,c17,a17)#2 or2(s17w42,a17b17nc17n,a17nb17c17n)#3 or2(s17w71,a17b17c17, a17nb17nc17)#3 or2(s17,s17w42,s17w71)#3 or2(s17w35, b17c17, a17c17)#3 or2(t17,s17w35,a17b17)#5 end netlist inv(a18n,a18)#4 inv(b18n,b18)#4 inv(c18n,c18)#4 and2(a18nb18n,a18n,b18n)#2 and2(a18nb18,a18n,b18)#2 and2(a18b18n,a18,b18n)#2 and2(a18b18,a18,b18)#3 and2(a18b18c18,a18b18,c18)#2 and2(a18nb18nc18,a18nb18n,c18)#2 and2(a18nb18c18n,a18nb18,c18n)#2 and2(a18b18nc18n,a18b18n,c18n)#2 and2(b18c18,b18,c18)#2 and2(a18c18,c18,a18)#2 or2(s18w42,a18b18nc18n,a18nb18c18n)#3 or2(s18w71,a18b18c18, a18nb18nc18)#3 or2(s18,s18w42,s18w71)#3 or2(s18w35, b18c18, a18c18)#3 or2(t18,s18w35,a18b18)#5 end netlist inv(a19n,a19)#4 inv(b19n,b19)#4 inv(c19n,c19)#4 and2(a19nb19n,a19n,b19n)#2 and2(a19nb19,a19n,b19)#2 and2(a19b19n,a19,b19n)#2 and2(a19b19,a19,b19)#3 and2(a19b19c19,a19b19,c19)#2 and2(a19nb19nc19,a19nb19n,c19)#2 and2(a19nb19c19n,a19nb19,c19n)#2 and2(a19b19nc19n,a19b19n,c19n)#2 and2(b19c19,b19,c19)#2 and2(a19c19,c19,a19)#2 or2(s19w42,a19b19nc19n,a19nb19c19n)#3 or2(s19w71,a19b19c19, a19nb19nc19)#3 or2(s19,s19w42,s19w71)#3 or2(s19w35, b19c19, a19c19)#3 or2(t19,s19w35,a19b19)#5 end netlist inv(a20n,a20)#4 inv(b20n,b20)#4 inv(c20n,c20)#4 and2(a20nb20n,a20n,b20n)#2 and2(a20nb20,a20n,b20)#2 and2(a20b20n,a20,b20n)#2 and2(a20b20,a20,b20)#3 and2(a20b20c20,a20b20,c20)#2 and2(a20nb20nc20,a20nb20n,c20)#2 and2(a20nb20c20n,a20nb20,c20n)#2 and2(a20b20nc20n,a20b20n,c20n)#2 and2(b20c20,b20,c20)#2 and2(a20c20,c20,a20)#2 or2(s20w42,a20b20nc20n,a20nb20c20n)#3 or2(s20w71,a20b20c20, a20nb20nc20)#3 or2(s20,s20w42,s20w71)#3 or2(s20w35, b20c20, a20c20)#3 or2(t20,s20w35,a20b20)#5 end netlist inv(a21n,a21)#4 inv(b21n,b21)#4 inv(c21n,c21)#4 and2(a21nb21n,a21n,b21n)#2 and2(a21nb21,a21n,b21)#2 and2(a21b21n,a21,b21n)#2 and2(a21b21,a21,b21)#3 and2(a21b21c21,a21b21,c21)#2 and2(a21nb21nc21,a21nb21n,c21)#2 and2(a21nb21c21n,a21nb21,c21n)#2 and2(a21b21nc21n,a21b21n,c21n)#2 and2(b21c21,b21,c21)#2 and2(a21c21,c21,a21)#2 or2(s21w42,a21b21nc21n,a21nb21c21n)#3 or2(s21w71,a21b21c21, a21nb21nc21)#3 or2(s21,s21w42,s21w71)#3 or2(s21w35, b21c21, a21c21)#3 or2(t21,s21w35,a21b21)#5 end netlist inv(a22n,a22)#4 inv(b22n,b22)#4 inv(c22n,c22)#4 and2(a22nb22n,a22n,b22n)#2 and2(a22nb22,a22n,b22)#2 and2(a22b22n,a22,b22n)#2 and2(a22b22,a22,b22)#3 and2(a22b22c22,a22b22,c22)#2 and2(a22nb22nc22,a22nb22n,c22)#2 and2(a22nb22c22n,a22nb22,c22n)#2 and2(a22b22nc22n,a22b22n,c22n)#2 and2(b22c22,b22,c22)#2 and2(a22c22,c22,a22)#2 or2(s22w42,a22b22nc22n,a22nb22c22n)#3 or2(s22w71,a22b22c22, a22nb22nc22)#3 or2(s22,s22w42,s22w71)#3 or2(s22w35, b22c22, a22c22)#3 or2(t22,s22w35,a22b22)#5 end netlist inv(a23n,a23)#4 inv(b23n,b23)#4 inv(c23n,c23)#4 and2(a23nb23n,a23n,b23n)#2 and2(a23nb23,a23n,b23)#2 and2(a23b23n,a23,b23n)#2 and2(a23b23,a23,b23)#3 and2(a23b23c23,a23b23,c23)#2 and2(a23nb23nc23,a23nb23n,c23)#2 and2(a23nb23c23n,a23nb23,c23n)#2 and2(a23b23nc23n,a23b23n,c23n)#2 and2(b23c23,b23,c23)#2 and2(a23c23,c23,a23)#2 or2(s23w42,a23b23nc23n,a23nb23c23n)#3 or2(s23w71,a23b23c23, a23nb23nc23)#3 or2(s23,s23w42,s23w71)#3 or2(s23w35, b23c23, a23c23)#3 or2(t23,s23w35,a23b23)#5 end netlist inv(a24n,a24)#4 inv(b24n,b24)#4 inv(c24n,c24)#4 and2(a24nb24n,a24n,b24n)#2 and2(a24nb24,a24n,b24)#2 and2(a24b24n,a24,b24n)#2 and2(a24b24,a24,b24)#3 and2(a24b24c24,a24b24,c24)#2 and2(a24nb24nc24,a24nb24n,c24)#2 and2(a24nb24c24n,a24nb24,c24n)#2 and2(a24b24nc24n,a24b24n,c24n)#2 and2(b24c24,b24,c24)#2 and2(a24c24,c24,a24)#2 or2(s24w42,a24b24nc24n,a24nb24c24n)#3 or2(s24w71,a24b24c24, a24nb24nc24)#3 or2(s24,s24w42,s24w71)#3 or2(s24w35, b24c24, a24c24)#3 or2(t24,s24w35,a24b24)#5 end netlist inv(a25n,a25)#4 inv(b25n,b25)#4 inv(c25n,c25)#4 and2(a25nb25n,a25n,b25n)#2 and2(a25nb25,a25n,b25)#2 and2(a25b25n,a25,b25n)#2 and2(a25b25,a25,b25)#3 and2(a25b25c25,a25b25,c25)#2 and2(a25nb25nc25,a25nb25n,c25)#2 and2(a25nb25c25n,a25nb25,c25n)#2 and2(a25b25nc25n,a25b25n,c25n)#2 and2(b25c25,b25,c25)#2 and2(a25c25,c25,a25)#2 or2(s25w42,a25b25nc25n,a25nb25c25n)#3 or2(s25w71,a25b25c25, a25nb25nc25)#3 or2(s25,s25w42,s25w71)#3 or2(s25w35, b25c25, a25c25)#3 or2(t25,s25w35,a25b25)#5 end netlist inv(a26n,a26)#4 inv(b26n,b26)#4 inv(c26n,c26)#4 and2(a26nb26n,a26n,b26n)#2 and2(a26nb26,a26n,b26)#2 and2(a26b26n,a26,b26n)#2 and2(a26b26,a26,b26)#3 and2(a26b26c26,a26b26,c26)#2 and2(a26nb26nc26,a26nb26n,c26)#2 and2(a26nb26c26n,a26nb26,c26n)#2 and2(a26b26nc26n,a26b26n,c26n)#2 and2(b26c26,b26,c26)#2 and2(a26c26,c26,a26)#2 or2(s26w42,a26b26nc26n,a26nb26c26n)#3 or2(s26w71,a26b26c26, a26nb26nc26)#3 or2(s26,s26w42,s26w71)#3 or2(s26w35, b26c26, a26c26)#3 or2(t26,s26w35,a26b26)#5 end netlist inv(a27n,a27)#4 inv(b27n,b27)#4 inv(c27n,c27)#4 and2(a27nb27n,a27n,b27n)#2 and2(a27nb27,a27n,b27)#2 and2(a27b27n,a27,b27n)#2 and2(a27b27,a27,b27)#3 and2(a27b27c27,a27b27,c27)#2 and2(a27nb27nc27,a27nb27n,c27)#2 and2(a27nb27c27n,a27nb27,c27n)#2 and2(a27b27nc27n,a27b27n,c27n)#2 and2(b27c27,b27,c27)#2 and2(a27c27,c27,a27)#2 or2(s27w42,a27b27nc27n,a27nb27c27n)#3 or2(s27w71,a27b27c27, a27nb27nc27)#3 or2(s27,s27w42,s27w71)#3 or2(s27w35, b27c27, a27c27)#3 or2(t27,s27w35,a27b27)#5 end netlist inv(a28n,a28)#4 inv(b28n,b28)#4 inv(c28n,c28)#4 and2(a28nb28n,a28n,b28n)#2 and2(a28nb28,a28n,b28)#2 and2(a28b28n,a28,b28n)#2 and2(a28b28,a28,b28)#3 and2(a28b28c28,a28b28,c28)#2 and2(a28nb28nc28,a28nb28n,c28)#2 and2(a28nb28c28n,a28nb28,c28n)#2 and2(a28b28nc28n,a28b28n,c28n)#2 and2(b28c28,b28,c28)#2 and2(a28c28,c28,a28)#2 or2(s28w42,a28b28nc28n,a28nb28c28n)#3 or2(s28w71,a28b28c28, a28nb28nc28)#3 or2(s28,s28w42,s28w71)#3 or2(s28w35, b28c28, a28c28)#3 or2(t28,s28w35,a28b28)#5 end netlist inv(a29n,a29)#4 inv(b29n,b29)#4 inv(c29n,c29)#4 and2(a29nb29n,a29n,b29n)#2 and2(a29nb29,a29n,b29)#2 and2(a29b29n,a29,b29n)#2 and2(a29b29,a29,b29)#3 and2(a29b29c29,a29b29,c29)#2 and2(a29nb29nc29,a29nb29n,c29)#2 and2(a29nb29c29n,a29nb29,c29n)#2 and2(a29b29nc29n,a29b29n,c29n)#2 and2(b29c29,b29,c29)#2 and2(a29c29,c29,a29)#2 or2(s29w42,a29b29nc29n,a29nb29c29n)#3 or2(s29w71,a29b29c29, a29nb29nc29)#3 or2(s29,s29w42,s29w71)#3 or2(s29w35, b29c29, a29c29)#3 or2(t29,s29w35,a29b29)#5 end netlist inv(a30n,a30)#4 inv(b30n,b30)#4 inv(c30n,c30)#4 and2(a30nb30n,a30n,b30n)#2 and2(a30nb30,a30n,b30)#2 and2(a30b30n,a30,b30n)#2 and2(a30b30,a30,b30)#3 and2(a30b30c30,a30b30,c30)#2 and2(a30nb30nc30,a30nb30n,c30)#2 and2(a30nb30c30n,a30nb30,c30n)#2 and2(a30b30nc30n,a30b30n,c30n)#2 and2(b30c30,b30,c30)#2 and2(a30c30,c30,a30)#2 or2(s30w42,a30b30nc30n,a30nb30c30n)#3 or2(s30w71,a30b30c30, a30nb30nc30)#3 or2(s30,s30w42,s30w71)#3 or2(s30w35, b30c30, a30c30)#3 or2(t30,s30w35,a30b30)#5 end netlist inv(a31n,a31)#4 inv(b31n,b31)#4 inv(c31n,c31)#4 and2(a31nb31n,a31n,b31n)#2 and2(a31nb31,a31n,b31)#2 and2(a31b31n,a31,b31n)#2 and2(a31b31,a31,b31)#3 and2(a31b31c31,a31b31,c31)#2 and2(a31nb31nc31,a31nb31n,c31)#2 and2(a31nb31c31n,a31nb31,c31n)#2 and2(a31b31nc31n,a31b31n,c31n)#2 and2(b31c31,b31,c31)#2 and2(a31c31,c31,a31)#2 or2(s31w42,a31b31nc31n,a31nb31c31n)#3 or2(s31w71,a31b31c31, a31nb31nc31)#3 or2(s31,s31w42,s31w71)#3 or2(s31w35, b31c31, a31c31)#3 or2(t31,s31w35,a31b31)#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/xor.net
inputs a,b end outputs o end finish=40 initlist a 0,0 5,1 10,0 15,1 end initlist b 0,0 10,1 20,0 end outvalues o 1 end netlist nand2(x,a,b)#4 nand2(y,a,x)#4 end netlist nand2(z,b,x)#4 nand2(o,y,z)#4 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/multTree8bit.net
// Lonestar Benchmark Suite for irregular applications that exhibit // amorphous data-parallelism. // // Center for Grid and Distributed Computing // The University of Texas at Austin // // Copyright (C) 2007, 2008, 2009 The University of Texas at Austin // // Licensed under the Eclipse Public License, Version 1.0 (the "License"); // you may not use this file except in compliance with the License. // You may obtain a copy of the License at // // http://www.eclipse.org/legal/epl-v10.html // // Unless required by applicable law or agreed to in writing, software // distributed under the License is distributed on an "AS IS" BASIS, // WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. // See the License for the specific language governing permissions and // limitations under the License. // // File: multTree8bit.net finish 100000 inputs a0, a1, a2, a3, a4, a5, a6, a7, b0, b1, b2, b3, b4, b5, b6, b7, GND end outputs m0, m1, m2, m3, m4, m5, m6, m7, m8, m9, m10, m11, m12, m13, m14, m15, end outvalues m0 1, m1 0, m2 0, m3 0, m4 0, m5 0, m6 0, m7 0, m8 0, m9 1, m10 1, m11 1, m12 1, m13 1, m14 1, m15 1, end initlist GND 0 0 end initlist a0 0,0 38,1 end initlist a1 0,0 18,1 end initlist a2 0,0 38,1 end initlist a3 0,0 57,1 end initlist a4 0,0 81,1 end initlist a5 0,0 94,1 end initlist a6 0,0 3,1 end initlist a7 0,0 12,1 end initlist b0 0,0 28,1 end initlist b1 0,0 35,1 end initlist b2 0,0 93,1 end initlist b3 0,0 6,1 end initlist b4 0,0 65,1 end initlist b5 0,0 28,1 end initlist b6 0,0 69,1 end initlist b7 0,0 71,1 end netlist // mux2x1 Bth0.0( PP_0_0, GND, a0, b0 ) inv(b0_n.Bth0.0, b0 )#5 and2(w0.Bth0.0, b0_n.Bth0.0, GND )#5 and2(w1.Bth0.0, b0, a0 )#5 or2(PP_0_0, w0.Bth0.0, w1.Bth0.0 )#5 // end mux2x1 Bth0.0 end netlist // mux2x1 Bth0.1( PP_0_1, GND, a1, b0 ) inv(b0_n.Bth0.1, b0 )#5 and2(w0.Bth0.1, b0_n.Bth0.1, GND )#5 and2(w1.Bth0.1, b0, a1 )#5 or2(PP_0_1, w0.Bth0.1, w1.Bth0.1 )#5 // end mux2x1 Bth0.1 end netlist // mux2x1 Bth0.2( PP_0_2, GND, a2, b0 ) inv(b0_n.Bth0.2, b0 )#5 and2(w0.Bth0.2, b0_n.Bth0.2, GND )#5 and2(w1.Bth0.2, b0, a2 )#5 or2(PP_0_2, w0.Bth0.2, w1.Bth0.2 )#5 // end mux2x1 Bth0.2 end netlist // mux2x1 Bth0.3( PP_0_3, GND, a3, b0 ) inv(b0_n.Bth0.3, b0 )#5 and2(w0.Bth0.3, b0_n.Bth0.3, GND )#5 and2(w1.Bth0.3, b0, a3 )#5 or2(PP_0_3, w0.Bth0.3, w1.Bth0.3 )#5 // end mux2x1 Bth0.3 end netlist // mux2x1 Bth0.4( PP_0_4, GND, a4, b0 ) inv(b0_n.Bth0.4, b0 )#5 and2(w0.Bth0.4, b0_n.Bth0.4, GND )#5 and2(w1.Bth0.4, b0, a4 )#5 or2(PP_0_4, w0.Bth0.4, w1.Bth0.4 )#5 // end mux2x1 Bth0.4 end netlist // mux2x1 Bth0.5( PP_0_5, GND, a5, b0 ) inv(b0_n.Bth0.5, b0 )#5 and2(w0.Bth0.5, b0_n.Bth0.5, GND )#5 and2(w1.Bth0.5, b0, a5 )#5 or2(PP_0_5, w0.Bth0.5, w1.Bth0.5 )#5 // end mux2x1 Bth0.5 end netlist // mux2x1 Bth0.6( PP_0_6, GND, a6, b0 ) inv(b0_n.Bth0.6, b0 )#5 and2(w0.Bth0.6, b0_n.Bth0.6, GND )#5 and2(w1.Bth0.6, b0, a6 )#5 or2(PP_0_6, w0.Bth0.6, w1.Bth0.6 )#5 // end mux2x1 Bth0.6 end netlist // mux2x1 Bth0.7( PP_0_7, GND, a7, b0 ) inv(b0_n.Bth0.7, b0 )#5 and2(w0.Bth0.7, b0_n.Bth0.7, GND )#5 and2(w1.Bth0.7, b0, a7 )#5 or2(PP_0_7, w0.Bth0.7, w1.Bth0.7 )#5 // end mux2x1 Bth0.7 end netlist // mux2x1 Bth0.8( PP_0_8, GND, GND, b0 ) inv(b0_n.Bth0.8, b0 )#5 and2(w0.Bth0.8, b0_n.Bth0.8, GND )#5 and2(w1.Bth0.8, b0, GND )#5 or2(PP_0_8, w0.Bth0.8, w1.Bth0.8 )#5 // end mux2x1 Bth0.8 end netlist // mux2x1 Bth0.9( PP_0_9, GND, GND, b0 ) inv(b0_n.Bth0.9, b0 )#5 and2(w0.Bth0.9, b0_n.Bth0.9, GND )#5 and2(w1.Bth0.9, b0, GND )#5 or2(PP_0_9, w0.Bth0.9, w1.Bth0.9 )#5 // end mux2x1 Bth0.9 end netlist // mux2x1 Bth0.10( PP_0_10, GND, GND, b0 ) inv(b0_n.Bth0.10, b0 )#5 and2(w0.Bth0.10, b0_n.Bth0.10, GND )#5 and2(w1.Bth0.10, b0, GND )#5 or2(PP_0_10, w0.Bth0.10, w1.Bth0.10 )#5 // end mux2x1 Bth0.10 end netlist // mux2x1 Bth0.11( PP_0_11, GND, GND, b0 ) inv(b0_n.Bth0.11, b0 )#5 and2(w0.Bth0.11, b0_n.Bth0.11, GND )#5 and2(w1.Bth0.11, b0, GND )#5 or2(PP_0_11, w0.Bth0.11, w1.Bth0.11 )#5 // end mux2x1 Bth0.11 end netlist // mux2x1 Bth0.12( PP_0_12, GND, GND, b0 ) inv(b0_n.Bth0.12, b0 )#5 and2(w0.Bth0.12, b0_n.Bth0.12, GND )#5 and2(w1.Bth0.12, b0, GND )#5 or2(PP_0_12, w0.Bth0.12, w1.Bth0.12 )#5 // end mux2x1 Bth0.12 end netlist // mux2x1 Bth0.13( PP_0_13, GND, GND, b0 ) inv(b0_n.Bth0.13, b0 )#5 and2(w0.Bth0.13, b0_n.Bth0.13, GND )#5 and2(w1.Bth0.13, b0, GND )#5 or2(PP_0_13, w0.Bth0.13, w1.Bth0.13 )#5 // end mux2x1 Bth0.13 end netlist // mux2x1 Bth0.14( PP_0_14, GND, GND, b0 ) inv(b0_n.Bth0.14, b0 )#5 and2(w0.Bth0.14, b0_n.Bth0.14, GND )#5 and2(w1.Bth0.14, b0, GND )#5 or2(PP_0_14, w0.Bth0.14, w1.Bth0.14 )#5 // end mux2x1 Bth0.14 end netlist // mux2x1 Bth0.15( PP_0_15, GND, GND, b0 ) inv(b0_n.Bth0.15, b0 )#5 and2(w0.Bth0.15, b0_n.Bth0.15, GND )#5 and2(w1.Bth0.15, b0, GND )#5 or2(PP_0_15, w0.Bth0.15, w1.Bth0.15 )#5 // end mux2x1 Bth0.15 end netlist // mux2x1 Bth1.0( PP_1_0, GND, GND, b1 ) inv(b1_n.Bth1.0, b1 )#5 and2(w0.Bth1.0, b1_n.Bth1.0, GND )#5 and2(w1.Bth1.0, b1, GND )#5 or2(PP_1_0, w0.Bth1.0, w1.Bth1.0 )#5 // end mux2x1 Bth1.0 end netlist // mux2x1 Bth1.1( PP_1_1, GND, a0, b1 ) inv(b1_n.Bth1.1, b1 )#5 and2(w0.Bth1.1, b1_n.Bth1.1, GND )#5 and2(w1.Bth1.1, b1, a0 )#5 or2(PP_1_1, w0.Bth1.1, w1.Bth1.1 )#5 // end mux2x1 Bth1.1 end netlist // mux2x1 Bth1.2( PP_1_2, GND, a1, b1 ) inv(b1_n.Bth1.2, b1 )#5 and2(w0.Bth1.2, b1_n.Bth1.2, GND )#5 and2(w1.Bth1.2, b1, a1 )#5 or2(PP_1_2, w0.Bth1.2, w1.Bth1.2 )#5 // end mux2x1 Bth1.2 end netlist // mux2x1 Bth1.3( PP_1_3, GND, a2, b1 ) inv(b1_n.Bth1.3, b1 )#5 and2(w0.Bth1.3, b1_n.Bth1.3, GND )#5 and2(w1.Bth1.3, b1, a2 )#5 or2(PP_1_3, w0.Bth1.3, w1.Bth1.3 )#5 // end mux2x1 Bth1.3 end netlist // mux2x1 Bth1.4( PP_1_4, GND, a3, b1 ) inv(b1_n.Bth1.4, b1 )#5 and2(w0.Bth1.4, b1_n.Bth1.4, GND )#5 and2(w1.Bth1.4, b1, a3 )#5 or2(PP_1_4, w0.Bth1.4, w1.Bth1.4 )#5 // end mux2x1 Bth1.4 end netlist // mux2x1 Bth1.5( PP_1_5, GND, a4, b1 ) inv(b1_n.Bth1.5, b1 )#5 and2(w0.Bth1.5, b1_n.Bth1.5, GND )#5 and2(w1.Bth1.5, b1, a4 )#5 or2(PP_1_5, w0.Bth1.5, w1.Bth1.5 )#5 // end mux2x1 Bth1.5 end netlist // mux2x1 Bth1.6( PP_1_6, GND, a5, b1 ) inv(b1_n.Bth1.6, b1 )#5 and2(w0.Bth1.6, b1_n.Bth1.6, GND )#5 and2(w1.Bth1.6, b1, a5 )#5 or2(PP_1_6, w0.Bth1.6, w1.Bth1.6 )#5 // end mux2x1 Bth1.6 end netlist // mux2x1 Bth1.7( PP_1_7, GND, a6, b1 ) inv(b1_n.Bth1.7, b1 )#5 and2(w0.Bth1.7, b1_n.Bth1.7, GND )#5 and2(w1.Bth1.7, b1, a6 )#5 or2(PP_1_7, w0.Bth1.7, w1.Bth1.7 )#5 // end mux2x1 Bth1.7 end netlist // mux2x1 Bth1.8( PP_1_8, GND, a7, b1 ) inv(b1_n.Bth1.8, b1 )#5 and2(w0.Bth1.8, b1_n.Bth1.8, GND )#5 and2(w1.Bth1.8, b1, a7 )#5 or2(PP_1_8, w0.Bth1.8, w1.Bth1.8 )#5 // end mux2x1 Bth1.8 end netlist // mux2x1 Bth1.9( PP_1_9, GND, GND, b1 ) inv(b1_n.Bth1.9, b1 )#5 and2(w0.Bth1.9, b1_n.Bth1.9, GND )#5 and2(w1.Bth1.9, b1, GND )#5 or2(PP_1_9, w0.Bth1.9, w1.Bth1.9 )#5 // end mux2x1 Bth1.9 end netlist // mux2x1 Bth1.10( PP_1_10, GND, GND, b1 ) inv(b1_n.Bth1.10, b1 )#5 and2(w0.Bth1.10, b1_n.Bth1.10, GND )#5 and2(w1.Bth1.10, b1, GND )#5 or2(PP_1_10, w0.Bth1.10, w1.Bth1.10 )#5 // end mux2x1 Bth1.10 end netlist // mux2x1 Bth1.11( PP_1_11, GND, GND, b1 ) inv(b1_n.Bth1.11, b1 )#5 and2(w0.Bth1.11, b1_n.Bth1.11, GND )#5 and2(w1.Bth1.11, b1, GND )#5 or2(PP_1_11, w0.Bth1.11, w1.Bth1.11 )#5 // end mux2x1 Bth1.11 end netlist // mux2x1 Bth1.12( PP_1_12, GND, GND, b1 ) inv(b1_n.Bth1.12, b1 )#5 and2(w0.Bth1.12, b1_n.Bth1.12, GND )#5 and2(w1.Bth1.12, b1, GND )#5 or2(PP_1_12, w0.Bth1.12, w1.Bth1.12 )#5 // end mux2x1 Bth1.12 end netlist // mux2x1 Bth1.13( PP_1_13, GND, GND, b1 ) inv(b1_n.Bth1.13, b1 )#5 and2(w0.Bth1.13, b1_n.Bth1.13, GND )#5 and2(w1.Bth1.13, b1, GND )#5 or2(PP_1_13, w0.Bth1.13, w1.Bth1.13 )#5 // end mux2x1 Bth1.13 end netlist // mux2x1 Bth1.14( PP_1_14, GND, GND, b1 ) inv(b1_n.Bth1.14, b1 )#5 and2(w0.Bth1.14, b1_n.Bth1.14, GND )#5 and2(w1.Bth1.14, b1, GND )#5 or2(PP_1_14, w0.Bth1.14, w1.Bth1.14 )#5 // end mux2x1 Bth1.14 end netlist // mux2x1 Bth1.15( PP_1_15, GND, GND, b1 ) inv(b1_n.Bth1.15, b1 )#5 and2(w0.Bth1.15, b1_n.Bth1.15, GND )#5 and2(w1.Bth1.15, b1, GND )#5 or2(PP_1_15, w0.Bth1.15, w1.Bth1.15 )#5 // end mux2x1 Bth1.15 end netlist // mux2x1 Bth2.0( PP_2_0, GND, GND, b2 ) inv(b2_n.Bth2.0, b2 )#5 and2(w0.Bth2.0, b2_n.Bth2.0, GND )#5 and2(w1.Bth2.0, b2, GND )#5 or2(PP_2_0, w0.Bth2.0, w1.Bth2.0 )#5 // end mux2x1 Bth2.0 end netlist // mux2x1 Bth2.1( PP_2_1, GND, GND, b2 ) inv(b2_n.Bth2.1, b2 )#5 and2(w0.Bth2.1, b2_n.Bth2.1, GND )#5 and2(w1.Bth2.1, b2, GND )#5 or2(PP_2_1, w0.Bth2.1, w1.Bth2.1 )#5 // end mux2x1 Bth2.1 end netlist // mux2x1 Bth2.2( PP_2_2, GND, a0, b2 ) inv(b2_n.Bth2.2, b2 )#5 and2(w0.Bth2.2, b2_n.Bth2.2, GND )#5 and2(w1.Bth2.2, b2, a0 )#5 or2(PP_2_2, w0.Bth2.2, w1.Bth2.2 )#5 // end mux2x1 Bth2.2 end netlist // mux2x1 Bth2.3( PP_2_3, GND, a1, b2 ) inv(b2_n.Bth2.3, b2 )#5 and2(w0.Bth2.3, b2_n.Bth2.3, GND )#5 and2(w1.Bth2.3, b2, a1 )#5 or2(PP_2_3, w0.Bth2.3, w1.Bth2.3 )#5 // end mux2x1 Bth2.3 end netlist // mux2x1 Bth2.4( PP_2_4, GND, a2, b2 ) inv(b2_n.Bth2.4, b2 )#5 and2(w0.Bth2.4, b2_n.Bth2.4, GND )#5 and2(w1.Bth2.4, b2, a2 )#5 or2(PP_2_4, w0.Bth2.4, w1.Bth2.4 )#5 // end mux2x1 Bth2.4 end netlist // mux2x1 Bth2.5( PP_2_5, GND, a3, b2 ) inv(b2_n.Bth2.5, b2 )#5 and2(w0.Bth2.5, b2_n.Bth2.5, GND )#5 and2(w1.Bth2.5, b2, a3 )#5 or2(PP_2_5, w0.Bth2.5, w1.Bth2.5 )#5 // end mux2x1 Bth2.5 end netlist // mux2x1 Bth2.6( PP_2_6, GND, a4, b2 ) inv(b2_n.Bth2.6, b2 )#5 and2(w0.Bth2.6, b2_n.Bth2.6, GND )#5 and2(w1.Bth2.6, b2, a4 )#5 or2(PP_2_6, w0.Bth2.6, w1.Bth2.6 )#5 // end mux2x1 Bth2.6 end netlist // mux2x1 Bth2.7( PP_2_7, GND, a5, b2 ) inv(b2_n.Bth2.7, b2 )#5 and2(w0.Bth2.7, b2_n.Bth2.7, GND )#5 and2(w1.Bth2.7, b2, a5 )#5 or2(PP_2_7, w0.Bth2.7, w1.Bth2.7 )#5 // end mux2x1 Bth2.7 end netlist // mux2x1 Bth2.8( PP_2_8, GND, a6, b2 ) inv(b2_n.Bth2.8, b2 )#5 and2(w0.Bth2.8, b2_n.Bth2.8, GND )#5 and2(w1.Bth2.8, b2, a6 )#5 or2(PP_2_8, w0.Bth2.8, w1.Bth2.8 )#5 // end mux2x1 Bth2.8 end netlist // mux2x1 Bth2.9( PP_2_9, GND, a7, b2 ) inv(b2_n.Bth2.9, b2 )#5 and2(w0.Bth2.9, b2_n.Bth2.9, GND )#5 and2(w1.Bth2.9, b2, a7 )#5 or2(PP_2_9, w0.Bth2.9, w1.Bth2.9 )#5 // end mux2x1 Bth2.9 end netlist // mux2x1 Bth2.10( PP_2_10, GND, GND, b2 ) inv(b2_n.Bth2.10, b2 )#5 and2(w0.Bth2.10, b2_n.Bth2.10, GND )#5 and2(w1.Bth2.10, b2, GND )#5 or2(PP_2_10, w0.Bth2.10, w1.Bth2.10 )#5 // end mux2x1 Bth2.10 end netlist // mux2x1 Bth2.11( PP_2_11, GND, GND, b2 ) inv(b2_n.Bth2.11, b2 )#5 and2(w0.Bth2.11, b2_n.Bth2.11, GND )#5 and2(w1.Bth2.11, b2, GND )#5 or2(PP_2_11, w0.Bth2.11, w1.Bth2.11 )#5 // end mux2x1 Bth2.11 end netlist // mux2x1 Bth2.12( PP_2_12, GND, GND, b2 ) inv(b2_n.Bth2.12, b2 )#5 and2(w0.Bth2.12, b2_n.Bth2.12, GND )#5 and2(w1.Bth2.12, b2, GND )#5 or2(PP_2_12, w0.Bth2.12, w1.Bth2.12 )#5 // end mux2x1 Bth2.12 end netlist // mux2x1 Bth2.13( PP_2_13, GND, GND, b2 ) inv(b2_n.Bth2.13, b2 )#5 and2(w0.Bth2.13, b2_n.Bth2.13, GND )#5 and2(w1.Bth2.13, b2, GND )#5 or2(PP_2_13, w0.Bth2.13, w1.Bth2.13 )#5 // end mux2x1 Bth2.13 end netlist // mux2x1 Bth2.14( PP_2_14, GND, GND, b2 ) inv(b2_n.Bth2.14, b2 )#5 and2(w0.Bth2.14, b2_n.Bth2.14, GND )#5 and2(w1.Bth2.14, b2, GND )#5 or2(PP_2_14, w0.Bth2.14, w1.Bth2.14 )#5 // end mux2x1 Bth2.14 end netlist // mux2x1 Bth2.15( PP_2_15, GND, GND, b2 ) inv(b2_n.Bth2.15, b2 )#5 and2(w0.Bth2.15, b2_n.Bth2.15, GND )#5 and2(w1.Bth2.15, b2, GND )#5 or2(PP_2_15, w0.Bth2.15, w1.Bth2.15 )#5 // end mux2x1 Bth2.15 end netlist // mux2x1 Bth3.0( PP_3_0, GND, GND, b3 ) inv(b3_n.Bth3.0, b3 )#5 and2(w0.Bth3.0, b3_n.Bth3.0, GND )#5 and2(w1.Bth3.0, b3, GND )#5 or2(PP_3_0, w0.Bth3.0, w1.Bth3.0 )#5 // end mux2x1 Bth3.0 end netlist // mux2x1 Bth3.1( PP_3_1, GND, GND, b3 ) inv(b3_n.Bth3.1, b3 )#5 and2(w0.Bth3.1, b3_n.Bth3.1, GND )#5 and2(w1.Bth3.1, b3, GND )#5 or2(PP_3_1, w0.Bth3.1, w1.Bth3.1 )#5 // end mux2x1 Bth3.1 end netlist // mux2x1 Bth3.2( PP_3_2, GND, GND, b3 ) inv(b3_n.Bth3.2, b3 )#5 and2(w0.Bth3.2, b3_n.Bth3.2, GND )#5 and2(w1.Bth3.2, b3, GND )#5 or2(PP_3_2, w0.Bth3.2, w1.Bth3.2 )#5 // end mux2x1 Bth3.2 end netlist // mux2x1 Bth3.3( PP_3_3, GND, a0, b3 ) inv(b3_n.Bth3.3, b3 )#5 and2(w0.Bth3.3, b3_n.Bth3.3, GND )#5 and2(w1.Bth3.3, b3, a0 )#5 or2(PP_3_3, w0.Bth3.3, w1.Bth3.3 )#5 // end mux2x1 Bth3.3 end netlist // mux2x1 Bth3.4( PP_3_4, GND, a1, b3 ) inv(b3_n.Bth3.4, b3 )#5 and2(w0.Bth3.4, b3_n.Bth3.4, GND )#5 and2(w1.Bth3.4, b3, a1 )#5 or2(PP_3_4, w0.Bth3.4, w1.Bth3.4 )#5 // end mux2x1 Bth3.4 end netlist // mux2x1 Bth3.5( PP_3_5, GND, a2, b3 ) inv(b3_n.Bth3.5, b3 )#5 and2(w0.Bth3.5, b3_n.Bth3.5, GND )#5 and2(w1.Bth3.5, b3, a2 )#5 or2(PP_3_5, w0.Bth3.5, w1.Bth3.5 )#5 // end mux2x1 Bth3.5 end netlist // mux2x1 Bth3.6( PP_3_6, GND, a3, b3 ) inv(b3_n.Bth3.6, b3 )#5 and2(w0.Bth3.6, b3_n.Bth3.6, GND )#5 and2(w1.Bth3.6, b3, a3 )#5 or2(PP_3_6, w0.Bth3.6, w1.Bth3.6 )#5 // end mux2x1 Bth3.6 end netlist // mux2x1 Bth3.7( PP_3_7, GND, a4, b3 ) inv(b3_n.Bth3.7, b3 )#5 and2(w0.Bth3.7, b3_n.Bth3.7, GND )#5 and2(w1.Bth3.7, b3, a4 )#5 or2(PP_3_7, w0.Bth3.7, w1.Bth3.7 )#5 // end mux2x1 Bth3.7 end netlist // mux2x1 Bth3.8( PP_3_8, GND, a5, b3 ) inv(b3_n.Bth3.8, b3 )#5 and2(w0.Bth3.8, b3_n.Bth3.8, GND )#5 and2(w1.Bth3.8, b3, a5 )#5 or2(PP_3_8, w0.Bth3.8, w1.Bth3.8 )#5 // end mux2x1 Bth3.8 end netlist // mux2x1 Bth3.9( PP_3_9, GND, a6, b3 ) inv(b3_n.Bth3.9, b3 )#5 and2(w0.Bth3.9, b3_n.Bth3.9, GND )#5 and2(w1.Bth3.9, b3, a6 )#5 or2(PP_3_9, w0.Bth3.9, w1.Bth3.9 )#5 // end mux2x1 Bth3.9 end netlist // mux2x1 Bth3.10( PP_3_10, GND, a7, b3 ) inv(b3_n.Bth3.10, b3 )#5 and2(w0.Bth3.10, b3_n.Bth3.10, GND )#5 and2(w1.Bth3.10, b3, a7 )#5 or2(PP_3_10, w0.Bth3.10, w1.Bth3.10 )#5 // end mux2x1 Bth3.10 end netlist // mux2x1 Bth3.11( PP_3_11, GND, GND, b3 ) inv(b3_n.Bth3.11, b3 )#5 and2(w0.Bth3.11, b3_n.Bth3.11, GND )#5 and2(w1.Bth3.11, b3, GND )#5 or2(PP_3_11, w0.Bth3.11, w1.Bth3.11 )#5 // end mux2x1 Bth3.11 end netlist // mux2x1 Bth3.12( PP_3_12, GND, GND, b3 ) inv(b3_n.Bth3.12, b3 )#5 and2(w0.Bth3.12, b3_n.Bth3.12, GND )#5 and2(w1.Bth3.12, b3, GND )#5 or2(PP_3_12, w0.Bth3.12, w1.Bth3.12 )#5 // end mux2x1 Bth3.12 end netlist // mux2x1 Bth3.13( PP_3_13, GND, GND, b3 ) inv(b3_n.Bth3.13, b3 )#5 and2(w0.Bth3.13, b3_n.Bth3.13, GND )#5 and2(w1.Bth3.13, b3, GND )#5 or2(PP_3_13, w0.Bth3.13, w1.Bth3.13 )#5 // end mux2x1 Bth3.13 end netlist // mux2x1 Bth3.14( PP_3_14, GND, GND, b3 ) inv(b3_n.Bth3.14, b3 )#5 and2(w0.Bth3.14, b3_n.Bth3.14, GND )#5 and2(w1.Bth3.14, b3, GND )#5 or2(PP_3_14, w0.Bth3.14, w1.Bth3.14 )#5 // end mux2x1 Bth3.14 end netlist // mux2x1 Bth3.15( PP_3_15, GND, GND, b3 ) inv(b3_n.Bth3.15, b3 )#5 and2(w0.Bth3.15, b3_n.Bth3.15, GND )#5 and2(w1.Bth3.15, b3, GND )#5 or2(PP_3_15, w0.Bth3.15, w1.Bth3.15 )#5 // end mux2x1 Bth3.15 end netlist // mux2x1 Bth4.0( PP_4_0, GND, GND, b4 ) inv(b4_n.Bth4.0, b4 )#5 and2(w0.Bth4.0, b4_n.Bth4.0, GND )#5 and2(w1.Bth4.0, b4, GND )#5 or2(PP_4_0, w0.Bth4.0, w1.Bth4.0 )#5 // end mux2x1 Bth4.0 end netlist // mux2x1 Bth4.1( PP_4_1, GND, GND, b4 ) inv(b4_n.Bth4.1, b4 )#5 and2(w0.Bth4.1, b4_n.Bth4.1, GND )#5 and2(w1.Bth4.1, b4, GND )#5 or2(PP_4_1, w0.Bth4.1, w1.Bth4.1 )#5 // end mux2x1 Bth4.1 end netlist // mux2x1 Bth4.2( PP_4_2, GND, GND, b4 ) inv(b4_n.Bth4.2, b4 )#5 and2(w0.Bth4.2, b4_n.Bth4.2, GND )#5 and2(w1.Bth4.2, b4, GND )#5 or2(PP_4_2, w0.Bth4.2, w1.Bth4.2 )#5 // end mux2x1 Bth4.2 end netlist // mux2x1 Bth4.3( PP_4_3, GND, GND, b4 ) inv(b4_n.Bth4.3, b4 )#5 and2(w0.Bth4.3, b4_n.Bth4.3, GND )#5 and2(w1.Bth4.3, b4, GND )#5 or2(PP_4_3, w0.Bth4.3, w1.Bth4.3 )#5 // end mux2x1 Bth4.3 end netlist // mux2x1 Bth4.4( PP_4_4, GND, a0, b4 ) inv(b4_n.Bth4.4, b4 )#5 and2(w0.Bth4.4, b4_n.Bth4.4, GND )#5 and2(w1.Bth4.4, b4, a0 )#5 or2(PP_4_4, w0.Bth4.4, w1.Bth4.4 )#5 // end mux2x1 Bth4.4 end netlist // mux2x1 Bth4.5( PP_4_5, GND, a1, b4 ) inv(b4_n.Bth4.5, b4 )#5 and2(w0.Bth4.5, b4_n.Bth4.5, GND )#5 and2(w1.Bth4.5, b4, a1 )#5 or2(PP_4_5, w0.Bth4.5, w1.Bth4.5 )#5 // end mux2x1 Bth4.5 end netlist // mux2x1 Bth4.6( PP_4_6, GND, a2, b4 ) inv(b4_n.Bth4.6, b4 )#5 and2(w0.Bth4.6, b4_n.Bth4.6, GND )#5 and2(w1.Bth4.6, b4, a2 )#5 or2(PP_4_6, w0.Bth4.6, w1.Bth4.6 )#5 // end mux2x1 Bth4.6 end netlist // mux2x1 Bth4.7( PP_4_7, GND, a3, b4 ) inv(b4_n.Bth4.7, b4 )#5 and2(w0.Bth4.7, b4_n.Bth4.7, GND )#5 and2(w1.Bth4.7, b4, a3 )#5 or2(PP_4_7, w0.Bth4.7, w1.Bth4.7 )#5 // end mux2x1 Bth4.7 end netlist // mux2x1 Bth4.8( PP_4_8, GND, a4, b4 ) inv(b4_n.Bth4.8, b4 )#5 and2(w0.Bth4.8, b4_n.Bth4.8, GND )#5 and2(w1.Bth4.8, b4, a4 )#5 or2(PP_4_8, w0.Bth4.8, w1.Bth4.8 )#5 // end mux2x1 Bth4.8 end netlist // mux2x1 Bth4.9( PP_4_9, GND, a5, b4 ) inv(b4_n.Bth4.9, b4 )#5 and2(w0.Bth4.9, b4_n.Bth4.9, GND )#5 and2(w1.Bth4.9, b4, a5 )#5 or2(PP_4_9, w0.Bth4.9, w1.Bth4.9 )#5 // end mux2x1 Bth4.9 end netlist // mux2x1 Bth4.10( PP_4_10, GND, a6, b4 ) inv(b4_n.Bth4.10, b4 )#5 and2(w0.Bth4.10, b4_n.Bth4.10, GND )#5 and2(w1.Bth4.10, b4, a6 )#5 or2(PP_4_10, w0.Bth4.10, w1.Bth4.10 )#5 // end mux2x1 Bth4.10 end netlist // mux2x1 Bth4.11( PP_4_11, GND, a7, b4 ) inv(b4_n.Bth4.11, b4 )#5 and2(w0.Bth4.11, b4_n.Bth4.11, GND )#5 and2(w1.Bth4.11, b4, a7 )#5 or2(PP_4_11, w0.Bth4.11, w1.Bth4.11 )#5 // end mux2x1 Bth4.11 end netlist // mux2x1 Bth4.12( PP_4_12, GND, GND, b4 ) inv(b4_n.Bth4.12, b4 )#5 and2(w0.Bth4.12, b4_n.Bth4.12, GND )#5 and2(w1.Bth4.12, b4, GND )#5 or2(PP_4_12, w0.Bth4.12, w1.Bth4.12 )#5 // end mux2x1 Bth4.12 end netlist // mux2x1 Bth4.13( PP_4_13, GND, GND, b4 ) inv(b4_n.Bth4.13, b4 )#5 and2(w0.Bth4.13, b4_n.Bth4.13, GND )#5 and2(w1.Bth4.13, b4, GND )#5 or2(PP_4_13, w0.Bth4.13, w1.Bth4.13 )#5 // end mux2x1 Bth4.13 end netlist // mux2x1 Bth4.14( PP_4_14, GND, GND, b4 ) inv(b4_n.Bth4.14, b4 )#5 and2(w0.Bth4.14, b4_n.Bth4.14, GND )#5 and2(w1.Bth4.14, b4, GND )#5 or2(PP_4_14, w0.Bth4.14, w1.Bth4.14 )#5 // end mux2x1 Bth4.14 end netlist // mux2x1 Bth4.15( PP_4_15, GND, GND, b4 ) inv(b4_n.Bth4.15, b4 )#5 and2(w0.Bth4.15, b4_n.Bth4.15, GND )#5 and2(w1.Bth4.15, b4, GND )#5 or2(PP_4_15, w0.Bth4.15, w1.Bth4.15 )#5 // end mux2x1 Bth4.15 end netlist // mux2x1 Bth5.0( PP_5_0, GND, GND, b5 ) inv(b5_n.Bth5.0, b5 )#5 and2(w0.Bth5.0, b5_n.Bth5.0, GND )#5 and2(w1.Bth5.0, b5, GND )#5 or2(PP_5_0, w0.Bth5.0, w1.Bth5.0 )#5 // end mux2x1 Bth5.0 end netlist // mux2x1 Bth5.1( PP_5_1, GND, GND, b5 ) inv(b5_n.Bth5.1, b5 )#5 and2(w0.Bth5.1, b5_n.Bth5.1, GND )#5 and2(w1.Bth5.1, b5, GND )#5 or2(PP_5_1, w0.Bth5.1, w1.Bth5.1 )#5 // end mux2x1 Bth5.1 end netlist // mux2x1 Bth5.2( PP_5_2, GND, GND, b5 ) inv(b5_n.Bth5.2, b5 )#5 and2(w0.Bth5.2, b5_n.Bth5.2, GND )#5 and2(w1.Bth5.2, b5, GND )#5 or2(PP_5_2, w0.Bth5.2, w1.Bth5.2 )#5 // end mux2x1 Bth5.2 end netlist // mux2x1 Bth5.3( PP_5_3, GND, GND, b5 ) inv(b5_n.Bth5.3, b5 )#5 and2(w0.Bth5.3, b5_n.Bth5.3, GND )#5 and2(w1.Bth5.3, b5, GND )#5 or2(PP_5_3, w0.Bth5.3, w1.Bth5.3 )#5 // end mux2x1 Bth5.3 end netlist // mux2x1 Bth5.4( PP_5_4, GND, GND, b5 ) inv(b5_n.Bth5.4, b5 )#5 and2(w0.Bth5.4, b5_n.Bth5.4, GND )#5 and2(w1.Bth5.4, b5, GND )#5 or2(PP_5_4, w0.Bth5.4, w1.Bth5.4 )#5 // end mux2x1 Bth5.4 end netlist // mux2x1 Bth5.5( PP_5_5, GND, a0, b5 ) inv(b5_n.Bth5.5, b5 )#5 and2(w0.Bth5.5, b5_n.Bth5.5, GND )#5 and2(w1.Bth5.5, b5, a0 )#5 or2(PP_5_5, w0.Bth5.5, w1.Bth5.5 )#5 // end mux2x1 Bth5.5 end netlist // mux2x1 Bth5.6( PP_5_6, GND, a1, b5 ) inv(b5_n.Bth5.6, b5 )#5 and2(w0.Bth5.6, b5_n.Bth5.6, GND )#5 and2(w1.Bth5.6, b5, a1 )#5 or2(PP_5_6, w0.Bth5.6, w1.Bth5.6 )#5 // end mux2x1 Bth5.6 end netlist // mux2x1 Bth5.7( PP_5_7, GND, a2, b5 ) inv(b5_n.Bth5.7, b5 )#5 and2(w0.Bth5.7, b5_n.Bth5.7, GND )#5 and2(w1.Bth5.7, b5, a2 )#5 or2(PP_5_7, w0.Bth5.7, w1.Bth5.7 )#5 // end mux2x1 Bth5.7 end netlist // mux2x1 Bth5.8( PP_5_8, GND, a3, b5 ) inv(b5_n.Bth5.8, b5 )#5 and2(w0.Bth5.8, b5_n.Bth5.8, GND )#5 and2(w1.Bth5.8, b5, a3 )#5 or2(PP_5_8, w0.Bth5.8, w1.Bth5.8 )#5 // end mux2x1 Bth5.8 end netlist // mux2x1 Bth5.9( PP_5_9, GND, a4, b5 ) inv(b5_n.Bth5.9, b5 )#5 and2(w0.Bth5.9, b5_n.Bth5.9, GND )#5 and2(w1.Bth5.9, b5, a4 )#5 or2(PP_5_9, w0.Bth5.9, w1.Bth5.9 )#5 // end mux2x1 Bth5.9 end netlist // mux2x1 Bth5.10( PP_5_10, GND, a5, b5 ) inv(b5_n.Bth5.10, b5 )#5 and2(w0.Bth5.10, b5_n.Bth5.10, GND )#5 and2(w1.Bth5.10, b5, a5 )#5 or2(PP_5_10, w0.Bth5.10, w1.Bth5.10 )#5 // end mux2x1 Bth5.10 end netlist // mux2x1 Bth5.11( PP_5_11, GND, a6, b5 ) inv(b5_n.Bth5.11, b5 )#5 and2(w0.Bth5.11, b5_n.Bth5.11, GND )#5 and2(w1.Bth5.11, b5, a6 )#5 or2(PP_5_11, w0.Bth5.11, w1.Bth5.11 )#5 // end mux2x1 Bth5.11 end netlist // mux2x1 Bth5.12( PP_5_12, GND, a7, b5 ) inv(b5_n.Bth5.12, b5 )#5 and2(w0.Bth5.12, b5_n.Bth5.12, GND )#5 and2(w1.Bth5.12, b5, a7 )#5 or2(PP_5_12, w0.Bth5.12, w1.Bth5.12 )#5 // end mux2x1 Bth5.12 end netlist // mux2x1 Bth5.13( PP_5_13, GND, GND, b5 ) inv(b5_n.Bth5.13, b5 )#5 and2(w0.Bth5.13, b5_n.Bth5.13, GND )#5 and2(w1.Bth5.13, b5, GND )#5 or2(PP_5_13, w0.Bth5.13, w1.Bth5.13 )#5 // end mux2x1 Bth5.13 end netlist // mux2x1 Bth5.14( PP_5_14, GND, GND, b5 ) inv(b5_n.Bth5.14, b5 )#5 and2(w0.Bth5.14, b5_n.Bth5.14, GND )#5 and2(w1.Bth5.14, b5, GND )#5 or2(PP_5_14, w0.Bth5.14, w1.Bth5.14 )#5 // end mux2x1 Bth5.14 end netlist // mux2x1 Bth5.15( PP_5_15, GND, GND, b5 ) inv(b5_n.Bth5.15, b5 )#5 and2(w0.Bth5.15, b5_n.Bth5.15, GND )#5 and2(w1.Bth5.15, b5, GND )#5 or2(PP_5_15, w0.Bth5.15, w1.Bth5.15 )#5 // end mux2x1 Bth5.15 end netlist // mux2x1 Bth6.0( PP_6_0, GND, GND, b6 ) inv(b6_n.Bth6.0, b6 )#5 and2(w0.Bth6.0, b6_n.Bth6.0, GND )#5 and2(w1.Bth6.0, b6, GND )#5 or2(PP_6_0, w0.Bth6.0, w1.Bth6.0 )#5 // end mux2x1 Bth6.0 end netlist // mux2x1 Bth6.1( PP_6_1, GND, GND, b6 ) inv(b6_n.Bth6.1, b6 )#5 and2(w0.Bth6.1, b6_n.Bth6.1, GND )#5 and2(w1.Bth6.1, b6, GND )#5 or2(PP_6_1, w0.Bth6.1, w1.Bth6.1 )#5 // end mux2x1 Bth6.1 end netlist // mux2x1 Bth6.2( PP_6_2, GND, GND, b6 ) inv(b6_n.Bth6.2, b6 )#5 and2(w0.Bth6.2, b6_n.Bth6.2, GND )#5 and2(w1.Bth6.2, b6, GND )#5 or2(PP_6_2, w0.Bth6.2, w1.Bth6.2 )#5 // end mux2x1 Bth6.2 end netlist // mux2x1 Bth6.3( PP_6_3, GND, GND, b6 ) inv(b6_n.Bth6.3, b6 )#5 and2(w0.Bth6.3, b6_n.Bth6.3, GND )#5 and2(w1.Bth6.3, b6, GND )#5 or2(PP_6_3, w0.Bth6.3, w1.Bth6.3 )#5 // end mux2x1 Bth6.3 end netlist // mux2x1 Bth6.4( PP_6_4, GND, GND, b6 ) inv(b6_n.Bth6.4, b6 )#5 and2(w0.Bth6.4, b6_n.Bth6.4, GND )#5 and2(w1.Bth6.4, b6, GND )#5 or2(PP_6_4, w0.Bth6.4, w1.Bth6.4 )#5 // end mux2x1 Bth6.4 end netlist // mux2x1 Bth6.5( PP_6_5, GND, GND, b6 ) inv(b6_n.Bth6.5, b6 )#5 and2(w0.Bth6.5, b6_n.Bth6.5, GND )#5 and2(w1.Bth6.5, b6, GND )#5 or2(PP_6_5, w0.Bth6.5, w1.Bth6.5 )#5 // end mux2x1 Bth6.5 end netlist // mux2x1 Bth6.6( PP_6_6, GND, a0, b6 ) inv(b6_n.Bth6.6, b6 )#5 and2(w0.Bth6.6, b6_n.Bth6.6, GND )#5 and2(w1.Bth6.6, b6, a0 )#5 or2(PP_6_6, w0.Bth6.6, w1.Bth6.6 )#5 // end mux2x1 Bth6.6 end netlist // mux2x1 Bth6.7( PP_6_7, GND, a1, b6 ) inv(b6_n.Bth6.7, b6 )#5 and2(w0.Bth6.7, b6_n.Bth6.7, GND )#5 and2(w1.Bth6.7, b6, a1 )#5 or2(PP_6_7, w0.Bth6.7, w1.Bth6.7 )#5 // end mux2x1 Bth6.7 end netlist // mux2x1 Bth6.8( PP_6_8, GND, a2, b6 ) inv(b6_n.Bth6.8, b6 )#5 and2(w0.Bth6.8, b6_n.Bth6.8, GND )#5 and2(w1.Bth6.8, b6, a2 )#5 or2(PP_6_8, w0.Bth6.8, w1.Bth6.8 )#5 // end mux2x1 Bth6.8 end netlist // mux2x1 Bth6.9( PP_6_9, GND, a3, b6 ) inv(b6_n.Bth6.9, b6 )#5 and2(w0.Bth6.9, b6_n.Bth6.9, GND )#5 and2(w1.Bth6.9, b6, a3 )#5 or2(PP_6_9, w0.Bth6.9, w1.Bth6.9 )#5 // end mux2x1 Bth6.9 end netlist // mux2x1 Bth6.10( PP_6_10, GND, a4, b6 ) inv(b6_n.Bth6.10, b6 )#5 and2(w0.Bth6.10, b6_n.Bth6.10, GND )#5 and2(w1.Bth6.10, b6, a4 )#5 or2(PP_6_10, w0.Bth6.10, w1.Bth6.10 )#5 // end mux2x1 Bth6.10 end netlist // mux2x1 Bth6.11( PP_6_11, GND, a5, b6 ) inv(b6_n.Bth6.11, b6 )#5 and2(w0.Bth6.11, b6_n.Bth6.11, GND )#5 and2(w1.Bth6.11, b6, a5 )#5 or2(PP_6_11, w0.Bth6.11, w1.Bth6.11 )#5 // end mux2x1 Bth6.11 end netlist // mux2x1 Bth6.12( PP_6_12, GND, a6, b6 ) inv(b6_n.Bth6.12, b6 )#5 and2(w0.Bth6.12, b6_n.Bth6.12, GND )#5 and2(w1.Bth6.12, b6, a6 )#5 or2(PP_6_12, w0.Bth6.12, w1.Bth6.12 )#5 // end mux2x1 Bth6.12 end netlist // mux2x1 Bth6.13( PP_6_13, GND, a7, b6 ) inv(b6_n.Bth6.13, b6 )#5 and2(w0.Bth6.13, b6_n.Bth6.13, GND )#5 and2(w1.Bth6.13, b6, a7 )#5 or2(PP_6_13, w0.Bth6.13, w1.Bth6.13 )#5 // end mux2x1 Bth6.13 end netlist // mux2x1 Bth6.14( PP_6_14, GND, GND, b6 ) inv(b6_n.Bth6.14, b6 )#5 and2(w0.Bth6.14, b6_n.Bth6.14, GND )#5 and2(w1.Bth6.14, b6, GND )#5 or2(PP_6_14, w0.Bth6.14, w1.Bth6.14 )#5 // end mux2x1 Bth6.14 end netlist // mux2x1 Bth6.15( PP_6_15, GND, GND, b6 ) inv(b6_n.Bth6.15, b6 )#5 and2(w0.Bth6.15, b6_n.Bth6.15, GND )#5 and2(w1.Bth6.15, b6, GND )#5 or2(PP_6_15, w0.Bth6.15, w1.Bth6.15 )#5 // end mux2x1 Bth6.15 end netlist // mux2x1 Bth7.0( PP_7_0, GND, GND, b7 ) inv(b7_n.Bth7.0, b7 )#5 and2(w0.Bth7.0, b7_n.Bth7.0, GND )#5 and2(w1.Bth7.0, b7, GND )#5 or2(PP_7_0, w0.Bth7.0, w1.Bth7.0 )#5 // end mux2x1 Bth7.0 end netlist // mux2x1 Bth7.1( PP_7_1, GND, GND, b7 ) inv(b7_n.Bth7.1, b7 )#5 and2(w0.Bth7.1, b7_n.Bth7.1, GND )#5 and2(w1.Bth7.1, b7, GND )#5 or2(PP_7_1, w0.Bth7.1, w1.Bth7.1 )#5 // end mux2x1 Bth7.1 end netlist // mux2x1 Bth7.2( PP_7_2, GND, GND, b7 ) inv(b7_n.Bth7.2, b7 )#5 and2(w0.Bth7.2, b7_n.Bth7.2, GND )#5 and2(w1.Bth7.2, b7, GND )#5 or2(PP_7_2, w0.Bth7.2, w1.Bth7.2 )#5 // end mux2x1 Bth7.2 end netlist // mux2x1 Bth7.3( PP_7_3, GND, GND, b7 ) inv(b7_n.Bth7.3, b7 )#5 and2(w0.Bth7.3, b7_n.Bth7.3, GND )#5 and2(w1.Bth7.3, b7, GND )#5 or2(PP_7_3, w0.Bth7.3, w1.Bth7.3 )#5 // end mux2x1 Bth7.3 end netlist // mux2x1 Bth7.4( PP_7_4, GND, GND, b7 ) inv(b7_n.Bth7.4, b7 )#5 and2(w0.Bth7.4, b7_n.Bth7.4, GND )#5 and2(w1.Bth7.4, b7, GND )#5 or2(PP_7_4, w0.Bth7.4, w1.Bth7.4 )#5 // end mux2x1 Bth7.4 end netlist // mux2x1 Bth7.5( PP_7_5, GND, GND, b7 ) inv(b7_n.Bth7.5, b7 )#5 and2(w0.Bth7.5, b7_n.Bth7.5, GND )#5 and2(w1.Bth7.5, b7, GND )#5 or2(PP_7_5, w0.Bth7.5, w1.Bth7.5 )#5 // end mux2x1 Bth7.5 end netlist // mux2x1 Bth7.6( PP_7_6, GND, GND, b7 ) inv(b7_n.Bth7.6, b7 )#5 and2(w0.Bth7.6, b7_n.Bth7.6, GND )#5 and2(w1.Bth7.6, b7, GND )#5 or2(PP_7_6, w0.Bth7.6, w1.Bth7.6 )#5 // end mux2x1 Bth7.6 end netlist // mux2x1 Bth7.7( PP_7_7, GND, a0, b7 ) inv(b7_n.Bth7.7, b7 )#5 and2(w0.Bth7.7, b7_n.Bth7.7, GND )#5 and2(w1.Bth7.7, b7, a0 )#5 or2(PP_7_7, w0.Bth7.7, w1.Bth7.7 )#5 // end mux2x1 Bth7.7 end netlist // mux2x1 Bth7.8( PP_7_8, GND, a1, b7 ) inv(b7_n.Bth7.8, b7 )#5 and2(w0.Bth7.8, b7_n.Bth7.8, GND )#5 and2(w1.Bth7.8, b7, a1 )#5 or2(PP_7_8, w0.Bth7.8, w1.Bth7.8 )#5 // end mux2x1 Bth7.8 end netlist // mux2x1 Bth7.9( PP_7_9, GND, a2, b7 ) inv(b7_n.Bth7.9, b7 )#5 and2(w0.Bth7.9, b7_n.Bth7.9, GND )#5 and2(w1.Bth7.9, b7, a2 )#5 or2(PP_7_9, w0.Bth7.9, w1.Bth7.9 )#5 // end mux2x1 Bth7.9 end netlist // mux2x1 Bth7.10( PP_7_10, GND, a3, b7 ) inv(b7_n.Bth7.10, b7 )#5 and2(w0.Bth7.10, b7_n.Bth7.10, GND )#5 and2(w1.Bth7.10, b7, a3 )#5 or2(PP_7_10, w0.Bth7.10, w1.Bth7.10 )#5 // end mux2x1 Bth7.10 end netlist // mux2x1 Bth7.11( PP_7_11, GND, a4, b7 ) inv(b7_n.Bth7.11, b7 )#5 and2(w0.Bth7.11, b7_n.Bth7.11, GND )#5 and2(w1.Bth7.11, b7, a4 )#5 or2(PP_7_11, w0.Bth7.11, w1.Bth7.11 )#5 // end mux2x1 Bth7.11 end netlist // mux2x1 Bth7.12( PP_7_12, GND, a5, b7 ) inv(b7_n.Bth7.12, b7 )#5 and2(w0.Bth7.12, b7_n.Bth7.12, GND )#5 and2(w1.Bth7.12, b7, a5 )#5 or2(PP_7_12, w0.Bth7.12, w1.Bth7.12 )#5 // end mux2x1 Bth7.12 end netlist // mux2x1 Bth7.13( PP_7_13, GND, a6, b7 ) inv(b7_n.Bth7.13, b7 )#5 and2(w0.Bth7.13, b7_n.Bth7.13, GND )#5 and2(w1.Bth7.13, b7, a6 )#5 or2(PP_7_13, w0.Bth7.13, w1.Bth7.13 )#5 // end mux2x1 Bth7.13 end netlist // mux2x1 Bth7.14( PP_7_14, GND, a7, b7 ) inv(b7_n.Bth7.14, b7 )#5 and2(w0.Bth7.14, b7_n.Bth7.14, GND )#5 and2(w1.Bth7.14, b7, a7 )#5 or2(PP_7_14, w0.Bth7.14, w1.Bth7.14 )#5 // end mux2x1 Bth7.14 end netlist // mux2x1 Bth7.15( PP_7_15, GND, GND, b7 ) inv(b7_n.Bth7.15, b7 )#5 and2(w0.Bth7.15, b7_n.Bth7.15, GND )#5 and2(w1.Bth7.15, b7, GND )#5 or2(PP_7_15, w0.Bth7.15, w1.Bth7.15 )#5 // end mux2x1 Bth7.15 end // instantiating csa4x2Vec at lvl 0 netlist // csa4x2 (csa4x2_0_lvl0.0, s0_lvl0_0,t0_lvl0_0,cout_csa4x2_0_lvl0.0,PP_0_0,PP_1_0,PP_2_0,PP_3_0,GND) ; // adder1bit Adder0.csa4x2_0_lvl0.0( sintcsa4x2_0_lvl0.0, cout_csa4x2_0_lvl0.0, PP_0_0, PP_1_0, PP_2_0) // sum xor2( w0.Adder0.csa4x2_0_lvl0.0, PP_0_0, PP_1_0 )#5 xor2( sintcsa4x2_0_lvl0.0, w0.Adder0.csa4x2_0_lvl0.0, PP_2_0 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.0, PP_0_0, PP_1_0 )#5 and2( w2.Adder0.csa4x2_0_lvl0.0, w0.Adder0.csa4x2_0_lvl0.0, PP_2_0 )#5 or2( cout_csa4x2_0_lvl0.0, w1.Adder0.csa4x2_0_lvl0.0, w2.Adder0.csa4x2_0_lvl0.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.0( s0_lvl0_0, t0_lvl0_0, sintcsa4x2_0_lvl0.0, PP_3_0, GND) // sum xor2( w0.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, PP_3_0 )#5 xor2( s0_lvl0_0, w0.Adder1.csa4x2_0_lvl0.0, GND )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, PP_3_0 )#5 and2( w2.Adder1.csa4x2_0_lvl0.0, w0.Adder1.csa4x2_0_lvl0.0, GND )#5 or2( t0_lvl0_0, w1.Adder1.csa4x2_0_lvl0.0, w2.Adder1.csa4x2_0_lvl0.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.1, s0_lvl0_1,t0_lvl0_1,cout_csa4x2_0_lvl0.1,PP_0_1,PP_1_1,PP_2_1,PP_3_1,cout_csa4x2_0_lvl0.0) ; // adder1bit Adder0.csa4x2_0_lvl0.1( sintcsa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.1, PP_0_1, PP_1_1, PP_2_1) // sum xor2( w0.Adder0.csa4x2_0_lvl0.1, PP_0_1, PP_1_1 )#5 xor2( sintcsa4x2_0_lvl0.1, w0.Adder0.csa4x2_0_lvl0.1, PP_2_1 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.1, PP_0_1, PP_1_1 )#5 and2( w2.Adder0.csa4x2_0_lvl0.1, w0.Adder0.csa4x2_0_lvl0.1, PP_2_1 )#5 or2( cout_csa4x2_0_lvl0.1, w1.Adder0.csa4x2_0_lvl0.1, w2.Adder0.csa4x2_0_lvl0.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.1( s0_lvl0_1, t0_lvl0_1, sintcsa4x2_0_lvl0.1, PP_3_1, cout_csa4x2_0_lvl0.0) // sum xor2( w0.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, PP_3_1 )#5 xor2( s0_lvl0_1, w0.Adder1.csa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, PP_3_1 )#5 and2( w2.Adder1.csa4x2_0_lvl0.1, w0.Adder1.csa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0 )#5 or2( t0_lvl0_1, w1.Adder1.csa4x2_0_lvl0.1, w2.Adder1.csa4x2_0_lvl0.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.2, s0_lvl0_2,t0_lvl0_2,cout_csa4x2_0_lvl0.2,PP_0_2,PP_1_2,PP_2_2,PP_3_2,cout_csa4x2_0_lvl0.1) ; // adder1bit Adder0.csa4x2_0_lvl0.2( sintcsa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.2, PP_0_2, PP_1_2, PP_2_2) // sum xor2( w0.Adder0.csa4x2_0_lvl0.2, PP_0_2, PP_1_2 )#5 xor2( sintcsa4x2_0_lvl0.2, w0.Adder0.csa4x2_0_lvl0.2, PP_2_2 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.2, PP_0_2, PP_1_2 )#5 and2( w2.Adder0.csa4x2_0_lvl0.2, w0.Adder0.csa4x2_0_lvl0.2, PP_2_2 )#5 or2( cout_csa4x2_0_lvl0.2, w1.Adder0.csa4x2_0_lvl0.2, w2.Adder0.csa4x2_0_lvl0.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.2( s0_lvl0_2, t0_lvl0_2, sintcsa4x2_0_lvl0.2, PP_3_2, cout_csa4x2_0_lvl0.1) // sum xor2( w0.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, PP_3_2 )#5 xor2( s0_lvl0_2, w0.Adder1.csa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, PP_3_2 )#5 and2( w2.Adder1.csa4x2_0_lvl0.2, w0.Adder1.csa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1 )#5 or2( t0_lvl0_2, w1.Adder1.csa4x2_0_lvl0.2, w2.Adder1.csa4x2_0_lvl0.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.3, s0_lvl0_3,t0_lvl0_3,cout_csa4x2_0_lvl0.3,PP_0_3,PP_1_3,PP_2_3,PP_3_3,cout_csa4x2_0_lvl0.2) ; // adder1bit Adder0.csa4x2_0_lvl0.3( sintcsa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.3, PP_0_3, PP_1_3, PP_2_3) // sum xor2( w0.Adder0.csa4x2_0_lvl0.3, PP_0_3, PP_1_3 )#5 xor2( sintcsa4x2_0_lvl0.3, w0.Adder0.csa4x2_0_lvl0.3, PP_2_3 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.3, PP_0_3, PP_1_3 )#5 and2( w2.Adder0.csa4x2_0_lvl0.3, w0.Adder0.csa4x2_0_lvl0.3, PP_2_3 )#5 or2( cout_csa4x2_0_lvl0.3, w1.Adder0.csa4x2_0_lvl0.3, w2.Adder0.csa4x2_0_lvl0.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.3( s0_lvl0_3, t0_lvl0_3, sintcsa4x2_0_lvl0.3, PP_3_3, cout_csa4x2_0_lvl0.2) // sum xor2( w0.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, PP_3_3 )#5 xor2( s0_lvl0_3, w0.Adder1.csa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, PP_3_3 )#5 and2( w2.Adder1.csa4x2_0_lvl0.3, w0.Adder1.csa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2 )#5 or2( t0_lvl0_3, w1.Adder1.csa4x2_0_lvl0.3, w2.Adder1.csa4x2_0_lvl0.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.4, s0_lvl0_4,t0_lvl0_4,cout_csa4x2_0_lvl0.4,PP_0_4,PP_1_4,PP_2_4,PP_3_4,cout_csa4x2_0_lvl0.3) ; // adder1bit Adder0.csa4x2_0_lvl0.4( sintcsa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.4, PP_0_4, PP_1_4, PP_2_4) // sum xor2( w0.Adder0.csa4x2_0_lvl0.4, PP_0_4, PP_1_4 )#5 xor2( sintcsa4x2_0_lvl0.4, w0.Adder0.csa4x2_0_lvl0.4, PP_2_4 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.4, PP_0_4, PP_1_4 )#5 and2( w2.Adder0.csa4x2_0_lvl0.4, w0.Adder0.csa4x2_0_lvl0.4, PP_2_4 )#5 or2( cout_csa4x2_0_lvl0.4, w1.Adder0.csa4x2_0_lvl0.4, w2.Adder0.csa4x2_0_lvl0.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.4( s0_lvl0_4, t0_lvl0_4, sintcsa4x2_0_lvl0.4, PP_3_4, cout_csa4x2_0_lvl0.3) // sum xor2( w0.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, PP_3_4 )#5 xor2( s0_lvl0_4, w0.Adder1.csa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, PP_3_4 )#5 and2( w2.Adder1.csa4x2_0_lvl0.4, w0.Adder1.csa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3 )#5 or2( t0_lvl0_4, w1.Adder1.csa4x2_0_lvl0.4, w2.Adder1.csa4x2_0_lvl0.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.5, s0_lvl0_5,t0_lvl0_5,cout_csa4x2_0_lvl0.5,PP_0_5,PP_1_5,PP_2_5,PP_3_5,cout_csa4x2_0_lvl0.4) ; // adder1bit Adder0.csa4x2_0_lvl0.5( sintcsa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.5, PP_0_5, PP_1_5, PP_2_5) // sum xor2( w0.Adder0.csa4x2_0_lvl0.5, PP_0_5, PP_1_5 )#5 xor2( sintcsa4x2_0_lvl0.5, w0.Adder0.csa4x2_0_lvl0.5, PP_2_5 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.5, PP_0_5, PP_1_5 )#5 and2( w2.Adder0.csa4x2_0_lvl0.5, w0.Adder0.csa4x2_0_lvl0.5, PP_2_5 )#5 or2( cout_csa4x2_0_lvl0.5, w1.Adder0.csa4x2_0_lvl0.5, w2.Adder0.csa4x2_0_lvl0.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.5( s0_lvl0_5, t0_lvl0_5, sintcsa4x2_0_lvl0.5, PP_3_5, cout_csa4x2_0_lvl0.4) // sum xor2( w0.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, PP_3_5 )#5 xor2( s0_lvl0_5, w0.Adder1.csa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, PP_3_5 )#5 and2( w2.Adder1.csa4x2_0_lvl0.5, w0.Adder1.csa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4 )#5 or2( t0_lvl0_5, w1.Adder1.csa4x2_0_lvl0.5, w2.Adder1.csa4x2_0_lvl0.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.6, s0_lvl0_6,t0_lvl0_6,cout_csa4x2_0_lvl0.6,PP_0_6,PP_1_6,PP_2_6,PP_3_6,cout_csa4x2_0_lvl0.5) ; // adder1bit Adder0.csa4x2_0_lvl0.6( sintcsa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.6, PP_0_6, PP_1_6, PP_2_6) // sum xor2( w0.Adder0.csa4x2_0_lvl0.6, PP_0_6, PP_1_6 )#5 xor2( sintcsa4x2_0_lvl0.6, w0.Adder0.csa4x2_0_lvl0.6, PP_2_6 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.6, PP_0_6, PP_1_6 )#5 and2( w2.Adder0.csa4x2_0_lvl0.6, w0.Adder0.csa4x2_0_lvl0.6, PP_2_6 )#5 or2( cout_csa4x2_0_lvl0.6, w1.Adder0.csa4x2_0_lvl0.6, w2.Adder0.csa4x2_0_lvl0.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.6( s0_lvl0_6, t0_lvl0_6, sintcsa4x2_0_lvl0.6, PP_3_6, cout_csa4x2_0_lvl0.5) // sum xor2( w0.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, PP_3_6 )#5 xor2( s0_lvl0_6, w0.Adder1.csa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, PP_3_6 )#5 and2( w2.Adder1.csa4x2_0_lvl0.6, w0.Adder1.csa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5 )#5 or2( t0_lvl0_6, w1.Adder1.csa4x2_0_lvl0.6, w2.Adder1.csa4x2_0_lvl0.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.7, s0_lvl0_7,t0_lvl0_7,cout_csa4x2_0_lvl0.7,PP_0_7,PP_1_7,PP_2_7,PP_3_7,cout_csa4x2_0_lvl0.6) ; // adder1bit Adder0.csa4x2_0_lvl0.7( sintcsa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.7, PP_0_7, PP_1_7, PP_2_7) // sum xor2( w0.Adder0.csa4x2_0_lvl0.7, PP_0_7, PP_1_7 )#5 xor2( sintcsa4x2_0_lvl0.7, w0.Adder0.csa4x2_0_lvl0.7, PP_2_7 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.7, PP_0_7, PP_1_7 )#5 and2( w2.Adder0.csa4x2_0_lvl0.7, w0.Adder0.csa4x2_0_lvl0.7, PP_2_7 )#5 or2( cout_csa4x2_0_lvl0.7, w1.Adder0.csa4x2_0_lvl0.7, w2.Adder0.csa4x2_0_lvl0.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.7( s0_lvl0_7, t0_lvl0_7, sintcsa4x2_0_lvl0.7, PP_3_7, cout_csa4x2_0_lvl0.6) // sum xor2( w0.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, PP_3_7 )#5 xor2( s0_lvl0_7, w0.Adder1.csa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, PP_3_7 )#5 and2( w2.Adder1.csa4x2_0_lvl0.7, w0.Adder1.csa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6 )#5 or2( t0_lvl0_7, w1.Adder1.csa4x2_0_lvl0.7, w2.Adder1.csa4x2_0_lvl0.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.8, s0_lvl0_8,t0_lvl0_8,cout_csa4x2_0_lvl0.8,PP_0_8,PP_1_8,PP_2_8,PP_3_8,cout_csa4x2_0_lvl0.7) ; // adder1bit Adder0.csa4x2_0_lvl0.8( sintcsa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.8, PP_0_8, PP_1_8, PP_2_8) // sum xor2( w0.Adder0.csa4x2_0_lvl0.8, PP_0_8, PP_1_8 )#5 xor2( sintcsa4x2_0_lvl0.8, w0.Adder0.csa4x2_0_lvl0.8, PP_2_8 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.8, PP_0_8, PP_1_8 )#5 and2( w2.Adder0.csa4x2_0_lvl0.8, w0.Adder0.csa4x2_0_lvl0.8, PP_2_8 )#5 or2( cout_csa4x2_0_lvl0.8, w1.Adder0.csa4x2_0_lvl0.8, w2.Adder0.csa4x2_0_lvl0.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.8( s0_lvl0_8, t0_lvl0_8, sintcsa4x2_0_lvl0.8, PP_3_8, cout_csa4x2_0_lvl0.7) // sum xor2( w0.Adder1.csa4x2_0_lvl0.8, sintcsa4x2_0_lvl0.8, PP_3_8 )#5 xor2( s0_lvl0_8, w0.Adder1.csa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.7 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.8, sintcsa4x2_0_lvl0.8, PP_3_8 )#5 and2( w2.Adder1.csa4x2_0_lvl0.8, w0.Adder1.csa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.7 )#5 or2( t0_lvl0_8, w1.Adder1.csa4x2_0_lvl0.8, w2.Adder1.csa4x2_0_lvl0.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.9, s0_lvl0_9,t0_lvl0_9,cout_csa4x2_0_lvl0.9,PP_0_9,PP_1_9,PP_2_9,PP_3_9,cout_csa4x2_0_lvl0.8) ; // adder1bit Adder0.csa4x2_0_lvl0.9( sintcsa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.9, PP_0_9, PP_1_9, PP_2_9) // sum xor2( w0.Adder0.csa4x2_0_lvl0.9, PP_0_9, PP_1_9 )#5 xor2( sintcsa4x2_0_lvl0.9, w0.Adder0.csa4x2_0_lvl0.9, PP_2_9 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.9, PP_0_9, PP_1_9 )#5 and2( w2.Adder0.csa4x2_0_lvl0.9, w0.Adder0.csa4x2_0_lvl0.9, PP_2_9 )#5 or2( cout_csa4x2_0_lvl0.9, w1.Adder0.csa4x2_0_lvl0.9, w2.Adder0.csa4x2_0_lvl0.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.9( s0_lvl0_9, t0_lvl0_9, sintcsa4x2_0_lvl0.9, PP_3_9, cout_csa4x2_0_lvl0.8) // sum xor2( w0.Adder1.csa4x2_0_lvl0.9, sintcsa4x2_0_lvl0.9, PP_3_9 )#5 xor2( s0_lvl0_9, w0.Adder1.csa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.8 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.9, sintcsa4x2_0_lvl0.9, PP_3_9 )#5 and2( w2.Adder1.csa4x2_0_lvl0.9, w0.Adder1.csa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.8 )#5 or2( t0_lvl0_9, w1.Adder1.csa4x2_0_lvl0.9, w2.Adder1.csa4x2_0_lvl0.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.10, s0_lvl0_10,t0_lvl0_10,cout_csa4x2_0_lvl0.10,PP_0_10,PP_1_10,PP_2_10,PP_3_10,cout_csa4x2_0_lvl0.9) ; // adder1bit Adder0.csa4x2_0_lvl0.10( sintcsa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.10, PP_0_10, PP_1_10, PP_2_10) // sum xor2( w0.Adder0.csa4x2_0_lvl0.10, PP_0_10, PP_1_10 )#5 xor2( sintcsa4x2_0_lvl0.10, w0.Adder0.csa4x2_0_lvl0.10, PP_2_10 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.10, PP_0_10, PP_1_10 )#5 and2( w2.Adder0.csa4x2_0_lvl0.10, w0.Adder0.csa4x2_0_lvl0.10, PP_2_10 )#5 or2( cout_csa4x2_0_lvl0.10, w1.Adder0.csa4x2_0_lvl0.10, w2.Adder0.csa4x2_0_lvl0.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.10( s0_lvl0_10, t0_lvl0_10, sintcsa4x2_0_lvl0.10, PP_3_10, cout_csa4x2_0_lvl0.9) // sum xor2( w0.Adder1.csa4x2_0_lvl0.10, sintcsa4x2_0_lvl0.10, PP_3_10 )#5 xor2( s0_lvl0_10, w0.Adder1.csa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.9 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.10, sintcsa4x2_0_lvl0.10, PP_3_10 )#5 and2( w2.Adder1.csa4x2_0_lvl0.10, w0.Adder1.csa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.9 )#5 or2( t0_lvl0_10, w1.Adder1.csa4x2_0_lvl0.10, w2.Adder1.csa4x2_0_lvl0.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.11, s0_lvl0_11,t0_lvl0_11,cout_csa4x2_0_lvl0.11,PP_0_11,PP_1_11,PP_2_11,PP_3_11,cout_csa4x2_0_lvl0.10) ; // adder1bit Adder0.csa4x2_0_lvl0.11( sintcsa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.11, PP_0_11, PP_1_11, PP_2_11) // sum xor2( w0.Adder0.csa4x2_0_lvl0.11, PP_0_11, PP_1_11 )#5 xor2( sintcsa4x2_0_lvl0.11, w0.Adder0.csa4x2_0_lvl0.11, PP_2_11 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.11, PP_0_11, PP_1_11 )#5 and2( w2.Adder0.csa4x2_0_lvl0.11, w0.Adder0.csa4x2_0_lvl0.11, PP_2_11 )#5 or2( cout_csa4x2_0_lvl0.11, w1.Adder0.csa4x2_0_lvl0.11, w2.Adder0.csa4x2_0_lvl0.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.11( s0_lvl0_11, t0_lvl0_11, sintcsa4x2_0_lvl0.11, PP_3_11, cout_csa4x2_0_lvl0.10) // sum xor2( w0.Adder1.csa4x2_0_lvl0.11, sintcsa4x2_0_lvl0.11, PP_3_11 )#5 xor2( s0_lvl0_11, w0.Adder1.csa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.10 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.11, sintcsa4x2_0_lvl0.11, PP_3_11 )#5 and2( w2.Adder1.csa4x2_0_lvl0.11, w0.Adder1.csa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.10 )#5 or2( t0_lvl0_11, w1.Adder1.csa4x2_0_lvl0.11, w2.Adder1.csa4x2_0_lvl0.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.12, s0_lvl0_12,t0_lvl0_12,cout_csa4x2_0_lvl0.12,PP_0_12,PP_1_12,PP_2_12,PP_3_12,cout_csa4x2_0_lvl0.11) ; // adder1bit Adder0.csa4x2_0_lvl0.12( sintcsa4x2_0_lvl0.12, cout_csa4x2_0_lvl0.12, PP_0_12, PP_1_12, PP_2_12) // sum xor2( w0.Adder0.csa4x2_0_lvl0.12, PP_0_12, PP_1_12 )#5 xor2( sintcsa4x2_0_lvl0.12, w0.Adder0.csa4x2_0_lvl0.12, PP_2_12 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.12, PP_0_12, PP_1_12 )#5 and2( w2.Adder0.csa4x2_0_lvl0.12, w0.Adder0.csa4x2_0_lvl0.12, PP_2_12 )#5 or2( cout_csa4x2_0_lvl0.12, w1.Adder0.csa4x2_0_lvl0.12, w2.Adder0.csa4x2_0_lvl0.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.12( s0_lvl0_12, t0_lvl0_12, sintcsa4x2_0_lvl0.12, PP_3_12, cout_csa4x2_0_lvl0.11) // sum xor2( w0.Adder1.csa4x2_0_lvl0.12, sintcsa4x2_0_lvl0.12, PP_3_12 )#5 xor2( s0_lvl0_12, w0.Adder1.csa4x2_0_lvl0.12, cout_csa4x2_0_lvl0.11 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.12, sintcsa4x2_0_lvl0.12, PP_3_12 )#5 and2( w2.Adder1.csa4x2_0_lvl0.12, w0.Adder1.csa4x2_0_lvl0.12, cout_csa4x2_0_lvl0.11 )#5 or2( t0_lvl0_12, w1.Adder1.csa4x2_0_lvl0.12, w2.Adder1.csa4x2_0_lvl0.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.13, s0_lvl0_13,t0_lvl0_13,cout_csa4x2_0_lvl0.13,PP_0_13,PP_1_13,PP_2_13,PP_3_13,cout_csa4x2_0_lvl0.12) ; // adder1bit Adder0.csa4x2_0_lvl0.13( sintcsa4x2_0_lvl0.13, cout_csa4x2_0_lvl0.13, PP_0_13, PP_1_13, PP_2_13) // sum xor2( w0.Adder0.csa4x2_0_lvl0.13, PP_0_13, PP_1_13 )#5 xor2( sintcsa4x2_0_lvl0.13, w0.Adder0.csa4x2_0_lvl0.13, PP_2_13 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.13, PP_0_13, PP_1_13 )#5 and2( w2.Adder0.csa4x2_0_lvl0.13, w0.Adder0.csa4x2_0_lvl0.13, PP_2_13 )#5 or2( cout_csa4x2_0_lvl0.13, w1.Adder0.csa4x2_0_lvl0.13, w2.Adder0.csa4x2_0_lvl0.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.13( s0_lvl0_13, t0_lvl0_13, sintcsa4x2_0_lvl0.13, PP_3_13, cout_csa4x2_0_lvl0.12) // sum xor2( w0.Adder1.csa4x2_0_lvl0.13, sintcsa4x2_0_lvl0.13, PP_3_13 )#5 xor2( s0_lvl0_13, w0.Adder1.csa4x2_0_lvl0.13, cout_csa4x2_0_lvl0.12 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.13, sintcsa4x2_0_lvl0.13, PP_3_13 )#5 and2( w2.Adder1.csa4x2_0_lvl0.13, w0.Adder1.csa4x2_0_lvl0.13, cout_csa4x2_0_lvl0.12 )#5 or2( t0_lvl0_13, w1.Adder1.csa4x2_0_lvl0.13, w2.Adder1.csa4x2_0_lvl0.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.14, s0_lvl0_14,t0_lvl0_14,cout_csa4x2_0_lvl0.14,PP_0_14,PP_1_14,PP_2_14,PP_3_14,cout_csa4x2_0_lvl0.13) ; // adder1bit Adder0.csa4x2_0_lvl0.14( sintcsa4x2_0_lvl0.14, cout_csa4x2_0_lvl0.14, PP_0_14, PP_1_14, PP_2_14) // sum xor2( w0.Adder0.csa4x2_0_lvl0.14, PP_0_14, PP_1_14 )#5 xor2( sintcsa4x2_0_lvl0.14, w0.Adder0.csa4x2_0_lvl0.14, PP_2_14 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.14, PP_0_14, PP_1_14 )#5 and2( w2.Adder0.csa4x2_0_lvl0.14, w0.Adder0.csa4x2_0_lvl0.14, PP_2_14 )#5 or2( cout_csa4x2_0_lvl0.14, w1.Adder0.csa4x2_0_lvl0.14, w2.Adder0.csa4x2_0_lvl0.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.14( s0_lvl0_14, t0_lvl0_14, sintcsa4x2_0_lvl0.14, PP_3_14, cout_csa4x2_0_lvl0.13) // sum xor2( w0.Adder1.csa4x2_0_lvl0.14, sintcsa4x2_0_lvl0.14, PP_3_14 )#5 xor2( s0_lvl0_14, w0.Adder1.csa4x2_0_lvl0.14, cout_csa4x2_0_lvl0.13 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.14, sintcsa4x2_0_lvl0.14, PP_3_14 )#5 and2( w2.Adder1.csa4x2_0_lvl0.14, w0.Adder1.csa4x2_0_lvl0.14, cout_csa4x2_0_lvl0.13 )#5 or2( t0_lvl0_14, w1.Adder1.csa4x2_0_lvl0.14, w2.Adder1.csa4x2_0_lvl0.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.15, s0_lvl0_15,t0_lvl0_15,cout_csa4x2_0_lvl0.15,PP_0_15,PP_1_15,PP_2_15,PP_3_15,cout_csa4x2_0_lvl0.14) ; // adder1bit Adder0.csa4x2_0_lvl0.15( sintcsa4x2_0_lvl0.15, cout_csa4x2_0_lvl0.15, PP_0_15, PP_1_15, PP_2_15) // sum xor2( w0.Adder0.csa4x2_0_lvl0.15, PP_0_15, PP_1_15 )#5 xor2( sintcsa4x2_0_lvl0.15, w0.Adder0.csa4x2_0_lvl0.15, PP_2_15 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.15, PP_0_15, PP_1_15 )#5 and2( w2.Adder0.csa4x2_0_lvl0.15, w0.Adder0.csa4x2_0_lvl0.15, PP_2_15 )#5 or2( cout_csa4x2_0_lvl0.15, w1.Adder0.csa4x2_0_lvl0.15, w2.Adder0.csa4x2_0_lvl0.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.15( s0_lvl0_15, t0_lvl0_15, sintcsa4x2_0_lvl0.15, PP_3_15, cout_csa4x2_0_lvl0.14) // sum xor2( w0.Adder1.csa4x2_0_lvl0.15, sintcsa4x2_0_lvl0.15, PP_3_15 )#5 xor2( s0_lvl0_15, w0.Adder1.csa4x2_0_lvl0.15, cout_csa4x2_0_lvl0.14 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.15, sintcsa4x2_0_lvl0.15, PP_3_15 )#5 and2( w2.Adder1.csa4x2_0_lvl0.15, w0.Adder1.csa4x2_0_lvl0.15, cout_csa4x2_0_lvl0.14 )#5 or2( t0_lvl0_15, w1.Adder1.csa4x2_0_lvl0.15, w2.Adder1.csa4x2_0_lvl0.15 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.0, s4_lvl0_0,t4_lvl0_0,cout_csa4x2_4_lvl0.0,PP_4_0,PP_5_0,PP_6_0,PP_7_0,GND) ; // adder1bit Adder0.csa4x2_4_lvl0.0( sintcsa4x2_4_lvl0.0, cout_csa4x2_4_lvl0.0, PP_4_0, PP_5_0, PP_6_0) // sum xor2( w0.Adder0.csa4x2_4_lvl0.0, PP_4_0, PP_5_0 )#5 xor2( sintcsa4x2_4_lvl0.0, w0.Adder0.csa4x2_4_lvl0.0, PP_6_0 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.0, PP_4_0, PP_5_0 )#5 and2( w2.Adder0.csa4x2_4_lvl0.0, w0.Adder0.csa4x2_4_lvl0.0, PP_6_0 )#5 or2( cout_csa4x2_4_lvl0.0, w1.Adder0.csa4x2_4_lvl0.0, w2.Adder0.csa4x2_4_lvl0.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.0( s4_lvl0_0, t4_lvl0_0, sintcsa4x2_4_lvl0.0, PP_7_0, GND) // sum xor2( w0.Adder1.csa4x2_4_lvl0.0, sintcsa4x2_4_lvl0.0, PP_7_0 )#5 xor2( s4_lvl0_0, w0.Adder1.csa4x2_4_lvl0.0, GND )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.0, sintcsa4x2_4_lvl0.0, PP_7_0 )#5 and2( w2.Adder1.csa4x2_4_lvl0.0, w0.Adder1.csa4x2_4_lvl0.0, GND )#5 or2( t4_lvl0_0, w1.Adder1.csa4x2_4_lvl0.0, w2.Adder1.csa4x2_4_lvl0.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.1, s4_lvl0_1,t4_lvl0_1,cout_csa4x2_4_lvl0.1,PP_4_1,PP_5_1,PP_6_1,PP_7_1,cout_csa4x2_4_lvl0.0) ; // adder1bit Adder0.csa4x2_4_lvl0.1( sintcsa4x2_4_lvl0.1, cout_csa4x2_4_lvl0.1, PP_4_1, PP_5_1, PP_6_1) // sum xor2( w0.Adder0.csa4x2_4_lvl0.1, PP_4_1, PP_5_1 )#5 xor2( sintcsa4x2_4_lvl0.1, w0.Adder0.csa4x2_4_lvl0.1, PP_6_1 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.1, PP_4_1, PP_5_1 )#5 and2( w2.Adder0.csa4x2_4_lvl0.1, w0.Adder0.csa4x2_4_lvl0.1, PP_6_1 )#5 or2( cout_csa4x2_4_lvl0.1, w1.Adder0.csa4x2_4_lvl0.1, w2.Adder0.csa4x2_4_lvl0.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.1( s4_lvl0_1, t4_lvl0_1, sintcsa4x2_4_lvl0.1, PP_7_1, cout_csa4x2_4_lvl0.0) // sum xor2( w0.Adder1.csa4x2_4_lvl0.1, sintcsa4x2_4_lvl0.1, PP_7_1 )#5 xor2( s4_lvl0_1, w0.Adder1.csa4x2_4_lvl0.1, cout_csa4x2_4_lvl0.0 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.1, sintcsa4x2_4_lvl0.1, PP_7_1 )#5 and2( w2.Adder1.csa4x2_4_lvl0.1, w0.Adder1.csa4x2_4_lvl0.1, cout_csa4x2_4_lvl0.0 )#5 or2( t4_lvl0_1, w1.Adder1.csa4x2_4_lvl0.1, w2.Adder1.csa4x2_4_lvl0.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.2, s4_lvl0_2,t4_lvl0_2,cout_csa4x2_4_lvl0.2,PP_4_2,PP_5_2,PP_6_2,PP_7_2,cout_csa4x2_4_lvl0.1) ; // adder1bit Adder0.csa4x2_4_lvl0.2( sintcsa4x2_4_lvl0.2, cout_csa4x2_4_lvl0.2, PP_4_2, PP_5_2, PP_6_2) // sum xor2( w0.Adder0.csa4x2_4_lvl0.2, PP_4_2, PP_5_2 )#5 xor2( sintcsa4x2_4_lvl0.2, w0.Adder0.csa4x2_4_lvl0.2, PP_6_2 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.2, PP_4_2, PP_5_2 )#5 and2( w2.Adder0.csa4x2_4_lvl0.2, w0.Adder0.csa4x2_4_lvl0.2, PP_6_2 )#5 or2( cout_csa4x2_4_lvl0.2, w1.Adder0.csa4x2_4_lvl0.2, w2.Adder0.csa4x2_4_lvl0.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.2( s4_lvl0_2, t4_lvl0_2, sintcsa4x2_4_lvl0.2, PP_7_2, cout_csa4x2_4_lvl0.1) // sum xor2( w0.Adder1.csa4x2_4_lvl0.2, sintcsa4x2_4_lvl0.2, PP_7_2 )#5 xor2( s4_lvl0_2, w0.Adder1.csa4x2_4_lvl0.2, cout_csa4x2_4_lvl0.1 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.2, sintcsa4x2_4_lvl0.2, PP_7_2 )#5 and2( w2.Adder1.csa4x2_4_lvl0.2, w0.Adder1.csa4x2_4_lvl0.2, cout_csa4x2_4_lvl0.1 )#5 or2( t4_lvl0_2, w1.Adder1.csa4x2_4_lvl0.2, w2.Adder1.csa4x2_4_lvl0.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.3, s4_lvl0_3,t4_lvl0_3,cout_csa4x2_4_lvl0.3,PP_4_3,PP_5_3,PP_6_3,PP_7_3,cout_csa4x2_4_lvl0.2) ; // adder1bit Adder0.csa4x2_4_lvl0.3( sintcsa4x2_4_lvl0.3, cout_csa4x2_4_lvl0.3, PP_4_3, PP_5_3, PP_6_3) // sum xor2( w0.Adder0.csa4x2_4_lvl0.3, PP_4_3, PP_5_3 )#5 xor2( sintcsa4x2_4_lvl0.3, w0.Adder0.csa4x2_4_lvl0.3, PP_6_3 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.3, PP_4_3, PP_5_3 )#5 and2( w2.Adder0.csa4x2_4_lvl0.3, w0.Adder0.csa4x2_4_lvl0.3, PP_6_3 )#5 or2( cout_csa4x2_4_lvl0.3, w1.Adder0.csa4x2_4_lvl0.3, w2.Adder0.csa4x2_4_lvl0.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.3( s4_lvl0_3, t4_lvl0_3, sintcsa4x2_4_lvl0.3, PP_7_3, cout_csa4x2_4_lvl0.2) // sum xor2( w0.Adder1.csa4x2_4_lvl0.3, sintcsa4x2_4_lvl0.3, PP_7_3 )#5 xor2( s4_lvl0_3, w0.Adder1.csa4x2_4_lvl0.3, cout_csa4x2_4_lvl0.2 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.3, sintcsa4x2_4_lvl0.3, PP_7_3 )#5 and2( w2.Adder1.csa4x2_4_lvl0.3, w0.Adder1.csa4x2_4_lvl0.3, cout_csa4x2_4_lvl0.2 )#5 or2( t4_lvl0_3, w1.Adder1.csa4x2_4_lvl0.3, w2.Adder1.csa4x2_4_lvl0.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.4, s4_lvl0_4,t4_lvl0_4,cout_csa4x2_4_lvl0.4,PP_4_4,PP_5_4,PP_6_4,PP_7_4,cout_csa4x2_4_lvl0.3) ; // adder1bit Adder0.csa4x2_4_lvl0.4( sintcsa4x2_4_lvl0.4, cout_csa4x2_4_lvl0.4, PP_4_4, PP_5_4, PP_6_4) // sum xor2( w0.Adder0.csa4x2_4_lvl0.4, PP_4_4, PP_5_4 )#5 xor2( sintcsa4x2_4_lvl0.4, w0.Adder0.csa4x2_4_lvl0.4, PP_6_4 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.4, PP_4_4, PP_5_4 )#5 and2( w2.Adder0.csa4x2_4_lvl0.4, w0.Adder0.csa4x2_4_lvl0.4, PP_6_4 )#5 or2( cout_csa4x2_4_lvl0.4, w1.Adder0.csa4x2_4_lvl0.4, w2.Adder0.csa4x2_4_lvl0.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.4( s4_lvl0_4, t4_lvl0_4, sintcsa4x2_4_lvl0.4, PP_7_4, cout_csa4x2_4_lvl0.3) // sum xor2( w0.Adder1.csa4x2_4_lvl0.4, sintcsa4x2_4_lvl0.4, PP_7_4 )#5 xor2( s4_lvl0_4, w0.Adder1.csa4x2_4_lvl0.4, cout_csa4x2_4_lvl0.3 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.4, sintcsa4x2_4_lvl0.4, PP_7_4 )#5 and2( w2.Adder1.csa4x2_4_lvl0.4, w0.Adder1.csa4x2_4_lvl0.4, cout_csa4x2_4_lvl0.3 )#5 or2( t4_lvl0_4, w1.Adder1.csa4x2_4_lvl0.4, w2.Adder1.csa4x2_4_lvl0.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.5, s4_lvl0_5,t4_lvl0_5,cout_csa4x2_4_lvl0.5,PP_4_5,PP_5_5,PP_6_5,PP_7_5,cout_csa4x2_4_lvl0.4) ; // adder1bit Adder0.csa4x2_4_lvl0.5( sintcsa4x2_4_lvl0.5, cout_csa4x2_4_lvl0.5, PP_4_5, PP_5_5, PP_6_5) // sum xor2( w0.Adder0.csa4x2_4_lvl0.5, PP_4_5, PP_5_5 )#5 xor2( sintcsa4x2_4_lvl0.5, w0.Adder0.csa4x2_4_lvl0.5, PP_6_5 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.5, PP_4_5, PP_5_5 )#5 and2( w2.Adder0.csa4x2_4_lvl0.5, w0.Adder0.csa4x2_4_lvl0.5, PP_6_5 )#5 or2( cout_csa4x2_4_lvl0.5, w1.Adder0.csa4x2_4_lvl0.5, w2.Adder0.csa4x2_4_lvl0.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.5( s4_lvl0_5, t4_lvl0_5, sintcsa4x2_4_lvl0.5, PP_7_5, cout_csa4x2_4_lvl0.4) // sum xor2( w0.Adder1.csa4x2_4_lvl0.5, sintcsa4x2_4_lvl0.5, PP_7_5 )#5 xor2( s4_lvl0_5, w0.Adder1.csa4x2_4_lvl0.5, cout_csa4x2_4_lvl0.4 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.5, sintcsa4x2_4_lvl0.5, PP_7_5 )#5 and2( w2.Adder1.csa4x2_4_lvl0.5, w0.Adder1.csa4x2_4_lvl0.5, cout_csa4x2_4_lvl0.4 )#5 or2( t4_lvl0_5, w1.Adder1.csa4x2_4_lvl0.5, w2.Adder1.csa4x2_4_lvl0.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.6, s4_lvl0_6,t4_lvl0_6,cout_csa4x2_4_lvl0.6,PP_4_6,PP_5_6,PP_6_6,PP_7_6,cout_csa4x2_4_lvl0.5) ; // adder1bit Adder0.csa4x2_4_lvl0.6( sintcsa4x2_4_lvl0.6, cout_csa4x2_4_lvl0.6, PP_4_6, PP_5_6, PP_6_6) // sum xor2( w0.Adder0.csa4x2_4_lvl0.6, PP_4_6, PP_5_6 )#5 xor2( sintcsa4x2_4_lvl0.6, w0.Adder0.csa4x2_4_lvl0.6, PP_6_6 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.6, PP_4_6, PP_5_6 )#5 and2( w2.Adder0.csa4x2_4_lvl0.6, w0.Adder0.csa4x2_4_lvl0.6, PP_6_6 )#5 or2( cout_csa4x2_4_lvl0.6, w1.Adder0.csa4x2_4_lvl0.6, w2.Adder0.csa4x2_4_lvl0.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.6( s4_lvl0_6, t4_lvl0_6, sintcsa4x2_4_lvl0.6, PP_7_6, cout_csa4x2_4_lvl0.5) // sum xor2( w0.Adder1.csa4x2_4_lvl0.6, sintcsa4x2_4_lvl0.6, PP_7_6 )#5 xor2( s4_lvl0_6, w0.Adder1.csa4x2_4_lvl0.6, cout_csa4x2_4_lvl0.5 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.6, sintcsa4x2_4_lvl0.6, PP_7_6 )#5 and2( w2.Adder1.csa4x2_4_lvl0.6, w0.Adder1.csa4x2_4_lvl0.6, cout_csa4x2_4_lvl0.5 )#5 or2( t4_lvl0_6, w1.Adder1.csa4x2_4_lvl0.6, w2.Adder1.csa4x2_4_lvl0.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.7, s4_lvl0_7,t4_lvl0_7,cout_csa4x2_4_lvl0.7,PP_4_7,PP_5_7,PP_6_7,PP_7_7,cout_csa4x2_4_lvl0.6) ; // adder1bit Adder0.csa4x2_4_lvl0.7( sintcsa4x2_4_lvl0.7, cout_csa4x2_4_lvl0.7, PP_4_7, PP_5_7, PP_6_7) // sum xor2( w0.Adder0.csa4x2_4_lvl0.7, PP_4_7, PP_5_7 )#5 xor2( sintcsa4x2_4_lvl0.7, w0.Adder0.csa4x2_4_lvl0.7, PP_6_7 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.7, PP_4_7, PP_5_7 )#5 and2( w2.Adder0.csa4x2_4_lvl0.7, w0.Adder0.csa4x2_4_lvl0.7, PP_6_7 )#5 or2( cout_csa4x2_4_lvl0.7, w1.Adder0.csa4x2_4_lvl0.7, w2.Adder0.csa4x2_4_lvl0.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.7( s4_lvl0_7, t4_lvl0_7, sintcsa4x2_4_lvl0.7, PP_7_7, cout_csa4x2_4_lvl0.6) // sum xor2( w0.Adder1.csa4x2_4_lvl0.7, sintcsa4x2_4_lvl0.7, PP_7_7 )#5 xor2( s4_lvl0_7, w0.Adder1.csa4x2_4_lvl0.7, cout_csa4x2_4_lvl0.6 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.7, sintcsa4x2_4_lvl0.7, PP_7_7 )#5 and2( w2.Adder1.csa4x2_4_lvl0.7, w0.Adder1.csa4x2_4_lvl0.7, cout_csa4x2_4_lvl0.6 )#5 or2( t4_lvl0_7, w1.Adder1.csa4x2_4_lvl0.7, w2.Adder1.csa4x2_4_lvl0.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.8, s4_lvl0_8,t4_lvl0_8,cout_csa4x2_4_lvl0.8,PP_4_8,PP_5_8,PP_6_8,PP_7_8,cout_csa4x2_4_lvl0.7) ; // adder1bit Adder0.csa4x2_4_lvl0.8( sintcsa4x2_4_lvl0.8, cout_csa4x2_4_lvl0.8, PP_4_8, PP_5_8, PP_6_8) // sum xor2( w0.Adder0.csa4x2_4_lvl0.8, PP_4_8, PP_5_8 )#5 xor2( sintcsa4x2_4_lvl0.8, w0.Adder0.csa4x2_4_lvl0.8, PP_6_8 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.8, PP_4_8, PP_5_8 )#5 and2( w2.Adder0.csa4x2_4_lvl0.8, w0.Adder0.csa4x2_4_lvl0.8, PP_6_8 )#5 or2( cout_csa4x2_4_lvl0.8, w1.Adder0.csa4x2_4_lvl0.8, w2.Adder0.csa4x2_4_lvl0.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.8( s4_lvl0_8, t4_lvl0_8, sintcsa4x2_4_lvl0.8, PP_7_8, cout_csa4x2_4_lvl0.7) // sum xor2( w0.Adder1.csa4x2_4_lvl0.8, sintcsa4x2_4_lvl0.8, PP_7_8 )#5 xor2( s4_lvl0_8, w0.Adder1.csa4x2_4_lvl0.8, cout_csa4x2_4_lvl0.7 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.8, sintcsa4x2_4_lvl0.8, PP_7_8 )#5 and2( w2.Adder1.csa4x2_4_lvl0.8, w0.Adder1.csa4x2_4_lvl0.8, cout_csa4x2_4_lvl0.7 )#5 or2( t4_lvl0_8, w1.Adder1.csa4x2_4_lvl0.8, w2.Adder1.csa4x2_4_lvl0.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.9, s4_lvl0_9,t4_lvl0_9,cout_csa4x2_4_lvl0.9,PP_4_9,PP_5_9,PP_6_9,PP_7_9,cout_csa4x2_4_lvl0.8) ; // adder1bit Adder0.csa4x2_4_lvl0.9( sintcsa4x2_4_lvl0.9, cout_csa4x2_4_lvl0.9, PP_4_9, PP_5_9, PP_6_9) // sum xor2( w0.Adder0.csa4x2_4_lvl0.9, PP_4_9, PP_5_9 )#5 xor2( sintcsa4x2_4_lvl0.9, w0.Adder0.csa4x2_4_lvl0.9, PP_6_9 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.9, PP_4_9, PP_5_9 )#5 and2( w2.Adder0.csa4x2_4_lvl0.9, w0.Adder0.csa4x2_4_lvl0.9, PP_6_9 )#5 or2( cout_csa4x2_4_lvl0.9, w1.Adder0.csa4x2_4_lvl0.9, w2.Adder0.csa4x2_4_lvl0.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.9( s4_lvl0_9, t4_lvl0_9, sintcsa4x2_4_lvl0.9, PP_7_9, cout_csa4x2_4_lvl0.8) // sum xor2( w0.Adder1.csa4x2_4_lvl0.9, sintcsa4x2_4_lvl0.9, PP_7_9 )#5 xor2( s4_lvl0_9, w0.Adder1.csa4x2_4_lvl0.9, cout_csa4x2_4_lvl0.8 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.9, sintcsa4x2_4_lvl0.9, PP_7_9 )#5 and2( w2.Adder1.csa4x2_4_lvl0.9, w0.Adder1.csa4x2_4_lvl0.9, cout_csa4x2_4_lvl0.8 )#5 or2( t4_lvl0_9, w1.Adder1.csa4x2_4_lvl0.9, w2.Adder1.csa4x2_4_lvl0.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.10, s4_lvl0_10,t4_lvl0_10,cout_csa4x2_4_lvl0.10,PP_4_10,PP_5_10,PP_6_10,PP_7_10,cout_csa4x2_4_lvl0.9) ; // adder1bit Adder0.csa4x2_4_lvl0.10( sintcsa4x2_4_lvl0.10, cout_csa4x2_4_lvl0.10, PP_4_10, PP_5_10, PP_6_10) // sum xor2( w0.Adder0.csa4x2_4_lvl0.10, PP_4_10, PP_5_10 )#5 xor2( sintcsa4x2_4_lvl0.10, w0.Adder0.csa4x2_4_lvl0.10, PP_6_10 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.10, PP_4_10, PP_5_10 )#5 and2( w2.Adder0.csa4x2_4_lvl0.10, w0.Adder0.csa4x2_4_lvl0.10, PP_6_10 )#5 or2( cout_csa4x2_4_lvl0.10, w1.Adder0.csa4x2_4_lvl0.10, w2.Adder0.csa4x2_4_lvl0.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.10( s4_lvl0_10, t4_lvl0_10, sintcsa4x2_4_lvl0.10, PP_7_10, cout_csa4x2_4_lvl0.9) // sum xor2( w0.Adder1.csa4x2_4_lvl0.10, sintcsa4x2_4_lvl0.10, PP_7_10 )#5 xor2( s4_lvl0_10, w0.Adder1.csa4x2_4_lvl0.10, cout_csa4x2_4_lvl0.9 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.10, sintcsa4x2_4_lvl0.10, PP_7_10 )#5 and2( w2.Adder1.csa4x2_4_lvl0.10, w0.Adder1.csa4x2_4_lvl0.10, cout_csa4x2_4_lvl0.9 )#5 or2( t4_lvl0_10, w1.Adder1.csa4x2_4_lvl0.10, w2.Adder1.csa4x2_4_lvl0.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.11, s4_lvl0_11,t4_lvl0_11,cout_csa4x2_4_lvl0.11,PP_4_11,PP_5_11,PP_6_11,PP_7_11,cout_csa4x2_4_lvl0.10) ; // adder1bit Adder0.csa4x2_4_lvl0.11( sintcsa4x2_4_lvl0.11, cout_csa4x2_4_lvl0.11, PP_4_11, PP_5_11, PP_6_11) // sum xor2( w0.Adder0.csa4x2_4_lvl0.11, PP_4_11, PP_5_11 )#5 xor2( sintcsa4x2_4_lvl0.11, w0.Adder0.csa4x2_4_lvl0.11, PP_6_11 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.11, PP_4_11, PP_5_11 )#5 and2( w2.Adder0.csa4x2_4_lvl0.11, w0.Adder0.csa4x2_4_lvl0.11, PP_6_11 )#5 or2( cout_csa4x2_4_lvl0.11, w1.Adder0.csa4x2_4_lvl0.11, w2.Adder0.csa4x2_4_lvl0.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.11( s4_lvl0_11, t4_lvl0_11, sintcsa4x2_4_lvl0.11, PP_7_11, cout_csa4x2_4_lvl0.10) // sum xor2( w0.Adder1.csa4x2_4_lvl0.11, sintcsa4x2_4_lvl0.11, PP_7_11 )#5 xor2( s4_lvl0_11, w0.Adder1.csa4x2_4_lvl0.11, cout_csa4x2_4_lvl0.10 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.11, sintcsa4x2_4_lvl0.11, PP_7_11 )#5 and2( w2.Adder1.csa4x2_4_lvl0.11, w0.Adder1.csa4x2_4_lvl0.11, cout_csa4x2_4_lvl0.10 )#5 or2( t4_lvl0_11, w1.Adder1.csa4x2_4_lvl0.11, w2.Adder1.csa4x2_4_lvl0.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.12, s4_lvl0_12,t4_lvl0_12,cout_csa4x2_4_lvl0.12,PP_4_12,PP_5_12,PP_6_12,PP_7_12,cout_csa4x2_4_lvl0.11) ; // adder1bit Adder0.csa4x2_4_lvl0.12( sintcsa4x2_4_lvl0.12, cout_csa4x2_4_lvl0.12, PP_4_12, PP_5_12, PP_6_12) // sum xor2( w0.Adder0.csa4x2_4_lvl0.12, PP_4_12, PP_5_12 )#5 xor2( sintcsa4x2_4_lvl0.12, w0.Adder0.csa4x2_4_lvl0.12, PP_6_12 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.12, PP_4_12, PP_5_12 )#5 and2( w2.Adder0.csa4x2_4_lvl0.12, w0.Adder0.csa4x2_4_lvl0.12, PP_6_12 )#5 or2( cout_csa4x2_4_lvl0.12, w1.Adder0.csa4x2_4_lvl0.12, w2.Adder0.csa4x2_4_lvl0.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.12( s4_lvl0_12, t4_lvl0_12, sintcsa4x2_4_lvl0.12, PP_7_12, cout_csa4x2_4_lvl0.11) // sum xor2( w0.Adder1.csa4x2_4_lvl0.12, sintcsa4x2_4_lvl0.12, PP_7_12 )#5 xor2( s4_lvl0_12, w0.Adder1.csa4x2_4_lvl0.12, cout_csa4x2_4_lvl0.11 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.12, sintcsa4x2_4_lvl0.12, PP_7_12 )#5 and2( w2.Adder1.csa4x2_4_lvl0.12, w0.Adder1.csa4x2_4_lvl0.12, cout_csa4x2_4_lvl0.11 )#5 or2( t4_lvl0_12, w1.Adder1.csa4x2_4_lvl0.12, w2.Adder1.csa4x2_4_lvl0.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.13, s4_lvl0_13,t4_lvl0_13,cout_csa4x2_4_lvl0.13,PP_4_13,PP_5_13,PP_6_13,PP_7_13,cout_csa4x2_4_lvl0.12) ; // adder1bit Adder0.csa4x2_4_lvl0.13( sintcsa4x2_4_lvl0.13, cout_csa4x2_4_lvl0.13, PP_4_13, PP_5_13, PP_6_13) // sum xor2( w0.Adder0.csa4x2_4_lvl0.13, PP_4_13, PP_5_13 )#5 xor2( sintcsa4x2_4_lvl0.13, w0.Adder0.csa4x2_4_lvl0.13, PP_6_13 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.13, PP_4_13, PP_5_13 )#5 and2( w2.Adder0.csa4x2_4_lvl0.13, w0.Adder0.csa4x2_4_lvl0.13, PP_6_13 )#5 or2( cout_csa4x2_4_lvl0.13, w1.Adder0.csa4x2_4_lvl0.13, w2.Adder0.csa4x2_4_lvl0.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.13( s4_lvl0_13, t4_lvl0_13, sintcsa4x2_4_lvl0.13, PP_7_13, cout_csa4x2_4_lvl0.12) // sum xor2( w0.Adder1.csa4x2_4_lvl0.13, sintcsa4x2_4_lvl0.13, PP_7_13 )#5 xor2( s4_lvl0_13, w0.Adder1.csa4x2_4_lvl0.13, cout_csa4x2_4_lvl0.12 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.13, sintcsa4x2_4_lvl0.13, PP_7_13 )#5 and2( w2.Adder1.csa4x2_4_lvl0.13, w0.Adder1.csa4x2_4_lvl0.13, cout_csa4x2_4_lvl0.12 )#5 or2( t4_lvl0_13, w1.Adder1.csa4x2_4_lvl0.13, w2.Adder1.csa4x2_4_lvl0.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.14, s4_lvl0_14,t4_lvl0_14,cout_csa4x2_4_lvl0.14,PP_4_14,PP_5_14,PP_6_14,PP_7_14,cout_csa4x2_4_lvl0.13) ; // adder1bit Adder0.csa4x2_4_lvl0.14( sintcsa4x2_4_lvl0.14, cout_csa4x2_4_lvl0.14, PP_4_14, PP_5_14, PP_6_14) // sum xor2( w0.Adder0.csa4x2_4_lvl0.14, PP_4_14, PP_5_14 )#5 xor2( sintcsa4x2_4_lvl0.14, w0.Adder0.csa4x2_4_lvl0.14, PP_6_14 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.14, PP_4_14, PP_5_14 )#5 and2( w2.Adder0.csa4x2_4_lvl0.14, w0.Adder0.csa4x2_4_lvl0.14, PP_6_14 )#5 or2( cout_csa4x2_4_lvl0.14, w1.Adder0.csa4x2_4_lvl0.14, w2.Adder0.csa4x2_4_lvl0.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.14( s4_lvl0_14, t4_lvl0_14, sintcsa4x2_4_lvl0.14, PP_7_14, cout_csa4x2_4_lvl0.13) // sum xor2( w0.Adder1.csa4x2_4_lvl0.14, sintcsa4x2_4_lvl0.14, PP_7_14 )#5 xor2( s4_lvl0_14, w0.Adder1.csa4x2_4_lvl0.14, cout_csa4x2_4_lvl0.13 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.14, sintcsa4x2_4_lvl0.14, PP_7_14 )#5 and2( w2.Adder1.csa4x2_4_lvl0.14, w0.Adder1.csa4x2_4_lvl0.14, cout_csa4x2_4_lvl0.13 )#5 or2( t4_lvl0_14, w1.Adder1.csa4x2_4_lvl0.14, w2.Adder1.csa4x2_4_lvl0.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.15, s4_lvl0_15,t4_lvl0_15,cout_csa4x2_4_lvl0.15,PP_4_15,PP_5_15,PP_6_15,PP_7_15,cout_csa4x2_4_lvl0.14) ; // adder1bit Adder0.csa4x2_4_lvl0.15( sintcsa4x2_4_lvl0.15, cout_csa4x2_4_lvl0.15, PP_4_15, PP_5_15, PP_6_15) // sum xor2( w0.Adder0.csa4x2_4_lvl0.15, PP_4_15, PP_5_15 )#5 xor2( sintcsa4x2_4_lvl0.15, w0.Adder0.csa4x2_4_lvl0.15, PP_6_15 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.15, PP_4_15, PP_5_15 )#5 and2( w2.Adder0.csa4x2_4_lvl0.15, w0.Adder0.csa4x2_4_lvl0.15, PP_6_15 )#5 or2( cout_csa4x2_4_lvl0.15, w1.Adder0.csa4x2_4_lvl0.15, w2.Adder0.csa4x2_4_lvl0.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.15( s4_lvl0_15, t4_lvl0_15, sintcsa4x2_4_lvl0.15, PP_7_15, cout_csa4x2_4_lvl0.14) // sum xor2( w0.Adder1.csa4x2_4_lvl0.15, sintcsa4x2_4_lvl0.15, PP_7_15 )#5 xor2( s4_lvl0_15, w0.Adder1.csa4x2_4_lvl0.15, cout_csa4x2_4_lvl0.14 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.15, sintcsa4x2_4_lvl0.15, PP_7_15 )#5 and2( w2.Adder1.csa4x2_4_lvl0.15, w0.Adder1.csa4x2_4_lvl0.15, cout_csa4x2_4_lvl0.14 )#5 or2( t4_lvl0_15, w1.Adder1.csa4x2_4_lvl0.15, w2.Adder1.csa4x2_4_lvl0.15 )#5 // end adder1bit // end csa4x2 end // instantiating csa4x2Vec at lvl 1 netlist // csa4x2 (csa4x2_0_lvl1.0, s0_lvl1_0,t0_lvl1_0,cout_csa4x2_0_lvl1.0,s0_lvl0_0,GND,s4_lvl0_0,GND,GND) ; // adder1bit Adder0.csa4x2_0_lvl1.0( sintcsa4x2_0_lvl1.0, cout_csa4x2_0_lvl1.0, s0_lvl0_0, GND, s4_lvl0_0) // sum xor2( w0.Adder0.csa4x2_0_lvl1.0, s0_lvl0_0, GND )#5 xor2( sintcsa4x2_0_lvl1.0, w0.Adder0.csa4x2_0_lvl1.0, s4_lvl0_0 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.0, s0_lvl0_0, GND )#5 and2( w2.Adder0.csa4x2_0_lvl1.0, w0.Adder0.csa4x2_0_lvl1.0, s4_lvl0_0 )#5 or2( cout_csa4x2_0_lvl1.0, w1.Adder0.csa4x2_0_lvl1.0, w2.Adder0.csa4x2_0_lvl1.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.0( s0_lvl1_0, t0_lvl1_0, sintcsa4x2_0_lvl1.0, GND, GND) // sum xor2( w0.Adder1.csa4x2_0_lvl1.0, sintcsa4x2_0_lvl1.0, GND )#5 xor2( s0_lvl1_0, w0.Adder1.csa4x2_0_lvl1.0, GND )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.0, sintcsa4x2_0_lvl1.0, GND )#5 and2( w2.Adder1.csa4x2_0_lvl1.0, w0.Adder1.csa4x2_0_lvl1.0, GND )#5 or2( t0_lvl1_0, w1.Adder1.csa4x2_0_lvl1.0, w2.Adder1.csa4x2_0_lvl1.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.1, s0_lvl1_1,t0_lvl1_1,cout_csa4x2_0_lvl1.1,s0_lvl0_1,t0_lvl0_0,s4_lvl0_1,t4_lvl0_0,cout_csa4x2_0_lvl1.0) ; // adder1bit Adder0.csa4x2_0_lvl1.1( sintcsa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.1, s0_lvl0_1, t0_lvl0_0, s4_lvl0_1) // sum xor2( w0.Adder0.csa4x2_0_lvl1.1, s0_lvl0_1, t0_lvl0_0 )#5 xor2( sintcsa4x2_0_lvl1.1, w0.Adder0.csa4x2_0_lvl1.1, s4_lvl0_1 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.1, s0_lvl0_1, t0_lvl0_0 )#5 and2( w2.Adder0.csa4x2_0_lvl1.1, w0.Adder0.csa4x2_0_lvl1.1, s4_lvl0_1 )#5 or2( cout_csa4x2_0_lvl1.1, w1.Adder0.csa4x2_0_lvl1.1, w2.Adder0.csa4x2_0_lvl1.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.1( s0_lvl1_1, t0_lvl1_1, sintcsa4x2_0_lvl1.1, t4_lvl0_0, cout_csa4x2_0_lvl1.0) // sum xor2( w0.Adder1.csa4x2_0_lvl1.1, sintcsa4x2_0_lvl1.1, t4_lvl0_0 )#5 xor2( s0_lvl1_1, w0.Adder1.csa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.0 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.1, sintcsa4x2_0_lvl1.1, t4_lvl0_0 )#5 and2( w2.Adder1.csa4x2_0_lvl1.1, w0.Adder1.csa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.0 )#5 or2( t0_lvl1_1, w1.Adder1.csa4x2_0_lvl1.1, w2.Adder1.csa4x2_0_lvl1.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.2, s0_lvl1_2,t0_lvl1_2,cout_csa4x2_0_lvl1.2,s0_lvl0_2,t0_lvl0_1,s4_lvl0_2,t4_lvl0_1,cout_csa4x2_0_lvl1.1) ; // adder1bit Adder0.csa4x2_0_lvl1.2( sintcsa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.2, s0_lvl0_2, t0_lvl0_1, s4_lvl0_2) // sum xor2( w0.Adder0.csa4x2_0_lvl1.2, s0_lvl0_2, t0_lvl0_1 )#5 xor2( sintcsa4x2_0_lvl1.2, w0.Adder0.csa4x2_0_lvl1.2, s4_lvl0_2 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.2, s0_lvl0_2, t0_lvl0_1 )#5 and2( w2.Adder0.csa4x2_0_lvl1.2, w0.Adder0.csa4x2_0_lvl1.2, s4_lvl0_2 )#5 or2( cout_csa4x2_0_lvl1.2, w1.Adder0.csa4x2_0_lvl1.2, w2.Adder0.csa4x2_0_lvl1.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.2( s0_lvl1_2, t0_lvl1_2, sintcsa4x2_0_lvl1.2, t4_lvl0_1, cout_csa4x2_0_lvl1.1) // sum xor2( w0.Adder1.csa4x2_0_lvl1.2, sintcsa4x2_0_lvl1.2, t4_lvl0_1 )#5 xor2( s0_lvl1_2, w0.Adder1.csa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.1 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.2, sintcsa4x2_0_lvl1.2, t4_lvl0_1 )#5 and2( w2.Adder1.csa4x2_0_lvl1.2, w0.Adder1.csa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.1 )#5 or2( t0_lvl1_2, w1.Adder1.csa4x2_0_lvl1.2, w2.Adder1.csa4x2_0_lvl1.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.3, s0_lvl1_3,t0_lvl1_3,cout_csa4x2_0_lvl1.3,s0_lvl0_3,t0_lvl0_2,s4_lvl0_3,t4_lvl0_2,cout_csa4x2_0_lvl1.2) ; // adder1bit Adder0.csa4x2_0_lvl1.3( sintcsa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.3, s0_lvl0_3, t0_lvl0_2, s4_lvl0_3) // sum xor2( w0.Adder0.csa4x2_0_lvl1.3, s0_lvl0_3, t0_lvl0_2 )#5 xor2( sintcsa4x2_0_lvl1.3, w0.Adder0.csa4x2_0_lvl1.3, s4_lvl0_3 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.3, s0_lvl0_3, t0_lvl0_2 )#5 and2( w2.Adder0.csa4x2_0_lvl1.3, w0.Adder0.csa4x2_0_lvl1.3, s4_lvl0_3 )#5 or2( cout_csa4x2_0_lvl1.3, w1.Adder0.csa4x2_0_lvl1.3, w2.Adder0.csa4x2_0_lvl1.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.3( s0_lvl1_3, t0_lvl1_3, sintcsa4x2_0_lvl1.3, t4_lvl0_2, cout_csa4x2_0_lvl1.2) // sum xor2( w0.Adder1.csa4x2_0_lvl1.3, sintcsa4x2_0_lvl1.3, t4_lvl0_2 )#5 xor2( s0_lvl1_3, w0.Adder1.csa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.2 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.3, sintcsa4x2_0_lvl1.3, t4_lvl0_2 )#5 and2( w2.Adder1.csa4x2_0_lvl1.3, w0.Adder1.csa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.2 )#5 or2( t0_lvl1_3, w1.Adder1.csa4x2_0_lvl1.3, w2.Adder1.csa4x2_0_lvl1.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.4, s0_lvl1_4,t0_lvl1_4,cout_csa4x2_0_lvl1.4,s0_lvl0_4,t0_lvl0_3,s4_lvl0_4,t4_lvl0_3,cout_csa4x2_0_lvl1.3) ; // adder1bit Adder0.csa4x2_0_lvl1.4( sintcsa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.4, s0_lvl0_4, t0_lvl0_3, s4_lvl0_4) // sum xor2( w0.Adder0.csa4x2_0_lvl1.4, s0_lvl0_4, t0_lvl0_3 )#5 xor2( sintcsa4x2_0_lvl1.4, w0.Adder0.csa4x2_0_lvl1.4, s4_lvl0_4 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.4, s0_lvl0_4, t0_lvl0_3 )#5 and2( w2.Adder0.csa4x2_0_lvl1.4, w0.Adder0.csa4x2_0_lvl1.4, s4_lvl0_4 )#5 or2( cout_csa4x2_0_lvl1.4, w1.Adder0.csa4x2_0_lvl1.4, w2.Adder0.csa4x2_0_lvl1.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.4( s0_lvl1_4, t0_lvl1_4, sintcsa4x2_0_lvl1.4, t4_lvl0_3, cout_csa4x2_0_lvl1.3) // sum xor2( w0.Adder1.csa4x2_0_lvl1.4, sintcsa4x2_0_lvl1.4, t4_lvl0_3 )#5 xor2( s0_lvl1_4, w0.Adder1.csa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.3 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.4, sintcsa4x2_0_lvl1.4, t4_lvl0_3 )#5 and2( w2.Adder1.csa4x2_0_lvl1.4, w0.Adder1.csa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.3 )#5 or2( t0_lvl1_4, w1.Adder1.csa4x2_0_lvl1.4, w2.Adder1.csa4x2_0_lvl1.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.5, s0_lvl1_5,t0_lvl1_5,cout_csa4x2_0_lvl1.5,s0_lvl0_5,t0_lvl0_4,s4_lvl0_5,t4_lvl0_4,cout_csa4x2_0_lvl1.4) ; // adder1bit Adder0.csa4x2_0_lvl1.5( sintcsa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.5, s0_lvl0_5, t0_lvl0_4, s4_lvl0_5) // sum xor2( w0.Adder0.csa4x2_0_lvl1.5, s0_lvl0_5, t0_lvl0_4 )#5 xor2( sintcsa4x2_0_lvl1.5, w0.Adder0.csa4x2_0_lvl1.5, s4_lvl0_5 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.5, s0_lvl0_5, t0_lvl0_4 )#5 and2( w2.Adder0.csa4x2_0_lvl1.5, w0.Adder0.csa4x2_0_lvl1.5, s4_lvl0_5 )#5 or2( cout_csa4x2_0_lvl1.5, w1.Adder0.csa4x2_0_lvl1.5, w2.Adder0.csa4x2_0_lvl1.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.5( s0_lvl1_5, t0_lvl1_5, sintcsa4x2_0_lvl1.5, t4_lvl0_4, cout_csa4x2_0_lvl1.4) // sum xor2( w0.Adder1.csa4x2_0_lvl1.5, sintcsa4x2_0_lvl1.5, t4_lvl0_4 )#5 xor2( s0_lvl1_5, w0.Adder1.csa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.4 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.5, sintcsa4x2_0_lvl1.5, t4_lvl0_4 )#5 and2( w2.Adder1.csa4x2_0_lvl1.5, w0.Adder1.csa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.4 )#5 or2( t0_lvl1_5, w1.Adder1.csa4x2_0_lvl1.5, w2.Adder1.csa4x2_0_lvl1.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.6, s0_lvl1_6,t0_lvl1_6,cout_csa4x2_0_lvl1.6,s0_lvl0_6,t0_lvl0_5,s4_lvl0_6,t4_lvl0_5,cout_csa4x2_0_lvl1.5) ; // adder1bit Adder0.csa4x2_0_lvl1.6( sintcsa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.6, s0_lvl0_6, t0_lvl0_5, s4_lvl0_6) // sum xor2( w0.Adder0.csa4x2_0_lvl1.6, s0_lvl0_6, t0_lvl0_5 )#5 xor2( sintcsa4x2_0_lvl1.6, w0.Adder0.csa4x2_0_lvl1.6, s4_lvl0_6 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.6, s0_lvl0_6, t0_lvl0_5 )#5 and2( w2.Adder0.csa4x2_0_lvl1.6, w0.Adder0.csa4x2_0_lvl1.6, s4_lvl0_6 )#5 or2( cout_csa4x2_0_lvl1.6, w1.Adder0.csa4x2_0_lvl1.6, w2.Adder0.csa4x2_0_lvl1.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.6( s0_lvl1_6, t0_lvl1_6, sintcsa4x2_0_lvl1.6, t4_lvl0_5, cout_csa4x2_0_lvl1.5) // sum xor2( w0.Adder1.csa4x2_0_lvl1.6, sintcsa4x2_0_lvl1.6, t4_lvl0_5 )#5 xor2( s0_lvl1_6, w0.Adder1.csa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.5 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.6, sintcsa4x2_0_lvl1.6, t4_lvl0_5 )#5 and2( w2.Adder1.csa4x2_0_lvl1.6, w0.Adder1.csa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.5 )#5 or2( t0_lvl1_6, w1.Adder1.csa4x2_0_lvl1.6, w2.Adder1.csa4x2_0_lvl1.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.7, s0_lvl1_7,t0_lvl1_7,cout_csa4x2_0_lvl1.7,s0_lvl0_7,t0_lvl0_6,s4_lvl0_7,t4_lvl0_6,cout_csa4x2_0_lvl1.6) ; // adder1bit Adder0.csa4x2_0_lvl1.7( sintcsa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.7, s0_lvl0_7, t0_lvl0_6, s4_lvl0_7) // sum xor2( w0.Adder0.csa4x2_0_lvl1.7, s0_lvl0_7, t0_lvl0_6 )#5 xor2( sintcsa4x2_0_lvl1.7, w0.Adder0.csa4x2_0_lvl1.7, s4_lvl0_7 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.7, s0_lvl0_7, t0_lvl0_6 )#5 and2( w2.Adder0.csa4x2_0_lvl1.7, w0.Adder0.csa4x2_0_lvl1.7, s4_lvl0_7 )#5 or2( cout_csa4x2_0_lvl1.7, w1.Adder0.csa4x2_0_lvl1.7, w2.Adder0.csa4x2_0_lvl1.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.7( s0_lvl1_7, t0_lvl1_7, sintcsa4x2_0_lvl1.7, t4_lvl0_6, cout_csa4x2_0_lvl1.6) // sum xor2( w0.Adder1.csa4x2_0_lvl1.7, sintcsa4x2_0_lvl1.7, t4_lvl0_6 )#5 xor2( s0_lvl1_7, w0.Adder1.csa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.6 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.7, sintcsa4x2_0_lvl1.7, t4_lvl0_6 )#5 and2( w2.Adder1.csa4x2_0_lvl1.7, w0.Adder1.csa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.6 )#5 or2( t0_lvl1_7, w1.Adder1.csa4x2_0_lvl1.7, w2.Adder1.csa4x2_0_lvl1.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.8, s0_lvl1_8,t0_lvl1_8,cout_csa4x2_0_lvl1.8,s0_lvl0_8,t0_lvl0_7,s4_lvl0_8,t4_lvl0_7,cout_csa4x2_0_lvl1.7) ; // adder1bit Adder0.csa4x2_0_lvl1.8( sintcsa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.8, s0_lvl0_8, t0_lvl0_7, s4_lvl0_8) // sum xor2( w0.Adder0.csa4x2_0_lvl1.8, s0_lvl0_8, t0_lvl0_7 )#5 xor2( sintcsa4x2_0_lvl1.8, w0.Adder0.csa4x2_0_lvl1.8, s4_lvl0_8 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.8, s0_lvl0_8, t0_lvl0_7 )#5 and2( w2.Adder0.csa4x2_0_lvl1.8, w0.Adder0.csa4x2_0_lvl1.8, s4_lvl0_8 )#5 or2( cout_csa4x2_0_lvl1.8, w1.Adder0.csa4x2_0_lvl1.8, w2.Adder0.csa4x2_0_lvl1.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.8( s0_lvl1_8, t0_lvl1_8, sintcsa4x2_0_lvl1.8, t4_lvl0_7, cout_csa4x2_0_lvl1.7) // sum xor2( w0.Adder1.csa4x2_0_lvl1.8, sintcsa4x2_0_lvl1.8, t4_lvl0_7 )#5 xor2( s0_lvl1_8, w0.Adder1.csa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.7 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.8, sintcsa4x2_0_lvl1.8, t4_lvl0_7 )#5 and2( w2.Adder1.csa4x2_0_lvl1.8, w0.Adder1.csa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.7 )#5 or2( t0_lvl1_8, w1.Adder1.csa4x2_0_lvl1.8, w2.Adder1.csa4x2_0_lvl1.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.9, s0_lvl1_9,t0_lvl1_9,cout_csa4x2_0_lvl1.9,s0_lvl0_9,t0_lvl0_8,s4_lvl0_9,t4_lvl0_8,cout_csa4x2_0_lvl1.8) ; // adder1bit Adder0.csa4x2_0_lvl1.9( sintcsa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.9, s0_lvl0_9, t0_lvl0_8, s4_lvl0_9) // sum xor2( w0.Adder0.csa4x2_0_lvl1.9, s0_lvl0_9, t0_lvl0_8 )#5 xor2( sintcsa4x2_0_lvl1.9, w0.Adder0.csa4x2_0_lvl1.9, s4_lvl0_9 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.9, s0_lvl0_9, t0_lvl0_8 )#5 and2( w2.Adder0.csa4x2_0_lvl1.9, w0.Adder0.csa4x2_0_lvl1.9, s4_lvl0_9 )#5 or2( cout_csa4x2_0_lvl1.9, w1.Adder0.csa4x2_0_lvl1.9, w2.Adder0.csa4x2_0_lvl1.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.9( s0_lvl1_9, t0_lvl1_9, sintcsa4x2_0_lvl1.9, t4_lvl0_8, cout_csa4x2_0_lvl1.8) // sum xor2( w0.Adder1.csa4x2_0_lvl1.9, sintcsa4x2_0_lvl1.9, t4_lvl0_8 )#5 xor2( s0_lvl1_9, w0.Adder1.csa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.8 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.9, sintcsa4x2_0_lvl1.9, t4_lvl0_8 )#5 and2( w2.Adder1.csa4x2_0_lvl1.9, w0.Adder1.csa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.8 )#5 or2( t0_lvl1_9, w1.Adder1.csa4x2_0_lvl1.9, w2.Adder1.csa4x2_0_lvl1.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.10, s0_lvl1_10,t0_lvl1_10,cout_csa4x2_0_lvl1.10,s0_lvl0_10,t0_lvl0_9,s4_lvl0_10,t4_lvl0_9,cout_csa4x2_0_lvl1.9) ; // adder1bit Adder0.csa4x2_0_lvl1.10( sintcsa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.10, s0_lvl0_10, t0_lvl0_9, s4_lvl0_10) // sum xor2( w0.Adder0.csa4x2_0_lvl1.10, s0_lvl0_10, t0_lvl0_9 )#5 xor2( sintcsa4x2_0_lvl1.10, w0.Adder0.csa4x2_0_lvl1.10, s4_lvl0_10 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.10, s0_lvl0_10, t0_lvl0_9 )#5 and2( w2.Adder0.csa4x2_0_lvl1.10, w0.Adder0.csa4x2_0_lvl1.10, s4_lvl0_10 )#5 or2( cout_csa4x2_0_lvl1.10, w1.Adder0.csa4x2_0_lvl1.10, w2.Adder0.csa4x2_0_lvl1.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.10( s0_lvl1_10, t0_lvl1_10, sintcsa4x2_0_lvl1.10, t4_lvl0_9, cout_csa4x2_0_lvl1.9) // sum xor2( w0.Adder1.csa4x2_0_lvl1.10, sintcsa4x2_0_lvl1.10, t4_lvl0_9 )#5 xor2( s0_lvl1_10, w0.Adder1.csa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.9 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.10, sintcsa4x2_0_lvl1.10, t4_lvl0_9 )#5 and2( w2.Adder1.csa4x2_0_lvl1.10, w0.Adder1.csa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.9 )#5 or2( t0_lvl1_10, w1.Adder1.csa4x2_0_lvl1.10, w2.Adder1.csa4x2_0_lvl1.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.11, s0_lvl1_11,t0_lvl1_11,cout_csa4x2_0_lvl1.11,s0_lvl0_11,t0_lvl0_10,s4_lvl0_11,t4_lvl0_10,cout_csa4x2_0_lvl1.10) ; // adder1bit Adder0.csa4x2_0_lvl1.11( sintcsa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.11, s0_lvl0_11, t0_lvl0_10, s4_lvl0_11) // sum xor2( w0.Adder0.csa4x2_0_lvl1.11, s0_lvl0_11, t0_lvl0_10 )#5 xor2( sintcsa4x2_0_lvl1.11, w0.Adder0.csa4x2_0_lvl1.11, s4_lvl0_11 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.11, s0_lvl0_11, t0_lvl0_10 )#5 and2( w2.Adder0.csa4x2_0_lvl1.11, w0.Adder0.csa4x2_0_lvl1.11, s4_lvl0_11 )#5 or2( cout_csa4x2_0_lvl1.11, w1.Adder0.csa4x2_0_lvl1.11, w2.Adder0.csa4x2_0_lvl1.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.11( s0_lvl1_11, t0_lvl1_11, sintcsa4x2_0_lvl1.11, t4_lvl0_10, cout_csa4x2_0_lvl1.10) // sum xor2( w0.Adder1.csa4x2_0_lvl1.11, sintcsa4x2_0_lvl1.11, t4_lvl0_10 )#5 xor2( s0_lvl1_11, w0.Adder1.csa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.10 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.11, sintcsa4x2_0_lvl1.11, t4_lvl0_10 )#5 and2( w2.Adder1.csa4x2_0_lvl1.11, w0.Adder1.csa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.10 )#5 or2( t0_lvl1_11, w1.Adder1.csa4x2_0_lvl1.11, w2.Adder1.csa4x2_0_lvl1.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.12, s0_lvl1_12,t0_lvl1_12,cout_csa4x2_0_lvl1.12,s0_lvl0_12,t0_lvl0_11,s4_lvl0_12,t4_lvl0_11,cout_csa4x2_0_lvl1.11) ; // adder1bit Adder0.csa4x2_0_lvl1.12( sintcsa4x2_0_lvl1.12, cout_csa4x2_0_lvl1.12, s0_lvl0_12, t0_lvl0_11, s4_lvl0_12) // sum xor2( w0.Adder0.csa4x2_0_lvl1.12, s0_lvl0_12, t0_lvl0_11 )#5 xor2( sintcsa4x2_0_lvl1.12, w0.Adder0.csa4x2_0_lvl1.12, s4_lvl0_12 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.12, s0_lvl0_12, t0_lvl0_11 )#5 and2( w2.Adder0.csa4x2_0_lvl1.12, w0.Adder0.csa4x2_0_lvl1.12, s4_lvl0_12 )#5 or2( cout_csa4x2_0_lvl1.12, w1.Adder0.csa4x2_0_lvl1.12, w2.Adder0.csa4x2_0_lvl1.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.12( s0_lvl1_12, t0_lvl1_12, sintcsa4x2_0_lvl1.12, t4_lvl0_11, cout_csa4x2_0_lvl1.11) // sum xor2( w0.Adder1.csa4x2_0_lvl1.12, sintcsa4x2_0_lvl1.12, t4_lvl0_11 )#5 xor2( s0_lvl1_12, w0.Adder1.csa4x2_0_lvl1.12, cout_csa4x2_0_lvl1.11 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.12, sintcsa4x2_0_lvl1.12, t4_lvl0_11 )#5 and2( w2.Adder1.csa4x2_0_lvl1.12, w0.Adder1.csa4x2_0_lvl1.12, cout_csa4x2_0_lvl1.11 )#5 or2( t0_lvl1_12, w1.Adder1.csa4x2_0_lvl1.12, w2.Adder1.csa4x2_0_lvl1.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.13, s0_lvl1_13,t0_lvl1_13,cout_csa4x2_0_lvl1.13,s0_lvl0_13,t0_lvl0_12,s4_lvl0_13,t4_lvl0_12,cout_csa4x2_0_lvl1.12) ; // adder1bit Adder0.csa4x2_0_lvl1.13( sintcsa4x2_0_lvl1.13, cout_csa4x2_0_lvl1.13, s0_lvl0_13, t0_lvl0_12, s4_lvl0_13) // sum xor2( w0.Adder0.csa4x2_0_lvl1.13, s0_lvl0_13, t0_lvl0_12 )#5 xor2( sintcsa4x2_0_lvl1.13, w0.Adder0.csa4x2_0_lvl1.13, s4_lvl0_13 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.13, s0_lvl0_13, t0_lvl0_12 )#5 and2( w2.Adder0.csa4x2_0_lvl1.13, w0.Adder0.csa4x2_0_lvl1.13, s4_lvl0_13 )#5 or2( cout_csa4x2_0_lvl1.13, w1.Adder0.csa4x2_0_lvl1.13, w2.Adder0.csa4x2_0_lvl1.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.13( s0_lvl1_13, t0_lvl1_13, sintcsa4x2_0_lvl1.13, t4_lvl0_12, cout_csa4x2_0_lvl1.12) // sum xor2( w0.Adder1.csa4x2_0_lvl1.13, sintcsa4x2_0_lvl1.13, t4_lvl0_12 )#5 xor2( s0_lvl1_13, w0.Adder1.csa4x2_0_lvl1.13, cout_csa4x2_0_lvl1.12 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.13, sintcsa4x2_0_lvl1.13, t4_lvl0_12 )#5 and2( w2.Adder1.csa4x2_0_lvl1.13, w0.Adder1.csa4x2_0_lvl1.13, cout_csa4x2_0_lvl1.12 )#5 or2( t0_lvl1_13, w1.Adder1.csa4x2_0_lvl1.13, w2.Adder1.csa4x2_0_lvl1.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.14, s0_lvl1_14,t0_lvl1_14,cout_csa4x2_0_lvl1.14,s0_lvl0_14,t0_lvl0_13,s4_lvl0_14,t4_lvl0_13,cout_csa4x2_0_lvl1.13) ; // adder1bit Adder0.csa4x2_0_lvl1.14( sintcsa4x2_0_lvl1.14, cout_csa4x2_0_lvl1.14, s0_lvl0_14, t0_lvl0_13, s4_lvl0_14) // sum xor2( w0.Adder0.csa4x2_0_lvl1.14, s0_lvl0_14, t0_lvl0_13 )#5 xor2( sintcsa4x2_0_lvl1.14, w0.Adder0.csa4x2_0_lvl1.14, s4_lvl0_14 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.14, s0_lvl0_14, t0_lvl0_13 )#5 and2( w2.Adder0.csa4x2_0_lvl1.14, w0.Adder0.csa4x2_0_lvl1.14, s4_lvl0_14 )#5 or2( cout_csa4x2_0_lvl1.14, w1.Adder0.csa4x2_0_lvl1.14, w2.Adder0.csa4x2_0_lvl1.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.14( s0_lvl1_14, t0_lvl1_14, sintcsa4x2_0_lvl1.14, t4_lvl0_13, cout_csa4x2_0_lvl1.13) // sum xor2( w0.Adder1.csa4x2_0_lvl1.14, sintcsa4x2_0_lvl1.14, t4_lvl0_13 )#5 xor2( s0_lvl1_14, w0.Adder1.csa4x2_0_lvl1.14, cout_csa4x2_0_lvl1.13 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.14, sintcsa4x2_0_lvl1.14, t4_lvl0_13 )#5 and2( w2.Adder1.csa4x2_0_lvl1.14, w0.Adder1.csa4x2_0_lvl1.14, cout_csa4x2_0_lvl1.13 )#5 or2( t0_lvl1_14, w1.Adder1.csa4x2_0_lvl1.14, w2.Adder1.csa4x2_0_lvl1.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.15, s0_lvl1_15,t0_lvl1_15,cout_csa4x2_0_lvl1.15,s0_lvl0_15,t0_lvl0_14,s4_lvl0_15,t4_lvl0_14,cout_csa4x2_0_lvl1.14) ; // adder1bit Adder0.csa4x2_0_lvl1.15( sintcsa4x2_0_lvl1.15, cout_csa4x2_0_lvl1.15, s0_lvl0_15, t0_lvl0_14, s4_lvl0_15) // sum xor2( w0.Adder0.csa4x2_0_lvl1.15, s0_lvl0_15, t0_lvl0_14 )#5 xor2( sintcsa4x2_0_lvl1.15, w0.Adder0.csa4x2_0_lvl1.15, s4_lvl0_15 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.15, s0_lvl0_15, t0_lvl0_14 )#5 and2( w2.Adder0.csa4x2_0_lvl1.15, w0.Adder0.csa4x2_0_lvl1.15, s4_lvl0_15 )#5 or2( cout_csa4x2_0_lvl1.15, w1.Adder0.csa4x2_0_lvl1.15, w2.Adder0.csa4x2_0_lvl1.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.15( s0_lvl1_15, t0_lvl1_15, sintcsa4x2_0_lvl1.15, t4_lvl0_14, cout_csa4x2_0_lvl1.14) // sum xor2( w0.Adder1.csa4x2_0_lvl1.15, sintcsa4x2_0_lvl1.15, t4_lvl0_14 )#5 xor2( s0_lvl1_15, w0.Adder1.csa4x2_0_lvl1.15, cout_csa4x2_0_lvl1.14 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.15, sintcsa4x2_0_lvl1.15, t4_lvl0_14 )#5 and2( w2.Adder1.csa4x2_0_lvl1.15, w0.Adder1.csa4x2_0_lvl1.15, cout_csa4x2_0_lvl1.14 )#5 or2( t0_lvl1_15, w1.Adder1.csa4x2_0_lvl1.15, w2.Adder1.csa4x2_0_lvl1.15 )#5 // end adder1bit // end csa4x2 end // genKoggeStoneVec(2*numBits, outVec, "cout", currRow->[0], currRow->[1], 'GND' ); netlist // PGgen (g0,p0,s0_lvl1_0,GND) xor2(p0,s0_lvl1_0,GND)#5 and2(g0,s0_lvl1_0,GND)#5 end netlist // PGgen (g1,p1,s0_lvl1_1,t0_lvl1_0) xor2(p1,s0_lvl1_1,t0_lvl1_0)#5 and2(g1,s0_lvl1_1,t0_lvl1_0)#5 end netlist // PGgen (g2,p2,s0_lvl1_2,t0_lvl1_1) xor2(p2,s0_lvl1_2,t0_lvl1_1)#5 and2(g2,s0_lvl1_2,t0_lvl1_1)#5 end netlist // PGgen (g3,p3,s0_lvl1_3,t0_lvl1_2) xor2(p3,s0_lvl1_3,t0_lvl1_2)#5 and2(g3,s0_lvl1_3,t0_lvl1_2)#5 end netlist // PGgen (g4,p4,s0_lvl1_4,t0_lvl1_3) xor2(p4,s0_lvl1_4,t0_lvl1_3)#5 and2(g4,s0_lvl1_4,t0_lvl1_3)#5 end netlist // PGgen (g5,p5,s0_lvl1_5,t0_lvl1_4) xor2(p5,s0_lvl1_5,t0_lvl1_4)#5 and2(g5,s0_lvl1_5,t0_lvl1_4)#5 end netlist // PGgen (g6,p6,s0_lvl1_6,t0_lvl1_5) xor2(p6,s0_lvl1_6,t0_lvl1_5)#5 and2(g6,s0_lvl1_6,t0_lvl1_5)#5 end netlist // PGgen (g7,p7,s0_lvl1_7,t0_lvl1_6) xor2(p7,s0_lvl1_7,t0_lvl1_6)#5 and2(g7,s0_lvl1_7,t0_lvl1_6)#5 end netlist // PGgen (g8,p8,s0_lvl1_8,t0_lvl1_7) xor2(p8,s0_lvl1_8,t0_lvl1_7)#5 and2(g8,s0_lvl1_8,t0_lvl1_7)#5 end netlist // PGgen (g9,p9,s0_lvl1_9,t0_lvl1_8) xor2(p9,s0_lvl1_9,t0_lvl1_8)#5 and2(g9,s0_lvl1_9,t0_lvl1_8)#5 end netlist // PGgen (g10,p10,s0_lvl1_10,t0_lvl1_9) xor2(p10,s0_lvl1_10,t0_lvl1_9)#5 and2(g10,s0_lvl1_10,t0_lvl1_9)#5 end netlist // PGgen (g11,p11,s0_lvl1_11,t0_lvl1_10) xor2(p11,s0_lvl1_11,t0_lvl1_10)#5 and2(g11,s0_lvl1_11,t0_lvl1_10)#5 end netlist // PGgen (g12,p12,s0_lvl1_12,t0_lvl1_11) xor2(p12,s0_lvl1_12,t0_lvl1_11)#5 and2(g12,s0_lvl1_12,t0_lvl1_11)#5 end netlist // PGgen (g13,p13,s0_lvl1_13,t0_lvl1_12) xor2(p13,s0_lvl1_13,t0_lvl1_12)#5 and2(g13,s0_lvl1_13,t0_lvl1_12)#5 end netlist // PGgen (g14,p14,s0_lvl1_14,t0_lvl1_13) xor2(p14,s0_lvl1_14,t0_lvl1_13)#5 and2(g14,s0_lvl1_14,t0_lvl1_13)#5 end netlist // PGgen (g15,p15,s0_lvl1_15,t0_lvl1_14) xor2(p15,s0_lvl1_15,t0_lvl1_14)#5 and2(g15,s0_lvl1_15,t0_lvl1_14)#5 end netlist // Gcombine (g_0_GND, g0, GND, p0 ) and2(w0g_0_GND, p0, GND )#5 or2( g_0_GND, w0g_0_GND, g0 )#5 end netlist // PGcombine (g_1_0,p_1_0,g1,p1,g0,p0) and2( w0g_1_0, p1, g0 )#5 or2( g_1_0, w0g_1_0, g1 )#5 and2( p_1_0, p1, p0)#5 end netlist // PGcombine (g_2_1,p_2_1,g2,p2,g1,p1) and2( w0g_2_1, p2, g1 )#5 or2( g_2_1, w0g_2_1, g2 )#5 and2( p_2_1, p2, p1)#5 end netlist // PGcombine (g_3_2,p_3_2,g3,p3,g2,p2) and2( w0g_3_2, p3, g2 )#5 or2( g_3_2, w0g_3_2, g3 )#5 and2( p_3_2, p3, p2)#5 end netlist // PGcombine (g_4_3,p_4_3,g4,p4,g3,p3) and2( w0g_4_3, p4, g3 )#5 or2( g_4_3, w0g_4_3, g4 )#5 and2( p_4_3, p4, p3)#5 end netlist // PGcombine (g_5_4,p_5_4,g5,p5,g4,p4) and2( w0g_5_4, p5, g4 )#5 or2( g_5_4, w0g_5_4, g5 )#5 and2( p_5_4, p5, p4)#5 end netlist // PGcombine (g_6_5,p_6_5,g6,p6,g5,p5) and2( w0g_6_5, p6, g5 )#5 or2( g_6_5, w0g_6_5, g6 )#5 and2( p_6_5, p6, p5)#5 end netlist // PGcombine (g_7_6,p_7_6,g7,p7,g6,p6) and2( w0g_7_6, p7, g6 )#5 or2( g_7_6, w0g_7_6, g7 )#5 and2( p_7_6, p7, p6)#5 end netlist // PGcombine (g_8_7,p_8_7,g8,p8,g7,p7) and2( w0g_8_7, p8, g7 )#5 or2( g_8_7, w0g_8_7, g8 )#5 and2( p_8_7, p8, p7)#5 end netlist // PGcombine (g_9_8,p_9_8,g9,p9,g8,p8) and2( w0g_9_8, p9, g8 )#5 or2( g_9_8, w0g_9_8, g9 )#5 and2( p_9_8, p9, p8)#5 end netlist // PGcombine (g_10_9,p_10_9,g10,p10,g9,p9) and2( w0g_10_9, p10, g9 )#5 or2( g_10_9, w0g_10_9, g10 )#5 and2( p_10_9, p10, p9)#5 end netlist // PGcombine (g_11_10,p_11_10,g11,p11,g10,p10) and2( w0g_11_10, p11, g10 )#5 or2( g_11_10, w0g_11_10, g11 )#5 and2( p_11_10, p11, p10)#5 end netlist // PGcombine (g_12_11,p_12_11,g12,p12,g11,p11) and2( w0g_12_11, p12, g11 )#5 or2( g_12_11, w0g_12_11, g12 )#5 and2( p_12_11, p12, p11)#5 end netlist // PGcombine (g_13_12,p_13_12,g13,p13,g12,p12) and2( w0g_13_12, p13, g12 )#5 or2( g_13_12, w0g_13_12, g13 )#5 and2( p_13_12, p13, p12)#5 end netlist // PGcombine (g_14_13,p_14_13,g14,p14,g13,p13) and2( w0g_14_13, p14, g13 )#5 or2( g_14_13, w0g_14_13, g14 )#5 and2( p_14_13, p14, p13)#5 end netlist // PGcombine (g_15_14,p_15_14,g15,p15,g14,p14) and2( w0g_15_14, p15, g14 )#5 or2( g_15_14, w0g_15_14, g15 )#5 and2( p_15_14, p15, p14)#5 end netlist // Gcombine (g_1_GND, g_1_0, GND, p_1_0 ) and2(w0g_1_GND, p_1_0, GND )#5 or2( g_1_GND, w0g_1_GND, g_1_0 )#5 end netlist // Gcombine (g_2_GND, g_2_1, g_0_GND, p_2_1 ) and2(w0g_2_GND, p_2_1, g_0_GND )#5 or2( g_2_GND, w0g_2_GND, g_2_1 )#5 end netlist // PGcombine (g_3_0,p_3_0,g_3_2,p_3_2,g_1_0,p_1_0) and2( w0g_3_0, p_3_2, g_1_0 )#5 or2( g_3_0, w0g_3_0, g_3_2 )#5 and2( p_3_0, p_3_2, p_1_0)#5 end netlist // PGcombine (g_4_1,p_4_1,g_4_3,p_4_3,g_2_1,p_2_1) and2( w0g_4_1, p_4_3, g_2_1 )#5 or2( g_4_1, w0g_4_1, g_4_3 )#5 and2( p_4_1, p_4_3, p_2_1)#5 end netlist // PGcombine (g_5_2,p_5_2,g_5_4,p_5_4,g_3_2,p_3_2) and2( w0g_5_2, p_5_4, g_3_2 )#5 or2( g_5_2, w0g_5_2, g_5_4 )#5 and2( p_5_2, p_5_4, p_3_2)#5 end netlist // PGcombine (g_6_3,p_6_3,g_6_5,p_6_5,g_4_3,p_4_3) and2( w0g_6_3, p_6_5, g_4_3 )#5 or2( g_6_3, w0g_6_3, g_6_5 )#5 and2( p_6_3, p_6_5, p_4_3)#5 end netlist // PGcombine (g_7_4,p_7_4,g_7_6,p_7_6,g_5_4,p_5_4) and2( w0g_7_4, p_7_6, g_5_4 )#5 or2( g_7_4, w0g_7_4, g_7_6 )#5 and2( p_7_4, p_7_6, p_5_4)#5 end netlist // PGcombine (g_8_5,p_8_5,g_8_7,p_8_7,g_6_5,p_6_5) and2( w0g_8_5, p_8_7, g_6_5 )#5 or2( g_8_5, w0g_8_5, g_8_7 )#5 and2( p_8_5, p_8_7, p_6_5)#5 end netlist // PGcombine (g_9_6,p_9_6,g_9_8,p_9_8,g_7_6,p_7_6) and2( w0g_9_6, p_9_8, g_7_6 )#5 or2( g_9_6, w0g_9_6, g_9_8 )#5 and2( p_9_6, p_9_8, p_7_6)#5 end netlist // PGcombine (g_10_7,p_10_7,g_10_9,p_10_9,g_8_7,p_8_7) and2( w0g_10_7, p_10_9, g_8_7 )#5 or2( g_10_7, w0g_10_7, g_10_9 )#5 and2( p_10_7, p_10_9, p_8_7)#5 end netlist // PGcombine (g_11_8,p_11_8,g_11_10,p_11_10,g_9_8,p_9_8) and2( w0g_11_8, p_11_10, g_9_8 )#5 or2( g_11_8, w0g_11_8, g_11_10 )#5 and2( p_11_8, p_11_10, p_9_8)#5 end netlist // PGcombine (g_12_9,p_12_9,g_12_11,p_12_11,g_10_9,p_10_9) and2( w0g_12_9, p_12_11, g_10_9 )#5 or2( g_12_9, w0g_12_9, g_12_11 )#5 and2( p_12_9, p_12_11, p_10_9)#5 end netlist // PGcombine (g_13_10,p_13_10,g_13_12,p_13_12,g_11_10,p_11_10) and2( w0g_13_10, p_13_12, g_11_10 )#5 or2( g_13_10, w0g_13_10, g_13_12 )#5 and2( p_13_10, p_13_12, p_11_10)#5 end netlist // PGcombine (g_14_11,p_14_11,g_14_13,p_14_13,g_12_11,p_12_11) and2( w0g_14_11, p_14_13, g_12_11 )#5 or2( g_14_11, w0g_14_11, g_14_13 )#5 and2( p_14_11, p_14_13, p_12_11)#5 end netlist // PGcombine (g_15_12,p_15_12,g_15_14,p_15_14,g_13_12,p_13_12) and2( w0g_15_12, p_15_14, g_13_12 )#5 or2( g_15_12, w0g_15_12, g_15_14 )#5 and2( p_15_12, p_15_14, p_13_12)#5 end netlist // Gcombine (g_3_GND, g_3_0, GND, p_3_0 ) and2(w0g_3_GND, p_3_0, GND )#5 or2( g_3_GND, w0g_3_GND, g_3_0 )#5 end netlist // Gcombine (g_4_GND, g_4_1, g_0_GND, p_4_1 ) and2(w0g_4_GND, p_4_1, g_0_GND )#5 or2( g_4_GND, w0g_4_GND, g_4_1 )#5 end netlist // Gcombine (g_5_GND, g_5_2, g_1_GND, p_5_2 ) and2(w0g_5_GND, p_5_2, g_1_GND )#5 or2( g_5_GND, w0g_5_GND, g_5_2 )#5 end netlist // Gcombine (g_6_GND, g_6_3, g_2_GND, p_6_3 ) and2(w0g_6_GND, p_6_3, g_2_GND )#5 or2( g_6_GND, w0g_6_GND, g_6_3 )#5 end netlist // PGcombine (g_7_0,p_7_0,g_7_4,p_7_4,g_3_0,p_3_0) and2( w0g_7_0, p_7_4, g_3_0 )#5 or2( g_7_0, w0g_7_0, g_7_4 )#5 and2( p_7_0, p_7_4, p_3_0)#5 end netlist // PGcombine (g_8_1,p_8_1,g_8_5,p_8_5,g_4_1,p_4_1) and2( w0g_8_1, p_8_5, g_4_1 )#5 or2( g_8_1, w0g_8_1, g_8_5 )#5 and2( p_8_1, p_8_5, p_4_1)#5 end netlist // PGcombine (g_9_2,p_9_2,g_9_6,p_9_6,g_5_2,p_5_2) and2( w0g_9_2, p_9_6, g_5_2 )#5 or2( g_9_2, w0g_9_2, g_9_6 )#5 and2( p_9_2, p_9_6, p_5_2)#5 end netlist // PGcombine (g_10_3,p_10_3,g_10_7,p_10_7,g_6_3,p_6_3) and2( w0g_10_3, p_10_7, g_6_3 )#5 or2( g_10_3, w0g_10_3, g_10_7 )#5 and2( p_10_3, p_10_7, p_6_3)#5 end netlist // PGcombine (g_11_4,p_11_4,g_11_8,p_11_8,g_7_4,p_7_4) and2( w0g_11_4, p_11_8, g_7_4 )#5 or2( g_11_4, w0g_11_4, g_11_8 )#5 and2( p_11_4, p_11_8, p_7_4)#5 end netlist // PGcombine (g_12_5,p_12_5,g_12_9,p_12_9,g_8_5,p_8_5) and2( w0g_12_5, p_12_9, g_8_5 )#5 or2( g_12_5, w0g_12_5, g_12_9 )#5 and2( p_12_5, p_12_9, p_8_5)#5 end netlist // PGcombine (g_13_6,p_13_6,g_13_10,p_13_10,g_9_6,p_9_6) and2( w0g_13_6, p_13_10, g_9_6 )#5 or2( g_13_6, w0g_13_6, g_13_10 )#5 and2( p_13_6, p_13_10, p_9_6)#5 end netlist // PGcombine (g_14_7,p_14_7,g_14_11,p_14_11,g_10_7,p_10_7) and2( w0g_14_7, p_14_11, g_10_7 )#5 or2( g_14_7, w0g_14_7, g_14_11 )#5 and2( p_14_7, p_14_11, p_10_7)#5 end netlist // PGcombine (g_15_8,p_15_8,g_15_12,p_15_12,g_11_8,p_11_8) and2( w0g_15_8, p_15_12, g_11_8 )#5 or2( g_15_8, w0g_15_8, g_15_12 )#5 and2( p_15_8, p_15_12, p_11_8)#5 end netlist // Gcombine (g_7_GND, g_7_0, GND, p_7_0 ) and2(w0g_7_GND, p_7_0, GND )#5 or2( g_7_GND, w0g_7_GND, g_7_0 )#5 end netlist // Gcombine (g_8_GND, g_8_1, g_0_GND, p_8_1 ) and2(w0g_8_GND, p_8_1, g_0_GND )#5 or2( g_8_GND, w0g_8_GND, g_8_1 )#5 end netlist // Gcombine (g_9_GND, g_9_2, g_1_GND, p_9_2 ) and2(w0g_9_GND, p_9_2, g_1_GND )#5 or2( g_9_GND, w0g_9_GND, g_9_2 )#5 end netlist // Gcombine (g_10_GND, g_10_3, g_2_GND, p_10_3 ) and2(w0g_10_GND, p_10_3, g_2_GND )#5 or2( g_10_GND, w0g_10_GND, g_10_3 )#5 end netlist // Gcombine (g_11_GND, g_11_4, g_3_GND, p_11_4 ) and2(w0g_11_GND, p_11_4, g_3_GND )#5 or2( g_11_GND, w0g_11_GND, g_11_4 )#5 end netlist // Gcombine (g_12_GND, g_12_5, g_4_GND, p_12_5 ) and2(w0g_12_GND, p_12_5, g_4_GND )#5 or2( g_12_GND, w0g_12_GND, g_12_5 )#5 end netlist // Gcombine (g_13_GND, g_13_6, g_5_GND, p_13_6 ) and2(w0g_13_GND, p_13_6, g_5_GND )#5 or2( g_13_GND, w0g_13_GND, g_13_6 )#5 end netlist // Gcombine (g_14_GND, g_14_7, g_6_GND, p_14_7 ) and2(w0g_14_GND, p_14_7, g_6_GND )#5 or2( g_14_GND, w0g_14_GND, g_14_7 )#5 end netlist // PGcombine (g_15_0,p_15_0,g_15_8,p_15_8,g_7_0,p_7_0) and2( w0g_15_0, p_15_8, g_7_0 )#5 or2( g_15_0, w0g_15_0, g_15_8 )#5 and2( p_15_0, p_15_8, p_7_0)#5 end netlist // Gcombine (cout, g_15_0, GND, p_15_0 ) and2(w0cout, p_15_0, GND )#5 or2( cout, w0cout, g_15_0 )#5 end netlist xor2( m0, p0,GND )#5 xor2( m1, p1,g_0_GND )#5 xor2( m2, p2,g_1_GND )#5 xor2( m3, p3,g_2_GND )#5 xor2( m4, p4,g_3_GND )#5 xor2( m5, p5,g_4_GND )#5 xor2( m6, p6,g_5_GND )#5 xor2( m7, p7,g_6_GND )#5 xor2( m8, p8,g_7_GND )#5 xor2( m9, p9,g_8_GND )#5 xor2( m10, p10,g_9_GND )#5 xor2( m11, p11,g_10_GND )#5 xor2( m12, p12,g_11_GND )#5 xor2( m13, p13,g_12_GND )#5 xor2( m14, p14,g_13_GND )#5 xor2( m15, p15,g_14_GND )#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/adder8.net
// Lonestar Benchmark Suite for irregular applications that exhibit // amorphous data-parallelism. // // Center for Grid and Distributed Computing // The University of Texas at Austin // // Copyright (C) 2007, 2008, 2009 The University of Texas at Austin // // Licensed under the Eclipse Public License, Version 1.0 (the "License"); // you may not use this file except in compliance with the License. // You may obtain a copy of the License at // // http://www.eclipse.org/legal/epl-v10.html // // Unless required by applicable law or agreed to in writing, software // distributed under the License is distributed on an "AS IS" BASIS, // WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. // See the License for the specific language governing permissions and // limitations under the License. // // File: adder8.net finish 10000 inputs cin, a0, a1, a2, a3, a4, a5, a6, a7, b0, b1, b2, b3, b4, b5, b6, b7 end outputs cout, s0, s1, s2, s3, s4, s5, s6, s7 end outvalues s0 1, s1 1, s2 1, s3 1, s4 1, s5 1, s6 1, s7 1, , cout 1, end initlist a0 0,0 34, 1 end initlist a1 0,0 43, 1 end initlist a2 0,0 2, 1 end initlist a3 0,0 78, 1 end initlist a4 0,0 79, 1 end initlist a5 0,0 57, 1 end initlist a6 0,0 22, 1 end initlist a7 0,0 97, 1 end initlist b0 0,0 98, 1 end initlist b1 0,0 81, 1 end initlist b2 0,0 32, 1 end initlist b3 0,0 98, 1 end initlist b4 0,0 87, 1 end initlist b5 0,0 1, 1 end initlist b6 0,0 59, 1 end initlist b7 0,0 37, 1 end initlist cin 0, 0 50, 1 end netlist inv(a0n,a0)#4 inv(b0n,b0)#4 inv(cinn,cin)#4 and2(a0nb0n,a0n,b0n)#2 and2(a0nb0,a0n,b0)#2 and2(a0b0n,a0,b0n)#2 and2(a0b0,a0,b0)#3 and2(a0b0cin,a0b0,cin)#2 and2(a0nb0ncin,a0nb0n,cin)#2 and2(a0nb0cinn,a0nb0,cinn)#2 and2(a0b0ncinn,a0b0n,cinn)#2 and2(b0cin,b0,cin)#2 and2(a0cin,cin,a0)#2 or2(s0w42,a0b0ncinn,a0nb0cinn)#3 or2(s0w71,a0b0cin, a0nb0ncin)#3 or2(s0,s0w42,s0w71)#3 or2(s0w35, b0cin, a0cin)#3 or2(c0,s0w35,a0b0)#5 end netlist inv(a1n,a1)#4 inv(b1n,b1)#4 inv(c0n,c0)#4 and2(a1nb1n,a1n,b1n)#2 and2(a1nb1,a1n,b1)#2 and2(a1b1n,a1,b1n)#2 and2(a1b1,a1,b1)#3 and2(a1b1c0,a1b1,c0)#2 and2(a1nb1nc0,a1nb1n,c0)#2 and2(a1nb1c0n,a1nb1,c0n)#2 and2(a1b1nc0n,a1b1n,c0n)#2 and2(b1c0,b1,c0)#2 and2(a1c0,c0,a1)#2 or2(s1w42,a1b1nc0n,a1nb1c0n)#3 or2(s1w71,a1b1c0, a1nb1nc0)#3 or2(s1,s1w42,s1w71)#3 or2(s1w35, b1c0, a1c0)#3 or2(c1,s1w35,a1b1)#5 end netlist inv(a2n,a2)#4 inv(b2n,b2)#4 inv(c1n,c1)#4 and2(a2nb2n,a2n,b2n)#2 and2(a2nb2,a2n,b2)#2 and2(a2b2n,a2,b2n)#2 and2(a2b2,a2,b2)#3 and2(a2b2c1,a2b2,c1)#2 and2(a2nb2nc1,a2nb2n,c1)#2 and2(a2nb2c1n,a2nb2,c1n)#2 and2(a2b2nc1n,a2b2n,c1n)#2 and2(b2c1,b2,c1)#2 and2(a2c1,c1,a2)#2 or2(s2w42,a2b2nc1n,a2nb2c1n)#3 or2(s2w71,a2b2c1, a2nb2nc1)#3 or2(s2,s2w42,s2w71)#3 or2(s2w35, b2c1, a2c1)#3 or2(c2,s2w35,a2b2)#5 end netlist inv(a3n,a3)#4 inv(b3n,b3)#4 inv(c2n,c2)#4 and2(a3nb3n,a3n,b3n)#2 and2(a3nb3,a3n,b3)#2 and2(a3b3n,a3,b3n)#2 and2(a3b3,a3,b3)#3 and2(a3b3c2,a3b3,c2)#2 and2(a3nb3nc2,a3nb3n,c2)#2 and2(a3nb3c2n,a3nb3,c2n)#2 and2(a3b3nc2n,a3b3n,c2n)#2 and2(b3c2,b3,c2)#2 and2(a3c2,c2,a3)#2 or2(s3w42,a3b3nc2n,a3nb3c2n)#3 or2(s3w71,a3b3c2, a3nb3nc2)#3 or2(s3,s3w42,s3w71)#3 or2(s3w35, b3c2, a3c2)#3 or2(c3,s3w35,a3b3)#5 end netlist inv(a4n,a4)#4 inv(b4n,b4)#4 inv(c3n,c3)#4 and2(a4nb4n,a4n,b4n)#2 and2(a4nb4,a4n,b4)#2 and2(a4b4n,a4,b4n)#2 and2(a4b4,a4,b4)#3 and2(a4b4c3,a4b4,c3)#2 and2(a4nb4nc3,a4nb4n,c3)#2 and2(a4nb4c3n,a4nb4,c3n)#2 and2(a4b4nc3n,a4b4n,c3n)#2 and2(b4c3,b4,c3)#2 and2(a4c3,c3,a4)#2 or2(s4w42,a4b4nc3n,a4nb4c3n)#3 or2(s4w71,a4b4c3, a4nb4nc3)#3 or2(s4,s4w42,s4w71)#3 or2(s4w35, b4c3, a4c3)#3 or2(c4,s4w35,a4b4)#5 end netlist inv(a5n,a5)#4 inv(b5n,b5)#4 inv(c4n,c4)#4 and2(a5nb5n,a5n,b5n)#2 and2(a5nb5,a5n,b5)#2 and2(a5b5n,a5,b5n)#2 and2(a5b5,a5,b5)#3 and2(a5b5c4,a5b5,c4)#2 and2(a5nb5nc4,a5nb5n,c4)#2 and2(a5nb5c4n,a5nb5,c4n)#2 and2(a5b5nc4n,a5b5n,c4n)#2 and2(b5c4,b5,c4)#2 and2(a5c4,c4,a5)#2 or2(s5w42,a5b5nc4n,a5nb5c4n)#3 or2(s5w71,a5b5c4, a5nb5nc4)#3 or2(s5,s5w42,s5w71)#3 or2(s5w35, b5c4, a5c4)#3 or2(c5,s5w35,a5b5)#5 end netlist inv(a6n,a6)#4 inv(b6n,b6)#4 inv(c5n,c5)#4 and2(a6nb6n,a6n,b6n)#2 and2(a6nb6,a6n,b6)#2 and2(a6b6n,a6,b6n)#2 and2(a6b6,a6,b6)#3 and2(a6b6c5,a6b6,c5)#2 and2(a6nb6nc5,a6nb6n,c5)#2 and2(a6nb6c5n,a6nb6,c5n)#2 and2(a6b6nc5n,a6b6n,c5n)#2 and2(b6c5,b6,c5)#2 and2(a6c5,c5,a6)#2 or2(s6w42,a6b6nc5n,a6nb6c5n)#3 or2(s6w71,a6b6c5, a6nb6nc5)#3 or2(s6,s6w42,s6w71)#3 or2(s6w35, b6c5, a6c5)#3 or2(c6,s6w35,a6b6)#5 end netlist inv(a7n,a7)#4 inv(b7n,b7)#4 inv(c6n,c6)#4 and2(a7nb7n,a7n,b7n)#2 and2(a7nb7,a7n,b7)#2 and2(a7b7n,a7,b7n)#2 and2(a7b7,a7,b7)#3 and2(a7b7c6,a7b7,c6)#2 and2(a7nb7nc6,a7nb7n,c6)#2 and2(a7nb7c6n,a7nb7,c6n)#2 and2(a7b7nc6n,a7b7n,c6n)#2 and2(b7c6,b7,c6)#2 and2(a7c6,c6,a7)#2 or2(s7w42,a7b7nc6n,a7nb7c6n)#3 or2(s7w71,a7b7c6, a7nb7nc6)#3 or2(s7,s7w42,s7w71)#3 or2(s7w35, b7c6, a7c6)#3 or2(cout,s7w35,a7b7)#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/multTree10bit.net
// Lonestar Benchmark Suite for irregular applications that exhibit // amorphous data-parallelism. // // Center for Grid and Distributed Computing // The University of Texas at Austin // // Copyright (C) 2007, 2008, 2009 The University of Texas at Austin // // Licensed under the Eclipse Public License, Version 1.0 (the "License"); // you may not use this file except in compliance with the License. // You may obtain a copy of the License at // // http://www.eclipse.org/legal/epl-v10.html // // Unless required by applicable law or agreed to in writing, software // distributed under the License is distributed on an "AS IS" BASIS, // WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. // See the License for the specific language governing permissions and // limitations under the License. // // File: multTree10bit.net finish 100000 inputs a0, a1, a2, a3, a4, a5, a6, a7, a8, a9, b0, b1, b2, b3, b4, b5, b6, b7, b8, b9, GND end outputs m0, m1, m2, m3, m4, m5, m6, m7, m8, m9, m10, m11, m12, m13, m14, m15, m16, m17, m18, m19, end outvalues m0 1, m1 0, m2 0, m3 0, m4 0, m5 0, m6 0, m7 0, m8 0, m9 0, m10 0, m11 1, m12 1, m13 1, m14 1, m15 1, m16 1, m17 1, m18 1, m19 1, end initlist GND 0 0 end initlist a0 0,0 68,1 end initlist a1 0,0 72,1 end initlist a2 0,0 91,1 end initlist a3 0,0 62,1 end initlist a4 0,0 15,1 end initlist a5 0,0 89,1 end initlist a6 0,0 12,1 end initlist a7 0,0 88,1 end initlist a8 0,0 52,1 end initlist a9 0,0 91,1 end initlist b0 0,0 34,1 end initlist b1 0,0 32,1 end initlist b2 0,0 87,1 end initlist b3 0,0 1,1 end initlist b4 0,0 59,1 end initlist b5 0,0 27,1 end initlist b6 0,0 74,1 end initlist b7 0,0 31,1 end initlist b8 0,0 60,1 end initlist b9 0,0 76,1 end netlist // mux2x1 Bth0.0( PP_0_0, GND, a0, b0 ) inv(b0_n.Bth0.0, b0 )#5 and2(w0.Bth0.0, b0_n.Bth0.0, GND )#5 and2(w1.Bth0.0, b0, a0 )#5 or2(PP_0_0, w0.Bth0.0, w1.Bth0.0 )#5 // end mux2x1 Bth0.0 end netlist // mux2x1 Bth0.1( PP_0_1, GND, a1, b0 ) inv(b0_n.Bth0.1, b0 )#5 and2(w0.Bth0.1, b0_n.Bth0.1, GND )#5 and2(w1.Bth0.1, b0, a1 )#5 or2(PP_0_1, w0.Bth0.1, w1.Bth0.1 )#5 // end mux2x1 Bth0.1 end netlist // mux2x1 Bth0.2( PP_0_2, GND, a2, b0 ) inv(b0_n.Bth0.2, b0 )#5 and2(w0.Bth0.2, b0_n.Bth0.2, GND )#5 and2(w1.Bth0.2, b0, a2 )#5 or2(PP_0_2, w0.Bth0.2, w1.Bth0.2 )#5 // end mux2x1 Bth0.2 end netlist // mux2x1 Bth0.3( PP_0_3, GND, a3, b0 ) inv(b0_n.Bth0.3, b0 )#5 and2(w0.Bth0.3, b0_n.Bth0.3, GND )#5 and2(w1.Bth0.3, b0, a3 )#5 or2(PP_0_3, w0.Bth0.3, w1.Bth0.3 )#5 // end mux2x1 Bth0.3 end netlist // mux2x1 Bth0.4( PP_0_4, GND, a4, b0 ) inv(b0_n.Bth0.4, b0 )#5 and2(w0.Bth0.4, b0_n.Bth0.4, GND )#5 and2(w1.Bth0.4, b0, a4 )#5 or2(PP_0_4, w0.Bth0.4, w1.Bth0.4 )#5 // end mux2x1 Bth0.4 end netlist // mux2x1 Bth0.5( PP_0_5, GND, a5, b0 ) inv(b0_n.Bth0.5, b0 )#5 and2(w0.Bth0.5, b0_n.Bth0.5, GND )#5 and2(w1.Bth0.5, b0, a5 )#5 or2(PP_0_5, w0.Bth0.5, w1.Bth0.5 )#5 // end mux2x1 Bth0.5 end netlist // mux2x1 Bth0.6( PP_0_6, GND, a6, b0 ) inv(b0_n.Bth0.6, b0 )#5 and2(w0.Bth0.6, b0_n.Bth0.6, GND )#5 and2(w1.Bth0.6, b0, a6 )#5 or2(PP_0_6, w0.Bth0.6, w1.Bth0.6 )#5 // end mux2x1 Bth0.6 end netlist // mux2x1 Bth0.7( PP_0_7, GND, a7, b0 ) inv(b0_n.Bth0.7, b0 )#5 and2(w0.Bth0.7, b0_n.Bth0.7, GND )#5 and2(w1.Bth0.7, b0, a7 )#5 or2(PP_0_7, w0.Bth0.7, w1.Bth0.7 )#5 // end mux2x1 Bth0.7 end netlist // mux2x1 Bth0.8( PP_0_8, GND, a8, b0 ) inv(b0_n.Bth0.8, b0 )#5 and2(w0.Bth0.8, b0_n.Bth0.8, GND )#5 and2(w1.Bth0.8, b0, a8 )#5 or2(PP_0_8, w0.Bth0.8, w1.Bth0.8 )#5 // end mux2x1 Bth0.8 end netlist // mux2x1 Bth0.9( PP_0_9, GND, a9, b0 ) inv(b0_n.Bth0.9, b0 )#5 and2(w0.Bth0.9, b0_n.Bth0.9, GND )#5 and2(w1.Bth0.9, b0, a9 )#5 or2(PP_0_9, w0.Bth0.9, w1.Bth0.9 )#5 // end mux2x1 Bth0.9 end netlist // mux2x1 Bth0.10( PP_0_10, GND, GND, b0 ) inv(b0_n.Bth0.10, b0 )#5 and2(w0.Bth0.10, b0_n.Bth0.10, GND )#5 and2(w1.Bth0.10, b0, GND )#5 or2(PP_0_10, w0.Bth0.10, w1.Bth0.10 )#5 // end mux2x1 Bth0.10 end netlist // mux2x1 Bth0.11( PP_0_11, GND, GND, b0 ) inv(b0_n.Bth0.11, b0 )#5 and2(w0.Bth0.11, b0_n.Bth0.11, GND )#5 and2(w1.Bth0.11, b0, GND )#5 or2(PP_0_11, w0.Bth0.11, w1.Bth0.11 )#5 // end mux2x1 Bth0.11 end netlist // mux2x1 Bth0.12( PP_0_12, GND, GND, b0 ) inv(b0_n.Bth0.12, b0 )#5 and2(w0.Bth0.12, b0_n.Bth0.12, GND )#5 and2(w1.Bth0.12, b0, GND )#5 or2(PP_0_12, w0.Bth0.12, w1.Bth0.12 )#5 // end mux2x1 Bth0.12 end netlist // mux2x1 Bth0.13( PP_0_13, GND, GND, b0 ) inv(b0_n.Bth0.13, b0 )#5 and2(w0.Bth0.13, b0_n.Bth0.13, GND )#5 and2(w1.Bth0.13, b0, GND )#5 or2(PP_0_13, w0.Bth0.13, w1.Bth0.13 )#5 // end mux2x1 Bth0.13 end netlist // mux2x1 Bth0.14( PP_0_14, GND, GND, b0 ) inv(b0_n.Bth0.14, b0 )#5 and2(w0.Bth0.14, b0_n.Bth0.14, GND )#5 and2(w1.Bth0.14, b0, GND )#5 or2(PP_0_14, w0.Bth0.14, w1.Bth0.14 )#5 // end mux2x1 Bth0.14 end netlist // mux2x1 Bth0.15( PP_0_15, GND, GND, b0 ) inv(b0_n.Bth0.15, b0 )#5 and2(w0.Bth0.15, b0_n.Bth0.15, GND )#5 and2(w1.Bth0.15, b0, GND )#5 or2(PP_0_15, w0.Bth0.15, w1.Bth0.15 )#5 // end mux2x1 Bth0.15 end netlist // mux2x1 Bth0.16( PP_0_16, GND, GND, b0 ) inv(b0_n.Bth0.16, b0 )#5 and2(w0.Bth0.16, b0_n.Bth0.16, GND )#5 and2(w1.Bth0.16, b0, GND )#5 or2(PP_0_16, w0.Bth0.16, w1.Bth0.16 )#5 // end mux2x1 Bth0.16 end netlist // mux2x1 Bth0.17( PP_0_17, GND, GND, b0 ) inv(b0_n.Bth0.17, b0 )#5 and2(w0.Bth0.17, b0_n.Bth0.17, GND )#5 and2(w1.Bth0.17, b0, GND )#5 or2(PP_0_17, w0.Bth0.17, w1.Bth0.17 )#5 // end mux2x1 Bth0.17 end netlist // mux2x1 Bth0.18( PP_0_18, GND, GND, b0 ) inv(b0_n.Bth0.18, b0 )#5 and2(w0.Bth0.18, b0_n.Bth0.18, GND )#5 and2(w1.Bth0.18, b0, GND )#5 or2(PP_0_18, w0.Bth0.18, w1.Bth0.18 )#5 // end mux2x1 Bth0.18 end netlist // mux2x1 Bth0.19( PP_0_19, GND, GND, b0 ) inv(b0_n.Bth0.19, b0 )#5 and2(w0.Bth0.19, b0_n.Bth0.19, GND )#5 and2(w1.Bth0.19, b0, GND )#5 or2(PP_0_19, w0.Bth0.19, w1.Bth0.19 )#5 // end mux2x1 Bth0.19 end netlist // mux2x1 Bth1.0( PP_1_0, GND, GND, b1 ) inv(b1_n.Bth1.0, b1 )#5 and2(w0.Bth1.0, b1_n.Bth1.0, GND )#5 and2(w1.Bth1.0, b1, GND )#5 or2(PP_1_0, w0.Bth1.0, w1.Bth1.0 )#5 // end mux2x1 Bth1.0 end netlist // mux2x1 Bth1.1( PP_1_1, GND, a0, b1 ) inv(b1_n.Bth1.1, b1 )#5 and2(w0.Bth1.1, b1_n.Bth1.1, GND )#5 and2(w1.Bth1.1, b1, a0 )#5 or2(PP_1_1, w0.Bth1.1, w1.Bth1.1 )#5 // end mux2x1 Bth1.1 end netlist // mux2x1 Bth1.2( PP_1_2, GND, a1, b1 ) inv(b1_n.Bth1.2, b1 )#5 and2(w0.Bth1.2, b1_n.Bth1.2, GND )#5 and2(w1.Bth1.2, b1, a1 )#5 or2(PP_1_2, w0.Bth1.2, w1.Bth1.2 )#5 // end mux2x1 Bth1.2 end netlist // mux2x1 Bth1.3( PP_1_3, GND, a2, b1 ) inv(b1_n.Bth1.3, b1 )#5 and2(w0.Bth1.3, b1_n.Bth1.3, GND )#5 and2(w1.Bth1.3, b1, a2 )#5 or2(PP_1_3, w0.Bth1.3, w1.Bth1.3 )#5 // end mux2x1 Bth1.3 end netlist // mux2x1 Bth1.4( PP_1_4, GND, a3, b1 ) inv(b1_n.Bth1.4, b1 )#5 and2(w0.Bth1.4, b1_n.Bth1.4, GND )#5 and2(w1.Bth1.4, b1, a3 )#5 or2(PP_1_4, w0.Bth1.4, w1.Bth1.4 )#5 // end mux2x1 Bth1.4 end netlist // mux2x1 Bth1.5( PP_1_5, GND, a4, b1 ) inv(b1_n.Bth1.5, b1 )#5 and2(w0.Bth1.5, b1_n.Bth1.5, GND )#5 and2(w1.Bth1.5, b1, a4 )#5 or2(PP_1_5, w0.Bth1.5, w1.Bth1.5 )#5 // end mux2x1 Bth1.5 end netlist // mux2x1 Bth1.6( PP_1_6, GND, a5, b1 ) inv(b1_n.Bth1.6, b1 )#5 and2(w0.Bth1.6, b1_n.Bth1.6, GND )#5 and2(w1.Bth1.6, b1, a5 )#5 or2(PP_1_6, w0.Bth1.6, w1.Bth1.6 )#5 // end mux2x1 Bth1.6 end netlist // mux2x1 Bth1.7( PP_1_7, GND, a6, b1 ) inv(b1_n.Bth1.7, b1 )#5 and2(w0.Bth1.7, b1_n.Bth1.7, GND )#5 and2(w1.Bth1.7, b1, a6 )#5 or2(PP_1_7, w0.Bth1.7, w1.Bth1.7 )#5 // end mux2x1 Bth1.7 end netlist // mux2x1 Bth1.8( PP_1_8, GND, a7, b1 ) inv(b1_n.Bth1.8, b1 )#5 and2(w0.Bth1.8, b1_n.Bth1.8, GND )#5 and2(w1.Bth1.8, b1, a7 )#5 or2(PP_1_8, w0.Bth1.8, w1.Bth1.8 )#5 // end mux2x1 Bth1.8 end netlist // mux2x1 Bth1.9( PP_1_9, GND, a8, b1 ) inv(b1_n.Bth1.9, b1 )#5 and2(w0.Bth1.9, b1_n.Bth1.9, GND )#5 and2(w1.Bth1.9, b1, a8 )#5 or2(PP_1_9, w0.Bth1.9, w1.Bth1.9 )#5 // end mux2x1 Bth1.9 end netlist // mux2x1 Bth1.10( PP_1_10, GND, a9, b1 ) inv(b1_n.Bth1.10, b1 )#5 and2(w0.Bth1.10, b1_n.Bth1.10, GND )#5 and2(w1.Bth1.10, b1, a9 )#5 or2(PP_1_10, w0.Bth1.10, w1.Bth1.10 )#5 // end mux2x1 Bth1.10 end netlist // mux2x1 Bth1.11( PP_1_11, GND, GND, b1 ) inv(b1_n.Bth1.11, b1 )#5 and2(w0.Bth1.11, b1_n.Bth1.11, GND )#5 and2(w1.Bth1.11, b1, GND )#5 or2(PP_1_11, w0.Bth1.11, w1.Bth1.11 )#5 // end mux2x1 Bth1.11 end netlist // mux2x1 Bth1.12( PP_1_12, GND, GND, b1 ) inv(b1_n.Bth1.12, b1 )#5 and2(w0.Bth1.12, b1_n.Bth1.12, GND )#5 and2(w1.Bth1.12, b1, GND )#5 or2(PP_1_12, w0.Bth1.12, w1.Bth1.12 )#5 // end mux2x1 Bth1.12 end netlist // mux2x1 Bth1.13( PP_1_13, GND, GND, b1 ) inv(b1_n.Bth1.13, b1 )#5 and2(w0.Bth1.13, b1_n.Bth1.13, GND )#5 and2(w1.Bth1.13, b1, GND )#5 or2(PP_1_13, w0.Bth1.13, w1.Bth1.13 )#5 // end mux2x1 Bth1.13 end netlist // mux2x1 Bth1.14( PP_1_14, GND, GND, b1 ) inv(b1_n.Bth1.14, b1 )#5 and2(w0.Bth1.14, b1_n.Bth1.14, GND )#5 and2(w1.Bth1.14, b1, GND )#5 or2(PP_1_14, w0.Bth1.14, w1.Bth1.14 )#5 // end mux2x1 Bth1.14 end netlist // mux2x1 Bth1.15( PP_1_15, GND, GND, b1 ) inv(b1_n.Bth1.15, b1 )#5 and2(w0.Bth1.15, b1_n.Bth1.15, GND )#5 and2(w1.Bth1.15, b1, GND )#5 or2(PP_1_15, w0.Bth1.15, w1.Bth1.15 )#5 // end mux2x1 Bth1.15 end netlist // mux2x1 Bth1.16( PP_1_16, GND, GND, b1 ) inv(b1_n.Bth1.16, b1 )#5 and2(w0.Bth1.16, b1_n.Bth1.16, GND )#5 and2(w1.Bth1.16, b1, GND )#5 or2(PP_1_16, w0.Bth1.16, w1.Bth1.16 )#5 // end mux2x1 Bth1.16 end netlist // mux2x1 Bth1.17( PP_1_17, GND, GND, b1 ) inv(b1_n.Bth1.17, b1 )#5 and2(w0.Bth1.17, b1_n.Bth1.17, GND )#5 and2(w1.Bth1.17, b1, GND )#5 or2(PP_1_17, w0.Bth1.17, w1.Bth1.17 )#5 // end mux2x1 Bth1.17 end netlist // mux2x1 Bth1.18( PP_1_18, GND, GND, b1 ) inv(b1_n.Bth1.18, b1 )#5 and2(w0.Bth1.18, b1_n.Bth1.18, GND )#5 and2(w1.Bth1.18, b1, GND )#5 or2(PP_1_18, w0.Bth1.18, w1.Bth1.18 )#5 // end mux2x1 Bth1.18 end netlist // mux2x1 Bth1.19( PP_1_19, GND, GND, b1 ) inv(b1_n.Bth1.19, b1 )#5 and2(w0.Bth1.19, b1_n.Bth1.19, GND )#5 and2(w1.Bth1.19, b1, GND )#5 or2(PP_1_19, w0.Bth1.19, w1.Bth1.19 )#5 // end mux2x1 Bth1.19 end netlist // mux2x1 Bth2.0( PP_2_0, GND, GND, b2 ) inv(b2_n.Bth2.0, b2 )#5 and2(w0.Bth2.0, b2_n.Bth2.0, GND )#5 and2(w1.Bth2.0, b2, GND )#5 or2(PP_2_0, w0.Bth2.0, w1.Bth2.0 )#5 // end mux2x1 Bth2.0 end netlist // mux2x1 Bth2.1( PP_2_1, GND, GND, b2 ) inv(b2_n.Bth2.1, b2 )#5 and2(w0.Bth2.1, b2_n.Bth2.1, GND )#5 and2(w1.Bth2.1, b2, GND )#5 or2(PP_2_1, w0.Bth2.1, w1.Bth2.1 )#5 // end mux2x1 Bth2.1 end netlist // mux2x1 Bth2.2( PP_2_2, GND, a0, b2 ) inv(b2_n.Bth2.2, b2 )#5 and2(w0.Bth2.2, b2_n.Bth2.2, GND )#5 and2(w1.Bth2.2, b2, a0 )#5 or2(PP_2_2, w0.Bth2.2, w1.Bth2.2 )#5 // end mux2x1 Bth2.2 end netlist // mux2x1 Bth2.3( PP_2_3, GND, a1, b2 ) inv(b2_n.Bth2.3, b2 )#5 and2(w0.Bth2.3, b2_n.Bth2.3, GND )#5 and2(w1.Bth2.3, b2, a1 )#5 or2(PP_2_3, w0.Bth2.3, w1.Bth2.3 )#5 // end mux2x1 Bth2.3 end netlist // mux2x1 Bth2.4( PP_2_4, GND, a2, b2 ) inv(b2_n.Bth2.4, b2 )#5 and2(w0.Bth2.4, b2_n.Bth2.4, GND )#5 and2(w1.Bth2.4, b2, a2 )#5 or2(PP_2_4, w0.Bth2.4, w1.Bth2.4 )#5 // end mux2x1 Bth2.4 end netlist // mux2x1 Bth2.5( PP_2_5, GND, a3, b2 ) inv(b2_n.Bth2.5, b2 )#5 and2(w0.Bth2.5, b2_n.Bth2.5, GND )#5 and2(w1.Bth2.5, b2, a3 )#5 or2(PP_2_5, w0.Bth2.5, w1.Bth2.5 )#5 // end mux2x1 Bth2.5 end netlist // mux2x1 Bth2.6( PP_2_6, GND, a4, b2 ) inv(b2_n.Bth2.6, b2 )#5 and2(w0.Bth2.6, b2_n.Bth2.6, GND )#5 and2(w1.Bth2.6, b2, a4 )#5 or2(PP_2_6, w0.Bth2.6, w1.Bth2.6 )#5 // end mux2x1 Bth2.6 end netlist // mux2x1 Bth2.7( PP_2_7, GND, a5, b2 ) inv(b2_n.Bth2.7, b2 )#5 and2(w0.Bth2.7, b2_n.Bth2.7, GND )#5 and2(w1.Bth2.7, b2, a5 )#5 or2(PP_2_7, w0.Bth2.7, w1.Bth2.7 )#5 // end mux2x1 Bth2.7 end netlist // mux2x1 Bth2.8( PP_2_8, GND, a6, b2 ) inv(b2_n.Bth2.8, b2 )#5 and2(w0.Bth2.8, b2_n.Bth2.8, GND )#5 and2(w1.Bth2.8, b2, a6 )#5 or2(PP_2_8, w0.Bth2.8, w1.Bth2.8 )#5 // end mux2x1 Bth2.8 end netlist // mux2x1 Bth2.9( PP_2_9, GND, a7, b2 ) inv(b2_n.Bth2.9, b2 )#5 and2(w0.Bth2.9, b2_n.Bth2.9, GND )#5 and2(w1.Bth2.9, b2, a7 )#5 or2(PP_2_9, w0.Bth2.9, w1.Bth2.9 )#5 // end mux2x1 Bth2.9 end netlist // mux2x1 Bth2.10( PP_2_10, GND, a8, b2 ) inv(b2_n.Bth2.10, b2 )#5 and2(w0.Bth2.10, b2_n.Bth2.10, GND )#5 and2(w1.Bth2.10, b2, a8 )#5 or2(PP_2_10, w0.Bth2.10, w1.Bth2.10 )#5 // end mux2x1 Bth2.10 end netlist // mux2x1 Bth2.11( PP_2_11, GND, a9, b2 ) inv(b2_n.Bth2.11, b2 )#5 and2(w0.Bth2.11, b2_n.Bth2.11, GND )#5 and2(w1.Bth2.11, b2, a9 )#5 or2(PP_2_11, w0.Bth2.11, w1.Bth2.11 )#5 // end mux2x1 Bth2.11 end netlist // mux2x1 Bth2.12( PP_2_12, GND, GND, b2 ) inv(b2_n.Bth2.12, b2 )#5 and2(w0.Bth2.12, b2_n.Bth2.12, GND )#5 and2(w1.Bth2.12, b2, GND )#5 or2(PP_2_12, w0.Bth2.12, w1.Bth2.12 )#5 // end mux2x1 Bth2.12 end netlist // mux2x1 Bth2.13( PP_2_13, GND, GND, b2 ) inv(b2_n.Bth2.13, b2 )#5 and2(w0.Bth2.13, b2_n.Bth2.13, GND )#5 and2(w1.Bth2.13, b2, GND )#5 or2(PP_2_13, w0.Bth2.13, w1.Bth2.13 )#5 // end mux2x1 Bth2.13 end netlist // mux2x1 Bth2.14( PP_2_14, GND, GND, b2 ) inv(b2_n.Bth2.14, b2 )#5 and2(w0.Bth2.14, b2_n.Bth2.14, GND )#5 and2(w1.Bth2.14, b2, GND )#5 or2(PP_2_14, w0.Bth2.14, w1.Bth2.14 )#5 // end mux2x1 Bth2.14 end netlist // mux2x1 Bth2.15( PP_2_15, GND, GND, b2 ) inv(b2_n.Bth2.15, b2 )#5 and2(w0.Bth2.15, b2_n.Bth2.15, GND )#5 and2(w1.Bth2.15, b2, GND )#5 or2(PP_2_15, w0.Bth2.15, w1.Bth2.15 )#5 // end mux2x1 Bth2.15 end netlist // mux2x1 Bth2.16( PP_2_16, GND, GND, b2 ) inv(b2_n.Bth2.16, b2 )#5 and2(w0.Bth2.16, b2_n.Bth2.16, GND )#5 and2(w1.Bth2.16, b2, GND )#5 or2(PP_2_16, w0.Bth2.16, w1.Bth2.16 )#5 // end mux2x1 Bth2.16 end netlist // mux2x1 Bth2.17( PP_2_17, GND, GND, b2 ) inv(b2_n.Bth2.17, b2 )#5 and2(w0.Bth2.17, b2_n.Bth2.17, GND )#5 and2(w1.Bth2.17, b2, GND )#5 or2(PP_2_17, w0.Bth2.17, w1.Bth2.17 )#5 // end mux2x1 Bth2.17 end netlist // mux2x1 Bth2.18( PP_2_18, GND, GND, b2 ) inv(b2_n.Bth2.18, b2 )#5 and2(w0.Bth2.18, b2_n.Bth2.18, GND )#5 and2(w1.Bth2.18, b2, GND )#5 or2(PP_2_18, w0.Bth2.18, w1.Bth2.18 )#5 // end mux2x1 Bth2.18 end netlist // mux2x1 Bth2.19( PP_2_19, GND, GND, b2 ) inv(b2_n.Bth2.19, b2 )#5 and2(w0.Bth2.19, b2_n.Bth2.19, GND )#5 and2(w1.Bth2.19, b2, GND )#5 or2(PP_2_19, w0.Bth2.19, w1.Bth2.19 )#5 // end mux2x1 Bth2.19 end netlist // mux2x1 Bth3.0( PP_3_0, GND, GND, b3 ) inv(b3_n.Bth3.0, b3 )#5 and2(w0.Bth3.0, b3_n.Bth3.0, GND )#5 and2(w1.Bth3.0, b3, GND )#5 or2(PP_3_0, w0.Bth3.0, w1.Bth3.0 )#5 // end mux2x1 Bth3.0 end netlist // mux2x1 Bth3.1( PP_3_1, GND, GND, b3 ) inv(b3_n.Bth3.1, b3 )#5 and2(w0.Bth3.1, b3_n.Bth3.1, GND )#5 and2(w1.Bth3.1, b3, GND )#5 or2(PP_3_1, w0.Bth3.1, w1.Bth3.1 )#5 // end mux2x1 Bth3.1 end netlist // mux2x1 Bth3.2( PP_3_2, GND, GND, b3 ) inv(b3_n.Bth3.2, b3 )#5 and2(w0.Bth3.2, b3_n.Bth3.2, GND )#5 and2(w1.Bth3.2, b3, GND )#5 or2(PP_3_2, w0.Bth3.2, w1.Bth3.2 )#5 // end mux2x1 Bth3.2 end netlist // mux2x1 Bth3.3( PP_3_3, GND, a0, b3 ) inv(b3_n.Bth3.3, b3 )#5 and2(w0.Bth3.3, b3_n.Bth3.3, GND )#5 and2(w1.Bth3.3, b3, a0 )#5 or2(PP_3_3, w0.Bth3.3, w1.Bth3.3 )#5 // end mux2x1 Bth3.3 end netlist // mux2x1 Bth3.4( PP_3_4, GND, a1, b3 ) inv(b3_n.Bth3.4, b3 )#5 and2(w0.Bth3.4, b3_n.Bth3.4, GND )#5 and2(w1.Bth3.4, b3, a1 )#5 or2(PP_3_4, w0.Bth3.4, w1.Bth3.4 )#5 // end mux2x1 Bth3.4 end netlist // mux2x1 Bth3.5( PP_3_5, GND, a2, b3 ) inv(b3_n.Bth3.5, b3 )#5 and2(w0.Bth3.5, b3_n.Bth3.5, GND )#5 and2(w1.Bth3.5, b3, a2 )#5 or2(PP_3_5, w0.Bth3.5, w1.Bth3.5 )#5 // end mux2x1 Bth3.5 end netlist // mux2x1 Bth3.6( PP_3_6, GND, a3, b3 ) inv(b3_n.Bth3.6, b3 )#5 and2(w0.Bth3.6, b3_n.Bth3.6, GND )#5 and2(w1.Bth3.6, b3, a3 )#5 or2(PP_3_6, w0.Bth3.6, w1.Bth3.6 )#5 // end mux2x1 Bth3.6 end netlist // mux2x1 Bth3.7( PP_3_7, GND, a4, b3 ) inv(b3_n.Bth3.7, b3 )#5 and2(w0.Bth3.7, b3_n.Bth3.7, GND )#5 and2(w1.Bth3.7, b3, a4 )#5 or2(PP_3_7, w0.Bth3.7, w1.Bth3.7 )#5 // end mux2x1 Bth3.7 end netlist // mux2x1 Bth3.8( PP_3_8, GND, a5, b3 ) inv(b3_n.Bth3.8, b3 )#5 and2(w0.Bth3.8, b3_n.Bth3.8, GND )#5 and2(w1.Bth3.8, b3, a5 )#5 or2(PP_3_8, w0.Bth3.8, w1.Bth3.8 )#5 // end mux2x1 Bth3.8 end netlist // mux2x1 Bth3.9( PP_3_9, GND, a6, b3 ) inv(b3_n.Bth3.9, b3 )#5 and2(w0.Bth3.9, b3_n.Bth3.9, GND )#5 and2(w1.Bth3.9, b3, a6 )#5 or2(PP_3_9, w0.Bth3.9, w1.Bth3.9 )#5 // end mux2x1 Bth3.9 end netlist // mux2x1 Bth3.10( PP_3_10, GND, a7, b3 ) inv(b3_n.Bth3.10, b3 )#5 and2(w0.Bth3.10, b3_n.Bth3.10, GND )#5 and2(w1.Bth3.10, b3, a7 )#5 or2(PP_3_10, w0.Bth3.10, w1.Bth3.10 )#5 // end mux2x1 Bth3.10 end netlist // mux2x1 Bth3.11( PP_3_11, GND, a8, b3 ) inv(b3_n.Bth3.11, b3 )#5 and2(w0.Bth3.11, b3_n.Bth3.11, GND )#5 and2(w1.Bth3.11, b3, a8 )#5 or2(PP_3_11, w0.Bth3.11, w1.Bth3.11 )#5 // end mux2x1 Bth3.11 end netlist // mux2x1 Bth3.12( PP_3_12, GND, a9, b3 ) inv(b3_n.Bth3.12, b3 )#5 and2(w0.Bth3.12, b3_n.Bth3.12, GND )#5 and2(w1.Bth3.12, b3, a9 )#5 or2(PP_3_12, w0.Bth3.12, w1.Bth3.12 )#5 // end mux2x1 Bth3.12 end netlist // mux2x1 Bth3.13( PP_3_13, GND, GND, b3 ) inv(b3_n.Bth3.13, b3 )#5 and2(w0.Bth3.13, b3_n.Bth3.13, GND )#5 and2(w1.Bth3.13, b3, GND )#5 or2(PP_3_13, w0.Bth3.13, w1.Bth3.13 )#5 // end mux2x1 Bth3.13 end netlist // mux2x1 Bth3.14( PP_3_14, GND, GND, b3 ) inv(b3_n.Bth3.14, b3 )#5 and2(w0.Bth3.14, b3_n.Bth3.14, GND )#5 and2(w1.Bth3.14, b3, GND )#5 or2(PP_3_14, w0.Bth3.14, w1.Bth3.14 )#5 // end mux2x1 Bth3.14 end netlist // mux2x1 Bth3.15( PP_3_15, GND, GND, b3 ) inv(b3_n.Bth3.15, b3 )#5 and2(w0.Bth3.15, b3_n.Bth3.15, GND )#5 and2(w1.Bth3.15, b3, GND )#5 or2(PP_3_15, w0.Bth3.15, w1.Bth3.15 )#5 // end mux2x1 Bth3.15 end netlist // mux2x1 Bth3.16( PP_3_16, GND, GND, b3 ) inv(b3_n.Bth3.16, b3 )#5 and2(w0.Bth3.16, b3_n.Bth3.16, GND )#5 and2(w1.Bth3.16, b3, GND )#5 or2(PP_3_16, w0.Bth3.16, w1.Bth3.16 )#5 // end mux2x1 Bth3.16 end netlist // mux2x1 Bth3.17( PP_3_17, GND, GND, b3 ) inv(b3_n.Bth3.17, b3 )#5 and2(w0.Bth3.17, b3_n.Bth3.17, GND )#5 and2(w1.Bth3.17, b3, GND )#5 or2(PP_3_17, w0.Bth3.17, w1.Bth3.17 )#5 // end mux2x1 Bth3.17 end netlist // mux2x1 Bth3.18( PP_3_18, GND, GND, b3 ) inv(b3_n.Bth3.18, b3 )#5 and2(w0.Bth3.18, b3_n.Bth3.18, GND )#5 and2(w1.Bth3.18, b3, GND )#5 or2(PP_3_18, w0.Bth3.18, w1.Bth3.18 )#5 // end mux2x1 Bth3.18 end netlist // mux2x1 Bth3.19( PP_3_19, GND, GND, b3 ) inv(b3_n.Bth3.19, b3 )#5 and2(w0.Bth3.19, b3_n.Bth3.19, GND )#5 and2(w1.Bth3.19, b3, GND )#5 or2(PP_3_19, w0.Bth3.19, w1.Bth3.19 )#5 // end mux2x1 Bth3.19 end netlist // mux2x1 Bth4.0( PP_4_0, GND, GND, b4 ) inv(b4_n.Bth4.0, b4 )#5 and2(w0.Bth4.0, b4_n.Bth4.0, GND )#5 and2(w1.Bth4.0, b4, GND )#5 or2(PP_4_0, w0.Bth4.0, w1.Bth4.0 )#5 // end mux2x1 Bth4.0 end netlist // mux2x1 Bth4.1( PP_4_1, GND, GND, b4 ) inv(b4_n.Bth4.1, b4 )#5 and2(w0.Bth4.1, b4_n.Bth4.1, GND )#5 and2(w1.Bth4.1, b4, GND )#5 or2(PP_4_1, w0.Bth4.1, w1.Bth4.1 )#5 // end mux2x1 Bth4.1 end netlist // mux2x1 Bth4.2( PP_4_2, GND, GND, b4 ) inv(b4_n.Bth4.2, b4 )#5 and2(w0.Bth4.2, b4_n.Bth4.2, GND )#5 and2(w1.Bth4.2, b4, GND )#5 or2(PP_4_2, w0.Bth4.2, w1.Bth4.2 )#5 // end mux2x1 Bth4.2 end netlist // mux2x1 Bth4.3( PP_4_3, GND, GND, b4 ) inv(b4_n.Bth4.3, b4 )#5 and2(w0.Bth4.3, b4_n.Bth4.3, GND )#5 and2(w1.Bth4.3, b4, GND )#5 or2(PP_4_3, w0.Bth4.3, w1.Bth4.3 )#5 // end mux2x1 Bth4.3 end netlist // mux2x1 Bth4.4( PP_4_4, GND, a0, b4 ) inv(b4_n.Bth4.4, b4 )#5 and2(w0.Bth4.4, b4_n.Bth4.4, GND )#5 and2(w1.Bth4.4, b4, a0 )#5 or2(PP_4_4, w0.Bth4.4, w1.Bth4.4 )#5 // end mux2x1 Bth4.4 end netlist // mux2x1 Bth4.5( PP_4_5, GND, a1, b4 ) inv(b4_n.Bth4.5, b4 )#5 and2(w0.Bth4.5, b4_n.Bth4.5, GND )#5 and2(w1.Bth4.5, b4, a1 )#5 or2(PP_4_5, w0.Bth4.5, w1.Bth4.5 )#5 // end mux2x1 Bth4.5 end netlist // mux2x1 Bth4.6( PP_4_6, GND, a2, b4 ) inv(b4_n.Bth4.6, b4 )#5 and2(w0.Bth4.6, b4_n.Bth4.6, GND )#5 and2(w1.Bth4.6, b4, a2 )#5 or2(PP_4_6, w0.Bth4.6, w1.Bth4.6 )#5 // end mux2x1 Bth4.6 end netlist // mux2x1 Bth4.7( PP_4_7, GND, a3, b4 ) inv(b4_n.Bth4.7, b4 )#5 and2(w0.Bth4.7, b4_n.Bth4.7, GND )#5 and2(w1.Bth4.7, b4, a3 )#5 or2(PP_4_7, w0.Bth4.7, w1.Bth4.7 )#5 // end mux2x1 Bth4.7 end netlist // mux2x1 Bth4.8( PP_4_8, GND, a4, b4 ) inv(b4_n.Bth4.8, b4 )#5 and2(w0.Bth4.8, b4_n.Bth4.8, GND )#5 and2(w1.Bth4.8, b4, a4 )#5 or2(PP_4_8, w0.Bth4.8, w1.Bth4.8 )#5 // end mux2x1 Bth4.8 end netlist // mux2x1 Bth4.9( PP_4_9, GND, a5, b4 ) inv(b4_n.Bth4.9, b4 )#5 and2(w0.Bth4.9, b4_n.Bth4.9, GND )#5 and2(w1.Bth4.9, b4, a5 )#5 or2(PP_4_9, w0.Bth4.9, w1.Bth4.9 )#5 // end mux2x1 Bth4.9 end netlist // mux2x1 Bth4.10( PP_4_10, GND, a6, b4 ) inv(b4_n.Bth4.10, b4 )#5 and2(w0.Bth4.10, b4_n.Bth4.10, GND )#5 and2(w1.Bth4.10, b4, a6 )#5 or2(PP_4_10, w0.Bth4.10, w1.Bth4.10 )#5 // end mux2x1 Bth4.10 end netlist // mux2x1 Bth4.11( PP_4_11, GND, a7, b4 ) inv(b4_n.Bth4.11, b4 )#5 and2(w0.Bth4.11, b4_n.Bth4.11, GND )#5 and2(w1.Bth4.11, b4, a7 )#5 or2(PP_4_11, w0.Bth4.11, w1.Bth4.11 )#5 // end mux2x1 Bth4.11 end netlist // mux2x1 Bth4.12( PP_4_12, GND, a8, b4 ) inv(b4_n.Bth4.12, b4 )#5 and2(w0.Bth4.12, b4_n.Bth4.12, GND )#5 and2(w1.Bth4.12, b4, a8 )#5 or2(PP_4_12, w0.Bth4.12, w1.Bth4.12 )#5 // end mux2x1 Bth4.12 end netlist // mux2x1 Bth4.13( PP_4_13, GND, a9, b4 ) inv(b4_n.Bth4.13, b4 )#5 and2(w0.Bth4.13, b4_n.Bth4.13, GND )#5 and2(w1.Bth4.13, b4, a9 )#5 or2(PP_4_13, w0.Bth4.13, w1.Bth4.13 )#5 // end mux2x1 Bth4.13 end netlist // mux2x1 Bth4.14( PP_4_14, GND, GND, b4 ) inv(b4_n.Bth4.14, b4 )#5 and2(w0.Bth4.14, b4_n.Bth4.14, GND )#5 and2(w1.Bth4.14, b4, GND )#5 or2(PP_4_14, w0.Bth4.14, w1.Bth4.14 )#5 // end mux2x1 Bth4.14 end netlist // mux2x1 Bth4.15( PP_4_15, GND, GND, b4 ) inv(b4_n.Bth4.15, b4 )#5 and2(w0.Bth4.15, b4_n.Bth4.15, GND )#5 and2(w1.Bth4.15, b4, GND )#5 or2(PP_4_15, w0.Bth4.15, w1.Bth4.15 )#5 // end mux2x1 Bth4.15 end netlist // mux2x1 Bth4.16( PP_4_16, GND, GND, b4 ) inv(b4_n.Bth4.16, b4 )#5 and2(w0.Bth4.16, b4_n.Bth4.16, GND )#5 and2(w1.Bth4.16, b4, GND )#5 or2(PP_4_16, w0.Bth4.16, w1.Bth4.16 )#5 // end mux2x1 Bth4.16 end netlist // mux2x1 Bth4.17( PP_4_17, GND, GND, b4 ) inv(b4_n.Bth4.17, b4 )#5 and2(w0.Bth4.17, b4_n.Bth4.17, GND )#5 and2(w1.Bth4.17, b4, GND )#5 or2(PP_4_17, w0.Bth4.17, w1.Bth4.17 )#5 // end mux2x1 Bth4.17 end netlist // mux2x1 Bth4.18( PP_4_18, GND, GND, b4 ) inv(b4_n.Bth4.18, b4 )#5 and2(w0.Bth4.18, b4_n.Bth4.18, GND )#5 and2(w1.Bth4.18, b4, GND )#5 or2(PP_4_18, w0.Bth4.18, w1.Bth4.18 )#5 // end mux2x1 Bth4.18 end netlist // mux2x1 Bth4.19( PP_4_19, GND, GND, b4 ) inv(b4_n.Bth4.19, b4 )#5 and2(w0.Bth4.19, b4_n.Bth4.19, GND )#5 and2(w1.Bth4.19, b4, GND )#5 or2(PP_4_19, w0.Bth4.19, w1.Bth4.19 )#5 // end mux2x1 Bth4.19 end netlist // mux2x1 Bth5.0( PP_5_0, GND, GND, b5 ) inv(b5_n.Bth5.0, b5 )#5 and2(w0.Bth5.0, b5_n.Bth5.0, GND )#5 and2(w1.Bth5.0, b5, GND )#5 or2(PP_5_0, w0.Bth5.0, w1.Bth5.0 )#5 // end mux2x1 Bth5.0 end netlist // mux2x1 Bth5.1( PP_5_1, GND, GND, b5 ) inv(b5_n.Bth5.1, b5 )#5 and2(w0.Bth5.1, b5_n.Bth5.1, GND )#5 and2(w1.Bth5.1, b5, GND )#5 or2(PP_5_1, w0.Bth5.1, w1.Bth5.1 )#5 // end mux2x1 Bth5.1 end netlist // mux2x1 Bth5.2( PP_5_2, GND, GND, b5 ) inv(b5_n.Bth5.2, b5 )#5 and2(w0.Bth5.2, b5_n.Bth5.2, GND )#5 and2(w1.Bth5.2, b5, GND )#5 or2(PP_5_2, w0.Bth5.2, w1.Bth5.2 )#5 // end mux2x1 Bth5.2 end netlist // mux2x1 Bth5.3( PP_5_3, GND, GND, b5 ) inv(b5_n.Bth5.3, b5 )#5 and2(w0.Bth5.3, b5_n.Bth5.3, GND )#5 and2(w1.Bth5.3, b5, GND )#5 or2(PP_5_3, w0.Bth5.3, w1.Bth5.3 )#5 // end mux2x1 Bth5.3 end netlist // mux2x1 Bth5.4( PP_5_4, GND, GND, b5 ) inv(b5_n.Bth5.4, b5 )#5 and2(w0.Bth5.4, b5_n.Bth5.4, GND )#5 and2(w1.Bth5.4, b5, GND )#5 or2(PP_5_4, w0.Bth5.4, w1.Bth5.4 )#5 // end mux2x1 Bth5.4 end netlist // mux2x1 Bth5.5( PP_5_5, GND, a0, b5 ) inv(b5_n.Bth5.5, b5 )#5 and2(w0.Bth5.5, b5_n.Bth5.5, GND )#5 and2(w1.Bth5.5, b5, a0 )#5 or2(PP_5_5, w0.Bth5.5, w1.Bth5.5 )#5 // end mux2x1 Bth5.5 end netlist // mux2x1 Bth5.6( PP_5_6, GND, a1, b5 ) inv(b5_n.Bth5.6, b5 )#5 and2(w0.Bth5.6, b5_n.Bth5.6, GND )#5 and2(w1.Bth5.6, b5, a1 )#5 or2(PP_5_6, w0.Bth5.6, w1.Bth5.6 )#5 // end mux2x1 Bth5.6 end netlist // mux2x1 Bth5.7( PP_5_7, GND, a2, b5 ) inv(b5_n.Bth5.7, b5 )#5 and2(w0.Bth5.7, b5_n.Bth5.7, GND )#5 and2(w1.Bth5.7, b5, a2 )#5 or2(PP_5_7, w0.Bth5.7, w1.Bth5.7 )#5 // end mux2x1 Bth5.7 end netlist // mux2x1 Bth5.8( PP_5_8, GND, a3, b5 ) inv(b5_n.Bth5.8, b5 )#5 and2(w0.Bth5.8, b5_n.Bth5.8, GND )#5 and2(w1.Bth5.8, b5, a3 )#5 or2(PP_5_8, w0.Bth5.8, w1.Bth5.8 )#5 // end mux2x1 Bth5.8 end netlist // mux2x1 Bth5.9( PP_5_9, GND, a4, b5 ) inv(b5_n.Bth5.9, b5 )#5 and2(w0.Bth5.9, b5_n.Bth5.9, GND )#5 and2(w1.Bth5.9, b5, a4 )#5 or2(PP_5_9, w0.Bth5.9, w1.Bth5.9 )#5 // end mux2x1 Bth5.9 end netlist // mux2x1 Bth5.10( PP_5_10, GND, a5, b5 ) inv(b5_n.Bth5.10, b5 )#5 and2(w0.Bth5.10, b5_n.Bth5.10, GND )#5 and2(w1.Bth5.10, b5, a5 )#5 or2(PP_5_10, w0.Bth5.10, w1.Bth5.10 )#5 // end mux2x1 Bth5.10 end netlist // mux2x1 Bth5.11( PP_5_11, GND, a6, b5 ) inv(b5_n.Bth5.11, b5 )#5 and2(w0.Bth5.11, b5_n.Bth5.11, GND )#5 and2(w1.Bth5.11, b5, a6 )#5 or2(PP_5_11, w0.Bth5.11, w1.Bth5.11 )#5 // end mux2x1 Bth5.11 end netlist // mux2x1 Bth5.12( PP_5_12, GND, a7, b5 ) inv(b5_n.Bth5.12, b5 )#5 and2(w0.Bth5.12, b5_n.Bth5.12, GND )#5 and2(w1.Bth5.12, b5, a7 )#5 or2(PP_5_12, w0.Bth5.12, w1.Bth5.12 )#5 // end mux2x1 Bth5.12 end netlist // mux2x1 Bth5.13( PP_5_13, GND, a8, b5 ) inv(b5_n.Bth5.13, b5 )#5 and2(w0.Bth5.13, b5_n.Bth5.13, GND )#5 and2(w1.Bth5.13, b5, a8 )#5 or2(PP_5_13, w0.Bth5.13, w1.Bth5.13 )#5 // end mux2x1 Bth5.13 end netlist // mux2x1 Bth5.14( PP_5_14, GND, a9, b5 ) inv(b5_n.Bth5.14, b5 )#5 and2(w0.Bth5.14, b5_n.Bth5.14, GND )#5 and2(w1.Bth5.14, b5, a9 )#5 or2(PP_5_14, w0.Bth5.14, w1.Bth5.14 )#5 // end mux2x1 Bth5.14 end netlist // mux2x1 Bth5.15( PP_5_15, GND, GND, b5 ) inv(b5_n.Bth5.15, b5 )#5 and2(w0.Bth5.15, b5_n.Bth5.15, GND )#5 and2(w1.Bth5.15, b5, GND )#5 or2(PP_5_15, w0.Bth5.15, w1.Bth5.15 )#5 // end mux2x1 Bth5.15 end netlist // mux2x1 Bth5.16( PP_5_16, GND, GND, b5 ) inv(b5_n.Bth5.16, b5 )#5 and2(w0.Bth5.16, b5_n.Bth5.16, GND )#5 and2(w1.Bth5.16, b5, GND )#5 or2(PP_5_16, w0.Bth5.16, w1.Bth5.16 )#5 // end mux2x1 Bth5.16 end netlist // mux2x1 Bth5.17( PP_5_17, GND, GND, b5 ) inv(b5_n.Bth5.17, b5 )#5 and2(w0.Bth5.17, b5_n.Bth5.17, GND )#5 and2(w1.Bth5.17, b5, GND )#5 or2(PP_5_17, w0.Bth5.17, w1.Bth5.17 )#5 // end mux2x1 Bth5.17 end netlist // mux2x1 Bth5.18( PP_5_18, GND, GND, b5 ) inv(b5_n.Bth5.18, b5 )#5 and2(w0.Bth5.18, b5_n.Bth5.18, GND )#5 and2(w1.Bth5.18, b5, GND )#5 or2(PP_5_18, w0.Bth5.18, w1.Bth5.18 )#5 // end mux2x1 Bth5.18 end netlist // mux2x1 Bth5.19( PP_5_19, GND, GND, b5 ) inv(b5_n.Bth5.19, b5 )#5 and2(w0.Bth5.19, b5_n.Bth5.19, GND )#5 and2(w1.Bth5.19, b5, GND )#5 or2(PP_5_19, w0.Bth5.19, w1.Bth5.19 )#5 // end mux2x1 Bth5.19 end netlist // mux2x1 Bth6.0( PP_6_0, GND, GND, b6 ) inv(b6_n.Bth6.0, b6 )#5 and2(w0.Bth6.0, b6_n.Bth6.0, GND )#5 and2(w1.Bth6.0, b6, GND )#5 or2(PP_6_0, w0.Bth6.0, w1.Bth6.0 )#5 // end mux2x1 Bth6.0 end netlist // mux2x1 Bth6.1( PP_6_1, GND, GND, b6 ) inv(b6_n.Bth6.1, b6 )#5 and2(w0.Bth6.1, b6_n.Bth6.1, GND )#5 and2(w1.Bth6.1, b6, GND )#5 or2(PP_6_1, w0.Bth6.1, w1.Bth6.1 )#5 // end mux2x1 Bth6.1 end netlist // mux2x1 Bth6.2( PP_6_2, GND, GND, b6 ) inv(b6_n.Bth6.2, b6 )#5 and2(w0.Bth6.2, b6_n.Bth6.2, GND )#5 and2(w1.Bth6.2, b6, GND )#5 or2(PP_6_2, w0.Bth6.2, w1.Bth6.2 )#5 // end mux2x1 Bth6.2 end netlist // mux2x1 Bth6.3( PP_6_3, GND, GND, b6 ) inv(b6_n.Bth6.3, b6 )#5 and2(w0.Bth6.3, b6_n.Bth6.3, GND )#5 and2(w1.Bth6.3, b6, GND )#5 or2(PP_6_3, w0.Bth6.3, w1.Bth6.3 )#5 // end mux2x1 Bth6.3 end netlist // mux2x1 Bth6.4( PP_6_4, GND, GND, b6 ) inv(b6_n.Bth6.4, b6 )#5 and2(w0.Bth6.4, b6_n.Bth6.4, GND )#5 and2(w1.Bth6.4, b6, GND )#5 or2(PP_6_4, w0.Bth6.4, w1.Bth6.4 )#5 // end mux2x1 Bth6.4 end netlist // mux2x1 Bth6.5( PP_6_5, GND, GND, b6 ) inv(b6_n.Bth6.5, b6 )#5 and2(w0.Bth6.5, b6_n.Bth6.5, GND )#5 and2(w1.Bth6.5, b6, GND )#5 or2(PP_6_5, w0.Bth6.5, w1.Bth6.5 )#5 // end mux2x1 Bth6.5 end netlist // mux2x1 Bth6.6( PP_6_6, GND, a0, b6 ) inv(b6_n.Bth6.6, b6 )#5 and2(w0.Bth6.6, b6_n.Bth6.6, GND )#5 and2(w1.Bth6.6, b6, a0 )#5 or2(PP_6_6, w0.Bth6.6, w1.Bth6.6 )#5 // end mux2x1 Bth6.6 end netlist // mux2x1 Bth6.7( PP_6_7, GND, a1, b6 ) inv(b6_n.Bth6.7, b6 )#5 and2(w0.Bth6.7, b6_n.Bth6.7, GND )#5 and2(w1.Bth6.7, b6, a1 )#5 or2(PP_6_7, w0.Bth6.7, w1.Bth6.7 )#5 // end mux2x1 Bth6.7 end netlist // mux2x1 Bth6.8( PP_6_8, GND, a2, b6 ) inv(b6_n.Bth6.8, b6 )#5 and2(w0.Bth6.8, b6_n.Bth6.8, GND )#5 and2(w1.Bth6.8, b6, a2 )#5 or2(PP_6_8, w0.Bth6.8, w1.Bth6.8 )#5 // end mux2x1 Bth6.8 end netlist // mux2x1 Bth6.9( PP_6_9, GND, a3, b6 ) inv(b6_n.Bth6.9, b6 )#5 and2(w0.Bth6.9, b6_n.Bth6.9, GND )#5 and2(w1.Bth6.9, b6, a3 )#5 or2(PP_6_9, w0.Bth6.9, w1.Bth6.9 )#5 // end mux2x1 Bth6.9 end netlist // mux2x1 Bth6.10( PP_6_10, GND, a4, b6 ) inv(b6_n.Bth6.10, b6 )#5 and2(w0.Bth6.10, b6_n.Bth6.10, GND )#5 and2(w1.Bth6.10, b6, a4 )#5 or2(PP_6_10, w0.Bth6.10, w1.Bth6.10 )#5 // end mux2x1 Bth6.10 end netlist // mux2x1 Bth6.11( PP_6_11, GND, a5, b6 ) inv(b6_n.Bth6.11, b6 )#5 and2(w0.Bth6.11, b6_n.Bth6.11, GND )#5 and2(w1.Bth6.11, b6, a5 )#5 or2(PP_6_11, w0.Bth6.11, w1.Bth6.11 )#5 // end mux2x1 Bth6.11 end netlist // mux2x1 Bth6.12( PP_6_12, GND, a6, b6 ) inv(b6_n.Bth6.12, b6 )#5 and2(w0.Bth6.12, b6_n.Bth6.12, GND )#5 and2(w1.Bth6.12, b6, a6 )#5 or2(PP_6_12, w0.Bth6.12, w1.Bth6.12 )#5 // end mux2x1 Bth6.12 end netlist // mux2x1 Bth6.13( PP_6_13, GND, a7, b6 ) inv(b6_n.Bth6.13, b6 )#5 and2(w0.Bth6.13, b6_n.Bth6.13, GND )#5 and2(w1.Bth6.13, b6, a7 )#5 or2(PP_6_13, w0.Bth6.13, w1.Bth6.13 )#5 // end mux2x1 Bth6.13 end netlist // mux2x1 Bth6.14( PP_6_14, GND, a8, b6 ) inv(b6_n.Bth6.14, b6 )#5 and2(w0.Bth6.14, b6_n.Bth6.14, GND )#5 and2(w1.Bth6.14, b6, a8 )#5 or2(PP_6_14, w0.Bth6.14, w1.Bth6.14 )#5 // end mux2x1 Bth6.14 end netlist // mux2x1 Bth6.15( PP_6_15, GND, a9, b6 ) inv(b6_n.Bth6.15, b6 )#5 and2(w0.Bth6.15, b6_n.Bth6.15, GND )#5 and2(w1.Bth6.15, b6, a9 )#5 or2(PP_6_15, w0.Bth6.15, w1.Bth6.15 )#5 // end mux2x1 Bth6.15 end netlist // mux2x1 Bth6.16( PP_6_16, GND, GND, b6 ) inv(b6_n.Bth6.16, b6 )#5 and2(w0.Bth6.16, b6_n.Bth6.16, GND )#5 and2(w1.Bth6.16, b6, GND )#5 or2(PP_6_16, w0.Bth6.16, w1.Bth6.16 )#5 // end mux2x1 Bth6.16 end netlist // mux2x1 Bth6.17( PP_6_17, GND, GND, b6 ) inv(b6_n.Bth6.17, b6 )#5 and2(w0.Bth6.17, b6_n.Bth6.17, GND )#5 and2(w1.Bth6.17, b6, GND )#5 or2(PP_6_17, w0.Bth6.17, w1.Bth6.17 )#5 // end mux2x1 Bth6.17 end netlist // mux2x1 Bth6.18( PP_6_18, GND, GND, b6 ) inv(b6_n.Bth6.18, b6 )#5 and2(w0.Bth6.18, b6_n.Bth6.18, GND )#5 and2(w1.Bth6.18, b6, GND )#5 or2(PP_6_18, w0.Bth6.18, w1.Bth6.18 )#5 // end mux2x1 Bth6.18 end netlist // mux2x1 Bth6.19( PP_6_19, GND, GND, b6 ) inv(b6_n.Bth6.19, b6 )#5 and2(w0.Bth6.19, b6_n.Bth6.19, GND )#5 and2(w1.Bth6.19, b6, GND )#5 or2(PP_6_19, w0.Bth6.19, w1.Bth6.19 )#5 // end mux2x1 Bth6.19 end netlist // mux2x1 Bth7.0( PP_7_0, GND, GND, b7 ) inv(b7_n.Bth7.0, b7 )#5 and2(w0.Bth7.0, b7_n.Bth7.0, GND )#5 and2(w1.Bth7.0, b7, GND )#5 or2(PP_7_0, w0.Bth7.0, w1.Bth7.0 )#5 // end mux2x1 Bth7.0 end netlist // mux2x1 Bth7.1( PP_7_1, GND, GND, b7 ) inv(b7_n.Bth7.1, b7 )#5 and2(w0.Bth7.1, b7_n.Bth7.1, GND )#5 and2(w1.Bth7.1, b7, GND )#5 or2(PP_7_1, w0.Bth7.1, w1.Bth7.1 )#5 // end mux2x1 Bth7.1 end netlist // mux2x1 Bth7.2( PP_7_2, GND, GND, b7 ) inv(b7_n.Bth7.2, b7 )#5 and2(w0.Bth7.2, b7_n.Bth7.2, GND )#5 and2(w1.Bth7.2, b7, GND )#5 or2(PP_7_2, w0.Bth7.2, w1.Bth7.2 )#5 // end mux2x1 Bth7.2 end netlist // mux2x1 Bth7.3( PP_7_3, GND, GND, b7 ) inv(b7_n.Bth7.3, b7 )#5 and2(w0.Bth7.3, b7_n.Bth7.3, GND )#5 and2(w1.Bth7.3, b7, GND )#5 or2(PP_7_3, w0.Bth7.3, w1.Bth7.3 )#5 // end mux2x1 Bth7.3 end netlist // mux2x1 Bth7.4( PP_7_4, GND, GND, b7 ) inv(b7_n.Bth7.4, b7 )#5 and2(w0.Bth7.4, b7_n.Bth7.4, GND )#5 and2(w1.Bth7.4, b7, GND )#5 or2(PP_7_4, w0.Bth7.4, w1.Bth7.4 )#5 // end mux2x1 Bth7.4 end netlist // mux2x1 Bth7.5( PP_7_5, GND, GND, b7 ) inv(b7_n.Bth7.5, b7 )#5 and2(w0.Bth7.5, b7_n.Bth7.5, GND )#5 and2(w1.Bth7.5, b7, GND )#5 or2(PP_7_5, w0.Bth7.5, w1.Bth7.5 )#5 // end mux2x1 Bth7.5 end netlist // mux2x1 Bth7.6( PP_7_6, GND, GND, b7 ) inv(b7_n.Bth7.6, b7 )#5 and2(w0.Bth7.6, b7_n.Bth7.6, GND )#5 and2(w1.Bth7.6, b7, GND )#5 or2(PP_7_6, w0.Bth7.6, w1.Bth7.6 )#5 // end mux2x1 Bth7.6 end netlist // mux2x1 Bth7.7( PP_7_7, GND, a0, b7 ) inv(b7_n.Bth7.7, b7 )#5 and2(w0.Bth7.7, b7_n.Bth7.7, GND )#5 and2(w1.Bth7.7, b7, a0 )#5 or2(PP_7_7, w0.Bth7.7, w1.Bth7.7 )#5 // end mux2x1 Bth7.7 end netlist // mux2x1 Bth7.8( PP_7_8, GND, a1, b7 ) inv(b7_n.Bth7.8, b7 )#5 and2(w0.Bth7.8, b7_n.Bth7.8, GND )#5 and2(w1.Bth7.8, b7, a1 )#5 or2(PP_7_8, w0.Bth7.8, w1.Bth7.8 )#5 // end mux2x1 Bth7.8 end netlist // mux2x1 Bth7.9( PP_7_9, GND, a2, b7 ) inv(b7_n.Bth7.9, b7 )#5 and2(w0.Bth7.9, b7_n.Bth7.9, GND )#5 and2(w1.Bth7.9, b7, a2 )#5 or2(PP_7_9, w0.Bth7.9, w1.Bth7.9 )#5 // end mux2x1 Bth7.9 end netlist // mux2x1 Bth7.10( PP_7_10, GND, a3, b7 ) inv(b7_n.Bth7.10, b7 )#5 and2(w0.Bth7.10, b7_n.Bth7.10, GND )#5 and2(w1.Bth7.10, b7, a3 )#5 or2(PP_7_10, w0.Bth7.10, w1.Bth7.10 )#5 // end mux2x1 Bth7.10 end netlist // mux2x1 Bth7.11( PP_7_11, GND, a4, b7 ) inv(b7_n.Bth7.11, b7 )#5 and2(w0.Bth7.11, b7_n.Bth7.11, GND )#5 and2(w1.Bth7.11, b7, a4 )#5 or2(PP_7_11, w0.Bth7.11, w1.Bth7.11 )#5 // end mux2x1 Bth7.11 end netlist // mux2x1 Bth7.12( PP_7_12, GND, a5, b7 ) inv(b7_n.Bth7.12, b7 )#5 and2(w0.Bth7.12, b7_n.Bth7.12, GND )#5 and2(w1.Bth7.12, b7, a5 )#5 or2(PP_7_12, w0.Bth7.12, w1.Bth7.12 )#5 // end mux2x1 Bth7.12 end netlist // mux2x1 Bth7.13( PP_7_13, GND, a6, b7 ) inv(b7_n.Bth7.13, b7 )#5 and2(w0.Bth7.13, b7_n.Bth7.13, GND )#5 and2(w1.Bth7.13, b7, a6 )#5 or2(PP_7_13, w0.Bth7.13, w1.Bth7.13 )#5 // end mux2x1 Bth7.13 end netlist // mux2x1 Bth7.14( PP_7_14, GND, a7, b7 ) inv(b7_n.Bth7.14, b7 )#5 and2(w0.Bth7.14, b7_n.Bth7.14, GND )#5 and2(w1.Bth7.14, b7, a7 )#5 or2(PP_7_14, w0.Bth7.14, w1.Bth7.14 )#5 // end mux2x1 Bth7.14 end netlist // mux2x1 Bth7.15( PP_7_15, GND, a8, b7 ) inv(b7_n.Bth7.15, b7 )#5 and2(w0.Bth7.15, b7_n.Bth7.15, GND )#5 and2(w1.Bth7.15, b7, a8 )#5 or2(PP_7_15, w0.Bth7.15, w1.Bth7.15 )#5 // end mux2x1 Bth7.15 end netlist // mux2x1 Bth7.16( PP_7_16, GND, a9, b7 ) inv(b7_n.Bth7.16, b7 )#5 and2(w0.Bth7.16, b7_n.Bth7.16, GND )#5 and2(w1.Bth7.16, b7, a9 )#5 or2(PP_7_16, w0.Bth7.16, w1.Bth7.16 )#5 // end mux2x1 Bth7.16 end netlist // mux2x1 Bth7.17( PP_7_17, GND, GND, b7 ) inv(b7_n.Bth7.17, b7 )#5 and2(w0.Bth7.17, b7_n.Bth7.17, GND )#5 and2(w1.Bth7.17, b7, GND )#5 or2(PP_7_17, w0.Bth7.17, w1.Bth7.17 )#5 // end mux2x1 Bth7.17 end netlist // mux2x1 Bth7.18( PP_7_18, GND, GND, b7 ) inv(b7_n.Bth7.18, b7 )#5 and2(w0.Bth7.18, b7_n.Bth7.18, GND )#5 and2(w1.Bth7.18, b7, GND )#5 or2(PP_7_18, w0.Bth7.18, w1.Bth7.18 )#5 // end mux2x1 Bth7.18 end netlist // mux2x1 Bth7.19( PP_7_19, GND, GND, b7 ) inv(b7_n.Bth7.19, b7 )#5 and2(w0.Bth7.19, b7_n.Bth7.19, GND )#5 and2(w1.Bth7.19, b7, GND )#5 or2(PP_7_19, w0.Bth7.19, w1.Bth7.19 )#5 // end mux2x1 Bth7.19 end netlist // mux2x1 Bth8.0( PP_8_0, GND, GND, b8 ) inv(b8_n.Bth8.0, b8 )#5 and2(w0.Bth8.0, b8_n.Bth8.0, GND )#5 and2(w1.Bth8.0, b8, GND )#5 or2(PP_8_0, w0.Bth8.0, w1.Bth8.0 )#5 // end mux2x1 Bth8.0 end netlist // mux2x1 Bth8.1( PP_8_1, GND, GND, b8 ) inv(b8_n.Bth8.1, b8 )#5 and2(w0.Bth8.1, b8_n.Bth8.1, GND )#5 and2(w1.Bth8.1, b8, GND )#5 or2(PP_8_1, w0.Bth8.1, w1.Bth8.1 )#5 // end mux2x1 Bth8.1 end netlist // mux2x1 Bth8.2( PP_8_2, GND, GND, b8 ) inv(b8_n.Bth8.2, b8 )#5 and2(w0.Bth8.2, b8_n.Bth8.2, GND )#5 and2(w1.Bth8.2, b8, GND )#5 or2(PP_8_2, w0.Bth8.2, w1.Bth8.2 )#5 // end mux2x1 Bth8.2 end netlist // mux2x1 Bth8.3( PP_8_3, GND, GND, b8 ) inv(b8_n.Bth8.3, b8 )#5 and2(w0.Bth8.3, b8_n.Bth8.3, GND )#5 and2(w1.Bth8.3, b8, GND )#5 or2(PP_8_3, w0.Bth8.3, w1.Bth8.3 )#5 // end mux2x1 Bth8.3 end netlist // mux2x1 Bth8.4( PP_8_4, GND, GND, b8 ) inv(b8_n.Bth8.4, b8 )#5 and2(w0.Bth8.4, b8_n.Bth8.4, GND )#5 and2(w1.Bth8.4, b8, GND )#5 or2(PP_8_4, w0.Bth8.4, w1.Bth8.4 )#5 // end mux2x1 Bth8.4 end netlist // mux2x1 Bth8.5( PP_8_5, GND, GND, b8 ) inv(b8_n.Bth8.5, b8 )#5 and2(w0.Bth8.5, b8_n.Bth8.5, GND )#5 and2(w1.Bth8.5, b8, GND )#5 or2(PP_8_5, w0.Bth8.5, w1.Bth8.5 )#5 // end mux2x1 Bth8.5 end netlist // mux2x1 Bth8.6( PP_8_6, GND, GND, b8 ) inv(b8_n.Bth8.6, b8 )#5 and2(w0.Bth8.6, b8_n.Bth8.6, GND )#5 and2(w1.Bth8.6, b8, GND )#5 or2(PP_8_6, w0.Bth8.6, w1.Bth8.6 )#5 // end mux2x1 Bth8.6 end netlist // mux2x1 Bth8.7( PP_8_7, GND, GND, b8 ) inv(b8_n.Bth8.7, b8 )#5 and2(w0.Bth8.7, b8_n.Bth8.7, GND )#5 and2(w1.Bth8.7, b8, GND )#5 or2(PP_8_7, w0.Bth8.7, w1.Bth8.7 )#5 // end mux2x1 Bth8.7 end netlist // mux2x1 Bth8.8( PP_8_8, GND, a0, b8 ) inv(b8_n.Bth8.8, b8 )#5 and2(w0.Bth8.8, b8_n.Bth8.8, GND )#5 and2(w1.Bth8.8, b8, a0 )#5 or2(PP_8_8, w0.Bth8.8, w1.Bth8.8 )#5 // end mux2x1 Bth8.8 end netlist // mux2x1 Bth8.9( PP_8_9, GND, a1, b8 ) inv(b8_n.Bth8.9, b8 )#5 and2(w0.Bth8.9, b8_n.Bth8.9, GND )#5 and2(w1.Bth8.9, b8, a1 )#5 or2(PP_8_9, w0.Bth8.9, w1.Bth8.9 )#5 // end mux2x1 Bth8.9 end netlist // mux2x1 Bth8.10( PP_8_10, GND, a2, b8 ) inv(b8_n.Bth8.10, b8 )#5 and2(w0.Bth8.10, b8_n.Bth8.10, GND )#5 and2(w1.Bth8.10, b8, a2 )#5 or2(PP_8_10, w0.Bth8.10, w1.Bth8.10 )#5 // end mux2x1 Bth8.10 end netlist // mux2x1 Bth8.11( PP_8_11, GND, a3, b8 ) inv(b8_n.Bth8.11, b8 )#5 and2(w0.Bth8.11, b8_n.Bth8.11, GND )#5 and2(w1.Bth8.11, b8, a3 )#5 or2(PP_8_11, w0.Bth8.11, w1.Bth8.11 )#5 // end mux2x1 Bth8.11 end netlist // mux2x1 Bth8.12( PP_8_12, GND, a4, b8 ) inv(b8_n.Bth8.12, b8 )#5 and2(w0.Bth8.12, b8_n.Bth8.12, GND )#5 and2(w1.Bth8.12, b8, a4 )#5 or2(PP_8_12, w0.Bth8.12, w1.Bth8.12 )#5 // end mux2x1 Bth8.12 end netlist // mux2x1 Bth8.13( PP_8_13, GND, a5, b8 ) inv(b8_n.Bth8.13, b8 )#5 and2(w0.Bth8.13, b8_n.Bth8.13, GND )#5 and2(w1.Bth8.13, b8, a5 )#5 or2(PP_8_13, w0.Bth8.13, w1.Bth8.13 )#5 // end mux2x1 Bth8.13 end netlist // mux2x1 Bth8.14( PP_8_14, GND, a6, b8 ) inv(b8_n.Bth8.14, b8 )#5 and2(w0.Bth8.14, b8_n.Bth8.14, GND )#5 and2(w1.Bth8.14, b8, a6 )#5 or2(PP_8_14, w0.Bth8.14, w1.Bth8.14 )#5 // end mux2x1 Bth8.14 end netlist // mux2x1 Bth8.15( PP_8_15, GND, a7, b8 ) inv(b8_n.Bth8.15, b8 )#5 and2(w0.Bth8.15, b8_n.Bth8.15, GND )#5 and2(w1.Bth8.15, b8, a7 )#5 or2(PP_8_15, w0.Bth8.15, w1.Bth8.15 )#5 // end mux2x1 Bth8.15 end netlist // mux2x1 Bth8.16( PP_8_16, GND, a8, b8 ) inv(b8_n.Bth8.16, b8 )#5 and2(w0.Bth8.16, b8_n.Bth8.16, GND )#5 and2(w1.Bth8.16, b8, a8 )#5 or2(PP_8_16, w0.Bth8.16, w1.Bth8.16 )#5 // end mux2x1 Bth8.16 end netlist // mux2x1 Bth8.17( PP_8_17, GND, a9, b8 ) inv(b8_n.Bth8.17, b8 )#5 and2(w0.Bth8.17, b8_n.Bth8.17, GND )#5 and2(w1.Bth8.17, b8, a9 )#5 or2(PP_8_17, w0.Bth8.17, w1.Bth8.17 )#5 // end mux2x1 Bth8.17 end netlist // mux2x1 Bth8.18( PP_8_18, GND, GND, b8 ) inv(b8_n.Bth8.18, b8 )#5 and2(w0.Bth8.18, b8_n.Bth8.18, GND )#5 and2(w1.Bth8.18, b8, GND )#5 or2(PP_8_18, w0.Bth8.18, w1.Bth8.18 )#5 // end mux2x1 Bth8.18 end netlist // mux2x1 Bth8.19( PP_8_19, GND, GND, b8 ) inv(b8_n.Bth8.19, b8 )#5 and2(w0.Bth8.19, b8_n.Bth8.19, GND )#5 and2(w1.Bth8.19, b8, GND )#5 or2(PP_8_19, w0.Bth8.19, w1.Bth8.19 )#5 // end mux2x1 Bth8.19 end netlist // mux2x1 Bth9.0( PP_9_0, GND, GND, b9 ) inv(b9_n.Bth9.0, b9 )#5 and2(w0.Bth9.0, b9_n.Bth9.0, GND )#5 and2(w1.Bth9.0, b9, GND )#5 or2(PP_9_0, w0.Bth9.0, w1.Bth9.0 )#5 // end mux2x1 Bth9.0 end netlist // mux2x1 Bth9.1( PP_9_1, GND, GND, b9 ) inv(b9_n.Bth9.1, b9 )#5 and2(w0.Bth9.1, b9_n.Bth9.1, GND )#5 and2(w1.Bth9.1, b9, GND )#5 or2(PP_9_1, w0.Bth9.1, w1.Bth9.1 )#5 // end mux2x1 Bth9.1 end netlist // mux2x1 Bth9.2( PP_9_2, GND, GND, b9 ) inv(b9_n.Bth9.2, b9 )#5 and2(w0.Bth9.2, b9_n.Bth9.2, GND )#5 and2(w1.Bth9.2, b9, GND )#5 or2(PP_9_2, w0.Bth9.2, w1.Bth9.2 )#5 // end mux2x1 Bth9.2 end netlist // mux2x1 Bth9.3( PP_9_3, GND, GND, b9 ) inv(b9_n.Bth9.3, b9 )#5 and2(w0.Bth9.3, b9_n.Bth9.3, GND )#5 and2(w1.Bth9.3, b9, GND )#5 or2(PP_9_3, w0.Bth9.3, w1.Bth9.3 )#5 // end mux2x1 Bth9.3 end netlist // mux2x1 Bth9.4( PP_9_4, GND, GND, b9 ) inv(b9_n.Bth9.4, b9 )#5 and2(w0.Bth9.4, b9_n.Bth9.4, GND )#5 and2(w1.Bth9.4, b9, GND )#5 or2(PP_9_4, w0.Bth9.4, w1.Bth9.4 )#5 // end mux2x1 Bth9.4 end netlist // mux2x1 Bth9.5( PP_9_5, GND, GND, b9 ) inv(b9_n.Bth9.5, b9 )#5 and2(w0.Bth9.5, b9_n.Bth9.5, GND )#5 and2(w1.Bth9.5, b9, GND )#5 or2(PP_9_5, w0.Bth9.5, w1.Bth9.5 )#5 // end mux2x1 Bth9.5 end netlist // mux2x1 Bth9.6( PP_9_6, GND, GND, b9 ) inv(b9_n.Bth9.6, b9 )#5 and2(w0.Bth9.6, b9_n.Bth9.6, GND )#5 and2(w1.Bth9.6, b9, GND )#5 or2(PP_9_6, w0.Bth9.6, w1.Bth9.6 )#5 // end mux2x1 Bth9.6 end netlist // mux2x1 Bth9.7( PP_9_7, GND, GND, b9 ) inv(b9_n.Bth9.7, b9 )#5 and2(w0.Bth9.7, b9_n.Bth9.7, GND )#5 and2(w1.Bth9.7, b9, GND )#5 or2(PP_9_7, w0.Bth9.7, w1.Bth9.7 )#5 // end mux2x1 Bth9.7 end netlist // mux2x1 Bth9.8( PP_9_8, GND, GND, b9 ) inv(b9_n.Bth9.8, b9 )#5 and2(w0.Bth9.8, b9_n.Bth9.8, GND )#5 and2(w1.Bth9.8, b9, GND )#5 or2(PP_9_8, w0.Bth9.8, w1.Bth9.8 )#5 // end mux2x1 Bth9.8 end netlist // mux2x1 Bth9.9( PP_9_9, GND, a0, b9 ) inv(b9_n.Bth9.9, b9 )#5 and2(w0.Bth9.9, b9_n.Bth9.9, GND )#5 and2(w1.Bth9.9, b9, a0 )#5 or2(PP_9_9, w0.Bth9.9, w1.Bth9.9 )#5 // end mux2x1 Bth9.9 end netlist // mux2x1 Bth9.10( PP_9_10, GND, a1, b9 ) inv(b9_n.Bth9.10, b9 )#5 and2(w0.Bth9.10, b9_n.Bth9.10, GND )#5 and2(w1.Bth9.10, b9, a1 )#5 or2(PP_9_10, w0.Bth9.10, w1.Bth9.10 )#5 // end mux2x1 Bth9.10 end netlist // mux2x1 Bth9.11( PP_9_11, GND, a2, b9 ) inv(b9_n.Bth9.11, b9 )#5 and2(w0.Bth9.11, b9_n.Bth9.11, GND )#5 and2(w1.Bth9.11, b9, a2 )#5 or2(PP_9_11, w0.Bth9.11, w1.Bth9.11 )#5 // end mux2x1 Bth9.11 end netlist // mux2x1 Bth9.12( PP_9_12, GND, a3, b9 ) inv(b9_n.Bth9.12, b9 )#5 and2(w0.Bth9.12, b9_n.Bth9.12, GND )#5 and2(w1.Bth9.12, b9, a3 )#5 or2(PP_9_12, w0.Bth9.12, w1.Bth9.12 )#5 // end mux2x1 Bth9.12 end netlist // mux2x1 Bth9.13( PP_9_13, GND, a4, b9 ) inv(b9_n.Bth9.13, b9 )#5 and2(w0.Bth9.13, b9_n.Bth9.13, GND )#5 and2(w1.Bth9.13, b9, a4 )#5 or2(PP_9_13, w0.Bth9.13, w1.Bth9.13 )#5 // end mux2x1 Bth9.13 end netlist // mux2x1 Bth9.14( PP_9_14, GND, a5, b9 ) inv(b9_n.Bth9.14, b9 )#5 and2(w0.Bth9.14, b9_n.Bth9.14, GND )#5 and2(w1.Bth9.14, b9, a5 )#5 or2(PP_9_14, w0.Bth9.14, w1.Bth9.14 )#5 // end mux2x1 Bth9.14 end netlist // mux2x1 Bth9.15( PP_9_15, GND, a6, b9 ) inv(b9_n.Bth9.15, b9 )#5 and2(w0.Bth9.15, b9_n.Bth9.15, GND )#5 and2(w1.Bth9.15, b9, a6 )#5 or2(PP_9_15, w0.Bth9.15, w1.Bth9.15 )#5 // end mux2x1 Bth9.15 end netlist // mux2x1 Bth9.16( PP_9_16, GND, a7, b9 ) inv(b9_n.Bth9.16, b9 )#5 and2(w0.Bth9.16, b9_n.Bth9.16, GND )#5 and2(w1.Bth9.16, b9, a7 )#5 or2(PP_9_16, w0.Bth9.16, w1.Bth9.16 )#5 // end mux2x1 Bth9.16 end netlist // mux2x1 Bth9.17( PP_9_17, GND, a8, b9 ) inv(b9_n.Bth9.17, b9 )#5 and2(w0.Bth9.17, b9_n.Bth9.17, GND )#5 and2(w1.Bth9.17, b9, a8 )#5 or2(PP_9_17, w0.Bth9.17, w1.Bth9.17 )#5 // end mux2x1 Bth9.17 end netlist // mux2x1 Bth9.18( PP_9_18, GND, a9, b9 ) inv(b9_n.Bth9.18, b9 )#5 and2(w0.Bth9.18, b9_n.Bth9.18, GND )#5 and2(w1.Bth9.18, b9, a9 )#5 or2(PP_9_18, w0.Bth9.18, w1.Bth9.18 )#5 // end mux2x1 Bth9.18 end netlist // mux2x1 Bth9.19( PP_9_19, GND, GND, b9 ) inv(b9_n.Bth9.19, b9 )#5 and2(w0.Bth9.19, b9_n.Bth9.19, GND )#5 and2(w1.Bth9.19, b9, GND )#5 or2(PP_9_19, w0.Bth9.19, w1.Bth9.19 )#5 // end mux2x1 Bth9.19 end // instantiating csa4x2Vec at lvl 0 netlist // csa4x2 (csa4x2_0_lvl0.0, s0_lvl0_0,t0_lvl0_0,cout_csa4x2_0_lvl0.0,PP_0_0,PP_1_0,PP_2_0,PP_3_0,GND) ; // adder1bit Adder0.csa4x2_0_lvl0.0( sintcsa4x2_0_lvl0.0, cout_csa4x2_0_lvl0.0, PP_0_0, PP_1_0, PP_2_0) // sum xor2( w0.Adder0.csa4x2_0_lvl0.0, PP_0_0, PP_1_0 )#5 xor2( sintcsa4x2_0_lvl0.0, w0.Adder0.csa4x2_0_lvl0.0, PP_2_0 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.0, PP_0_0, PP_1_0 )#5 and2( w2.Adder0.csa4x2_0_lvl0.0, w0.Adder0.csa4x2_0_lvl0.0, PP_2_0 )#5 or2( cout_csa4x2_0_lvl0.0, w1.Adder0.csa4x2_0_lvl0.0, w2.Adder0.csa4x2_0_lvl0.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.0( s0_lvl0_0, t0_lvl0_0, sintcsa4x2_0_lvl0.0, PP_3_0, GND) // sum xor2( w0.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, PP_3_0 )#5 xor2( s0_lvl0_0, w0.Adder1.csa4x2_0_lvl0.0, GND )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.0, sintcsa4x2_0_lvl0.0, PP_3_0 )#5 and2( w2.Adder1.csa4x2_0_lvl0.0, w0.Adder1.csa4x2_0_lvl0.0, GND )#5 or2( t0_lvl0_0, w1.Adder1.csa4x2_0_lvl0.0, w2.Adder1.csa4x2_0_lvl0.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.1, s0_lvl0_1,t0_lvl0_1,cout_csa4x2_0_lvl0.1,PP_0_1,PP_1_1,PP_2_1,PP_3_1,cout_csa4x2_0_lvl0.0) ; // adder1bit Adder0.csa4x2_0_lvl0.1( sintcsa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.1, PP_0_1, PP_1_1, PP_2_1) // sum xor2( w0.Adder0.csa4x2_0_lvl0.1, PP_0_1, PP_1_1 )#5 xor2( sintcsa4x2_0_lvl0.1, w0.Adder0.csa4x2_0_lvl0.1, PP_2_1 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.1, PP_0_1, PP_1_1 )#5 and2( w2.Adder0.csa4x2_0_lvl0.1, w0.Adder0.csa4x2_0_lvl0.1, PP_2_1 )#5 or2( cout_csa4x2_0_lvl0.1, w1.Adder0.csa4x2_0_lvl0.1, w2.Adder0.csa4x2_0_lvl0.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.1( s0_lvl0_1, t0_lvl0_1, sintcsa4x2_0_lvl0.1, PP_3_1, cout_csa4x2_0_lvl0.0) // sum xor2( w0.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, PP_3_1 )#5 xor2( s0_lvl0_1, w0.Adder1.csa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.1, sintcsa4x2_0_lvl0.1, PP_3_1 )#5 and2( w2.Adder1.csa4x2_0_lvl0.1, w0.Adder1.csa4x2_0_lvl0.1, cout_csa4x2_0_lvl0.0 )#5 or2( t0_lvl0_1, w1.Adder1.csa4x2_0_lvl0.1, w2.Adder1.csa4x2_0_lvl0.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.2, s0_lvl0_2,t0_lvl0_2,cout_csa4x2_0_lvl0.2,PP_0_2,PP_1_2,PP_2_2,PP_3_2,cout_csa4x2_0_lvl0.1) ; // adder1bit Adder0.csa4x2_0_lvl0.2( sintcsa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.2, PP_0_2, PP_1_2, PP_2_2) // sum xor2( w0.Adder0.csa4x2_0_lvl0.2, PP_0_2, PP_1_2 )#5 xor2( sintcsa4x2_0_lvl0.2, w0.Adder0.csa4x2_0_lvl0.2, PP_2_2 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.2, PP_0_2, PP_1_2 )#5 and2( w2.Adder0.csa4x2_0_lvl0.2, w0.Adder0.csa4x2_0_lvl0.2, PP_2_2 )#5 or2( cout_csa4x2_0_lvl0.2, w1.Adder0.csa4x2_0_lvl0.2, w2.Adder0.csa4x2_0_lvl0.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.2( s0_lvl0_2, t0_lvl0_2, sintcsa4x2_0_lvl0.2, PP_3_2, cout_csa4x2_0_lvl0.1) // sum xor2( w0.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, PP_3_2 )#5 xor2( s0_lvl0_2, w0.Adder1.csa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.2, sintcsa4x2_0_lvl0.2, PP_3_2 )#5 and2( w2.Adder1.csa4x2_0_lvl0.2, w0.Adder1.csa4x2_0_lvl0.2, cout_csa4x2_0_lvl0.1 )#5 or2( t0_lvl0_2, w1.Adder1.csa4x2_0_lvl0.2, w2.Adder1.csa4x2_0_lvl0.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.3, s0_lvl0_3,t0_lvl0_3,cout_csa4x2_0_lvl0.3,PP_0_3,PP_1_3,PP_2_3,PP_3_3,cout_csa4x2_0_lvl0.2) ; // adder1bit Adder0.csa4x2_0_lvl0.3( sintcsa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.3, PP_0_3, PP_1_3, PP_2_3) // sum xor2( w0.Adder0.csa4x2_0_lvl0.3, PP_0_3, PP_1_3 )#5 xor2( sintcsa4x2_0_lvl0.3, w0.Adder0.csa4x2_0_lvl0.3, PP_2_3 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.3, PP_0_3, PP_1_3 )#5 and2( w2.Adder0.csa4x2_0_lvl0.3, w0.Adder0.csa4x2_0_lvl0.3, PP_2_3 )#5 or2( cout_csa4x2_0_lvl0.3, w1.Adder0.csa4x2_0_lvl0.3, w2.Adder0.csa4x2_0_lvl0.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.3( s0_lvl0_3, t0_lvl0_3, sintcsa4x2_0_lvl0.3, PP_3_3, cout_csa4x2_0_lvl0.2) // sum xor2( w0.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, PP_3_3 )#5 xor2( s0_lvl0_3, w0.Adder1.csa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.3, sintcsa4x2_0_lvl0.3, PP_3_3 )#5 and2( w2.Adder1.csa4x2_0_lvl0.3, w0.Adder1.csa4x2_0_lvl0.3, cout_csa4x2_0_lvl0.2 )#5 or2( t0_lvl0_3, w1.Adder1.csa4x2_0_lvl0.3, w2.Adder1.csa4x2_0_lvl0.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.4, s0_lvl0_4,t0_lvl0_4,cout_csa4x2_0_lvl0.4,PP_0_4,PP_1_4,PP_2_4,PP_3_4,cout_csa4x2_0_lvl0.3) ; // adder1bit Adder0.csa4x2_0_lvl0.4( sintcsa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.4, PP_0_4, PP_1_4, PP_2_4) // sum xor2( w0.Adder0.csa4x2_0_lvl0.4, PP_0_4, PP_1_4 )#5 xor2( sintcsa4x2_0_lvl0.4, w0.Adder0.csa4x2_0_lvl0.4, PP_2_4 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.4, PP_0_4, PP_1_4 )#5 and2( w2.Adder0.csa4x2_0_lvl0.4, w0.Adder0.csa4x2_0_lvl0.4, PP_2_4 )#5 or2( cout_csa4x2_0_lvl0.4, w1.Adder0.csa4x2_0_lvl0.4, w2.Adder0.csa4x2_0_lvl0.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.4( s0_lvl0_4, t0_lvl0_4, sintcsa4x2_0_lvl0.4, PP_3_4, cout_csa4x2_0_lvl0.3) // sum xor2( w0.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, PP_3_4 )#5 xor2( s0_lvl0_4, w0.Adder1.csa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.4, sintcsa4x2_0_lvl0.4, PP_3_4 )#5 and2( w2.Adder1.csa4x2_0_lvl0.4, w0.Adder1.csa4x2_0_lvl0.4, cout_csa4x2_0_lvl0.3 )#5 or2( t0_lvl0_4, w1.Adder1.csa4x2_0_lvl0.4, w2.Adder1.csa4x2_0_lvl0.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.5, s0_lvl0_5,t0_lvl0_5,cout_csa4x2_0_lvl0.5,PP_0_5,PP_1_5,PP_2_5,PP_3_5,cout_csa4x2_0_lvl0.4) ; // adder1bit Adder0.csa4x2_0_lvl0.5( sintcsa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.5, PP_0_5, PP_1_5, PP_2_5) // sum xor2( w0.Adder0.csa4x2_0_lvl0.5, PP_0_5, PP_1_5 )#5 xor2( sintcsa4x2_0_lvl0.5, w0.Adder0.csa4x2_0_lvl0.5, PP_2_5 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.5, PP_0_5, PP_1_5 )#5 and2( w2.Adder0.csa4x2_0_lvl0.5, w0.Adder0.csa4x2_0_lvl0.5, PP_2_5 )#5 or2( cout_csa4x2_0_lvl0.5, w1.Adder0.csa4x2_0_lvl0.5, w2.Adder0.csa4x2_0_lvl0.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.5( s0_lvl0_5, t0_lvl0_5, sintcsa4x2_0_lvl0.5, PP_3_5, cout_csa4x2_0_lvl0.4) // sum xor2( w0.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, PP_3_5 )#5 xor2( s0_lvl0_5, w0.Adder1.csa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.5, sintcsa4x2_0_lvl0.5, PP_3_5 )#5 and2( w2.Adder1.csa4x2_0_lvl0.5, w0.Adder1.csa4x2_0_lvl0.5, cout_csa4x2_0_lvl0.4 )#5 or2( t0_lvl0_5, w1.Adder1.csa4x2_0_lvl0.5, w2.Adder1.csa4x2_0_lvl0.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.6, s0_lvl0_6,t0_lvl0_6,cout_csa4x2_0_lvl0.6,PP_0_6,PP_1_6,PP_2_6,PP_3_6,cout_csa4x2_0_lvl0.5) ; // adder1bit Adder0.csa4x2_0_lvl0.6( sintcsa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.6, PP_0_6, PP_1_6, PP_2_6) // sum xor2( w0.Adder0.csa4x2_0_lvl0.6, PP_0_6, PP_1_6 )#5 xor2( sintcsa4x2_0_lvl0.6, w0.Adder0.csa4x2_0_lvl0.6, PP_2_6 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.6, PP_0_6, PP_1_6 )#5 and2( w2.Adder0.csa4x2_0_lvl0.6, w0.Adder0.csa4x2_0_lvl0.6, PP_2_6 )#5 or2( cout_csa4x2_0_lvl0.6, w1.Adder0.csa4x2_0_lvl0.6, w2.Adder0.csa4x2_0_lvl0.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.6( s0_lvl0_6, t0_lvl0_6, sintcsa4x2_0_lvl0.6, PP_3_6, cout_csa4x2_0_lvl0.5) // sum xor2( w0.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, PP_3_6 )#5 xor2( s0_lvl0_6, w0.Adder1.csa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.6, sintcsa4x2_0_lvl0.6, PP_3_6 )#5 and2( w2.Adder1.csa4x2_0_lvl0.6, w0.Adder1.csa4x2_0_lvl0.6, cout_csa4x2_0_lvl0.5 )#5 or2( t0_lvl0_6, w1.Adder1.csa4x2_0_lvl0.6, w2.Adder1.csa4x2_0_lvl0.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.7, s0_lvl0_7,t0_lvl0_7,cout_csa4x2_0_lvl0.7,PP_0_7,PP_1_7,PP_2_7,PP_3_7,cout_csa4x2_0_lvl0.6) ; // adder1bit Adder0.csa4x2_0_lvl0.7( sintcsa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.7, PP_0_7, PP_1_7, PP_2_7) // sum xor2( w0.Adder0.csa4x2_0_lvl0.7, PP_0_7, PP_1_7 )#5 xor2( sintcsa4x2_0_lvl0.7, w0.Adder0.csa4x2_0_lvl0.7, PP_2_7 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.7, PP_0_7, PP_1_7 )#5 and2( w2.Adder0.csa4x2_0_lvl0.7, w0.Adder0.csa4x2_0_lvl0.7, PP_2_7 )#5 or2( cout_csa4x2_0_lvl0.7, w1.Adder0.csa4x2_0_lvl0.7, w2.Adder0.csa4x2_0_lvl0.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.7( s0_lvl0_7, t0_lvl0_7, sintcsa4x2_0_lvl0.7, PP_3_7, cout_csa4x2_0_lvl0.6) // sum xor2( w0.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, PP_3_7 )#5 xor2( s0_lvl0_7, w0.Adder1.csa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.7, sintcsa4x2_0_lvl0.7, PP_3_7 )#5 and2( w2.Adder1.csa4x2_0_lvl0.7, w0.Adder1.csa4x2_0_lvl0.7, cout_csa4x2_0_lvl0.6 )#5 or2( t0_lvl0_7, w1.Adder1.csa4x2_0_lvl0.7, w2.Adder1.csa4x2_0_lvl0.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.8, s0_lvl0_8,t0_lvl0_8,cout_csa4x2_0_lvl0.8,PP_0_8,PP_1_8,PP_2_8,PP_3_8,cout_csa4x2_0_lvl0.7) ; // adder1bit Adder0.csa4x2_0_lvl0.8( sintcsa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.8, PP_0_8, PP_1_8, PP_2_8) // sum xor2( w0.Adder0.csa4x2_0_lvl0.8, PP_0_8, PP_1_8 )#5 xor2( sintcsa4x2_0_lvl0.8, w0.Adder0.csa4x2_0_lvl0.8, PP_2_8 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.8, PP_0_8, PP_1_8 )#5 and2( w2.Adder0.csa4x2_0_lvl0.8, w0.Adder0.csa4x2_0_lvl0.8, PP_2_8 )#5 or2( cout_csa4x2_0_lvl0.8, w1.Adder0.csa4x2_0_lvl0.8, w2.Adder0.csa4x2_0_lvl0.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.8( s0_lvl0_8, t0_lvl0_8, sintcsa4x2_0_lvl0.8, PP_3_8, cout_csa4x2_0_lvl0.7) // sum xor2( w0.Adder1.csa4x2_0_lvl0.8, sintcsa4x2_0_lvl0.8, PP_3_8 )#5 xor2( s0_lvl0_8, w0.Adder1.csa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.7 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.8, sintcsa4x2_0_lvl0.8, PP_3_8 )#5 and2( w2.Adder1.csa4x2_0_lvl0.8, w0.Adder1.csa4x2_0_lvl0.8, cout_csa4x2_0_lvl0.7 )#5 or2( t0_lvl0_8, w1.Adder1.csa4x2_0_lvl0.8, w2.Adder1.csa4x2_0_lvl0.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.9, s0_lvl0_9,t0_lvl0_9,cout_csa4x2_0_lvl0.9,PP_0_9,PP_1_9,PP_2_9,PP_3_9,cout_csa4x2_0_lvl0.8) ; // adder1bit Adder0.csa4x2_0_lvl0.9( sintcsa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.9, PP_0_9, PP_1_9, PP_2_9) // sum xor2( w0.Adder0.csa4x2_0_lvl0.9, PP_0_9, PP_1_9 )#5 xor2( sintcsa4x2_0_lvl0.9, w0.Adder0.csa4x2_0_lvl0.9, PP_2_9 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.9, PP_0_9, PP_1_9 )#5 and2( w2.Adder0.csa4x2_0_lvl0.9, w0.Adder0.csa4x2_0_lvl0.9, PP_2_9 )#5 or2( cout_csa4x2_0_lvl0.9, w1.Adder0.csa4x2_0_lvl0.9, w2.Adder0.csa4x2_0_lvl0.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.9( s0_lvl0_9, t0_lvl0_9, sintcsa4x2_0_lvl0.9, PP_3_9, cout_csa4x2_0_lvl0.8) // sum xor2( w0.Adder1.csa4x2_0_lvl0.9, sintcsa4x2_0_lvl0.9, PP_3_9 )#5 xor2( s0_lvl0_9, w0.Adder1.csa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.8 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.9, sintcsa4x2_0_lvl0.9, PP_3_9 )#5 and2( w2.Adder1.csa4x2_0_lvl0.9, w0.Adder1.csa4x2_0_lvl0.9, cout_csa4x2_0_lvl0.8 )#5 or2( t0_lvl0_9, w1.Adder1.csa4x2_0_lvl0.9, w2.Adder1.csa4x2_0_lvl0.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.10, s0_lvl0_10,t0_lvl0_10,cout_csa4x2_0_lvl0.10,PP_0_10,PP_1_10,PP_2_10,PP_3_10,cout_csa4x2_0_lvl0.9) ; // adder1bit Adder0.csa4x2_0_lvl0.10( sintcsa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.10, PP_0_10, PP_1_10, PP_2_10) // sum xor2( w0.Adder0.csa4x2_0_lvl0.10, PP_0_10, PP_1_10 )#5 xor2( sintcsa4x2_0_lvl0.10, w0.Adder0.csa4x2_0_lvl0.10, PP_2_10 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.10, PP_0_10, PP_1_10 )#5 and2( w2.Adder0.csa4x2_0_lvl0.10, w0.Adder0.csa4x2_0_lvl0.10, PP_2_10 )#5 or2( cout_csa4x2_0_lvl0.10, w1.Adder0.csa4x2_0_lvl0.10, w2.Adder0.csa4x2_0_lvl0.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.10( s0_lvl0_10, t0_lvl0_10, sintcsa4x2_0_lvl0.10, PP_3_10, cout_csa4x2_0_lvl0.9) // sum xor2( w0.Adder1.csa4x2_0_lvl0.10, sintcsa4x2_0_lvl0.10, PP_3_10 )#5 xor2( s0_lvl0_10, w0.Adder1.csa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.9 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.10, sintcsa4x2_0_lvl0.10, PP_3_10 )#5 and2( w2.Adder1.csa4x2_0_lvl0.10, w0.Adder1.csa4x2_0_lvl0.10, cout_csa4x2_0_lvl0.9 )#5 or2( t0_lvl0_10, w1.Adder1.csa4x2_0_lvl0.10, w2.Adder1.csa4x2_0_lvl0.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.11, s0_lvl0_11,t0_lvl0_11,cout_csa4x2_0_lvl0.11,PP_0_11,PP_1_11,PP_2_11,PP_3_11,cout_csa4x2_0_lvl0.10) ; // adder1bit Adder0.csa4x2_0_lvl0.11( sintcsa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.11, PP_0_11, PP_1_11, PP_2_11) // sum xor2( w0.Adder0.csa4x2_0_lvl0.11, PP_0_11, PP_1_11 )#5 xor2( sintcsa4x2_0_lvl0.11, w0.Adder0.csa4x2_0_lvl0.11, PP_2_11 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.11, PP_0_11, PP_1_11 )#5 and2( w2.Adder0.csa4x2_0_lvl0.11, w0.Adder0.csa4x2_0_lvl0.11, PP_2_11 )#5 or2( cout_csa4x2_0_lvl0.11, w1.Adder0.csa4x2_0_lvl0.11, w2.Adder0.csa4x2_0_lvl0.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.11( s0_lvl0_11, t0_lvl0_11, sintcsa4x2_0_lvl0.11, PP_3_11, cout_csa4x2_0_lvl0.10) // sum xor2( w0.Adder1.csa4x2_0_lvl0.11, sintcsa4x2_0_lvl0.11, PP_3_11 )#5 xor2( s0_lvl0_11, w0.Adder1.csa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.10 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.11, sintcsa4x2_0_lvl0.11, PP_3_11 )#5 and2( w2.Adder1.csa4x2_0_lvl0.11, w0.Adder1.csa4x2_0_lvl0.11, cout_csa4x2_0_lvl0.10 )#5 or2( t0_lvl0_11, w1.Adder1.csa4x2_0_lvl0.11, w2.Adder1.csa4x2_0_lvl0.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.12, s0_lvl0_12,t0_lvl0_12,cout_csa4x2_0_lvl0.12,PP_0_12,PP_1_12,PP_2_12,PP_3_12,cout_csa4x2_0_lvl0.11) ; // adder1bit Adder0.csa4x2_0_lvl0.12( sintcsa4x2_0_lvl0.12, cout_csa4x2_0_lvl0.12, PP_0_12, PP_1_12, PP_2_12) // sum xor2( w0.Adder0.csa4x2_0_lvl0.12, PP_0_12, PP_1_12 )#5 xor2( sintcsa4x2_0_lvl0.12, w0.Adder0.csa4x2_0_lvl0.12, PP_2_12 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.12, PP_0_12, PP_1_12 )#5 and2( w2.Adder0.csa4x2_0_lvl0.12, w0.Adder0.csa4x2_0_lvl0.12, PP_2_12 )#5 or2( cout_csa4x2_0_lvl0.12, w1.Adder0.csa4x2_0_lvl0.12, w2.Adder0.csa4x2_0_lvl0.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.12( s0_lvl0_12, t0_lvl0_12, sintcsa4x2_0_lvl0.12, PP_3_12, cout_csa4x2_0_lvl0.11) // sum xor2( w0.Adder1.csa4x2_0_lvl0.12, sintcsa4x2_0_lvl0.12, PP_3_12 )#5 xor2( s0_lvl0_12, w0.Adder1.csa4x2_0_lvl0.12, cout_csa4x2_0_lvl0.11 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.12, sintcsa4x2_0_lvl0.12, PP_3_12 )#5 and2( w2.Adder1.csa4x2_0_lvl0.12, w0.Adder1.csa4x2_0_lvl0.12, cout_csa4x2_0_lvl0.11 )#5 or2( t0_lvl0_12, w1.Adder1.csa4x2_0_lvl0.12, w2.Adder1.csa4x2_0_lvl0.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.13, s0_lvl0_13,t0_lvl0_13,cout_csa4x2_0_lvl0.13,PP_0_13,PP_1_13,PP_2_13,PP_3_13,cout_csa4x2_0_lvl0.12) ; // adder1bit Adder0.csa4x2_0_lvl0.13( sintcsa4x2_0_lvl0.13, cout_csa4x2_0_lvl0.13, PP_0_13, PP_1_13, PP_2_13) // sum xor2( w0.Adder0.csa4x2_0_lvl0.13, PP_0_13, PP_1_13 )#5 xor2( sintcsa4x2_0_lvl0.13, w0.Adder0.csa4x2_0_lvl0.13, PP_2_13 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.13, PP_0_13, PP_1_13 )#5 and2( w2.Adder0.csa4x2_0_lvl0.13, w0.Adder0.csa4x2_0_lvl0.13, PP_2_13 )#5 or2( cout_csa4x2_0_lvl0.13, w1.Adder0.csa4x2_0_lvl0.13, w2.Adder0.csa4x2_0_lvl0.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.13( s0_lvl0_13, t0_lvl0_13, sintcsa4x2_0_lvl0.13, PP_3_13, cout_csa4x2_0_lvl0.12) // sum xor2( w0.Adder1.csa4x2_0_lvl0.13, sintcsa4x2_0_lvl0.13, PP_3_13 )#5 xor2( s0_lvl0_13, w0.Adder1.csa4x2_0_lvl0.13, cout_csa4x2_0_lvl0.12 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.13, sintcsa4x2_0_lvl0.13, PP_3_13 )#5 and2( w2.Adder1.csa4x2_0_lvl0.13, w0.Adder1.csa4x2_0_lvl0.13, cout_csa4x2_0_lvl0.12 )#5 or2( t0_lvl0_13, w1.Adder1.csa4x2_0_lvl0.13, w2.Adder1.csa4x2_0_lvl0.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.14, s0_lvl0_14,t0_lvl0_14,cout_csa4x2_0_lvl0.14,PP_0_14,PP_1_14,PP_2_14,PP_3_14,cout_csa4x2_0_lvl0.13) ; // adder1bit Adder0.csa4x2_0_lvl0.14( sintcsa4x2_0_lvl0.14, cout_csa4x2_0_lvl0.14, PP_0_14, PP_1_14, PP_2_14) // sum xor2( w0.Adder0.csa4x2_0_lvl0.14, PP_0_14, PP_1_14 )#5 xor2( sintcsa4x2_0_lvl0.14, w0.Adder0.csa4x2_0_lvl0.14, PP_2_14 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.14, PP_0_14, PP_1_14 )#5 and2( w2.Adder0.csa4x2_0_lvl0.14, w0.Adder0.csa4x2_0_lvl0.14, PP_2_14 )#5 or2( cout_csa4x2_0_lvl0.14, w1.Adder0.csa4x2_0_lvl0.14, w2.Adder0.csa4x2_0_lvl0.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.14( s0_lvl0_14, t0_lvl0_14, sintcsa4x2_0_lvl0.14, PP_3_14, cout_csa4x2_0_lvl0.13) // sum xor2( w0.Adder1.csa4x2_0_lvl0.14, sintcsa4x2_0_lvl0.14, PP_3_14 )#5 xor2( s0_lvl0_14, w0.Adder1.csa4x2_0_lvl0.14, cout_csa4x2_0_lvl0.13 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.14, sintcsa4x2_0_lvl0.14, PP_3_14 )#5 and2( w2.Adder1.csa4x2_0_lvl0.14, w0.Adder1.csa4x2_0_lvl0.14, cout_csa4x2_0_lvl0.13 )#5 or2( t0_lvl0_14, w1.Adder1.csa4x2_0_lvl0.14, w2.Adder1.csa4x2_0_lvl0.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.15, s0_lvl0_15,t0_lvl0_15,cout_csa4x2_0_lvl0.15,PP_0_15,PP_1_15,PP_2_15,PP_3_15,cout_csa4x2_0_lvl0.14) ; // adder1bit Adder0.csa4x2_0_lvl0.15( sintcsa4x2_0_lvl0.15, cout_csa4x2_0_lvl0.15, PP_0_15, PP_1_15, PP_2_15) // sum xor2( w0.Adder0.csa4x2_0_lvl0.15, PP_0_15, PP_1_15 )#5 xor2( sintcsa4x2_0_lvl0.15, w0.Adder0.csa4x2_0_lvl0.15, PP_2_15 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.15, PP_0_15, PP_1_15 )#5 and2( w2.Adder0.csa4x2_0_lvl0.15, w0.Adder0.csa4x2_0_lvl0.15, PP_2_15 )#5 or2( cout_csa4x2_0_lvl0.15, w1.Adder0.csa4x2_0_lvl0.15, w2.Adder0.csa4x2_0_lvl0.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.15( s0_lvl0_15, t0_lvl0_15, sintcsa4x2_0_lvl0.15, PP_3_15, cout_csa4x2_0_lvl0.14) // sum xor2( w0.Adder1.csa4x2_0_lvl0.15, sintcsa4x2_0_lvl0.15, PP_3_15 )#5 xor2( s0_lvl0_15, w0.Adder1.csa4x2_0_lvl0.15, cout_csa4x2_0_lvl0.14 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.15, sintcsa4x2_0_lvl0.15, PP_3_15 )#5 and2( w2.Adder1.csa4x2_0_lvl0.15, w0.Adder1.csa4x2_0_lvl0.15, cout_csa4x2_0_lvl0.14 )#5 or2( t0_lvl0_15, w1.Adder1.csa4x2_0_lvl0.15, w2.Adder1.csa4x2_0_lvl0.15 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.16, s0_lvl0_16,t0_lvl0_16,cout_csa4x2_0_lvl0.16,PP_0_16,PP_1_16,PP_2_16,PP_3_16,cout_csa4x2_0_lvl0.15) ; // adder1bit Adder0.csa4x2_0_lvl0.16( sintcsa4x2_0_lvl0.16, cout_csa4x2_0_lvl0.16, PP_0_16, PP_1_16, PP_2_16) // sum xor2( w0.Adder0.csa4x2_0_lvl0.16, PP_0_16, PP_1_16 )#5 xor2( sintcsa4x2_0_lvl0.16, w0.Adder0.csa4x2_0_lvl0.16, PP_2_16 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.16, PP_0_16, PP_1_16 )#5 and2( w2.Adder0.csa4x2_0_lvl0.16, w0.Adder0.csa4x2_0_lvl0.16, PP_2_16 )#5 or2( cout_csa4x2_0_lvl0.16, w1.Adder0.csa4x2_0_lvl0.16, w2.Adder0.csa4x2_0_lvl0.16 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.16( s0_lvl0_16, t0_lvl0_16, sintcsa4x2_0_lvl0.16, PP_3_16, cout_csa4x2_0_lvl0.15) // sum xor2( w0.Adder1.csa4x2_0_lvl0.16, sintcsa4x2_0_lvl0.16, PP_3_16 )#5 xor2( s0_lvl0_16, w0.Adder1.csa4x2_0_lvl0.16, cout_csa4x2_0_lvl0.15 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.16, sintcsa4x2_0_lvl0.16, PP_3_16 )#5 and2( w2.Adder1.csa4x2_0_lvl0.16, w0.Adder1.csa4x2_0_lvl0.16, cout_csa4x2_0_lvl0.15 )#5 or2( t0_lvl0_16, w1.Adder1.csa4x2_0_lvl0.16, w2.Adder1.csa4x2_0_lvl0.16 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.17, s0_lvl0_17,t0_lvl0_17,cout_csa4x2_0_lvl0.17,PP_0_17,PP_1_17,PP_2_17,PP_3_17,cout_csa4x2_0_lvl0.16) ; // adder1bit Adder0.csa4x2_0_lvl0.17( sintcsa4x2_0_lvl0.17, cout_csa4x2_0_lvl0.17, PP_0_17, PP_1_17, PP_2_17) // sum xor2( w0.Adder0.csa4x2_0_lvl0.17, PP_0_17, PP_1_17 )#5 xor2( sintcsa4x2_0_lvl0.17, w0.Adder0.csa4x2_0_lvl0.17, PP_2_17 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.17, PP_0_17, PP_1_17 )#5 and2( w2.Adder0.csa4x2_0_lvl0.17, w0.Adder0.csa4x2_0_lvl0.17, PP_2_17 )#5 or2( cout_csa4x2_0_lvl0.17, w1.Adder0.csa4x2_0_lvl0.17, w2.Adder0.csa4x2_0_lvl0.17 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.17( s0_lvl0_17, t0_lvl0_17, sintcsa4x2_0_lvl0.17, PP_3_17, cout_csa4x2_0_lvl0.16) // sum xor2( w0.Adder1.csa4x2_0_lvl0.17, sintcsa4x2_0_lvl0.17, PP_3_17 )#5 xor2( s0_lvl0_17, w0.Adder1.csa4x2_0_lvl0.17, cout_csa4x2_0_lvl0.16 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.17, sintcsa4x2_0_lvl0.17, PP_3_17 )#5 and2( w2.Adder1.csa4x2_0_lvl0.17, w0.Adder1.csa4x2_0_lvl0.17, cout_csa4x2_0_lvl0.16 )#5 or2( t0_lvl0_17, w1.Adder1.csa4x2_0_lvl0.17, w2.Adder1.csa4x2_0_lvl0.17 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.18, s0_lvl0_18,t0_lvl0_18,cout_csa4x2_0_lvl0.18,PP_0_18,PP_1_18,PP_2_18,PP_3_18,cout_csa4x2_0_lvl0.17) ; // adder1bit Adder0.csa4x2_0_lvl0.18( sintcsa4x2_0_lvl0.18, cout_csa4x2_0_lvl0.18, PP_0_18, PP_1_18, PP_2_18) // sum xor2( w0.Adder0.csa4x2_0_lvl0.18, PP_0_18, PP_1_18 )#5 xor2( sintcsa4x2_0_lvl0.18, w0.Adder0.csa4x2_0_lvl0.18, PP_2_18 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.18, PP_0_18, PP_1_18 )#5 and2( w2.Adder0.csa4x2_0_lvl0.18, w0.Adder0.csa4x2_0_lvl0.18, PP_2_18 )#5 or2( cout_csa4x2_0_lvl0.18, w1.Adder0.csa4x2_0_lvl0.18, w2.Adder0.csa4x2_0_lvl0.18 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.18( s0_lvl0_18, t0_lvl0_18, sintcsa4x2_0_lvl0.18, PP_3_18, cout_csa4x2_0_lvl0.17) // sum xor2( w0.Adder1.csa4x2_0_lvl0.18, sintcsa4x2_0_lvl0.18, PP_3_18 )#5 xor2( s0_lvl0_18, w0.Adder1.csa4x2_0_lvl0.18, cout_csa4x2_0_lvl0.17 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.18, sintcsa4x2_0_lvl0.18, PP_3_18 )#5 and2( w2.Adder1.csa4x2_0_lvl0.18, w0.Adder1.csa4x2_0_lvl0.18, cout_csa4x2_0_lvl0.17 )#5 or2( t0_lvl0_18, w1.Adder1.csa4x2_0_lvl0.18, w2.Adder1.csa4x2_0_lvl0.18 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl0.19, s0_lvl0_19,t0_lvl0_19,cout_csa4x2_0_lvl0.19,PP_0_19,PP_1_19,PP_2_19,PP_3_19,cout_csa4x2_0_lvl0.18) ; // adder1bit Adder0.csa4x2_0_lvl0.19( sintcsa4x2_0_lvl0.19, cout_csa4x2_0_lvl0.19, PP_0_19, PP_1_19, PP_2_19) // sum xor2( w0.Adder0.csa4x2_0_lvl0.19, PP_0_19, PP_1_19 )#5 xor2( sintcsa4x2_0_lvl0.19, w0.Adder0.csa4x2_0_lvl0.19, PP_2_19 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl0.19, PP_0_19, PP_1_19 )#5 and2( w2.Adder0.csa4x2_0_lvl0.19, w0.Adder0.csa4x2_0_lvl0.19, PP_2_19 )#5 or2( cout_csa4x2_0_lvl0.19, w1.Adder0.csa4x2_0_lvl0.19, w2.Adder0.csa4x2_0_lvl0.19 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl0.19( s0_lvl0_19, t0_lvl0_19, sintcsa4x2_0_lvl0.19, PP_3_19, cout_csa4x2_0_lvl0.18) // sum xor2( w0.Adder1.csa4x2_0_lvl0.19, sintcsa4x2_0_lvl0.19, PP_3_19 )#5 xor2( s0_lvl0_19, w0.Adder1.csa4x2_0_lvl0.19, cout_csa4x2_0_lvl0.18 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl0.19, sintcsa4x2_0_lvl0.19, PP_3_19 )#5 and2( w2.Adder1.csa4x2_0_lvl0.19, w0.Adder1.csa4x2_0_lvl0.19, cout_csa4x2_0_lvl0.18 )#5 or2( t0_lvl0_19, w1.Adder1.csa4x2_0_lvl0.19, w2.Adder1.csa4x2_0_lvl0.19 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.0, s4_lvl0_0,t4_lvl0_0,cout_csa4x2_4_lvl0.0,PP_4_0,PP_5_0,PP_6_0,PP_7_0,GND) ; // adder1bit Adder0.csa4x2_4_lvl0.0( sintcsa4x2_4_lvl0.0, cout_csa4x2_4_lvl0.0, PP_4_0, PP_5_0, PP_6_0) // sum xor2( w0.Adder0.csa4x2_4_lvl0.0, PP_4_0, PP_5_0 )#5 xor2( sintcsa4x2_4_lvl0.0, w0.Adder0.csa4x2_4_lvl0.0, PP_6_0 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.0, PP_4_0, PP_5_0 )#5 and2( w2.Adder0.csa4x2_4_lvl0.0, w0.Adder0.csa4x2_4_lvl0.0, PP_6_0 )#5 or2( cout_csa4x2_4_lvl0.0, w1.Adder0.csa4x2_4_lvl0.0, w2.Adder0.csa4x2_4_lvl0.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.0( s4_lvl0_0, t4_lvl0_0, sintcsa4x2_4_lvl0.0, PP_7_0, GND) // sum xor2( w0.Adder1.csa4x2_4_lvl0.0, sintcsa4x2_4_lvl0.0, PP_7_0 )#5 xor2( s4_lvl0_0, w0.Adder1.csa4x2_4_lvl0.0, GND )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.0, sintcsa4x2_4_lvl0.0, PP_7_0 )#5 and2( w2.Adder1.csa4x2_4_lvl0.0, w0.Adder1.csa4x2_4_lvl0.0, GND )#5 or2( t4_lvl0_0, w1.Adder1.csa4x2_4_lvl0.0, w2.Adder1.csa4x2_4_lvl0.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.1, s4_lvl0_1,t4_lvl0_1,cout_csa4x2_4_lvl0.1,PP_4_1,PP_5_1,PP_6_1,PP_7_1,cout_csa4x2_4_lvl0.0) ; // adder1bit Adder0.csa4x2_4_lvl0.1( sintcsa4x2_4_lvl0.1, cout_csa4x2_4_lvl0.1, PP_4_1, PP_5_1, PP_6_1) // sum xor2( w0.Adder0.csa4x2_4_lvl0.1, PP_4_1, PP_5_1 )#5 xor2( sintcsa4x2_4_lvl0.1, w0.Adder0.csa4x2_4_lvl0.1, PP_6_1 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.1, PP_4_1, PP_5_1 )#5 and2( w2.Adder0.csa4x2_4_lvl0.1, w0.Adder0.csa4x2_4_lvl0.1, PP_6_1 )#5 or2( cout_csa4x2_4_lvl0.1, w1.Adder0.csa4x2_4_lvl0.1, w2.Adder0.csa4x2_4_lvl0.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.1( s4_lvl0_1, t4_lvl0_1, sintcsa4x2_4_lvl0.1, PP_7_1, cout_csa4x2_4_lvl0.0) // sum xor2( w0.Adder1.csa4x2_4_lvl0.1, sintcsa4x2_4_lvl0.1, PP_7_1 )#5 xor2( s4_lvl0_1, w0.Adder1.csa4x2_4_lvl0.1, cout_csa4x2_4_lvl0.0 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.1, sintcsa4x2_4_lvl0.1, PP_7_1 )#5 and2( w2.Adder1.csa4x2_4_lvl0.1, w0.Adder1.csa4x2_4_lvl0.1, cout_csa4x2_4_lvl0.0 )#5 or2( t4_lvl0_1, w1.Adder1.csa4x2_4_lvl0.1, w2.Adder1.csa4x2_4_lvl0.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.2, s4_lvl0_2,t4_lvl0_2,cout_csa4x2_4_lvl0.2,PP_4_2,PP_5_2,PP_6_2,PP_7_2,cout_csa4x2_4_lvl0.1) ; // adder1bit Adder0.csa4x2_4_lvl0.2( sintcsa4x2_4_lvl0.2, cout_csa4x2_4_lvl0.2, PP_4_2, PP_5_2, PP_6_2) // sum xor2( w0.Adder0.csa4x2_4_lvl0.2, PP_4_2, PP_5_2 )#5 xor2( sintcsa4x2_4_lvl0.2, w0.Adder0.csa4x2_4_lvl0.2, PP_6_2 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.2, PP_4_2, PP_5_2 )#5 and2( w2.Adder0.csa4x2_4_lvl0.2, w0.Adder0.csa4x2_4_lvl0.2, PP_6_2 )#5 or2( cout_csa4x2_4_lvl0.2, w1.Adder0.csa4x2_4_lvl0.2, w2.Adder0.csa4x2_4_lvl0.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.2( s4_lvl0_2, t4_lvl0_2, sintcsa4x2_4_lvl0.2, PP_7_2, cout_csa4x2_4_lvl0.1) // sum xor2( w0.Adder1.csa4x2_4_lvl0.2, sintcsa4x2_4_lvl0.2, PP_7_2 )#5 xor2( s4_lvl0_2, w0.Adder1.csa4x2_4_lvl0.2, cout_csa4x2_4_lvl0.1 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.2, sintcsa4x2_4_lvl0.2, PP_7_2 )#5 and2( w2.Adder1.csa4x2_4_lvl0.2, w0.Adder1.csa4x2_4_lvl0.2, cout_csa4x2_4_lvl0.1 )#5 or2( t4_lvl0_2, w1.Adder1.csa4x2_4_lvl0.2, w2.Adder1.csa4x2_4_lvl0.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.3, s4_lvl0_3,t4_lvl0_3,cout_csa4x2_4_lvl0.3,PP_4_3,PP_5_3,PP_6_3,PP_7_3,cout_csa4x2_4_lvl0.2) ; // adder1bit Adder0.csa4x2_4_lvl0.3( sintcsa4x2_4_lvl0.3, cout_csa4x2_4_lvl0.3, PP_4_3, PP_5_3, PP_6_3) // sum xor2( w0.Adder0.csa4x2_4_lvl0.3, PP_4_3, PP_5_3 )#5 xor2( sintcsa4x2_4_lvl0.3, w0.Adder0.csa4x2_4_lvl0.3, PP_6_3 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.3, PP_4_3, PP_5_3 )#5 and2( w2.Adder0.csa4x2_4_lvl0.3, w0.Adder0.csa4x2_4_lvl0.3, PP_6_3 )#5 or2( cout_csa4x2_4_lvl0.3, w1.Adder0.csa4x2_4_lvl0.3, w2.Adder0.csa4x2_4_lvl0.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.3( s4_lvl0_3, t4_lvl0_3, sintcsa4x2_4_lvl0.3, PP_7_3, cout_csa4x2_4_lvl0.2) // sum xor2( w0.Adder1.csa4x2_4_lvl0.3, sintcsa4x2_4_lvl0.3, PP_7_3 )#5 xor2( s4_lvl0_3, w0.Adder1.csa4x2_4_lvl0.3, cout_csa4x2_4_lvl0.2 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.3, sintcsa4x2_4_lvl0.3, PP_7_3 )#5 and2( w2.Adder1.csa4x2_4_lvl0.3, w0.Adder1.csa4x2_4_lvl0.3, cout_csa4x2_4_lvl0.2 )#5 or2( t4_lvl0_3, w1.Adder1.csa4x2_4_lvl0.3, w2.Adder1.csa4x2_4_lvl0.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.4, s4_lvl0_4,t4_lvl0_4,cout_csa4x2_4_lvl0.4,PP_4_4,PP_5_4,PP_6_4,PP_7_4,cout_csa4x2_4_lvl0.3) ; // adder1bit Adder0.csa4x2_4_lvl0.4( sintcsa4x2_4_lvl0.4, cout_csa4x2_4_lvl0.4, PP_4_4, PP_5_4, PP_6_4) // sum xor2( w0.Adder0.csa4x2_4_lvl0.4, PP_4_4, PP_5_4 )#5 xor2( sintcsa4x2_4_lvl0.4, w0.Adder0.csa4x2_4_lvl0.4, PP_6_4 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.4, PP_4_4, PP_5_4 )#5 and2( w2.Adder0.csa4x2_4_lvl0.4, w0.Adder0.csa4x2_4_lvl0.4, PP_6_4 )#5 or2( cout_csa4x2_4_lvl0.4, w1.Adder0.csa4x2_4_lvl0.4, w2.Adder0.csa4x2_4_lvl0.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.4( s4_lvl0_4, t4_lvl0_4, sintcsa4x2_4_lvl0.4, PP_7_4, cout_csa4x2_4_lvl0.3) // sum xor2( w0.Adder1.csa4x2_4_lvl0.4, sintcsa4x2_4_lvl0.4, PP_7_4 )#5 xor2( s4_lvl0_4, w0.Adder1.csa4x2_4_lvl0.4, cout_csa4x2_4_lvl0.3 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.4, sintcsa4x2_4_lvl0.4, PP_7_4 )#5 and2( w2.Adder1.csa4x2_4_lvl0.4, w0.Adder1.csa4x2_4_lvl0.4, cout_csa4x2_4_lvl0.3 )#5 or2( t4_lvl0_4, w1.Adder1.csa4x2_4_lvl0.4, w2.Adder1.csa4x2_4_lvl0.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.5, s4_lvl0_5,t4_lvl0_5,cout_csa4x2_4_lvl0.5,PP_4_5,PP_5_5,PP_6_5,PP_7_5,cout_csa4x2_4_lvl0.4) ; // adder1bit Adder0.csa4x2_4_lvl0.5( sintcsa4x2_4_lvl0.5, cout_csa4x2_4_lvl0.5, PP_4_5, PP_5_5, PP_6_5) // sum xor2( w0.Adder0.csa4x2_4_lvl0.5, PP_4_5, PP_5_5 )#5 xor2( sintcsa4x2_4_lvl0.5, w0.Adder0.csa4x2_4_lvl0.5, PP_6_5 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.5, PP_4_5, PP_5_5 )#5 and2( w2.Adder0.csa4x2_4_lvl0.5, w0.Adder0.csa4x2_4_lvl0.5, PP_6_5 )#5 or2( cout_csa4x2_4_lvl0.5, w1.Adder0.csa4x2_4_lvl0.5, w2.Adder0.csa4x2_4_lvl0.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.5( s4_lvl0_5, t4_lvl0_5, sintcsa4x2_4_lvl0.5, PP_7_5, cout_csa4x2_4_lvl0.4) // sum xor2( w0.Adder1.csa4x2_4_lvl0.5, sintcsa4x2_4_lvl0.5, PP_7_5 )#5 xor2( s4_lvl0_5, w0.Adder1.csa4x2_4_lvl0.5, cout_csa4x2_4_lvl0.4 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.5, sintcsa4x2_4_lvl0.5, PP_7_5 )#5 and2( w2.Adder1.csa4x2_4_lvl0.5, w0.Adder1.csa4x2_4_lvl0.5, cout_csa4x2_4_lvl0.4 )#5 or2( t4_lvl0_5, w1.Adder1.csa4x2_4_lvl0.5, w2.Adder1.csa4x2_4_lvl0.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.6, s4_lvl0_6,t4_lvl0_6,cout_csa4x2_4_lvl0.6,PP_4_6,PP_5_6,PP_6_6,PP_7_6,cout_csa4x2_4_lvl0.5) ; // adder1bit Adder0.csa4x2_4_lvl0.6( sintcsa4x2_4_lvl0.6, cout_csa4x2_4_lvl0.6, PP_4_6, PP_5_6, PP_6_6) // sum xor2( w0.Adder0.csa4x2_4_lvl0.6, PP_4_6, PP_5_6 )#5 xor2( sintcsa4x2_4_lvl0.6, w0.Adder0.csa4x2_4_lvl0.6, PP_6_6 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.6, PP_4_6, PP_5_6 )#5 and2( w2.Adder0.csa4x2_4_lvl0.6, w0.Adder0.csa4x2_4_lvl0.6, PP_6_6 )#5 or2( cout_csa4x2_4_lvl0.6, w1.Adder0.csa4x2_4_lvl0.6, w2.Adder0.csa4x2_4_lvl0.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.6( s4_lvl0_6, t4_lvl0_6, sintcsa4x2_4_lvl0.6, PP_7_6, cout_csa4x2_4_lvl0.5) // sum xor2( w0.Adder1.csa4x2_4_lvl0.6, sintcsa4x2_4_lvl0.6, PP_7_6 )#5 xor2( s4_lvl0_6, w0.Adder1.csa4x2_4_lvl0.6, cout_csa4x2_4_lvl0.5 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.6, sintcsa4x2_4_lvl0.6, PP_7_6 )#5 and2( w2.Adder1.csa4x2_4_lvl0.6, w0.Adder1.csa4x2_4_lvl0.6, cout_csa4x2_4_lvl0.5 )#5 or2( t4_lvl0_6, w1.Adder1.csa4x2_4_lvl0.6, w2.Adder1.csa4x2_4_lvl0.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.7, s4_lvl0_7,t4_lvl0_7,cout_csa4x2_4_lvl0.7,PP_4_7,PP_5_7,PP_6_7,PP_7_7,cout_csa4x2_4_lvl0.6) ; // adder1bit Adder0.csa4x2_4_lvl0.7( sintcsa4x2_4_lvl0.7, cout_csa4x2_4_lvl0.7, PP_4_7, PP_5_7, PP_6_7) // sum xor2( w0.Adder0.csa4x2_4_lvl0.7, PP_4_7, PP_5_7 )#5 xor2( sintcsa4x2_4_lvl0.7, w0.Adder0.csa4x2_4_lvl0.7, PP_6_7 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.7, PP_4_7, PP_5_7 )#5 and2( w2.Adder0.csa4x2_4_lvl0.7, w0.Adder0.csa4x2_4_lvl0.7, PP_6_7 )#5 or2( cout_csa4x2_4_lvl0.7, w1.Adder0.csa4x2_4_lvl0.7, w2.Adder0.csa4x2_4_lvl0.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.7( s4_lvl0_7, t4_lvl0_7, sintcsa4x2_4_lvl0.7, PP_7_7, cout_csa4x2_4_lvl0.6) // sum xor2( w0.Adder1.csa4x2_4_lvl0.7, sintcsa4x2_4_lvl0.7, PP_7_7 )#5 xor2( s4_lvl0_7, w0.Adder1.csa4x2_4_lvl0.7, cout_csa4x2_4_lvl0.6 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.7, sintcsa4x2_4_lvl0.7, PP_7_7 )#5 and2( w2.Adder1.csa4x2_4_lvl0.7, w0.Adder1.csa4x2_4_lvl0.7, cout_csa4x2_4_lvl0.6 )#5 or2( t4_lvl0_7, w1.Adder1.csa4x2_4_lvl0.7, w2.Adder1.csa4x2_4_lvl0.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.8, s4_lvl0_8,t4_lvl0_8,cout_csa4x2_4_lvl0.8,PP_4_8,PP_5_8,PP_6_8,PP_7_8,cout_csa4x2_4_lvl0.7) ; // adder1bit Adder0.csa4x2_4_lvl0.8( sintcsa4x2_4_lvl0.8, cout_csa4x2_4_lvl0.8, PP_4_8, PP_5_8, PP_6_8) // sum xor2( w0.Adder0.csa4x2_4_lvl0.8, PP_4_8, PP_5_8 )#5 xor2( sintcsa4x2_4_lvl0.8, w0.Adder0.csa4x2_4_lvl0.8, PP_6_8 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.8, PP_4_8, PP_5_8 )#5 and2( w2.Adder0.csa4x2_4_lvl0.8, w0.Adder0.csa4x2_4_lvl0.8, PP_6_8 )#5 or2( cout_csa4x2_4_lvl0.8, w1.Adder0.csa4x2_4_lvl0.8, w2.Adder0.csa4x2_4_lvl0.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.8( s4_lvl0_8, t4_lvl0_8, sintcsa4x2_4_lvl0.8, PP_7_8, cout_csa4x2_4_lvl0.7) // sum xor2( w0.Adder1.csa4x2_4_lvl0.8, sintcsa4x2_4_lvl0.8, PP_7_8 )#5 xor2( s4_lvl0_8, w0.Adder1.csa4x2_4_lvl0.8, cout_csa4x2_4_lvl0.7 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.8, sintcsa4x2_4_lvl0.8, PP_7_8 )#5 and2( w2.Adder1.csa4x2_4_lvl0.8, w0.Adder1.csa4x2_4_lvl0.8, cout_csa4x2_4_lvl0.7 )#5 or2( t4_lvl0_8, w1.Adder1.csa4x2_4_lvl0.8, w2.Adder1.csa4x2_4_lvl0.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.9, s4_lvl0_9,t4_lvl0_9,cout_csa4x2_4_lvl0.9,PP_4_9,PP_5_9,PP_6_9,PP_7_9,cout_csa4x2_4_lvl0.8) ; // adder1bit Adder0.csa4x2_4_lvl0.9( sintcsa4x2_4_lvl0.9, cout_csa4x2_4_lvl0.9, PP_4_9, PP_5_9, PP_6_9) // sum xor2( w0.Adder0.csa4x2_4_lvl0.9, PP_4_9, PP_5_9 )#5 xor2( sintcsa4x2_4_lvl0.9, w0.Adder0.csa4x2_4_lvl0.9, PP_6_9 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.9, PP_4_9, PP_5_9 )#5 and2( w2.Adder0.csa4x2_4_lvl0.9, w0.Adder0.csa4x2_4_lvl0.9, PP_6_9 )#5 or2( cout_csa4x2_4_lvl0.9, w1.Adder0.csa4x2_4_lvl0.9, w2.Adder0.csa4x2_4_lvl0.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.9( s4_lvl0_9, t4_lvl0_9, sintcsa4x2_4_lvl0.9, PP_7_9, cout_csa4x2_4_lvl0.8) // sum xor2( w0.Adder1.csa4x2_4_lvl0.9, sintcsa4x2_4_lvl0.9, PP_7_9 )#5 xor2( s4_lvl0_9, w0.Adder1.csa4x2_4_lvl0.9, cout_csa4x2_4_lvl0.8 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.9, sintcsa4x2_4_lvl0.9, PP_7_9 )#5 and2( w2.Adder1.csa4x2_4_lvl0.9, w0.Adder1.csa4x2_4_lvl0.9, cout_csa4x2_4_lvl0.8 )#5 or2( t4_lvl0_9, w1.Adder1.csa4x2_4_lvl0.9, w2.Adder1.csa4x2_4_lvl0.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.10, s4_lvl0_10,t4_lvl0_10,cout_csa4x2_4_lvl0.10,PP_4_10,PP_5_10,PP_6_10,PP_7_10,cout_csa4x2_4_lvl0.9) ; // adder1bit Adder0.csa4x2_4_lvl0.10( sintcsa4x2_4_lvl0.10, cout_csa4x2_4_lvl0.10, PP_4_10, PP_5_10, PP_6_10) // sum xor2( w0.Adder0.csa4x2_4_lvl0.10, PP_4_10, PP_5_10 )#5 xor2( sintcsa4x2_4_lvl0.10, w0.Adder0.csa4x2_4_lvl0.10, PP_6_10 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.10, PP_4_10, PP_5_10 )#5 and2( w2.Adder0.csa4x2_4_lvl0.10, w0.Adder0.csa4x2_4_lvl0.10, PP_6_10 )#5 or2( cout_csa4x2_4_lvl0.10, w1.Adder0.csa4x2_4_lvl0.10, w2.Adder0.csa4x2_4_lvl0.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.10( s4_lvl0_10, t4_lvl0_10, sintcsa4x2_4_lvl0.10, PP_7_10, cout_csa4x2_4_lvl0.9) // sum xor2( w0.Adder1.csa4x2_4_lvl0.10, sintcsa4x2_4_lvl0.10, PP_7_10 )#5 xor2( s4_lvl0_10, w0.Adder1.csa4x2_4_lvl0.10, cout_csa4x2_4_lvl0.9 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.10, sintcsa4x2_4_lvl0.10, PP_7_10 )#5 and2( w2.Adder1.csa4x2_4_lvl0.10, w0.Adder1.csa4x2_4_lvl0.10, cout_csa4x2_4_lvl0.9 )#5 or2( t4_lvl0_10, w1.Adder1.csa4x2_4_lvl0.10, w2.Adder1.csa4x2_4_lvl0.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.11, s4_lvl0_11,t4_lvl0_11,cout_csa4x2_4_lvl0.11,PP_4_11,PP_5_11,PP_6_11,PP_7_11,cout_csa4x2_4_lvl0.10) ; // adder1bit Adder0.csa4x2_4_lvl0.11( sintcsa4x2_4_lvl0.11, cout_csa4x2_4_lvl0.11, PP_4_11, PP_5_11, PP_6_11) // sum xor2( w0.Adder0.csa4x2_4_lvl0.11, PP_4_11, PP_5_11 )#5 xor2( sintcsa4x2_4_lvl0.11, w0.Adder0.csa4x2_4_lvl0.11, PP_6_11 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.11, PP_4_11, PP_5_11 )#5 and2( w2.Adder0.csa4x2_4_lvl0.11, w0.Adder0.csa4x2_4_lvl0.11, PP_6_11 )#5 or2( cout_csa4x2_4_lvl0.11, w1.Adder0.csa4x2_4_lvl0.11, w2.Adder0.csa4x2_4_lvl0.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.11( s4_lvl0_11, t4_lvl0_11, sintcsa4x2_4_lvl0.11, PP_7_11, cout_csa4x2_4_lvl0.10) // sum xor2( w0.Adder1.csa4x2_4_lvl0.11, sintcsa4x2_4_lvl0.11, PP_7_11 )#5 xor2( s4_lvl0_11, w0.Adder1.csa4x2_4_lvl0.11, cout_csa4x2_4_lvl0.10 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.11, sintcsa4x2_4_lvl0.11, PP_7_11 )#5 and2( w2.Adder1.csa4x2_4_lvl0.11, w0.Adder1.csa4x2_4_lvl0.11, cout_csa4x2_4_lvl0.10 )#5 or2( t4_lvl0_11, w1.Adder1.csa4x2_4_lvl0.11, w2.Adder1.csa4x2_4_lvl0.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.12, s4_lvl0_12,t4_lvl0_12,cout_csa4x2_4_lvl0.12,PP_4_12,PP_5_12,PP_6_12,PP_7_12,cout_csa4x2_4_lvl0.11) ; // adder1bit Adder0.csa4x2_4_lvl0.12( sintcsa4x2_4_lvl0.12, cout_csa4x2_4_lvl0.12, PP_4_12, PP_5_12, PP_6_12) // sum xor2( w0.Adder0.csa4x2_4_lvl0.12, PP_4_12, PP_5_12 )#5 xor2( sintcsa4x2_4_lvl0.12, w0.Adder0.csa4x2_4_lvl0.12, PP_6_12 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.12, PP_4_12, PP_5_12 )#5 and2( w2.Adder0.csa4x2_4_lvl0.12, w0.Adder0.csa4x2_4_lvl0.12, PP_6_12 )#5 or2( cout_csa4x2_4_lvl0.12, w1.Adder0.csa4x2_4_lvl0.12, w2.Adder0.csa4x2_4_lvl0.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.12( s4_lvl0_12, t4_lvl0_12, sintcsa4x2_4_lvl0.12, PP_7_12, cout_csa4x2_4_lvl0.11) // sum xor2( w0.Adder1.csa4x2_4_lvl0.12, sintcsa4x2_4_lvl0.12, PP_7_12 )#5 xor2( s4_lvl0_12, w0.Adder1.csa4x2_4_lvl0.12, cout_csa4x2_4_lvl0.11 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.12, sintcsa4x2_4_lvl0.12, PP_7_12 )#5 and2( w2.Adder1.csa4x2_4_lvl0.12, w0.Adder1.csa4x2_4_lvl0.12, cout_csa4x2_4_lvl0.11 )#5 or2( t4_lvl0_12, w1.Adder1.csa4x2_4_lvl0.12, w2.Adder1.csa4x2_4_lvl0.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.13, s4_lvl0_13,t4_lvl0_13,cout_csa4x2_4_lvl0.13,PP_4_13,PP_5_13,PP_6_13,PP_7_13,cout_csa4x2_4_lvl0.12) ; // adder1bit Adder0.csa4x2_4_lvl0.13( sintcsa4x2_4_lvl0.13, cout_csa4x2_4_lvl0.13, PP_4_13, PP_5_13, PP_6_13) // sum xor2( w0.Adder0.csa4x2_4_lvl0.13, PP_4_13, PP_5_13 )#5 xor2( sintcsa4x2_4_lvl0.13, w0.Adder0.csa4x2_4_lvl0.13, PP_6_13 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.13, PP_4_13, PP_5_13 )#5 and2( w2.Adder0.csa4x2_4_lvl0.13, w0.Adder0.csa4x2_4_lvl0.13, PP_6_13 )#5 or2( cout_csa4x2_4_lvl0.13, w1.Adder0.csa4x2_4_lvl0.13, w2.Adder0.csa4x2_4_lvl0.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.13( s4_lvl0_13, t4_lvl0_13, sintcsa4x2_4_lvl0.13, PP_7_13, cout_csa4x2_4_lvl0.12) // sum xor2( w0.Adder1.csa4x2_4_lvl0.13, sintcsa4x2_4_lvl0.13, PP_7_13 )#5 xor2( s4_lvl0_13, w0.Adder1.csa4x2_4_lvl0.13, cout_csa4x2_4_lvl0.12 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.13, sintcsa4x2_4_lvl0.13, PP_7_13 )#5 and2( w2.Adder1.csa4x2_4_lvl0.13, w0.Adder1.csa4x2_4_lvl0.13, cout_csa4x2_4_lvl0.12 )#5 or2( t4_lvl0_13, w1.Adder1.csa4x2_4_lvl0.13, w2.Adder1.csa4x2_4_lvl0.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.14, s4_lvl0_14,t4_lvl0_14,cout_csa4x2_4_lvl0.14,PP_4_14,PP_5_14,PP_6_14,PP_7_14,cout_csa4x2_4_lvl0.13) ; // adder1bit Adder0.csa4x2_4_lvl0.14( sintcsa4x2_4_lvl0.14, cout_csa4x2_4_lvl0.14, PP_4_14, PP_5_14, PP_6_14) // sum xor2( w0.Adder0.csa4x2_4_lvl0.14, PP_4_14, PP_5_14 )#5 xor2( sintcsa4x2_4_lvl0.14, w0.Adder0.csa4x2_4_lvl0.14, PP_6_14 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.14, PP_4_14, PP_5_14 )#5 and2( w2.Adder0.csa4x2_4_lvl0.14, w0.Adder0.csa4x2_4_lvl0.14, PP_6_14 )#5 or2( cout_csa4x2_4_lvl0.14, w1.Adder0.csa4x2_4_lvl0.14, w2.Adder0.csa4x2_4_lvl0.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.14( s4_lvl0_14, t4_lvl0_14, sintcsa4x2_4_lvl0.14, PP_7_14, cout_csa4x2_4_lvl0.13) // sum xor2( w0.Adder1.csa4x2_4_lvl0.14, sintcsa4x2_4_lvl0.14, PP_7_14 )#5 xor2( s4_lvl0_14, w0.Adder1.csa4x2_4_lvl0.14, cout_csa4x2_4_lvl0.13 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.14, sintcsa4x2_4_lvl0.14, PP_7_14 )#5 and2( w2.Adder1.csa4x2_4_lvl0.14, w0.Adder1.csa4x2_4_lvl0.14, cout_csa4x2_4_lvl0.13 )#5 or2( t4_lvl0_14, w1.Adder1.csa4x2_4_lvl0.14, w2.Adder1.csa4x2_4_lvl0.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.15, s4_lvl0_15,t4_lvl0_15,cout_csa4x2_4_lvl0.15,PP_4_15,PP_5_15,PP_6_15,PP_7_15,cout_csa4x2_4_lvl0.14) ; // adder1bit Adder0.csa4x2_4_lvl0.15( sintcsa4x2_4_lvl0.15, cout_csa4x2_4_lvl0.15, PP_4_15, PP_5_15, PP_6_15) // sum xor2( w0.Adder0.csa4x2_4_lvl0.15, PP_4_15, PP_5_15 )#5 xor2( sintcsa4x2_4_lvl0.15, w0.Adder0.csa4x2_4_lvl0.15, PP_6_15 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.15, PP_4_15, PP_5_15 )#5 and2( w2.Adder0.csa4x2_4_lvl0.15, w0.Adder0.csa4x2_4_lvl0.15, PP_6_15 )#5 or2( cout_csa4x2_4_lvl0.15, w1.Adder0.csa4x2_4_lvl0.15, w2.Adder0.csa4x2_4_lvl0.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.15( s4_lvl0_15, t4_lvl0_15, sintcsa4x2_4_lvl0.15, PP_7_15, cout_csa4x2_4_lvl0.14) // sum xor2( w0.Adder1.csa4x2_4_lvl0.15, sintcsa4x2_4_lvl0.15, PP_7_15 )#5 xor2( s4_lvl0_15, w0.Adder1.csa4x2_4_lvl0.15, cout_csa4x2_4_lvl0.14 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.15, sintcsa4x2_4_lvl0.15, PP_7_15 )#5 and2( w2.Adder1.csa4x2_4_lvl0.15, w0.Adder1.csa4x2_4_lvl0.15, cout_csa4x2_4_lvl0.14 )#5 or2( t4_lvl0_15, w1.Adder1.csa4x2_4_lvl0.15, w2.Adder1.csa4x2_4_lvl0.15 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.16, s4_lvl0_16,t4_lvl0_16,cout_csa4x2_4_lvl0.16,PP_4_16,PP_5_16,PP_6_16,PP_7_16,cout_csa4x2_4_lvl0.15) ; // adder1bit Adder0.csa4x2_4_lvl0.16( sintcsa4x2_4_lvl0.16, cout_csa4x2_4_lvl0.16, PP_4_16, PP_5_16, PP_6_16) // sum xor2( w0.Adder0.csa4x2_4_lvl0.16, PP_4_16, PP_5_16 )#5 xor2( sintcsa4x2_4_lvl0.16, w0.Adder0.csa4x2_4_lvl0.16, PP_6_16 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.16, PP_4_16, PP_5_16 )#5 and2( w2.Adder0.csa4x2_4_lvl0.16, w0.Adder0.csa4x2_4_lvl0.16, PP_6_16 )#5 or2( cout_csa4x2_4_lvl0.16, w1.Adder0.csa4x2_4_lvl0.16, w2.Adder0.csa4x2_4_lvl0.16 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.16( s4_lvl0_16, t4_lvl0_16, sintcsa4x2_4_lvl0.16, PP_7_16, cout_csa4x2_4_lvl0.15) // sum xor2( w0.Adder1.csa4x2_4_lvl0.16, sintcsa4x2_4_lvl0.16, PP_7_16 )#5 xor2( s4_lvl0_16, w0.Adder1.csa4x2_4_lvl0.16, cout_csa4x2_4_lvl0.15 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.16, sintcsa4x2_4_lvl0.16, PP_7_16 )#5 and2( w2.Adder1.csa4x2_4_lvl0.16, w0.Adder1.csa4x2_4_lvl0.16, cout_csa4x2_4_lvl0.15 )#5 or2( t4_lvl0_16, w1.Adder1.csa4x2_4_lvl0.16, w2.Adder1.csa4x2_4_lvl0.16 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.17, s4_lvl0_17,t4_lvl0_17,cout_csa4x2_4_lvl0.17,PP_4_17,PP_5_17,PP_6_17,PP_7_17,cout_csa4x2_4_lvl0.16) ; // adder1bit Adder0.csa4x2_4_lvl0.17( sintcsa4x2_4_lvl0.17, cout_csa4x2_4_lvl0.17, PP_4_17, PP_5_17, PP_6_17) // sum xor2( w0.Adder0.csa4x2_4_lvl0.17, PP_4_17, PP_5_17 )#5 xor2( sintcsa4x2_4_lvl0.17, w0.Adder0.csa4x2_4_lvl0.17, PP_6_17 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.17, PP_4_17, PP_5_17 )#5 and2( w2.Adder0.csa4x2_4_lvl0.17, w0.Adder0.csa4x2_4_lvl0.17, PP_6_17 )#5 or2( cout_csa4x2_4_lvl0.17, w1.Adder0.csa4x2_4_lvl0.17, w2.Adder0.csa4x2_4_lvl0.17 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.17( s4_lvl0_17, t4_lvl0_17, sintcsa4x2_4_lvl0.17, PP_7_17, cout_csa4x2_4_lvl0.16) // sum xor2( w0.Adder1.csa4x2_4_lvl0.17, sintcsa4x2_4_lvl0.17, PP_7_17 )#5 xor2( s4_lvl0_17, w0.Adder1.csa4x2_4_lvl0.17, cout_csa4x2_4_lvl0.16 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.17, sintcsa4x2_4_lvl0.17, PP_7_17 )#5 and2( w2.Adder1.csa4x2_4_lvl0.17, w0.Adder1.csa4x2_4_lvl0.17, cout_csa4x2_4_lvl0.16 )#5 or2( t4_lvl0_17, w1.Adder1.csa4x2_4_lvl0.17, w2.Adder1.csa4x2_4_lvl0.17 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.18, s4_lvl0_18,t4_lvl0_18,cout_csa4x2_4_lvl0.18,PP_4_18,PP_5_18,PP_6_18,PP_7_18,cout_csa4x2_4_lvl0.17) ; // adder1bit Adder0.csa4x2_4_lvl0.18( sintcsa4x2_4_lvl0.18, cout_csa4x2_4_lvl0.18, PP_4_18, PP_5_18, PP_6_18) // sum xor2( w0.Adder0.csa4x2_4_lvl0.18, PP_4_18, PP_5_18 )#5 xor2( sintcsa4x2_4_lvl0.18, w0.Adder0.csa4x2_4_lvl0.18, PP_6_18 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.18, PP_4_18, PP_5_18 )#5 and2( w2.Adder0.csa4x2_4_lvl0.18, w0.Adder0.csa4x2_4_lvl0.18, PP_6_18 )#5 or2( cout_csa4x2_4_lvl0.18, w1.Adder0.csa4x2_4_lvl0.18, w2.Adder0.csa4x2_4_lvl0.18 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.18( s4_lvl0_18, t4_lvl0_18, sintcsa4x2_4_lvl0.18, PP_7_18, cout_csa4x2_4_lvl0.17) // sum xor2( w0.Adder1.csa4x2_4_lvl0.18, sintcsa4x2_4_lvl0.18, PP_7_18 )#5 xor2( s4_lvl0_18, w0.Adder1.csa4x2_4_lvl0.18, cout_csa4x2_4_lvl0.17 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.18, sintcsa4x2_4_lvl0.18, PP_7_18 )#5 and2( w2.Adder1.csa4x2_4_lvl0.18, w0.Adder1.csa4x2_4_lvl0.18, cout_csa4x2_4_lvl0.17 )#5 or2( t4_lvl0_18, w1.Adder1.csa4x2_4_lvl0.18, w2.Adder1.csa4x2_4_lvl0.18 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_4_lvl0.19, s4_lvl0_19,t4_lvl0_19,cout_csa4x2_4_lvl0.19,PP_4_19,PP_5_19,PP_6_19,PP_7_19,cout_csa4x2_4_lvl0.18) ; // adder1bit Adder0.csa4x2_4_lvl0.19( sintcsa4x2_4_lvl0.19, cout_csa4x2_4_lvl0.19, PP_4_19, PP_5_19, PP_6_19) // sum xor2( w0.Adder0.csa4x2_4_lvl0.19, PP_4_19, PP_5_19 )#5 xor2( sintcsa4x2_4_lvl0.19, w0.Adder0.csa4x2_4_lvl0.19, PP_6_19 )#5 //cout and2( w1.Adder0.csa4x2_4_lvl0.19, PP_4_19, PP_5_19 )#5 and2( w2.Adder0.csa4x2_4_lvl0.19, w0.Adder0.csa4x2_4_lvl0.19, PP_6_19 )#5 or2( cout_csa4x2_4_lvl0.19, w1.Adder0.csa4x2_4_lvl0.19, w2.Adder0.csa4x2_4_lvl0.19 )#5 // end adder1bit // adder1bit Adder1.csa4x2_4_lvl0.19( s4_lvl0_19, t4_lvl0_19, sintcsa4x2_4_lvl0.19, PP_7_19, cout_csa4x2_4_lvl0.18) // sum xor2( w0.Adder1.csa4x2_4_lvl0.19, sintcsa4x2_4_lvl0.19, PP_7_19 )#5 xor2( s4_lvl0_19, w0.Adder1.csa4x2_4_lvl0.19, cout_csa4x2_4_lvl0.18 )#5 //cout and2( w1.Adder1.csa4x2_4_lvl0.19, sintcsa4x2_4_lvl0.19, PP_7_19 )#5 and2( w2.Adder1.csa4x2_4_lvl0.19, w0.Adder1.csa4x2_4_lvl0.19, cout_csa4x2_4_lvl0.18 )#5 or2( t4_lvl0_19, w1.Adder1.csa4x2_4_lvl0.19, w2.Adder1.csa4x2_4_lvl0.19 )#5 // end adder1bit // end csa4x2 end // instantiating csa4x2Vec at lvl 1 netlist // csa4x2 (csa4x2_0_lvl1.0, s0_lvl1_0,t0_lvl1_0,cout_csa4x2_0_lvl1.0,PP_8_0,PP_9_0,s0_lvl0_0,GND,GND) ; // adder1bit Adder0.csa4x2_0_lvl1.0( sintcsa4x2_0_lvl1.0, cout_csa4x2_0_lvl1.0, PP_8_0, PP_9_0, s0_lvl0_0) // sum xor2( w0.Adder0.csa4x2_0_lvl1.0, PP_8_0, PP_9_0 )#5 xor2( sintcsa4x2_0_lvl1.0, w0.Adder0.csa4x2_0_lvl1.0, s0_lvl0_0 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.0, PP_8_0, PP_9_0 )#5 and2( w2.Adder0.csa4x2_0_lvl1.0, w0.Adder0.csa4x2_0_lvl1.0, s0_lvl0_0 )#5 or2( cout_csa4x2_0_lvl1.0, w1.Adder0.csa4x2_0_lvl1.0, w2.Adder0.csa4x2_0_lvl1.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.0( s0_lvl1_0, t0_lvl1_0, sintcsa4x2_0_lvl1.0, GND, GND) // sum xor2( w0.Adder1.csa4x2_0_lvl1.0, sintcsa4x2_0_lvl1.0, GND )#5 xor2( s0_lvl1_0, w0.Adder1.csa4x2_0_lvl1.0, GND )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.0, sintcsa4x2_0_lvl1.0, GND )#5 and2( w2.Adder1.csa4x2_0_lvl1.0, w0.Adder1.csa4x2_0_lvl1.0, GND )#5 or2( t0_lvl1_0, w1.Adder1.csa4x2_0_lvl1.0, w2.Adder1.csa4x2_0_lvl1.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.1, s0_lvl1_1,t0_lvl1_1,cout_csa4x2_0_lvl1.1,PP_8_1,PP_9_1,s0_lvl0_1,t0_lvl0_0,cout_csa4x2_0_lvl1.0) ; // adder1bit Adder0.csa4x2_0_lvl1.1( sintcsa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.1, PP_8_1, PP_9_1, s0_lvl0_1) // sum xor2( w0.Adder0.csa4x2_0_lvl1.1, PP_8_1, PP_9_1 )#5 xor2( sintcsa4x2_0_lvl1.1, w0.Adder0.csa4x2_0_lvl1.1, s0_lvl0_1 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.1, PP_8_1, PP_9_1 )#5 and2( w2.Adder0.csa4x2_0_lvl1.1, w0.Adder0.csa4x2_0_lvl1.1, s0_lvl0_1 )#5 or2( cout_csa4x2_0_lvl1.1, w1.Adder0.csa4x2_0_lvl1.1, w2.Adder0.csa4x2_0_lvl1.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.1( s0_lvl1_1, t0_lvl1_1, sintcsa4x2_0_lvl1.1, t0_lvl0_0, cout_csa4x2_0_lvl1.0) // sum xor2( w0.Adder1.csa4x2_0_lvl1.1, sintcsa4x2_0_lvl1.1, t0_lvl0_0 )#5 xor2( s0_lvl1_1, w0.Adder1.csa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.0 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.1, sintcsa4x2_0_lvl1.1, t0_lvl0_0 )#5 and2( w2.Adder1.csa4x2_0_lvl1.1, w0.Adder1.csa4x2_0_lvl1.1, cout_csa4x2_0_lvl1.0 )#5 or2( t0_lvl1_1, w1.Adder1.csa4x2_0_lvl1.1, w2.Adder1.csa4x2_0_lvl1.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.2, s0_lvl1_2,t0_lvl1_2,cout_csa4x2_0_lvl1.2,PP_8_2,PP_9_2,s0_lvl0_2,t0_lvl0_1,cout_csa4x2_0_lvl1.1) ; // adder1bit Adder0.csa4x2_0_lvl1.2( sintcsa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.2, PP_8_2, PP_9_2, s0_lvl0_2) // sum xor2( w0.Adder0.csa4x2_0_lvl1.2, PP_8_2, PP_9_2 )#5 xor2( sintcsa4x2_0_lvl1.2, w0.Adder0.csa4x2_0_lvl1.2, s0_lvl0_2 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.2, PP_8_2, PP_9_2 )#5 and2( w2.Adder0.csa4x2_0_lvl1.2, w0.Adder0.csa4x2_0_lvl1.2, s0_lvl0_2 )#5 or2( cout_csa4x2_0_lvl1.2, w1.Adder0.csa4x2_0_lvl1.2, w2.Adder0.csa4x2_0_lvl1.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.2( s0_lvl1_2, t0_lvl1_2, sintcsa4x2_0_lvl1.2, t0_lvl0_1, cout_csa4x2_0_lvl1.1) // sum xor2( w0.Adder1.csa4x2_0_lvl1.2, sintcsa4x2_0_lvl1.2, t0_lvl0_1 )#5 xor2( s0_lvl1_2, w0.Adder1.csa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.1 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.2, sintcsa4x2_0_lvl1.2, t0_lvl0_1 )#5 and2( w2.Adder1.csa4x2_0_lvl1.2, w0.Adder1.csa4x2_0_lvl1.2, cout_csa4x2_0_lvl1.1 )#5 or2( t0_lvl1_2, w1.Adder1.csa4x2_0_lvl1.2, w2.Adder1.csa4x2_0_lvl1.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.3, s0_lvl1_3,t0_lvl1_3,cout_csa4x2_0_lvl1.3,PP_8_3,PP_9_3,s0_lvl0_3,t0_lvl0_2,cout_csa4x2_0_lvl1.2) ; // adder1bit Adder0.csa4x2_0_lvl1.3( sintcsa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.3, PP_8_3, PP_9_3, s0_lvl0_3) // sum xor2( w0.Adder0.csa4x2_0_lvl1.3, PP_8_3, PP_9_3 )#5 xor2( sintcsa4x2_0_lvl1.3, w0.Adder0.csa4x2_0_lvl1.3, s0_lvl0_3 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.3, PP_8_3, PP_9_3 )#5 and2( w2.Adder0.csa4x2_0_lvl1.3, w0.Adder0.csa4x2_0_lvl1.3, s0_lvl0_3 )#5 or2( cout_csa4x2_0_lvl1.3, w1.Adder0.csa4x2_0_lvl1.3, w2.Adder0.csa4x2_0_lvl1.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.3( s0_lvl1_3, t0_lvl1_3, sintcsa4x2_0_lvl1.3, t0_lvl0_2, cout_csa4x2_0_lvl1.2) // sum xor2( w0.Adder1.csa4x2_0_lvl1.3, sintcsa4x2_0_lvl1.3, t0_lvl0_2 )#5 xor2( s0_lvl1_3, w0.Adder1.csa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.2 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.3, sintcsa4x2_0_lvl1.3, t0_lvl0_2 )#5 and2( w2.Adder1.csa4x2_0_lvl1.3, w0.Adder1.csa4x2_0_lvl1.3, cout_csa4x2_0_lvl1.2 )#5 or2( t0_lvl1_3, w1.Adder1.csa4x2_0_lvl1.3, w2.Adder1.csa4x2_0_lvl1.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.4, s0_lvl1_4,t0_lvl1_4,cout_csa4x2_0_lvl1.4,PP_8_4,PP_9_4,s0_lvl0_4,t0_lvl0_3,cout_csa4x2_0_lvl1.3) ; // adder1bit Adder0.csa4x2_0_lvl1.4( sintcsa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.4, PP_8_4, PP_9_4, s0_lvl0_4) // sum xor2( w0.Adder0.csa4x2_0_lvl1.4, PP_8_4, PP_9_4 )#5 xor2( sintcsa4x2_0_lvl1.4, w0.Adder0.csa4x2_0_lvl1.4, s0_lvl0_4 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.4, PP_8_4, PP_9_4 )#5 and2( w2.Adder0.csa4x2_0_lvl1.4, w0.Adder0.csa4x2_0_lvl1.4, s0_lvl0_4 )#5 or2( cout_csa4x2_0_lvl1.4, w1.Adder0.csa4x2_0_lvl1.4, w2.Adder0.csa4x2_0_lvl1.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.4( s0_lvl1_4, t0_lvl1_4, sintcsa4x2_0_lvl1.4, t0_lvl0_3, cout_csa4x2_0_lvl1.3) // sum xor2( w0.Adder1.csa4x2_0_lvl1.4, sintcsa4x2_0_lvl1.4, t0_lvl0_3 )#5 xor2( s0_lvl1_4, w0.Adder1.csa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.3 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.4, sintcsa4x2_0_lvl1.4, t0_lvl0_3 )#5 and2( w2.Adder1.csa4x2_0_lvl1.4, w0.Adder1.csa4x2_0_lvl1.4, cout_csa4x2_0_lvl1.3 )#5 or2( t0_lvl1_4, w1.Adder1.csa4x2_0_lvl1.4, w2.Adder1.csa4x2_0_lvl1.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.5, s0_lvl1_5,t0_lvl1_5,cout_csa4x2_0_lvl1.5,PP_8_5,PP_9_5,s0_lvl0_5,t0_lvl0_4,cout_csa4x2_0_lvl1.4) ; // adder1bit Adder0.csa4x2_0_lvl1.5( sintcsa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.5, PP_8_5, PP_9_5, s0_lvl0_5) // sum xor2( w0.Adder0.csa4x2_0_lvl1.5, PP_8_5, PP_9_5 )#5 xor2( sintcsa4x2_0_lvl1.5, w0.Adder0.csa4x2_0_lvl1.5, s0_lvl0_5 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.5, PP_8_5, PP_9_5 )#5 and2( w2.Adder0.csa4x2_0_lvl1.5, w0.Adder0.csa4x2_0_lvl1.5, s0_lvl0_5 )#5 or2( cout_csa4x2_0_lvl1.5, w1.Adder0.csa4x2_0_lvl1.5, w2.Adder0.csa4x2_0_lvl1.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.5( s0_lvl1_5, t0_lvl1_5, sintcsa4x2_0_lvl1.5, t0_lvl0_4, cout_csa4x2_0_lvl1.4) // sum xor2( w0.Adder1.csa4x2_0_lvl1.5, sintcsa4x2_0_lvl1.5, t0_lvl0_4 )#5 xor2( s0_lvl1_5, w0.Adder1.csa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.4 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.5, sintcsa4x2_0_lvl1.5, t0_lvl0_4 )#5 and2( w2.Adder1.csa4x2_0_lvl1.5, w0.Adder1.csa4x2_0_lvl1.5, cout_csa4x2_0_lvl1.4 )#5 or2( t0_lvl1_5, w1.Adder1.csa4x2_0_lvl1.5, w2.Adder1.csa4x2_0_lvl1.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.6, s0_lvl1_6,t0_lvl1_6,cout_csa4x2_0_lvl1.6,PP_8_6,PP_9_6,s0_lvl0_6,t0_lvl0_5,cout_csa4x2_0_lvl1.5) ; // adder1bit Adder0.csa4x2_0_lvl1.6( sintcsa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.6, PP_8_6, PP_9_6, s0_lvl0_6) // sum xor2( w0.Adder0.csa4x2_0_lvl1.6, PP_8_6, PP_9_6 )#5 xor2( sintcsa4x2_0_lvl1.6, w0.Adder0.csa4x2_0_lvl1.6, s0_lvl0_6 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.6, PP_8_6, PP_9_6 )#5 and2( w2.Adder0.csa4x2_0_lvl1.6, w0.Adder0.csa4x2_0_lvl1.6, s0_lvl0_6 )#5 or2( cout_csa4x2_0_lvl1.6, w1.Adder0.csa4x2_0_lvl1.6, w2.Adder0.csa4x2_0_lvl1.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.6( s0_lvl1_6, t0_lvl1_6, sintcsa4x2_0_lvl1.6, t0_lvl0_5, cout_csa4x2_0_lvl1.5) // sum xor2( w0.Adder1.csa4x2_0_lvl1.6, sintcsa4x2_0_lvl1.6, t0_lvl0_5 )#5 xor2( s0_lvl1_6, w0.Adder1.csa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.5 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.6, sintcsa4x2_0_lvl1.6, t0_lvl0_5 )#5 and2( w2.Adder1.csa4x2_0_lvl1.6, w0.Adder1.csa4x2_0_lvl1.6, cout_csa4x2_0_lvl1.5 )#5 or2( t0_lvl1_6, w1.Adder1.csa4x2_0_lvl1.6, w2.Adder1.csa4x2_0_lvl1.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.7, s0_lvl1_7,t0_lvl1_7,cout_csa4x2_0_lvl1.7,PP_8_7,PP_9_7,s0_lvl0_7,t0_lvl0_6,cout_csa4x2_0_lvl1.6) ; // adder1bit Adder0.csa4x2_0_lvl1.7( sintcsa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.7, PP_8_7, PP_9_7, s0_lvl0_7) // sum xor2( w0.Adder0.csa4x2_0_lvl1.7, PP_8_7, PP_9_7 )#5 xor2( sintcsa4x2_0_lvl1.7, w0.Adder0.csa4x2_0_lvl1.7, s0_lvl0_7 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.7, PP_8_7, PP_9_7 )#5 and2( w2.Adder0.csa4x2_0_lvl1.7, w0.Adder0.csa4x2_0_lvl1.7, s0_lvl0_7 )#5 or2( cout_csa4x2_0_lvl1.7, w1.Adder0.csa4x2_0_lvl1.7, w2.Adder0.csa4x2_0_lvl1.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.7( s0_lvl1_7, t0_lvl1_7, sintcsa4x2_0_lvl1.7, t0_lvl0_6, cout_csa4x2_0_lvl1.6) // sum xor2( w0.Adder1.csa4x2_0_lvl1.7, sintcsa4x2_0_lvl1.7, t0_lvl0_6 )#5 xor2( s0_lvl1_7, w0.Adder1.csa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.6 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.7, sintcsa4x2_0_lvl1.7, t0_lvl0_6 )#5 and2( w2.Adder1.csa4x2_0_lvl1.7, w0.Adder1.csa4x2_0_lvl1.7, cout_csa4x2_0_lvl1.6 )#5 or2( t0_lvl1_7, w1.Adder1.csa4x2_0_lvl1.7, w2.Adder1.csa4x2_0_lvl1.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.8, s0_lvl1_8,t0_lvl1_8,cout_csa4x2_0_lvl1.8,PP_8_8,PP_9_8,s0_lvl0_8,t0_lvl0_7,cout_csa4x2_0_lvl1.7) ; // adder1bit Adder0.csa4x2_0_lvl1.8( sintcsa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.8, PP_8_8, PP_9_8, s0_lvl0_8) // sum xor2( w0.Adder0.csa4x2_0_lvl1.8, PP_8_8, PP_9_8 )#5 xor2( sintcsa4x2_0_lvl1.8, w0.Adder0.csa4x2_0_lvl1.8, s0_lvl0_8 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.8, PP_8_8, PP_9_8 )#5 and2( w2.Adder0.csa4x2_0_lvl1.8, w0.Adder0.csa4x2_0_lvl1.8, s0_lvl0_8 )#5 or2( cout_csa4x2_0_lvl1.8, w1.Adder0.csa4x2_0_lvl1.8, w2.Adder0.csa4x2_0_lvl1.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.8( s0_lvl1_8, t0_lvl1_8, sintcsa4x2_0_lvl1.8, t0_lvl0_7, cout_csa4x2_0_lvl1.7) // sum xor2( w0.Adder1.csa4x2_0_lvl1.8, sintcsa4x2_0_lvl1.8, t0_lvl0_7 )#5 xor2( s0_lvl1_8, w0.Adder1.csa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.7 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.8, sintcsa4x2_0_lvl1.8, t0_lvl0_7 )#5 and2( w2.Adder1.csa4x2_0_lvl1.8, w0.Adder1.csa4x2_0_lvl1.8, cout_csa4x2_0_lvl1.7 )#5 or2( t0_lvl1_8, w1.Adder1.csa4x2_0_lvl1.8, w2.Adder1.csa4x2_0_lvl1.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.9, s0_lvl1_9,t0_lvl1_9,cout_csa4x2_0_lvl1.9,PP_8_9,PP_9_9,s0_lvl0_9,t0_lvl0_8,cout_csa4x2_0_lvl1.8) ; // adder1bit Adder0.csa4x2_0_lvl1.9( sintcsa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.9, PP_8_9, PP_9_9, s0_lvl0_9) // sum xor2( w0.Adder0.csa4x2_0_lvl1.9, PP_8_9, PP_9_9 )#5 xor2( sintcsa4x2_0_lvl1.9, w0.Adder0.csa4x2_0_lvl1.9, s0_lvl0_9 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.9, PP_8_9, PP_9_9 )#5 and2( w2.Adder0.csa4x2_0_lvl1.9, w0.Adder0.csa4x2_0_lvl1.9, s0_lvl0_9 )#5 or2( cout_csa4x2_0_lvl1.9, w1.Adder0.csa4x2_0_lvl1.9, w2.Adder0.csa4x2_0_lvl1.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.9( s0_lvl1_9, t0_lvl1_9, sintcsa4x2_0_lvl1.9, t0_lvl0_8, cout_csa4x2_0_lvl1.8) // sum xor2( w0.Adder1.csa4x2_0_lvl1.9, sintcsa4x2_0_lvl1.9, t0_lvl0_8 )#5 xor2( s0_lvl1_9, w0.Adder1.csa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.8 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.9, sintcsa4x2_0_lvl1.9, t0_lvl0_8 )#5 and2( w2.Adder1.csa4x2_0_lvl1.9, w0.Adder1.csa4x2_0_lvl1.9, cout_csa4x2_0_lvl1.8 )#5 or2( t0_lvl1_9, w1.Adder1.csa4x2_0_lvl1.9, w2.Adder1.csa4x2_0_lvl1.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.10, s0_lvl1_10,t0_lvl1_10,cout_csa4x2_0_lvl1.10,PP_8_10,PP_9_10,s0_lvl0_10,t0_lvl0_9,cout_csa4x2_0_lvl1.9) ; // adder1bit Adder0.csa4x2_0_lvl1.10( sintcsa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.10, PP_8_10, PP_9_10, s0_lvl0_10) // sum xor2( w0.Adder0.csa4x2_0_lvl1.10, PP_8_10, PP_9_10 )#5 xor2( sintcsa4x2_0_lvl1.10, w0.Adder0.csa4x2_0_lvl1.10, s0_lvl0_10 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.10, PP_8_10, PP_9_10 )#5 and2( w2.Adder0.csa4x2_0_lvl1.10, w0.Adder0.csa4x2_0_lvl1.10, s0_lvl0_10 )#5 or2( cout_csa4x2_0_lvl1.10, w1.Adder0.csa4x2_0_lvl1.10, w2.Adder0.csa4x2_0_lvl1.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.10( s0_lvl1_10, t0_lvl1_10, sintcsa4x2_0_lvl1.10, t0_lvl0_9, cout_csa4x2_0_lvl1.9) // sum xor2( w0.Adder1.csa4x2_0_lvl1.10, sintcsa4x2_0_lvl1.10, t0_lvl0_9 )#5 xor2( s0_lvl1_10, w0.Adder1.csa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.9 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.10, sintcsa4x2_0_lvl1.10, t0_lvl0_9 )#5 and2( w2.Adder1.csa4x2_0_lvl1.10, w0.Adder1.csa4x2_0_lvl1.10, cout_csa4x2_0_lvl1.9 )#5 or2( t0_lvl1_10, w1.Adder1.csa4x2_0_lvl1.10, w2.Adder1.csa4x2_0_lvl1.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.11, s0_lvl1_11,t0_lvl1_11,cout_csa4x2_0_lvl1.11,PP_8_11,PP_9_11,s0_lvl0_11,t0_lvl0_10,cout_csa4x2_0_lvl1.10) ; // adder1bit Adder0.csa4x2_0_lvl1.11( sintcsa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.11, PP_8_11, PP_9_11, s0_lvl0_11) // sum xor2( w0.Adder0.csa4x2_0_lvl1.11, PP_8_11, PP_9_11 )#5 xor2( sintcsa4x2_0_lvl1.11, w0.Adder0.csa4x2_0_lvl1.11, s0_lvl0_11 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.11, PP_8_11, PP_9_11 )#5 and2( w2.Adder0.csa4x2_0_lvl1.11, w0.Adder0.csa4x2_0_lvl1.11, s0_lvl0_11 )#5 or2( cout_csa4x2_0_lvl1.11, w1.Adder0.csa4x2_0_lvl1.11, w2.Adder0.csa4x2_0_lvl1.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.11( s0_lvl1_11, t0_lvl1_11, sintcsa4x2_0_lvl1.11, t0_lvl0_10, cout_csa4x2_0_lvl1.10) // sum xor2( w0.Adder1.csa4x2_0_lvl1.11, sintcsa4x2_0_lvl1.11, t0_lvl0_10 )#5 xor2( s0_lvl1_11, w0.Adder1.csa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.10 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.11, sintcsa4x2_0_lvl1.11, t0_lvl0_10 )#5 and2( w2.Adder1.csa4x2_0_lvl1.11, w0.Adder1.csa4x2_0_lvl1.11, cout_csa4x2_0_lvl1.10 )#5 or2( t0_lvl1_11, w1.Adder1.csa4x2_0_lvl1.11, w2.Adder1.csa4x2_0_lvl1.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.12, s0_lvl1_12,t0_lvl1_12,cout_csa4x2_0_lvl1.12,PP_8_12,PP_9_12,s0_lvl0_12,t0_lvl0_11,cout_csa4x2_0_lvl1.11) ; // adder1bit Adder0.csa4x2_0_lvl1.12( sintcsa4x2_0_lvl1.12, cout_csa4x2_0_lvl1.12, PP_8_12, PP_9_12, s0_lvl0_12) // sum xor2( w0.Adder0.csa4x2_0_lvl1.12, PP_8_12, PP_9_12 )#5 xor2( sintcsa4x2_0_lvl1.12, w0.Adder0.csa4x2_0_lvl1.12, s0_lvl0_12 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.12, PP_8_12, PP_9_12 )#5 and2( w2.Adder0.csa4x2_0_lvl1.12, w0.Adder0.csa4x2_0_lvl1.12, s0_lvl0_12 )#5 or2( cout_csa4x2_0_lvl1.12, w1.Adder0.csa4x2_0_lvl1.12, w2.Adder0.csa4x2_0_lvl1.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.12( s0_lvl1_12, t0_lvl1_12, sintcsa4x2_0_lvl1.12, t0_lvl0_11, cout_csa4x2_0_lvl1.11) // sum xor2( w0.Adder1.csa4x2_0_lvl1.12, sintcsa4x2_0_lvl1.12, t0_lvl0_11 )#5 xor2( s0_lvl1_12, w0.Adder1.csa4x2_0_lvl1.12, cout_csa4x2_0_lvl1.11 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.12, sintcsa4x2_0_lvl1.12, t0_lvl0_11 )#5 and2( w2.Adder1.csa4x2_0_lvl1.12, w0.Adder1.csa4x2_0_lvl1.12, cout_csa4x2_0_lvl1.11 )#5 or2( t0_lvl1_12, w1.Adder1.csa4x2_0_lvl1.12, w2.Adder1.csa4x2_0_lvl1.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.13, s0_lvl1_13,t0_lvl1_13,cout_csa4x2_0_lvl1.13,PP_8_13,PP_9_13,s0_lvl0_13,t0_lvl0_12,cout_csa4x2_0_lvl1.12) ; // adder1bit Adder0.csa4x2_0_lvl1.13( sintcsa4x2_0_lvl1.13, cout_csa4x2_0_lvl1.13, PP_8_13, PP_9_13, s0_lvl0_13) // sum xor2( w0.Adder0.csa4x2_0_lvl1.13, PP_8_13, PP_9_13 )#5 xor2( sintcsa4x2_0_lvl1.13, w0.Adder0.csa4x2_0_lvl1.13, s0_lvl0_13 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.13, PP_8_13, PP_9_13 )#5 and2( w2.Adder0.csa4x2_0_lvl1.13, w0.Adder0.csa4x2_0_lvl1.13, s0_lvl0_13 )#5 or2( cout_csa4x2_0_lvl1.13, w1.Adder0.csa4x2_0_lvl1.13, w2.Adder0.csa4x2_0_lvl1.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.13( s0_lvl1_13, t0_lvl1_13, sintcsa4x2_0_lvl1.13, t0_lvl0_12, cout_csa4x2_0_lvl1.12) // sum xor2( w0.Adder1.csa4x2_0_lvl1.13, sintcsa4x2_0_lvl1.13, t0_lvl0_12 )#5 xor2( s0_lvl1_13, w0.Adder1.csa4x2_0_lvl1.13, cout_csa4x2_0_lvl1.12 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.13, sintcsa4x2_0_lvl1.13, t0_lvl0_12 )#5 and2( w2.Adder1.csa4x2_0_lvl1.13, w0.Adder1.csa4x2_0_lvl1.13, cout_csa4x2_0_lvl1.12 )#5 or2( t0_lvl1_13, w1.Adder1.csa4x2_0_lvl1.13, w2.Adder1.csa4x2_0_lvl1.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.14, s0_lvl1_14,t0_lvl1_14,cout_csa4x2_0_lvl1.14,PP_8_14,PP_9_14,s0_lvl0_14,t0_lvl0_13,cout_csa4x2_0_lvl1.13) ; // adder1bit Adder0.csa4x2_0_lvl1.14( sintcsa4x2_0_lvl1.14, cout_csa4x2_0_lvl1.14, PP_8_14, PP_9_14, s0_lvl0_14) // sum xor2( w0.Adder0.csa4x2_0_lvl1.14, PP_8_14, PP_9_14 )#5 xor2( sintcsa4x2_0_lvl1.14, w0.Adder0.csa4x2_0_lvl1.14, s0_lvl0_14 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.14, PP_8_14, PP_9_14 )#5 and2( w2.Adder0.csa4x2_0_lvl1.14, w0.Adder0.csa4x2_0_lvl1.14, s0_lvl0_14 )#5 or2( cout_csa4x2_0_lvl1.14, w1.Adder0.csa4x2_0_lvl1.14, w2.Adder0.csa4x2_0_lvl1.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.14( s0_lvl1_14, t0_lvl1_14, sintcsa4x2_0_lvl1.14, t0_lvl0_13, cout_csa4x2_0_lvl1.13) // sum xor2( w0.Adder1.csa4x2_0_lvl1.14, sintcsa4x2_0_lvl1.14, t0_lvl0_13 )#5 xor2( s0_lvl1_14, w0.Adder1.csa4x2_0_lvl1.14, cout_csa4x2_0_lvl1.13 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.14, sintcsa4x2_0_lvl1.14, t0_lvl0_13 )#5 and2( w2.Adder1.csa4x2_0_lvl1.14, w0.Adder1.csa4x2_0_lvl1.14, cout_csa4x2_0_lvl1.13 )#5 or2( t0_lvl1_14, w1.Adder1.csa4x2_0_lvl1.14, w2.Adder1.csa4x2_0_lvl1.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.15, s0_lvl1_15,t0_lvl1_15,cout_csa4x2_0_lvl1.15,PP_8_15,PP_9_15,s0_lvl0_15,t0_lvl0_14,cout_csa4x2_0_lvl1.14) ; // adder1bit Adder0.csa4x2_0_lvl1.15( sintcsa4x2_0_lvl1.15, cout_csa4x2_0_lvl1.15, PP_8_15, PP_9_15, s0_lvl0_15) // sum xor2( w0.Adder0.csa4x2_0_lvl1.15, PP_8_15, PP_9_15 )#5 xor2( sintcsa4x2_0_lvl1.15, w0.Adder0.csa4x2_0_lvl1.15, s0_lvl0_15 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.15, PP_8_15, PP_9_15 )#5 and2( w2.Adder0.csa4x2_0_lvl1.15, w0.Adder0.csa4x2_0_lvl1.15, s0_lvl0_15 )#5 or2( cout_csa4x2_0_lvl1.15, w1.Adder0.csa4x2_0_lvl1.15, w2.Adder0.csa4x2_0_lvl1.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.15( s0_lvl1_15, t0_lvl1_15, sintcsa4x2_0_lvl1.15, t0_lvl0_14, cout_csa4x2_0_lvl1.14) // sum xor2( w0.Adder1.csa4x2_0_lvl1.15, sintcsa4x2_0_lvl1.15, t0_lvl0_14 )#5 xor2( s0_lvl1_15, w0.Adder1.csa4x2_0_lvl1.15, cout_csa4x2_0_lvl1.14 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.15, sintcsa4x2_0_lvl1.15, t0_lvl0_14 )#5 and2( w2.Adder1.csa4x2_0_lvl1.15, w0.Adder1.csa4x2_0_lvl1.15, cout_csa4x2_0_lvl1.14 )#5 or2( t0_lvl1_15, w1.Adder1.csa4x2_0_lvl1.15, w2.Adder1.csa4x2_0_lvl1.15 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.16, s0_lvl1_16,t0_lvl1_16,cout_csa4x2_0_lvl1.16,PP_8_16,PP_9_16,s0_lvl0_16,t0_lvl0_15,cout_csa4x2_0_lvl1.15) ; // adder1bit Adder0.csa4x2_0_lvl1.16( sintcsa4x2_0_lvl1.16, cout_csa4x2_0_lvl1.16, PP_8_16, PP_9_16, s0_lvl0_16) // sum xor2( w0.Adder0.csa4x2_0_lvl1.16, PP_8_16, PP_9_16 )#5 xor2( sintcsa4x2_0_lvl1.16, w0.Adder0.csa4x2_0_lvl1.16, s0_lvl0_16 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.16, PP_8_16, PP_9_16 )#5 and2( w2.Adder0.csa4x2_0_lvl1.16, w0.Adder0.csa4x2_0_lvl1.16, s0_lvl0_16 )#5 or2( cout_csa4x2_0_lvl1.16, w1.Adder0.csa4x2_0_lvl1.16, w2.Adder0.csa4x2_0_lvl1.16 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.16( s0_lvl1_16, t0_lvl1_16, sintcsa4x2_0_lvl1.16, t0_lvl0_15, cout_csa4x2_0_lvl1.15) // sum xor2( w0.Adder1.csa4x2_0_lvl1.16, sintcsa4x2_0_lvl1.16, t0_lvl0_15 )#5 xor2( s0_lvl1_16, w0.Adder1.csa4x2_0_lvl1.16, cout_csa4x2_0_lvl1.15 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.16, sintcsa4x2_0_lvl1.16, t0_lvl0_15 )#5 and2( w2.Adder1.csa4x2_0_lvl1.16, w0.Adder1.csa4x2_0_lvl1.16, cout_csa4x2_0_lvl1.15 )#5 or2( t0_lvl1_16, w1.Adder1.csa4x2_0_lvl1.16, w2.Adder1.csa4x2_0_lvl1.16 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.17, s0_lvl1_17,t0_lvl1_17,cout_csa4x2_0_lvl1.17,PP_8_17,PP_9_17,s0_lvl0_17,t0_lvl0_16,cout_csa4x2_0_lvl1.16) ; // adder1bit Adder0.csa4x2_0_lvl1.17( sintcsa4x2_0_lvl1.17, cout_csa4x2_0_lvl1.17, PP_8_17, PP_9_17, s0_lvl0_17) // sum xor2( w0.Adder0.csa4x2_0_lvl1.17, PP_8_17, PP_9_17 )#5 xor2( sintcsa4x2_0_lvl1.17, w0.Adder0.csa4x2_0_lvl1.17, s0_lvl0_17 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.17, PP_8_17, PP_9_17 )#5 and2( w2.Adder0.csa4x2_0_lvl1.17, w0.Adder0.csa4x2_0_lvl1.17, s0_lvl0_17 )#5 or2( cout_csa4x2_0_lvl1.17, w1.Adder0.csa4x2_0_lvl1.17, w2.Adder0.csa4x2_0_lvl1.17 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.17( s0_lvl1_17, t0_lvl1_17, sintcsa4x2_0_lvl1.17, t0_lvl0_16, cout_csa4x2_0_lvl1.16) // sum xor2( w0.Adder1.csa4x2_0_lvl1.17, sintcsa4x2_0_lvl1.17, t0_lvl0_16 )#5 xor2( s0_lvl1_17, w0.Adder1.csa4x2_0_lvl1.17, cout_csa4x2_0_lvl1.16 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.17, sintcsa4x2_0_lvl1.17, t0_lvl0_16 )#5 and2( w2.Adder1.csa4x2_0_lvl1.17, w0.Adder1.csa4x2_0_lvl1.17, cout_csa4x2_0_lvl1.16 )#5 or2( t0_lvl1_17, w1.Adder1.csa4x2_0_lvl1.17, w2.Adder1.csa4x2_0_lvl1.17 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.18, s0_lvl1_18,t0_lvl1_18,cout_csa4x2_0_lvl1.18,PP_8_18,PP_9_18,s0_lvl0_18,t0_lvl0_17,cout_csa4x2_0_lvl1.17) ; // adder1bit Adder0.csa4x2_0_lvl1.18( sintcsa4x2_0_lvl1.18, cout_csa4x2_0_lvl1.18, PP_8_18, PP_9_18, s0_lvl0_18) // sum xor2( w0.Adder0.csa4x2_0_lvl1.18, PP_8_18, PP_9_18 )#5 xor2( sintcsa4x2_0_lvl1.18, w0.Adder0.csa4x2_0_lvl1.18, s0_lvl0_18 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.18, PP_8_18, PP_9_18 )#5 and2( w2.Adder0.csa4x2_0_lvl1.18, w0.Adder0.csa4x2_0_lvl1.18, s0_lvl0_18 )#5 or2( cout_csa4x2_0_lvl1.18, w1.Adder0.csa4x2_0_lvl1.18, w2.Adder0.csa4x2_0_lvl1.18 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.18( s0_lvl1_18, t0_lvl1_18, sintcsa4x2_0_lvl1.18, t0_lvl0_17, cout_csa4x2_0_lvl1.17) // sum xor2( w0.Adder1.csa4x2_0_lvl1.18, sintcsa4x2_0_lvl1.18, t0_lvl0_17 )#5 xor2( s0_lvl1_18, w0.Adder1.csa4x2_0_lvl1.18, cout_csa4x2_0_lvl1.17 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.18, sintcsa4x2_0_lvl1.18, t0_lvl0_17 )#5 and2( w2.Adder1.csa4x2_0_lvl1.18, w0.Adder1.csa4x2_0_lvl1.18, cout_csa4x2_0_lvl1.17 )#5 or2( t0_lvl1_18, w1.Adder1.csa4x2_0_lvl1.18, w2.Adder1.csa4x2_0_lvl1.18 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl1.19, s0_lvl1_19,t0_lvl1_19,cout_csa4x2_0_lvl1.19,PP_8_19,PP_9_19,s0_lvl0_19,t0_lvl0_18,cout_csa4x2_0_lvl1.18) ; // adder1bit Adder0.csa4x2_0_lvl1.19( sintcsa4x2_0_lvl1.19, cout_csa4x2_0_lvl1.19, PP_8_19, PP_9_19, s0_lvl0_19) // sum xor2( w0.Adder0.csa4x2_0_lvl1.19, PP_8_19, PP_9_19 )#5 xor2( sintcsa4x2_0_lvl1.19, w0.Adder0.csa4x2_0_lvl1.19, s0_lvl0_19 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl1.19, PP_8_19, PP_9_19 )#5 and2( w2.Adder0.csa4x2_0_lvl1.19, w0.Adder0.csa4x2_0_lvl1.19, s0_lvl0_19 )#5 or2( cout_csa4x2_0_lvl1.19, w1.Adder0.csa4x2_0_lvl1.19, w2.Adder0.csa4x2_0_lvl1.19 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl1.19( s0_lvl1_19, t0_lvl1_19, sintcsa4x2_0_lvl1.19, t0_lvl0_18, cout_csa4x2_0_lvl1.18) // sum xor2( w0.Adder1.csa4x2_0_lvl1.19, sintcsa4x2_0_lvl1.19, t0_lvl0_18 )#5 xor2( s0_lvl1_19, w0.Adder1.csa4x2_0_lvl1.19, cout_csa4x2_0_lvl1.18 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl1.19, sintcsa4x2_0_lvl1.19, t0_lvl0_18 )#5 and2( w2.Adder1.csa4x2_0_lvl1.19, w0.Adder1.csa4x2_0_lvl1.19, cout_csa4x2_0_lvl1.18 )#5 or2( t0_lvl1_19, w1.Adder1.csa4x2_0_lvl1.19, w2.Adder1.csa4x2_0_lvl1.19 )#5 // end adder1bit // end csa4x2 end // instantiating csa4x2Vec at lvl 2 netlist // csa4x2 (csa4x2_0_lvl2.0, s0_lvl2_0,t0_lvl2_0,cout_csa4x2_0_lvl2.0,s4_lvl0_0,GND,s0_lvl1_0,GND,GND) ; // adder1bit Adder0.csa4x2_0_lvl2.0( sintcsa4x2_0_lvl2.0, cout_csa4x2_0_lvl2.0, s4_lvl0_0, GND, s0_lvl1_0) // sum xor2( w0.Adder0.csa4x2_0_lvl2.0, s4_lvl0_0, GND )#5 xor2( sintcsa4x2_0_lvl2.0, w0.Adder0.csa4x2_0_lvl2.0, s0_lvl1_0 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.0, s4_lvl0_0, GND )#5 and2( w2.Adder0.csa4x2_0_lvl2.0, w0.Adder0.csa4x2_0_lvl2.0, s0_lvl1_0 )#5 or2( cout_csa4x2_0_lvl2.0, w1.Adder0.csa4x2_0_lvl2.0, w2.Adder0.csa4x2_0_lvl2.0 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.0( s0_lvl2_0, t0_lvl2_0, sintcsa4x2_0_lvl2.0, GND, GND) // sum xor2( w0.Adder1.csa4x2_0_lvl2.0, sintcsa4x2_0_lvl2.0, GND )#5 xor2( s0_lvl2_0, w0.Adder1.csa4x2_0_lvl2.0, GND )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.0, sintcsa4x2_0_lvl2.0, GND )#5 and2( w2.Adder1.csa4x2_0_lvl2.0, w0.Adder1.csa4x2_0_lvl2.0, GND )#5 or2( t0_lvl2_0, w1.Adder1.csa4x2_0_lvl2.0, w2.Adder1.csa4x2_0_lvl2.0 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.1, s0_lvl2_1,t0_lvl2_1,cout_csa4x2_0_lvl2.1,s4_lvl0_1,t4_lvl0_0,s0_lvl1_1,t0_lvl1_0,cout_csa4x2_0_lvl2.0) ; // adder1bit Adder0.csa4x2_0_lvl2.1( sintcsa4x2_0_lvl2.1, cout_csa4x2_0_lvl2.1, s4_lvl0_1, t4_lvl0_0, s0_lvl1_1) // sum xor2( w0.Adder0.csa4x2_0_lvl2.1, s4_lvl0_1, t4_lvl0_0 )#5 xor2( sintcsa4x2_0_lvl2.1, w0.Adder0.csa4x2_0_lvl2.1, s0_lvl1_1 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.1, s4_lvl0_1, t4_lvl0_0 )#5 and2( w2.Adder0.csa4x2_0_lvl2.1, w0.Adder0.csa4x2_0_lvl2.1, s0_lvl1_1 )#5 or2( cout_csa4x2_0_lvl2.1, w1.Adder0.csa4x2_0_lvl2.1, w2.Adder0.csa4x2_0_lvl2.1 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.1( s0_lvl2_1, t0_lvl2_1, sintcsa4x2_0_lvl2.1, t0_lvl1_0, cout_csa4x2_0_lvl2.0) // sum xor2( w0.Adder1.csa4x2_0_lvl2.1, sintcsa4x2_0_lvl2.1, t0_lvl1_0 )#5 xor2( s0_lvl2_1, w0.Adder1.csa4x2_0_lvl2.1, cout_csa4x2_0_lvl2.0 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.1, sintcsa4x2_0_lvl2.1, t0_lvl1_0 )#5 and2( w2.Adder1.csa4x2_0_lvl2.1, w0.Adder1.csa4x2_0_lvl2.1, cout_csa4x2_0_lvl2.0 )#5 or2( t0_lvl2_1, w1.Adder1.csa4x2_0_lvl2.1, w2.Adder1.csa4x2_0_lvl2.1 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.2, s0_lvl2_2,t0_lvl2_2,cout_csa4x2_0_lvl2.2,s4_lvl0_2,t4_lvl0_1,s0_lvl1_2,t0_lvl1_1,cout_csa4x2_0_lvl2.1) ; // adder1bit Adder0.csa4x2_0_lvl2.2( sintcsa4x2_0_lvl2.2, cout_csa4x2_0_lvl2.2, s4_lvl0_2, t4_lvl0_1, s0_lvl1_2) // sum xor2( w0.Adder0.csa4x2_0_lvl2.2, s4_lvl0_2, t4_lvl0_1 )#5 xor2( sintcsa4x2_0_lvl2.2, w0.Adder0.csa4x2_0_lvl2.2, s0_lvl1_2 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.2, s4_lvl0_2, t4_lvl0_1 )#5 and2( w2.Adder0.csa4x2_0_lvl2.2, w0.Adder0.csa4x2_0_lvl2.2, s0_lvl1_2 )#5 or2( cout_csa4x2_0_lvl2.2, w1.Adder0.csa4x2_0_lvl2.2, w2.Adder0.csa4x2_0_lvl2.2 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.2( s0_lvl2_2, t0_lvl2_2, sintcsa4x2_0_lvl2.2, t0_lvl1_1, cout_csa4x2_0_lvl2.1) // sum xor2( w0.Adder1.csa4x2_0_lvl2.2, sintcsa4x2_0_lvl2.2, t0_lvl1_1 )#5 xor2( s0_lvl2_2, w0.Adder1.csa4x2_0_lvl2.2, cout_csa4x2_0_lvl2.1 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.2, sintcsa4x2_0_lvl2.2, t0_lvl1_1 )#5 and2( w2.Adder1.csa4x2_0_lvl2.2, w0.Adder1.csa4x2_0_lvl2.2, cout_csa4x2_0_lvl2.1 )#5 or2( t0_lvl2_2, w1.Adder1.csa4x2_0_lvl2.2, w2.Adder1.csa4x2_0_lvl2.2 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.3, s0_lvl2_3,t0_lvl2_3,cout_csa4x2_0_lvl2.3,s4_lvl0_3,t4_lvl0_2,s0_lvl1_3,t0_lvl1_2,cout_csa4x2_0_lvl2.2) ; // adder1bit Adder0.csa4x2_0_lvl2.3( sintcsa4x2_0_lvl2.3, cout_csa4x2_0_lvl2.3, s4_lvl0_3, t4_lvl0_2, s0_lvl1_3) // sum xor2( w0.Adder0.csa4x2_0_lvl2.3, s4_lvl0_3, t4_lvl0_2 )#5 xor2( sintcsa4x2_0_lvl2.3, w0.Adder0.csa4x2_0_lvl2.3, s0_lvl1_3 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.3, s4_lvl0_3, t4_lvl0_2 )#5 and2( w2.Adder0.csa4x2_0_lvl2.3, w0.Adder0.csa4x2_0_lvl2.3, s0_lvl1_3 )#5 or2( cout_csa4x2_0_lvl2.3, w1.Adder0.csa4x2_0_lvl2.3, w2.Adder0.csa4x2_0_lvl2.3 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.3( s0_lvl2_3, t0_lvl2_3, sintcsa4x2_0_lvl2.3, t0_lvl1_2, cout_csa4x2_0_lvl2.2) // sum xor2( w0.Adder1.csa4x2_0_lvl2.3, sintcsa4x2_0_lvl2.3, t0_lvl1_2 )#5 xor2( s0_lvl2_3, w0.Adder1.csa4x2_0_lvl2.3, cout_csa4x2_0_lvl2.2 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.3, sintcsa4x2_0_lvl2.3, t0_lvl1_2 )#5 and2( w2.Adder1.csa4x2_0_lvl2.3, w0.Adder1.csa4x2_0_lvl2.3, cout_csa4x2_0_lvl2.2 )#5 or2( t0_lvl2_3, w1.Adder1.csa4x2_0_lvl2.3, w2.Adder1.csa4x2_0_lvl2.3 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.4, s0_lvl2_4,t0_lvl2_4,cout_csa4x2_0_lvl2.4,s4_lvl0_4,t4_lvl0_3,s0_lvl1_4,t0_lvl1_3,cout_csa4x2_0_lvl2.3) ; // adder1bit Adder0.csa4x2_0_lvl2.4( sintcsa4x2_0_lvl2.4, cout_csa4x2_0_lvl2.4, s4_lvl0_4, t4_lvl0_3, s0_lvl1_4) // sum xor2( w0.Adder0.csa4x2_0_lvl2.4, s4_lvl0_4, t4_lvl0_3 )#5 xor2( sintcsa4x2_0_lvl2.4, w0.Adder0.csa4x2_0_lvl2.4, s0_lvl1_4 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.4, s4_lvl0_4, t4_lvl0_3 )#5 and2( w2.Adder0.csa4x2_0_lvl2.4, w0.Adder0.csa4x2_0_lvl2.4, s0_lvl1_4 )#5 or2( cout_csa4x2_0_lvl2.4, w1.Adder0.csa4x2_0_lvl2.4, w2.Adder0.csa4x2_0_lvl2.4 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.4( s0_lvl2_4, t0_lvl2_4, sintcsa4x2_0_lvl2.4, t0_lvl1_3, cout_csa4x2_0_lvl2.3) // sum xor2( w0.Adder1.csa4x2_0_lvl2.4, sintcsa4x2_0_lvl2.4, t0_lvl1_3 )#5 xor2( s0_lvl2_4, w0.Adder1.csa4x2_0_lvl2.4, cout_csa4x2_0_lvl2.3 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.4, sintcsa4x2_0_lvl2.4, t0_lvl1_3 )#5 and2( w2.Adder1.csa4x2_0_lvl2.4, w0.Adder1.csa4x2_0_lvl2.4, cout_csa4x2_0_lvl2.3 )#5 or2( t0_lvl2_4, w1.Adder1.csa4x2_0_lvl2.4, w2.Adder1.csa4x2_0_lvl2.4 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.5, s0_lvl2_5,t0_lvl2_5,cout_csa4x2_0_lvl2.5,s4_lvl0_5,t4_lvl0_4,s0_lvl1_5,t0_lvl1_4,cout_csa4x2_0_lvl2.4) ; // adder1bit Adder0.csa4x2_0_lvl2.5( sintcsa4x2_0_lvl2.5, cout_csa4x2_0_lvl2.5, s4_lvl0_5, t4_lvl0_4, s0_lvl1_5) // sum xor2( w0.Adder0.csa4x2_0_lvl2.5, s4_lvl0_5, t4_lvl0_4 )#5 xor2( sintcsa4x2_0_lvl2.5, w0.Adder0.csa4x2_0_lvl2.5, s0_lvl1_5 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.5, s4_lvl0_5, t4_lvl0_4 )#5 and2( w2.Adder0.csa4x2_0_lvl2.5, w0.Adder0.csa4x2_0_lvl2.5, s0_lvl1_5 )#5 or2( cout_csa4x2_0_lvl2.5, w1.Adder0.csa4x2_0_lvl2.5, w2.Adder0.csa4x2_0_lvl2.5 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.5( s0_lvl2_5, t0_lvl2_5, sintcsa4x2_0_lvl2.5, t0_lvl1_4, cout_csa4x2_0_lvl2.4) // sum xor2( w0.Adder1.csa4x2_0_lvl2.5, sintcsa4x2_0_lvl2.5, t0_lvl1_4 )#5 xor2( s0_lvl2_5, w0.Adder1.csa4x2_0_lvl2.5, cout_csa4x2_0_lvl2.4 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.5, sintcsa4x2_0_lvl2.5, t0_lvl1_4 )#5 and2( w2.Adder1.csa4x2_0_lvl2.5, w0.Adder1.csa4x2_0_lvl2.5, cout_csa4x2_0_lvl2.4 )#5 or2( t0_lvl2_5, w1.Adder1.csa4x2_0_lvl2.5, w2.Adder1.csa4x2_0_lvl2.5 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.6, s0_lvl2_6,t0_lvl2_6,cout_csa4x2_0_lvl2.6,s4_lvl0_6,t4_lvl0_5,s0_lvl1_6,t0_lvl1_5,cout_csa4x2_0_lvl2.5) ; // adder1bit Adder0.csa4x2_0_lvl2.6( sintcsa4x2_0_lvl2.6, cout_csa4x2_0_lvl2.6, s4_lvl0_6, t4_lvl0_5, s0_lvl1_6) // sum xor2( w0.Adder0.csa4x2_0_lvl2.6, s4_lvl0_6, t4_lvl0_5 )#5 xor2( sintcsa4x2_0_lvl2.6, w0.Adder0.csa4x2_0_lvl2.6, s0_lvl1_6 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.6, s4_lvl0_6, t4_lvl0_5 )#5 and2( w2.Adder0.csa4x2_0_lvl2.6, w0.Adder0.csa4x2_0_lvl2.6, s0_lvl1_6 )#5 or2( cout_csa4x2_0_lvl2.6, w1.Adder0.csa4x2_0_lvl2.6, w2.Adder0.csa4x2_0_lvl2.6 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.6( s0_lvl2_6, t0_lvl2_6, sintcsa4x2_0_lvl2.6, t0_lvl1_5, cout_csa4x2_0_lvl2.5) // sum xor2( w0.Adder1.csa4x2_0_lvl2.6, sintcsa4x2_0_lvl2.6, t0_lvl1_5 )#5 xor2( s0_lvl2_6, w0.Adder1.csa4x2_0_lvl2.6, cout_csa4x2_0_lvl2.5 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.6, sintcsa4x2_0_lvl2.6, t0_lvl1_5 )#5 and2( w2.Adder1.csa4x2_0_lvl2.6, w0.Adder1.csa4x2_0_lvl2.6, cout_csa4x2_0_lvl2.5 )#5 or2( t0_lvl2_6, w1.Adder1.csa4x2_0_lvl2.6, w2.Adder1.csa4x2_0_lvl2.6 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.7, s0_lvl2_7,t0_lvl2_7,cout_csa4x2_0_lvl2.7,s4_lvl0_7,t4_lvl0_6,s0_lvl1_7,t0_lvl1_6,cout_csa4x2_0_lvl2.6) ; // adder1bit Adder0.csa4x2_0_lvl2.7( sintcsa4x2_0_lvl2.7, cout_csa4x2_0_lvl2.7, s4_lvl0_7, t4_lvl0_6, s0_lvl1_7) // sum xor2( w0.Adder0.csa4x2_0_lvl2.7, s4_lvl0_7, t4_lvl0_6 )#5 xor2( sintcsa4x2_0_lvl2.7, w0.Adder0.csa4x2_0_lvl2.7, s0_lvl1_7 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.7, s4_lvl0_7, t4_lvl0_6 )#5 and2( w2.Adder0.csa4x2_0_lvl2.7, w0.Adder0.csa4x2_0_lvl2.7, s0_lvl1_7 )#5 or2( cout_csa4x2_0_lvl2.7, w1.Adder0.csa4x2_0_lvl2.7, w2.Adder0.csa4x2_0_lvl2.7 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.7( s0_lvl2_7, t0_lvl2_7, sintcsa4x2_0_lvl2.7, t0_lvl1_6, cout_csa4x2_0_lvl2.6) // sum xor2( w0.Adder1.csa4x2_0_lvl2.7, sintcsa4x2_0_lvl2.7, t0_lvl1_6 )#5 xor2( s0_lvl2_7, w0.Adder1.csa4x2_0_lvl2.7, cout_csa4x2_0_lvl2.6 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.7, sintcsa4x2_0_lvl2.7, t0_lvl1_6 )#5 and2( w2.Adder1.csa4x2_0_lvl2.7, w0.Adder1.csa4x2_0_lvl2.7, cout_csa4x2_0_lvl2.6 )#5 or2( t0_lvl2_7, w1.Adder1.csa4x2_0_lvl2.7, w2.Adder1.csa4x2_0_lvl2.7 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.8, s0_lvl2_8,t0_lvl2_8,cout_csa4x2_0_lvl2.8,s4_lvl0_8,t4_lvl0_7,s0_lvl1_8,t0_lvl1_7,cout_csa4x2_0_lvl2.7) ; // adder1bit Adder0.csa4x2_0_lvl2.8( sintcsa4x2_0_lvl2.8, cout_csa4x2_0_lvl2.8, s4_lvl0_8, t4_lvl0_7, s0_lvl1_8) // sum xor2( w0.Adder0.csa4x2_0_lvl2.8, s4_lvl0_8, t4_lvl0_7 )#5 xor2( sintcsa4x2_0_lvl2.8, w0.Adder0.csa4x2_0_lvl2.8, s0_lvl1_8 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.8, s4_lvl0_8, t4_lvl0_7 )#5 and2( w2.Adder0.csa4x2_0_lvl2.8, w0.Adder0.csa4x2_0_lvl2.8, s0_lvl1_8 )#5 or2( cout_csa4x2_0_lvl2.8, w1.Adder0.csa4x2_0_lvl2.8, w2.Adder0.csa4x2_0_lvl2.8 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.8( s0_lvl2_8, t0_lvl2_8, sintcsa4x2_0_lvl2.8, t0_lvl1_7, cout_csa4x2_0_lvl2.7) // sum xor2( w0.Adder1.csa4x2_0_lvl2.8, sintcsa4x2_0_lvl2.8, t0_lvl1_7 )#5 xor2( s0_lvl2_8, w0.Adder1.csa4x2_0_lvl2.8, cout_csa4x2_0_lvl2.7 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.8, sintcsa4x2_0_lvl2.8, t0_lvl1_7 )#5 and2( w2.Adder1.csa4x2_0_lvl2.8, w0.Adder1.csa4x2_0_lvl2.8, cout_csa4x2_0_lvl2.7 )#5 or2( t0_lvl2_8, w1.Adder1.csa4x2_0_lvl2.8, w2.Adder1.csa4x2_0_lvl2.8 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.9, s0_lvl2_9,t0_lvl2_9,cout_csa4x2_0_lvl2.9,s4_lvl0_9,t4_lvl0_8,s0_lvl1_9,t0_lvl1_8,cout_csa4x2_0_lvl2.8) ; // adder1bit Adder0.csa4x2_0_lvl2.9( sintcsa4x2_0_lvl2.9, cout_csa4x2_0_lvl2.9, s4_lvl0_9, t4_lvl0_8, s0_lvl1_9) // sum xor2( w0.Adder0.csa4x2_0_lvl2.9, s4_lvl0_9, t4_lvl0_8 )#5 xor2( sintcsa4x2_0_lvl2.9, w0.Adder0.csa4x2_0_lvl2.9, s0_lvl1_9 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.9, s4_lvl0_9, t4_lvl0_8 )#5 and2( w2.Adder0.csa4x2_0_lvl2.9, w0.Adder0.csa4x2_0_lvl2.9, s0_lvl1_9 )#5 or2( cout_csa4x2_0_lvl2.9, w1.Adder0.csa4x2_0_lvl2.9, w2.Adder0.csa4x2_0_lvl2.9 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.9( s0_lvl2_9, t0_lvl2_9, sintcsa4x2_0_lvl2.9, t0_lvl1_8, cout_csa4x2_0_lvl2.8) // sum xor2( w0.Adder1.csa4x2_0_lvl2.9, sintcsa4x2_0_lvl2.9, t0_lvl1_8 )#5 xor2( s0_lvl2_9, w0.Adder1.csa4x2_0_lvl2.9, cout_csa4x2_0_lvl2.8 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.9, sintcsa4x2_0_lvl2.9, t0_lvl1_8 )#5 and2( w2.Adder1.csa4x2_0_lvl2.9, w0.Adder1.csa4x2_0_lvl2.9, cout_csa4x2_0_lvl2.8 )#5 or2( t0_lvl2_9, w1.Adder1.csa4x2_0_lvl2.9, w2.Adder1.csa4x2_0_lvl2.9 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.10, s0_lvl2_10,t0_lvl2_10,cout_csa4x2_0_lvl2.10,s4_lvl0_10,t4_lvl0_9,s0_lvl1_10,t0_lvl1_9,cout_csa4x2_0_lvl2.9) ; // adder1bit Adder0.csa4x2_0_lvl2.10( sintcsa4x2_0_lvl2.10, cout_csa4x2_0_lvl2.10, s4_lvl0_10, t4_lvl0_9, s0_lvl1_10) // sum xor2( w0.Adder0.csa4x2_0_lvl2.10, s4_lvl0_10, t4_lvl0_9 )#5 xor2( sintcsa4x2_0_lvl2.10, w0.Adder0.csa4x2_0_lvl2.10, s0_lvl1_10 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.10, s4_lvl0_10, t4_lvl0_9 )#5 and2( w2.Adder0.csa4x2_0_lvl2.10, w0.Adder0.csa4x2_0_lvl2.10, s0_lvl1_10 )#5 or2( cout_csa4x2_0_lvl2.10, w1.Adder0.csa4x2_0_lvl2.10, w2.Adder0.csa4x2_0_lvl2.10 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.10( s0_lvl2_10, t0_lvl2_10, sintcsa4x2_0_lvl2.10, t0_lvl1_9, cout_csa4x2_0_lvl2.9) // sum xor2( w0.Adder1.csa4x2_0_lvl2.10, sintcsa4x2_0_lvl2.10, t0_lvl1_9 )#5 xor2( s0_lvl2_10, w0.Adder1.csa4x2_0_lvl2.10, cout_csa4x2_0_lvl2.9 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.10, sintcsa4x2_0_lvl2.10, t0_lvl1_9 )#5 and2( w2.Adder1.csa4x2_0_lvl2.10, w0.Adder1.csa4x2_0_lvl2.10, cout_csa4x2_0_lvl2.9 )#5 or2( t0_lvl2_10, w1.Adder1.csa4x2_0_lvl2.10, w2.Adder1.csa4x2_0_lvl2.10 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.11, s0_lvl2_11,t0_lvl2_11,cout_csa4x2_0_lvl2.11,s4_lvl0_11,t4_lvl0_10,s0_lvl1_11,t0_lvl1_10,cout_csa4x2_0_lvl2.10) ; // adder1bit Adder0.csa4x2_0_lvl2.11( sintcsa4x2_0_lvl2.11, cout_csa4x2_0_lvl2.11, s4_lvl0_11, t4_lvl0_10, s0_lvl1_11) // sum xor2( w0.Adder0.csa4x2_0_lvl2.11, s4_lvl0_11, t4_lvl0_10 )#5 xor2( sintcsa4x2_0_lvl2.11, w0.Adder0.csa4x2_0_lvl2.11, s0_lvl1_11 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.11, s4_lvl0_11, t4_lvl0_10 )#5 and2( w2.Adder0.csa4x2_0_lvl2.11, w0.Adder0.csa4x2_0_lvl2.11, s0_lvl1_11 )#5 or2( cout_csa4x2_0_lvl2.11, w1.Adder0.csa4x2_0_lvl2.11, w2.Adder0.csa4x2_0_lvl2.11 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.11( s0_lvl2_11, t0_lvl2_11, sintcsa4x2_0_lvl2.11, t0_lvl1_10, cout_csa4x2_0_lvl2.10) // sum xor2( w0.Adder1.csa4x2_0_lvl2.11, sintcsa4x2_0_lvl2.11, t0_lvl1_10 )#5 xor2( s0_lvl2_11, w0.Adder1.csa4x2_0_lvl2.11, cout_csa4x2_0_lvl2.10 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.11, sintcsa4x2_0_lvl2.11, t0_lvl1_10 )#5 and2( w2.Adder1.csa4x2_0_lvl2.11, w0.Adder1.csa4x2_0_lvl2.11, cout_csa4x2_0_lvl2.10 )#5 or2( t0_lvl2_11, w1.Adder1.csa4x2_0_lvl2.11, w2.Adder1.csa4x2_0_lvl2.11 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.12, s0_lvl2_12,t0_lvl2_12,cout_csa4x2_0_lvl2.12,s4_lvl0_12,t4_lvl0_11,s0_lvl1_12,t0_lvl1_11,cout_csa4x2_0_lvl2.11) ; // adder1bit Adder0.csa4x2_0_lvl2.12( sintcsa4x2_0_lvl2.12, cout_csa4x2_0_lvl2.12, s4_lvl0_12, t4_lvl0_11, s0_lvl1_12) // sum xor2( w0.Adder0.csa4x2_0_lvl2.12, s4_lvl0_12, t4_lvl0_11 )#5 xor2( sintcsa4x2_0_lvl2.12, w0.Adder0.csa4x2_0_lvl2.12, s0_lvl1_12 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.12, s4_lvl0_12, t4_lvl0_11 )#5 and2( w2.Adder0.csa4x2_0_lvl2.12, w0.Adder0.csa4x2_0_lvl2.12, s0_lvl1_12 )#5 or2( cout_csa4x2_0_lvl2.12, w1.Adder0.csa4x2_0_lvl2.12, w2.Adder0.csa4x2_0_lvl2.12 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.12( s0_lvl2_12, t0_lvl2_12, sintcsa4x2_0_lvl2.12, t0_lvl1_11, cout_csa4x2_0_lvl2.11) // sum xor2( w0.Adder1.csa4x2_0_lvl2.12, sintcsa4x2_0_lvl2.12, t0_lvl1_11 )#5 xor2( s0_lvl2_12, w0.Adder1.csa4x2_0_lvl2.12, cout_csa4x2_0_lvl2.11 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.12, sintcsa4x2_0_lvl2.12, t0_lvl1_11 )#5 and2( w2.Adder1.csa4x2_0_lvl2.12, w0.Adder1.csa4x2_0_lvl2.12, cout_csa4x2_0_lvl2.11 )#5 or2( t0_lvl2_12, w1.Adder1.csa4x2_0_lvl2.12, w2.Adder1.csa4x2_0_lvl2.12 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.13, s0_lvl2_13,t0_lvl2_13,cout_csa4x2_0_lvl2.13,s4_lvl0_13,t4_lvl0_12,s0_lvl1_13,t0_lvl1_12,cout_csa4x2_0_lvl2.12) ; // adder1bit Adder0.csa4x2_0_lvl2.13( sintcsa4x2_0_lvl2.13, cout_csa4x2_0_lvl2.13, s4_lvl0_13, t4_lvl0_12, s0_lvl1_13) // sum xor2( w0.Adder0.csa4x2_0_lvl2.13, s4_lvl0_13, t4_lvl0_12 )#5 xor2( sintcsa4x2_0_lvl2.13, w0.Adder0.csa4x2_0_lvl2.13, s0_lvl1_13 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.13, s4_lvl0_13, t4_lvl0_12 )#5 and2( w2.Adder0.csa4x2_0_lvl2.13, w0.Adder0.csa4x2_0_lvl2.13, s0_lvl1_13 )#5 or2( cout_csa4x2_0_lvl2.13, w1.Adder0.csa4x2_0_lvl2.13, w2.Adder0.csa4x2_0_lvl2.13 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.13( s0_lvl2_13, t0_lvl2_13, sintcsa4x2_0_lvl2.13, t0_lvl1_12, cout_csa4x2_0_lvl2.12) // sum xor2( w0.Adder1.csa4x2_0_lvl2.13, sintcsa4x2_0_lvl2.13, t0_lvl1_12 )#5 xor2( s0_lvl2_13, w0.Adder1.csa4x2_0_lvl2.13, cout_csa4x2_0_lvl2.12 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.13, sintcsa4x2_0_lvl2.13, t0_lvl1_12 )#5 and2( w2.Adder1.csa4x2_0_lvl2.13, w0.Adder1.csa4x2_0_lvl2.13, cout_csa4x2_0_lvl2.12 )#5 or2( t0_lvl2_13, w1.Adder1.csa4x2_0_lvl2.13, w2.Adder1.csa4x2_0_lvl2.13 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.14, s0_lvl2_14,t0_lvl2_14,cout_csa4x2_0_lvl2.14,s4_lvl0_14,t4_lvl0_13,s0_lvl1_14,t0_lvl1_13,cout_csa4x2_0_lvl2.13) ; // adder1bit Adder0.csa4x2_0_lvl2.14( sintcsa4x2_0_lvl2.14, cout_csa4x2_0_lvl2.14, s4_lvl0_14, t4_lvl0_13, s0_lvl1_14) // sum xor2( w0.Adder0.csa4x2_0_lvl2.14, s4_lvl0_14, t4_lvl0_13 )#5 xor2( sintcsa4x2_0_lvl2.14, w0.Adder0.csa4x2_0_lvl2.14, s0_lvl1_14 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.14, s4_lvl0_14, t4_lvl0_13 )#5 and2( w2.Adder0.csa4x2_0_lvl2.14, w0.Adder0.csa4x2_0_lvl2.14, s0_lvl1_14 )#5 or2( cout_csa4x2_0_lvl2.14, w1.Adder0.csa4x2_0_lvl2.14, w2.Adder0.csa4x2_0_lvl2.14 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.14( s0_lvl2_14, t0_lvl2_14, sintcsa4x2_0_lvl2.14, t0_lvl1_13, cout_csa4x2_0_lvl2.13) // sum xor2( w0.Adder1.csa4x2_0_lvl2.14, sintcsa4x2_0_lvl2.14, t0_lvl1_13 )#5 xor2( s0_lvl2_14, w0.Adder1.csa4x2_0_lvl2.14, cout_csa4x2_0_lvl2.13 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.14, sintcsa4x2_0_lvl2.14, t0_lvl1_13 )#5 and2( w2.Adder1.csa4x2_0_lvl2.14, w0.Adder1.csa4x2_0_lvl2.14, cout_csa4x2_0_lvl2.13 )#5 or2( t0_lvl2_14, w1.Adder1.csa4x2_0_lvl2.14, w2.Adder1.csa4x2_0_lvl2.14 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.15, s0_lvl2_15,t0_lvl2_15,cout_csa4x2_0_lvl2.15,s4_lvl0_15,t4_lvl0_14,s0_lvl1_15,t0_lvl1_14,cout_csa4x2_0_lvl2.14) ; // adder1bit Adder0.csa4x2_0_lvl2.15( sintcsa4x2_0_lvl2.15, cout_csa4x2_0_lvl2.15, s4_lvl0_15, t4_lvl0_14, s0_lvl1_15) // sum xor2( w0.Adder0.csa4x2_0_lvl2.15, s4_lvl0_15, t4_lvl0_14 )#5 xor2( sintcsa4x2_0_lvl2.15, w0.Adder0.csa4x2_0_lvl2.15, s0_lvl1_15 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.15, s4_lvl0_15, t4_lvl0_14 )#5 and2( w2.Adder0.csa4x2_0_lvl2.15, w0.Adder0.csa4x2_0_lvl2.15, s0_lvl1_15 )#5 or2( cout_csa4x2_0_lvl2.15, w1.Adder0.csa4x2_0_lvl2.15, w2.Adder0.csa4x2_0_lvl2.15 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.15( s0_lvl2_15, t0_lvl2_15, sintcsa4x2_0_lvl2.15, t0_lvl1_14, cout_csa4x2_0_lvl2.14) // sum xor2( w0.Adder1.csa4x2_0_lvl2.15, sintcsa4x2_0_lvl2.15, t0_lvl1_14 )#5 xor2( s0_lvl2_15, w0.Adder1.csa4x2_0_lvl2.15, cout_csa4x2_0_lvl2.14 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.15, sintcsa4x2_0_lvl2.15, t0_lvl1_14 )#5 and2( w2.Adder1.csa4x2_0_lvl2.15, w0.Adder1.csa4x2_0_lvl2.15, cout_csa4x2_0_lvl2.14 )#5 or2( t0_lvl2_15, w1.Adder1.csa4x2_0_lvl2.15, w2.Adder1.csa4x2_0_lvl2.15 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.16, s0_lvl2_16,t0_lvl2_16,cout_csa4x2_0_lvl2.16,s4_lvl0_16,t4_lvl0_15,s0_lvl1_16,t0_lvl1_15,cout_csa4x2_0_lvl2.15) ; // adder1bit Adder0.csa4x2_0_lvl2.16( sintcsa4x2_0_lvl2.16, cout_csa4x2_0_lvl2.16, s4_lvl0_16, t4_lvl0_15, s0_lvl1_16) // sum xor2( w0.Adder0.csa4x2_0_lvl2.16, s4_lvl0_16, t4_lvl0_15 )#5 xor2( sintcsa4x2_0_lvl2.16, w0.Adder0.csa4x2_0_lvl2.16, s0_lvl1_16 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.16, s4_lvl0_16, t4_lvl0_15 )#5 and2( w2.Adder0.csa4x2_0_lvl2.16, w0.Adder0.csa4x2_0_lvl2.16, s0_lvl1_16 )#5 or2( cout_csa4x2_0_lvl2.16, w1.Adder0.csa4x2_0_lvl2.16, w2.Adder0.csa4x2_0_lvl2.16 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.16( s0_lvl2_16, t0_lvl2_16, sintcsa4x2_0_lvl2.16, t0_lvl1_15, cout_csa4x2_0_lvl2.15) // sum xor2( w0.Adder1.csa4x2_0_lvl2.16, sintcsa4x2_0_lvl2.16, t0_lvl1_15 )#5 xor2( s0_lvl2_16, w0.Adder1.csa4x2_0_lvl2.16, cout_csa4x2_0_lvl2.15 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.16, sintcsa4x2_0_lvl2.16, t0_lvl1_15 )#5 and2( w2.Adder1.csa4x2_0_lvl2.16, w0.Adder1.csa4x2_0_lvl2.16, cout_csa4x2_0_lvl2.15 )#5 or2( t0_lvl2_16, w1.Adder1.csa4x2_0_lvl2.16, w2.Adder1.csa4x2_0_lvl2.16 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.17, s0_lvl2_17,t0_lvl2_17,cout_csa4x2_0_lvl2.17,s4_lvl0_17,t4_lvl0_16,s0_lvl1_17,t0_lvl1_16,cout_csa4x2_0_lvl2.16) ; // adder1bit Adder0.csa4x2_0_lvl2.17( sintcsa4x2_0_lvl2.17, cout_csa4x2_0_lvl2.17, s4_lvl0_17, t4_lvl0_16, s0_lvl1_17) // sum xor2( w0.Adder0.csa4x2_0_lvl2.17, s4_lvl0_17, t4_lvl0_16 )#5 xor2( sintcsa4x2_0_lvl2.17, w0.Adder0.csa4x2_0_lvl2.17, s0_lvl1_17 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.17, s4_lvl0_17, t4_lvl0_16 )#5 and2( w2.Adder0.csa4x2_0_lvl2.17, w0.Adder0.csa4x2_0_lvl2.17, s0_lvl1_17 )#5 or2( cout_csa4x2_0_lvl2.17, w1.Adder0.csa4x2_0_lvl2.17, w2.Adder0.csa4x2_0_lvl2.17 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.17( s0_lvl2_17, t0_lvl2_17, sintcsa4x2_0_lvl2.17, t0_lvl1_16, cout_csa4x2_0_lvl2.16) // sum xor2( w0.Adder1.csa4x2_0_lvl2.17, sintcsa4x2_0_lvl2.17, t0_lvl1_16 )#5 xor2( s0_lvl2_17, w0.Adder1.csa4x2_0_lvl2.17, cout_csa4x2_0_lvl2.16 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.17, sintcsa4x2_0_lvl2.17, t0_lvl1_16 )#5 and2( w2.Adder1.csa4x2_0_lvl2.17, w0.Adder1.csa4x2_0_lvl2.17, cout_csa4x2_0_lvl2.16 )#5 or2( t0_lvl2_17, w1.Adder1.csa4x2_0_lvl2.17, w2.Adder1.csa4x2_0_lvl2.17 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.18, s0_lvl2_18,t0_lvl2_18,cout_csa4x2_0_lvl2.18,s4_lvl0_18,t4_lvl0_17,s0_lvl1_18,t0_lvl1_17,cout_csa4x2_0_lvl2.17) ; // adder1bit Adder0.csa4x2_0_lvl2.18( sintcsa4x2_0_lvl2.18, cout_csa4x2_0_lvl2.18, s4_lvl0_18, t4_lvl0_17, s0_lvl1_18) // sum xor2( w0.Adder0.csa4x2_0_lvl2.18, s4_lvl0_18, t4_lvl0_17 )#5 xor2( sintcsa4x2_0_lvl2.18, w0.Adder0.csa4x2_0_lvl2.18, s0_lvl1_18 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.18, s4_lvl0_18, t4_lvl0_17 )#5 and2( w2.Adder0.csa4x2_0_lvl2.18, w0.Adder0.csa4x2_0_lvl2.18, s0_lvl1_18 )#5 or2( cout_csa4x2_0_lvl2.18, w1.Adder0.csa4x2_0_lvl2.18, w2.Adder0.csa4x2_0_lvl2.18 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.18( s0_lvl2_18, t0_lvl2_18, sintcsa4x2_0_lvl2.18, t0_lvl1_17, cout_csa4x2_0_lvl2.17) // sum xor2( w0.Adder1.csa4x2_0_lvl2.18, sintcsa4x2_0_lvl2.18, t0_lvl1_17 )#5 xor2( s0_lvl2_18, w0.Adder1.csa4x2_0_lvl2.18, cout_csa4x2_0_lvl2.17 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.18, sintcsa4x2_0_lvl2.18, t0_lvl1_17 )#5 and2( w2.Adder1.csa4x2_0_lvl2.18, w0.Adder1.csa4x2_0_lvl2.18, cout_csa4x2_0_lvl2.17 )#5 or2( t0_lvl2_18, w1.Adder1.csa4x2_0_lvl2.18, w2.Adder1.csa4x2_0_lvl2.18 )#5 // end adder1bit // end csa4x2 end netlist // csa4x2 (csa4x2_0_lvl2.19, s0_lvl2_19,t0_lvl2_19,cout_csa4x2_0_lvl2.19,s4_lvl0_19,t4_lvl0_18,s0_lvl1_19,t0_lvl1_18,cout_csa4x2_0_lvl2.18) ; // adder1bit Adder0.csa4x2_0_lvl2.19( sintcsa4x2_0_lvl2.19, cout_csa4x2_0_lvl2.19, s4_lvl0_19, t4_lvl0_18, s0_lvl1_19) // sum xor2( w0.Adder0.csa4x2_0_lvl2.19, s4_lvl0_19, t4_lvl0_18 )#5 xor2( sintcsa4x2_0_lvl2.19, w0.Adder0.csa4x2_0_lvl2.19, s0_lvl1_19 )#5 //cout and2( w1.Adder0.csa4x2_0_lvl2.19, s4_lvl0_19, t4_lvl0_18 )#5 and2( w2.Adder0.csa4x2_0_lvl2.19, w0.Adder0.csa4x2_0_lvl2.19, s0_lvl1_19 )#5 or2( cout_csa4x2_0_lvl2.19, w1.Adder0.csa4x2_0_lvl2.19, w2.Adder0.csa4x2_0_lvl2.19 )#5 // end adder1bit // adder1bit Adder1.csa4x2_0_lvl2.19( s0_lvl2_19, t0_lvl2_19, sintcsa4x2_0_lvl2.19, t0_lvl1_18, cout_csa4x2_0_lvl2.18) // sum xor2( w0.Adder1.csa4x2_0_lvl2.19, sintcsa4x2_0_lvl2.19, t0_lvl1_18 )#5 xor2( s0_lvl2_19, w0.Adder1.csa4x2_0_lvl2.19, cout_csa4x2_0_lvl2.18 )#5 //cout and2( w1.Adder1.csa4x2_0_lvl2.19, sintcsa4x2_0_lvl2.19, t0_lvl1_18 )#5 and2( w2.Adder1.csa4x2_0_lvl2.19, w0.Adder1.csa4x2_0_lvl2.19, cout_csa4x2_0_lvl2.18 )#5 or2( t0_lvl2_19, w1.Adder1.csa4x2_0_lvl2.19, w2.Adder1.csa4x2_0_lvl2.19 )#5 // end adder1bit // end csa4x2 end // genKoggeStoneVec(2*numBits, outVec, "cout", currRow->[0], currRow->[1], 'GND' ); netlist // PGgen (g0,p0,s0_lvl2_0,GND) xor2(p0,s0_lvl2_0,GND)#5 and2(g0,s0_lvl2_0,GND)#5 end netlist // PGgen (g1,p1,s0_lvl2_1,t0_lvl2_0) xor2(p1,s0_lvl2_1,t0_lvl2_0)#5 and2(g1,s0_lvl2_1,t0_lvl2_0)#5 end netlist // PGgen (g2,p2,s0_lvl2_2,t0_lvl2_1) xor2(p2,s0_lvl2_2,t0_lvl2_1)#5 and2(g2,s0_lvl2_2,t0_lvl2_1)#5 end netlist // PGgen (g3,p3,s0_lvl2_3,t0_lvl2_2) xor2(p3,s0_lvl2_3,t0_lvl2_2)#5 and2(g3,s0_lvl2_3,t0_lvl2_2)#5 end netlist // PGgen (g4,p4,s0_lvl2_4,t0_lvl2_3) xor2(p4,s0_lvl2_4,t0_lvl2_3)#5 and2(g4,s0_lvl2_4,t0_lvl2_3)#5 end netlist // PGgen (g5,p5,s0_lvl2_5,t0_lvl2_4) xor2(p5,s0_lvl2_5,t0_lvl2_4)#5 and2(g5,s0_lvl2_5,t0_lvl2_4)#5 end netlist // PGgen (g6,p6,s0_lvl2_6,t0_lvl2_5) xor2(p6,s0_lvl2_6,t0_lvl2_5)#5 and2(g6,s0_lvl2_6,t0_lvl2_5)#5 end netlist // PGgen (g7,p7,s0_lvl2_7,t0_lvl2_6) xor2(p7,s0_lvl2_7,t0_lvl2_6)#5 and2(g7,s0_lvl2_7,t0_lvl2_6)#5 end netlist // PGgen (g8,p8,s0_lvl2_8,t0_lvl2_7) xor2(p8,s0_lvl2_8,t0_lvl2_7)#5 and2(g8,s0_lvl2_8,t0_lvl2_7)#5 end netlist // PGgen (g9,p9,s0_lvl2_9,t0_lvl2_8) xor2(p9,s0_lvl2_9,t0_lvl2_8)#5 and2(g9,s0_lvl2_9,t0_lvl2_8)#5 end netlist // PGgen (g10,p10,s0_lvl2_10,t0_lvl2_9) xor2(p10,s0_lvl2_10,t0_lvl2_9)#5 and2(g10,s0_lvl2_10,t0_lvl2_9)#5 end netlist // PGgen (g11,p11,s0_lvl2_11,t0_lvl2_10) xor2(p11,s0_lvl2_11,t0_lvl2_10)#5 and2(g11,s0_lvl2_11,t0_lvl2_10)#5 end netlist // PGgen (g12,p12,s0_lvl2_12,t0_lvl2_11) xor2(p12,s0_lvl2_12,t0_lvl2_11)#5 and2(g12,s0_lvl2_12,t0_lvl2_11)#5 end netlist // PGgen (g13,p13,s0_lvl2_13,t0_lvl2_12) xor2(p13,s0_lvl2_13,t0_lvl2_12)#5 and2(g13,s0_lvl2_13,t0_lvl2_12)#5 end netlist // PGgen (g14,p14,s0_lvl2_14,t0_lvl2_13) xor2(p14,s0_lvl2_14,t0_lvl2_13)#5 and2(g14,s0_lvl2_14,t0_lvl2_13)#5 end netlist // PGgen (g15,p15,s0_lvl2_15,t0_lvl2_14) xor2(p15,s0_lvl2_15,t0_lvl2_14)#5 and2(g15,s0_lvl2_15,t0_lvl2_14)#5 end netlist // PGgen (g16,p16,s0_lvl2_16,t0_lvl2_15) xor2(p16,s0_lvl2_16,t0_lvl2_15)#5 and2(g16,s0_lvl2_16,t0_lvl2_15)#5 end netlist // PGgen (g17,p17,s0_lvl2_17,t0_lvl2_16) xor2(p17,s0_lvl2_17,t0_lvl2_16)#5 and2(g17,s0_lvl2_17,t0_lvl2_16)#5 end netlist // PGgen (g18,p18,s0_lvl2_18,t0_lvl2_17) xor2(p18,s0_lvl2_18,t0_lvl2_17)#5 and2(g18,s0_lvl2_18,t0_lvl2_17)#5 end netlist // PGgen (g19,p19,s0_lvl2_19,t0_lvl2_18) xor2(p19,s0_lvl2_19,t0_lvl2_18)#5 and2(g19,s0_lvl2_19,t0_lvl2_18)#5 end netlist // Gcombine (g_0_GND, g0, GND, p0 ) and2(w0g_0_GND, p0, GND )#5 or2( g_0_GND, w0g_0_GND, g0 )#5 end netlist // PGcombine (g_1_0,p_1_0,g1,p1,g0,p0) and2( w0g_1_0, p1, g0 )#5 or2( g_1_0, w0g_1_0, g1 )#5 and2( p_1_0, p1, p0)#5 end netlist // PGcombine (g_2_1,p_2_1,g2,p2,g1,p1) and2( w0g_2_1, p2, g1 )#5 or2( g_2_1, w0g_2_1, g2 )#5 and2( p_2_1, p2, p1)#5 end netlist // PGcombine (g_3_2,p_3_2,g3,p3,g2,p2) and2( w0g_3_2, p3, g2 )#5 or2( g_3_2, w0g_3_2, g3 )#5 and2( p_3_2, p3, p2)#5 end netlist // PGcombine (g_4_3,p_4_3,g4,p4,g3,p3) and2( w0g_4_3, p4, g3 )#5 or2( g_4_3, w0g_4_3, g4 )#5 and2( p_4_3, p4, p3)#5 end netlist // PGcombine (g_5_4,p_5_4,g5,p5,g4,p4) and2( w0g_5_4, p5, g4 )#5 or2( g_5_4, w0g_5_4, g5 )#5 and2( p_5_4, p5, p4)#5 end netlist // PGcombine (g_6_5,p_6_5,g6,p6,g5,p5) and2( w0g_6_5, p6, g5 )#5 or2( g_6_5, w0g_6_5, g6 )#5 and2( p_6_5, p6, p5)#5 end netlist // PGcombine (g_7_6,p_7_6,g7,p7,g6,p6) and2( w0g_7_6, p7, g6 )#5 or2( g_7_6, w0g_7_6, g7 )#5 and2( p_7_6, p7, p6)#5 end netlist // PGcombine (g_8_7,p_8_7,g8,p8,g7,p7) and2( w0g_8_7, p8, g7 )#5 or2( g_8_7, w0g_8_7, g8 )#5 and2( p_8_7, p8, p7)#5 end netlist // PGcombine (g_9_8,p_9_8,g9,p9,g8,p8) and2( w0g_9_8, p9, g8 )#5 or2( g_9_8, w0g_9_8, g9 )#5 and2( p_9_8, p9, p8)#5 end netlist // PGcombine (g_10_9,p_10_9,g10,p10,g9,p9) and2( w0g_10_9, p10, g9 )#5 or2( g_10_9, w0g_10_9, g10 )#5 and2( p_10_9, p10, p9)#5 end netlist // PGcombine (g_11_10,p_11_10,g11,p11,g10,p10) and2( w0g_11_10, p11, g10 )#5 or2( g_11_10, w0g_11_10, g11 )#5 and2( p_11_10, p11, p10)#5 end netlist // PGcombine (g_12_11,p_12_11,g12,p12,g11,p11) and2( w0g_12_11, p12, g11 )#5 or2( g_12_11, w0g_12_11, g12 )#5 and2( p_12_11, p12, p11)#5 end netlist // PGcombine (g_13_12,p_13_12,g13,p13,g12,p12) and2( w0g_13_12, p13, g12 )#5 or2( g_13_12, w0g_13_12, g13 )#5 and2( p_13_12, p13, p12)#5 end netlist // PGcombine (g_14_13,p_14_13,g14,p14,g13,p13) and2( w0g_14_13, p14, g13 )#5 or2( g_14_13, w0g_14_13, g14 )#5 and2( p_14_13, p14, p13)#5 end netlist // PGcombine (g_15_14,p_15_14,g15,p15,g14,p14) and2( w0g_15_14, p15, g14 )#5 or2( g_15_14, w0g_15_14, g15 )#5 and2( p_15_14, p15, p14)#5 end netlist // PGcombine (g_16_15,p_16_15,g16,p16,g15,p15) and2( w0g_16_15, p16, g15 )#5 or2( g_16_15, w0g_16_15, g16 )#5 and2( p_16_15, p16, p15)#5 end netlist // PGcombine (g_17_16,p_17_16,g17,p17,g16,p16) and2( w0g_17_16, p17, g16 )#5 or2( g_17_16, w0g_17_16, g17 )#5 and2( p_17_16, p17, p16)#5 end netlist // PGcombine (g_18_17,p_18_17,g18,p18,g17,p17) and2( w0g_18_17, p18, g17 )#5 or2( g_18_17, w0g_18_17, g18 )#5 and2( p_18_17, p18, p17)#5 end netlist // PGcombine (g_19_18,p_19_18,g19,p19,g18,p18) and2( w0g_19_18, p19, g18 )#5 or2( g_19_18, w0g_19_18, g19 )#5 and2( p_19_18, p19, p18)#5 end netlist // Gcombine (g_1_GND, g_1_0, GND, p_1_0 ) and2(w0g_1_GND, p_1_0, GND )#5 or2( g_1_GND, w0g_1_GND, g_1_0 )#5 end netlist // Gcombine (g_2_GND, g_2_1, g_0_GND, p_2_1 ) and2(w0g_2_GND, p_2_1, g_0_GND )#5 or2( g_2_GND, w0g_2_GND, g_2_1 )#5 end netlist // PGcombine (g_3_0,p_3_0,g_3_2,p_3_2,g_1_0,p_1_0) and2( w0g_3_0, p_3_2, g_1_0 )#5 or2( g_3_0, w0g_3_0, g_3_2 )#5 and2( p_3_0, p_3_2, p_1_0)#5 end netlist // PGcombine (g_4_1,p_4_1,g_4_3,p_4_3,g_2_1,p_2_1) and2( w0g_4_1, p_4_3, g_2_1 )#5 or2( g_4_1, w0g_4_1, g_4_3 )#5 and2( p_4_1, p_4_3, p_2_1)#5 end netlist // PGcombine (g_5_2,p_5_2,g_5_4,p_5_4,g_3_2,p_3_2) and2( w0g_5_2, p_5_4, g_3_2 )#5 or2( g_5_2, w0g_5_2, g_5_4 )#5 and2( p_5_2, p_5_4, p_3_2)#5 end netlist // PGcombine (g_6_3,p_6_3,g_6_5,p_6_5,g_4_3,p_4_3) and2( w0g_6_3, p_6_5, g_4_3 )#5 or2( g_6_3, w0g_6_3, g_6_5 )#5 and2( p_6_3, p_6_5, p_4_3)#5 end netlist // PGcombine (g_7_4,p_7_4,g_7_6,p_7_6,g_5_4,p_5_4) and2( w0g_7_4, p_7_6, g_5_4 )#5 or2( g_7_4, w0g_7_4, g_7_6 )#5 and2( p_7_4, p_7_6, p_5_4)#5 end netlist // PGcombine (g_8_5,p_8_5,g_8_7,p_8_7,g_6_5,p_6_5) and2( w0g_8_5, p_8_7, g_6_5 )#5 or2( g_8_5, w0g_8_5, g_8_7 )#5 and2( p_8_5, p_8_7, p_6_5)#5 end netlist // PGcombine (g_9_6,p_9_6,g_9_8,p_9_8,g_7_6,p_7_6) and2( w0g_9_6, p_9_8, g_7_6 )#5 or2( g_9_6, w0g_9_6, g_9_8 )#5 and2( p_9_6, p_9_8, p_7_6)#5 end netlist // PGcombine (g_10_7,p_10_7,g_10_9,p_10_9,g_8_7,p_8_7) and2( w0g_10_7, p_10_9, g_8_7 )#5 or2( g_10_7, w0g_10_7, g_10_9 )#5 and2( p_10_7, p_10_9, p_8_7)#5 end netlist // PGcombine (g_11_8,p_11_8,g_11_10,p_11_10,g_9_8,p_9_8) and2( w0g_11_8, p_11_10, g_9_8 )#5 or2( g_11_8, w0g_11_8, g_11_10 )#5 and2( p_11_8, p_11_10, p_9_8)#5 end netlist // PGcombine (g_12_9,p_12_9,g_12_11,p_12_11,g_10_9,p_10_9) and2( w0g_12_9, p_12_11, g_10_9 )#5 or2( g_12_9, w0g_12_9, g_12_11 )#5 and2( p_12_9, p_12_11, p_10_9)#5 end netlist // PGcombine (g_13_10,p_13_10,g_13_12,p_13_12,g_11_10,p_11_10) and2( w0g_13_10, p_13_12, g_11_10 )#5 or2( g_13_10, w0g_13_10, g_13_12 )#5 and2( p_13_10, p_13_12, p_11_10)#5 end netlist // PGcombine (g_14_11,p_14_11,g_14_13,p_14_13,g_12_11,p_12_11) and2( w0g_14_11, p_14_13, g_12_11 )#5 or2( g_14_11, w0g_14_11, g_14_13 )#5 and2( p_14_11, p_14_13, p_12_11)#5 end netlist // PGcombine (g_15_12,p_15_12,g_15_14,p_15_14,g_13_12,p_13_12) and2( w0g_15_12, p_15_14, g_13_12 )#5 or2( g_15_12, w0g_15_12, g_15_14 )#5 and2( p_15_12, p_15_14, p_13_12)#5 end netlist // PGcombine (g_16_13,p_16_13,g_16_15,p_16_15,g_14_13,p_14_13) and2( w0g_16_13, p_16_15, g_14_13 )#5 or2( g_16_13, w0g_16_13, g_16_15 )#5 and2( p_16_13, p_16_15, p_14_13)#5 end netlist // PGcombine (g_17_14,p_17_14,g_17_16,p_17_16,g_15_14,p_15_14) and2( w0g_17_14, p_17_16, g_15_14 )#5 or2( g_17_14, w0g_17_14, g_17_16 )#5 and2( p_17_14, p_17_16, p_15_14)#5 end netlist // PGcombine (g_18_15,p_18_15,g_18_17,p_18_17,g_16_15,p_16_15) and2( w0g_18_15, p_18_17, g_16_15 )#5 or2( g_18_15, w0g_18_15, g_18_17 )#5 and2( p_18_15, p_18_17, p_16_15)#5 end netlist // PGcombine (g_19_16,p_19_16,g_19_18,p_19_18,g_17_16,p_17_16) and2( w0g_19_16, p_19_18, g_17_16 )#5 or2( g_19_16, w0g_19_16, g_19_18 )#5 and2( p_19_16, p_19_18, p_17_16)#5 end netlist // Gcombine (g_3_GND, g_3_0, GND, p_3_0 ) and2(w0g_3_GND, p_3_0, GND )#5 or2( g_3_GND, w0g_3_GND, g_3_0 )#5 end netlist // Gcombine (g_4_GND, g_4_1, g_0_GND, p_4_1 ) and2(w0g_4_GND, p_4_1, g_0_GND )#5 or2( g_4_GND, w0g_4_GND, g_4_1 )#5 end netlist // Gcombine (g_5_GND, g_5_2, g_1_GND, p_5_2 ) and2(w0g_5_GND, p_5_2, g_1_GND )#5 or2( g_5_GND, w0g_5_GND, g_5_2 )#5 end netlist // Gcombine (g_6_GND, g_6_3, g_2_GND, p_6_3 ) and2(w0g_6_GND, p_6_3, g_2_GND )#5 or2( g_6_GND, w0g_6_GND, g_6_3 )#5 end netlist // PGcombine (g_7_0,p_7_0,g_7_4,p_7_4,g_3_0,p_3_0) and2( w0g_7_0, p_7_4, g_3_0 )#5 or2( g_7_0, w0g_7_0, g_7_4 )#5 and2( p_7_0, p_7_4, p_3_0)#5 end netlist // PGcombine (g_8_1,p_8_1,g_8_5,p_8_5,g_4_1,p_4_1) and2( w0g_8_1, p_8_5, g_4_1 )#5 or2( g_8_1, w0g_8_1, g_8_5 )#5 and2( p_8_1, p_8_5, p_4_1)#5 end netlist // PGcombine (g_9_2,p_9_2,g_9_6,p_9_6,g_5_2,p_5_2) and2( w0g_9_2, p_9_6, g_5_2 )#5 or2( g_9_2, w0g_9_2, g_9_6 )#5 and2( p_9_2, p_9_6, p_5_2)#5 end netlist // PGcombine (g_10_3,p_10_3,g_10_7,p_10_7,g_6_3,p_6_3) and2( w0g_10_3, p_10_7, g_6_3 )#5 or2( g_10_3, w0g_10_3, g_10_7 )#5 and2( p_10_3, p_10_7, p_6_3)#5 end netlist // PGcombine (g_11_4,p_11_4,g_11_8,p_11_8,g_7_4,p_7_4) and2( w0g_11_4, p_11_8, g_7_4 )#5 or2( g_11_4, w0g_11_4, g_11_8 )#5 and2( p_11_4, p_11_8, p_7_4)#5 end netlist // PGcombine (g_12_5,p_12_5,g_12_9,p_12_9,g_8_5,p_8_5) and2( w0g_12_5, p_12_9, g_8_5 )#5 or2( g_12_5, w0g_12_5, g_12_9 )#5 and2( p_12_5, p_12_9, p_8_5)#5 end netlist // PGcombine (g_13_6,p_13_6,g_13_10,p_13_10,g_9_6,p_9_6) and2( w0g_13_6, p_13_10, g_9_6 )#5 or2( g_13_6, w0g_13_6, g_13_10 )#5 and2( p_13_6, p_13_10, p_9_6)#5 end netlist // PGcombine (g_14_7,p_14_7,g_14_11,p_14_11,g_10_7,p_10_7) and2( w0g_14_7, p_14_11, g_10_7 )#5 or2( g_14_7, w0g_14_7, g_14_11 )#5 and2( p_14_7, p_14_11, p_10_7)#5 end netlist // PGcombine (g_15_8,p_15_8,g_15_12,p_15_12,g_11_8,p_11_8) and2( w0g_15_8, p_15_12, g_11_8 )#5 or2( g_15_8, w0g_15_8, g_15_12 )#5 and2( p_15_8, p_15_12, p_11_8)#5 end netlist // PGcombine (g_16_9,p_16_9,g_16_13,p_16_13,g_12_9,p_12_9) and2( w0g_16_9, p_16_13, g_12_9 )#5 or2( g_16_9, w0g_16_9, g_16_13 )#5 and2( p_16_9, p_16_13, p_12_9)#5 end netlist // PGcombine (g_17_10,p_17_10,g_17_14,p_17_14,g_13_10,p_13_10) and2( w0g_17_10, p_17_14, g_13_10 )#5 or2( g_17_10, w0g_17_10, g_17_14 )#5 and2( p_17_10, p_17_14, p_13_10)#5 end netlist // PGcombine (g_18_11,p_18_11,g_18_15,p_18_15,g_14_11,p_14_11) and2( w0g_18_11, p_18_15, g_14_11 )#5 or2( g_18_11, w0g_18_11, g_18_15 )#5 and2( p_18_11, p_18_15, p_14_11)#5 end netlist // PGcombine (g_19_12,p_19_12,g_19_16,p_19_16,g_15_12,p_15_12) and2( w0g_19_12, p_19_16, g_15_12 )#5 or2( g_19_12, w0g_19_12, g_19_16 )#5 and2( p_19_12, p_19_16, p_15_12)#5 end netlist // Gcombine (g_7_GND, g_7_0, GND, p_7_0 ) and2(w0g_7_GND, p_7_0, GND )#5 or2( g_7_GND, w0g_7_GND, g_7_0 )#5 end netlist // Gcombine (g_8_GND, g_8_1, g_0_GND, p_8_1 ) and2(w0g_8_GND, p_8_1, g_0_GND )#5 or2( g_8_GND, w0g_8_GND, g_8_1 )#5 end netlist // Gcombine (g_9_GND, g_9_2, g_1_GND, p_9_2 ) and2(w0g_9_GND, p_9_2, g_1_GND )#5 or2( g_9_GND, w0g_9_GND, g_9_2 )#5 end netlist // Gcombine (g_10_GND, g_10_3, g_2_GND, p_10_3 ) and2(w0g_10_GND, p_10_3, g_2_GND )#5 or2( g_10_GND, w0g_10_GND, g_10_3 )#5 end netlist // Gcombine (g_11_GND, g_11_4, g_3_GND, p_11_4 ) and2(w0g_11_GND, p_11_4, g_3_GND )#5 or2( g_11_GND, w0g_11_GND, g_11_4 )#5 end netlist // Gcombine (g_12_GND, g_12_5, g_4_GND, p_12_5 ) and2(w0g_12_GND, p_12_5, g_4_GND )#5 or2( g_12_GND, w0g_12_GND, g_12_5 )#5 end netlist // Gcombine (g_13_GND, g_13_6, g_5_GND, p_13_6 ) and2(w0g_13_GND, p_13_6, g_5_GND )#5 or2( g_13_GND, w0g_13_GND, g_13_6 )#5 end netlist // Gcombine (g_14_GND, g_14_7, g_6_GND, p_14_7 ) and2(w0g_14_GND, p_14_7, g_6_GND )#5 or2( g_14_GND, w0g_14_GND, g_14_7 )#5 end netlist // PGcombine (g_15_0,p_15_0,g_15_8,p_15_8,g_7_0,p_7_0) and2( w0g_15_0, p_15_8, g_7_0 )#5 or2( g_15_0, w0g_15_0, g_15_8 )#5 and2( p_15_0, p_15_8, p_7_0)#5 end netlist // PGcombine (g_16_1,p_16_1,g_16_9,p_16_9,g_8_1,p_8_1) and2( w0g_16_1, p_16_9, g_8_1 )#5 or2( g_16_1, w0g_16_1, g_16_9 )#5 and2( p_16_1, p_16_9, p_8_1)#5 end netlist // PGcombine (g_17_2,p_17_2,g_17_10,p_17_10,g_9_2,p_9_2) and2( w0g_17_2, p_17_10, g_9_2 )#5 or2( g_17_2, w0g_17_2, g_17_10 )#5 and2( p_17_2, p_17_10, p_9_2)#5 end netlist // PGcombine (g_18_3,p_18_3,g_18_11,p_18_11,g_10_3,p_10_3) and2( w0g_18_3, p_18_11, g_10_3 )#5 or2( g_18_3, w0g_18_3, g_18_11 )#5 and2( p_18_3, p_18_11, p_10_3)#5 end netlist // PGcombine (g_19_4,p_19_4,g_19_12,p_19_12,g_11_4,p_11_4) and2( w0g_19_4, p_19_12, g_11_4 )#5 or2( g_19_4, w0g_19_4, g_19_12 )#5 and2( p_19_4, p_19_12, p_11_4)#5 end netlist // Gcombine (g_15_GND, g_15_0, GND, p_15_0 ) and2(w0g_15_GND, p_15_0, GND )#5 or2( g_15_GND, w0g_15_GND, g_15_0 )#5 end netlist // Gcombine (g_16_GND, g_16_1, g_0_GND, p_16_1 ) and2(w0g_16_GND, p_16_1, g_0_GND )#5 or2( g_16_GND, w0g_16_GND, g_16_1 )#5 end netlist // Gcombine (g_17_GND, g_17_2, g_1_GND, p_17_2 ) and2(w0g_17_GND, p_17_2, g_1_GND )#5 or2( g_17_GND, w0g_17_GND, g_17_2 )#5 end netlist // Gcombine (g_18_GND, g_18_3, g_2_GND, p_18_3 ) and2(w0g_18_GND, p_18_3, g_2_GND )#5 or2( g_18_GND, w0g_18_GND, g_18_3 )#5 end netlist // Gcombine (cout, g_19_4, g_3_GND, p_19_4 ) and2(w0cout, p_19_4, g_3_GND )#5 or2( cout, w0cout, g_19_4 )#5 end netlist xor2( m0, p0,GND )#5 xor2( m1, p1,g_0_GND )#5 xor2( m2, p2,g_1_GND )#5 xor2( m3, p3,g_2_GND )#5 xor2( m4, p4,g_3_GND )#5 xor2( m5, p5,g_4_GND )#5 xor2( m6, p6,g_5_GND )#5 xor2( m7, p7,g_6_GND )#5 xor2( m8, p8,g_7_GND )#5 xor2( m9, p9,g_8_GND )#5 xor2( m10, p10,g_9_GND )#5 xor2( m11, p11,g_10_GND )#5 xor2( m12, p12,g_11_GND )#5 xor2( m13, p13,g_12_GND )#5 xor2( m14, p14,g_13_GND )#5 xor2( m15, p15,g_14_GND )#5 xor2( m16, p16,g_15_GND )#5 xor2( m17, p17,g_16_GND )#5 xor2( m18, p18,g_17_GND )#5 xor2( m19, p19,g_18_GND )#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/adder12.net
// Lonestar Benchmark Suite for irregular applications that exhibit // amorphous data-parallelism. // // Center for Grid and Distributed Computing // The University of Texas at Austin // // Copyright (C) 2007, 2008, 2009 The University of Texas at Austin // // Licensed under the Eclipse Public License, Version 1.0 (the "License"); // you may not use this file except in compliance with the License. // You may obtain a copy of the License at // // http://www.eclipse.org/legal/epl-v10.html // // Unless required by applicable law or agreed to in writing, software // distributed under the License is distributed on an "AS IS" BASIS, // WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. // See the License for the specific language governing permissions and // limitations under the License. // // File: adder12.net finish=200 inputs cin, a0, a1, a2, a3, a4, a5, a6, a7, a8, a9, a10, a11, end inputs b0, b1, b2, b3, b4, b5, b6, b7, b8, b9, b10, b11, end outputs r11, s0, s1, s2, s3, s4, s5, s6, s7, s8, s9, s10, s11 end outvalues r11 1, s0 0, s1 0, s2 0, s3 0, s4 0, s5 0, s6 0, s7 0, s8 0, s9 0, s10 0, s11 0, end initlist cin 0,0 21,1 end initlist a0 0,1 end initlist a1 0,1 end initlist a2 0,1 end initlist a3 0,1 end initlist a4 0,1 end initlist a5 0,1 end initlist a6 0,1 end initlist a7 0,1 end initlist a8 0,1 end initlist a9 0,1 end initlist a10 0,1 end initlist a11 0,1 end initlist b0 0,0 end initlist b1 0,0 end initlist b2 0,0 end initlist b3 0,0 end initlist b4 0,0 end initlist b5 0,0 end initlist b6 0,0 end initlist b7 0,0 end initlist b8 0,0 end initlist b9 0,0 end initlist b10 0,0 end initlist b11 0,0 end netlist inv(a0n,a0)#4 inv(b0n,b0)#4 inv(cinn,cin)#4 and2(a0nb0n,a0n,b0n)#2 and2(a0nb0,a0n,b0)#2 and2(a0b0n,a0,b0n)#2 and2(a0b0,a0,b0)#3 and2(a0b0cin,a0b0,cin)#2 and2(a0nb0ncin,a0nb0n,cin)#2 and2(a0nb0cinn,a0nb0,cinn)#2 and2(a0b0ncinn,a0b0n,cinn)#2 and2(b0cin,b0,cin)#2 and2(a0cin,cin,a0)#2 or2(s0w42,a0b0ncinn,a0nb0cinn)#3 or2(s0w71,a0b0cin, a0nb0ncin)#3 or2(s0,s0w42,s0w71)#3 or2(s0w35, b0cin, a0cin)#3 or2(r0,s0w35,a0b0)#5 end netlist inv(a1n,a1)#4 inv(b1n,b1)#4 inv(r0n,r0)#4 and2(a1nb1n,a1n,b1n)#2 and2(a1nb1,a1n,b1)#2 and2(a1b1n,a1,b1n)#2 and2(a1b1,a1,b1)#3 and2(a1b1r0,a1b1,r0)#2 and2(a1nb1nr0,a1nb1n,r0)#2 and2(a1nb1r0n,a1nb1,r0n)#2 and2(a1b1nr0n,a1b1n,r0n)#2 and2(b1r0,b1,r0)#2 and2(a1r0,r0,a1)#2 or2(s1w42,a1b1nr0n,a1nb1r0n)#3 or2(s1w71,a1b1r0, a1nb1nr0)#3 or2(s1,s1w42,s1w71)#3 or2(s1w35, b1r0, a1r0)#3 or2(r1,s1w35,a1b1)#5 end netlist inv(a2n,a2)#4 inv(b2n,b2)#4 inv(r1n,r1)#4 and2(a2nb2n,a2n,b2n)#2 and2(a2nb2,a2n,b2)#2 and2(a2b2n,a2,b2n)#2 and2(a2b2,a2,b2)#3 and2(a2b2r1,a2b2,r1)#2 and2(a2nb2nr1,a2nb2n,r1)#2 and2(a2nb2r1n,a2nb2,r1n)#2 and2(a2b2nr1n,a2b2n,r1n)#2 and2(b2r1,b2,r1)#2 and2(a2r1,r1,a2)#2 or2(s2w42,a2b2nr1n,a2nb2r1n)#3 or2(s2w71,a2b2r1, a2nb2nr1)#3 or2(s2,s2w42,s2w71)#3 or2(s2w35, b2r1, a2r1)#3 or2(r2,s2w35,a2b2)#5 end netlist inv(a3n,a3)#4 inv(b3n,b3)#4 inv(r2n,r2)#4 and2(a3nb3n,a3n,b3n)#2 and2(a3nb3,a3n,b3)#2 and2(a3b3n,a3,b3n)#2 and2(a3b3,a3,b3)#3 and2(a3b3r2,a3b3,r2)#2 and2(a3nb3nr2,a3nb3n,r2)#2 and2(a3nb3r2n,a3nb3,r2n)#2 and2(a3b3nr2n,a3b3n,r2n)#2 and2(b3r2,b3,r2)#2 and2(a3r2,r2,a3)#2 or2(s3w42,a3b3nr2n,a3nb3r2n)#3 or2(s3w71,a3b3r2, a3nb3nr2)#3 or2(s3,s3w42,s3w71)#3 or2(s3w35, b3r2, a3r2)#3 or2(r3,s3w35,a3b3)#5 end netlist inv(a4n,a4)#4 inv(b4n,b4)#4 inv(r3n,r3)#4 and2(a4nb4n,a4n,b4n)#2 and2(a4nb4,a4n,b4)#2 and2(a4b4n,a4,b4n)#2 and2(a4b4,a4,b4)#3 and2(a4b4r3,a4b4,r3)#2 and2(a4nb4nr3,a4nb4n,r3)#2 and2(a4nb4r3n,a4nb4,r3n)#2 and2(a4b4nr3n,a4b4n,r3n)#2 and2(b4r3,b4,r3)#2 and2(a4r3,r3,a4)#2 or2(s4w42,a4b4nr3n,a4nb4r3n)#3 or2(s4w71,a4b4r3, a4nb4nr3)#3 or2(s4,s4w42,s4w71)#3 or2(s4w35, b4r3, a4r3)#3 or2(r4,s4w35,a4b4)#5 end netlist inv(a5n,a5)#4 inv(b5n,b5)#4 inv(r4n,r4)#4 and2(a5nb5n,a5n,b5n)#2 and2(a5nb5,a5n,b5)#2 and2(a5b5n,a5,b5n)#2 and2(a5b5,a5,b5)#3 and2(a5b5r4,a5b5,r4)#2 and2(a5nb5nr4,a5nb5n,r4)#2 and2(a5nb5r4n,a5nb5,r4n)#2 and2(a5b5nr4n,a5b5n,r4n)#2 and2(b5r4,b5,r4)#2 and2(a5r4,r4,a5)#2 or2(s5w42,a5b5nr4n,a5nb5r4n)#3 or2(s5w71,a5b5r4, a5nb5nr4)#3 or2(s5,s5w42,s5w71)#3 or2(s5w35, b5r4, a5r4)#3 or2(r5,s5w35,a5b5)#5 end netlist inv(a6n,a6)#4 inv(b6n,b6)#4 inv(r5n,r5)#4 and2(a6nb6n,a6n,b6n)#2 and2(a6nb6,a6n,b6)#2 and2(a6b6n,a6,b6n)#2 and2(a6b6,a6,b6)#3 and2(a6b6r5,a6b6,r5)#2 and2(a6nb6nr5,a6nb6n,r5)#2 and2(a6nb6r5n,a6nb6,r5n)#2 and2(a6b6nr5n,a6b6n,r5n)#2 and2(b6r5,b6,r5)#2 and2(a6r5,r5,a6)#2 or2(s6w42,a6b6nr5n,a6nb6r5n)#3 or2(s6w71,a6b6r5, a6nb6nr5)#3 or2(s6,s6w42,s6w71)#3 or2(s6w35, b6r5, a6r5)#3 or2(r6,s6w35,a6b6)#5 end netlist inv(a7n,a7)#4 inv(b7n,b7)#4 inv(r6n,r6)#4 and2(a7nb7n,a7n,b7n)#2 and2(a7nb7,a7n,b7)#2 and2(a7b7n,a7,b7n)#2 and2(a7b7,a7,b7)#3 and2(a7b7r6,a7b7,r6)#2 and2(a7nb7nr6,a7nb7n,r6)#2 and2(a7nb7r6n,a7nb7,r6n)#2 and2(a7b7nr6n,a7b7n,r6n)#2 and2(b7r6,b7,r6)#2 and2(a7r6,r6,a7)#2 or2(s7w42,a7b7nr6n,a7nb7r6n)#3 or2(s7w71,a7b7r6, a7nb7nr6)#3 or2(s7,s7w42,s7w71)#3 or2(s7w35, b7r6, a7r6)#3 or2(r7,s7w35,a7b7)#5 end netlist inv(a8n,a8)#4 inv(b8n,b8)#4 inv(r7n,r7)#4 and2(a8nb8n,a8n,b8n)#2 and2(a8nb8,a8n,b8)#2 and2(a8b8n,a8,b8n)#2 and2(a8b8,a8,b8)#3 and2(a8b8r7,a8b8,r7)#2 and2(a8nb8nr7,a8nb8n,r7)#2 and2(a8nb8r7n,a8nb8,r7n)#2 and2(a8b8nr7n,a8b8n,r7n)#2 and2(b8r7,b8,r7)#2 and2(a8r7,r7,a8)#2 or2(s8w42,a8b8nr7n,a8nb8r7n)#3 or2(s8w71,a8b8r7, a8nb8nr7)#3 or2(s8,s8w42,s8w71)#3 or2(s8w35, b8r7, a8r7)#3 or2(r8,s8w35,a8b8)#5 end netlist inv(a9n,a9)#4 inv(b9n,b9)#4 inv(r8n,r8)#4 and2(a9nb9n,a9n,b9n)#2 and2(a9nb9,a9n,b9)#2 and2(a9b9n,a9,b9n)#2 and2(a9b9,a9,b9)#3 and2(a9b9r8,a9b9,r8)#2 and2(a9nb9nr8,a9nb9n,r8)#2 and2(a9nb9r8n,a9nb9,r8n)#2 and2(a9b9nr8n,a9b9n,r8n)#2 and2(b9r8,b9,r8)#2 and2(a9r8,r8,a9)#2 or2(s9w42,a9b9nr8n,a9nb9r8n)#3 or2(s9w71,a9b9r8, a9nb9nr8)#3 or2(s9,s9w42,s9w71)#3 or2(s9w35, b9r8, a9r8)#3 or2(r9,s9w35,a9b9)#5 end netlist inv(a10n,a10)#4 inv(b10n,b10)#4 inv(r9n,r9)#4 and2(a10nb10n,a10n,b10n)#2 and2(a10nb10,a10n,b10)#2 and2(a10b10n,a10,b10n)#2 and2(a10b10,a10,b10)#3 and2(a10b10r9,a10b10,r9)#2 and2(a10nb10nr9,a10nb10n,r9)#2 and2(a10nb10r9n,a10nb10,r9n)#2 and2(a10b10nr9n,a10b10n,r9n)#2 and2(b10r9,b10,r9)#2 and2(a10r9,r9,a10)#2 or2(s10w42,a10b10nr9n,a10nb10r9n)#3 or2(s10w71,a10b10r9, a10nb10nr9)#3 or2(s10,s10w42,s10w71)#3 or2(s10w35, b10r9, a10r9)#3 or2(r10,s10w35,a10b10)#5 end netlist inv(a11n,a11)#4 inv(b11n,b11)#4 inv(r10n,r10)#4 and2(a11nb11n,a11n,b11n)#2 and2(a11nb11,a11n,b11)#2 and2(a11b11n,a11,b11n)#2 and2(a11b11,a11,b11)#3 and2(a11b11r10,a11b11,r10)#2 and2(a11nb11nr10,a11nb11n,r10)#2 and2(a11nb11r10n,a11nb11,r10n)#2 and2(a11b11nr10n,a11b11n,r10n)#2 and2(b11r10,b11,r10)#2 and2(a11r10,r10,a11)#2 or2(s11w42,a11b11nr10n,a11nb11r10n)#3 or2(s11w71,a11b11r10, a11nb11nr10)#3 or2(s11,s11w42,s11w71)#3 or2(s11w35, b11r10, a11r10)#3 or2(r11,s11w35,a11b11)#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/adder1.net
finish 10000 inputs cin, a, b end outputs cout, s end initlist a 0,0 59, 0 end initlist b 0,0 39, 0 end initlist cin 0,0 16, 1 end outvalues cout 0, s 1, end netlist inv(an,a)#4 inv(bn,b)#4 inv(cinn,cin)#4 and2(anbn,an,bn)#2 and2(anb,an,b)#2 and2(abn,a,bn)#2 and2(ab,a,b)#3 and2(abcin,ab,cin)#2 and2(anbncin,anbn,cin)#2 and2(anbcinn,anb,cinn)#2 and2(abncinn,abn,cinn)#2 and2(bcin,b,cin)#2 and2(acin,cin,a)#2 or2(sw42,abncinn,anbcinn)#3 or2(sw71,abcin, anbncin)#3 or2(s,sw42,sw71)#3 or2(sw35, bcin, acin)#3 or2(cout,sw35,ab)#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/csaArray16.net
// Lonestar Benchmark Suite for irregular applications that exhibit // amorphous data-parallelism. // // Center for Grid and Distributed Computing // The University of Texas at Austin // // Copyright (C) 2007, 2008, 2009 The University of Texas at Austin // // Licensed under the Eclipse Public License, Version 1.0 (the "License"); // you may not use this file except in compliance with the License. // You may obtain a copy of the License at // // http://www.eclipse.org/legal/epl-v10.html // // Unless required by applicable law or agreed to in writing, software // distributed under the License is distributed on an "AS IS" BASIS, // WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied. // See the License for the specific language governing permissions and // limitations under the License. // // File: csaArray16.net finish 100000 inputs a0, a1, a2, a3, a4, a5, a6, a7, a8, a9, a10, a11, a12, a13, a14, a15 b0, b1, b2, b3, b4, b5, b6, b7, b8, b9, b10, b11, b12, b13, b14, b15 c0, c1, c2, c3, c4, c5, c6, c7, c8, c9, c10, c11, c12, c13, c14, c15 end initlist a0 0,0 5,1 39,0 75,1 76,0 104,1 116,0 213,1 298,0 304,1 399,0 412,1 488,0 520,1 575,0 664,1 720,0 807,1 857,0 927,1 976,0 1065,1 1144,0 1180,1 1238,0 1323,1 1359,0 1370,1 1409,0 1411,1 1442,0 1456,1 1460,0 1553,1 1571,0 1588,1 1633,0 1667,1 1682,0 1683,1 1764,0 1796,1 1819,0 1883,1 1961,0 2034,1 2111,0 2206,1 2214,0 2303,1 2351,0 2405,1 2476,0 2548,1 2570,0 2575,1 2587,0 2598,1 2607,0 2662,1 2697,0 2764,1 2794,0 2833,1 2871,0 2969,1 3000,0 3073,1 3126,0 3154,1 3230,0 3268,1 3340,0 3348,1 3380,0 3424,1 3510,0 3570,1 3622,0 3700,1 3761,0 3809,1 3812,0 3831,1 3894,0 3979,1 4056,0 4153,1 4253,0 4337,1 4397,0 4461,1 4517,0 4532,1 4565,0 4592,1 4643,0 4656,1 4745,0 4780,1 4795,0 4883,1 4899,0 4960,1 5009,0 5022,1 5091,0 5095,1 5182,0 5194,1 5280,0 5326,1 5393,0 5457,1 5514,0 5535,1 5564,0 5579,1 5602,0 5690,1 5695,0 5778,1 5786,0 5852,1 5905,0 5940,1 5971,0 5994,1 6064,0 6145,1 6166,0 6185,1 6259,0 6287,1 6301,0 6343,1 6390,0 6472,1 6549,0 6577,1 6611,0 6711,1 6780,0 6850,1 6883,0 6969,1 7022,0 7104,1 7121,0 7182,1 7210,0 7269,1 end initlist a1 0,0 82,1 159,0 178,1 266,0 270,1 317,0 408,1 492,0 558,1 647,0 741,1 821,0 856,1 871,0 909,1 939,0 960,1 1018,0 1032,1 1089,0 1185,1 1203,0 1267,1 1299,0 1362,1 1431,0 1525,1 1585,0 1666,1 1728,0 1801,1 1852,0 1931,1 1948,0 1962,1 1979,0 2012,1 2098,0 2099,1 2155,0 2194,1 2230,0 2236,1 2290,0 2382,1 2463,0 2537,1 2602,0 2616,1 2694,0 2763,1 2833,0 2890,1 2923,0 2926,1 3023,0 3029,1 3052,0 3059,1 3077,0 3170,1 3239,0 3333,1 3338,0 3392,1 3481,0 3495,1 3540,0 3631,1 3703,0 3732,1 3734,0 3762,1 3793,0 3829,1 3852,0 3888,1 3897,0 3989,1 3994,0 4042,1 4100,0 4138,1 4179,0 4180,1 4235,0 4271,1 4322,0 4358,1 4373,0 4442,1 4493,0 4554,1 4645,0 4739,1 4779,0 4841,1 4925,0 4975,1 4990,0 5053,1 5092,0 5172,1 5195,0 5287,1 5357,0 5421,1 5482,0 5576,1 5586,0 5601,1 5615,0 5622,1 5635,0 5728,1 5777,0 5816,1 5891,0 5986,1 6062,0 6107,1 6188,0 6238,1 6258,0 6355,1 6438,0 6511,1 6522,0 6570,1 6601,0 6606,1 6657,0 6683,1 6736,0 6807,1 6841,0 6853,1 6883,0 6927,1 6947,0 6991,1 7064,0 7091,1 7154,0 7211,1 7273,0 7274,1 7352,0 7376,1 7400,0 7405,1 end initlist a2 0,0 84,1 156,0 234,1 252,0 288,1 380,0 387,1 417,0 432,1 529,0 571,1 602,0 693,1 732,0 802,1 898,0 932,1 998,0 1054,1 1108,0 1187,1 1247,0 1261,1 1337,0 1425,1 1469,0 1548,1 1596,0 1656,1 1674,0 1676,1 1683,0 1771,1 1804,0 1855,1 1909,0 1964,1 2008,0 2046,1 2124,0 2191,1 2288,0 2316,1 2399,0 2400,1 2487,0 2489,1 2508,0 2539,1 2568,0 2626,1 2717,0 2756,1 2788,0 2876,1 2895,0 2958,1 2987,0 3021,1 3030,0 3037,1 3070,0 3107,1 3145,0 3184,1 3188,0 3225,1 3256,0 3277,1 3365,0 3406,1 3443,0 3473,1 3538,0 3564,1 3606,0 3701,1 3747,0 3767,1 3818,0 3872,1 3915,0 4012,1 4060,0 4146,1 4168,0 4172,1 4240,0 4277,1 4291,0 4358,1 4379,0 4470,1 4499,0 4595,1 4611,0 4697,1 4786,0 4873,1 4884,0 4908,1 4987,0 5080,1 5117,0 5137,1 5211,0 5297,1 5349,0 5377,1 5394,0 5450,1 5506,0 5536,1 5540,0 5631,1 5665,0 5761,1 5850,0 5856,1 5929,0 6001,1 6093,0 6148,1 6157,0 6171,1 6264,0 6300,1 6380,0 6398,1 6442,0 6468,1 6564,0 6565,1 6647,0 6725,1 6822,0 6868,1 6915,0 6994,1 7033,0 7042,1 7108,0 7154,1 7196,0 7241,1 7276,0 7281,1 7362,0 7370,1 7421,0 7475,1 end initlist a3 0,0 100,1 157,0 248,1 268,0 271,1 289,0 352,1 368,0 407,1 428,0 528,1 551,0 651,1 705,0 718,1 739,0 757,1 804,0 864,1 932,0 982,1 1058,0 1101,1 1181,0 1259,1 1321,0 1385,1 1445,0 1531,1 1564,0 1582,1 1654,0 1713,1 1732,0 1780,1 1807,0 1823,1 1918,0 1960,1 1988,0 2068,1 2079,0 2104,1 2118,0 2197,1 2208,0 2291,1 2298,0 2349,1 2405,0 2406,1 2496,0 2572,1 2664,0 2670,1 2754,0 2854,1 2894,0 2984,1 3007,0 3049,1 3095,0 3157,1 3249,0 3266,1 3270,0 3339,1 3352,0 3369,1 3397,0 3452,1 3456,0 3534,1 3632,0 3724,1 3743,0 3816,1 3822,0 3916,1 3939,0 4018,1 4070,0 4110,1 4118,0 4206,1 4214,0 4232,1 4235,0 4280,1 4372,0 4432,1 4458,0 4466,1 4469,0 4526,1 4595,0 4661,1 4729,0 4752,1 4773,0 4827,1 4866,0 4959,1 5000,0 5062,1 5074,0 5161,1 5177,0 5195,1 5295,0 5342,1 5440,0 5510,1 5562,0 5626,1 5697,0 5757,1 5800,0 5856,1 5894,0 5954,1 6003,0 6029,1 6085,0 6152,1 6191,0 6244,1 6343,0 6417,1 6446,0 6467,1 6521,0 6601,1 6667,0 6668,1 6767,0 6863,1 6923,0 6942,1 6965,0 7028,1 7045,0 7137,1 7200,0 7248,1 7333,0 7348,1 7391,0 7402,1 7435,0 7524,1 end initlist a4 0,0 64,1 124,0 200,1 218,0 297,1 321,0 419,1 446,0 534,1 622,0 648,1 683,0 721,1 750,0 791,1 846,0 860,1 863,0 924,1 998,0 1016,1 1069,0 1101,1 1189,0 1193,1 1231,0 1236,1 1324,0 1372,1 1397,0 1490,1 1561,0 1565,1 1612,0 1687,1 1778,0 1813,1 1894,0 1934,1 1996,0 2043,1 2071,0 2119,1 2207,0 2218,1 2306,0 2314,1 2400,0 2491,1 2503,0 2593,1 2664,0 2738,1 2764,0 2825,1 2843,0 2881,1 2901,0 2989,1 3035,0 3109,1 3203,0 3261,1 3357,0 3452,1 3529,0 3581,1 3681,0 3745,1 3814,0 3899,1 3903,0 3925,1 3951,0 4016,1 4114,0 4118,1 4144,0 4177,1 4263,0 4269,1 4315,0 4329,1 4388,0 4426,1 4496,0 4509,1 4510,0 4595,1 4660,0 4729,1 4816,0 4908,1 4945,0 4967,1 5044,0 5048,1 5146,0 5214,1 5254,0 5258,1 5304,0 5330,1 5380,0 5436,1 5495,0 5523,1 5610,0 5677,1 5697,0 5755,1 5814,0 5905,1 5932,0 5972,1 5990,0 6004,1 6101,0 6140,1 6205,0 6266,1 6348,0 6412,1 6436,0 6483,1 6534,0 6603,1 6687,0 6717,1 6742,0 6792,1 6801,0 6828,1 6882,0 6965,1 6978,0 7065,1 7089,0 7165,1 7208,0 7287,1 7316,0 7362,1 7428,0 7459,1 7494,0 7531,1 7532,0 7533,1 7610,0 7652,1 end initlist a5 0,0 18,1 80,0 111,1 134,0 158,1 213,0 234,1 333,0 334,1 395,0 492,1 587,0 637,1 671,0 716,1 745,0 760,1 833,0 847,1 851,0 901,1 999,0 1074,1 1144,0 1153,1 1187,0 1256,1 1345,0 1421,1 1452,0 1536,1 1624,0 1698,1 1775,0 1843,1 1920,0 1979,1 2045,0 2124,1 2159,0 2211,1 2236,0 2300,1 2326,0 2329,1 2424,0 2483,1 2534,0 2591,1 2656,0 2683,1 2730,0 2797,1 2801,0 2869,1 2963,0 3063,1 3084,0 3158,1 3175,0 3192,1 3245,0 3252,1 3332,0 3416,1 3506,0 3550,1 3570,0 3583,1 3631,0 3644,1 3691,0 3723,1 3805,0 3856,1 3900,0 3947,1 4003,0 4087,1 4178,0 4200,1 4286,0 4365,1 4383,0 4464,1 4538,0 4571,1 4667,0 4752,1 4845,0 4910,1 4932,0 5022,1 5053,0 5126,1 5150,0 5170,1 5175,0 5208,1 5279,0 5379,1 5403,0 5425,1 5459,0 5478,1 5498,0 5563,1 5591,0 5633,1 5705,0 5758,1 5770,0 5825,1 5903,0 5961,1 6024,0 6029,1 6088,0 6177,1 6263,0 6304,1 6312,0 6327,1 6339,0 6426,1 6510,0 6546,1 6608,0 6670,1 6735,0 6764,1 6843,0 6889,1 6925,0 6960,1 6997,0 7091,1 7175,0 7247,1 7289,0 7356,1 7383,0 7412,1 7462,0 7528,1 7576,0 7645,1 7724,0 7773,1 7860,0 7891,1 end initlist a6 0,0 60,1 91,0 129,1 171,0 208,1 262,0 293,1 363,0 364,1 399,0 495,1 548,0 562,1 636,0 698,1 758,0 766,1 787,0 803,1 817,0 894,1 954,0 1019,1 1053,0 1146,1 1167,0 1246,1 1275,0 1310,1 1343,0 1405,1 1457,0 1514,1 1554,0 1593,1 1657,0 1671,1 1747,0 1836,1 1873,0 1882,1 1942,0 1984,1 2027,0 2114,1 2166,0 2225,1 2230,0 2233,1 2293,0 2321,1 2421,0 2429,1 2470,0 2487,1 2543,0 2584,1 2637,0 2680,1 2731,0 2793,1 2883,0 2888,1 2967,0 3017,1 3068,0 3069,1 3117,0 3186,1 3232,0 3306,1 3364,0 3365,1 3409,0 3433,1 3484,0 3553,1 3608,0 3665,1 3690,0 3732,1 3758,0 3836,1 3873,0 3957,1 4014,0 4048,1 4050,0 4147,1 4205,0 4280,1 4355,0 4406,1 4493,0 4570,1 4620,0 4652,1 4673,0 4681,1 4703,0 4749,1 4841,0 4889,1 4942,0 5034,1 5120,0 5213,1 5228,0 5262,1 5338,0 5418,1 5471,0 5554,1 5635,0 5725,1 5763,0 5790,1 5886,0 5904,1 5937,0 5971,1 5985,0 6046,1 6135,0 6148,1 6198,0 6247,1 6339,0 6385,1 6475,0 6553,1 6651,0 6705,1 6801,0 6878,1 6966,0 7013,1 7044,0 7047,1 7096,0 7190,1 7248,0 7273,1 7313,0 7381,1 7460,0 7528,1 7589,0 7669,1 7693,0 7758,1 end initlist a7 0,0 45,1 143,0 224,1 295,0 299,1 350,0 361,1 418,0 475,1 483,0 566,1 584,0 624,1 698,0 756,1 787,0 882,1 977,0 1002,1 1083,0 1088,1 1160,0 1240,1 1296,0 1382,1 1465,0 1504,1 1559,0 1587,1 1634,0 1729,1 1816,0 1843,1 1928,0 1961,1 1973,0 1983,1 2076,0 2120,1 2216,0 2263,1 2329,0 2384,1 2435,0 2486,1 2488,0 2557,1 2652,0 2742,1 2781,0 2812,1 2832,0 2876,1 2933,0 2986,1 3048,0 3133,1 3224,0 3297,1 3391,0 3477,1 3562,0 3646,1 3717,0 3781,1 3837,0 3898,1 3935,0 4023,1 4058,0 4094,1 4104,0 4203,1 4267,0 4291,1 4358,0 4365,1 4419,0 4434,1 4461,0 4529,1 4555,0 4595,1 4656,0 4750,1 4849,0 4926,1 4958,0 5013,1 5085,0 5121,1 5148,0 5182,1 5184,0 5276,1 5277,0 5308,1 5330,0 5343,1 5398,0 5402,1 5447,0 5489,1 5498,0 5564,1 5599,0 5646,1 5683,0 5687,1 5693,0 5782,1 5801,0 5807,1 5827,0 5872,1 5877,0 5883,1 5970,0 5980,1 6075,0 6160,1 6205,0 6246,1 6340,0 6434,1 6523,0 6590,1 6607,0 6620,1 6686,0 6689,1 6698,0 6761,1 6844,0 6918,1 7007,0 7055,1 7152,0 7241,1 7299,0 7357,1 7456,0 7504,1 7511,0 7533,1 7567,0 7573,1 7580,0 7680,1 7746,0 7833,1 end initlist a8 0,0 67,1 131,0 226,1 317,0 394,1 454,0 519,1 532,0 580,1 605,0 652,1 709,0 764,1 803,0 880,1 958,0 1042,1 1070,0 1156,1 1183,0 1243,1 1259,0 1331,1 1398,0 1488,1 1546,0 1608,1 1690,0 1703,1 1712,0 1752,1 1817,0 1891,1 1919,0 1992,1 2066,0 2105,1 2181,0 2244,1 2245,0 2316,1 2381,0 2407,1 2442,0 2446,1 2511,0 2523,1 2564,0 2571,1 2619,0 2702,1 2751,0 2787,1 2801,0 2871,1 2910,0 3006,1 3026,0 3093,1 3149,0 3212,1 3225,0 3234,1 3245,0 3323,1 3416,0 3431,1 3508,0 3516,1 3613,0 3631,1 3699,0 3742,1 3794,0 3870,1 3948,0 4016,1 4023,0 4106,1 4195,0 4230,1 4330,0 4414,1 4513,0 4562,1 4618,0 4689,1 4763,0 4810,1 4840,0 4919,1 4941,0 4985,1 5061,0 5159,1 5171,0 5248,1 5250,0 5277,1 5344,0 5406,1 5491,0 5591,1 5624,0 5697,1 5705,0 5732,1 5770,0 5838,1 5925,0 5977,1 5987,0 6065,1 6120,0 6180,1 6279,0 6326,1 6362,0 6456,1 6499,0 6584,1 6628,0 6669,1 6736,0 6753,1 6813,0 6825,1 6864,0 6876,1 6931,0 7013,1 7092,0 7140,1 7222,0 7275,1 7357,0 7414,1 7439,0 7524,1 7558,0 7605,1 7701,0 7779,1 7854,0 7946,1 8044,0 8110,1 8138,0 8200,1 8276,0 8300,1 end initlist a9 0,0 25,1 116,0 198,1 264,0 275,1 353,0 412,1 502,0 523,1 567,0 629,1 726,0 813,1 825,0 842,1 915,0 993,1 1037,0 1102,1 1182,0 1270,1 1313,0 1371,1 1416,0 1496,1 1575,0 1589,1 1624,0 1706,1 1729,0 1743,1 1754,0 1844,1 1905,0 1922,1 1967,0 2022,1 2028,0 2122,1 2206,0 2288,1 2329,0 2399,1 2416,0 2486,1 2549,0 2644,1 2740,0 2790,1 2874,0 2933,1 3033,0 3120,1 3192,0 3272,1 3336,0 3421,1 3450,0 3519,1 3540,0 3615,1 3651,0 3658,1 3660,0 3755,1 3837,0 3922,1 3983,0 4054,1 4094,0 4133,1 4168,0 4249,1 4285,0 4304,1 4373,0 4438,1 4473,0 4488,1 4510,0 4597,1 4697,0 4728,1 4780,0 4808,1 4874,0 4927,1 5004,0 5081,1 5128,0 5178,1 5205,0 5245,1 5340,0 5419,1 5453,0 5464,1 5524,0 5574,1 5637,0 5647,1 5689,0 5695,1 5768,0 5791,1 5879,0 5947,1 5983,0 6003,1 6005,0 6079,1 6132,0 6157,1 6188,0 6211,1 6212,0 6299,1 6315,0 6358,1 6381,0 6408,1 6429,0 6526,1 6610,0 6669,1 6724,0 6809,1 6869,0 6929,1 6983,0 7069,1 7104,0 7151,1 7241,0 7293,1 7309,0 7375,1 7396,0 7450,1 7548,0 7568,1 7645,0 7741,1 7807,0 7848,1 7859,0 7905,1 7948,0 8016,1 8100,0 8126,1 end initlist a10 0,0 26,1 102,0 189,1 282,0 300,1 392,0 421,1 453,0 500,1 590,0 642,1 663,0 692,1 738,0 797,1 859,0 955,1 1054,0 1122,1 1140,0 1227,1 1256,0 1323,1 1376,0 1466,1 1490,0 1513,1 1539,0 1593,1 1675,0 1690,1 1711,0 1737,1 1743,0 1760,1 1804,0 1863,1 1908,0 1962,1 2058,0 2151,1 2207,0 2270,1 2362,0 2462,1 2528,0 2560,1 2599,0 2673,1 2698,0 2781,1 2842,0 2857,1 2953,0 2967,1 2973,0 3010,1 3082,0 3153,1 3239,0 3312,1 3316,0 3322,1 3385,0 3426,1 3477,0 3494,1 3517,0 3562,1 3590,0 3672,1 3683,0 3707,1 3747,0 3792,1 3861,0 3958,1 4038,0 4132,1 4203,0 4300,1 4305,0 4370,1 4447,0 4463,1 4542,0 4638,1 4673,0 4697,1 4755,0 4800,1 4817,0 4882,1 4937,0 5025,1 5098,0 5172,1 5255,0 5300,1 5301,0 5367,1 5424,0 5461,1 5510,0 5521,1 5594,0 5645,1 5728,0 5782,1 5817,0 5878,1 5898,0 5927,1 5934,0 5986,1 5994,0 6050,1 6085,0 6091,1 6190,0 6237,1 6250,0 6347,1 6430,0 6437,1 6504,0 6570,1 6639,0 6682,1 6729,0 6762,1 6802,0 6805,1 6846,0 6939,1 7011,0 7076,1 7082,0 7096,1 7119,0 7164,1 7198,0 7285,1 7355,0 7388,1 7411,0 7435,1 7508,0 7569,1 7591,0 7680,1 end initlist a11 0,0 78,1 133,0 227,1 232,0 250,1 317,0 394,1 455,0 531,1 597,0 661,1 701,0 778,1 789,0 805,1 833,0 908,1 957,0 1026,1 1068,0 1115,1 1153,0 1204,1 1221,0 1223,1 1248,0 1341,1 1410,0 1440,1 1452,0 1523,1 1598,0 1642,1 1711,0 1773,1 1831,0 1894,1 1990,0 2084,1 2104,0 2176,1 2231,0 2313,1 2411,0 2475,1 2562,0 2633,1 2725,0 2825,1 2895,0 2985,1 3046,0 3095,1 3097,0 3164,1 3169,0 3205,1 3284,0 3364,1 3438,0 3440,1 3502,0 3580,1 3626,0 3641,1 3648,0 3685,1 3703,0 3784,1 3806,0 3905,1 3931,0 3972,1 4056,0 4063,1 4159,0 4165,1 4255,0 4258,1 4305,0 4353,1 4447,0 4451,1 4512,0 4558,1 4586,0 4630,1 4712,0 4807,1 4811,0 4882,1 4948,0 4990,1 5002,0 5050,1 5064,0 5110,1 5159,0 5238,1 5256,0 5278,1 5326,0 5350,1 5420,0 5476,1 5526,0 5592,1 5648,0 5699,1 5746,0 5830,1 5863,0 5911,1 5941,0 5947,1 6041,0 6065,1 6159,0 6180,1 6275,0 6305,1 6371,0 6395,1 6473,0 6532,1 6543,0 6616,1 6649,0 6742,1 6751,0 6786,1 6807,0 6873,1 6928,0 6983,1 7012,0 7076,1 7087,0 7147,1 7192,0 7270,1 7275,0 7320,1 7419,0 7455,1 7499,0 7509,1 7583,0 7681,1 7726,0 7769,1 end initlist a12 0,0 89,1 161,0 258,1 286,0 362,1 443,0 466,1 529,0 541,1 552,0 599,1 610,0 629,1 641,0 660,1 682,0 686,1 703,0 732,1 782,0 859,1 900,0 973,1 1044,0 1102,1 1192,0 1236,1 1287,0 1317,1 1353,0 1374,1 1383,0 1446,1 1498,0 1532,1 1561,0 1659,1 1746,0 1755,1 1849,0 1923,1 1963,0 2053,1 2070,0 2076,1 2124,0 2137,1 2140,0 2209,1 2298,0 2368,1 2392,0 2450,1 2453,0 2466,1 2492,0 2500,1 2570,0 2655,1 2735,0 2795,1 2887,0 2982,1 3047,0 3111,1 3149,0 3198,1 3258,0 3324,1 3392,0 3473,1 3507,0 3515,1 3530,0 3622,1 3653,0 3727,1 3791,0 3829,1 3854,0 3923,1 3970,0 3994,1 3999,0 4015,1 4047,0 4056,1 4128,0 4209,1 4222,0 4281,1 4294,0 4328,1 4336,0 4397,1 4405,0 4473,1 4512,0 4529,1 4558,0 4657,1 4716,0 4781,1 4849,0 4919,1 4978,0 4981,1 5025,0 5114,1 5161,0 5200,1 5278,0 5316,1 5324,0 5408,1 5444,0 5518,1 5608,0 5708,1 5738,0 5795,1 5838,0 5934,1 6009,0 6013,1 6036,0 6067,1 6101,0 6187,1 6222,0 6285,1 6308,0 6310,1 6312,0 6356,1 6456,0 6532,1 6545,0 6619,1 6632,0 6726,1 6752,0 6797,1 6812,0 6876,1 6918,0 6946,1 6958,0 6967,1 7041,0 7124,1 end initlist a13 0,0 29,1 129,0 153,1 198,0 290,1 354,0 402,1 492,0 588,1 645,0 715,1 769,0 836,1 900,0 978,1 984,0 1054,1 1096,0 1137,1 1212,0 1312,1 1402,0 1487,1 1576,0 1656,1 1729,0 1804,1 1878,0 1960,1 2014,0 2072,1 2149,0 2249,1 2315,0 2349,1 2430,0 2504,1 2517,0 2572,1 2615,0 2632,1 2710,0 2776,1 2846,0 2942,1 2965,0 3036,1 3106,0 3137,1 3159,0 3228,1 3279,0 3303,1 3342,0 3378,1 3443,0 3456,1 3517,0 3546,1 3586,0 3681,1 3767,0 3855,1 3923,0 3981,1 4012,0 4097,1 4177,0 4233,1 4296,0 4320,1 4356,0 4456,1 4466,0 4475,1 4494,0 4575,1 4618,0 4620,1 4642,0 4695,1 4786,0 4795,1 4877,0 4970,1 5020,0 5084,1 5139,0 5222,1 5265,0 5323,1 5389,0 5419,1 5476,0 5546,1 5549,0 5574,1 5662,0 5717,1 5741,0 5769,1 5830,0 5839,1 5905,0 6000,1 6023,0 6071,1 6099,0 6172,1 6231,0 6324,1 6345,0 6423,1 6442,0 6449,1 6538,0 6587,1 6677,0 6691,1 6789,0 6793,1 6844,0 6873,1 6921,0 6981,1 6992,0 7009,1 7080,0 7129,1 7197,0 7272,1 7344,0 7359,1 7414,0 7475,1 7530,0 7604,1 7623,0 7692,1 7773,0 7775,1 7804,0 7904,1 7933,0 7940,1 8037,0 8120,1 8164,0 8256,1 8324,0 8396,1 end initlist a14 0,0 28,1 98,0 151,1 152,0 185,1 282,0 325,1 414,0 446,1 500,0 531,1 554,0 620,1 676,0 737,1 807,0 832,1 881,0 978,1 1063,0 1100,1 1183,0 1243,1 1325,0 1418,1 1458,0 1516,1 1607,0 1629,1 1658,0 1710,1 1786,0 1831,1 1913,0 1926,1 1963,0 1991,1 2067,0 2114,1 2206,0 2242,1 2336,0 2409,1 2483,0 2583,1 2608,0 2693,1 2759,0 2788,1 2794,0 2882,1 2978,0 3065,1 3154,0 3199,1 3230,0 3293,1 3333,0 3368,1 3439,0 3494,1 3578,0 3638,1 3656,0 3730,1 3821,0 3899,1 3924,0 3986,1 4013,0 4015,1 4081,0 4165,1 4199,0 4210,1 4268,0 4285,1 4341,0 4391,1 4421,0 4512,1 4591,0 4629,1 4699,0 4791,1 4818,0 4877,1 4916,0 4982,1 5040,0 5070,1 5098,0 5135,1 5177,0 5253,1 5336,0 5379,1 5405,0 5413,1 5441,0 5514,1 5585,0 5633,1 5667,0 5752,1 5788,0 5869,1 5943,0 6025,1 6035,0 6102,1 6180,0 6273,1 6316,0 6376,1 6463,0 6532,1 6613,0 6689,1 6728,0 6824,1 6904,0 6917,1 7007,0 7031,1 7087,0 7135,1 7216,0 7263,1 7311,0 7333,1 7375,0 7416,1 7427,0 7432,1 7477,0 7524,1 7596,0 7614,1 7622,0 7700,1 7744,0 7760,1 7805,0 7880,1 7924,0 7956,1 7967,0 8015,1 8069,0 8120,1 end initlist a15 0,0 63,1 149,0 181,1 209,0 211,1 298,0 385,1 393,0 398,1 439,0 528,1 529,0 618,1 663,0 716,1 789,0 858,1 931,0 972,1 1012,0 1026,1 1096,0 1117,1 1188,0 1232,1 1316,0 1362,1 1430,0 1454,1 1533,0 1613,1 1622,0 1710,1 1785,0 1796,1 1837,0 1838,1 1895,0 1898,1 1971,0 2065,1 2080,0 2086,1 2183,0 2188,1 2261,0 2275,1 2358,0 2454,1 2545,0 2565,1 2585,0 2678,1 2680,0 2702,1 2738,0 2764,1 2800,0 2826,1 2855,0 2938,1 2956,0 2999,1 3006,0 3101,1 3168,0 3237,1 3316,0 3336,1 3365,0 3377,1 3446,0 3461,1 3555,0 3584,1 3588,0 3667,1 3716,0 3778,1 3805,0 3884,1 3962,0 3967,1 4035,0 4074,1 4136,0 4142,1 4168,0 4182,1 4202,0 4270,1 4283,0 4326,1 4375,0 4427,1 4432,0 4445,1 4534,0 4562,1 4586,0 4665,1 4716,0 4777,1 4810,0 4861,1 4883,0 4909,1 4943,0 5017,1 5033,0 5077,1 5108,0 5189,1 5215,0 5309,1 5394,0 5475,1 5547,0 5609,1 5658,0 5702,1 5725,0 5746,1 5826,0 5829,1 5924,0 5952,1 5956,0 6037,1 6060,0 6108,1 6204,0 6302,1 6382,0 6440,1 6487,0 6496,1 6573,0 6623,1 6673,0 6680,1 6718,0 6762,1 6787,0 6858,1 6864,0 6933,1 6976,0 7064,1 7115,0 7129,1 end initlist b0 0,0 50,1 120,0 216,1 270,0 331,1 348,0 416,1 473,0 571,1 663,0 722,1 741,0 821,1 826,0 845,1 913,0 955,1 988,0 1052,1 1074,0 1087,1 1098,0 1149,1 1181,0 1216,1 1242,0 1308,1 1313,0 1340,1 1422,0 1428,1 1450,0 1494,1 1571,0 1606,1 1666,0 1766,1 1795,0 1891,1 1929,0 2017,1 2077,0 2090,1 2106,0 2163,1 2224,0 2236,1 2264,0 2294,1 2339,0 2375,1 2452,0 2533,1 2578,0 2618,1 2662,0 2746,1 2819,0 2848,1 2929,0 2937,1 2939,0 3028,1 3052,0 3061,1 3132,0 3144,1 3219,0 3294,1 3366,0 3463,1 3470,0 3486,1 3543,0 3602,1 3671,0 3746,1 3827,0 3865,1 3905,0 3923,1 3993,0 4093,1 4145,0 4167,1 4168,0 4234,1 4281,0 4302,1 4343,0 4371,1 4397,0 4476,1 4552,0 4640,1 4727,0 4809,1 4871,0 4882,1 4923,0 4982,1 5072,0 5105,1 5167,0 5223,1 5308,0 5339,1 5343,0 5356,1 5430,0 5483,1 5565,0 5612,1 5627,0 5678,1 5727,0 5803,1 5856,0 5866,1 5904,0 5943,1 6000,0 6042,1 6102,0 6115,1 6173,0 6254,1 6346,0 6443,1 6473,0 6497,1 6574,0 6633,1 6658,0 6757,1 6802,0 6829,1 6843,0 6893,1 6987,0 7086,1 7159,0 7186,1 7273,0 7373,1 7388,0 7472,1 7494,0 7533,1 7629,0 7704,1 end initlist b1 0,0 30,1 70,0 116,1 175,0 250,1 345,0 402,1 425,0 455,1 495,0 583,1 626,0 627,1 721,0 753,1 761,0 805,1 869,0 924,1 926,0 1002,1 1017,0 1111,1 1145,0 1204,1 1254,0 1290,1 1327,0 1374,1 1464,0 1504,1 1507,0 1579,1 1660,0 1742,1 1793,0 1796,1 1867,0 1902,1 1904,0 1936,1 1976,0 1991,1 2009,0 2068,1 2112,0 2160,1 2259,0 2305,1 2315,0 2414,1 2465,0 2560,1 2613,0 2689,1 2729,0 2770,1 2847,0 2900,1 2918,0 2939,1 2978,0 3062,1 3115,0 3170,1 3236,0 3270,1 3347,0 3380,1 3450,0 3455,1 3472,0 3478,1 3555,0 3560,1 3571,0 3575,1 3624,0 3721,1 3760,0 3761,1 3824,0 3911,1 3921,0 4015,1 4082,0 4134,1 4174,0 4197,1 4208,0 4278,1 4335,0 4370,1 4397,0 4445,1 4529,0 4574,1 4596,0 4665,1 4748,0 4757,1 4803,0 4894,1 4933,0 4948,1 4977,0 5046,1 5057,0 5138,1 5216,0 5270,1 5333,0 5383,1 5435,0 5491,1 5520,0 5561,1 5626,0 5631,1 5725,0 5737,1 5794,0 5825,1 5863,0 5946,1 5976,0 6061,1 6069,0 6085,1 6108,0 6159,1 6207,0 6286,1 6375,0 6463,1 6544,0 6603,1 6633,0 6694,1 6744,0 6804,1 6843,0 6869,1 6966,0 7027,1 7085,0 7088,1 7145,0 7155,1 7162,0 7215,1 end initlist b2 0,0 7,1 37,0 82,1 146,0 214,1 252,0 285,1 339,0 387,1 388,0 477,1 571,0 587,1 614,0 675,1 757,0 817,1 914,0 988,1 1048,0 1124,1 1209,0 1272,1 1285,0 1298,1 1317,0 1387,1 1423,0 1438,1 1515,0 1550,1 1565,0 1582,1 1660,0 1712,1 1727,0 1744,1 1814,0 1817,1 1887,0 1949,1 1988,0 2030,1 2040,0 2120,1 2172,0 2270,1 2350,0 2414,1 2484,0 2512,1 2578,0 2613,1 2673,0 2709,1 2788,0 2872,1 2908,0 2998,1 3040,0 3079,1 3169,0 3181,1 3191,0 3216,1 3244,0 3306,1 3327,0 3420,1 3452,0 3472,1 3480,0 3554,1 3607,0 3643,1 3655,0 3700,1 3733,0 3770,1 3860,0 3868,1 3938,0 4026,1 4086,0 4182,1 4237,0 4336,1 4427,0 4483,1 4494,0 4553,1 4582,0 4626,1 4676,0 4775,1 4813,0 4836,1 4922,0 5012,1 5080,0 5178,1 5258,0 5280,1 5283,0 5353,1 5367,0 5404,1 5422,0 5471,1 5511,0 5518,1 5530,0 5536,1 5547,0 5591,1 5667,0 5763,1 5811,0 5899,1 5988,0 6015,1 6024,0 6072,1 6077,0 6126,1 6182,0 6209,1 6301,0 6378,1 6452,0 6494,1 6585,0 6597,1 6669,0 6674,1 6759,0 6762,1 6799,0 6884,1 6885,0 6947,1 6976,0 7027,1 7113,0 7129,1 7167,0 7258,1 7296,0 7328,1 7418,0 7479,1 end initlist b3 0,0 10,1 53,0 142,1 202,0 216,1 239,0 310,1 333,0 386,1 392,0 481,1 531,0 587,1 641,0 727,1 755,0 772,1 833,0 895,1 899,0 940,1 982,0 1072,1 1081,0 1125,1 1142,0 1185,1 1237,0 1243,1 1298,0 1304,1 1355,0 1395,1 1491,0 1545,1 1546,0 1564,1 1567,0 1619,1 1638,0 1648,1 1652,0 1733,1 1764,0 1853,1 1936,0 1971,1 2056,0 2126,1 2168,0 2245,1 2337,0 2370,1 2440,0 2509,1 2534,0 2552,1 2601,0 2622,1 2662,0 2751,1 2782,0 2794,1 2799,0 2836,1 2886,0 2936,1 2995,0 3031,1 3052,0 3145,1 3165,0 3240,1 3311,0 3314,1 3342,0 3423,1 3488,0 3578,1 3652,0 3653,1 3751,0 3765,1 3822,0 3906,1 3942,0 3991,1 4019,0 4080,1 4166,0 4193,1 4224,0 4292,1 4382,0 4457,1 4515,0 4579,1 4633,0 4713,1 4770,0 4791,1 4793,0 4834,1 4890,0 4904,1 4990,0 5076,1 5148,0 5190,1 5275,0 5371,1 5403,0 5467,1 5552,0 5643,1 5681,0 5753,1 5767,0 5775,1 5806,0 5822,1 5897,0 5976,1 6063,0 6145,1 6193,0 6282,1 6371,0 6373,1 6466,0 6545,1 6554,0 6561,1 6645,0 6664,1 6753,0 6826,1 6905,0 6992,1 7016,0 7050,1 7076,0 7086,1 7163,0 7188,1 7261,0 7290,1 7361,0 7461,1 7546,0 7572,1 end initlist b4 0,0 97,1 196,0 204,1 264,0 341,1 372,0 392,1 484,0 491,1 561,0 586,1 680,0 730,1 813,0 913,1 936,0 947,1 974,0 1030,1 1080,0 1128,1 1179,0 1267,1 1287,0 1294,1 1311,0 1383,1 1395,0 1436,1 1532,0 1576,1 1655,0 1687,1 1718,0 1774,1 1839,0 1897,1 1930,0 2027,1 2121,0 2148,1 2178,0 2232,1 2261,0 2335,1 2375,0 2455,1 2487,0 2574,1 2587,0 2606,1 2661,0 2712,1 2789,0 2870,1 2961,0 2968,1 3052,0 3068,1 3093,0 3163,1 3187,0 3242,1 3319,0 3368,1 3457,0 3497,1 3542,0 3591,1 3598,0 3620,1 3677,0 3749,1 3842,0 3933,1 4029,0 4073,1 4118,0 4135,1 4214,0 4309,1 4406,0 4443,1 4517,0 4578,1 4667,0 4716,1 4804,0 4818,1 4902,0 4962,1 4996,0 4997,1 5034,0 5132,1 5222,0 5264,1 5359,0 5424,1 5426,0 5488,1 5493,0 5519,1 5596,0 5661,1 5670,0 5714,1 5740,0 5745,1 5838,0 5898,1 5949,0 5964,1 5984,0 5997,1 6005,0 6080,1 6126,0 6203,1 6238,0 6329,1 6395,0 6433,1 6476,0 6496,1 6529,0 6588,1 6607,0 6653,1 6686,0 6769,1 6846,0 6882,1 6949,0 7015,1 7038,0 7084,1 7152,0 7162,1 7257,0 7330,1 7410,0 7471,1 7510,0 7516,1 7592,0 7596,1 7642,0 7674,1 7690,0 7717,1 end initlist b5 0,0 42,1 103,0 111,1 141,0 232,1 295,0 356,1 367,0 419,1 425,0 429,1 458,0 543,1 562,0 596,1 614,0 688,1 769,0 845,1 929,0 1029,1 1060,0 1113,1 1166,0 1182,1 1220,0 1293,1 1327,0 1418,1 1493,0 1580,1 1628,0 1695,1 1741,0 1785,1 1880,0 1911,1 1977,0 2005,1 2044,0 2113,1 2137,0 2237,1 2320,0 2374,1 2427,0 2501,1 2581,0 2595,1 2694,0 2732,1 2800,0 2854,1 2948,0 3034,1 3119,0 3195,1 3206,0 3230,1 3295,0 3308,1 3330,0 3353,1 3383,0 3440,1 3504,0 3533,1 3544,0 3592,1 3597,0 3655,1 3710,0 3739,1 3759,0 3788,1 3887,0 3890,1 3905,0 3980,1 3998,0 4028,1 4041,0 4072,1 4085,0 4122,1 4207,0 4240,1 4321,0 4411,1 4439,0 4459,1 4516,0 4591,1 4623,0 4627,1 4647,0 4661,1 4699,0 4703,1 4781,0 4836,1 4912,0 4957,1 5015,0 5020,1 5089,0 5138,1 5204,0 5227,1 5283,0 5328,1 5364,0 5427,1 5501,0 5573,1 5617,0 5672,1 5749,0 5751,1 5815,0 5841,1 5895,0 5933,1 6014,0 6088,1 6172,0 6174,1 6259,0 6299,1 6358,0 6368,1 6402,0 6434,1 6493,0 6558,1 6649,0 6659,1 6717,0 6772,1 6810,0 6909,1 6998,0 7077,1 7157,0 7215,1 7225,0 7301,1 7325,0 7386,1 7436,0 7442,1 end initlist b6 0,0 99,1 191,0 220,1 243,0 277,1 343,0 385,1 433,0 476,1 491,0 552,1 634,0 660,1 699,0 726,1 810,0 836,1 891,0 901,1 979,0 1069,1 1108,0 1196,1 1235,0 1300,1 1378,0 1473,1 1492,0 1499,1 1588,0 1598,1 1642,0 1742,1 1774,0 1851,1 1860,0 1956,1 1957,0 1997,1 2033,0 2064,1 2113,0 2164,1 2165,0 2170,1 2247,0 2291,1 2304,0 2364,1 2376,0 2413,1 2449,0 2493,1 2533,0 2563,1 2656,0 2701,1 2712,0 2718,1 2796,0 2815,1 2854,0 2881,1 2931,0 2993,1 3046,0 3096,1 3115,0 3207,1 3246,0 3296,1 3312,0 3360,1 3420,0 3469,1 3504,0 3570,1 3591,0 3592,1 3665,0 3706,1 3713,0 3762,1 3857,0 3882,1 3940,0 3987,1 4058,0 4153,1 4189,0 4196,1 4282,0 4320,1 4399,0 4432,1 4506,0 4556,1 4565,0 4647,1 4742,0 4842,1 4927,0 5002,1 5021,0 5057,1 5098,0 5183,1 5202,0 5216,1 5313,0 5353,1 5451,0 5542,1 5548,0 5550,1 5633,0 5720,1 5741,0 5759,1 5840,0 5882,1 5973,0 5997,1 6054,0 6150,1 6157,0 6194,1 6226,0 6243,1 6244,0 6323,1 6337,0 6394,1 6489,0 6505,1 6588,0 6618,1 6661,0 6666,1 6704,0 6783,1 6823,0 6842,1 6891,0 6961,1 7010,0 7013,1 7028,0 7090,1 7135,0 7214,1 end initlist b7 0,0 43,1 53,0 148,1 191,0 225,1 302,0 320,1 321,0 408,1 487,0 532,1 540,0 569,1 586,0 593,1 661,0 759,1 807,0 853,1 891,0 942,1 997,0 1082,1 1152,0 1225,1 1260,0 1324,1 1363,0 1435,1 1518,0 1608,1 1678,0 1754,1 1765,0 1838,1 1839,0 1937,1 1989,0 2021,1 2058,0 2063,1 2081,0 2140,1 2170,0 2171,1 2174,0 2216,1 2314,0 2374,1 2427,0 2478,1 2539,0 2542,1 2630,0 2679,1 2767,0 2833,1 2873,0 2904,1 2985,0 3072,1 3109,0 3129,1 3225,0 3236,1 3280,0 3315,1 3322,0 3330,1 3421,0 3458,1 3521,0 3551,1 3591,0 3603,1 3636,0 3685,1 3698,0 3729,1 3767,0 3809,1 3864,0 3924,1 3964,0 4057,1 4141,0 4180,1 4200,0 4278,1 4304,0 4339,1 4342,0 4427,1 4508,0 4513,1 4542,0 4595,1 4650,0 4709,1 4749,0 4844,1 4866,0 4951,1 5023,0 5064,1 5130,0 5216,1 5222,0 5321,1 5345,0 5352,1 5420,0 5492,1 5574,0 5648,1 5707,0 5729,1 5802,0 5855,1 5938,0 5969,1 6031,0 6084,1 6163,0 6199,1 6291,0 6311,1 6332,0 6401,1 6491,0 6516,1 6609,0 6697,1 6767,0 6866,1 6941,0 6976,1 7051,0 7066,1 7074,0 7122,1 7161,0 7189,1 7207,0 7241,1 7329,0 7402,1 7424,0 7425,1 7515,0 7522,1 end initlist b8 0,0 80,1 158,0 224,1 270,0 359,1 420,0 504,1 505,0 570,1 599,0 616,1 674,0 760,1 765,0 799,1 846,0 889,1 968,0 1045,1 1071,0 1162,1 1184,0 1223,1 1288,0 1336,1 1402,0 1442,1 1476,0 1533,1 1571,0 1581,1 1642,0 1691,1 1753,0 1833,1 1909,0 1917,1 1959,0 2012,1 2097,0 2153,1 2217,0 2256,1 2272,0 2295,1 2356,0 2406,1 2420,0 2452,1 2544,0 2591,1 2650,0 2657,1 2715,0 2799,1 2817,0 2874,1 2965,0 2999,1 3008,0 3088,1 3167,0 3169,1 3231,0 3237,1 3274,0 3307,1 3334,0 3343,1 3434,0 3525,1 3529,0 3538,1 3626,0 3702,1 3791,0 3817,1 3863,0 3955,1 3998,0 4002,1 4004,0 4079,1 4172,0 4242,1 4311,0 4318,1 4417,0 4487,1 4525,0 4615,1 4666,0 4732,1 4771,0 4809,1 4894,0 4919,1 4989,0 5031,1 5091,0 5129,1 5160,0 5193,1 5269,0 5342,1 5371,0 5413,1 5463,0 5469,1 5495,0 5553,1 5635,0 5663,1 5694,0 5786,1 5830,0 5839,1 5887,0 5953,1 5995,0 6041,1 6044,0 6126,1 6128,0 6206,1 6285,0 6301,1 6302,0 6313,1 6328,0 6346,1 6407,0 6415,1 6437,0 6501,1 6546,0 6551,1 6578,0 6657,1 6664,0 6680,1 6685,0 6773,1 6865,0 6949,1 6994,0 6996,1 7073,0 7140,1 7180,0 7264,1 end initlist b9 0,0 82,1 150,0 243,1 285,0 308,1 312,0 390,1 435,0 473,1 478,0 547,1 644,0 674,1 744,0 748,1 813,0 826,1 862,0 907,1 908,0 917,1 951,0 968,1 1048,0 1110,1 1150,0 1195,1 1291,0 1373,1 1473,0 1532,1 1578,0 1635,1 1696,0 1704,1 1800,0 1893,1 1952,0 1993,1 2035,0 2102,1 2187,0 2277,1 2360,0 2419,1 2516,0 2608,1 2629,0 2651,1 2748,0 2784,1 2870,0 2928,1 2963,0 3040,1 3070,0 3159,1 3194,0 3211,1 3277,0 3351,1 3365,0 3442,1 3533,0 3618,1 3703,0 3724,1 3807,0 3846,1 3926,0 3943,1 4028,0 4109,1 4115,0 4125,1 4142,0 4200,1 4240,0 4320,1 4378,0 4416,1 4459,0 4492,1 4571,0 4644,1 4735,0 4791,1 4855,0 4917,1 4953,0 4976,1 4978,0 5022,1 5028,0 5082,1 5139,0 5197,1 5245,0 5323,1 5325,0 5375,1 5472,0 5515,1 5601,0 5602,1 5630,0 5631,1 5680,0 5740,1 5753,0 5849,1 5903,0 5974,1 6003,0 6095,1 6141,0 6198,1 6255,0 6283,1 6288,0 6298,1 6300,0 6354,1 6454,0 6497,1 6540,0 6575,1 6593,0 6605,1 6617,0 6623,1 6660,0 6670,1 6770,0 6868,1 6884,0 6961,1 7040,0 7079,1 7126,0 7206,1 7242,0 7314,1 7386,0 7391,1 7483,0 7541,1 7579,0 7596,1 7687,0 7715,1 end initlist b10 0,0 30,1 88,0 100,1 119,0 155,1 178,0 223,1 321,0 395,1 415,0 427,1 467,0 482,1 499,0 565,1 654,0 705,1 716,0 736,1 757,0 759,1 814,0 823,1 887,0 957,1 1025,0 1104,1 1190,0 1192,1 1283,0 1337,1 1424,0 1481,1 1522,0 1540,1 1640,0 1701,1 1791,0 1794,1 1861,0 1904,1 1958,0 2013,1 2068,0 2111,1 2141,0 2241,1 2278,0 2345,1 2424,0 2457,1 2537,0 2612,1 2643,0 2693,1 2776,0 2806,1 2903,0 2984,1 3058,0 3063,1 3086,0 3131,1 3212,0 3237,1 3270,0 3317,1 3358,0 3420,1 3454,0 3460,1 3525,0 3619,1 3691,0 3741,1 3761,0 3837,1 3923,0 3952,1 3962,0 4024,1 4098,0 4110,1 4164,0 4195,1 4234,0 4293,1 4371,0 4435,1 4493,0 4509,1 4579,0 4588,1 4635,0 4658,1 4712,0 4715,1 4747,0 4777,1 4782,0 4822,1 4890,0 4990,1 5036,0 5122,1 5198,0 5210,1 5264,0 5328,1 5389,0 5395,1 5437,0 5462,1 5505,0 5592,1 5639,0 5667,1 5677,0 5726,1 5755,0 5799,1 5857,0 5876,1 5955,0 6010,1 6031,0 6081,1 6135,0 6227,1 6278,0 6367,1 6431,0 6490,1 6521,0 6575,1 6636,0 6686,1 6777,0 6872,1 6882,0 6910,1 7002,0 7071,1 7075,0 7097,1 7153,0 7191,1 7246,0 7330,1 7415,0 7513,1 end initlist b11 0,0 100,1 104,0 109,1 186,0 223,1 317,0 383,1 420,0 463,1 522,0 600,1 641,0 698,1 704,0 719,1 785,0 787,1 864,0 884,1 980,0 1030,1 1048,0 1090,1 1103,0 1164,1 1213,0 1273,1 1323,0 1397,1 1495,0 1560,1 1635,0 1724,1 1793,0 1858,1 1931,0 1935,1 1966,0 2023,1 2123,0 2147,1 2208,0 2249,1 2315,0 2390,1 2416,0 2466,1 2528,0 2610,1 2656,0 2676,1 2771,0 2831,1 2835,0 2870,1 2891,0 2976,1 3061,0 3127,1 3185,0 3261,1 3319,0 3365,1 3446,0 3487,1 3541,0 3610,1 3687,0 3699,1 3722,0 3743,1 3763,0 3804,1 3805,0 3831,1 3917,0 3946,1 4017,0 4024,1 4074,0 4166,1 4226,0 4271,1 4335,0 4387,1 4424,0 4447,1 4542,0 4589,1 4603,0 4626,1 4650,0 4724,1 4814,0 4821,1 4887,0 4958,1 5046,0 5059,1 5097,0 5126,1 5201,0 5283,1 5307,0 5395,1 5470,0 5490,1 5506,0 5538,1 5550,0 5626,1 5687,0 5781,1 5803,0 5823,1 5833,0 5932,1 5983,0 6013,1 6067,0 6137,1 6195,0 6220,1 6240,0 6280,1 6285,0 6362,1 6428,0 6465,1 6479,0 6487,1 6524,0 6608,1 6612,0 6631,1 6682,0 6683,1 6733,0 6832,1 6855,0 6918,1 6999,0 7039,1 7075,0 7167,1 7183,0 7261,1 7347,0 7414,1 7457,0 7483,1 end initlist b12 0,0 35,1 93,0 163,1 168,0 198,1 224,0 310,1 359,0 366,1 386,0 398,1 426,0 453,1 465,0 559,1 626,0 680,1 738,0 772,1 806,0 857,1 914,0 979,1 1020,0 1040,1 1075,0 1111,1 1142,0 1180,1 1256,0 1329,1 1406,0 1463,1 1549,0 1583,1 1647,0 1703,1 1735,0 1803,1 1889,0 1921,1 1988,0 2079,1 2083,0 2125,1 2175,0 2191,1 2222,0 2308,1 2361,0 2439,1 2494,0 2555,1 2620,0 2653,1 2689,0 2772,1 2779,0 2789,1 2888,0 2913,1 2966,0 3027,1 3054,0 3141,1 3213,0 3248,1 3327,0 3388,1 3467,0 3522,1 3586,0 3686,1 3718,0 3732,1 3744,0 3836,1 3893,0 3942,1 3988,0 4000,1 4090,0 4157,1 4182,0 4219,1 4269,0 4285,1 4326,0 4380,1 4422,0 4500,1 4575,0 4639,1 4665,0 4763,1 4819,0 4885,1 4886,0 4921,1 4974,0 5067,1 5092,0 5133,1 5144,0 5149,1 5232,0 5320,1 5335,0 5357,1 5448,0 5504,1 5548,0 5561,1 5602,0 5645,1 5714,0 5715,1 5755,0 5771,1 5845,0 5936,1 5958,0 6023,1 6075,0 6130,1 6228,0 6275,1 6343,0 6395,1 6430,0 6440,1 6486,0 6547,1 6637,0 6701,1 6780,0 6843,1 6848,0 6931,1 7029,0 7095,1 7194,0 7261,1 7339,0 7360,1 7393,0 7416,1 7438,0 7441,1 7471,0 7549,1 end initlist b13 0,0 78,1 129,0 139,1 144,0 220,1 254,0 322,1 396,0 449,1 453,0 532,1 630,0 672,1 764,0 787,1 842,0 860,1 886,0 959,1 982,0 1033,1 1089,0 1162,1 1176,0 1215,1 1244,0 1333,1 1376,0 1405,1 1417,0 1455,1 1532,0 1580,1 1679,0 1740,1 1803,0 1877,1 1974,0 2004,1 2052,0 2141,1 2232,0 2260,1 2274,0 2374,1 2403,0 2482,1 2515,0 2596,1 2652,0 2666,1 2669,0 2718,1 2750,0 2765,1 2842,0 2884,1 2932,0 2939,1 3037,0 3097,1 3177,0 3178,1 3256,0 3289,1 3315,0 3383,1 3388,0 3488,1 3546,0 3566,1 3655,0 3660,1 3711,0 3778,1 3848,0 3889,1 3908,0 3943,1 4028,0 4055,1 4089,0 4134,1 4207,0 4286,1 4290,0 4359,1 4435,0 4532,1 4567,0 4656,1 4664,0 4741,1 4764,0 4800,1 4811,0 4858,1 4953,0 5036,1 5104,0 5158,1 5236,0 5279,1 5359,0 5449,1 5506,0 5568,1 5624,0 5641,1 5684,0 5700,1 5701,0 5761,1 5786,0 5790,1 5848,0 5914,1 5931,0 5993,1 6070,0 6121,1 6185,0 6189,1 6268,0 6290,1 6344,0 6381,1 6391,0 6446,1 6546,0 6627,1 6707,0 6736,1 6765,0 6807,1 6823,0 6892,1 6937,0 7035,1 7074,0 7090,1 7120,0 7188,1 7276,0 7339,1 7416,0 7456,1 7495,0 7539,1 7603,0 7614,1 end initlist b14 0,0 48,1 71,0 142,1 154,0 252,1 307,0 355,1 392,0 470,1 532,0 591,1 685,0 760,1 778,0 802,1 856,0 891,1 905,0 954,1 956,0 973,1 1031,0 1047,1 1076,0 1108,1 1178,0 1256,1 1272,0 1338,1 1365,0 1374,1 1412,0 1431,1 1524,0 1562,1 1572,0 1583,1 1590,0 1645,1 1648,0 1659,1 1742,0 1750,1 1834,0 1894,1 1952,0 2032,1 2037,0 2113,1 2139,0 2233,1 2257,0 2342,1 2353,0 2442,1 2494,0 2553,1 2582,0 2629,1 2691,0 2732,1 2757,0 2809,1 2868,0 2873,1 2874,0 2933,1 2982,0 3026,1 3116,0 3150,1 3151,0 3196,1 3212,0 3247,1 3342,0 3423,1 3457,0 3521,1 3608,0 3625,1 3682,0 3779,1 3783,0 3852,1 3864,0 3937,1 3970,0 3997,1 4010,0 4092,1 4127,0 4156,1 4211,0 4214,1 4283,0 4306,1 4399,0 4441,1 4503,0 4602,1 4621,0 4681,1 4772,0 4841,1 4931,0 4953,1 4986,0 5024,1 5037,0 5089,1 5172,0 5214,1 5311,0 5338,1 5415,0 5473,1 5573,0 5580,1 5662,0 5683,1 5691,0 5732,1 5775,0 5811,1 5820,0 5827,1 5834,0 5906,1 5980,0 6066,1 6139,0 6142,1 6237,0 6265,1 6359,0 6411,1 6434,0 6451,1 6491,0 6582,1 6629,0 6706,1 6778,0 6872,1 6873,0 6943,1 7033,0 7046,1 7101,0 7155,1 end initlist b15 0,0 97,1 177,0 234,1 319,0 380,1 398,0 403,1 469,0 490,1 504,0 516,1 517,0 534,1 558,0 647,1 683,0 770,1 817,0 867,1 880,0 964,1 995,0 1092,1 1190,0 1263,1 1313,0 1403,1 1463,0 1507,1 1583,0 1639,1 1648,0 1740,1 1770,0 1855,1 1902,0 1927,1 1985,0 2082,1 2105,0 2108,1 2124,0 2170,1 2172,0 2201,1 2242,0 2243,1 2319,0 2387,1 2487,0 2552,1 2621,0 2659,1 2693,0 2727,1 2774,0 2855,1 2937,0 3014,1 3022,0 3065,1 3110,0 3145,1 3185,0 3206,1 3252,0 3322,1 3390,0 3398,1 3470,0 3546,1 3581,0 3617,1 3705,0 3758,1 3804,0 3862,1 3952,0 3965,1 4056,0 4114,1 4153,0 4185,1 4210,0 4305,1 4375,0 4433,1 4437,0 4473,1 4520,0 4597,1 4692,0 4773,1 4831,0 4886,1 4908,0 4960,1 4974,0 4977,1 5032,0 5106,1 5192,0 5216,1 5223,0 5323,1 5404,0 5413,1 5457,0 5501,1 5546,0 5559,1 5604,0 5666,1 5737,0 5742,1 5807,0 5865,1 5881,0 5972,1 6023,0 6106,1 6158,0 6203,1 6280,0 6304,1 6347,0 6431,1 6440,0 6487,1 6525,0 6611,1 6624,0 6649,1 6685,0 6740,1 6768,0 6864,1 6958,0 6968,1 6978,0 6997,1 7092,0 7114,1 7174,0 7245,1 7295,0 7317,1 7396,0 7458,1 7465,0 7556,1 end initlist c0 0,0 44,1 111,0 170,1 257,0 294,1 333,0 406,1 500,0 593,1 678,0 707,1 738,0 829,1 840,0 882,1 899,0 954,1 984,0 1014,1 1110,0 1203,1 1274,0 1324,1 1410,0 1478,1 1507,0 1574,1 1584,0 1643,1 1724,0 1819,1 1858,0 1932,1 1952,0 2013,1 2019,0 2076,1 2091,0 2176,1 2229,0 2240,1 2333,0 2385,1 2473,0 2478,1 2524,0 2534,1 2612,0 2710,1 2718,0 2773,1 2800,0 2840,1 2874,0 2904,1 2977,0 2996,1 3026,0 3123,1 3184,0 3190,1 3255,0 3307,1 3357,0 3406,1 3490,0 3579,1 3605,0 3645,1 3672,0 3687,1 3732,0 3760,1 3778,0 3826,1 3897,0 3976,1 4053,0 4055,1 4123,0 4185,1 4186,0 4211,1 4274,0 4320,1 4364,0 4366,1 4400,0 4418,1 4509,0 4586,1 4602,0 4674,1 4733,0 4809,1 4864,0 4911,1 4929,0 4936,1 4974,0 5018,1 5114,0 5199,1 5275,0 5348,1 5359,0 5372,1 5395,0 5450,1 5513,0 5545,1 5562,0 5653,1 5667,0 5767,1 5862,0 5896,1 5910,0 6002,1 6071,0 6084,1 6128,0 6167,1 6188,0 6189,1 6241,0 6280,1 6282,0 6292,1 6344,0 6372,1 6403,0 6478,1 6569,0 6579,1 6602,0 6658,1 6707,0 6772,1 6848,0 6875,1 6886,0 6926,1 6962,0 7015,1 7041,0 7069,1 7156,0 7175,1 7252,0 7292,1 end initlist c1 0,0 57,1 60,0 73,1 142,0 143,1 159,0 168,1 207,0 241,1 244,0 261,1 276,0 326,1 411,0 441,1 501,0 553,1 579,0 650,1 698,0 740,1 784,0 803,1 884,0 984,1 1030,0 1063,1 1091,0 1154,1 1160,0 1209,1 1247,0 1342,1 1357,0 1368,1 1397,0 1490,1 1590,0 1629,1 1634,0 1722,1 1726,0 1749,1 1757,0 1791,1 1821,0 1841,1 1880,0 1968,1 1990,0 2038,1 2074,0 2081,1 2117,0 2187,1 2286,0 2361,1 2398,0 2466,1 2491,0 2591,1 2663,0 2730,1 2736,0 2832,1 2919,0 2928,1 2930,0 3029,1 3056,0 3089,1 3175,0 3242,1 3313,0 3334,1 3373,0 3447,1 3484,0 3576,1 3595,0 3653,1 3710,0 3781,1 3861,0 3919,1 3922,0 3961,1 3972,0 4018,1 4031,0 4050,1 4147,0 4227,1 4302,0 4334,1 4387,0 4480,1 4498,0 4538,1 4634,0 4642,1 4726,0 4771,1 4779,0 4807,1 4846,0 4848,1 4915,0 4979,1 5005,0 5086,1 5177,0 5247,1 5347,0 5420,1 5457,0 5460,1 5497,0 5552,1 5633,0 5719,1 5805,0 5823,1 5897,0 5934,1 5994,0 6033,1 6108,0 6121,1 6159,0 6226,1 6300,0 6326,1 6365,0 6416,1 6430,0 6483,1 6568,0 6653,1 6752,0 6820,1 6866,0 6870,1 6946,0 7031,1 7119,0 7186,1 7242,0 7277,1 7281,0 7349,1 end initlist c2 0,0 2,1 31,0 123,1 169,0 208,1 270,0 349,1 360,0 401,1 450,0 484,1 570,0 615,1 697,0 708,1 747,0 809,1 843,0 875,1 919,0 962,1 1032,0 1094,1 1168,0 1210,1 1222,0 1257,1 1277,0 1323,1 1406,0 1458,1 1535,0 1600,1 1689,0 1737,1 1828,0 1915,1 1930,0 1943,1 1952,0 1966,1 2065,0 2162,1 2262,0 2341,1 2380,0 2455,1 2533,0 2549,1 2580,0 2601,1 2619,0 2652,1 2706,0 2762,1 2777,0 2868,1 2967,0 3044,1 3080,0 3171,1 3176,0 3265,1 3319,0 3362,1 3433,0 3441,1 3468,0 3560,1 3642,0 3655,1 3718,0 3773,1 3785,0 3818,1 3836,0 3922,1 4004,0 4075,1 4100,0 4194,1 4253,0 4263,1 4332,0 4426,1 4488,0 4574,1 4590,0 4643,1 4693,0 4700,1 4791,0 4847,1 4920,0 4999,1 5039,0 5090,1 5123,0 5194,1 5246,0 5269,1 5310,0 5343,1 5411,0 5480,1 5577,0 5658,1 5687,0 5696,1 5710,0 5768,1 5775,0 5778,1 5815,0 5875,1 5890,0 5969,1 6045,0 6090,1 6177,0 6214,1 6243,0 6292,1 6350,0 6389,1 6487,0 6500,1 6536,0 6571,1 6621,0 6718,1 6760,0 6829,1 6913,0 7005,1 7104,0 7138,1 7174,0 7179,1 7185,0 7277,1 7300,0 7361,1 7403,0 7439,1 7507,0 7538,1 7547,0 7589,1 7677,0 7768,1 end initlist c3 0,0 46,1 48,0 53,1 75,0 169,1 178,0 228,1 328,0 382,1 408,0 423,1 486,0 551,1 570,0 604,1 624,0 723,1 791,0 854,1 949,0 1029,1 1090,0 1149,1 1211,0 1242,1 1297,0 1383,1 1458,0 1466,1 1552,0 1637,1 1713,0 1731,1 1814,0 1887,1 1933,0 1955,1 2050,0 2062,1 2084,0 2159,1 2183,0 2228,1 2260,0 2267,1 2312,0 2338,1 2379,0 2464,1 2544,0 2591,1 2627,0 2667,1 2739,0 2824,1 2917,0 3011,1 3045,0 3074,1 3111,0 3181,1 3226,0 3256,1 3290,0 3348,1 3380,0 3394,1 3423,0 3485,1 3541,0 3568,1 3590,0 3655,1 3711,0 3745,1 3814,0 3881,1 3921,0 4003,1 4033,0 4050,1 4109,0 4152,1 4239,0 4252,1 4333,0 4371,1 4441,0 4521,1 4613,0 4695,1 4740,0 4792,1 4834,0 4884,1 4968,0 5056,1 5071,0 5110,1 5117,0 5183,1 5194,0 5288,1 5337,0 5432,1 5486,0 5583,1 5644,0 5700,1 5765,0 5810,1 5821,0 5917,1 5968,0 6006,1 6033,0 6097,1 6173,0 6230,1 6254,0 6260,1 6343,0 6383,1 6408,0 6439,1 6523,0 6548,1 6629,0 6689,1 6719,0 6789,1 6846,0 6945,1 6986,0 7028,1 7062,0 7081,1 7089,0 7159,1 7242,0 7310,1 7359,0 7377,1 7418,0 7444,1 7509,0 7587,1 7602,0 7677,1 7709,0 7740,1 end initlist c4 0,0 74,1 164,0 241,1 291,0 379,1 407,0 438,1 526,0 610,1 637,0 710,1 713,0 781,1 808,0 858,1 916,0 950,1 1010,0 1056,1 1156,0 1233,1 1289,0 1379,1 1428,0 1442,1 1534,0 1614,1 1696,0 1714,1 1762,0 1790,1 1797,0 1803,1 1804,0 1897,1 1965,0 2016,1 2074,0 2166,1 2179,0 2255,1 2307,0 2336,1 2340,0 2422,1 2472,0 2483,1 2575,0 2668,1 2716,0 2802,1 2886,0 2958,1 3033,0 3049,1 3076,0 3138,1 3153,0 3222,1 3256,0 3301,1 3381,0 3466,1 3483,0 3568,1 3666,0 3701,1 3795,0 3822,1 3897,0 3912,1 3940,0 4039,1 4049,0 4063,1 4160,0 4253,1 4287,0 4342,1 4362,0 4441,1 4513,0 4520,1 4531,0 4544,1 4585,0 4636,1 4665,0 4750,1 4767,0 4793,1 4869,0 4924,1 4995,0 5067,1 5140,0 5211,1 5213,0 5283,1 5307,0 5359,1 5409,0 5500,1 5508,0 5547,1 5584,0 5619,1 5697,0 5715,1 5716,0 5769,1 5847,0 5884,1 5962,0 5967,1 6010,0 6048,1 6090,0 6125,1 6194,0 6252,1 6317,0 6337,1 6396,0 6469,1 6473,0 6503,1 6577,0 6656,1 6705,0 6713,1 6794,0 6870,1 6912,0 6957,1 7051,0 7075,1 7149,0 7155,1 7175,0 7199,1 7210,0 7255,1 7315,0 7330,1 7419,0 7477,1 7574,0 7633,1 7710,0 7756,1 end initlist c5 0,0 4,1 83,0 108,1 147,0 157,1 228,0 271,1 329,0 414,1 445,0 512,1 543,0 600,1 696,0 699,1 760,0 856,1 937,0 988,1 1066,0 1075,1 1105,0 1203,1 1254,0 1336,1 1351,0 1416,1 1496,0 1571,1 1666,0 1709,1 1792,0 1829,1 1927,0 2019,1 2090,0 2147,1 2216,0 2237,1 2262,0 2282,1 2343,0 2391,1 2412,0 2457,1 2509,0 2582,1 2665,0 2680,1 2681,0 2750,1 2785,0 2855,1 2916,0 2926,1 2965,0 2976,1 2980,0 3061,1 3148,0 3238,1 3244,0 3290,1 3337,0 3420,1 3497,0 3531,1 3594,0 3652,1 3746,0 3784,1 3826,0 3834,1 3844,0 3882,1 3920,0 3993,1 4052,0 4062,1 4104,0 4159,1 4215,0 4238,1 4329,0 4349,1 4428,0 4519,1 4591,0 4658,1 4714,0 4770,1 4815,0 4857,1 4934,0 5005,1 5091,0 5122,1 5157,0 5165,1 5197,0 5295,1 5349,0 5398,1 5454,0 5514,1 5577,0 5596,1 5686,0 5711,1 5723,0 5735,1 5805,0 5861,1 5895,0 5917,1 5972,0 5984,1 6049,0 6122,1 6128,0 6201,1 6260,0 6352,1 6387,0 6471,1 6483,0 6543,1 6581,0 6641,1 6668,0 6764,1 6811,0 6904,1 6986,0 7050,1 7062,0 7073,1 7169,0 7189,1 7252,0 7333,1 7353,0 7425,1 7468,0 7474,1 7499,0 7550,1 7558,0 7569,1 7651,0 7660,1 end initlist c6 0,0 77,1 177,0 223,1 294,0 390,1 435,0 503,1 567,0 596,1 660,0 665,1 674,0 731,1 779,0 869,1 902,0 932,1 1004,0 1055,1 1057,0 1095,1 1116,0 1131,1 1159,0 1259,1 1343,0 1360,1 1392,0 1433,1 1491,0 1574,1 1589,0 1621,1 1667,0 1762,1 1811,0 1905,1 1948,0 2048,1 2144,0 2226,1 2251,0 2261,1 2267,0 2366,1 2400,0 2485,1 2536,0 2585,1 2642,0 2665,1 2753,0 2822,1 2888,0 2978,1 3022,0 3116,1 3196,0 3248,1 3265,0 3363,1 3424,0 3429,1 3484,0 3537,1 3544,0 3590,1 3609,0 3666,1 3714,0 3771,1 3825,0 3899,1 3990,0 4043,1 4133,0 4183,1 4202,0 4208,1 4249,0 4341,1 4355,0 4432,1 4496,0 4544,1 4619,0 4631,1 4710,0 4738,1 4784,0 4875,1 4967,0 5057,1 5138,0 5141,1 5172,0 5194,1 5290,0 5390,1 5465,0 5507,1 5551,0 5625,1 5683,0 5688,1 5697,0 5721,1 5740,0 5795,1 5805,0 5827,1 5891,0 5988,1 6018,0 6093,1 6107,0 6135,1 6215,0 6276,1 6278,0 6290,1 6309,0 6338,1 6350,0 6361,1 6407,0 6485,1 6509,0 6586,1 6629,0 6652,1 6682,0 6755,1 6788,0 6811,1 6853,0 6869,1 6928,0 7015,1 7098,0 7099,1 7152,0 7196,1 7294,0 7359,1 7411,0 7449,1 7493,0 7531,1 7611,0 7664,1 end initlist c7 0,0 86,1 92,0 174,1 204,0 239,1 264,0 314,1 347,0 378,1 396,0 440,1 475,0 520,1 618,0 659,1 720,0 786,1 799,0 844,1 848,0 856,1 928,0 979,1 1079,0 1128,1 1203,0 1273,1 1286,0 1309,1 1361,0 1428,1 1507,0 1548,1 1642,0 1736,1 1749,0 1848,1 1904,0 1997,1 2032,0 2088,1 2184,0 2279,1 2289,0 2302,1 2332,0 2404,1 2439,0 2531,1 2584,0 2671,1 2723,0 2743,1 2784,0 2811,1 2840,0 2874,1 2891,0 2911,1 2985,0 3005,1 3060,0 3076,1 3105,0 3147,1 3181,0 3239,1 3286,0 3383,1 3426,0 3519,1 3520,0 3619,1 3670,0 3744,1 3799,0 3849,1 3850,0 3903,1 3985,0 4050,1 4074,0 4139,1 4196,0 4232,1 4282,0 4293,1 4330,0 4420,1 4517,0 4565,1 4597,0 4664,1 4721,0 4726,1 4769,0 4854,1 4895,0 4953,1 4956,0 5046,1 5052,0 5103,1 5185,0 5284,1 5325,0 5331,1 5429,0 5473,1 5570,0 5602,1 5690,0 5754,1 5845,0 5916,1 5947,0 5966,1 5993,0 6072,1 6139,0 6200,1 6252,0 6350,1 6429,0 6528,1 6533,0 6535,1 6568,0 6608,1 6654,0 6683,1 6706,0 6725,1 6798,0 6878,1 6962,0 7036,1 7047,0 7122,1 7182,0 7187,1 7201,0 7277,1 7321,0 7385,1 7423,0 7432,1 7456,0 7514,1 7595,0 7598,1 end initlist c8 0,0 31,1 37,0 72,1 129,0 167,1 202,0 250,1 327,0 362,1 398,0 493,1 503,0 535,1 593,0 614,1 703,0 785,1 797,0 857,1 882,0 920,1 999,0 1088,1 1090,0 1147,1 1204,0 1273,1 1281,0 1353,1 1357,0 1407,1 1472,0 1537,1 1619,0 1642,1 1665,0 1714,1 1747,0 1844,1 1928,0 1972,1 2005,0 2019,1 2035,0 2106,1 2169,0 2240,1 2275,0 2338,1 2402,0 2446,1 2546,0 2611,1 2674,0 2729,1 2756,0 2816,1 2911,0 2930,1 3002,0 3075,1 3122,0 3138,1 3211,0 3249,1 3309,0 3397,1 3429,0 3485,1 3565,0 3598,1 3666,0 3729,1 3768,0 3784,1 3883,0 3968,1 4033,0 4038,1 4059,0 4132,1 4215,0 4293,1 4375,0 4459,1 4541,0 4608,1 4651,0 4729,1 4814,0 4821,1 4874,0 4916,1 4952,0 5022,1 5065,0 5146,1 5154,0 5234,1 5247,0 5290,1 5352,0 5371,1 5413,0 5456,1 5464,0 5545,1 5570,0 5584,1 5640,0 5672,1 5745,0 5840,1 5913,0 5988,1 6046,0 6047,1 6114,0 6169,1 6174,0 6264,1 6268,0 6280,1 6343,0 6353,1 6397,0 6457,1 6544,0 6626,1 6630,0 6723,1 6816,0 6872,1 6942,0 6998,1 7083,0 7123,1 7201,0 7271,1 7314,0 7363,1 7384,0 7462,1 7516,0 7529,1 7604,0 7686,1 7776,0 7825,1 7917,0 7968,1 end initlist c9 0,0 63,1 115,0 191,1 275,0 371,1 467,0 547,1 619,0 687,1 777,0 798,1 828,0 860,1 941,0 1020,1 1058,0 1077,1 1128,0 1226,1 1244,0 1317,1 1410,0 1472,1 1499,0 1561,1 1585,0 1651,1 1706,0 1726,1 1761,0 1782,1 1817,0 1899,1 1910,0 1970,1 2049,0 2051,1 2070,0 2107,1 2205,0 2256,1 2347,0 2388,1 2438,0 2452,1 2461,0 2532,1 2593,0 2693,1 2775,0 2867,1 2921,0 2996,1 3075,0 3141,1 3222,0 3283,1 3318,0 3416,1 3447,0 3514,1 3607,0 3612,1 3674,0 3697,1 3778,0 3877,1 3913,0 3977,1 4064,0 4158,1 4206,0 4237,1 4324,0 4367,1 4395,0 4459,1 4514,0 4538,1 4560,0 4645,1 4732,0 4741,1 4747,0 4799,1 4899,0 4973,1 5046,0 5051,1 5052,0 5100,1 5135,0 5200,1 5222,0 5313,1 5323,0 5336,1 5348,0 5438,1 5501,0 5533,1 5559,0 5615,1 5651,0 5704,1 5759,0 5775,1 5853,0 5871,1 5936,0 5985,1 6062,0 6085,1 6119,0 6135,1 6168,0 6186,1 6280,0 6359,1 6361,0 6442,1 6491,0 6497,1 6587,0 6677,1 6709,0 6793,1 6888,0 6951,1 6970,0 6978,1 7061,0 7113,1 7199,0 7240,1 7252,0 7261,1 7265,0 7310,1 7409,0 7433,1 7508,0 7605,1 7694,0 7709,1 7766,0 7841,1 7881,0 7894,1 7932,0 7969,1 end initlist c10 0,0 19,1 74,0 118,1 193,0 253,1 288,0 362,1 384,0 407,1 489,0 496,1 542,0 618,1 679,0 765,1 770,0 844,1 874,0 884,1 913,0 1002,1 1096,0 1156,1 1157,0 1188,1 1286,0 1305,1 1361,0 1377,1 1455,0 1555,1 1560,0 1589,1 1628,0 1675,1 1691,0 1782,1 1847,0 1922,1 2018,0 2023,1 2071,0 2125,1 2146,0 2228,1 2301,0 2336,1 2361,0 2385,1 2433,0 2490,1 2558,0 2631,1 2718,0 2751,1 2754,0 2838,1 2937,0 3004,1 3046,0 3110,1 3185,0 3284,1 3373,0 3433,1 3483,0 3491,1 3580,0 3674,1 3700,0 3761,1 3852,0 3952,1 4012,0 4099,1 4187,0 4197,1 4226,0 4323,1 4331,0 4431,1 4492,0 4538,1 4617,0 4715,1 4758,0 4799,1 4804,0 4887,1 4906,0 4916,1 4988,0 5036,1 5106,0 5134,1 5152,0 5179,1 5279,0 5329,1 5384,0 5402,1 5434,0 5519,1 5591,0 5621,1 5673,0 5691,1 5710,0 5807,1 5846,0 5872,1 5934,0 5989,1 6052,0 6072,1 6155,0 6208,1 6253,0 6352,1 6366,0 6437,1 6513,0 6575,1 6645,0 6673,1 6732,0 6807,1 6840,0 6919,1 6993,0 7088,1 7159,0 7227,1 7229,0 7264,1 7343,0 7367,1 7463,0 7543,1 7639,0 7716,1 7810,0 7853,1 7944,0 7957,1 8038,0 8083,1 8108,0 8155,1 8198,0 8226,1 end initlist c11 0,0 4,1 92,0 174,1 209,0 216,1 242,0 303,1 315,0 414,1 452,0 491,1 564,0 599,1 614,0 701,1 763,0 852,1 881,0 936,1 947,0 1013,1 1016,0 1078,1 1175,0 1234,1 1302,0 1374,1 1394,0 1455,1 1464,0 1554,1 1587,0 1655,1 1722,0 1809,1 1893,0 1958,1 2024,0 2072,1 2160,0 2191,1 2203,0 2244,1 2322,0 2355,1 2404,0 2435,1 2510,0 2577,1 2625,0 2658,1 2707,0 2716,1 2788,0 2841,1 2893,0 2967,1 3035,0 3064,1 3099,0 3176,1 3235,0 3285,1 3368,0 3372,1 3452,0 3500,1 3599,0 3620,1 3669,0 3715,1 3793,0 3839,1 3849,0 3886,1 3895,0 3936,1 3960,0 3993,1 4050,0 4136,1 4190,0 4262,1 4326,0 4391,1 4403,0 4485,1 4548,0 4583,1 4612,0 4662,1 4720,0 4799,1 4888,0 4905,1 4934,0 5010,1 5090,0 5156,1 5216,0 5251,1 5257,0 5329,1 5378,0 5401,1 5433,0 5442,1 5496,0 5515,1 5557,0 5601,1 5661,0 5717,1 5739,0 5785,1 5795,0 5878,1 5939,0 6021,1 6107,0 6112,1 6158,0 6169,1 6245,0 6258,1 6277,0 6285,1 6309,0 6320,1 6410,0 6457,1 6489,0 6553,1 6635,0 6677,1 6746,0 6748,1 6798,0 6810,1 6864,0 6925,1 6966,0 7022,1 7028,0 7123,1 7164,0 7167,1 7181,0 7206,1 7226,0 7251,1 end initlist c12 0,0 65,1 118,0 151,1 158,0 215,1 266,0 331,1 389,0 472,1 545,0 638,1 678,0 697,1 768,0 868,1 884,0 926,1 1000,0 1071,1 1085,0 1108,1 1152,0 1160,1 1191,0 1263,1 1287,0 1333,1 1338,0 1413,1 1497,0 1589,1 1687,0 1746,1 1754,0 1805,1 1898,0 1970,1 1986,0 2063,1 2162,0 2210,1 2286,0 2360,1 2450,0 2516,1 2585,0 2640,1 2652,0 2738,1 2756,0 2853,1 2914,0 2954,1 2981,0 2985,1 3010,0 3099,1 3101,0 3127,1 3139,0 3153,1 3220,0 3309,1 3384,0 3431,1 3520,0 3591,1 3685,0 3718,1 3789,0 3884,1 3921,0 4006,1 4081,0 4136,1 4203,0 4225,1 4276,0 4360,1 4416,0 4444,1 4482,0 4536,1 4569,0 4660,1 4709,0 4722,1 4768,0 4782,1 4869,0 4923,1 4989,0 5010,1 5102,0 5138,1 5190,0 5261,1 5317,0 5346,1 5365,0 5464,1 5504,0 5576,1 5586,0 5676,1 5758,0 5839,1 5857,0 5893,1 5959,0 6035,1 6044,0 6102,1 6133,0 6162,1 6197,0 6198,1 6283,0 6285,1 6298,0 6318,1 6351,0 6442,1 6466,0 6529,1 6572,0 6611,1 6690,0 6747,1 6765,0 6774,1 6808,0 6899,1 6900,0 6916,1 6968,0 7000,1 7078,0 7087,1 7178,0 7208,1 7279,0 7332,1 7350,0 7431,1 7492,0 7559,1 7627,0 7723,1 7811,0 7814,1 end initlist c13 0,0 47,1 108,0 116,1 133,0 217,1 299,0 343,1 390,0 437,1 511,0 588,1 606,0 659,1 731,0 734,1 828,0 856,1 954,0 997,1 1034,0 1109,1 1208,0 1239,1 1322,0 1374,1 1414,0 1485,1 1571,0 1611,1 1679,0 1776,1 1784,0 1839,1 1892,0 1955,1 1984,0 2042,1 2101,0 2190,1 2269,0 2349,1 2422,0 2448,1 2543,0 2618,1 2665,0 2730,1 2792,0 2873,1 2948,0 3022,1 3063,0 3089,1 3177,0 3178,1 3254,0 3315,1 3356,0 3448,1 3492,0 3550,1 3614,0 3648,1 3743,0 3803,1 3834,0 3845,1 3918,0 3969,1 4037,0 4130,1 4182,0 4258,1 4318,0 4394,1 4405,0 4451,1 4472,0 4567,1 4623,0 4678,1 4718,0 4752,1 4806,0 4906,1 4998,0 5047,1 5054,0 5074,1 5107,0 5202,1 5228,0 5286,1 5365,0 5423,1 5466,0 5481,1 5501,0 5555,1 5592,0 5666,1 5753,0 5851,1 5910,0 5971,1 6026,0 6076,1 6172,0 6241,1 6316,0 6399,1 6401,0 6416,1 6499,0 6584,1 6635,0 6702,1 6742,0 6807,1 6828,0 6918,1 6921,0 6956,1 7040,0 7055,1 7136,0 7151,1 7157,0 7222,1 7307,0 7339,1 7421,0 7486,1 7496,0 7593,1 7656,0 7743,1 7819,0 7908,1 7970,0 8000,1 8006,0 8030,1 8128,0 8185,1 8220,0 8267,1 8339,0 8386,1 8485,0 8494,1 end initlist c14 0,0 68,1 142,0 168,1 212,0 310,1 406,0 429,1 470,0 527,1 620,0 713,1 725,0 760,1 811,0 826,1 845,0 883,1 917,0 936,1 977,0 1031,1 1112,0 1191,1 1208,0 1215,1 1226,0 1262,1 1302,0 1358,1 1373,0 1435,1 1483,0 1499,1 1585,0 1604,1 1618,0 1706,1 1792,0 1795,1 1864,0 1961,1 1971,0 2022,1 2116,0 2126,1 2138,0 2165,1 2193,0 2210,1 2285,0 2344,1 2399,0 2496,1 2529,0 2577,1 2658,0 2678,1 2707,0 2709,1 2775,0 2790,1 2823,0 2878,1 2903,0 3000,1 3007,0 3072,1 3096,0 3142,1 3202,0 3206,1 3279,0 3319,1 3361,0 3427,1 3500,0 3507,1 3596,0 3631,1 3712,0 3807,1 3840,0 3882,1 3936,0 4005,1 4017,0 4104,1 4160,0 4202,1 4277,0 4316,1 4375,0 4385,1 4429,0 4457,1 4482,0 4511,1 4580,0 4612,1 4679,0 4704,1 4739,0 4820,1 4852,0 4899,1 4946,0 5015,1 5017,0 5045,1 5132,0 5150,1 5158,0 5194,1 5293,0 5299,1 5319,0 5386,1 5406,0 5495,1 5520,0 5553,1 5644,0 5689,1 5766,0 5846,1 5852,0 5922,1 5994,0 6069,1 6081,0 6137,1 6150,0 6188,1 6242,0 6273,1 6299,0 6355,1 6384,0 6452,1 6469,0 6540,1 6575,0 6587,1 6630,0 6673,1 6723,0 6810,1 6867,0 6875,1 6936,0 7011,1 end initlist c15 0,0 10,1 91,0 162,1 231,0 303,1 360,0 438,1 535,0 552,1 626,0 706,1 741,0 813,1 835,0 895,1 904,0 949,1 996,0 1091,1 1156,0 1222,1 1269,0 1298,1 1384,0 1461,1 1478,0 1500,1 1558,0 1620,1 1634,0 1701,1 1776,0 1777,1 1811,0 1818,1 1873,0 1964,1 2013,0 2057,1 2134,0 2195,1 2203,0 2285,1 2361,0 2457,1 2470,0 2472,1 2503,0 2545,1 2551,0 2649,1 2748,0 2844,1 2913,0 2949,1 3018,0 3088,1 3177,0 3262,1 3314,0 3389,1 3427,0 3527,1 3541,0 3587,1 3637,0 3685,1 3724,0 3784,1 3785,0 3885,1 3907,0 3979,1 4024,0 4118,1 4170,0 4253,1 4330,0 4356,1 4368,0 4456,1 4483,0 4511,1 4564,0 4612,1 4682,0 4767,1 4842,0 4916,1 4960,0 5034,1 5049,0 5090,1 5161,0 5206,1 5276,0 5358,1 5375,0 5401,1 5440,0 5540,1 5564,0 5634,1 5644,0 5674,1 5690,0 5720,1 5741,0 5757,1 5820,0 5919,1 6016,0 6093,1 6103,0 6184,1 6273,0 6275,1 6362,0 6375,1 6463,0 6490,1 6495,0 6517,1 6565,0 6614,1 6701,0 6781,1 6821,0 6853,1 6943,0 7042,1 7131,0 7154,1 7161,0 7247,1 7336,0 7406,1 7476,0 7525,1 7571,0 7576,1 7577,0 7601,1 7638,0 7673,1 7773,0 7861,1 7912,0 7950,1 8025,0 8027,1 end outputs s0, s1, s2, s3, s4, s5, s6, s7, s8, s9, s10, s11, s12, s13, s14, s15 t0, t1, t2, t3, t4, t5, t6, t7, t8, t9, t10, t11, t12, t13, t14, t15 end outvalues s0 1, s1 1, s2 1, s3 1, s4 1, s5 1, s6 1, s7 1, s8 1, s9 1, s10 1, s11 1, s12 1, s13 1, s14 1, s15 1, t0 1, t1 1, t2 1, t3 1, t4 1, t5 1, t6 1, t7 1, t8 1, t9 1, t10 1, t11 1, t12 1, t13 1, t14 1, t15 1, end netlist inv(a0n,a0)#4 inv(b0n,b0)#4 inv(c0n,c0)#4 and2(a0nb0n,a0n,b0n)#2 and2(a0nb0,a0n,b0)#2 and2(a0b0n,a0,b0n)#2 and2(a0b0,a0,b0)#3 and2(a0b0c0,a0b0,c0)#2 and2(a0nb0nc0,a0nb0n,c0)#2 and2(a0nb0c0n,a0nb0,c0n)#2 and2(a0b0nc0n,a0b0n,c0n)#2 and2(b0c0,b0,c0)#2 and2(a0c0,c0,a0)#2 or2(s0w42,a0b0nc0n,a0nb0c0n)#3 or2(s0w71,a0b0c0, a0nb0nc0)#3 or2(s0,s0w42,s0w71)#3 or2(s0w35, b0c0, a0c0)#3 or2(t0,s0w35,a0b0)#5 end netlist inv(a1n,a1)#4 inv(b1n,b1)#4 inv(c1n,c1)#4 and2(a1nb1n,a1n,b1n)#2 and2(a1nb1,a1n,b1)#2 and2(a1b1n,a1,b1n)#2 and2(a1b1,a1,b1)#3 and2(a1b1c1,a1b1,c1)#2 and2(a1nb1nc1,a1nb1n,c1)#2 and2(a1nb1c1n,a1nb1,c1n)#2 and2(a1b1nc1n,a1b1n,c1n)#2 and2(b1c1,b1,c1)#2 and2(a1c1,c1,a1)#2 or2(s1w42,a1b1nc1n,a1nb1c1n)#3 or2(s1w71,a1b1c1, a1nb1nc1)#3 or2(s1,s1w42,s1w71)#3 or2(s1w35, b1c1, a1c1)#3 or2(t1,s1w35,a1b1)#5 end netlist inv(a2n,a2)#4 inv(b2n,b2)#4 inv(c2n,c2)#4 and2(a2nb2n,a2n,b2n)#2 and2(a2nb2,a2n,b2)#2 and2(a2b2n,a2,b2n)#2 and2(a2b2,a2,b2)#3 and2(a2b2c2,a2b2,c2)#2 and2(a2nb2nc2,a2nb2n,c2)#2 and2(a2nb2c2n,a2nb2,c2n)#2 and2(a2b2nc2n,a2b2n,c2n)#2 and2(b2c2,b2,c2)#2 and2(a2c2,c2,a2)#2 or2(s2w42,a2b2nc2n,a2nb2c2n)#3 or2(s2w71,a2b2c2, a2nb2nc2)#3 or2(s2,s2w42,s2w71)#3 or2(s2w35, b2c2, a2c2)#3 or2(t2,s2w35,a2b2)#5 end netlist inv(a3n,a3)#4 inv(b3n,b3)#4 inv(c3n,c3)#4 and2(a3nb3n,a3n,b3n)#2 and2(a3nb3,a3n,b3)#2 and2(a3b3n,a3,b3n)#2 and2(a3b3,a3,b3)#3 and2(a3b3c3,a3b3,c3)#2 and2(a3nb3nc3,a3nb3n,c3)#2 and2(a3nb3c3n,a3nb3,c3n)#2 and2(a3b3nc3n,a3b3n,c3n)#2 and2(b3c3,b3,c3)#2 and2(a3c3,c3,a3)#2 or2(s3w42,a3b3nc3n,a3nb3c3n)#3 or2(s3w71,a3b3c3, a3nb3nc3)#3 or2(s3,s3w42,s3w71)#3 or2(s3w35, b3c3, a3c3)#3 or2(t3,s3w35,a3b3)#5 end netlist inv(a4n,a4)#4 inv(b4n,b4)#4 inv(c4n,c4)#4 and2(a4nb4n,a4n,b4n)#2 and2(a4nb4,a4n,b4)#2 and2(a4b4n,a4,b4n)#2 and2(a4b4,a4,b4)#3 and2(a4b4c4,a4b4,c4)#2 and2(a4nb4nc4,a4nb4n,c4)#2 and2(a4nb4c4n,a4nb4,c4n)#2 and2(a4b4nc4n,a4b4n,c4n)#2 and2(b4c4,b4,c4)#2 and2(a4c4,c4,a4)#2 or2(s4w42,a4b4nc4n,a4nb4c4n)#3 or2(s4w71,a4b4c4, a4nb4nc4)#3 or2(s4,s4w42,s4w71)#3 or2(s4w35, b4c4, a4c4)#3 or2(t4,s4w35,a4b4)#5 end netlist inv(a5n,a5)#4 inv(b5n,b5)#4 inv(c5n,c5)#4 and2(a5nb5n,a5n,b5n)#2 and2(a5nb5,a5n,b5)#2 and2(a5b5n,a5,b5n)#2 and2(a5b5,a5,b5)#3 and2(a5b5c5,a5b5,c5)#2 and2(a5nb5nc5,a5nb5n,c5)#2 and2(a5nb5c5n,a5nb5,c5n)#2 and2(a5b5nc5n,a5b5n,c5n)#2 and2(b5c5,b5,c5)#2 and2(a5c5,c5,a5)#2 or2(s5w42,a5b5nc5n,a5nb5c5n)#3 or2(s5w71,a5b5c5, a5nb5nc5)#3 or2(s5,s5w42,s5w71)#3 or2(s5w35, b5c5, a5c5)#3 or2(t5,s5w35,a5b5)#5 end netlist inv(a6n,a6)#4 inv(b6n,b6)#4 inv(c6n,c6)#4 and2(a6nb6n,a6n,b6n)#2 and2(a6nb6,a6n,b6)#2 and2(a6b6n,a6,b6n)#2 and2(a6b6,a6,b6)#3 and2(a6b6c6,a6b6,c6)#2 and2(a6nb6nc6,a6nb6n,c6)#2 and2(a6nb6c6n,a6nb6,c6n)#2 and2(a6b6nc6n,a6b6n,c6n)#2 and2(b6c6,b6,c6)#2 and2(a6c6,c6,a6)#2 or2(s6w42,a6b6nc6n,a6nb6c6n)#3 or2(s6w71,a6b6c6, a6nb6nc6)#3 or2(s6,s6w42,s6w71)#3 or2(s6w35, b6c6, a6c6)#3 or2(t6,s6w35,a6b6)#5 end netlist inv(a7n,a7)#4 inv(b7n,b7)#4 inv(c7n,c7)#4 and2(a7nb7n,a7n,b7n)#2 and2(a7nb7,a7n,b7)#2 and2(a7b7n,a7,b7n)#2 and2(a7b7,a7,b7)#3 and2(a7b7c7,a7b7,c7)#2 and2(a7nb7nc7,a7nb7n,c7)#2 and2(a7nb7c7n,a7nb7,c7n)#2 and2(a7b7nc7n,a7b7n,c7n)#2 and2(b7c7,b7,c7)#2 and2(a7c7,c7,a7)#2 or2(s7w42,a7b7nc7n,a7nb7c7n)#3 or2(s7w71,a7b7c7, a7nb7nc7)#3 or2(s7,s7w42,s7w71)#3 or2(s7w35, b7c7, a7c7)#3 or2(t7,s7w35,a7b7)#5 end netlist inv(a8n,a8)#4 inv(b8n,b8)#4 inv(c8n,c8)#4 and2(a8nb8n,a8n,b8n)#2 and2(a8nb8,a8n,b8)#2 and2(a8b8n,a8,b8n)#2 and2(a8b8,a8,b8)#3 and2(a8b8c8,a8b8,c8)#2 and2(a8nb8nc8,a8nb8n,c8)#2 and2(a8nb8c8n,a8nb8,c8n)#2 and2(a8b8nc8n,a8b8n,c8n)#2 and2(b8c8,b8,c8)#2 and2(a8c8,c8,a8)#2 or2(s8w42,a8b8nc8n,a8nb8c8n)#3 or2(s8w71,a8b8c8, a8nb8nc8)#3 or2(s8,s8w42,s8w71)#3 or2(s8w35, b8c8, a8c8)#3 or2(t8,s8w35,a8b8)#5 end netlist inv(a9n,a9)#4 inv(b9n,b9)#4 inv(c9n,c9)#4 and2(a9nb9n,a9n,b9n)#2 and2(a9nb9,a9n,b9)#2 and2(a9b9n,a9,b9n)#2 and2(a9b9,a9,b9)#3 and2(a9b9c9,a9b9,c9)#2 and2(a9nb9nc9,a9nb9n,c9)#2 and2(a9nb9c9n,a9nb9,c9n)#2 and2(a9b9nc9n,a9b9n,c9n)#2 and2(b9c9,b9,c9)#2 and2(a9c9,c9,a9)#2 or2(s9w42,a9b9nc9n,a9nb9c9n)#3 or2(s9w71,a9b9c9, a9nb9nc9)#3 or2(s9,s9w42,s9w71)#3 or2(s9w35, b9c9, a9c9)#3 or2(t9,s9w35,a9b9)#5 end netlist inv(a10n,a10)#4 inv(b10n,b10)#4 inv(c10n,c10)#4 and2(a10nb10n,a10n,b10n)#2 and2(a10nb10,a10n,b10)#2 and2(a10b10n,a10,b10n)#2 and2(a10b10,a10,b10)#3 and2(a10b10c10,a10b10,c10)#2 and2(a10nb10nc10,a10nb10n,c10)#2 and2(a10nb10c10n,a10nb10,c10n)#2 and2(a10b10nc10n,a10b10n,c10n)#2 and2(b10c10,b10,c10)#2 and2(a10c10,c10,a10)#2 or2(s10w42,a10b10nc10n,a10nb10c10n)#3 or2(s10w71,a10b10c10, a10nb10nc10)#3 or2(s10,s10w42,s10w71)#3 or2(s10w35, b10c10, a10c10)#3 or2(t10,s10w35,a10b10)#5 end netlist inv(a11n,a11)#4 inv(b11n,b11)#4 inv(c11n,c11)#4 and2(a11nb11n,a11n,b11n)#2 and2(a11nb11,a11n,b11)#2 and2(a11b11n,a11,b11n)#2 and2(a11b11,a11,b11)#3 and2(a11b11c11,a11b11,c11)#2 and2(a11nb11nc11,a11nb11n,c11)#2 and2(a11nb11c11n,a11nb11,c11n)#2 and2(a11b11nc11n,a11b11n,c11n)#2 and2(b11c11,b11,c11)#2 and2(a11c11,c11,a11)#2 or2(s11w42,a11b11nc11n,a11nb11c11n)#3 or2(s11w71,a11b11c11, a11nb11nc11)#3 or2(s11,s11w42,s11w71)#3 or2(s11w35, b11c11, a11c11)#3 or2(t11,s11w35,a11b11)#5 end netlist inv(a12n,a12)#4 inv(b12n,b12)#4 inv(c12n,c12)#4 and2(a12nb12n,a12n,b12n)#2 and2(a12nb12,a12n,b12)#2 and2(a12b12n,a12,b12n)#2 and2(a12b12,a12,b12)#3 and2(a12b12c12,a12b12,c12)#2 and2(a12nb12nc12,a12nb12n,c12)#2 and2(a12nb12c12n,a12nb12,c12n)#2 and2(a12b12nc12n,a12b12n,c12n)#2 and2(b12c12,b12,c12)#2 and2(a12c12,c12,a12)#2 or2(s12w42,a12b12nc12n,a12nb12c12n)#3 or2(s12w71,a12b12c12, a12nb12nc12)#3 or2(s12,s12w42,s12w71)#3 or2(s12w35, b12c12, a12c12)#3 or2(t12,s12w35,a12b12)#5 end netlist inv(a13n,a13)#4 inv(b13n,b13)#4 inv(c13n,c13)#4 and2(a13nb13n,a13n,b13n)#2 and2(a13nb13,a13n,b13)#2 and2(a13b13n,a13,b13n)#2 and2(a13b13,a13,b13)#3 and2(a13b13c13,a13b13,c13)#2 and2(a13nb13nc13,a13nb13n,c13)#2 and2(a13nb13c13n,a13nb13,c13n)#2 and2(a13b13nc13n,a13b13n,c13n)#2 and2(b13c13,b13,c13)#2 and2(a13c13,c13,a13)#2 or2(s13w42,a13b13nc13n,a13nb13c13n)#3 or2(s13w71,a13b13c13, a13nb13nc13)#3 or2(s13,s13w42,s13w71)#3 or2(s13w35, b13c13, a13c13)#3 or2(t13,s13w35,a13b13)#5 end netlist inv(a14n,a14)#4 inv(b14n,b14)#4 inv(c14n,c14)#4 and2(a14nb14n,a14n,b14n)#2 and2(a14nb14,a14n,b14)#2 and2(a14b14n,a14,b14n)#2 and2(a14b14,a14,b14)#3 and2(a14b14c14,a14b14,c14)#2 and2(a14nb14nc14,a14nb14n,c14)#2 and2(a14nb14c14n,a14nb14,c14n)#2 and2(a14b14nc14n,a14b14n,c14n)#2 and2(b14c14,b14,c14)#2 and2(a14c14,c14,a14)#2 or2(s14w42,a14b14nc14n,a14nb14c14n)#3 or2(s14w71,a14b14c14, a14nb14nc14)#3 or2(s14,s14w42,s14w71)#3 or2(s14w35, b14c14, a14c14)#3 or2(t14,s14w35,a14b14)#5 end netlist inv(a15n,a15)#4 inv(b15n,b15)#4 inv(c15n,c15)#4 and2(a15nb15n,a15n,b15n)#2 and2(a15nb15,a15n,b15)#2 and2(a15b15n,a15,b15n)#2 and2(a15b15,a15,b15)#3 and2(a15b15c15,a15b15,c15)#2 and2(a15nb15nc15,a15nb15n,c15)#2 and2(a15nb15c15n,a15nb15,c15n)#2 and2(a15b15nc15n,a15b15n,c15n)#2 and2(b15c15,b15,c15)#2 and2(a15c15,c15,a15)#2 or2(s15w42,a15b15nc15n,a15nb15c15n)#3 or2(s15w71,a15b15c15, a15nb15nc15)#3 or2(s15,s15w42,s15w71)#3 or2(s15w35, b15c15, a15c15)#3 or2(t15,s15w35,a15b15)#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/xor2x1NandArray4.net
inputs a0, b0, a1, b1, a2, b2, a3, b3, end outputs o0, o1, o2, o3, end finish=10000 initlist a0 0, 0 5, 1 10, 0 15, 1 20, 0 25, 1 30, 0 35, 1 40, 0 45, 1 50, 0 55, 1 60, 0 65, 1 70, 0 75, 1 end initlist a1 0, 0 5, 1 10, 0 15, 1 20, 0 25, 1 30, 0 35, 1 40, 0 45, 1 50, 0 55, 1 60, 0 65, 1 70, 0 75, 1 end initlist a2 0, 0 5, 1 10, 0 15, 1 20, 0 25, 1 30, 0 35, 1 40, 0 45, 1 50, 0 55, 1 60, 0 65, 1 70, 0 75, 1 end initlist a3 0, 0 5, 1 10, 0 15, 1 20, 0 25, 1 30, 0 35, 1 40, 0 45, 1 50, 0 55, 1 60, 0 65, 1 70, 0 75, 1 end initlist b0 0, 0 10, 1 20, 0 30, 1 40, 0 50, 1 60, 0 70, 1 80, 0 90, 1 100, 0 110, 1 120, 0 130, 1 140, 0 150, 1 end initlist b1 0, 0 10, 1 20, 0 30, 1 40, 0 50, 1 60, 0 70, 1 80, 0 90, 1 100, 0 110, 1 120, 0 130, 1 140, 0 150, 1 end initlist b2 0, 0 10, 1 20, 0 30, 1 40, 0 50, 1 60, 0 70, 1 80, 0 90, 1 100, 0 110, 1 120, 0 130, 1 140, 0 150, 1 end initlist b3 0, 0 10, 1 20, 0 30, 1 40, 0 50, 1 60, 0 70, 1 80, 0 90, 1 100, 0 110, 1 120, 0 130, 1 140, 0 150, 1 end outvalues o0 0, o1 0, o2 0, o3 0, end netlist nand2(x0,a0,b0)#40 nand2(y0,a0,x0)#40 nand2(z0,b0,x0)#40 nand2(o0,y0,z0)#40 end netlist nand2(x1,a1,b1)#40 nand2(y1,a1,x1)#40 nand2(z1,b1,x1)#40 nand2(o1,y1,z1)#40 end netlist nand2(x2,a2,b2)#40 nand2(y2,a2,x2)#40 nand2(z2,b2,x2)#40 nand2(o2,y2,z2)#40 end netlist nand2(x3,a3,b3)#40 nand2(y3,a3,x3)#40 nand2(z3,b3,x3)#40 nand2(o3,y3,z3)#40 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/csaArray8.net
finish 100000 inputs a0, a1, a2, a3, a4, a5, a6, a7 b0, b1, b2, b3, b4, b5, b6, b7 c0, c1, c2, c3, c4, c5, c6, c7 end initlist a0 0,0 94,1 147,0 206,1 291,0 381,1 390,0 463,1 524,0 545,1 593,0 671,1 706,0 766,1 814,0 828,1 842,0 929,1 958,0 975,1 990,0 1089,1 1107,0 1119,1 1123,0 1157,1 1221,0 1286,1 1361,0 1459,1 1474,0 1495,1 1556,0 1629,1 1645,0 1660,1 1696,0 1718,1 1778,0 1813,1 1902,0 1915,1 1926,0 1939,1 1959,0 1997,1 2078,0 2131,1 2205,0 2274,1 2275,0 2324,1 2390,0 2430,1 2479,0 2517,1 2559,0 2621,1 2629,0 2699,1 2736,0 2822,1 2871,0 2969,1 3037,0 3070,1 3084,0 3154,1 3229,0 3312,1 3377,0 3420,1 3457,0 3557,1 3640,0 3650,1 3651,0 3704,1 3707,0 3736,1 3744,0 3772,1 3780,0 3837,1 3856,0 3858,1 3881,0 3937,1 4025,0 4060,1 4096,0 4163,1 4198,0 4205,1 4231,0 4323,1 4371,0 4464,1 4500,0 4575,1 4631,0 4723,1 4793,0 4856,1 4919,0 4948,1 4996,0 5035,1 5039,0 5070,1 5098,0 5187,1 5218,0 5236,1 5265,0 5335,1 5372,0 5463,1 5520,0 5577,1 5611,0 5636,1 5702,0 5764,1 5813,0 5846,1 5900,0 5990,1 6024,0 6105,1 6126,0 6196,1 6268,0 6326,1 6334,0 6420,1 6476,0 6532,1 6544,0 6554,1 6652,0 6654,1 6737,0 6787,1 6884,0 6885,1 6968,0 7056,1 7062,0 7143,1 7231,0 7278,1 7309,0 7360,1 7453,0 7511,1 7577,0 7599,1 7655,0 7754,1 7838,0 7858,1 7928,0 7972,1 8029,0 8129,1 8161,0 8250,1 8255,0 8257,1 8285,0 8385,1 8438,0 8514,1 8613,0 8661,1 8702,0 8801,1 8877,0 8932,1 9032,0 9072,1 9171,0 9266,1 9364,0 9435,1 9436,0 9467,1 9565,0 9568,1 9571,0 9593,1 9661,0 9667,1 9723,0 9791,1 9804,0 9866,1 9912,0 9956,1 10022,0 10062,1 10076,0 10102,1 10136,0 10231,1 10238,0 10244,1 10262,0 10304,1 10374,0 10397,1 10489,0 10496,1 10555,0 10634,1 10683,0 10716,1 10718,0 10782,1 10852,0 10900,1 10980,0 11062,1 11138,0 11139,1 11192,0 11262,1 11287,0 11375,1 11442,0 11488,1 11543,0 11618,1 11643,0 11650,1 11736,0 11833,1 11924,0 12000,1 12096,0 12178,1 12186,0 12273,1 12345,0 12379,1 12413,0 12472,1 12547,0 12594,1 12648,0 12649,1 12666,0 12765,1 12802,0 12852,1 12948,0 12954,1 13031,0 13106,1 13198,0 13210,1 13310,0 13317,1 13353,0 13422,1 13443,0 13518,1 13580,0 13636,1 13679,0 13690,1 13727,0 13814,1 13871,0 13881,1 13897,0 13971,1 13992,0 14030,1 14068,0 14084,1 14178,0 14246,1 14298,0 14379,1 14449,0 14465,1 14489,0 14553,1 14596,0 14686,1 14733,0 14833,1 14870,0 14917,1 14948,0 14992,1 15082,0 15155,1 15198,0 15244,1 15327,0 15329,1 15363,0 15371,1 15386,0 15399,1 15458,0 15504,1 15548,0 15615,1 15637,0 15722,1 15780,0 15797,1 15845,0 15919,1 16000,0 16060,1 16093,0 16133,1 16157,0 16215,1 16313,0 16315,1 16384,0 16443,1 16468,0 16504,1 16575,0 16671,1 16765,0 16831,1 16907,0 16952,1 16991,0 17029,1 17050,0 17117,1 17143,0 17178,1 17252,0 17274,1 17369,0 17422,1 17445,0 17475,1 17561,0 17625,1 17700,0 17776,1 17847,0 17867,1 17908,0 17956,1 18010,0 18072,1 18099,0 18182,1 18183,0 18210,1 18232,0 18259,1 18274,0 18369,1 18384,0 18464,1 18506,0 18526,1 18568,0 18609,1 18667,0 18744,1 18764,0 18798,1 18833,0 18932,1 18948,0 18994,1 19016,0 19071,1 19107,0 19194,1 19229,0 19328,1 19375,0 19400,1 19472,0 19509,1 19536,0 19572,1 19634,0 19665,1 19761,0 19777,1 19810,0 19824,1 19830,0 19885,1 19929,0 19993,1 20053,0 20105,1 20204,0 20274,1 20306,0 20396,1 20454,0 20526,1 20589,0 20639,1 20651,0 20716,1 20746,0 20765,1 20828,0 20911,1 20948,0 20990,1 21082,0 21153,1 21208,0 21265,1 21350,0 21403,1 21465,0 21512,1 21598,0 21642,1 21647,0 21708,1 21790,0 21803,1 21836,0 21907,1 21993,0 22073,1 22153,0 22233,1 22243,0 22246,1 22247,0 22334,1 22399,0 22477,1 22575,0 22639,1 22733,0 22816,1 22880,0 22908,1 22999,0 23084,1 23128,0 23146,1 23207,0 23306,1 23334,0 23386,1 23428,0 23494,1 23567,0 23658,1 23701,0 23711,1 23769,0 23810,1 23892,0 23962,1 24010,0 24038,1 24110,0 24174,1 24195,0 24232,1 24282,0 24365,1 24442,0 24540,1 24597,0 24618,1 24691,0 24780,1 24803,0 24818,1 24820,0 24853,1 24926,0 25001,1 25016,0 25035,1 25052,0 25105,1 25182,0 25262,1 25302,0 25322,1 25330,0 25370,1 25403,0 25418,1 25420,0 25479,1 25497,0 25560,1 25645,0 25658,1 25688,0 25749,1 25848,0 25947,1 25980,0 26003,1 26044,0 26143,1 26224,0 26291,1 26317,0 26361,1 26415,0 26430,1 26463,0 26497,1 26525,0 26596,1 26600,0 26657,1 26721,0 26770,1 26841,0 26893,1 26947,0 27001,1 27070,0 27119,1 27205,0 27292,1 27364,0 27385,1 27436,0 27511,1 27537,0 27539,1 27571,0 27605,1 27644,0 27666,1 27709,0 27731,1 27800,0 27810,1 27891,0 27905,1 28005,0 28030,1 28069,0 28078,1 28107,0 28186,1 28193,0 28211,1 28272,0 28372,1 28412,0 28433,1 28527,0 28548,1 28560,0 28627,1 28719,0 28760,1 28815,0 28906,1 28975,0 29047,1 29095,0 29107,1 29204,0 29209,1 29254,0 29313,1 29403,0 29456,1 29511,0 29597,1 29668,0 29713,1 29766,0 29840,1 29927,0 30018,1 30078,0 30121,1 30158,0 30232,1 30250,0 30258,1 30266,0 30280,1 30346,0 30350,1 30381,0 30457,1 30514,0 30527,1 30557,0 30566,1 30603,0 30653,1 30744,0 30755,1 30786,0 30812,1 30871,0 30900,1 30916,0 30939,1 30953,0 31002,1 31086,0 31092,1 31102,0 31149,1 31227,0 31284,1 31371,0 31392,1 31397,0 31415,1 31489,0 31587,1 31644,0 31661,1 31734,0 31751,1 31789,0 31834,1 31869,0 31928,1 31991,0 32060,1 32095,0 32122,1 32153,0 32181,1 32234,0 32278,1 32320,0 32402,1 32482,0 32487,1 32565,0 32636,1 32699,0 32772,1 32797,0 32841,1 32859,0 32895,1 32915,0 32960,1 33005,0 33078,1 33116,0 33158,1 33198,0 33274,1 33277,0 33340,1 33430,0 33508,1 33574,0 33623,1 33717,0 33720,1 33741,0 33806,1 33894,0 33991,1 34073,0 34149,1 34184,0 34198,1 34226,0 34288,1 34327,0 34414,1 34495,0 34512,1 34538,0 34550,1 34554,0 34591,1 34682,0 34686,1 34769,0 34826,1 34840,0 34877,1 34930,0 34956,1 34986,0 35069,1 35080,0 35106,1 35203,0 35273,1 35282,0 35369,1 35426,0 35495,1 35569,0 35656,1 35739,0 35797,1 35816,0 35898,1 35956,0 36009,1 36042,0 36046,1 36101,0 36192,1 36278,0 36376,1 36431,0 36471,1 36528,0 36599,1 36680,0 36753,1 36783,0 36869,1 36954,0 37017,1 37063,0 37082,1 37169,0 37262,1 37360,0 37459,1 37467,0 37507,1 37606,0 37691,1 37732,0 37776,1 37851,0 37896,1 37927,0 37936,1 37961,0 38047,1 38090,0 38163,1 38217,0 38285,1 38346,0 38422,1 38488,0 38505,1 38560,0 38645,1 38717,0 38756,1 38796,0 38879,1 38923,0 38963,1 39010,0 39105,1 39188,0 39267,1 39279,0 39328,1 39348,0 39424,1 39444,0 39542,1 39580,0 39625,1 39647,0 39656,1 39754,0 39782,1 39842,0 39871,1 39958,0 39992,1 40050,0 40140,1 40238,0 40259,1 40278,0 40280,1 40314,0 40388,1 40411,0 40452,1 40513,0 40536,1 40618,0 40639,1 40659,0 40713,1 40790,0 40871,1 40925,0 40966,1 41018,0 41061,1 41109,0 41155,1 41223,0 41274,1 41353,0 41426,1 41450,0 41521,1 41603,0 41638,1 41664,0 41693,1 41729,0 41810,1 41860,0 41862,1 41890,0 41963,1 42032,0 42050,1 42117,0 42149,1 42221,0 42295,1 42324,0 42407,1 42469,0 42476,1 42503,0 42522,1 42535,0 42555,1 42609,0 42653,1 42661,0 42682,1 42751,0 42784,1 42807,0 42828,1 42864,0 42951,1 43047,0 43121,1 43194,0 43204,1 43268,0 43274,1 43302,0 43400,1 43424,0 43507,1 43607,0 43609,1 43686,0 43773,1 43841,0 43938,1 43966,0 44005,1 44076,0 44151,1 44159,0 44169,1 44191,0 44243,1 44314,0 44330,1 44404,0 44436,1 44437,0 44480,1 44515,0 44517,1 44566,0 44607,1 44705,0 44797,1 44837,0 44912,1 45004,0 45030,1 45058,0 45147,1 45240,0 45287,1 45304,0 45376,1 45423,0 45472,1 45558,0 45600,1 45699,0 45708,1 45752,0 45839,1 45921,0 45973,1 46039,0 46123,1 46164,0 46213,1 46269,0 46343,1 46438,0 46467,1 46497,0 46568,1 46642,0 46648,1 46713,0 46807,1 46852,0 46940,1 46963,0 46994,1 47017,0 47020,1 47021,0 47118,1 47129,0 47153,1 47240,0 47301,1 47317,0 47371,1 47432,0 47505,1 47573,0 47640,1 47665,0 47710,1 47740,0 47759,1 47762,0 47778,1 47782,0 47876,1 47901,0 47958,1 48054,0 48118,1 48176,0 48229,1 48313,0 48354,1 48408,0 48495,1 48524,0 48566,1 48603,0 48656,1 48710,0 48763,1 48774,0 48783,1 48798,0 48813,1 48877,0 48906,1 49001,0 49010,1 49076,0 49108,1 49203,0 49234,1 49282,0 49306,1 49328,0 49382,1 49451,0 49506,1 49547,0 49556,1 49576,0 49592,1 49639,0 49683,1 49778,0 49797,1 49855,0 49876,1 49959,0 49992,1 50005,0 50091,1 50188,0 50255,1 50267,0 50360,1 end initlist a1 0,0 98,1 144,0 176,1 218,0 219,1 226,0 231,1 309,0 336,1 397,0 477,1 530,0 546,1 575,0 664,1 699,0 755,1 845,0 943,1 1020,0 1073,1 1142,0 1221,1 1319,0 1401,1 1415,0 1502,1 1582,0 1645,1 1686,0 1745,1 1802,0 1833,1 1900,0 1911,1 1930,0 1981,1 2078,0 2140,1 2150,0 2204,1 2250,0 2286,1 2380,0 2404,1 2496,0 2547,1 2610,0 2632,1 2703,0 2780,1 2836,0 2851,1 2853,0 2874,1 2956,0 2998,1 3045,0 3089,1 3122,0 3201,1 3237,0 3333,1 3429,0 3513,1 3530,0 3562,1 3599,0 3624,1 3639,0 3712,1 3753,0 3792,1 3860,0 3891,1 3901,0 3920,1 3989,0 4043,1 4080,0 4134,1 4142,0 4207,1 4304,0 4367,1 4420,0 4503,1 4561,0 4658,1 4699,0 4739,1 4774,0 4804,1 4889,0 4976,1 4991,0 5054,1 5113,0 5119,1 5187,0 5287,1 5375,0 5386,1 5440,0 5449,1 5544,0 5548,1 5604,0 5679,1 5740,0 5780,1 5866,0 5881,1 5911,0 5933,1 6000,0 6033,1 6053,0 6118,1 6155,0 6164,1 6241,0 6276,1 6355,0 6372,1 6471,0 6558,1 6579,0 6617,1 6674,0 6762,1 6767,0 6826,1 6899,0 6927,1 6989,0 6990,1 7037,0 7042,1 7132,0 7186,1 7219,0 7239,1 7331,0 7354,1 7446,0 7475,1 7565,0 7612,1 7661,0 7733,1 7820,0 7878,1 7969,0 7993,1 8063,0 8126,1 8193,0 8198,1 8247,0 8274,1 8347,0 8400,1 8481,0 8516,1 8609,0 8674,1 8741,0 8802,1 8869,0 8931,1 9018,0 9098,1 9197,0 9239,1 9273,0 9369,1 9462,0 9472,1 9516,0 9596,1 9681,0 9725,1 9813,0 9880,1 9978,0 10027,1 10031,0 10088,1 10161,0 10247,1 10319,0 10345,1 10401,0 10466,1 10474,0 10488,1 10530,0 10537,1 10609,0 10623,1 10675,0 10732,1 10767,0 10840,1 10872,0 10890,1 10924,0 11007,1 11011,0 11068,1 11075,0 11084,1 11184,0 11234,1 11298,0 11320,1 11414,0 11463,1 11508,0 11600,1 11680,0 11770,1 11828,0 11871,1 11953,0 12035,1 12124,0 12164,1 12181,0 12220,1 12222,0 12259,1 12346,0 12395,1 12459,0 12558,1 12631,0 12689,1 12769,0 12786,1 12855,0 12885,1 12977,0 13071,1 13163,0 13176,1 13217,0 13237,1 13321,0 13394,1 13463,0 13511,1 13520,0 13619,1 13630,0 13712,1 13789,0 13845,1 13891,0 13973,1 14001,0 14046,1 14107,0 14207,1 14241,0 14247,1 14305,0 14307,1 14371,0 14437,1 14491,0 14525,1 14547,0 14616,1 14651,0 14688,1 14749,0 14751,1 14839,0 14853,1 14946,0 14983,1 14993,0 15063,1 15065,0 15081,1 15136,0 15158,1 15248,0 15318,1 15345,0 15351,1 15378,0 15384,1 15394,0 15418,1 15442,0 15524,1 15528,0 15570,1 15646,0 15692,1 15720,0 15755,1 15829,0 15901,1 15975,0 16053,1 16108,0 16156,1 16232,0 16320,1 16327,0 16372,1 16436,0 16528,1 16600,0 16688,1 16691,0 16747,1 16798,0 16872,1 16893,0 16993,1 17001,0 17048,1 17131,0 17225,1 17237,0 17247,1 17265,0 17272,1 17342,0 17410,1 17485,0 17490,1 17502,0 17594,1 17674,0 17743,1 17840,0 17871,1 17891,0 17917,1 18012,0 18066,1 18076,0 18122,1 18156,0 18180,1 18251,0 18273,1 18352,0 18403,1 18463,0 18473,1 18514,0 18596,1 18604,0 18694,1 18719,0 18756,1 18764,0 18811,1 18856,0 18897,1 18941,0 19014,1 19082,0 19179,1 19251,0 19329,1 19399,0 19489,1 19536,0 19556,1 19611,0 19711,1 19787,0 19817,1 19855,0 19897,1 19973,0 20058,1 20135,0 20220,1 20244,0 20276,1 20343,0 20439,1 20525,0 20600,1 20678,0 20747,1 20767,0 20841,1 20861,0 20910,1 20956,0 20990,1 21001,0 21048,1 21139,0 21221,1 21225,0 21234,1 21276,0 21330,1 21383,0 21452,1 21475,0 21531,1 21595,0 21597,1 21677,0 21707,1 21783,0 21841,1 21872,0 21879,1 21908,0 21952,1 22017,0 22026,1 22109,0 22180,1 22199,0 22280,1 22289,0 22384,1 22398,0 22406,1 22505,0 22540,1 22602,0 22685,1 22784,0 22801,1 22814,0 22857,1 22932,0 22970,1 23054,0 23104,1 23132,0 23208,1 23224,0 23312,1 23375,0 23426,1 23467,0 23547,1 23614,0 23689,1 23759,0 23768,1 23790,0 23848,1 23893,0 23925,1 23947,0 23954,1 24018,0 24085,1 24137,0 24186,1 24187,0 24200,1 24263,0 24330,1 24377,0 24425,1 24501,0 24544,1 24556,0 24601,1 24657,0 24755,1 24813,0 24890,1 24949,0 25027,1 25059,0 25115,1 25158,0 25228,1 25259,0 25294,1 25314,0 25374,1 25389,0 25456,1 25518,0 25565,1 25597,0 25687,1 25778,0 25875,1 25898,0 25959,1 26042,0 26078,1 26158,0 26186,1 26230,0 26259,1 26342,0 26358,1 26414,0 26468,1 26548,0 26634,1 26718,0 26730,1 26825,0 26847,1 26886,0 26905,1 26973,0 27002,1 27080,0 27152,1 27248,0 27332,1 27384,0 27476,1 27495,0 27587,1 27685,0 27729,1 27819,0 27915,1 27925,0 28021,1 28071,0 28165,1 28222,0 28253,1 28264,0 28275,1 28341,0 28396,1 28450,0 28514,1 28585,0 28635,1 28638,0 28705,1 28779,0 28877,1 28951,0 29029,1 29034,0 29102,1 29124,0 29154,1 29207,0 29219,1 29224,0 29304,1 29344,0 29369,1 29430,0 29436,1 29514,0 29522,1 29600,0 29681,1 29743,0 29769,1 29791,0 29817,1 29821,0 29862,1 29899,0 29952,1 30017,0 30095,1 30194,0 30262,1 30264,0 30358,1 30409,0 30438,1 30445,0 30457,1 30538,0 30612,1 30626,0 30642,1 30713,0 30798,1 30810,0 30871,1 30952,0 30984,1 31019,0 31106,1 31129,0 31152,1 31186,0 31208,1 31239,0 31312,1 31394,0 31469,1 31565,0 31592,1 31665,0 31732,1 31788,0 31862,1 31891,0 31913,1 31962,0 31985,1 32071,0 32103,1 32153,0 32234,1 32246,0 32247,1 32339,0 32353,1 32401,0 32457,1 32526,0 32548,1 32564,0 32655,1 32720,0 32781,1 32852,0 32871,1 32952,0 33047,1 33077,0 33148,1 33179,0 33260,1 33356,0 33419,1 33470,0 33519,1 33525,0 33621,1 33678,0 33771,1 33860,0 33944,1 33950,0 34025,1 34050,0 34123,1 34163,0 34252,1 34298,0 34393,1 34446,0 34524,1 34534,0 34617,1 34680,0 34717,1 34782,0 34881,1 34973,0 35043,1 35129,0 35131,1 35151,0 35168,1 35182,0 35204,1 35225,0 35254,1 35296,0 35393,1 35486,0 35552,1 35612,0 35696,1 35759,0 35767,1 35861,0 35923,1 35979,0 36074,1 36145,0 36165,1 36166,0 36191,1 36283,0 36294,1 36339,0 36367,1 36368,0 36369,1 36430,0 36494,1 36584,0 36634,1 36710,0 36792,1 36852,0 36881,1 36915,0 36939,1 37036,0 37117,1 37167,0 37208,1 37264,0 37293,1 37302,0 37304,1 37324,0 37330,1 37362,0 37381,1 37440,0 37454,1 37543,0 37609,1 37642,0 37707,1 37778,0 37846,1 37888,0 37906,1 37988,0 38063,1 38109,0 38143,1 38164,0 38173,1 38203,0 38268,1 38292,0 38325,1 38422,0 38512,1 38554,0 38625,1 38681,0 38766,1 38825,0 38836,1 38885,0 38931,1 38988,0 38992,1 38997,0 39053,1 39133,0 39204,1 39281,0 39336,1 39359,0 39366,1 39404,0 39476,1 39484,0 39510,1 39601,0 39679,1 39746,0 39750,1 39849,0 39910,1 39971,0 39989,1 40003,0 40015,1 40016,0 40023,1 40060,0 40133,1 40139,0 40189,1 40279,0 40355,1 40438,0 40524,1 40581,0 40671,1 40707,0 40748,1 40751,0 40810,1 40882,0 40939,1 40959,0 40983,1 41021,0 41065,1 41094,0 41154,1 41183,0 41220,1 41284,0 41377,1 41455,0 41531,1 41619,0 41653,1 41730,0 41792,1 41840,0 41940,1 42032,0 42079,1 42099,0 42103,1 42154,0 42201,1 42284,0 42341,1 42369,0 42381,1 42431,0 42527,1 42603,0 42682,1 42701,0 42756,1 42808,0 42899,1 42970,0 43067,1 43091,0 43172,1 43267,0 43338,1 43368,0 43448,1 43450,0 43491,1 43583,0 43615,1 43652,0 43662,1 43733,0 43792,1 43825,0 43899,1 43931,0 43984,1 44041,0 44094,1 44194,0 44226,1 44249,0 44318,1 44366,0 44423,1 44494,0 44575,1 44631,0 44715,1 44756,0 44774,1 44791,0 44844,1 44858,0 44922,1 44935,0 44948,1 45047,0 45068,1 45158,0 45191,1 45286,0 45363,1 45368,0 45377,1 45438,0 45535,1 45568,0 45581,1 45588,0 45627,1 45643,0 45718,1 45783,0 45818,1 45875,0 45880,1 45928,0 45972,1 46057,0 46118,1 46214,0 46280,1 46333,0 46337,1 46418,0 46438,1 46451,0 46522,1 46580,0 46585,1 46632,0 46729,1 46766,0 46770,1 46805,0 46903,1 46948,0 46993,1 47011,0 47021,1 47106,0 47183,1 47248,0 47286,1 47303,0 47340,1 47341,0 47411,1 47481,0 47513,1 47533,0 47578,1 47672,0 47758,1 47784,0 47794,1 47802,0 47832,1 47851,0 47913,1 47919,0 47936,1 48013,0 48098,1 48103,0 48177,1 48274,0 48300,1 48383,0 48430,1 48522,0 48588,1 48589,0 48621,1 48670,0 48734,1 48766,0 48837,1 48851,0 48916,1 48962,0 49040,1 49092,0 49135,1 49227,0 49283,1 49324,0 49338,1 49415,0 49486,1 49548,0 49619,1 49714,0 49773,1 49864,0 49927,1 49944,0 49957,1 49969,0 50055,1 50078,0 50128,1 50228,0 50303,1 50385,0 50468,1 50498,0 50549,1 50634,0 50654,1 50694,0 50791,1 50890,0 50977,1 51040,0 51087,1 51177,0 51266,1 51281,0 51349,1 51445,0 51451,1 51473,0 51498,1 51508,0 51509,1 51569,0 51656,1 end initlist a2 0,0 20,1 112,0 124,1 209,0 239,1 334,0 428,1 492,0 581,1 587,0 651,1 742,0 776,1 778,0 822,1 848,0 863,1 902,0 969,1 1046,0 1141,1 1220,0 1286,1 1311,0 1359,1 1419,0 1471,1 1488,0 1530,1 1550,0 1577,1 1631,0 1639,1 1687,0 1738,1 1760,0 1762,1 1801,0 1807,1 1834,0 1890,1 1961,0 2042,1 2133,0 2208,1 2213,0 2306,1 2325,0 2405,1 2432,0 2480,1 2496,0 2537,1 2571,0 2615,1 2647,0 2727,1 2777,0 2858,1 2895,0 2988,1 3015,0 3040,1 3104,0 3134,1 3178,0 3226,1 3317,0 3383,1 3483,0 3577,1 3668,0 3768,1 3773,0 3839,1 3867,0 3924,1 3959,0 4027,1 4064,0 4100,1 4168,0 4234,1 4328,0 4354,1 4387,0 4431,1 4504,0 4594,1 4692,0 4725,1 4786,0 4838,1 4890,0 4933,1 4981,0 5050,1 5097,0 5110,1 5164,0 5174,1 5232,0 5331,1 5382,0 5421,1 5496,0 5575,1 5653,0 5733,1 5770,0 5817,1 5825,0 5856,1 5899,0 5971,1 6030,0 6036,1 6114,0 6187,1 6197,0 6250,1 6334,0 6347,1 6387,0 6481,1 6497,0 6594,1 6601,0 6613,1 6658,0 6662,1 6695,0 6699,1 6755,0 6822,1 6853,0 6946,1 6972,0 7050,1 7138,0 7195,1 7237,0 7264,1 7309,0 7394,1 7413,0 7485,1 7584,0 7682,1 7758,0 7847,1 7929,0 7969,1 8067,0 8089,1 8146,0 8198,1 8259,0 8306,1 8316,0 8402,1 8483,0 8555,1 8621,0 8675,1 8755,0 8838,1 8861,0 8944,1 8992,0 9071,1 9091,0 9155,1 9236,0 9242,1 9291,0 9340,1 9434,0 9441,1 9498,0 9553,1 9558,0 9651,1 9745,0 9823,1 9848,0 9886,1 9964,0 9982,1 10050,0 10077,1 10089,0 10181,1 10209,0 10245,1 10336,0 10383,1 10413,0 10485,1 10535,0 10552,1 10555,0 10577,1 10607,0 10652,1 10677,0 10687,1 10729,0 10809,1 10836,0 10926,1 11007,0 11045,1 11067,0 11071,1 11135,0 11144,1 11168,0 11181,1 11252,0 11260,1 11286,0 11302,1 11334,0 11432,1 11512,0 11553,1 11644,0 11671,1 11732,0 11747,1 11753,0 11829,1 11894,0 11966,1 11996,0 12007,1 12107,0 12187,1 12189,0 12203,1 12294,0 12343,1 12427,0 12488,1 12532,0 12607,1 12676,0 12758,1 12807,0 12861,1 12883,0 12948,1 12949,0 12965,1 13006,0 13039,1 13124,0 13174,1 13234,0 13294,1 13326,0 13355,1 13371,0 13454,1 13488,0 13512,1 13594,0 13690,1 13703,0 13705,1 13731,0 13780,1 13786,0 13816,1 13853,0 13894,1 13967,0 14066,1 14105,0 14151,1 14213,0 14222,1 14238,0 14256,1 14303,0 14385,1 14402,0 14447,1 14535,0 14555,1 14602,0 14641,1 14655,0 14712,1 14793,0 14872,1 14928,0 14978,1 15047,0 15145,1 15210,0 15309,1 15391,0 15415,1 15420,0 15426,1 15481,0 15493,1 15495,0 15547,1 15599,0 15678,1 15760,0 15796,1 15812,0 15896,1 15914,0 15968,1 15977,0 16026,1 16056,0 16069,1 16070,0 16137,1 16145,0 16178,1 16215,0 16286,1 16307,0 16349,1 16352,0 16439,1 16517,0 16578,1 16580,0 16602,1 16672,0 16720,1 16757,0 16806,1 16862,0 16891,1 16973,0 16990,1 17018,0 17104,1 17114,0 17143,1 17168,0 17205,1 17275,0 17323,1 17364,0 17444,1 17450,0 17532,1 17553,0 17601,1 17700,0 17798,1 17860,0 17960,1 17972,0 18066,1 18158,0 18205,1 18266,0 18316,1 18322,0 18323,1 18413,0 18465,1 18488,0 18506,1 18549,0 18566,1 18573,0 18631,1 18683,0 18740,1 18833,0 18924,1 19019,0 19061,1 19157,0 19253,1 19270,0 19339,1 19395,0 19485,1 19511,0 19572,1 19610,0 19629,1 19687,0 19748,1 19838,0 19853,1 19947,0 20003,1 20086,0 20105,1 20108,0 20156,1 20163,0 20224,1 20314,0 20334,1 20420,0 20497,1 20564,0 20644,1 20706,0 20770,1 20798,0 20804,1 20873,0 20930,1 21008,0 21013,1 21070,0 21166,1 21225,0 21297,1 21312,0 21330,1 21368,0 21453,1 21546,0 21573,1 21575,0 21594,1 21611,0 21620,1 21633,0 21678,1 21758,0 21816,1 21830,0 21882,1 21890,0 21930,1 21994,0 22093,1 22181,0 22212,1 22291,0 22355,1 22398,0 22431,1 22483,0 22576,1 22644,0 22712,1 22803,0 22881,1 22909,0 22976,1 22995,0 23004,1 23081,0 23167,1 23260,0 23334,1 23359,0 23391,1 23406,0 23409,1 23470,0 23531,1 23618,0 23636,1 23638,0 23722,1 23822,0 23892,1 23979,0 24069,1 24074,0 24097,1 24120,0 24202,1 24227,0 24256,1 24304,0 24308,1 24315,0 24404,1 24451,0 24508,1 24556,0 24576,1 24639,0 24684,1 24697,0 24714,1 24718,0 24731,1 24801,0 24866,1 24946,0 24947,1 24962,0 25005,1 25033,0 25056,1 25111,0 25201,1 25288,0 25336,1 25340,0 25348,1 25352,0 25366,1 25388,0 25449,1 25548,0 25639,1 25690,0 25773,1 25792,0 25860,1 25960,0 26044,1 26072,0 26116,1 26135,0 26171,1 26268,0 26277,1 26325,0 26425,1 26506,0 26520,1 26554,0 26652,1 26669,0 26680,1 26742,0 26794,1 26804,0 26875,1 26945,0 27003,1 27038,0 27067,1 27167,0 27244,1 27295,0 27311,1 27379,0 27406,1 27424,0 27509,1 27515,0 27604,1 27692,0 27718,1 27746,0 27772,1 27852,0 27936,1 28011,0 28020,1 28024,0 28121,1 28131,0 28207,1 28263,0 28331,1 28374,0 28406,1 28474,0 28504,1 28567,0 28586,1 28635,0 28729,1 28787,0 28874,1 28932,0 28972,1 29046,0 29110,1 29179,0 29182,1 29191,0 29227,1 29235,0 29313,1 29333,0 29367,1 29402,0 29450,1 29470,0 29504,1 29510,0 29572,1 29658,0 29715,1 29765,0 29795,1 29799,0 29846,1 29941,0 30039,1 30083,0 30084,1 30170,0 30267,1 30279,0 30312,1 30368,0 30453,1 30550,0 30570,1 30647,0 30732,1 30738,0 30758,1 30834,0 30884,1 30896,0 30974,1 31018,0 31111,1 31188,0 31227,1 31293,0 31313,1 31347,0 31359,1 31403,0 31478,1 31512,0 31542,1 31627,0 31678,1 31691,0 31722,1 31798,0 31836,1 31928,0 32023,1 32048,0 32139,1 32184,0 32259,1 32294,0 32304,1 32327,0 32402,1 32410,0 32508,1 32595,0 32604,1 32669,0 32768,1 32854,0 32954,1 32977,0 33044,1 33098,0 33109,1 33128,0 33187,1 33247,0 33338,1 33404,0 33427,1 33453,0 33524,1 33543,0 33548,1 33558,0 33582,1 33600,0 33676,1 33729,0 33782,1 33820,0 33888,1 33951,0 33954,1 33970,0 33981,1 34074,0 34110,1 34147,0 34186,1 34243,0 34289,1 34389,0 34485,1 34562,0 34619,1 34660,0 34695,1 34711,0 34803,1 34889,0 34947,1 34954,0 34986,1 35013,0 35091,1 35138,0 35206,1 35299,0 35373,1 35424,0 35506,1 35574,0 35631,1 35729,0 35787,1 35798,0 35854,1 35951,0 36049,1 36115,0 36166,1 36199,0 36228,1 36292,0 36299,1 36308,0 36338,1 36432,0 36512,1 36570,0 36669,1 36700,0 36720,1 36760,0 36808,1 36869,0 36891,1 36892,0 36922,1 36934,0 37014,1 37021,0 37091,1 37182,0 37197,1 37227,0 37263,1 37325,0 37334,1 37350,0 37352,1 37382,0 37392,1 37439,0 37477,1 37546,0 37602,1 37694,0 37755,1 37812,0 37815,1 37905,0 37967,1 38019,0 38116,1 38175,0 38227,1 38254,0 38261,1 38331,0 38349,1 38388,0 38445,1 38446,0 38493,1 38521,0 38575,1 38669,0 38767,1 38859,0 38860,1 38945,0 38946,1 39020,0 39080,1 39103,0 39139,1 39173,0 39259,1 39356,0 39357,1 39428,0 39498,1 39552,0 39613,1 39647,0 39712,1 39724,0 39738,1 39814,0 39831,1 39917,0 39937,1 39948,0 40015,1 40080,0 40104,1 40134,0 40177,1 40215,0 40220,1 40258,0 40316,1 40339,0 40387,1 40416,0 40479,1 40553,0 40608,1 40613,0 40625,1 40656,0 40695,1 40744,0 40839,1 40849,0 40928,1 40988,0 41038,1 41068,0 41141,1 41193,0 41283,1 41366,0 41446,1 41455,0 41509,1 41571,0 41599,1 41630,0 41707,1 41739,0 41839,1 41874,0 41924,1 41953,0 42032,1 42035,0 42124,1 42166,0 42264,1 42319,0 42396,1 42483,0 42489,1 42563,0 42625,1 42718,0 42774,1 42804,0 42845,1 42912,0 42948,1 42998,0 43035,1 43059,0 43060,1 43153,0 43206,1 43230,0 43268,1 43278,0 43279,1 43343,0 43422,1 43495,0 43524,1 43587,0 43663,1 43677,0 43710,1 43740,0 43749,1 43815,0 43879,1 43880,0 43902,1 43940,0 43950,1 44009,0 44060,1 44131,0 44138,1 44179,0 44250,1 44270,0 44274,1 44328,0 44364,1 44407,0 44465,1 44494,0 44503,1 44522,0 44546,1 44614,0 44640,1 44718,0 44807,1 44883,0 44949,1 45038,0 45115,1 45201,0 45254,1 45298,0 45384,1 45431,0 45470,1 45547,0 45582,1 45680,0 45777,1 45869,0 45935,1 45989,0 46054,1 46139,0 46144,1 46163,0 46177,1 46245,0 46246,1 46292,0 46389,1 46420,0 46502,1 46526,0 46560,1 46621,0 46625,1 46641,0 46733,1 46830,0 46897,1 46965,0 47015,1 47040,0 47063,1 47113,0 47138,1 47179,0 47258,1 47305,0 47369,1 47416,0 47473,1 47482,0 47559,1 47561,0 47562,1 47565,0 47622,1 47636,0 47640,1 47649,0 47705,1 47755,0 47850,1 47853,0 47933,1 48022,0 48118,1 48199,0 48219,1 48281,0 48322,1 48390,0 48422,1 48430,0 48473,1 48505,0 48542,1 48599,0 48617,1 48688,0 48689,1 48721,0 48778,1 48876,0 48934,1 48968,0 49017,1 49053,0 49084,1 49121,0 49159,1 49222,0 49284,1 end initlist a3 0,0 40,1 109,0 193,1 195,0 232,1 303,0 356,1 378,0 380,1 456,0 474,1 526,0 605,1 672,0 745,1 790,0 825,1 866,0 899,1 908,0 997,1 1008,0 1015,1 1080,0 1149,1 1246,0 1269,1 1347,0 1439,1 1489,0 1528,1 1618,0 1637,1 1732,0 1740,1 1757,0 1810,1 1903,0 1979,1 2071,0 2118,1 2204,0 2252,1 2261,0 2328,1 2347,0 2358,1 2398,0 2463,1 2494,0 2532,1 2607,0 2662,1 2666,0 2736,1 2770,0 2821,1 2872,0 2910,1 3005,0 3073,1 3077,0 3079,1 3097,0 3164,1 3261,0 3269,1 3315,0 3409,1 3438,0 3455,1 3493,0 3577,1 3603,0 3639,1 3671,0 3757,1 3776,0 3825,1 3913,0 3962,1 3998,0 4070,1 4111,0 4113,1 4153,0 4206,1 4269,0 4324,1 4410,0 4447,1 4536,0 4579,1 4666,0 4692,1 4788,0 4792,1 4858,0 4938,1 5020,0 5118,1 5139,0 5204,1 5217,0 5301,1 5361,0 5456,1 5533,0 5540,1 5603,0 5614,1 5691,0 5723,1 5766,0 5769,1 5809,0 5844,1 5919,0 6007,1 6050,0 6122,1 6149,0 6197,1 6273,0 6373,1 6398,0 6439,1 6471,0 6549,1 6600,0 6622,1 6682,0 6691,1 6725,0 6749,1 6765,0 6819,1 6855,0 6925,1 7011,0 7036,1 7082,0 7180,1 7188,0 7258,1 7291,0 7381,1 7439,0 7519,1 7565,0 7588,1 7685,0 7732,1 7811,0 7878,1 7938,0 7979,1 8052,0 8064,1 8112,0 8141,1 8180,0 8199,1 8270,0 8310,1 8347,0 8383,1 8407,0 8479,1 8495,0 8557,1 8608,0 8657,1 8727,0 8817,1 8892,0 8982,1 9039,0 9077,1 9148,0 9166,1 9222,0 9264,1 9338,0 9353,1 9378,0 9417,1 9472,0 9549,1 9556,0 9640,1 9689,0 9746,1 9825,0 9827,1 9914,0 9916,1 9969,0 10067,1 10084,0 10127,1 10145,0 10203,1 10256,0 10341,1 10434,0 10496,1 10585,0 10672,1 10747,0 10826,1 10830,0 10856,1 10913,0 10997,1 11044,0 11144,1 11212,0 11253,1 11339,0 11352,1 11443,0 11505,1 11569,0 11633,1 11645,0 11681,1 11698,0 11751,1 11792,0 11805,1 11816,0 11860,1 11873,0 11971,1 12066,0 12116,1 12185,0 12215,1 12311,0 12332,1 12357,0 12446,1 12511,0 12560,1 12655,0 12698,1 12770,0 12779,1 12830,0 12879,1 12911,0 12912,1 12968,0 13030,1 13036,0 13048,1 13080,0 13178,1 13255,0 13279,1 13333,0 13360,1 13455,0 13542,1 13574,0 13618,1 13628,0 13700,1 13728,0 13747,1 13782,0 13829,1 13883,0 13907,1 13909,0 13997,1 14039,0 14099,1 14139,0 14221,1 14233,0 14247,1 14301,0 14305,1 14342,0 14425,1 14513,0 14554,1 14612,0 14689,1 14690,0 14752,1 14776,0 14791,1 14870,0 14936,1 14967,0 15048,1 15122,0 15147,1 15189,0 15250,1 15342,0 15380,1 15457,0 15469,1 15503,0 15522,1 15615,0 15713,1 15810,0 15858,1 15880,0 15895,1 15953,0 15963,1 15994,0 16058,1 16133,0 16142,1 16180,0 16246,1 16300,0 16356,1 16377,0 16417,1 16448,0 16482,1 16548,0 16574,1 16654,0 16702,1 16732,0 16745,1 16839,0 16888,1 16894,0 16939,1 16945,0 16968,1 17025,0 17040,1 17100,0 17134,1 17189,0 17212,1 17257,0 17328,1 17350,0 17408,1 17494,0 17591,1 17646,0 17724,1 17814,0 17881,1 17926,0 17984,1 18029,0 18083,1 18104,0 18175,1 18204,0 18302,1 18361,0 18368,1 18464,0 18541,1 18630,0 18665,1 18686,0 18735,1 18739,0 18746,1 18839,0 18910,1 18953,0 18993,1 19089,0 19174,1 19184,0 19271,1 19298,0 19324,1 19408,0 19453,1 19469,0 19519,1 19607,0 19619,1 19703,0 19784,1 19833,0 19857,1 19933,0 20023,1 20103,0 20117,1 20127,0 20179,1 20217,0 20290,1 20376,0 20464,1 20476,0 20542,1 20628,0 20693,1 20755,0 20814,1 20863,0 20864,1 20878,0 20896,1 20977,0 21022,1 21057,0 21107,1 21204,0 21289,1 21318,0 21381,1 21438,0 21461,1 21531,0 21626,1 21712,0 21784,1 21834,0 21888,1 21916,0 21945,1 22007,0 22050,1 22095,0 22179,1 22247,0 22338,1 22429,0 22490,1 22495,0 22576,1 22579,0 22656,1 22743,0 22758,1 22782,0 22816,1 22860,0 22900,1 22962,0 23047,1 23048,0 23050,1 23126,0 23157,1 23234,0 23307,1 23369,0 23448,1 23547,0 23549,1 23636,0 23651,1 23727,0 23776,1 23803,0 23854,1 23921,0 23944,1 24003,0 24069,1 24153,0 24224,1 24240,0 24291,1 24383,0 24407,1 24411,0 24478,1 24545,0 24617,1 24683,0 24708,1 24798,0 24807,1 24847,0 24909,1 25008,0 25061,1 25134,0 25164,1 25252,0 25303,1 25332,0 25420,1 25455,0 25543,1 25611,0 25638,1 25706,0 25743,1 25780,0 25856,1 25872,0 25933,1 25970,0 26037,1 26134,0 26154,1 26191,0 26194,1 26205,0 26246,1 26284,0 26330,1 26337,0 26435,1 26436,0 26515,1 26591,0 26638,1 26685,0 26691,1 26787,0 26861,1 26956,0 27014,1 27048,0 27092,1 27156,0 27191,1 27238,0 27285,1 27350,0 27402,1 27447,0 27538,1 27560,0 27578,1 27609,0 27700,1 27774,0 27805,1 27868,0 27900,1 27988,0 28065,1 28151,0 28246,1 28307,0 28332,1 28417,0 28468,1 28547,0 28606,1 28616,0 28645,1 28669,0 28692,1 28717,0 28740,1 28828,0 28913,1 28921,0 28996,1 29032,0 29036,1 29082,0 29088,1 29179,0 29219,1 29278,0 29368,1 29452,0 29489,1 29559,0 29627,1 29638,0 29673,1 29739,0 29747,1 29798,0 29820,1 29903,0 30001,1 30096,0 30110,1 30155,0 30233,1 30319,0 30371,1 30387,0 30396,1 30433,0 30509,1 30597,0 30633,1 30684,0 30709,1 30768,0 30851,1 30919,0 30946,1 30959,0 30978,1 31078,0 31116,1 31120,0 31193,1 31228,0 31267,1 31356,0 31390,1 31420,0 31478,1 31578,0 31636,1 31666,0 31762,1 31819,0 31864,1 31871,0 31953,1 32033,0 32097,1 32151,0 32198,1 32219,0 32297,1 32332,0 32367,1 32376,0 32390,1 32444,0 32537,1 32585,0 32666,1 32762,0 32789,1 32876,0 32908,1 32979,0 32985,1 33072,0 33128,1 33206,0 33299,1 33349,0 33380,1 33448,0 33502,1 33594,0 33670,1 33714,0 33743,1 33782,0 33827,1 33894,0 33912,1 33914,0 33957,1 34017,0 34085,1 34149,0 34171,1 34269,0 34323,1 34380,0 34444,1 34455,0 34544,1 34640,0 34713,1 34730,0 34789,1 34875,0 34947,1 34958,0 35004,1 35091,0 35178,1 35268,0 35273,1 35306,0 35363,1 35409,0 35425,1 35495,0 35567,1 35579,0 35668,1 35669,0 35753,1 35770,0 35841,1 35904,0 35941,1 36032,0 36096,1 36192,0 36288,1 36299,0 36330,1 36358,0 36390,1 36441,0 36458,1 36549,0 36568,1 36643,0 36661,1 36743,0 36839,1 36928,0 37003,1 37080,0 37101,1 37159,0 37179,1 37258,0 37262,1 37329,0 37353,1 37430,0 37434,1 37532,0 37589,1 37681,0 37775,1 37826,0 37890,1 37973,0 38000,1 38007,0 38086,1 38136,0 38188,1 38265,0 38268,1 38271,0 38302,1 38377,0 38457,1 38508,0 38512,1 38600,0 38670,1 38675,0 38692,1 38715,0 38743,1 38839,0 38909,1 38981,0 39077,1 39132,0 39179,1 39211,0 39263,1 39296,0 39394,1 39444,0 39531,1 39537,0 39622,1 39713,0 39799,1 39899,0 39964,1 40041,0 40061,1 40160,0 40243,1 40322,0 40326,1 40418,0 40424,1 40454,0 40486,1 40578,0 40648,1 40667,0 40687,1 40732,0 40742,1 40807,0 40823,1 40913,0 40921,1 40942,0 40948,1 41000,0 41017,1 41039,0 41118,1 41211,0 41276,1 41319,0 41335,1 41418,0 41517,1 41613,0 41670,1 41728,0 41806,1 41866,0 41926,1 42008,0 42067,1 42137,0 42164,1 42173,0 42268,1 42361,0 42412,1 42438,0 42509,1 42607,0 42624,1 42714,0 42723,1 42765,0 42770,1 42836,0 42865,1 42867,0 42939,1 42944,0 43020,1 43076,0 43110,1 43125,0 43200,1 43244,0 43307,1 43350,0 43368,1 43375,0 43423,1 43504,0 43591,1 43622,0 43645,1 43703,0 43718,1 43758,0 43830,1 43908,0 43914,1 43982,0 44018,1 44067,0 44146,1 44190,0 44220,1 44266,0 44268,1 44334,0 44407,1 44489,0 44525,1 44550,0 44616,1 44670,0 44697,1 44728,0 44770,1 44801,0 44815,1 44889,0 44900,1 44997,0 45038,1 45114,0 45117,1 45216,0 45239,1 45305,0 45347,1 45401,0 45442,1 45473,0 45512,1 45526,0 45531,1 45533,0 45563,1 45567,0 45601,1 45693,0 45702,1 45716,0 45738,1 45796,0 45875,1 45963,0 45976,1 45989,0 46014,1 46016,0 46103,1 46112,0 46181,1 46232,0 46272,1 46307,0 46359,1 46382,0 46428,1 46434,0 46516,1 46589,0 46619,1 46654,0 46698,1 46767,0 46856,1 46939,0 46976,1 46986,0 47004,1 47021,0 47105,1 47175,0 47237,1 47284,0 47304,1 47316,0 47365,1 47443,0 47503,1 47570,0 47668,1 47676,0 47712,1 47724,0 47788,1 47833,0 47930,1 47935,0 48002,1 48022,0 48037,1 48126,0 48212,1 48238,0 48330,1 48396,0 48474,1 48531,0 48627,1 48718,0 48793,1 48819,0 48916,1 48958,0 49043,1 49112,0 49184,1 49233,0 49265,1 49301,0 49377,1 49444,0 49522,1 49576,0 49645,1 49677,0 49719,1 49774,0 49786,1 49884,0 49915,1 49960,0 50017,1 50047,0 50054,1 50138,0 50158,1 50215,0 50310,1 50329,0 50369,1 50442,0 50443,1 50473,0 50536,1 50596,0 50613,1 50652,0 50738,1 50815,0 50902,1 50959,0 51027,1 51127,0 51212,1 51296,0 51381,1 end initlist a4 0,0 39,1 113,0 149,1 223,0 250,1 272,0 305,1 391,0 454,1 514,0 537,1 608,0 686,1 725,0 792,1 866,0 958,1 1048,0 1126,1 1128,0 1139,1 1172,0 1267,1 1281,0 1367,1 1370,0 1373,1 1429,0 1456,1 1513,0 1547,1 1566,0 1609,1 1673,0 1734,1 1830,0 1833,1 1857,0 1885,1 1951,0 1973,1 2050,0 2074,1 2087,0 2124,1 2125,0 2206,1 2211,0 2261,1 2335,0 2391,1 2426,0 2454,1 2501,0 2546,1 2562,0 2609,1 2705,0 2726,1 2793,0 2795,1 2893,0 2914,1 2965,0 3064,1 3142,0 3228,1 3321,0 3370,1 3408,0 3455,1 3503,0 3569,1 3570,0 3607,1 3701,0 3752,1 3785,0 3845,1 3933,0 3982,1 4011,0 4036,1 4071,0 4170,1 4241,0 4264,1 4350,0 4362,1 4418,0 4437,1 4523,0 4605,1 4656,0 4752,1 4818,0 4892,1 4905,0 4906,1 4944,0 4991,1 4993,0 5081,1 5108,0 5205,1 5248,0 5257,1 5259,0 5348,1 5391,0 5455,1 5465,0 5520,1 5524,0 5562,1 5657,0 5683,1 5686,0 5716,1 5755,0 5779,1 5801,0 5901,1 5932,0 5991,1 6007,0 6040,1 6132,0 6209,1 6210,0 6295,1 6344,0 6426,1 6485,0 6533,1 6607,0 6616,1 6708,0 6789,1 6860,0 6922,1 6964,0 6971,1 7064,0 7119,1 7136,0 7139,1 7193,0 7209,1 7299,0 7378,1 7389,0 7448,1 7495,0 7594,1 7595,0 7672,1 7720,0 7818,1 7886,0 7979,1 7985,0 8016,1 8082,0 8113,1 8135,0 8202,1 8225,0 8226,1 8264,0 8282,1 8364,0 8384,1 8390,0 8454,1 8493,0 8530,1 8601,0 8628,1 8653,0 8672,1 8684,0 8694,1 8731,0 8803,1 8883,0 8937,1 8981,0 9049,1 9147,0 9191,1 9274,0 9356,1 9429,0 9503,1 9557,0 9584,1 9683,0 9762,1 9802,0 9812,1 9856,0 9858,1 9871,0 9967,1 9974,0 9995,1 10077,0 10135,1 10176,0 10269,1 10367,0 10463,1 10511,0 10538,1 10569,0 10660,1 10708,0 10803,1 10806,0 10874,1 10911,0 11003,1 11058,0 11136,1 11197,0 11284,1 11381,0 11458,1 11462,0 11555,1 11592,0 11615,1 11645,0 11705,1 11789,0 11845,1 11898,0 11940,1 12036,0 12082,1 12157,0 12190,1 12225,0 12267,1 12329,0 12427,1 12467,0 12561,1 12616,0 12680,1 12756,0 12820,1 12843,0 12879,1 12958,0 13009,1 13040,0 13121,1 13149,0 13212,1 13248,0 13324,1 13400,0 13401,1 13410,0 13464,1 13517,0 13617,1 13700,0 13783,1 13789,0 13872,1 13940,0 13967,1 14008,0 14032,1 14102,0 14180,1 14193,0 14241,1 14308,0 14353,1 14405,0 14414,1 14469,0 14501,1 14512,0 14587,1 14605,0 14678,1 14718,0 14797,1 14838,0 14911,1 14924,0 14998,1 15036,0 15042,1 15050,0 15112,1 15205,0 15218,1 15266,0 15289,1 15346,0 15440,1 15471,0 15558,1 15582,0 15674,1 15710,0 15743,1 15777,0 15818,1 15893,0 15965,1 16023,0 16040,1 16061,0 16121,1 16175,0 16238,1 16269,0 16337,1 16373,0 16395,1 16434,0 16500,1 16514,0 16601,1 16604,0 16671,1 16677,0 16769,1 16806,0 16895,1 16974,0 16994,1 17063,0 17138,1 17217,0 17256,1 17338,0 17353,1 17438,0 17483,1 17551,0 17611,1 17681,0 17684,1 17770,0 17851,1 17934,0 18006,1 18043,0 18126,1 18157,0 18172,1 18220,0 18299,1 18385,0 18425,1 18518,0 18602,1 18669,0 18724,1 18812,0 18822,1 18876,0 18945,1 18952,0 18962,1 19045,0 19115,1 19140,0 19151,1 19212,0 19278,1 19369,0 19443,1 19494,0 19506,1 19559,0 19637,1 19655,0 19746,1 19747,0 19801,1 19898,0 19938,1 19954,0 19958,1 19977,0 20043,1 20066,0 20104,1 20201,0 20245,1 20285,0 20324,1 20358,0 20392,1 20481,0 20575,1 20616,0 20688,1 20765,0 20774,1 20800,0 20850,1 20914,0 20945,1 21035,0 21114,1 21144,0 21196,1 21294,0 21385,1 21407,0 21492,1 21530,0 21610,1 21611,0 21613,1 21683,0 21727,1 21729,0 21747,1 21804,0 21858,1 21887,0 21982,1 22054,0 22120,1 22182,0 22248,1 22256,0 22282,1 22365,0 22439,1 22452,0 22501,1 22518,0 22537,1 22586,0 22676,1 22743,0 22773,1 22855,0 22903,1 22943,0 22981,1 22999,0 23095,1 23144,0 23153,1 23161,0 23177,1 23209,0 23247,1 23330,0 23358,1 23435,0 23440,1 23501,0 23555,1 23608,0 23693,1 23745,0 23832,1 23867,0 23869,1 23916,0 24010,1 24018,0 24054,1 24143,0 24147,1 24197,0 24229,1 24268,0 24290,1 24299,0 24364,1 24439,0 24490,1 24522,0 24621,1 24681,0 24682,1 24719,0 24723,1 24747,0 24806,1 24822,0 24889,1 24978,0 25057,1 25102,0 25169,1 25214,0 25234,1 25288,0 25362,1 25367,0 25380,1 25444,0 25483,1 25526,0 25625,1 25708,0 25804,1 25893,0 25949,1 25950,0 25975,1 26075,0 26111,1 26193,0 26278,1 26372,0 26457,1 26485,0 26512,1 26562,0 26614,1 26651,0 26747,1 26814,0 26818,1 26838,0 26878,1 26910,0 26973,1 27063,0 27118,1 27172,0 27217,1 27218,0 27306,1 27372,0 27373,1 27470,0 27486,1 27514,0 27544,1 27643,0 27680,1 27689,0 27717,1 27782,0 27863,1 27885,0 27910,1 27989,0 28032,1 28103,0 28180,1 28250,0 28263,1 28340,0 28404,1 28420,0 28487,1 28510,0 28564,1 28639,0 28718,1 28739,0 28750,1 28803,0 28805,1 28838,0 28880,1 28917,0 28947,1 28951,0 28981,1 29000,0 29029,1 29094,0 29143,1 29183,0 29266,1 29322,0 29362,1 29403,0 29486,1 29502,0 29598,1 29686,0 29690,1 29771,0 29845,1 29876,0 29954,1 30013,0 30093,1 30105,0 30198,1 30243,0 30317,1 30405,0 30411,1 30433,0 30533,1 30609,0 30637,1 30721,0 30794,1 30815,0 30840,1 30843,0 30901,1 30974,0 30998,1 31062,0 31078,1 31132,0 31174,1 31204,0 31285,1 31335,0 31361,1 31420,0 31456,1 31503,0 31574,1 31578,0 31661,1 31673,0 31765,1 31828,0 31886,1 31922,0 32011,1 32037,0 32105,1 32114,0 32119,1 32187,0 32240,1 32295,0 32309,1 32311,0 32358,1 32384,0 32439,1 32537,0 32623,1 32634,0 32642,1 32671,0 32759,1 32815,0 32899,1 32910,0 32989,1 33002,0 33025,1 33041,0 33136,1 33195,0 33287,1 33362,0 33418,1 33509,0 33565,1 33634,0 33733,1 33809,0 33840,1 33932,0 33969,1 34059,0 34129,1 34193,0 34265,1 34361,0 34444,1 34454,0 34494,1 34511,0 34593,1 34665,0 34714,1 34763,0 34811,1 34890,0 34974,1 35005,0 35074,1 35113,0 35148,1 35184,0 35198,1 35237,0 35332,1 35374,0 35464,1 35510,0 35602,1 35667,0 35747,1 35828,0 35909,1 35984,0 36037,1 36074,0 36153,1 36199,0 36245,1 36284,0 36287,1 36377,0 36438,1 36529,0 36629,1 36656,0 36710,1 36748,0 36794,1 36806,0 36901,1 36974,0 36999,1 37062,0 37160,1 37210,0 37303,1 37369,0 37377,1 37436,0 37479,1 37516,0 37575,1 37669,0 37671,1 37764,0 37818,1 37855,0 37923,1 37995,0 38039,1 38136,0 38172,1 38242,0 38254,1 38297,0 38327,1 38332,0 38364,1 38371,0 38395,1 38425,0 38519,1 38584,0 38655,1 38667,0 38690,1 38745,0 38818,1 38867,0 38897,1 38983,0 39023,1 39059,0 39062,1 39072,0 39138,1 39180,0 39205,1 39235,0 39297,1 39360,0 39362,1 39378,0 39397,1 39463,0 39472,1 39484,0 39561,1 39638,0 39661,1 39688,0 39709,1 39756,0 39794,1 39879,0 39947,1 39975,0 40042,1 40081,0 40146,1 40230,0 40260,1 40300,0 40330,1 40357,0 40431,1 40443,0 40474,1 40477,0 40532,1 40537,0 40538,1 40543,0 40640,1 40738,0 40783,1 40785,0 40849,1 40881,0 40910,1 40953,0 40981,1 41042,0 41105,1 41144,0 41154,1 41170,0 41232,1 41252,0 41322,1 41377,0 41443,1 41520,0 41539,1 41608,0 41625,1 41633,0 41654,1 41671,0 41682,1 41726,0 41753,1 41853,0 41897,1 41966,0 41973,1 41998,0 42000,1 42016,0 42028,1 42104,0 42190,1 42214,0 42253,1 42317,0 42416,1 42504,0 42564,1 42589,0 42631,1 42700,0 42733,1 42755,0 42854,1 42897,0 42991,1 43026,0 43071,1 43126,0 43173,1 43266,0 43353,1 43362,0 43385,1 43415,0 43421,1 43469,0 43503,1 43575,0 43640,1 43690,0 43692,1 43741,0 43762,1 43805,0 43808,1 43872,0 43972,1 44052,0 44067,1 44130,0 44220,1 44319,0 44339,1 44407,0 44416,1 44424,0 44451,1 44496,0 44499,1 44545,0 44578,1 44602,0 44649,1 44689,0 44703,1 44768,0 44856,1 44939,0 44980,1 45060,0 45134,1 45220,0 45250,1 45299,0 45394,1 45398,0 45467,1 45491,0 45578,1 45642,0 45652,1 45684,0 45737,1 45804,0 45805,1 45853,0 45928,1 46025,0 46043,1 46094,0 46111,1 46118,0 46188,1 46261,0 46330,1 46415,0 46502,1 46508,0 46558,1 46580,0 46650,1 46684,0 46713,1 46802,0 46888,1 46931,0 47018,1 47044,0 47117,1 47130,0 47175,1 47194,0 47274,1 47356,0 47437,1 47453,0 47550,1 47641,0 47696,1 47730,0 47814,1 47823,0 47893,1 47938,0 47993,1 48078,0 48110,1 48147,0 48214,1 48231,0 48311,1 48393,0 48461,1 48557,0 48616,1 48702,0 48749,1 48847,0 48914,1 48994,0 49091,1 49144,0 49227,1 49314,0 49384,1 49472,0 49556,1 49603,0 49665,1 49700,0 49744,1 49762,0 49785,1 49791,0 49889,1 49891,0 49975,1 50056,0 50134,1 50202,0 50278,1 50325,0 50425,1 50470,0 50566,1 end initlist a5 0,0 51,1 67,0 116,1 185,0 221,1 302,0 379,1 451,0 534,1 598,0 605,1 610,0 651,1 705,0 762,1 831,0 921,1 987,0 1013,1 1016,0 1057,1 1083,0 1178,1 1196,0 1199,1 1283,0 1368,1 1448,0 1464,1 1532,0 1578,1 1625,0 1626,1 1672,0 1695,1 1732,0 1774,1 1865,0 1930,1 1984,0 2071,1 2158,0 2172,1 2251,0 2275,1 2285,0 2372,1 2408,0 2490,1 2570,0 2646,1 2673,0 2758,1 2830,0 2908,1 2948,0 2998,1 3005,0 3082,1 3160,0 3250,1 3272,0 3274,1 3321,0 3392,1 3468,0 3519,1 3531,0 3619,1 3635,0 3712,1 3751,0 3804,1 3853,0 3902,1 3908,0 3922,1 3925,0 3974,1 4024,0 4055,1 4077,0 4105,1 4136,0 4215,1 4304,0 4389,1 4476,0 4532,1 4558,0 4658,1 4736,0 4750,1 4767,0 4802,1 4867,0 4938,1 5023,0 5071,1 5107,0 5132,1 5164,0 5242,1 5305,0 5393,1 5429,0 5452,1 5534,0 5580,1 5625,0 5675,1 5713,0 5722,1 5776,0 5820,1 5871,0 5894,1 5979,0 5981,1 6059,0 6125,1 6182,0 6223,1 6239,0 6277,1 6280,0 6310,1 6313,0 6378,1 6465,0 6535,1 6565,0 6645,1 6720,0 6795,1 6825,0 6883,1 6900,0 6997,1 7018,0 7043,1 7143,0 7146,1 7175,0 7208,1 7265,0 7345,1 7368,0 7374,1 7448,0 7467,1 7473,0 7527,1 7596,0 7613,1 7670,0 7769,1 7866,0 7955,1 8055,0 8147,1 8148,0 8183,1 8236,0 8255,1 8256,0 8276,1 8300,0 8305,1 8361,0 8378,1 8474,0 8561,1 8661,0 8698,1 8768,0 8798,1 8827,0 8867,1 8925,0 8935,1 8939,0 8944,1 8981,0 9018,1 9090,0 9156,1 9205,0 9212,1 9310,0 9338,1 9349,0 9351,1 9385,0 9415,1 9473,0 9500,1 9550,0 9626,1 9684,0 9747,1 9775,0 9838,1 9886,0 9895,1 9916,0 9999,1 10026,0 10074,1 10096,0 10159,1 10202,0 10275,1 10294,0 10361,1 10428,0 10455,1 10463,0 10524,1 10572,0 10640,1 10732,0 10786,1 10792,0 10833,1 10875,0 10958,1 11058,0 11101,1 11165,0 11245,1 11251,0 11318,1 11371,0 11425,1 11436,0 11518,1 11599,0 11671,1 11712,0 11749,1 11838,0 11913,1 11931,0 11951,1 12049,0 12086,1 12173,0 12260,1 12268,0 12288,1 12289,0 12310,1 12313,0 12412,1 12447,0 12494,1 12511,0 12524,1 12571,0 12587,1 12597,0 12657,1 12717,0 12780,1 12813,0 12879,1 12978,0 12984,1 12989,0 13089,1 13163,0 13228,1 13299,0 13366,1 13453,0 13495,1 13520,0 13555,1 13562,0 13586,1 13642,0 13685,1 13691,0 13710,1 13745,0 13775,1 13799,0 13800,1 13842,0 13884,1 13930,0 13946,1 14007,0 14068,1 14149,0 14244,1 14259,0 14264,1 14273,0 14348,1 14351,0 14358,1 14362,0 14381,1 14468,0 14510,1 14603,0 14668,1 14710,0 14770,1 14858,0 14935,1 14956,0 14996,1 15012,0 15024,1 15078,0 15088,1 15115,0 15198,1 15276,0 15373,1 15456,0 15523,1 15603,0 15620,1 15699,0 15710,1 15753,0 15850,1 15938,0 16010,1 16035,0 16063,1 16076,0 16112,1 16184,0 16273,1 16308,0 16357,1 16383,0 16447,1 16475,0 16526,1 16617,0 16705,1 16735,0 16813,1 16880,0 16927,1 16943,0 17035,1 17050,0 17113,1 17115,0 17146,1 17204,0 17237,1 17309,0 17346,1 17395,0 17426,1 17439,0 17485,1 17512,0 17565,1 17590,0 17599,1 17614,0 17637,1 17685,0 17765,1 17818,0 17867,1 17934,0 17981,1 18062,0 18136,1 18167,0 18226,1 18270,0 18351,1 18376,0 18435,1 18492,0 18519,1 18544,0 18564,1 18624,0 18641,1 18726,0 18795,1 18820,0 18833,1 18872,0 18891,1 18892,0 18945,1 18977,0 19012,1 19055,0 19107,1 19129,0 19131,1 19216,0 19264,1 19302,0 19329,1 19365,0 19445,1 19446,0 19488,1 19512,0 19579,1 19607,0 19642,1 19716,0 19795,1 19817,0 19870,1 19895,0 19909,1 19936,0 19973,1 20011,0 20097,1 20153,0 20211,1 20244,0 20278,1 20354,0 20394,1 20402,0 20420,1 20510,0 20538,1 20582,0 20612,1 20645,0 20733,1 20745,0 20783,1 20868,0 20912,1 20989,0 21084,1 21162,0 21226,1 21302,0 21400,1 21481,0 21527,1 21592,0 21692,1 21699,0 21782,1 21806,0 21857,1 21876,0 21959,1 21978,0 22016,1 22032,0 22065,1 22081,0 22133,1 22176,0 22275,1 22285,0 22371,1 22398,0 22462,1 22519,0 22557,1 22601,0 22650,1 22695,0 22701,1 22775,0 22810,1 22881,0 22981,1 23019,0 23063,1 23095,0 23167,1 23192,0 23209,1 23233,0 23286,1 23366,0 23408,1 23414,0 23490,1 23540,0 23586,1 23650,0 23660,1 23689,0 23714,1 23720,0 23761,1 23766,0 23802,1 23859,0 23862,1 23903,0 23940,1 23976,0 24015,1 24109,0 24130,1 24166,0 24236,1 24332,0 24417,1 24496,0 24589,1 24592,0 24674,1 24680,0 24754,1 24853,0 24867,1 24960,0 24977,1 25004,0 25007,1 25025,0 25051,1 25122,0 25189,1 25192,0 25242,1 25299,0 25375,1 25470,0 25484,1 25507,0 25584,1 25590,0 25675,1 25723,0 25815,1 25883,0 25931,1 25944,0 25957,1 26037,0 26086,1 26184,0 26281,1 26299,0 26389,1 26445,0 26538,1 26593,0 26596,1 26601,0 26675,1 26771,0 26812,1 26879,0 26882,1 26898,0 26912,1 26982,0 27073,1 27140,0 27147,1 27188,0 27192,1 27275,0 27340,1 27349,0 27364,1 27420,0 27431,1 27504,0 27512,1 27566,0 27612,1 27657,0 27666,1 27699,0 27734,1 27771,0 27858,1 27893,0 27909,1 27918,0 27970,1 28060,0 28109,1 28123,0 28158,1 28182,0 28265,1 28352,0 28362,1 28377,0 28392,1 28448,0 28512,1 28596,0 28605,1 28662,0 28697,1 28725,0 28726,1 28752,0 28839,1 28886,0 28907,1 28993,0 29020,1 29050,0 29070,1 29100,0 29101,1 29152,0 29229,1 29258,0 29283,1 29285,0 29308,1 29318,0 29403,1 29472,0 29556,1 29623,0 29686,1 29702,0 29790,1 29877,0 29918,1 29995,0 30070,1 30163,0 30200,1 30223,0 30278,1 30293,0 30296,1 30310,0 30312,1 30345,0 30410,1 30467,0 30539,1 30625,0 30669,1 30738,0 30834,1 30852,0 30921,1 30936,0 30991,1 31075,0 31098,1 31187,0 31211,1 31223,0 31229,1 31314,0 31367,1 31419,0 31472,1 31507,0 31566,1 31650,0 31735,1 31767,0 31841,1 31913,0 31930,1 31994,0 32066,1 32076,0 32133,1 32165,0 32190,1 32287,0 32291,1 32389,0 32439,1 32472,0 32497,1 32567,0 32640,1 32641,0 32734,1 32764,0 32791,1 32883,0 32923,1 32962,0 33012,1 33051,0 33084,1 33112,0 33152,1 33218,0 33275,1 33347,0 33445,1 33540,0 33625,1 33724,0 33812,1 33846,0 33938,1 33976,0 34000,1 34032,0 34093,1 34143,0 34163,1 34238,0 34248,1 34336,0 34416,1 34514,0 34578,1 34665,0 34714,1 34751,0 34826,1 34900,0 34918,1 34996,0 35063,1 35075,0 35101,1 35176,0 35214,1 35236,0 35256,1 35354,0 35450,1 35469,0 35568,1 35643,0 35662,1 35699,0 35785,1 35881,0 35943,1 35961,0 36007,1 36075,0 36084,1 36180,0 36245,1 36334,0 36413,1 36437,0 36454,1 36486,0 36570,1 36669,0 36714,1 36759,0 36794,1 36856,0 36887,1 36935,0 36959,1 37054,0 37060,1 37108,0 37144,1 37168,0 37195,1 37244,0 37312,1 37405,0 37479,1 37526,0 37560,1 37583,0 37632,1 37676,0 37774,1 37869,0 37904,1 37911,0 37953,1 37979,0 38029,1 38101,0 38109,1 38194,0 38271,1 38324,0 38423,1 38517,0 38571,1 38615,0 38691,1 38762,0 38817,1 38875,0 38884,1 38961,0 39000,1 39097,0 39141,1 39151,0 39180,1 39211,0 39273,1 39346,0 39413,1 39477,0 39523,1 39557,0 39577,1 39589,0 39669,1 39703,0 39712,1 39737,0 39786,1 39861,0 39947,1 40040,0 40127,1 40153,0 40239,1 40274,0 40360,1 40427,0 40485,1 40574,0 40642,1 40710,0 40793,1 40888,0 40925,1 40993,0 41007,1 41085,0 41184,1 41283,0 41343,1 41383,0 41437,1 41465,0 41466,1 41504,0 41568,1 41570,0 41594,1 41646,0 41656,1 41659,0 41756,1 41811,0 41850,1 41896,0 41915,1 41932,0 42032,1 42102,0 42113,1 42204,0 42217,1 42253,0 42275,1 42326,0 42327,1 42425,0 42437,1 42455,0 42502,1 42503,0 42530,1 42532,0 42605,1 42680,0 42688,1 42695,0 42792,1 42832,0 42883,1 42921,0 42948,1 43025,0 43106,1 43197,0 43238,1 43242,0 43336,1 43431,0 43472,1 43475,0 43486,1 43546,0 43549,1 43640,0 43664,1 43691,0 43748,1 43778,0 43819,1 43874,0 43940,1 44003,0 44094,1 44151,0 44202,1 44226,0 44273,1 44349,0 44403,1 44493,0 44497,1 44575,0 44627,1 44699,0 44793,1 44863,0 44880,1 44890,0 44920,1 45004,0 45099,1 45153,0 45167,1 45199,0 45227,1 45326,0 45378,1 45430,0 45487,1 45580,0 45604,1 45664,0 45726,1 45813,0 45817,1 45819,0 45885,1 45924,0 46009,1 46064,0 46067,1 46139,0 46158,1 46234,0 46252,1 46337,0 46433,1 46501,0 46523,1 46590,0 46601,1 46690,0 46695,1 46735,0 46818,1 46912,0 47005,1 47071,0 47084,1 47152,0 47228,1 47317,0 47388,1 47412,0 47501,1 47596,0 47604,1 47626,0 47716,1 47734,0 47812,1 47871,0 47938,1 48007,0 48104,1 48198,0 48258,1 48358,0 48364,1 48417,0 48494,1 48499,0 48549,1 48640,0 48653,1 48690,0 48773,1 48810,0 48878,1 48954,0 48960,1 49013,0 49081,1 end initlist a6 0,0 12,1 31,0 66,1 106,0 155,1 180,0 222,1 253,0 256,1 304,0 338,1 410,0 500,1 574,0 592,1 616,0 631,1 672,0 674,1 688,0 734,1 832,0 855,1 871,0 908,1 983,0 995,1 1046,0 1090,1 1115,0 1197,1 1235,0 1282,1 1366,0 1373,1 1426,0 1458,1 1558,0 1630,1 1641,0 1682,1 1687,0 1693,1 1727,0 1788,1 1852,0 1928,1 1946,0 2027,1 2119,0 2137,1 2205,0 2277,1 2325,0 2373,1 2452,0 2534,1 2592,0 2635,1 2722,0 2730,1 2795,0 2866,1 2959,0 2966,1 3035,0 3064,1 3162,0 3221,1 3292,0 3389,1 3409,0 3457,1 3477,0 3490,1 3525,0 3622,1 3668,0 3737,1 3803,0 3808,1 3889,0 3962,1 4028,0 4056,1 4133,0 4153,1 4204,0 4217,1 4222,0 4260,1 4274,0 4318,1 4403,0 4456,1 4457,0 4519,1 4607,0 4691,1 4781,0 4822,1 4919,0 4982,1 4994,0 5014,1 5054,0 5116,1 5148,0 5152,1 5163,0 5218,1 5316,0 5371,1 5426,0 5481,1 5552,0 5578,1 5654,0 5717,1 5752,0 5851,1 5903,0 5953,1 6008,0 6027,1 6095,0 6135,1 6164,0 6260,1 6302,0 6374,1 6443,0 6524,1 6531,0 6541,1 6611,0 6648,1 6705,0 6766,1 6828,0 6891,1 6941,0 6987,1 7022,0 7058,1 7127,0 7167,1 7192,0 7271,1 7298,0 7314,1 7390,0 7482,1 7556,0 7603,1 7638,0 7702,1 7741,0 7750,1 7843,0 7896,1 7910,0 7917,1 7935,0 7959,1 7973,0 8070,1 8083,0 8106,1 8121,0 8201,1 8275,0 8317,1 8331,0 8391,1 8413,0 8488,1 8581,0 8649,1 8691,0 8735,1 8802,0 8808,1 8900,0 8952,1 8977,0 9000,1 9055,0 9146,1 9233,0 9319,1 9398,0 9421,1 9433,0 9451,1 9499,0 9536,1 9578,0 9658,1 9733,0 9739,1 9819,0 9905,1 9968,0 10056,1 10065,0 10149,1 10204,0 10268,1 10281,0 10327,1 10426,0 10518,1 10610,0 10696,1 10717,0 10811,1 10867,0 10894,1 10978,0 10999,1 11038,0 11089,1 11176,0 11188,1 11222,0 11250,1 11259,0 11306,1 11329,0 11406,1 11433,0 11449,1 11480,0 11492,1 11520,0 11570,1 11634,0 11725,1 11768,0 11786,1 11852,0 11898,1 11981,0 12059,1 12119,0 12214,1 12233,0 12246,1 12338,0 12363,1 12372,0 12436,1 12470,0 12501,1 12537,0 12580,1 12663,0 12697,1 12775,0 12777,1 12784,0 12867,1 12938,0 13035,1 13069,0 13163,1 13189,0 13270,1 13296,0 13367,1 13448,0 13539,1 13594,0 13638,1 13673,0 13729,1 13750,0 13841,1 13914,0 13946,1 13953,0 14033,1 14131,0 14140,1 14200,0 14225,1 14325,0 14380,1 14479,0 14541,1 14615,0 14710,1 14751,0 14836,1 14907,0 14958,1 14983,0 15025,1 15086,0 15159,1 15200,0 15212,1 15260,0 15268,1 15271,0 15316,1 15357,0 15440,1 15492,0 15494,1 15549,0 15570,1 15611,0 15685,1 15714,0 15777,1 15862,0 15876,1 15976,0 16002,1 16048,0 16077,1 16122,0 16135,1 16196,0 16206,1 16266,0 16366,1 16440,0 16521,1 16586,0 16653,1 16712,0 16714,1 16732,0 16782,1 16871,0 16920,1 16952,0 17012,1 17037,0 17087,1 17090,0 17136,1 17150,0 17186,1 17217,0 17312,1 17358,0 17362,1 17385,0 17477,1 17487,0 17559,1 17642,0 17688,1 17741,0 17828,1 17916,0 17992,1 18058,0 18087,1 18094,0 18192,1 18204,0 18276,1 18373,0 18438,1 18458,0 18467,1 18493,0 18575,1 18645,0 18738,1 18777,0 18858,1 18950,0 18971,1 19058,0 19103,1 19141,0 19189,1 19200,0 19295,1 19355,0 19449,1 19459,0 19476,1 19502,0 19537,1 19580,0 19611,1 19675,0 19716,1 19721,0 19739,1 19773,0 19837,1 19904,0 19926,1 20017,0 20038,1 20112,0 20121,1 20195,0 20235,1 20246,0 20303,1 20352,0 20447,1 20496,0 20521,1 20587,0 20594,1 20660,0 20682,1 20694,0 20767,1 20867,0 20948,1 21004,0 21068,1 21075,0 21149,1 21227,0 21314,1 21373,0 21421,1 21469,0 21515,1 21587,0 21677,1 21748,0 21758,1 21816,0 21866,1 21941,0 22028,1 22105,0 22180,1 22251,0 22311,1 22329,0 22410,1 22496,0 22588,1 22610,0 22689,1 22746,0 22825,1 22885,0 22920,1 22960,0 22968,1 23062,0 23090,1 23111,0 23116,1 23203,0 23215,1 23297,0 23339,1 23431,0 23505,1 23589,0 23648,1 23734,0 23808,1 23908,0 23927,1 23930,0 23978,1 24042,0 24141,1 24178,0 24241,1 24255,0 24291,1 24331,0 24383,1 24387,0 24457,1 24510,0 24517,1 24541,0 24606,1 24624,0 24645,1 24726,0 24806,1 24893,0 24992,1 25067,0 25080,1 25147,0 25207,1 25225,0 25237,1 25276,0 25299,1 25383,0 25424,1 25444,0 25456,1 25464,0 25519,1 25562,0 25609,1 25635,0 25690,1 25765,0 25767,1 25836,0 25922,1 26006,0 26057,1 26096,0 26168,1 26214,0 26294,1 26358,0 26360,1 26457,0 26468,1 26562,0 26616,1 26631,0 26656,1 26678,0 26715,1 26735,0 26798,1 26839,0 26910,1 26991,0 27060,1 27064,0 27089,1 27127,0 27186,1 27207,0 27245,1 27298,0 27345,1 27434,0 27453,1 27472,0 27487,1 27494,0 27580,1 27658,0 27734,1 27799,0 27849,1 27932,0 27960,1 28006,0 28049,1 28140,0 28198,1 28234,0 28294,1 28344,0 28376,1 28396,0 28458,1 28537,0 28628,1 28700,0 28798,1 28816,0 28876,1 28958,0 28979,1 29005,0 29092,1 29176,0 29268,1 29345,0 29375,1 29439,0 29441,1 29453,0 29520,1 29523,0 29574,1 29597,0 29669,1 29676,0 29681,1 29721,0 29757,1 29760,0 29813,1 29878,0 29900,1 29902,0 29988,1 30061,0 30126,1 30171,0 30172,1 30188,0 30220,1 30314,0 30409,1 30448,0 30548,1 30585,0 30590,1 30635,0 30691,1 30738,0 30813,1 30852,0 30941,1 31026,0 31093,1 31119,0 31199,1 31236,0 31259,1 31358,0 31382,1 31410,0 31510,1 31579,0 31645,1 31736,0 31780,1 31842,0 31937,1 31950,0 32041,1 32050,0 32070,1 32131,0 32230,1 32305,0 32397,1 32425,0 32519,1 32588,0 32646,1 32740,0 32817,1 32840,0 32883,1 32925,0 32990,1 33026,0 33102,1 33118,0 33190,1 33279,0 33301,1 33304,0 33312,1 33389,0 33443,1 33485,0 33533,1 33611,0 33647,1 33707,0 33760,1 33798,0 33881,1 33964,0 34004,1 34011,0 34032,1 34111,0 34167,1 34246,0 34289,1 34309,0 34371,1 34376,0 34416,1 34496,0 34497,1 34576,0 34637,1 34704,0 34801,1 34853,0 34887,1 34970,0 34982,1 35002,0 35055,1 35139,0 35161,1 35188,0 35195,1 35243,0 35292,1 35382,0 35473,1 35504,0 35507,1 35541,0 35607,1 35673,0 35758,1 35832,0 35844,1 35942,0 36009,1 36105,0 36136,1 36151,0 36246,1 36340,0 36426,1 36429,0 36440,1 36522,0 36615,1 36652,0 36660,1 36701,0 36766,1 36850,0 36920,1 36959,0 36971,1 36977,0 37046,1 37138,0 37174,1 37249,0 37340,1 37359,0 37429,1 37453,0 37529,1 37575,0 37660,1 37670,0 37683,1 37687,0 37787,1 37806,0 37828,1 37832,0 37892,1 37942,0 37982,1 38082,0 38181,1 38221,0 38305,1 38350,0 38423,1 38519,0 38587,1 38662,0 38717,1 38772,0 38805,1 38875,0 38972,1 38995,0 39045,1 39058,0 39093,1 39128,0 39172,1 39242,0 39286,1 39306,0 39358,1 39385,0 39431,1 39476,0 39565,1 39638,0 39666,1 39670,0 39758,1 39781,0 39801,1 39848,0 39938,1 39990,0 40031,1 40090,0 40121,1 40161,0 40222,1 40262,0 40359,1 40379,0 40479,1 40483,0 40504,1 40591,0 40682,1 40782,0 40785,1 40812,0 40847,1 40946,0 40953,1 41053,0 41070,1 41142,0 41170,1 41174,0 41265,1 41327,0 41378,1 41460,0 41556,1 41652,0 41747,1 41844,0 41935,1 42015,0 42107,1 42161,0 42243,1 42246,0 42252,1 42292,0 42343,1 42405,0 42491,1 42526,0 42533,1 42630,0 42693,1 42792,0 42795,1 42878,0 42941,1 42944,0 42990,1 43013,0 43093,1 43116,0 43213,1 43298,0 43339,1 43364,0 43385,1 43396,0 43477,1 43504,0 43546,1 43609,0 43667,1 43697,0 43716,1 43773,0 43832,1 43911,0 43966,1 44063,0 44102,1 44105,0 44194,1 44217,0 44310,1 44394,0 44467,1 44551,0 44596,1 44613,0 44640,1 44644,0 44736,1 44833,0 44899,1 44938,0 45012,1 45081,0 45097,1 45119,0 45154,1 45216,0 45235,1 45258,0 45342,1 45343,0 45373,1 45377,0 45391,1 45438,0 45444,1 45460,0 45501,1 45576,0 45585,1 45605,0 45697,1 45794,0 45868,1 45892,0 45944,1 45992,0 45995,1 46013,0 46113,1 46161,0 46253,1 46313,0 46370,1 46421,0 46501,1 46583,0 46652,1 46688,0 46713,1 46760,0 46778,1 46847,0 46891,1 46946,0 46947,1 46980,0 47048,1 47082,0 47094,1 47183,0 47210,1 47299,0 47330,1 47421,0 47428,1 47456,0 47532,1 47627,0 47717,1 47814,0 47851,1 47852,0 47935,1 47938,0 47979,1 47991,0 48034,1 48048,0 48090,1 48097,0 48192,1 48235,0 48305,1 48400,0 48466,1 48557,0 48646,1 48741,0 48766,1 48843,0 48844,1 48863,0 48905,1 48986,0 48994,1 49041,0 49086,1 49131,0 49210,1 49299,0 49305,1 49316,0 49330,1 49345,0 49413,1 49431,0 49512,1 49599,0 49683,1 49726,0 49736,1 49795,0 49888,1 49917,0 49962,1 49966,0 50063,1 50088,0 50140,1 50197,0 50223,1 50267,0 50364,1 50435,0 50476,1 50565,0 50629,1 50634,0 50734,1 50756,0 50809,1 50879,0 50931,1 end initlist a7 0,0 95,1 130,0 189,1 238,0 241,1 287,0 316,1 373,0 440,1 511,0 562,1 565,0 581,1 583,0 629,1 653,0 667,1 753,0 822,1 911,0 977,1 989,0 1046,1 1113,0 1212,1 1229,0 1282,1 1379,0 1479,1 1512,0 1556,1 1639,0 1691,1 1773,0 1849,1 1870,0 1956,1 2008,0 2042,1 2127,0 2129,1 2181,0 2257,1 2322,0 2353,1 2438,0 2501,1 2548,0 2609,1 2637,0 2718,1 2726,0 2747,1 2757,0 2838,1 2929,0 2985,1 3044,0 3098,1 3127,0 3208,1 3217,0 3290,1 3325,0 3398,1 3432,0 3510,1 3537,0 3627,1 3663,0 3671,1 3729,0 3804,1 3884,0 3944,1 4042,0 4070,1 4137,0 4144,1 4211,0 4283,1 4315,0 4397,1 4414,0 4470,1 4475,0 4571,1 4580,0 4665,1 4735,0 4778,1 4798,0 4895,1 4967,0 5009,1 5058,0 5098,1 5150,0 5184,1 5279,0 5295,1 5351,0 5379,1 5475,0 5569,1 5663,0 5733,1 5806,0 5851,1 5923,0 6002,1 6005,0 6010,1 6050,0 6098,1 6160,0 6218,1 6228,0 6311,1 6341,0 6367,1 6457,0 6508,1 6568,0 6631,1 6699,0 6764,1 6805,0 6841,1 6846,0 6944,1 7044,0 7060,1 7093,0 7139,1 7161,0 7214,1 7264,0 7330,1 7402,0 7449,1 7468,0 7474,1 7559,0 7624,1 7636,0 7691,1 7709,0 7739,1 7787,0 7883,1 7980,0 8006,1 8019,0 8020,1 8075,0 8106,1 8196,0 8260,1 8339,0 8377,1 8441,0 8458,1 8469,0 8558,1 8570,0 8657,1 8756,0 8779,1 8837,0 8898,1 8987,0 9001,1 9027,0 9068,1 9133,0 9139,1 9187,0 9190,1 9216,0 9236,1 9252,0 9277,1 9377,0 9415,1 9457,0 9493,1 9543,0 9558,1 9626,0 9714,1 9810,0 9843,1 9864,0 9950,1 10016,0 10068,1 10145,0 10243,1 10318,0 10400,1 10420,0 10440,1 10474,0 10495,1 10542,0 10549,1 10559,0 10626,1 10699,0 10707,1 10775,0 10831,1 10851,0 10885,1 10902,0 10990,1 11047,0 11062,1 11122,0 11161,1 11169,0 11177,1 11189,0 11287,1 11381,0 11466,1 11492,0 11544,1 11620,0 11698,1 11788,0 11808,1 11903,0 11973,1 12039,0 12091,1 12163,0 12223,1 12232,0 12246,1 12265,0 12266,1 12329,0 12360,1 12406,0 12417,1 12469,0 12512,1 12562,0 12601,1 12681,0 12719,1 12738,0 12783,1 12787,0 12797,1 12847,0 12901,1 12962,0 13000,1 13001,0 13066,1 13163,0 13253,1 13312,0 13368,1 13395,0 13406,1 13459,0 13555,1 13616,0 13644,1 13700,0 13792,1 13800,0 13894,1 13911,0 14005,1 14102,0 14147,1 14222,0 14276,1 14277,0 14363,1 14457,0 14539,1 14608,0 14632,1 14644,0 14705,1 14720,0 14799,1 14877,0 14888,1 14927,0 14959,1 14969,0 15065,1 15081,0 15157,1 15251,0 15325,1 15412,0 15500,1 15530,0 15578,1 15603,0 15695,1 15774,0 15782,1 15874,0 15926,1 15983,0 16055,1 16060,0 16143,1 16224,0 16227,1 16268,0 16343,1 16429,0 16529,1 16530,0 16581,1 16600,0 16700,1 16747,0 16791,1 16840,0 16930,1 16985,0 17019,1 17088,0 17179,1 17188,0 17192,1 17242,0 17276,1 17346,0 17365,1 17439,0 17518,1 17532,0 17570,1 17595,0 17669,1 17737,0 17802,1 17804,0 17823,1 17829,0 17882,1 17953,0 18039,1 18115,0 18169,1 18244,0 18306,1 18389,0 18418,1 18436,0 18463,1 18464,0 18535,1 18539,0 18604,1 18665,0 18708,1 18787,0 18849,1 18888,0 18906,1 18950,0 19014,1 19068,0 19071,1 19168,0 19208,1 19243,0 19313,1 19381,0 19403,1 19464,0 19560,1 19654,0 19732,1 19781,0 19789,1 19842,0 19878,1 19894,0 19972,1 19979,0 20022,1 20069,0 20109,1 20197,0 20274,1 20345,0 20352,1 20426,0 20438,1 20470,0 20550,1 20568,0 20618,1 20649,0 20697,1 20790,0 20833,1 20848,0 20880,1 20918,0 20939,1 21023,0 21086,1 21106,0 21107,1 21170,0 21249,1 21286,0 21302,1 21340,0 21383,1 21403,0 21481,1 21545,0 21623,1 21666,0 21678,1 21738,0 21745,1 21778,0 21835,1 21858,0 21865,1 21899,0 21967,1 22060,0 22110,1 22113,0 22198,1 22234,0 22264,1 22342,0 22353,1 22389,0 22409,1 22500,0 22592,1 22605,0 22687,1 22759,0 22810,1 22816,0 22854,1 22873,0 22958,1 23001,0 23013,1 23041,0 23107,1 23135,0 23215,1 23300,0 23356,1 23441,0 23513,1 23556,0 23644,1 23695,0 23700,1 23771,0 23865,1 23893,0 23956,1 24014,0 24036,1 24110,0 24116,1 24156,0 24206,1 24247,0 24259,1 24310,0 24345,1 24385,0 24414,1 24422,0 24463,1 24532,0 24537,1 24538,0 24595,1 24649,0 24662,1 24756,0 24815,1 24835,0 24867,1 24913,0 24932,1 24937,0 25018,1 25063,0 25115,1 25177,0 25255,1 25306,0 25309,1 25321,0 25340,1 25376,0 25386,1 25449,0 25504,1 25570,0 25611,1 25641,0 25699,1 25711,0 25716,1 25815,0 25909,1 25923,0 26008,1 26077,0 26078,1 26083,0 26154,1 26195,0 26241,1 26254,0 26340,1 26342,0 26362,1 26406,0 26407,1 26424,0 26456,1 26532,0 26615,1 26689,0 26758,1 26762,0 26776,1 26848,0 26872,1 26931,0 26984,1 26993,0 27043,1 27132,0 27210,1 27285,0 27353,1 27420,0 27431,1 27493,0 27507,1 27602,0 27640,1 27705,0 27756,1 27798,0 27826,1 27905,0 27970,1 28054,0 28126,1 28132,0 28133,1 28172,0 28237,1 28239,0 28300,1 28365,0 28378,1 28455,0 28537,1 28576,0 28611,1 28648,0 28705,1 28744,0 28756,1 28785,0 28822,1 28915,0 28997,1 29050,0 29057,1 29136,0 29221,1 29276,0 29308,1 29397,0 29454,1 29501,0 29535,1 29556,0 29642,1 29670,0 29691,1 29704,0 29709,1 29772,0 29821,1 29889,0 29953,1 29969,0 30051,1 30059,0 30159,1 30199,0 30286,1 30327,0 30350,1 30386,0 30432,1 30435,0 30504,1 30590,0 30613,1 30628,0 30703,1 30774,0 30827,1 30869,0 30915,1 30973,0 30986,1 31047,0 31132,1 31210,0 31292,1 31314,0 31335,1 31430,0 31435,1 31469,0 31526,1 31532,0 31628,1 31660,0 31682,1 31750,0 31814,1 31910,0 31960,1 32017,0 32092,1 32158,0 32220,1 32228,0 32278,1 32337,0 32363,1 32438,0 32531,1 32607,0 32684,1 32697,0 32698,1 32775,0 32814,1 32901,0 32949,1 33010,0 33086,1 33157,0 33227,1 33311,0 33351,1 33417,0 33481,1 33520,0 33561,1 33575,0 33652,1 33742,0 33761,1 33782,0 33862,1 33903,0 33966,1 34027,0 34100,1 34126,0 34170,1 34212,0 34235,1 34269,0 34283,1 34329,0 34402,1 34404,0 34479,1 34492,0 34531,1 34558,0 34567,1 34658,0 34678,1 34773,0 34843,1 34918,0 34945,1 35007,0 35018,1 35052,0 35116,1 35179,0 35229,1 35237,0 35265,1 35315,0 35365,1 35413,0 35482,1 35484,0 35503,1 35525,0 35530,1 35534,0 35580,1 35635,0 35729,1 35753,0 35832,1 35899,0 35927,1 36002,0 36032,1 36116,0 36126,1 36157,0 36219,1 36226,0 36312,1 36405,0 36453,1 36495,0 36571,1 36581,0 36655,1 36718,0 36792,1 36797,0 36830,1 36865,0 36874,1 36932,0 36961,1 36973,0 37003,1 37017,0 37057,1 37074,0 37124,1 37180,0 37215,1 37309,0 37310,1 37400,0 37460,1 37521,0 37554,1 37653,0 37723,1 37820,0 37865,1 37964,0 37976,1 37986,0 38063,1 38133,0 38228,1 38242,0 38265,1 38330,0 38406,1 38417,0 38512,1 38523,0 38536,1 38619,0 38681,1 38707,0 38783,1 38818,0 38851,1 38861,0 38886,1 38963,0 39010,1 39099,0 39143,1 39203,0 39263,1 39347,0 39404,1 39495,0 39564,1 39605,0 39699,1 39726,0 39764,1 39823,0 39873,1 39901,0 39942,1 40003,0 40027,1 40108,0 40112,1 40208,0 40263,1 40270,0 40314,1 40363,0 40457,1 40529,0 40571,1 40620,0 40682,1 40691,0 40785,1 40816,0 40817,1 40857,0 40954,1 40969,0 40974,1 40992,0 41031,1 41087,0 41128,1 41201,0 41250,1 41336,0 41360,1 41413,0 41461,1 41503,0 41585,1 41616,0 41691,1 41773,0 41801,1 41845,0 41942,1 41989,0 41997,1 42027,0 42066,1 42105,0 42205,1 42284,0 42362,1 42424,0 42478,1 42561,0 42572,1 42669,0 42681,1 42731,0 42748,1 42791,0 42865,1 42918,0 42951,1 42971,0 43035,1 43051,0 43112,1 43203,0 43213,1 43231,0 43325,1 43420,0 43475,1 43507,0 43586,1 43655,0 43699,1 43701,0 43715,1 43789,0 43853,1 43882,0 43947,1 44009,0 44096,1 44128,0 44216,1 44301,0 44325,1 44413,0 44421,1 44432,0 44489,1 44533,0 44614,1 44647,0 44692,1 44695,0 44718,1 44779,0 44839,1 44868,0 44894,1 44984,0 45013,1 45047,0 45091,1 45163,0 45209,1 45280,0 45295,1 45311,0 45372,1 45400,0 45402,1 45440,0 45533,1 45570,0 45624,1 45642,0 45702,1 45729,0 45760,1 45792,0 45842,1 45843,0 45923,1 46013,0 46043,1 46127,0 46198,1 46285,0 46325,1 46397,0 46441,1 46468,0 46520,1 46607,0 46663,1 46738,0 46836,1 46923,0 47007,1 47102,0 47110,1 47122,0 47144,1 47155,0 47203,1 47250,0 47275,1 47371,0 47440,1 47494,0 47582,1 47635,0 47651,1 47725,0 47800,1 47828,0 47915,1 47948,0 47951,1 47961,0 47972,1 48004,0 48013,1 48108,0 48135,1 48142,0 48151,1 48238,0 48260,1 48352,0 48405,1 48430,0 48477,1 48518,0 48591,1 48637,0 48700,1 48702,0 48723,1 48745,0 48828,1 48855,0 48897,1 48917,0 48933,1 49022,0 49032,1 end initlist b0 0,0 75,1 84,0 172,1 249,0 328,1 341,0 397,1 436,0 482,1 557,0 559,1 654,0 738,1 822,0 838,1 885,0 970,1 1047,0 1077,1 1084,0 1166,1 1242,0 1310,1 1325,0 1404,1 1499,0 1579,1 1672,0 1723,1 1776,0 1814,1 1825,0 1877,1 1947,0 1955,1 1959,0 2030,1 2061,0 2073,1 2108,0 2179,1 2182,0 2218,1 2296,0 2351,1 2435,0 2458,1 2515,0 2532,1 2594,0 2680,1 2774,0 2783,1 2803,0 2884,1 2922,0 3001,1 3042,0 3050,1 3118,0 3147,1 3247,0 3281,1 3329,0 3352,1 3452,0 3514,1 3603,0 3683,1 3759,0 3831,1 3927,0 4011,1 4106,0 4107,1 4135,0 4224,1 4274,0 4308,1 4319,0 4401,1 4468,0 4492,1 4580,0 4612,1 4637,0 4667,1 4691,0 4729,1 4737,0 4826,1 4921,0 4967,1 5056,0 5125,1 5164,0 5195,1 5292,0 5318,1 5367,0 5398,1 5419,0 5480,1 5567,0 5628,1 5685,0 5729,1 5773,0 5817,1 5830,0 5922,1 5930,0 5968,1 6039,0 6135,1 6161,0 6252,1 6350,0 6397,1 6407,0 6443,1 6475,0 6554,1 6558,0 6611,1 6687,0 6731,1 6759,0 6832,1 6878,0 6887,1 6975,0 7035,1 7078,0 7122,1 7125,0 7194,1 7278,0 7371,1 7417,0 7465,1 7556,0 7566,1 7633,0 7707,1 7806,0 7890,1 7966,0 8039,1 8079,0 8116,1 8188,0 8282,1 8321,0 8358,1 8370,0 8447,1 8512,0 8515,1 8524,0 8585,1 8668,0 8748,1 8796,0 8815,1 8837,0 8912,1 8987,0 9049,1 9131,0 9181,1 9239,0 9322,1 9376,0 9435,1 9467,0 9538,1 9572,0 9587,1 9605,0 9670,1 9712,0 9730,1 9756,0 9790,1 9857,0 9893,1 9919,0 9955,1 9970,0 10002,1 10029,0 10063,1 10130,0 10160,1 10172,0 10217,1 10264,0 10337,1 10420,0 10486,1 10492,0 10570,1 10627,0 10727,1 10823,0 10859,1 10943,0 10954,1 11010,0 11057,1 11130,0 11138,1 11150,0 11246,1 11299,0 11362,1 11394,0 11395,1 11431,0 11452,1 11550,0 11614,1 11631,0 11675,1 11769,0 11806,1 11899,0 11962,1 12039,0 12115,1 12123,0 12150,1 12212,0 12260,1 12271,0 12299,1 12385,0 12462,1 12478,0 12491,1 12544,0 12606,1 12670,0 12768,1 12851,0 12905,1 13002,0 13041,1 13120,0 13141,1 13168,0 13249,1 13299,0 13354,1 13382,0 13473,1 13491,0 13555,1 13621,0 13661,1 13671,0 13686,1 13772,0 13822,1 13845,0 13936,1 14019,0 14020,1 14050,0 14096,1 14116,0 14148,1 14203,0 14238,1 14273,0 14350,1 14406,0 14483,1 14566,0 14622,1 14690,0 14693,1 14771,0 14838,1 14900,0 14959,1 15038,0 15088,1 15109,0 15164,1 15252,0 15331,1 15342,0 15400,1 15404,0 15502,1 15503,0 15509,1 15542,0 15618,1 15627,0 15700,1 15730,0 15796,1 15848,0 15867,1 15952,0 16027,1 16049,0 16132,1 16141,0 16152,1 16206,0 16303,1 16384,0 16469,1 16543,0 16621,1 16624,0 16652,1 16729,0 16797,1 16860,0 16934,1 16976,0 17064,1 17065,0 17159,1 17199,0 17265,1 17337,0 17425,1 17455,0 17519,1 17591,0 17625,1 17654,0 17751,1 17823,0 17867,1 17883,0 17886,1 17951,0 17952,1 17953,0 18007,1 18050,0 18057,1 18155,0 18164,1 18190,0 18206,1 18283,0 18295,1 18390,0 18472,1 18522,0 18568,1 18576,0 18639,1 18707,0 18797,1 18822,0 18902,1 18956,0 19014,1 19097,0 19160,1 19241,0 19293,1 19325,0 19363,1 19416,0 19468,1 19478,0 19565,1 19650,0 19712,1 19731,0 19822,1 19879,0 19945,1 19972,0 20055,1 20102,0 20111,1 20195,0 20272,1 20336,0 20338,1 20432,0 20525,1 20585,0 20600,1 20641,0 20712,1 20744,0 20813,1 20847,0 20893,1 20942,0 21041,1 21104,0 21199,1 21294,0 21353,1 21443,0 21539,1 21571,0 21590,1 21609,0 21667,1 21710,0 21711,1 21746,0 21798,1 21816,0 21884,1 21897,0 21914,1 21961,0 22059,1 22108,0 22141,1 22211,0 22230,1 22241,0 22248,1 22273,0 22331,1 22339,0 22349,1 22388,0 22436,1 22460,0 22513,1 22612,0 22705,1 22718,0 22811,1 22862,0 22937,1 22983,0 23061,1 23153,0 23249,1 23261,0 23287,1 23384,0 23471,1 23541,0 23620,1 23675,0 23690,1 23763,0 23767,1 23839,0 23893,1 23931,0 23975,1 24000,0 24098,1 24197,0 24243,1 24301,0 24321,1 24323,0 24396,1 24400,0 24431,1 24486,0 24568,1 24666,0 24682,1 24691,0 24701,1 24789,0 24850,1 24920,0 25009,1 25097,0 25150,1 25224,0 25249,1 25298,0 25314,1 25326,0 25378,1 25436,0 25470,1 25484,0 25497,1 25558,0 25632,1 25692,0 25754,1 25785,0 25872,1 25968,0 25969,1 26053,0 26085,1 26119,0 26203,1 26231,0 26248,1 26320,0 26380,1 26446,0 26543,1 26612,0 26674,1 26688,0 26774,1 26802,0 26830,1 26854,0 26865,1 26946,0 26960,1 27025,0 27053,1 27092,0 27115,1 27135,0 27199,1 27268,0 27359,1 27399,0 27481,1 27544,0 27572,1 27620,0 27681,1 27689,0 27731,1 27824,0 27857,1 27928,0 28016,1 28078,0 28141,1 28200,0 28238,1 28327,0 28398,1 28469,0 28494,1 28573,0 28666,1 28713,0 28739,1 28784,0 28789,1 28851,0 28892,1 28918,0 28983,1 29033,0 29051,1 29093,0 29117,1 29203,0 29299,1 29316,0 29321,1 29368,0 29372,1 29386,0 29455,1 29526,0 29552,1 29603,0 29618,1 29712,0 29771,1 29862,0 29902,1 29975,0 30017,1 30027,0 30032,1 30035,0 30072,1 30137,0 30222,1 30280,0 30291,1 30349,0 30449,1 30451,0 30526,1 30535,0 30542,1 30543,0 30642,1 30667,0 30709,1 30729,0 30758,1 30766,0 30840,1 30932,0 30988,1 31024,0 31073,1 31167,0 31252,1 31334,0 31373,1 31382,0 31411,1 31458,0 31534,1 31622,0 31700,1 31757,0 31808,1 31825,0 31877,1 31895,0 31952,1 32049,0 32091,1 32134,0 32148,1 32191,0 32220,1 32236,0 32247,1 32314,0 32389,1 32476,0 32499,1 32568,0 32661,1 32688,0 32693,1 32773,0 32872,1 32907,0 32945,1 33035,0 33116,1 33120,0 33197,1 33207,0 33235,1 33327,0 33383,1 33472,0 33562,1 33595,0 33625,1 33701,0 33720,1 33741,0 33832,1 33894,0 33913,1 33971,0 33995,1 34073,0 34083,1 34087,0 34112,1 34198,0 34229,1 34289,0 34376,1 34428,0 34432,1 34436,0 34480,1 34555,0 34625,1 34710,0 34773,1 34782,0 34815,1 34824,0 34919,1 34943,0 35017,1 35030,0 35105,1 35117,0 35126,1 35139,0 35186,1 35236,0 35266,1 35314,0 35399,1 35458,0 35463,1 35549,0 35559,1 35606,0 35697,1 35720,0 35760,1 35809,0 35866,1 35965,0 36005,1 36028,0 36075,1 36169,0 36193,1 36217,0 36247,1 36302,0 36375,1 36449,0 36476,1 36517,0 36586,1 36668,0 36740,1 36760,0 36772,1 36806,0 36845,1 36891,0 36942,1 36950,0 36996,1 37096,0 37146,1 37161,0 37193,1 37206,0 37248,1 37291,0 37388,1 37401,0 37433,1 37476,0 37548,1 37555,0 37576,1 37676,0 37695,1 37696,0 37732,1 37825,0 37902,1 37926,0 37927,1 38024,0 38103,1 38200,0 38220,1 38308,0 38372,1 38462,0 38559,1 38630,0 38662,1 38676,0 38733,1 38817,0 38886,1 38979,0 39034,1 39052,0 39058,1 39101,0 39128,1 39210,0 39215,1 39258,0 39298,1 39300,0 39341,1 39397,0 39400,1 39493,0 39514,1 39575,0 39615,1 39658,0 39709,1 39805,0 39860,1 39872,0 39963,1 40007,0 40032,1 40049,0 40139,1 40231,0 40243,1 40278,0 40324,1 40417,0 40502,1 40588,0 40651,1 40716,0 40729,1 40828,0 40856,1 40953,0 40976,1 41043,0 41045,1 41093,0 41145,1 41147,0 41223,1 41314,0 41372,1 41453,0 41544,1 41627,0 41647,1 41665,0 41711,1 41738,0 41813,1 41903,0 41983,1 42056,0 42128,1 42138,0 42165,1 42168,0 42178,1 42261,0 42302,1 42316,0 42390,1 42478,0 42507,1 42588,0 42610,1 42667,0 42673,1 42702,0 42717,1 42794,0 42855,1 42904,0 42923,1 42979,0 43078,1 43160,0 43226,1 43320,0 43380,1 43451,0 43539,1 43609,0 43620,1 43719,0 43733,1 43804,0 43831,1 43847,0 43860,1 43867,0 43950,1 43955,0 43956,1 44043,0 44057,1 44072,0 44095,1 44156,0 44193,1 44217,0 44241,1 44262,0 44321,1 44417,0 44437,1 44506,0 44593,1 44691,0 44739,1 44818,0 44900,1 44966,0 45022,1 45049,0 45098,1 45114,0 45162,1 45252,0 45327,1 45383,0 45462,1 45492,0 45525,1 45586,0 45633,1 45663,0 45745,1 45777,0 45779,1 45871,0 45911,1 45918,0 45983,1 46034,0 46053,1 46123,0 46132,1 46188,0 46256,1 46317,0 46352,1 46450,0 46541,1 46573,0 46610,1 46687,0 46730,1 46758,0 46829,1 46839,0 46852,1 46909,0 46915,1 46975,0 47014,1 47104,0 47173,1 47262,0 47289,1 47324,0 47368,1 47397,0 47454,1 47490,0 47577,1 47649,0 47682,1 47781,0 47824,1 47850,0 47905,1 47949,0 48004,1 48031,0 48072,1 48148,0 48205,1 48229,0 48258,1 48285,0 48380,1 48420,0 48437,1 48471,0 48540,1 48611,0 48621,1 48683,0 48705,1 48761,0 48768,1 48828,0 48925,1 48989,0 49054,1 49154,0 49165,1 49166,0 49224,1 49269,0 49303,1 49315,0 49342,1 49356,0 49449,1 49457,0 49477,1 49555,0 49617,1 49635,0 49698,1 49766,0 49769,1 49796,0 49868,1 49967,0 49971,1 50051,0 50104,1 50140,0 50176,1 50197,0 50236,1 50239,0 50333,1 50420,0 50489,1 end initlist b1 0,0 28,1 32,0 33,1 39,0 41,1 65,0 144,1 149,0 195,1 207,0 298,1 337,0 395,1 471,0 558,1 589,0 619,1 715,0 771,1 824,0 893,1 943,0 946,1 1001,0 1088,1 1127,0 1210,1 1265,0 1308,1 1405,0 1482,1 1568,0 1582,1 1631,0 1693,1 1773,0 1802,1 1861,0 1904,1 2003,0 2081,1 2126,0 2165,1 2192,0 2273,1 2274,0 2364,1 2450,0 2460,1 2514,0 2542,1 2614,0 2634,1 2638,0 2689,1 2741,0 2827,1 2904,0 2965,1 3054,0 3082,1 3099,0 3129,1 3222,0 3224,1 3296,0 3383,1 3467,0 3504,1 3588,0 3638,1 3701,0 3729,1 3826,0 3875,1 3938,0 3971,1 3987,0 4031,1 4089,0 4106,1 4198,0 4270,1 4289,0 4325,1 4356,0 4456,1 4493,0 4571,1 4640,0 4677,1 4707,0 4774,1 4835,0 4929,1 5004,0 5090,1 5168,0 5202,1 5280,0 5290,1 5329,0 5391,1 5409,0 5452,1 5475,0 5512,1 5526,0 5567,1 5599,0 5672,1 5768,0 5855,1 5891,0 5917,1 5994,0 6092,1 6186,0 6196,1 6256,0 6267,1 6326,0 6423,1 6515,0 6597,1 6647,0 6696,1 6712,0 6781,1 6819,0 6882,1 6982,0 7063,1 7140,0 7147,1 7239,0 7259,1 7274,0 7314,1 7322,0 7383,1 7417,0 7445,1 7529,0 7533,1 7617,0 7669,1 7705,0 7780,1 7820,0 7838,1 7902,0 7966,1 7979,0 7991,1 8054,0 8109,1 8165,0 8241,1 8341,0 8383,1 8468,0 8494,1 8530,0 8569,1 8654,0 8691,1 8706,0 8764,1 8828,0 8918,1 8929,0 8941,1 9025,0 9055,1 9143,0 9186,1 9285,0 9318,1 9385,0 9432,1 9531,0 9599,1 9611,0 9639,1 9737,0 9742,1 9813,0 9860,1 9884,0 9973,1 10041,0 10060,1 10119,0 10195,1 10259,0 10353,1 10376,0 10422,1 10462,0 10542,1 10577,0 10669,1 10715,0 10795,1 10808,0 10893,1 10964,0 10976,1 11047,0 11138,1 11140,0 11174,1 11219,0 11250,1 11306,0 11393,1 11416,0 11481,1 11494,0 11504,1 11510,0 11557,1 11618,0 11707,1 11770,0 11787,1 11822,0 11896,1 11960,0 12053,1 12076,0 12156,1 12169,0 12249,1 12255,0 12315,1 12384,0 12406,1 12455,0 12482,1 12508,0 12597,1 12677,0 12743,1 12806,0 12862,1 12955,0 13001,1 13047,0 13093,1 13115,0 13181,1 13259,0 13284,1 13319,0 13346,1 13418,0 13481,1 13520,0 13599,1 13664,0 13760,1 13773,0 13825,1 13886,0 13966,1 13985,0 14061,1 14123,0 14128,1 14134,0 14208,1 14307,0 14363,1 14454,0 14493,1 14582,0 14681,1 14738,0 14803,1 14856,0 14874,1 14960,0 15047,1 15121,0 15200,1 15260,0 15285,1 15329,0 15379,1 15475,0 15537,1 15556,0 15577,1 15594,0 15628,1 15681,0 15726,1 15825,0 15862,1 15913,0 15973,1 16027,0 16039,1 16089,0 16090,1 16176,0 16205,1 16252,0 16255,1 16262,0 16301,1 16302,0 16394,1 16494,0 16526,1 16626,0 16686,1 16772,0 16846,1 16941,0 16992,1 17035,0 17110,1 17165,0 17212,1 17279,0 17318,1 17336,0 17341,1 17395,0 17466,1 17507,0 17590,1 17649,0 17710,1 17759,0 17800,1 17890,0 17978,1 18036,0 18082,1 18135,0 18212,1 18239,0 18243,1 18327,0 18422,1 18490,0 18506,1 18603,0 18677,1 18742,0 18788,1 18829,0 18867,1 18880,0 18905,1 18972,0 18975,1 19033,0 19111,1 19190,0 19280,1 19303,0 19371,1 19466,0 19499,1 19500,0 19520,1 19599,0 19689,1 19747,0 19781,1 19846,0 19886,1 19924,0 20001,1 20025,0 20026,1 20027,0 20083,1 20113,0 20207,1 20261,0 20353,1 20429,0 20499,1 20560,0 20567,1 20602,0 20611,1 20685,0 20690,1 20695,0 20737,1 20747,0 20748,1 20825,0 20868,1 20910,0 20962,1 21019,0 21091,1 21161,0 21236,1 21268,0 21336,1 21378,0 21406,1 21487,0 21505,1 21576,0 21676,1 21762,0 21812,1 21865,0 21913,1 21997,0 22046,1 22146,0 22231,1 22258,0 22302,1 22373,0 22416,1 22448,0 22535,1 22563,0 22649,1 22673,0 22736,1 22808,0 22847,1 22947,0 22961,1 22962,0 23052,1 23151,0 23216,1 23293,0 23364,1 23384,0 23405,1 23505,0 23588,1 23685,0 23736,1 23770,0 23778,1 23846,0 23880,1 23979,0 24060,1 24127,0 24146,1 24219,0 24300,1 24321,0 24382,1 24482,0 24517,1 24607,0 24672,1 24740,0 24762,1 24763,0 24781,1 24868,0 24871,1 24928,0 25012,1 25094,0 25145,1 25162,0 25223,1 25318,0 25366,1 25464,0 25509,1 25552,0 25633,1 25676,0 25684,1 25707,0 25764,1 25806,0 25833,1 25841,0 25859,1 25927,0 25997,1 26084,0 26169,1 26203,0 26301,1 26318,0 26328,1 26407,0 26439,1 26496,0 26574,1 26580,0 26637,1 26695,0 26776,1 26852,0 26949,1 26996,0 27093,1 27136,0 27176,1 27227,0 27304,1 27365,0 27455,1 27547,0 27622,1 27633,0 27702,1 27712,0 27769,1 27805,0 27867,1 27883,0 27970,1 28022,0 28078,1 28124,0 28161,1 28251,0 28312,1 28369,0 28393,1 28466,0 28499,1 28572,0 28579,1 28605,0 28630,1 28692,0 28724,1 28755,0 28790,1 28800,0 28847,1 28928,0 28995,1 29028,0 29107,1 29188,0 29192,1 29281,0 29349,1 29425,0 29462,1 29529,0 29543,1 29598,0 29679,1 29745,0 29840,1 29846,0 29875,1 29957,0 30006,1 30015,0 30073,1 30133,0 30209,1 30240,0 30314,1 30376,0 30418,1 30500,0 30508,1 30565,0 30595,1 30600,0 30695,1 30751,0 30776,1 30875,0 30956,1 30973,0 31034,1 31124,0 31157,1 31213,0 31259,1 31261,0 31319,1 31325,0 31326,1 31412,0 31447,1 31524,0 31615,1 31646,0 31711,1 31764,0 31800,1 31879,0 31881,1 31891,0 31987,1 31993,0 32017,1 32053,0 32094,1 32160,0 32180,1 32215,0 32241,1 32340,0 32431,1 32517,0 32550,1 32553,0 32599,1 32662,0 32733,1 32813,0 32856,1 32929,0 32966,1 32993,0 33039,1 33077,0 33166,1 33217,0 33221,1 33249,0 33285,1 33369,0 33419,1 33427,0 33500,1 33541,0 33544,1 33606,0 33689,1 33774,0 33835,1 33840,0 33896,1 33972,0 34070,1 34149,0 34176,1 34242,0 34274,1 34340,0 34407,1 34456,0 34538,1 34631,0 34651,1 34751,0 34847,1 34933,0 34964,1 35008,0 35091,1 35159,0 35212,1 35274,0 35277,1 35299,0 35396,1 35474,0 35475,1 35574,0 35663,1 35729,0 35756,1 35816,0 35882,1 35899,0 35990,1 35998,0 36051,1 36112,0 36152,1 36165,0 36263,1 36280,0 36349,1 36431,0 36486,1 36550,0 36565,1 36607,0 36655,1 36663,0 36712,1 36750,0 36778,1 36807,0 36814,1 36891,0 36904,1 36948,0 37000,1 37087,0 37176,1 37251,0 37337,1 37420,0 37475,1 37521,0 37537,1 37613,0 37647,1 37705,0 37732,1 37740,0 37825,1 37915,0 38003,1 38103,0 38112,1 38186,0 38251,1 38324,0 38403,1 38465,0 38542,1 38636,0 38664,1 38732,0 38830,1 38911,0 38978,1 39064,0 39093,1 39173,0 39188,1 39242,0 39310,1 39369,0 39427,1 39463,0 39493,1 39592,0 39600,1 39653,0 39658,1 39689,0 39690,1 39748,0 39843,1 39869,0 39939,1 39997,0 40010,1 40053,0 40140,1 40172,0 40179,1 40261,0 40268,1 40285,0 40360,1 40373,0 40400,1 40412,0 40470,1 40506,0 40524,1 40537,0 40560,1 40588,0 40672,1 40710,0 40742,1 40793,0 40848,1 40914,0 40981,1 41046,0 41084,1 41126,0 41217,1 41244,0 41274,1 41366,0 41465,1 41489,0 41529,1 41608,0 41688,1 41775,0 41780,1 41808,0 41904,1 41954,0 41957,1 41978,0 42034,1 42043,0 42076,1 42132,0 42146,1 42171,0 42242,1 42308,0 42328,1 42400,0 42486,1 42513,0 42561,1 42631,0 42727,1 42810,0 42834,1 42875,0 42924,1 42966,0 43016,1 43043,0 43093,1 43106,0 43134,1 43206,0 43246,1 43289,0 43305,1 43357,0 43379,1 43479,0 43503,1 43505,0 43559,1 43658,0 43723,1 43774,0 43776,1 43784,0 43806,1 43904,0 43948,1 43958,0 44026,1 44083,0 44120,1 44123,0 44214,1 44271,0 44318,1 44326,0 44410,1 44491,0 44565,1 44619,0 44676,1 44731,0 44768,1 44820,0 44860,1 44940,0 45022,1 45037,0 45090,1 45110,0 45169,1 45177,0 45211,1 45249,0 45271,1 45361,0 45415,1 45473,0 45554,1 45614,0 45615,1 45624,0 45703,1 45789,0 45856,1 45868,0 45944,1 45977,0 46044,1 46085,0 46152,1 46223,0 46313,1 46397,0 46451,1 46505,0 46538,1 46626,0 46703,1 46754,0 46756,1 46841,0 46875,1 46904,0 46962,1 47006,0 47031,1 47093,0 47142,1 47223,0 47262,1 47335,0 47368,1 47467,0 47506,1 47553,0 47582,1 47653,0 47668,1 47676,0 47730,1 47765,0 47773,1 47844,0 47850,1 47902,0 47948,1 47955,0 47983,1 48019,0 48116,1 48179,0 48253,1 48299,0 48357,1 48406,0 48420,1 48456,0 48500,1 48544,0 48562,1 48648,0 48656,1 48715,0 48763,1 48827,0 48848,1 48867,0 48882,1 48926,0 48978,1 49031,0 49110,1 49156,0 49227,1 49298,0 49322,1 49331,0 49347,1 49431,0 49437,1 49510,0 49602,1 49676,0 49745,1 49797,0 49886,1 49924,0 49969,1 49984,0 49987,1 50081,0 50162,1 50234,0 50326,1 50392,0 50485,1 50553,0 50613,1 50640,0 50710,1 50782,0 50869,1 50958,0 50997,1 51035,0 51106,1 51119,0 51217,1 51222,0 51238,1 51250,0 51314,1 51369,0 51393,1 51461,0 51503,1 51530,0 51533,1 51563,0 51577,1 51590,0 51671,1 51699,0 51729,1 end initlist b2 0,0 89,1 137,0 225,1 306,0 329,1 421,0 494,1 525,0 578,1 594,0 672,1 694,0 791,1 843,0 908,1 963,0 1006,1 1035,0 1054,1 1109,0 1134,1 1202,0 1255,1 1280,0 1282,1 1315,0 1395,1 1417,0 1463,1 1490,0 1558,1 1612,0 1632,1 1664,0 1687,1 1759,0 1763,1 1768,0 1786,1 1789,0 1833,1 1881,0 1949,1 1979,0 2022,1 2078,0 2144,1 2179,0 2236,1 2237,0 2301,1 2328,0 2353,1 2366,0 2371,1 2436,0 2486,1 2556,0 2615,1 2656,0 2692,1 2694,0 2735,1 2742,0 2772,1 2791,0 2820,1 2902,0 2913,1 3012,0 3086,1 3151,0 3241,1 3332,0 3432,1 3475,0 3514,1 3542,0 3596,1 3676,0 3772,1 3831,0 3909,1 3929,0 4007,1 4012,0 4092,1 4112,0 4188,1 4246,0 4277,1 4306,0 4384,1 4441,0 4448,1 4486,0 4525,1 4562,0 4579,1 4660,0 4695,1 4725,0 4805,1 4880,0 4918,1 4994,0 5008,1 5088,0 5160,1 5166,0 5210,1 5239,0 5282,1 5349,0 5432,1 5504,0 5596,1 5691,0 5709,1 5780,0 5794,1 5846,0 5906,1 5955,0 6047,1 6093,0 6130,1 6184,0 6240,1 6306,0 6361,1 6379,0 6450,1 6515,0 6522,1 6524,0 6604,1 6659,0 6687,1 6689,0 6728,1 6772,0 6854,1 6912,0 6939,1 7023,0 7049,1 7126,0 7171,1 7199,0 7204,1 7301,0 7377,1 7445,0 7455,1 7523,0 7537,1 7614,0 7632,1 7684,0 7713,1 7763,0 7863,1 7894,0 7920,1 7941,0 7979,1 8029,0 8103,1 8130,0 8138,1 8153,0 8252,1 8276,0 8325,1 8343,0 8428,1 8477,0 8565,1 8618,0 8704,1 8734,0 8769,1 8834,0 8846,1 8946,0 9010,1 9078,0 9140,1 9228,0 9241,1 9321,0 9397,1 9479,0 9518,1 9599,0 9680,1 9697,0 9767,1 9791,0 9886,1 9929,0 9938,1 9945,0 9980,1 10076,0 10124,1 10158,0 10161,1 10231,0 10241,1 10308,0 10322,1 10366,0 10387,1 10461,0 10478,1 10506,0 10543,1 10576,0 10634,1 10709,0 10748,1 10827,0 10839,1 10840,0 10910,1 10989,0 11040,1 11043,0 11045,1 11126,0 11198,1 11240,0 11260,1 11347,0 11420,1 11430,0 11469,1 11562,0 11577,1 11620,0 11713,1 11780,0 11861,1 11925,0 11941,1 11965,0 12016,1 12106,0 12126,1 12176,0 12189,1 12220,0 12234,1 12270,0 12337,1 12391,0 12470,1 12504,0 12592,1 12603,0 12647,1 12658,0 12704,1 12766,0 12833,1 12901,0 12918,1 12997,0 13046,1 13133,0 13216,1 13287,0 13304,1 13367,0 13432,1 13446,0 13518,1 13556,0 13562,1 13608,0 13612,1 13692,0 13762,1 13811,0 13819,1 13847,0 13848,1 13921,0 13987,1 14077,0 14170,1 14244,0 14246,1 14269,0 14283,1 14366,0 14389,1 14428,0 14476,1 14499,0 14538,1 14597,0 14621,1 14638,0 14670,1 14700,0 14772,1 14796,0 14813,1 14815,0 14900,1 14910,0 14949,1 15000,0 15019,1 15044,0 15114,1 15195,0 15196,1 15221,0 15279,1 15372,0 15440,1 15516,0 15611,1 15662,0 15664,1 15707,0 15785,1 15869,0 15894,1 15954,0 15998,1 16093,0 16123,1 16177,0 16241,1 16291,0 16301,1 16358,0 16434,1 16504,0 16540,1 16613,0 16691,1 16705,0 16757,1 16791,0 16853,1 16861,0 16950,1 17023,0 17105,1 17138,0 17208,1 17270,0 17316,1 17378,0 17398,1 17490,0 17510,1 17609,0 17665,1 17729,0 17794,1 17815,0 17845,1 17894,0 17898,1 17972,0 18055,1 18082,0 18171,1 18244,0 18326,1 18409,0 18461,1 18487,0 18495,1 18501,0 18557,1 18629,0 18727,1 18824,0 18843,1 18873,0 18887,1 18971,0 19071,1 19160,0 19199,1 19211,0 19276,1 19322,0 19399,1 19477,0 19520,1 19561,0 19606,1 19654,0 19658,1 19694,0 19759,1 19833,0 19924,1 20023,0 20041,1 20073,0 20101,1 20199,0 20251,1 20312,0 20369,1 20397,0 20465,1 20512,0 20523,1 20615,0 20693,1 20701,0 20717,1 20783,0 20842,1 20919,0 20925,1 20930,0 21022,1 21112,0 21189,1 21278,0 21360,1 21450,0 21501,1 21572,0 21665,1 21687,0 21776,1 21860,0 21867,1 21964,0 21967,1 22028,0 22064,1 22130,0 22203,1 22283,0 22289,1 22332,0 22400,1 22405,0 22453,1 22501,0 22594,1 22684,0 22685,1 22770,0 22784,1 22855,0 22879,1 22945,0 22971,1 22994,0 23021,1 23042,0 23106,1 23198,0 23236,1 23238,0 23327,1 23395,0 23423,1 23498,0 23574,1 23674,0 23677,1 23710,0 23726,1 23754,0 23822,1 23830,0 23840,1 23852,0 23925,1 23999,0 24068,1 24142,0 24221,1 24240,0 24288,1 24330,0 24358,1 24407,0 24466,1 24482,0 24558,1 24607,0 24660,1 24736,0 24832,1 24886,0 24915,1 24968,0 25007,1 25089,0 25150,1 25167,0 25242,1 25287,0 25343,1 25370,0 25374,1 25427,0 25438,1 25454,0 25511,1 25549,0 25592,1 25630,0 25633,1 25725,0 25749,1 25806,0 25827,1 25829,0 25910,1 25919,0 25977,1 26057,0 26064,1 26068,0 26120,1 26211,0 26274,1 26316,0 26399,1 26452,0 26524,1 26571,0 26646,1 26676,0 26774,1 26804,0 26828,1 26919,0 27010,1 27076,0 27138,1 27213,0 27297,1 27389,0 27452,1 27461,0 27553,1 27571,0 27628,1 27667,0 27685,1 27736,0 27741,1 27750,0 27799,1 27806,0 27881,1 27933,0 27977,1 28049,0 28057,1 28149,0 28206,1 28217,0 28257,1 28305,0 28320,1 28373,0 28403,1 28407,0 28505,1 28585,0 28637,1 28665,0 28718,1 28767,0 28809,1 28832,0 28904,1 28972,0 29007,1 29086,0 29155,1 29158,0 29169,1 29261,0 29275,1 29342,0 29423,1 29427,0 29489,1 29514,0 29554,1 29583,0 29680,1 29700,0 29765,1 29806,0 29906,1 29921,0 29987,1 30023,0 30065,1 30107,0 30142,1 30181,0 30199,1 30231,0 30242,1 30246,0 30343,1 30398,0 30450,1 30549,0 30565,1 30594,0 30627,1 30690,0 30781,1 30816,0 30832,1 30877,0 30959,1 31004,0 31062,1 31089,0 31142,1 31157,0 31192,1 31278,0 31364,1 31371,0 31407,1 31457,0 31470,1 31507,0 31566,1 31636,0 31719,1 31735,0 31784,1 31785,0 31798,1 31839,0 31910,1 31917,0 31931,1 31977,0 32065,1 32106,0 32204,1 32294,0 32318,1 32363,0 32403,1 32419,0 32446,1 32544,0 32631,1 32694,0 32792,1 32809,0 32881,1 32909,0 32946,1 33041,0 33105,1 33168,0 33173,1 33262,0 33360,1 33421,0 33470,1 33487,0 33580,1 33590,0 33649,1 33663,0 33683,1 33756,0 33845,1 33923,0 33936,1 33951,0 33980,1 34079,0 34107,1 34163,0 34197,1 34266,0 34290,1 34372,0 34391,1 34437,0 34458,1 34518,0 34583,1 34630,0 34700,1 34778,0 34804,1 34888,0 34889,1 34966,0 35017,1 35094,0 35192,1 35207,0 35228,1 35260,0 35280,1 35310,0 35388,1 35486,0 35525,1 35554,0 35649,1 35658,0 35703,1 35780,0 35865,1 35912,0 35999,1 36025,0 36093,1 36146,0 36213,1 36215,0 36247,1 36308,0 36351,1 36378,0 36468,1 36516,0 36544,1 36629,0 36686,1 36705,0 36765,1 36786,0 36798,1 36855,0 36937,1 36972,0 37065,1 37144,0 37173,1 37198,0 37207,1 37290,0 37331,1 37380,0 37476,1 37525,0 37602,1 37700,0 37705,1 37786,0 37878,1 37922,0 37979,1 38071,0 38116,1 38117,0 38180,1 38263,0 38322,1 38331,0 38403,1 38459,0 38474,1 38565,0 38609,1 38699,0 38710,1 38763,0 38803,1 38825,0 38866,1 38923,0 38963,1 39024,0 39042,1 39078,0 39129,1 39155,0 39181,1 39206,0 39295,1 39385,0 39398,1 39408,0 39474,1 39501,0 39539,1 39615,0 39621,1 39700,0 39731,1 39788,0 39818,1 39898,0 39941,1 40013,0 40082,1 40126,0 40163,1 40211,0 40309,1 40374,0 40432,1 40478,0 40493,1 40549,0 40577,1 40619,0 40676,1 40717,0 40806,1 40861,0 40943,1 40970,0 41002,1 41025,0 41098,1 41191,0 41225,1 41312,0 41313,1 41327,0 41417,1 41461,0 41509,1 41546,0 41614,1 41628,0 41692,1 41771,0 41866,1 41947,0 41966,1 42052,0 42077,1 42113,0 42193,1 42227,0 42254,1 42266,0 42322,1 42379,0 42397,1 42426,0 42511,1 42557,0 42564,1 42613,0 42677,1 42743,0 42840,1 42923,0 43018,1 43051,0 43059,1 43060,0 43116,1 43144,0 43217,1 43310,0 43391,1 43418,0 43458,1 43471,0 43542,1 43589,0 43659,1 43715,0 43788,1 43874,0 43907,1 43971,0 44016,1 44089,0 44157,1 44213,0 44272,1 44320,0 44405,1 44477,0 44533,1 44596,0 44624,1 44632,0 44711,1 44745,0 44780,1 44795,0 44865,1 44958,0 45021,1 45098,0 45103,1 45155,0 45212,1 45265,0 45339,1 45367,0 45399,1 45439,0 45520,1 45580,0 45605,1 45667,0 45714,1 45776,0 45864,1 45942,0 46034,1 46105,0 46147,1 46181,0 46257,1 46293,0 46298,1 46371,0 46443,1 46485,0 46511,1 46582,0 46607,1 46634,0 46672,1 46749,0 46828,1 46924,0 46932,1 46942,0 47021,1 47028,0 47092,1 47146,0 47156,1 47238,0 47298,1 47317,0 47409,1 47479,0 47523,1 47559,0 47594,1 47694,0 47793,1 47797,0 47798,1 47837,0 47854,1 47906,0 47962,1 48059,0 48151,1 48170,0 48228,1 48291,0 48323,1 48381,0 48415,1 48466,0 48535,1 48631,0 48671,1 48694,0 48756,1 48837,0 48879,1 48900,0 48927,1 48981,0 49025,1 49037,0 49062,1 49080,0 49176,1 49202,0 49247,1 49277,0 49298,1 49311,0 49354,1 49416,0 49516,1 49535,0 49566,1 49601,0 49659,1 end initlist b3 0,0 95,1 147,0 172,1 259,0 284,1 290,0 316,1 340,0 429,1 487,0 495,1 500,0 563,1 576,0 644,1 691,0 712,1 795,0 813,1 910,0 935,1 963,0 964,1 1030,0 1058,1 1082,0 1161,1 1207,0 1293,1 1381,0 1398,1 1450,0 1523,1 1602,0 1675,1 1719,0 1762,1 1800,0 1873,1 1890,0 1976,1 2012,0 2086,1 2105,0 2125,1 2142,0 2214,1 2225,0 2233,1 2289,0 2356,1 2445,0 2534,1 2592,0 2596,1 2648,0 2698,1 2784,0 2809,1 2894,0 2991,1 3076,0 3149,1 3218,0 3250,1 3325,0 3339,1 3405,0 3431,1 3477,0 3495,1 3573,0 3583,1 3603,0 3627,1 3698,0 3744,1 3810,0 3855,1 3868,0 3935,1 3958,0 4043,1 4082,0 4152,1 4225,0 4310,1 4405,0 4476,1 4531,0 4631,1 4714,0 4761,1 4846,0 4891,1 4923,0 5012,1 5061,0 5122,1 5175,0 5181,1 5246,0 5302,1 5375,0 5471,1 5551,0 5570,1 5630,0 5722,1 5804,0 5840,1 5895,0 5982,1 6030,0 6129,1 6184,0 6269,1 6295,0 6298,1 6343,0 6395,1 6413,0 6498,1 6505,0 6586,1 6614,0 6631,1 6671,0 6754,1 6789,0 6885,1 6961,0 6997,1 7014,0 7109,1 7174,0 7272,1 7285,0 7336,1 7399,0 7461,1 7516,0 7609,1 7621,0 7639,1 7682,0 7764,1 7772,0 7798,1 7830,0 7831,1 7908,0 7948,1 8028,0 8110,1 8113,0 8179,1 8277,0 8341,1 8404,0 8485,1 8507,0 8596,1 8629,0 8648,1 8685,0 8703,1 8787,0 8833,1 8869,0 8886,1 8967,0 8988,1 9051,0 9101,1 9158,0 9201,1 9237,0 9298,1 9371,0 9409,1 9436,0 9490,1 9507,0 9595,1 9666,0 9698,1 9761,0 9798,1 9862,0 9957,1 9990,0 10011,1 10105,0 10116,1 10178,0 10211,1 10245,0 10272,1 10325,0 10379,1 10444,0 10542,1 10545,0 10636,1 10734,0 10757,1 10828,0 10922,1 10969,0 11012,1 11088,0 11184,1 11278,0 11319,1 11339,0 11396,1 11435,0 11508,1 11565,0 11629,1 11678,0 11700,1 11760,0 11787,1 11820,0 11906,1 11968,0 12055,1 12098,0 12157,1 12249,0 12266,1 12362,0 12459,1 12510,0 12610,1 12650,0 12730,1 12749,0 12836,1 12907,0 12919,1 12975,0 13029,1 13039,0 13134,1 13204,0 13223,1 13321,0 13386,1 13429,0 13523,1 13599,0 13623,1 13644,0 13702,1 13726,0 13766,1 13843,0 13907,1 13927,0 14007,1 14086,0 14129,1 14202,0 14284,1 14323,0 14352,1 14390,0 14396,1 14430,0 14521,1 14599,0 14641,1 14676,0 14765,1 14807,0 14883,1 14938,0 14975,1 15042,0 15103,1 15152,0 15166,1 15206,0 15255,1 15345,0 15377,1 15397,0 15495,1 15593,0 15686,1 15703,0 15752,1 15842,0 15924,1 15990,0 16074,1 16089,0 16091,1 16128,0 16180,1 16220,0 16242,1 16243,0 16326,1 16332,0 16355,1 16428,0 16451,1 16501,0 16556,1 16614,0 16667,1 16697,0 16780,1 16839,0 16844,1 16886,0 16964,1 16983,0 17050,1 17064,0 17078,1 17086,0 17157,1 17252,0 17351,1 17374,0 17379,1 17401,0 17479,1 17491,0 17570,1 17573,0 17643,1 17704,0 17769,1 17787,0 17824,1 17910,0 17935,1 18004,0 18061,1 18114,0 18164,1 18259,0 18350,1 18402,0 18481,1 18566,0 18638,1 18729,0 18801,1 18887,0 18956,1 19053,0 19054,1 19086,0 19113,1 19161,0 19241,1 19275,0 19359,1 19410,0 19486,1 19501,0 19548,1 19615,0 19683,1 19780,0 19834,1 19892,0 19967,1 20010,0 20049,1 20087,0 20123,1 20143,0 20231,1 20320,0 20380,1 20461,0 20556,1 20580,0 20657,1 20731,0 20816,1 20883,0 20939,1 20979,0 21050,1 21088,0 21135,1 21151,0 21208,1 21251,0 21337,1 21437,0 21512,1 21573,0 21588,1 21633,0 21667,1 21695,0 21739,1 21793,0 21843,1 21861,0 21926,1 21939,0 21976,1 22049,0 22136,1 22223,0 22295,1 22313,0 22374,1 22454,0 22546,1 22566,0 22632,1 22699,0 22700,1 22753,0 22827,1 22882,0 22897,1 22908,0 23003,1 23067,0 23152,1 23184,0 23220,1 23306,0 23327,1 23398,0 23428,1 23521,0 23570,1 23663,0 23696,1 23774,0 23810,1 23811,0 23898,1 23980,0 24022,1 24118,0 24195,1 24248,0 24263,1 24318,0 24355,1 24393,0 24475,1 24526,0 24616,1 24639,0 24683,1 24742,0 24780,1 24835,0 24906,1 24983,0 25023,1 25115,0 25123,1 25164,0 25204,1 25291,0 25316,1 25334,0 25415,1 25444,0 25507,1 25551,0 25611,1 25632,0 25732,1 25795,0 25856,1 25956,0 25970,1 26007,0 26061,1 26062,0 26158,1 26197,0 26276,1 26277,0 26299,1 26356,0 26416,1 26495,0 26533,1 26566,0 26637,1 26682,0 26734,1 26763,0 26799,1 26836,0 26870,1 26883,0 26969,1 26972,0 27071,1 27081,0 27118,1 27190,0 27266,1 27350,0 27387,1 27449,0 27453,1 27454,0 27549,1 27572,0 27585,1 27590,0 27659,1 27700,0 27740,1 27778,0 27878,1 27895,0 27908,1 27960,0 28034,1 28124,0 28135,1 28215,0 28229,1 28263,0 28269,1 28342,0 28418,1 28436,0 28500,1 28534,0 28624,1 28708,0 28794,1 28808,0 28869,1 28873,0 28878,1 28930,0 29012,1 29090,0 29131,1 29195,0 29288,1 29377,0 29451,1 29495,0 29524,1 29525,0 29585,1 29640,0 29673,1 29691,0 29719,1 29752,0 29812,1 29889,0 29954,1 29969,0 29999,1 30034,0 30066,1 30109,0 30131,1 30156,0 30170,1 30207,0 30269,1 30329,0 30413,1 30513,0 30561,1 30641,0 30665,1 30739,0 30780,1 30823,0 30878,1 30952,0 30956,1 31050,0 31085,1 31100,0 31126,1 31169,0 31205,1 31221,0 31243,1 31321,0 31330,1 31356,0 31367,1 31432,0 31498,1 31542,0 31636,1 31704,0 31779,1 31843,0 31873,1 31967,0 31995,1 32082,0 32124,1 32220,0 32251,1 32329,0 32410,1 32486,0 32566,1 32646,0 32736,1 32757,0 32823,1 32857,0 32907,1 32913,0 32927,1 32990,0 33059,1 33126,0 33147,1 33206,0 33285,1 33360,0 33385,1 33386,0 33432,1 33470,0 33566,1 33604,0 33693,1 33714,0 33715,1 33765,0 33803,1 33826,0 33909,1 33922,0 34004,1 34089,0 34116,1 34188,0 34273,1 34289,0 34354,1 34395,0 34465,1 34540,0 34599,1 34693,0 34760,1 34834,0 34862,1 34879,0 34914,1 34961,0 35057,1 35082,0 35134,1 35137,0 35231,1 35331,0 35355,1 35396,0 35435,1 35510,0 35610,1 35646,0 35720,1 35755,0 35844,1 35865,0 35879,1 35951,0 35966,1 35972,0 36031,1 36114,0 36141,1 36215,0 36229,1 36231,0 36263,1 36293,0 36386,1 36477,0 36524,1 36556,0 36649,1 36699,0 36759,1 36799,0 36861,1 36921,0 37020,1 37048,0 37074,1 37170,0 37208,1 37300,0 37334,1 37363,0 37378,1 37409,0 37466,1 37533,0 37574,1 37596,0 37662,1 37704,0 37780,1 37781,0 37788,1 37806,0 37820,1 37847,0 37906,1 37995,0 38005,1 38057,0 38138,1 38172,0 38251,1 38278,0 38329,1 38355,0 38370,1 38409,0 38418,1 38491,0 38509,1 38532,0 38604,1 38626,0 38703,1 38787,0 38858,1 38875,0 38903,1 38950,0 39030,1 39073,0 39159,1 39244,0 39296,1 39375,0 39420,1 39423,0 39441,1 39451,0 39537,1 39539,0 39616,1 39648,0 39691,1 39716,0 39784,1 39831,0 39901,1 39979,0 40072,1 40088,0 40169,1 40240,0 40322,1 40403,0 40454,1 40467,0 40542,1 40607,0 40631,1 40706,0 40710,1 40793,0 40855,1 40878,0 40931,1 40994,0 41023,1 41117,0 41158,1 41178,0 41250,1 41257,0 41320,1 41324,0 41343,1 41422,0 41481,1 41486,0 41539,1 41617,0 41691,1 41791,0 41888,1 41902,0 41916,1 41940,0 42018,1 42057,0 42096,1 42195,0 42203,1 42237,0 42327,1 42385,0 42418,1 42477,0 42554,1 42597,0 42684,1 42781,0 42810,1 42871,0 42927,1 42991,0 43072,1 43169,0 43174,1 43182,0 43200,1 43225,0 43267,1 43299,0 43355,1 43371,0 43400,1 43440,0 43448,1 43451,0 43521,1 43530,0 43560,1 43574,0 43620,1 43718,0 43753,1 43767,0 43833,1 43881,0 43908,1 43910,0 43956,1 43969,0 43995,1 44068,0 44070,1 44117,0 44163,1 44211,0 44269,1 44288,0 44366,1 44400,0 44442,1 44494,0 44498,1 44508,0 44557,1 44563,0 44568,1 44578,0 44665,1 44683,0 44688,1 44716,0 44729,1 44792,0 44863,1 44943,0 44983,1 45038,0 45126,1 45186,0 45278,1 45371,0 45417,1 45464,0 45477,1 45480,0 45511,1 45584,0 45605,1 45609,0 45632,1 45666,0 45680,1 45752,0 45832,1 45897,0 45943,1 45989,0 45994,1 46046,0 46054,1 46101,0 46103,1 46200,0 46223,1 46258,0 46281,1 46323,0 46372,1 46412,0 46476,1 46547,0 46601,1 46661,0 46734,1 46814,0 46849,1 46946,0 47017,1 47095,0 47168,1 47238,0 47328,1 47362,0 47415,1 47495,0 47506,1 47580,0 47675,1 47743,0 47758,1 47801,0 47869,1 47949,0 48027,1 48116,0 48145,1 48199,0 48255,1 48347,0 48410,1 48491,0 48586,1 48617,0 48676,1 48729,0 48801,1 48877,0 48906,1 48966,0 49018,1 49066,0 49151,1 49191,0 49278,1 49361,0 49421,1 49515,0 49563,1 49607,0 49621,1 49719,0 49758,1 49836,0 49927,1 49966,0 50009,1 50058,0 50088,1 50132,0 50215,1 50229,0 50250,1 50333,0 50401,1 50453,0 50468,1 50492,0 50558,1 50600,0 50689,1 50772,0 50777,1 50839,0 50936,1 51029,0 51127,1 51199,0 51252,1 51315,0 51375,1 51475,0 51559,1 51566,0 51621,1 end initlist b4 0,0 13,1 105,0 106,1 148,0 176,1 220,0 224,1 303,0 361,1 440,0 464,1 560,0 605,1 677,0 746,1 778,0 805,1 835,0 843,1 927,0 1013,1 1105,0 1185,1 1199,0 1233,1 1311,0 1333,1 1334,0 1355,1 1417,0 1510,1 1549,0 1577,1 1651,0 1683,1 1722,0 1724,1 1816,0 1824,1 1864,0 1898,1 1990,0 2073,1 2079,0 2159,1 2160,0 2172,1 2232,0 2294,1 2310,0 2381,1 2445,0 2537,1 2546,0 2620,1 2663,0 2670,1 2732,0 2790,1 2819,0 2890,1 2933,0 2980,1 3056,0 3057,1 3150,0 3246,1 3282,0 3337,1 3384,0 3447,1 3503,0 3507,1 3557,0 3568,1 3649,0 3693,1 3750,0 3770,1 3797,0 3837,1 3901,0 3947,1 3955,0 4013,1 4053,0 4143,1 4189,0 4198,1 4255,0 4300,1 4395,0 4458,1 4487,0 4549,1 4559,0 4623,1 4642,0 4733,1 4736,0 4788,1 4882,0 4952,1 4979,0 5076,1 5123,0 5208,1 5232,0 5311,1 5371,0 5446,1 5492,0 5589,1 5673,0 5702,1 5762,0 5850,1 5911,0 5961,1 6017,0 6077,1 6113,0 6193,1 6269,0 6284,1 6327,0 6368,1 6463,0 6529,1 6589,0 6645,1 6693,0 6769,1 6823,0 6860,1 6950,0 6965,1 6974,0 7068,1 7132,0 7156,1 7214,0 7284,1 7298,0 7333,1 7428,0 7457,1 7465,0 7478,1 7542,0 7554,1 7574,0 7598,1 7670,0 7758,1 7846,0 7898,1 7942,0 7982,1 8052,0 8068,1 8158,0 8160,1 8244,0 8298,1 8318,0 8320,1 8416,0 8477,1 8524,0 8546,1 8636,0 8658,1 8666,0 8734,1 8782,0 8822,1 8901,0 8909,1 8978,0 8998,1 9009,0 9055,1 9080,0 9085,1 9159,0 9191,1 9229,0 9317,1 9414,0 9422,1 9466,0 9514,1 9553,0 9572,1 9621,0 9670,1 9727,0 9734,1 9828,0 9892,1 9969,0 10023,1 10057,0 10109,1 10149,0 10231,1 10245,0 10296,1 10311,0 10323,1 10374,0 10430,1 10520,0 10595,1 10646,0 10692,1 10696,0 10790,1 10845,0 10894,1 10930,0 10998,1 11007,0 11056,1 11134,0 11139,1 11151,0 11191,1 11203,0 11288,1 11349,0 11376,1 11433,0 11515,1 11579,0 11591,1 11633,0 11654,1 11696,0 11716,1 11753,0 11813,1 11841,0 11900,1 11998,0 12051,1 12148,0 12243,1 12294,0 12348,1 12407,0 12501,1 12585,0 12676,1 12724,0 12737,1 12812,0 12877,1 12919,0 12985,1 13079,0 13166,1 13213,0 13275,1 13373,0 13409,1 13449,0 13469,1 13486,0 13543,1 13585,0 13602,1 13690,0 13716,1 13813,0 13881,1 13899,0 13925,1 13971,0 14044,1 14130,0 14174,1 14191,0 14255,1 14324,0 14335,1 14418,0 14485,1 14530,0 14576,1 14633,0 14695,1 14752,0 14782,1 14845,0 14903,1 14995,0 15003,1 15086,0 15177,1 15254,0 15303,1 15400,0 15435,1 15528,0 15600,1 15653,0 15707,1 15739,0 15753,1 15850,0 15853,1 15926,0 15927,1 15958,0 15985,1 16078,0 16117,1 16136,0 16145,1 16214,0 16243,1 16280,0 16336,1 16391,0 16483,1 16558,0 16592,1 16597,0 16607,1 16700,0 16710,1 16711,0 16712,1 16776,0 16815,1 16833,0 16910,1 16943,0 16980,1 17002,0 17087,1 17123,0 17169,1 17237,0 17329,1 17339,0 17400,1 17499,0 17507,1 17529,0 17561,1 17564,0 17623,1 17643,0 17704,1 17706,0 17717,1 17776,0 17794,1 17892,0 17908,1 17994,0 18074,1 18094,0 18169,1 18216,0 18223,1 18286,0 18310,1 18399,0 18425,1 18436,0 18484,1 18559,0 18653,1 18714,0 18759,1 18835,0 18865,1 18957,0 18980,1 19069,0 19120,1 19184,0 19228,1 19284,0 19304,1 19306,0 19350,1 19398,0 19419,1 19426,0 19474,1 19566,0 19656,1 19739,0 19760,1 19840,0 19863,1 19899,0 19969,1 19997,0 20024,1 20112,0 20143,1 20176,0 20253,1 20270,0 20306,1 20368,0 20457,1 20515,0 20558,1 20626,0 20640,1 20644,0 20717,1 20766,0 20824,1 20911,0 20940,1 20982,0 21014,1 21065,0 21105,1 21158,0 21189,1 21236,0 21324,1 21406,0 21465,1 21516,0 21597,1 21673,0 21770,1 21840,0 21931,1 22010,0 22028,1 22085,0 22087,1 22124,0 22216,1 22245,0 22310,1 22365,0 22396,1 22452,0 22466,1 22522,0 22604,1 22624,0 22722,1 22736,0 22741,1 22744,0 22785,1 22873,0 22916,1 22952,0 22986,1 23012,0 23022,1 23043,0 23099,1 23115,0 23172,1 23234,0 23237,1 23256,0 23265,1 23300,0 23400,1 23415,0 23444,1 23506,0 23549,1 23590,0 23657,1 23727,0 23763,1 23838,0 23916,1 23926,0 23929,1 24007,0 24084,1 24166,0 24173,1 24243,0 24258,1 24290,0 24310,1 24381,0 24400,1 24471,0 24472,1 24517,0 24558,1 24599,0 24670,1 24720,0 24752,1 24809,0 24896,1 24903,0 24963,1 25012,0 25015,1 25067,0 25127,1 25154,0 25254,1 25338,0 25412,1 25503,0 25591,1 25641,0 25705,1 25723,0 25747,1 25802,0 25808,1 25847,0 25858,1 25870,0 25918,1 25957,0 25965,1 25972,0 25993,1 26030,0 26066,1 26118,0 26218,1 26219,0 26274,1 26323,0 26402,1 26449,0 26549,1 26571,0 26590,1 26626,0 26703,1 26781,0 26870,1 26882,0 26958,1 27030,0 27128,1 27157,0 27184,1 27211,0 27240,1 27314,0 27364,1 27464,0 27516,1 27523,0 27596,1 27638,0 27693,1 27744,0 27840,1 27889,0 27934,1 28002,0 28086,1 28160,0 28239,1 28281,0 28352,1 28413,0 28434,1 28442,0 28484,1 28536,0 28578,1 28669,0 28672,1 28709,0 28752,1 28824,0 28864,1 28963,0 29008,1 29039,0 29084,1 29156,0 29240,1 29252,0 29274,1 29291,0 29309,1 29364,0 29381,1 29385,0 29411,1 29455,0 29507,1 29561,0 29609,1 29636,0 29656,1 29724,0 29727,1 29751,0 29835,1 29913,0 29982,1 30069,0 30130,1 30192,0 30235,1 30248,0 30267,1 30296,0 30328,1 30400,0 30430,1 30477,0 30490,1 30580,0 30657,1 30725,0 30783,1 30822,0 30897,1 30993,0 31078,1 31167,0 31222,1 31318,0 31377,1 31393,0 31405,1 31431,0 31488,1 31551,0 31651,1 31688,0 31763,1 31783,0 31877,1 31948,0 32005,1 32067,0 32086,1 32173,0 32225,1 32316,0 32355,1 32401,0 32476,1 32480,0 32513,1 32540,0 32562,1 32600,0 32666,1 32683,0 32700,1 32736,0 32830,1 32838,0 32931,1 33005,0 33098,1 33147,0 33151,1 33192,0 33198,1 33241,0 33246,1 33269,0 33368,1 33398,0 33425,1 33461,0 33515,1 33558,0 33560,1 33568,0 33612,1 33682,0 33708,1 33709,0 33780,1 33836,0 33857,1 33858,0 33921,1 33972,0 34070,1 34090,0 34155,1 34157,0 34220,1 34307,0 34320,1 34330,0 34415,1 34513,0 34535,1 34548,0 34607,1 34651,0 34740,1 34823,0 34845,1 34924,0 35015,1 35018,0 35082,1 35117,0 35140,1 35233,0 35270,1 35316,0 35391,1 35458,0 35519,1 35564,0 35605,1 35692,0 35708,1 35721,0 35741,1 35833,0 35899,1 35932,0 36022,1 36036,0 36063,1 36065,0 36152,1 36188,0 36195,1 36258,0 36307,1 36353,0 36378,1 36390,0 36418,1 36481,0 36506,1 36573,0 36654,1 36684,0 36773,1 36873,0 36876,1 36934,0 36946,1 36998,0 37031,1 37033,0 37100,1 37193,0 37224,1 37235,0 37262,1 37270,0 37332,1 37397,0 37423,1 37523,0 37561,1 37656,0 37719,1 37794,0 37849,1 37947,0 38046,1 38092,0 38106,1 38129,0 38141,1 38190,0 38289,1 38302,0 38311,1 38379,0 38425,1 38445,0 38483,1 38532,0 38606,1 38683,0 38738,1 38754,0 38776,1 38801,0 38892,1 38942,0 39030,1 39101,0 39102,1 39181,0 39202,1 39276,0 39330,1 39417,0 39516,1 39549,0 39630,1 39644,0 39697,1 39700,0 39794,1 39867,0 39910,1 39945,0 39949,1 40032,0 40078,1 40151,0 40223,1 40250,0 40315,1 40409,0 40463,1 40490,0 40494,1 40575,0 40669,1 40680,0 40716,1 40753,0 40823,1 40914,0 40988,1 41012,0 41056,1 41125,0 41189,1 41198,0 41271,1 41350,0 41388,1 41416,0 41508,1 41547,0 41647,1 41658,0 41700,1 41773,0 41782,1 41843,0 41901,1 41950,0 41974,1 42025,0 42095,1 42160,0 42243,1 42270,0 42344,1 42379,0 42396,1 42403,0 42502,1 42572,0 42602,1 42620,0 42680,1 42710,0 42717,1 42774,0 42824,1 42876,0 42960,1 42975,0 43031,1 43087,0 43157,1 43162,0 43191,1 43249,0 43311,1 43400,0 43418,1 43512,0 43579,1 43652,0 43726,1 43742,0 43809,1 43895,0 43978,1 44056,0 44066,1 44154,0 44216,1 44237,0 44336,1 44397,0 44469,1 44518,0 44616,1 44700,0 44759,1 44840,0 44924,1 44950,0 45011,1 45018,0 45104,1 45177,0 45200,1 45226,0 45246,1 45256,0 45257,1 45351,0 45412,1 45443,0 45472,1 45524,0 45568,1 45668,0 45691,1 45732,0 45763,1 45784,0 45871,1 45872,0 45942,1 46030,0 46100,1 46117,0 46178,1 46221,0 46278,1 46348,0 46409,1 46437,0 46498,1 46541,0 46636,1 46705,0 46765,1 46814,0 46901,1 46954,0 47014,1 47112,0 47133,1 47191,0 47279,1 47308,0 47373,1 47387,0 47468,1 47506,0 47597,1 47642,0 47650,1 47721,0 47811,1 47830,0 47925,1 47978,0 48052,1 48144,0 48164,1 48212,0 48265,1 48276,0 48335,1 48391,0 48451,1 48526,0 48535,1 48604,0 48676,1 48691,0 48791,1 48832,0 48903,1 48984,0 49075,1 49136,0 49227,1 49272,0 49275,1 49353,0 49356,1 49447,0 49545,1 49589,0 49651,1 49653,0 49729,1 49749,0 49818,1 49835,0 49929,1 end initlist b5 0,0 77,1 158,0 178,1 227,0 297,1 323,0 408,1 443,0 470,1 510,0 580,1 639,0 669,1 720,0 758,1 782,0 831,1 884,0 970,1 1023,0 1112,1 1189,0 1269,1 1285,0 1379,1 1403,0 1415,1 1427,0 1440,1 1534,0 1589,1 1614,0 1627,1 1687,0 1728,1 1784,0 1800,1 1807,0 1823,1 1922,0 1986,1 2057,0 2120,1 2180,0 2217,1 2306,0 2326,1 2413,0 2421,1 2491,0 2584,1 2601,0 2645,1 2700,0 2756,1 2784,0 2855,1 2901,0 2940,1 3002,0 3056,1 3128,0 3198,1 3223,0 3320,1 3412,0 3418,1 3479,0 3502,1 3544,0 3623,1 3684,0 3746,1 3809,0 3826,1 3923,0 3941,1 3958,0 4053,1 4073,0 4098,1 4177,0 4186,1 4275,0 4317,1 4362,0 4368,1 4419,0 4491,1 4492,0 4525,1 4609,0 4661,1 4682,0 4713,1 4734,0 4741,1 4835,0 4880,1 4902,0 4998,1 5060,0 5129,1 5153,0 5213,1 5249,0 5261,1 5351,0 5374,1 5429,0 5484,1 5516,0 5537,1 5566,0 5637,1 5642,0 5724,1 5820,0 5852,1 5913,0 5934,1 5997,0 6029,1 6103,0 6182,1 6261,0 6310,1 6341,0 6381,1 6398,0 6458,1 6531,0 6537,1 6567,0 6585,1 6658,0 6662,1 6745,0 6838,1 6914,0 6962,1 6997,0 7047,1 7144,0 7199,1 7280,0 7331,1 7393,0 7488,1 7547,0 7549,1 7576,0 7577,1 7656,0 7711,1 7774,0 7779,1 7857,0 7868,1 7904,0 7952,1 8050,0 8099,1 8126,0 8191,1 8290,0 8358,1 8423,0 8505,1 8526,0 8572,1 8641,0 8707,1 8804,0 8844,1 8895,0 8918,1 8996,0 9080,1 9155,0 9223,1 9225,0 9276,1 9292,0 9392,1 9450,0 9526,1 9535,0 9580,1 9614,0 9688,1 9759,0 9768,1 9866,0 9917,1 9968,0 9992,1 10026,0 10031,1 10039,0 10124,1 10216,0 10308,1 10357,0 10362,1 10383,0 10418,1 10469,0 10565,1 10581,0 10612,1 10637,0 10663,1 10668,0 10734,1 10748,0 10752,1 10798,0 10856,1 10904,0 10978,1 11055,0 11108,1 11116,0 11170,1 11249,0 11285,1 11341,0 11389,1 11440,0 11452,1 11545,0 11597,1 11660,0 11722,1 11753,0 11763,1 11798,0 11856,1 11897,0 11956,1 12041,0 12067,1 12119,0 12132,1 12140,0 12160,1 12181,0 12186,1 12197,0 12270,1 12308,0 12357,1 12359,0 12436,1 12506,0 12529,1 12594,0 12611,1 12652,0 12659,1 12691,0 12781,1 12794,0 12843,1 12911,0 13001,1 13061,0 13103,1 13162,0 13252,1 13327,0 13419,1 13432,0 13486,1 13509,0 13527,1 13575,0 13662,1 13734,0 13796,1 13810,0 13889,1 13955,0 14053,1 14117,0 14148,1 14177,0 14259,1 14301,0 14320,1 14385,0 14444,1 14489,0 14583,1 14621,0 14646,1 14707,0 14783,1 14861,0 14926,1 14943,0 14980,1 15032,0 15072,1 15154,0 15174,1 15233,0 15240,1 15274,0 15284,1 15296,0 15366,1 15460,0 15551,1 15598,0 15620,1 15703,0 15772,1 15807,0 15873,1 15910,0 15963,1 16036,0 16079,1 16123,0 16149,1 16223,0 16228,1 16232,0 16306,1 16333,0 16406,1 16503,0 16588,1 16592,0 16627,1 16673,0 16723,1 16756,0 16758,1 16781,0 16828,1 16844,0 16924,1 16957,0 17050,1 17129,0 17184,1 17185,0 17201,1 17230,0 17319,1 17365,0 17419,1 17462,0 17515,1 17590,0 17651,1 17730,0 17790,1 17858,0 17911,1 17930,0 17934,1 18006,0 18083,1 18179,0 18188,1 18202,0 18277,1 18297,0 18363,1 18394,0 18464,1 18518,0 18557,1 18603,0 18661,1 18666,0 18710,1 18758,0 18789,1 18882,0 18951,1 18987,0 19016,1 19112,0 19156,1 19214,0 19240,1 19308,0 19318,1 19389,0 19470,1 19509,0 19599,1 19664,0 19732,1 19816,0 19862,1 19905,0 19958,1 19989,0 20018,1 20060,0 20106,1 20204,0 20272,1 20309,0 20318,1 20332,0 20416,1 20476,0 20551,1 20625,0 20651,1 20742,0 20804,1 20820,0 20920,1 21007,0 21103,1 21166,0 21176,1 21196,0 21268,1 21295,0 21393,1 21484,0 21499,1 21577,0 21615,1 21710,0 21783,1 21868,0 21892,1 21945,0 22008,1 22096,0 22160,1 22246,0 22320,1 22379,0 22455,1 22458,0 22486,1 22540,0 22543,1 22582,0 22614,1 22656,0 22695,1 22781,0 22845,1 22891,0 22957,1 22963,0 23036,1 23115,0 23122,1 23144,0 23180,1 23248,0 23326,1 23331,0 23428,1 23508,0 23574,1 23598,0 23648,1 23669,0 23719,1 23727,0 23827,1 23844,0 23881,1 23934,0 23941,1 24032,0 24077,1 24099,0 24187,1 24252,0 24341,1 24441,0 24460,1 24506,0 24542,1 24627,0 24630,1 24663,0 24735,1 24775,0 24782,1 24835,0 24884,1 24889,0 24972,1 25058,0 25097,1 25151,0 25181,1 25191,0 25221,1 25256,0 25305,1 25359,0 25387,1 25466,0 25516,1 25517,0 25528,1 25572,0 25607,1 25609,0 25695,1 25733,0 25826,1 25861,0 25917,1 25940,0 25971,1 26047,0 26075,1 26094,0 26124,1 26159,0 26215,1 26281,0 26324,1 26372,0 26393,1 26457,0 26528,1 26598,0 26603,1 26675,0 26730,1 26770,0 26820,1 26902,0 26990,1 27011,0 27052,1 27117,0 27198,1 27270,0 27327,1 27371,0 27394,1 27452,0 27506,1 27537,0 27552,1 27584,0 27666,1 27749,0 27786,1 27797,0 27853,1 27951,0 28043,1 28055,0 28080,1 28093,0 28168,1 28232,0 28328,1 28406,0 28474,1 28545,0 28585,1 28626,0 28707,1 28710,0 28765,1 28835,0 28924,1 28967,0 28982,1 29011,0 29096,1 29164,0 29257,1 29307,0 29379,1 29456,0 29496,1 29596,0 29659,1 29694,0 29722,1 29785,0 29807,1 29856,0 29937,1 29948,0 30008,1 30086,0 30107,1 30124,0 30178,1 30217,0 30263,1 30275,0 30328,1 30423,0 30436,1 30521,0 30618,1 30712,0 30753,1 30780,0 30810,1 30908,0 31004,1 31038,0 31051,1 31076,0 31102,1 31150,0 31205,1 31285,0 31322,1 31368,0 31438,1 31452,0 31467,1 31543,0 31624,1 31688,0 31765,1 31805,0 31888,1 31889,0 31986,1 32016,0 32100,1 32152,0 32248,1 32321,0 32360,1 32396,0 32483,1 32492,0 32497,1 32535,0 32536,1 32624,0 32626,1 32676,0 32708,1 32726,0 32785,1 32846,0 32893,1 32935,0 32947,1 32949,0 33040,1 33119,0 33158,1 33164,0 33249,1 33281,0 33352,1 33362,0 33418,1 33492,0 33592,1 33626,0 33683,1 33752,0 33782,1 33839,0 33893,1 33920,0 33991,1 34040,0 34043,1 34137,0 34229,1 34307,0 34375,1 34474,0 34505,1 34570,0 34594,1 34595,0 34648,1 34679,0 34719,1 34754,0 34797,1 34847,0 34882,1 34973,0 34993,1 35029,0 35094,1 35118,0 35141,1 35173,0 35263,1 35361,0 35426,1 35445,0 35537,1 35550,0 35551,1 35629,0 35649,1 35748,0 35826,1 35834,0 35870,1 35950,0 35981,1 36022,0 36105,1 36191,0 36229,1 36258,0 36306,1 36391,0 36437,1 36498,0 36589,1 36666,0 36766,1 36813,0 36884,1 36973,0 36990,1 37069,0 37142,1 37177,0 37243,1 37324,0 37411,1 37417,0 37508,1 37527,0 37573,1 37661,0 37683,1 37694,0 37695,1 37746,0 37790,1 37889,0 37920,1 38008,0 38067,1 38113,0 38154,1 38176,0 38213,1 38263,0 38266,1 38347,0 38375,1 38462,0 38514,1 38539,0 38637,1 38638,0 38656,1 38700,0 38753,1 38831,0 38889,1 38930,0 38956,1 39021,0 39055,1 39073,0 39081,1 39137,0 39233,1 39249,0 39325,1 39387,0 39438,1 39500,0 39591,1 39659,0 39678,1 39684,0 39698,1 39720,0 39794,1 39870,0 39875,1 39890,0 39904,1 39923,0 39958,1 39996,0 40004,1 40066,0 40128,1 40150,0 40190,1 40245,0 40328,1 40340,0 40401,1 40444,0 40500,1 40509,0 40528,1 40626,0 40714,1 40746,0 40835,1 40849,0 40865,1 40925,0 41024,1 41053,0 41056,1 41145,0 41180,1 41268,0 41303,1 41332,0 41429,1 41503,0 41518,1 41528,0 41563,1 41624,0 41709,1 41768,0 41859,1 41922,0 42001,1 42052,0 42075,1 42164,0 42235,1 42303,0 42365,1 42436,0 42533,1 42544,0 42613,1 42618,0 42699,1 42708,0 42800,1 42863,0 42930,1 42940,0 43014,1 43049,0 43050,1 43114,0 43156,1 43200,0 43206,1 43268,0 43287,1 43340,0 43395,1 43443,0 43513,1 43567,0 43613,1 43627,0 43644,1 43678,0 43738,1 43800,0 43831,1 43900,0 43912,1 43943,0 43965,1 43979,0 44012,1 44108,0 44207,1 44267,0 44324,1 44327,0 44403,1 44406,0 44445,1 44514,0 44593,1 44680,0 44754,1 44794,0 44838,1 44914,0 44971,1 45071,0 45116,1 45163,0 45237,1 45249,0 45295,1 45321,0 45385,1 45473,0 45480,1 45509,0 45557,1 45602,0 45643,1 45657,0 45664,1 45729,0 45772,1 45807,0 45857,1 45925,0 45942,1 46025,0 46077,1 46132,0 46199,1 46258,0 46265,1 46318,0 46377,1 46394,0 46480,1 46513,0 46586,1 46656,0 46716,1 46732,0 46745,1 46755,0 46830,1 46851,0 46938,1 46950,0 47021,1 47040,0 47082,1 47092,0 47169,1 47197,0 47207,1 47208,0 47240,1 47334,0 47397,1 47434,0 47461,1 47498,0 47555,1 47576,0 47663,1 47729,0 47730,1 47759,0 47779,1 47871,0 47878,1 47887,0 47922,1 47959,0 48001,1 48100,0 48166,1 48216,0 48286,1 48340,0 48351,1 48442,0 48505,1 48587,0 48646,1 48707,0 48741,1 48830,0 48904,1 48977,0 49007,1 49047,0 49145,1 49166,0 49175,1 49177,0 49247,1 49327,0 49418,1 49492,0 49549,1 49629,0 49710,1 49778,0 49876,1 49927,0 50014,1 end initlist b6 0,0 42,1 139,0 232,1 263,0 362,1 381,0 411,1 474,0 476,1 565,0 600,1 693,0 709,1 748,0 847,1 892,0 936,1 942,0 950,1 979,0 1039,1 1056,0 1099,1 1138,0 1193,1 1243,0 1303,1 1317,0 1416,1 1434,0 1456,1 1517,0 1564,1 1606,0 1641,1 1667,0 1727,1 1814,0 1875,1 1932,0 1980,1 2019,0 2065,1 2102,0 2145,1 2239,0 2312,1 2383,0 2395,1 2402,0 2442,1 2507,0 2512,1 2543,0 2583,1 2613,0 2705,1 2719,0 2784,1 2878,0 2931,1 2986,0 3050,1 3111,0 3206,1 3294,0 3342,1 3432,0 3491,1 3503,0 3594,1 3645,0 3732,1 3751,0 3826,1 3864,0 3939,1 3992,0 4083,1 4114,0 4197,1 4272,0 4318,1 4337,0 4363,1 4407,0 4433,1 4451,0 4522,1 4558,0 4633,1 4724,0 4820,1 4867,0 4873,1 4887,0 4900,1 4957,0 4993,1 5069,0 5073,1 5096,0 5195,1 5219,0 5291,1 5302,0 5341,1 5414,0 5466,1 5477,0 5523,1 5616,0 5621,1 5676,0 5725,1 5741,0 5808,1 5818,0 5847,1 5947,0 5991,1 6038,0 6050,1 6082,0 6122,1 6128,0 6129,1 6138,0 6169,1 6172,0 6229,1 6300,0 6334,1 6382,0 6412,1 6504,0 6596,1 6683,0 6772,1 6792,0 6883,1 6911,0 7011,1 7074,0 7168,1 7178,0 7245,1 7337,0 7357,1 7412,0 7413,1 7414,0 7416,1 7418,0 7507,1 7526,0 7571,1 7661,0 7685,1 7743,0 7749,1 7774,0 7842,1 7908,0 7915,1 7970,0 8020,1 8052,0 8093,1 8164,0 8251,1 8343,0 8355,1 8447,0 8531,1 8559,0 8629,1 8649,0 8719,1 8762,0 8820,1 8838,0 8880,1 8909,0 9002,1 9025,0 9112,1 9121,0 9160,1 9244,0 9272,1 9317,0 9345,1 9401,0 9457,1 9553,0 9613,1 9634,0 9642,1 9728,0 9770,1 9839,0 9871,1 9955,0 9960,1 9993,0 10054,1 10069,0 10077,1 10154,0 10191,1 10277,0 10363,1 10426,0 10483,1 10539,0 10562,1 10608,0 10696,1 10720,0 10724,1 10773,0 10858,1 10955,0 11042,1 11119,0 11204,1 11236,0 11335,1 11418,0 11475,1 11494,0 11585,1 11636,0 11700,1 11762,0 11763,1 11786,0 11796,1 11894,0 11965,1 11984,0 12052,1 12136,0 12177,1 12255,0 12258,1 12316,0 12411,1 12449,0 12472,1 12510,0 12587,1 12677,0 12752,1 12796,0 12828,1 12924,0 12955,1 13011,0 13087,1 13097,0 13176,1 13242,0 13292,1 13298,0 13320,1 13373,0 13447,1 13464,0 13552,1 13568,0 13637,1 13712,0 13804,1 13884,0 13979,1 14022,0 14088,1 14170,0 14202,1 14211,0 14296,1 14385,0 14410,1 14492,0 14569,1 14577,0 14659,1 14717,0 14751,1 14819,0 14905,1 14971,0 15049,1 15074,0 15137,1 15176,0 15254,1 15347,0 15385,1 15471,0 15476,1 15524,0 15602,1 15650,0 15682,1 15684,0 15707,1 15792,0 15809,1 15889,0 15928,1 16027,0 16087,1 16148,0 16182,1 16204,0 16301,1 16378,0 16411,1 16429,0 16462,1 16554,0 16607,1 16693,0 16763,1 16808,0 16837,1 16883,0 16902,1 16965,0 17060,1 17153,0 17227,1 17321,0 17419,1 17517,0 17591,1 17664,0 17725,1 17727,0 17733,1 17791,0 17839,1 17905,0 17925,1 18024,0 18084,1 18126,0 18224,1 18225,0 18241,1 18287,0 18314,1 18328,0 18371,1 18416,0 18452,1 18505,0 18585,1 18615,0 18632,1 18717,0 18780,1 18835,0 18912,1 18921,0 19000,1 19070,0 19151,1 19238,0 19271,1 19350,0 19391,1 19395,0 19397,1 19428,0 19453,1 19548,0 19560,1 19594,0 19666,1 19750,0 19807,1 19903,0 19915,1 19918,0 19971,1 20017,0 20105,1 20188,0 20222,1 20320,0 20351,1 20369,0 20426,1 20479,0 20489,1 20542,0 20610,1 20633,0 20643,1 20645,0 20722,1 20789,0 20881,1 20903,0 20930,1 20974,0 21074,1 21076,0 21162,1 21213,0 21222,1 21316,0 21393,1 21493,0 21536,1 21617,0 21655,1 21745,0 21828,1 21873,0 21919,1 22014,0 22026,1 22122,0 22176,1 22201,0 22241,1 22324,0 22357,1 22364,0 22455,1 22538,0 22560,1 22613,0 22701,1 22746,0 22778,1 22877,0 22898,1 22914,0 22942,1 22956,0 22969,1 23032,0 23130,1 23170,0 23250,1 23322,0 23332,1 23407,0 23461,1 23546,0 23573,1 23594,0 23630,1 23709,0 23717,1 23723,0 23761,1 23829,0 23840,1 23868,0 23963,1 24040,0 24120,1 24121,0 24164,1 24230,0 24239,1 24303,0 24362,1 24460,0 24519,1 24610,0 24621,1 24638,0 24737,1 24765,0 24817,1 24907,0 24980,1 25051,0 25148,1 25244,0 25319,1 25403,0 25432,1 25472,0 25526,1 25583,0 25612,1 25662,0 25691,1 25765,0 25824,1 25856,0 25940,1 26018,0 26076,1 26111,0 26167,1 26238,0 26292,1 26349,0 26373,1 26465,0 26478,1 26563,0 26624,1 26703,0 26705,1 26728,0 26763,1 26791,0 26853,1 26870,0 26933,1 26969,0 27007,1 27075,0 27130,1 27167,0 27186,1 27197,0 27244,1 27270,0 27287,1 27329,0 27366,1 27412,0 27483,1 27555,0 27648,1 27659,0 27695,1 27756,0 27852,1 27876,0 27932,1 27975,0 28051,1 28134,0 28196,1 28237,0 28290,1 28347,0 28354,1 28435,0 28479,1 28527,0 28608,1 28616,0 28656,1 28716,0 28749,1 28756,0 28837,1 28863,0 28940,1 28991,0 29004,1 29059,0 29139,1 29199,0 29215,1 29310,0 29386,1 29422,0 29436,1 29507,0 29518,1 29556,0 29596,1 29666,0 29667,1 29672,0 29724,1 29766,0 29824,1 29876,0 29885,1 29948,0 29994,1 30000,0 30087,1 30088,0 30123,1 30218,0 30258,1 30292,0 30392,1 30456,0 30518,1 30603,0 30700,1 30750,0 30779,1 30800,0 30889,1 30959,0 31033,1 31066,0 31135,1 31176,0 31177,1 31260,0 31359,1 31365,0 31447,1 31482,0 31511,1 31524,0 31591,1 31679,0 31751,1 31763,0 31862,1 31947,0 32004,1 32032,0 32080,1 32117,0 32156,1 32188,0 32262,1 32360,0 32455,1 32485,0 32508,1 32509,0 32569,1 32580,0 32627,1 32711,0 32795,1 32885,0 32896,1 32926,0 32928,1 33022,0 33071,1 33139,0 33188,1 33228,0 33306,1 33382,0 33458,1 33526,0 33546,1 33574,0 33584,1 33632,0 33711,1 33769,0 33838,1 33878,0 33925,1 33962,0 34044,1 34070,0 34107,1 34108,0 34137,1 34216,0 34278,1 34374,0 34380,1 34434,0 34453,1 34511,0 34513,1 34560,0 34640,1 34698,0 34743,1 34771,0 34772,1 34800,0 34861,1 34922,0 34966,1 35021,0 35028,1 35073,0 35147,1 35148,0 35224,1 35289,0 35294,1 35327,0 35383,1 35442,0 35489,1 35524,0 35617,1 35673,0 35674,1 35750,0 35813,1 35899,0 35964,1 36058,0 36150,1 36173,0 36238,1 36268,0 36305,1 36309,0 36310,1 36406,0 36481,1 36549,0 36619,1 36687,0 36748,1 36760,0 36840,1 36850,0 36897,1 36938,0 36968,1 37036,0 37136,1 37170,0 37227,1 37301,0 37376,1 37382,0 37455,1 37530,0 37565,1 37570,0 37594,1 37612,0 37663,1 37721,0 37752,1 37773,0 37864,1 37953,0 38024,1 38036,0 38086,1 38139,0 38184,1 38192,0 38194,1 38259,0 38316,1 38375,0 38383,1 38473,0 38515,1 38544,0 38598,1 38683,0 38699,1 38710,0 38810,1 38873,0 38968,1 38976,0 39054,1 39114,0 39163,1 39260,0 39264,1 39306,0 39400,1 39414,0 39489,1 39544,0 39554,1 39654,0 39736,1 39804,0 39856,1 39904,0 39971,1 40036,0 40056,1 40104,0 40175,1 40242,0 40327,1 40362,0 40384,1 40432,0 40452,1 40492,0 40535,1 40584,0 40628,1 40667,0 40705,1 40730,0 40791,1 40842,0 40855,1 40893,0 40939,1 40989,0 41070,1 41089,0 41109,1 41139,0 41143,1 41240,0 41332,1 41415,0 41423,1 41523,0 41565,1 41613,0 41638,1 41703,0 41775,1 41823,0 41890,1 41892,0 41950,1 42041,0 42130,1 42199,0 42231,1 42320,0 42339,1 42417,0 42459,1 42543,0 42578,1 42670,0 42686,1 42757,0 42806,1 42848,0 42903,1 42956,0 43053,1 43064,0 43066,1 43127,0 43198,1 43267,0 43358,1 43394,0 43431,1 43468,0 43497,1 43549,0 43579,1 43607,0 43646,1 43722,0 43775,1 43799,0 43837,1 43840,0 43878,1 43885,0 43955,1 43997,0 44017,1 44093,0 44157,1 44189,0 44241,1 44301,0 44391,1 44459,0 44546,1 44607,0 44684,1 44691,0 44789,1 44817,0 44853,1 44936,0 45032,1 45106,0 45108,1 45135,0 45175,1 45207,0 45262,1 45355,0 45379,1 45388,0 45455,1 45490,0 45523,1 45526,0 45584,1 45625,0 45702,1 45719,0 45776,1 45833,0 45921,1 45940,0 45984,1 46061,0 46150,1 46232,0 46254,1 46336,0 46435,1 46475,0 46553,1 46590,0 46659,1 46661,0 46724,1 46803,0 46858,1 46957,0 46990,1 47036,0 47099,1 47128,0 47201,1 47202,0 47262,1 47345,0 47387,1 47405,0 47474,1 47549,0 47617,1 47675,0 47707,1 47758,0 47780,1 47855,0 47886,1 47927,0 47934,1 47968,0 48009,1 48089,0 48143,1 48197,0 48295,1 48338,0 48407,1 48484,0 48568,1 48573,0 48598,1 48614,0 48636,1 48731,0 48828,1 48875,0 48916,1 49006,0 49070,1 49125,0 49211,1 49303,0 49370,1 49461,0 49554,1 49594,0 49602,1 49629,0 49653,1 49741,0 49797,1 49896,0 49909,1 49960,0 50027,1 50053,0 50063,1 50143,0 50179,1 50217,0 50261,1 50313,0 50388,1 50436,0 50463,1 50502,0 50578,1 50657,0 50662,1 50695,0 50702,1 50722,0 50766,1 50861,0 50889,1 50981,0 51016,1 51055,0 51137,1 end initlist b7 0,0 70,1 92,0 150,1 185,0 267,1 276,0 326,1 412,0 467,1 537,0 633,1 690,0 707,1 709,0 785,1 820,0 917,1 988,0 1003,1 1076,0 1094,1 1169,0 1268,1 1299,0 1392,1 1454,0 1531,1 1561,0 1598,1 1695,0 1772,1 1860,0 1872,1 1888,0 1957,1 2039,0 2122,1 2203,0 2253,1 2328,0 2355,1 2397,0 2414,1 2446,0 2500,1 2546,0 2613,1 2671,0 2751,1 2831,0 2846,1 2909,0 2921,1 2976,0 2985,1 3033,0 3130,1 3197,0 3215,1 3288,0 3365,1 3448,0 3458,1 3475,0 3533,1 3553,0 3632,1 3656,0 3672,1 3687,0 3716,1 3805,0 3838,1 3936,0 3961,1 4012,0 4033,1 4076,0 4140,1 4171,0 4263,1 4345,0 4411,1 4460,0 4528,1 4580,0 4619,1 4629,0 4645,1 4713,0 4811,1 4903,0 4918,1 4966,0 5034,1 5086,0 5109,1 5111,0 5143,1 5186,0 5255,1 5330,0 5341,1 5343,0 5425,1 5455,0 5531,1 5613,0 5635,1 5662,0 5729,1 5822,0 5853,1 5904,0 5952,1 5991,0 6041,1 6047,0 6138,1 6172,0 6198,1 6270,0 6312,1 6395,0 6441,1 6492,0 6537,1 6563,0 6646,1 6742,0 6807,1 6836,0 6885,1 6957,0 7022,1 7024,0 7093,1 7110,0 7201,1 7214,0 7314,1 7388,0 7404,1 7498,0 7577,1 7634,0 7732,1 7773,0 7866,1 7924,0 7956,1 7987,0 7992,1 8053,0 8109,1 8132,0 8170,1 8183,0 8267,1 8302,0 8303,1 8357,0 8365,1 8449,0 8524,1 8621,0 8626,1 8641,0 8676,1 8766,0 8813,1 8816,0 8911,1 8918,0 9011,1 9043,0 9143,1 9231,0 9254,1 9283,0 9368,1 9385,0 9454,1 9537,0 9596,1 9603,0 9604,1 9615,0 9694,1 9728,0 9733,1 9801,0 9901,1 9999,0 10038,1 10045,0 10106,1 10187,0 10239,1 10334,0 10410,1 10458,0 10505,1 10587,0 10591,1 10676,0 10767,1 10798,0 10887,1 10970,0 10971,1 10993,0 11049,1 11120,0 11127,1 11148,0 11172,1 11230,0 11283,1 11376,0 11443,1 11458,0 11484,1 11583,0 11598,1 11694,0 11730,1 11762,0 11796,1 11819,0 11917,1 11968,0 12018,1 12099,0 12185,1 12247,0 12248,1 12274,0 12277,1 12286,0 12324,1 12351,0 12357,1 12391,0 12437,1 12532,0 12571,1 12618,0 12710,1 12766,0 12771,1 12793,0 12859,1 12904,0 12937,1 13022,0 13098,1 13141,0 13225,1 13278,0 13330,1 13368,0 13402,1 13434,0 13462,1 13506,0 13597,1 13696,0 13747,1 13760,0 13838,1 13913,0 13972,1 14034,0 14134,1 14172,0 14254,1 14256,0 14270,1 14330,0 14332,1 14357,0 14409,1 14492,0 14591,1 14680,0 14720,1 14749,0 14832,1 14897,0 14973,1 15065,0 15123,1 15202,0 15276,1 15324,0 15371,1 15398,0 15471,1 15534,0 15620,1 15653,0 15654,1 15671,0 15686,1 15755,0 15818,1 15821,0 15840,1 15934,0 15975,1 16002,0 16064,1 16155,0 16168,1 16237,0 16249,1 16285,0 16377,1 16433,0 16442,1 16472,0 16539,1 16599,0 16620,1 16694,0 16740,1 16802,0 16811,1 16893,0 16929,1 16987,0 17066,1 17162,0 17196,1 17219,0 17233,1 17283,0 17369,1 17415,0 17416,1 17473,0 17542,1 17596,0 17634,1 17716,0 17768,1 17783,0 17858,1 17919,0 17986,1 18030,0 18127,1 18211,0 18244,1 18309,0 18337,1 18376,0 18458,1 18459,0 18529,1 18583,0 18587,1 18644,0 18720,1 18816,0 18901,1 18997,0 19008,1 19100,0 19199,1 19244,0 19331,1 19380,0 19387,1 19393,0 19460,1 19505,0 19524,1 19606,0 19659,1 19697,0 19715,1 19788,0 19867,1 19950,0 20027,1 20030,0 20089,1 20100,0 20170,1 20214,0 20305,1 20365,0 20376,1 20457,0 20483,1 20528,0 20570,1 20662,0 20732,1 20762,0 20830,1 20913,0 21008,1 21045,0 21062,1 21089,0 21128,1 21177,0 21276,1 21283,0 21296,1 21358,0 21368,1 21403,0 21496,1 21562,0 21590,1 21591,0 21596,1 21644,0 21654,1 21692,0 21764,1 21832,0 21931,1 22018,0 22089,1 22135,0 22160,1 22221,0 22257,1 22343,0 22365,1 22414,0 22418,1 22446,0 22490,1 22500,0 22508,1 22520,0 22597,1 22688,0 22694,1 22729,0 22733,1 22779,0 22802,1 22815,0 22821,1 22870,0 22950,1 23003,0 23028,1 23109,0 23148,1 23183,0 23268,1 23286,0 23317,1 23366,0 23374,1 23380,0 23446,1 23458,0 23508,1 23567,0 23652,1 23699,0 23724,1 23780,0 23851,1 23853,0 23867,1 23927,0 24000,1 24054,0 24083,1 24116,0 24149,1 24193,0 24264,1 24333,0 24401,1 24469,0 24552,1 24584,0 24615,1 24654,0 24692,1 24736,0 24792,1 24829,0 24891,1 24936,0 25006,1 25015,0 25047,1 25092,0 25177,1 25188,0 25221,1 25318,0 25384,1 25456,0 25495,1 25561,0 25601,1 25660,0 25666,1 25689,0 25720,1 25731,0 25769,1 25860,0 25927,1 26017,0 26089,1 26184,0 26214,1 26286,0 26304,1 26377,0 26441,1 26540,0 26607,1 26706,0 26721,1 26771,0 26805,1 26871,0 26906,1 26950,0 27048,1 27056,0 27105,1 27167,0 27215,1 27273,0 27305,1 27397,0 27457,1 27554,0 27571,1 27593,0 27669,1 27723,0 27797,1 27851,0 27935,1 27960,0 28051,1 28077,0 28105,1 28163,0 28211,1 28246,0 28283,1 28352,0 28383,1 28457,0 28495,1 28572,0 28596,1 28691,0 28754,1 28822,0 28913,1 28953,0 28979,1 29069,0 29142,1 29151,0 29228,1 29280,0 29350,1 29412,0 29486,1 29497,0 29548,1 29589,0 29642,1 29655,0 29669,1 29702,0 29734,1 29792,0 29870,1 29911,0 29936,1 29987,0 30074,1 30166,0 30211,1 30237,0 30321,1 30419,0 30441,1 30466,0 30507,1 30515,0 30580,1 30586,0 30591,1 30597,0 30658,1 30687,0 30704,1 30755,0 30847,1 30925,0 30974,1 31025,0 31028,1 31115,0 31137,1 31152,0 31236,1 31248,0 31306,1 31341,0 31378,1 31416,0 31484,1 31541,0 31639,1 31650,0 31693,1 31718,0 31802,1 31805,0 31831,1 31875,0 31894,1 31947,0 32043,1 32140,0 32163,1 32212,0 32247,1 32334,0 32410,1 32472,0 32479,1 32487,0 32536,1 32628,0 32709,1 32784,0 32799,1 32861,0 32950,1 33003,0 33026,1 33076,0 33091,1 33142,0 33231,1 33288,0 33289,1 33380,0 33409,1 33424,0 33426,1 33440,0 33484,1 33565,0 33634,1 33639,0 33719,1 33731,0 33773,1 33809,0 33872,1 33923,0 33924,1 33942,0 33950,1 34044,0 34059,1 34153,0 34197,1 34276,0 34358,1 34453,0 34530,1 34593,0 34671,1 34703,0 34785,1 34846,0 34903,1 34950,0 35034,1 35054,0 35105,1 35124,0 35204,1 35271,0 35286,1 35300,0 35383,1 35388,0 35408,1 35414,0 35456,1 35534,0 35616,1 35683,0 35749,1 35804,0 35876,1 35961,0 36001,1 36055,0 36132,1 36172,0 36193,1 36259,0 36279,1 36379,0 36402,1 36459,0 36528,1 36555,0 36643,1 36722,0 36752,1 36762,0 36776,1 36795,0 36824,1 36839,0 36890,1 36966,0 36987,1 37048,0 37060,1 37100,0 37154,1 37227,0 37274,1 37308,0 37397,1 37438,0 37444,1 37527,0 37542,1 37546,0 37640,1 37646,0 37691,1 37717,0 37779,1 37822,0 37890,1 37975,0 38067,1 38131,0 38187,1 38224,0 38315,1 38331,0 38360,1 38391,0 38431,1 38444,0 38459,1 38487,0 38582,1 38590,0 38635,1 38709,0 38755,1 38817,0 38915,1 38954,0 38973,1 38986,0 39000,1 39071,0 39088,1 39158,0 39228,1 39322,0 39386,1 39415,0 39505,1 39584,0 39609,1 39670,0 39723,1 39794,0 39799,1 39818,0 39918,1 39949,0 39962,1 40050,0 40063,1 40104,0 40150,1 40221,0 40235,1 40306,0 40371,1 40409,0 40445,1 40490,0 40578,1 40669,0 40766,1 40835,0 40913,1 40965,0 40980,1 40989,0 41019,1 41073,0 41156,1 41207,0 41219,1 41240,0 41271,1 41324,0 41352,1 41373,0 41395,1 41411,0 41462,1 41478,0 41512,1 41584,0 41596,1 41677,0 41735,1 41740,0 41743,1 41746,0 41843,1 41917,0 41990,1 42060,0 42083,1 42102,0 42184,1 42243,0 42299,1 42318,0 42331,1 42347,0 42362,1 42415,0 42473,1 42492,0 42523,1 42549,0 42581,1 42654,0 42671,1 42675,0 42731,1 42797,0 42845,1 42849,0 42944,1 42987,0 43040,1 43138,0 43196,1 43230,0 43313,1 43361,0 43377,1 43398,0 43472,1 43499,0 43522,1 43523,0 43603,1 43703,0 43739,1 43814,0 43875,1 43944,0 44017,1 44065,0 44158,1 44241,0 44286,1 44324,0 44412,1 44491,0 44495,1 44586,0 44648,1 44746,0 44811,1 44896,0 44981,1 44995,0 45075,1 45089,0 45096,1 45100,0 45135,1 45228,0 45274,1 45321,0 45345,1 45363,0 45365,1 45424,0 45432,1 45502,0 45503,1 45584,0 45655,1 45681,0 45777,1 45778,0 45876,1 45904,0 45974,1 46020,0 46107,1 46123,0 46206,1 46295,0 46364,1 46449,0 46475,1 46571,0 46610,1 46637,0 46718,1 46732,0 46767,1 46853,0 46942,1 47030,0 47128,1 47222,0 47321,1 47420,0 47470,1 47472,0 47553,1 47585,0 47593,1 47632,0 47657,1 47757,0 47760,1 47832,0 47909,1 47951,0 47952,1 47995,0 48020,1 48102,0 48197,1 48276,0 48281,1 48299,0 48337,1 48358,0 48427,1 48471,0 48545,1 48623,0 48680,1 48681,0 48757,1 48762,0 48853,1 48951,0 48953,1 48994,0 49090,1 49126,0 49225,1 49319,0 49323,1 49398,0 49426,1 49487,0 49549,1 49611,0 49639,1 49642,0 49732,1 49810,0 49848,1 49869,0 49875,1 49886,0 49928,1 49933,0 49951,1 end initlist c0 0,0 25,1 73,0 125,1 127,0 222,1 276,0 332,1 374,0 427,1 484,0 579,1 612,0 693,1 755,0 766,1 819,0 880,1 883,0 909,1 976,0 1011,1 1075,0 1113,1 1206,0 1304,1 1311,0 1339,1 1413,0 1422,1 1483,0 1490,1 1545,0 1615,1 1655,0 1737,1 1821,0 1863,1 1874,0 1928,1 1947,0 1986,1 2051,0 2148,1 2186,0 2265,1 2316,0 2338,1 2359,0 2429,1 2449,0 2542,1 2637,0 2649,1 2684,0 2716,1 2783,0 2826,1 2872,0 2944,1 2990,0 3057,1 3096,0 3165,1 3227,0 3322,1 3397,0 3424,1 3448,0 3461,1 3505,0 3571,1 3625,0 3656,1 3726,0 3788,1 3828,0 3838,1 3853,0 3867,1 3902,0 3959,1 4021,0 4090,1 4151,0 4165,1 4233,0 4287,1 4289,0 4329,1 4420,0 4483,1 4574,0 4666,1 4765,0 4769,1 4787,0 4883,1 4927,0 4998,1 5064,0 5160,1 5237,0 5250,1 5328,0 5375,1 5387,0 5448,1 5543,0 5561,1 5605,0 5676,1 5705,0 5769,1 5799,0 5813,1 5891,0 5976,1 6019,0 6089,1 6163,0 6196,1 6237,0 6312,1 6381,0 6442,1 6537,0 6625,1 6646,0 6663,1 6704,0 6781,1 6870,0 6916,1 6996,0 7050,1 7099,0 7140,1 7208,0 7267,1 7366,0 7460,1 7500,0 7568,1 7655,0 7743,1 7843,0 7872,1 7881,0 7889,1 7989,0 8045,1 8047,0 8105,1 8173,0 8238,1 8242,0 8283,1 8305,0 8318,1 8387,0 8471,1 8526,0 8618,1 8646,0 8673,1 8739,0 8740,1 8798,0 8825,1 8880,0 8957,1 8970,0 8979,1 9055,0 9115,1 9177,0 9205,1 9279,0 9322,1 9385,0 9403,1 9436,0 9517,1 9611,0 9677,1 9713,0 9747,1 9825,0 9916,1 9948,0 10027,1 10061,0 10090,1 10178,0 10237,1 10278,0 10352,1 10355,0 10379,1 10406,0 10463,1 10528,0 10546,1 10600,0 10644,1 10726,0 10750,1 10772,0 10832,1 10895,0 10908,1 10963,0 11051,1 11087,0 11185,1 11215,0 11240,1 11304,0 11382,1 11413,0 11498,1 11504,0 11549,1 11629,0 11702,1 11724,0 11804,1 11891,0 11936,1 12032,0 12123,1 12202,0 12219,1 12297,0 12303,1 12307,0 12372,1 12387,0 12482,1 12542,0 12628,1 12689,0 12702,1 12706,0 12722,1 12752,0 12846,1 12866,0 12933,1 13025,0 13114,1 13208,0 13308,1 13342,0 13356,1 13441,0 13450,1 13462,0 13551,1 13602,0 13615,1 13703,0 13798,1 13813,0 13899,1 13993,0 13997,1 14082,0 14170,1 14230,0 14284,1 14313,0 14325,1 14386,0 14437,1 14444,0 14509,1 14561,0 14615,1 14626,0 14653,1 14753,0 14791,1 14805,0 14830,1 14877,0 14964,1 14970,0 15005,1 15033,0 15111,1 15190,0 15215,1 15245,0 15262,1 15307,0 15318,1 15363,0 15400,1 15448,0 15449,1 15462,0 15475,1 15529,0 15532,1 15580,0 15649,1 15690,0 15711,1 15732,0 15821,1 15886,0 15899,1 15923,0 15937,1 15960,0 16010,1 16076,0 16121,1 16164,0 16258,1 16282,0 16309,1 16367,0 16377,1 16446,0 16521,1 16558,0 16603,1 16633,0 16724,1 16754,0 16826,1 16923,0 16978,1 17038,0 17103,1 17145,0 17212,1 17252,0 17255,1 17313,0 17379,1 17459,0 17537,1 17558,0 17597,1 17689,0 17751,1 17844,0 17943,1 17988,0 18045,1 18105,0 18196,1 18207,0 18268,1 18277,0 18287,1 18309,0 18311,1 18335,0 18364,1 18391,0 18395,1 18448,0 18508,1 18583,0 18584,1 18603,0 18613,1 18622,0 18707,1 18805,0 18818,1 18914,0 18930,1 18969,0 19010,1 19045,0 19067,1 19090,0 19157,1 19182,0 19202,1 19240,0 19331,1 19364,0 19417,1 19505,0 19562,1 19567,0 19641,1 19661,0 19729,1 19758,0 19850,1 19924,0 20017,1 20073,0 20171,1 20250,0 20319,1 20328,0 20400,1 20448,0 20469,1 20498,0 20559,1 20595,0 20607,1 20705,0 20765,1 20768,0 20796,1 20803,0 20846,1 20856,0 20915,1 20957,0 21002,1 21023,0 21077,1 21123,0 21183,1 21221,0 21302,1 21382,0 21401,1 21412,0 21497,1 21581,0 21670,1 21763,0 21799,1 21873,0 21959,1 21991,0 22012,1 22111,0 22132,1 22226,0 22234,1 22320,0 22358,1 22360,0 22451,1 22535,0 22630,1 22712,0 22804,1 22876,0 22888,1 22960,0 22998,1 23034,0 23103,1 23162,0 23226,1 23318,0 23367,1 23379,0 23439,1 23527,0 23571,1 23665,0 23738,1 23742,0 23754,1 23844,0 23901,1 23984,0 24079,1 24171,0 24213,1 24303,0 24338,1 24374,0 24425,1 24442,0 24494,1 24594,0 24652,1 24735,0 24800,1 24883,0 24954,1 25003,0 25026,1 25071,0 25089,1 25174,0 25244,1 25292,0 25361,1 25394,0 25427,1 25481,0 25520,1 25612,0 25665,1 25728,0 25767,1 25830,0 25870,1 25945,0 25971,1 26019,0 26026,1 26027,0 26081,1 26109,0 26200,1 26234,0 26238,1 26249,0 26349,1 26384,0 26449,1 26541,0 26581,1 26651,0 26655,1 26744,0 26769,1 26837,0 26900,1 26934,0 26955,1 27051,0 27097,1 27116,0 27149,1 27178,0 27264,1 27362,0 27383,1 27454,0 27549,1 27648,0 27709,1 27770,0 27816,1 27862,0 27910,1 27942,0 27970,1 28000,0 28033,1 28096,0 28124,1 28143,0 28163,1 28202,0 28211,1 28275,0 28374,1 28404,0 28476,1 28521,0 28559,1 28561,0 28562,1 28654,0 28681,1 28705,0 28758,1 28849,0 28949,1 28961,0 29044,1 29121,0 29124,1 29166,0 29211,1 29263,0 29324,1 29410,0 29455,1 29520,0 29584,1 29587,0 29596,1 29649,0 29748,1 29773,0 29861,1 29939,0 30030,1 30103,0 30134,1 30200,0 30276,1 30327,0 30398,1 30444,0 30474,1 30493,0 30541,1 30624,0 30644,1 30652,0 30736,1 30737,0 30745,1 30832,0 30913,1 30972,0 31054,1 31113,0 31132,1 31142,0 31174,1 31181,0 31252,1 31325,0 31345,1 31426,0 31437,1 31454,0 31492,1 31557,0 31562,1 31586,0 31647,1 31690,0 31722,1 31809,0 31855,1 31935,0 31960,1 31997,0 32018,1 32028,0 32090,1 32187,0 32246,1 32260,0 32325,1 32333,0 32414,1 32442,0 32535,1 32632,0 32729,1 32795,0 32851,1 32855,0 32918,1 33002,0 33095,1 33135,0 33170,1 33251,0 33310,1 33387,0 33447,1 33522,0 33570,1 33573,0 33605,1 33686,0 33772,1 33823,0 33877,1 33916,0 33967,1 33988,0 33992,1 34022,0 34054,1 34146,0 34148,1 34234,0 34306,1 34374,0 34376,1 34390,0 34473,1 34542,0 34641,1 34686,0 34716,1 34790,0 34885,1 34956,0 34989,1 35077,0 35128,1 35214,0 35240,1 35250,0 35298,1 35302,0 35336,1 35401,0 35424,1 35429,0 35521,1 35536,0 35626,1 35679,0 35682,1 35774,0 35799,1 35862,0 35885,1 35890,0 35968,1 36017,0 36049,1 36103,0 36197,1 36253,0 36257,1 36309,0 36324,1 36373,0 36435,1 36459,0 36491,1 36546,0 36555,1 36630,0 36700,1 36787,0 36838,1 36928,0 36958,1 37033,0 37109,1 37167,0 37182,1 37276,0 37303,1 37356,0 37434,1 37532,0 37547,1 37607,0 37635,1 37652,0 37719,1 37748,0 37790,1 37791,0 37806,1 37889,0 37963,1 38033,0 38127,1 38151,0 38157,1 38234,0 38274,1 38342,0 38348,1 38415,0 38449,1 38486,0 38534,1 38586,0 38602,1 38658,0 38704,1 38740,0 38783,1 38842,0 38893,1 38934,0 39007,1 39047,0 39085,1 39106,0 39151,1 39231,0 39285,1 39381,0 39446,1 39527,0 39567,1 39607,0 39670,1 39767,0 39848,1 39933,0 39995,1 40085,0 40157,1 40220,0 40249,1 40313,0 40403,1 40495,0 40512,1 40541,0 40606,1 40689,0 40704,1 40756,0 40817,1 40819,0 40907,1 41000,0 41080,1 41178,0 41234,1 41334,0 41395,1 41408,0 41482,1 41492,0 41507,1 41509,0 41561,1 41637,0 41703,1 41757,0 41857,1 41890,0 41973,1 42032,0 42083,1 42106,0 42123,1 42154,0 42245,1 42274,0 42354,1 42356,0 42450,1 42509,0 42532,1 42555,0 42582,1 42630,0 42673,1 42686,0 42745,1 42837,0 42927,1 42941,0 42999,1 43099,0 43175,1 43231,0 43242,1 43259,0 43334,1 43376,0 43439,1 43454,0 43539,1 43563,0 43653,1 43686,0 43716,1 43774,0 43836,1 43891,0 43952,1 43987,0 44041,1 44090,0 44156,1 44164,0 44263,1 44329,0 44381,1 44408,0 44452,1 44480,0 44522,1 44595,0 44612,1 44684,0 44749,1 44814,0 44884,1 44932,0 44954,1 44982,0 45021,1 45068,0 45087,1 45121,0 45217,1 45256,0 45264,1 45348,0 45359,1 45370,0 45416,1 45420,0 45467,1 45473,0 45530,1 45597,0 45628,1 45660,0 45673,1 45748,0 45836,1 45861,0 45906,1 45923,0 45931,1 45966,0 46038,1 46123,0 46129,1 46185,0 46221,1 46295,0 46303,1 46379,0 46397,1 46428,0 46494,1 46501,0 46534,1 46609,0 46629,1 46680,0 46743,1 46827,0 46862,1 46895,0 46969,1 46993,0 47087,1 47147,0 47195,1 47221,0 47265,1 47333,0 47349,1 47394,0 47411,1 47506,0 47570,1 47655,0 47661,1 47700,0 47753,1 47842,0 47888,1 47946,0 47980,1 48060,0 48159,1 48163,0 48218,1 48287,0 48339,1 48403,0 48430,1 48507,0 48557,1 48621,0 48705,1 48742,0 48775,1 48822,0 48880,1 48928,0 48946,1 49005,0 49095,1 49168,0 49180,1 49214,0 49228,1 49317,0 49389,1 49470,0 49511,1 49531,0 49583,1 49592,0 49603,1 49675,0 49731,1 49745,0 49788,1 49842,0 49870,1 49925,0 49987,1 50031,0 50050,1 50071,0 50136,1 50219,0 50278,1 50309,0 50385,1 50440,0 50517,1 50528,0 50587,1 end initlist c1 0,0 50,1 56,0 152,1 219,0 226,1 267,0 269,1 359,0 395,1 450,0 531,1 596,0 610,1 692,0 723,1 803,0 849,1 895,0 961,1 1041,0 1082,1 1101,0 1163,1 1208,0 1255,1 1295,0 1304,1 1348,0 1413,1 1465,0 1525,1 1609,0 1613,1 1704,0 1760,1 1770,0 1868,1 1903,0 1928,1 1973,0 2024,1 2079,0 2106,1 2140,0 2211,1 2260,0 2261,1 2308,0 2316,1 2405,0 2485,1 2581,0 2599,1 2606,0 2693,1 2767,0 2857,1 2905,0 2951,1 3031,0 3060,1 3131,0 3167,1 3177,0 3239,1 3327,0 3413,1 3496,0 3505,1 3531,0 3555,1 3557,0 3588,1 3632,0 3712,1 3731,0 3829,1 3871,0 3904,1 3948,0 4034,1 4114,0 4195,1 4201,0 4220,1 4286,0 4319,1 4333,0 4347,1 4360,0 4406,1 4484,0 4565,1 4645,0 4689,1 4747,0 4844,1 4911,0 5009,1 5097,0 5146,1 5185,0 5267,1 5302,0 5343,1 5394,0 5415,1 5417,0 5434,1 5513,0 5572,1 5670,0 5745,1 5772,0 5859,1 5944,0 5983,1 6017,0 6033,1 6104,0 6204,1 6234,0 6264,1 6351,0 6404,1 6405,0 6503,1 6522,0 6564,1 6645,0 6648,1 6691,0 6736,1 6793,0 6829,1 6836,0 6918,1 6992,0 7068,1 7126,0 7214,1 7282,0 7346,1 7369,0 7374,1 7387,0 7428,1 7485,0 7574,1 7625,0 7703,1 7738,0 7790,1 7863,0 7917,1 7944,0 7961,1 8038,0 8114,1 8137,0 8183,1 8255,0 8286,1 8316,0 8347,1 8426,0 8455,1 8552,0 8612,1 8652,0 8733,1 8760,0 8784,1 8884,0 8952,1 9002,0 9065,1 9140,0 9223,1 9311,0 9331,1 9414,0 9487,1 9554,0 9566,1 9631,0 9679,1 9765,0 9852,1 9899,0 9923,1 9940,0 10025,1 10111,0 10181,1 10273,0 10285,1 10355,0 10402,1 10414,0 10462,1 10503,0 10591,1 10596,0 10598,1 10679,0 10754,1 10770,0 10792,1 10821,0 10884,1 10932,0 10983,1 11051,0 11106,1 11200,0 11279,1 11325,0 11418,1 11470,0 11514,1 11535,0 11616,1 11622,0 11640,1 11711,0 11783,1 11806,0 11876,1 11942,0 12012,1 12034,0 12121,1 12130,0 12171,1 12249,0 12262,1 12353,0 12426,1 12452,0 12474,1 12559,0 12610,1 12703,0 12754,1 12788,0 12800,1 12848,0 12946,1 12953,0 12963,1 12990,0 13024,1 13099,0 13148,1 13164,0 13264,1 13337,0 13410,1 13414,0 13456,1 13528,0 13627,1 13700,0 13769,1 13829,0 13915,1 13994,0 14008,1 14105,0 14111,1 14178,0 14221,1 14227,0 14309,1 14324,0 14356,1 14402,0 14498,1 14512,0 14569,1 14589,0 14590,1 14664,0 14740,1 14783,0 14872,1 14881,0 14920,1 14939,0 15018,1 15057,0 15090,1 15102,0 15108,1 15137,0 15198,1 15276,0 15330,1 15417,0 15433,1 15512,0 15596,1 15601,0 15640,1 15702,0 15799,1 15822,0 15922,1 15946,0 16046,1 16072,0 16122,1 16150,0 16243,1 16292,0 16345,1 16389,0 16454,1 16481,0 16493,1 16494,0 16565,1 16593,0 16607,1 16689,0 16742,1 16827,0 16848,1 16919,0 16997,1 17048,0 17123,1 17141,0 17230,1 17252,0 17319,1 17336,0 17354,1 17436,0 17440,1 17521,0 17561,1 17629,0 17681,1 17718,0 17754,1 17818,0 17821,1 17913,0 17916,1 18006,0 18021,1 18061,0 18130,1 18173,0 18224,1 18265,0 18298,1 18312,0 18354,1 18419,0 18504,1 18564,0 18578,1 18672,0 18767,1 18810,0 18873,1 18897,0 18921,1 19000,0 19052,1 19096,0 19165,1 19189,0 19244,1 19311,0 19411,1 19443,0 19542,1 19586,0 19593,1 19603,0 19691,1 19748,0 19772,1 19821,0 19825,1 19837,0 19929,1 20018,0 20116,1 20186,0 20205,1 20231,0 20286,1 20332,0 20425,1 20429,0 20455,1 20501,0 20560,1 20621,0 20651,1 20740,0 20744,1 20773,0 20794,1 20798,0 20836,1 20888,0 20922,1 20958,0 21047,1 21122,0 21187,1 21213,0 21274,1 21291,0 21371,1 21396,0 21455,1 21481,0 21490,1 21573,0 21612,1 21639,0 21725,1 21770,0 21807,1 21815,0 21861,1 21947,0 21983,1 22074,0 22145,1 22203,0 22293,1 22372,0 22465,1 22473,0 22509,1 22578,0 22662,1 22714,0 22769,1 22810,0 22904,1 22928,0 22980,1 23067,0 23110,1 23171,0 23232,1 23247,0 23263,1 23330,0 23378,1 23430,0 23448,1 23472,0 23551,1 23569,0 23606,1 23649,0 23728,1 23804,0 23847,1 23937,0 24005,1 24038,0 24063,1 24094,0 24121,1 24194,0 24275,1 24355,0 24453,1 24545,0 24636,1 24707,0 24752,1 24772,0 24849,1 24895,0 24946,1 25011,0 25085,1 25146,0 25147,1 25158,0 25257,1 25280,0 25326,1 25373,0 25390,1 25463,0 25522,1 25534,0 25616,1 25657,0 25737,1 25813,0 25878,1 25957,0 25966,1 26040,0 26107,1 26119,0 26180,1 26193,0 26259,1 26328,0 26342,1 26348,0 26361,1 26401,0 26419,1 26459,0 26505,1 26573,0 26614,1 26664,0 26673,1 26769,0 26857,1 26935,0 27024,1 27113,0 27183,1 27192,0 27231,1 27241,0 27330,1 27406,0 27470,1 27565,0 27575,1 27598,0 27653,1 27667,0 27767,1 27796,0 27864,1 27886,0 27963,1 28024,0 28027,1 28110,0 28117,1 28125,0 28154,1 28236,0 28249,1 28272,0 28282,1 28308,0 28379,1 28459,0 28536,1 28587,0 28682,1 28707,0 28789,1 28841,0 28866,1 28966,0 29003,1 29081,0 29144,1 29146,0 29214,1 29263,0 29272,1 29328,0 29345,1 29409,0 29428,1 29493,0 29555,1 29580,0 29602,1 29680,0 29748,1 29829,0 29833,1 29908,0 29989,1 29991,0 30042,1 30101,0 30154,1 30254,0 30265,1 30342,0 30344,1 30354,0 30398,1 30427,0 30468,1 30495,0 30524,1 30580,0 30673,1 30752,0 30812,1 30831,0 30884,1 30943,0 31040,1 31048,0 31102,1 31125,0 31172,1 31230,0 31241,1 31301,0 31370,1 31451,0 31453,1 31465,0 31552,1 31559,0 31582,1 31670,0 31762,1 31839,0 31917,1 31939,0 31968,1 31991,0 32010,1 32033,0 32062,1 32066,0 32070,1 32169,0 32261,1 32344,0 32408,1 32430,0 32478,1 32552,0 32600,1 32623,0 32661,1 32752,0 32801,1 32846,0 32923,1 33018,0 33052,1 33142,0 33170,1 33247,0 33258,1 33302,0 33349,1 33375,0 33424,1 33471,0 33560,1 33648,0 33696,1 33723,0 33746,1 33834,0 33842,1 33911,0 33935,1 33983,0 34017,1 34114,0 34186,1 34205,0 34219,1 34316,0 34355,1 34375,0 34471,1 34500,0 34538,1 34593,0 34630,1 34709,0 34758,1 34817,0 34908,1 34948,0 34997,1 35040,0 35082,1 35157,0 35256,1 35258,0 35319,1 35347,0 35447,1 35448,0 35503,1 35571,0 35586,1 35647,0 35725,1 35790,0 35813,1 35911,0 36011,1 36089,0 36160,1 36185,0 36239,1 36333,0 36399,1 36400,0 36488,1 36543,0 36606,1 36695,0 36715,1 36808,0 36818,1 36873,0 36879,1 36927,0 36979,1 37012,0 37087,1 37185,0 37202,1 37248,0 37316,1 37364,0 37405,1 37495,0 37582,1 37595,0 37664,1 37753,0 37787,1 37830,0 37871,1 37968,0 37987,1 38050,0 38059,1 38100,0 38141,1 38203,0 38270,1 38323,0 38350,1 38411,0 38451,1 38461,0 38463,1 38531,0 38570,1 38586,0 38666,1 38669,0 38709,1 38796,0 38845,1 38860,0 38890,1 38901,0 38965,1 38984,0 39059,1 39121,0 39138,1 39231,0 39255,1 39330,0 39403,1 39433,0 39445,1 39484,0 39561,1 39567,0 39645,1 39667,0 39760,1 39850,0 39903,1 39969,0 39972,1 39991,0 40036,1 40066,0 40117,1 40131,0 40174,1 40197,0 40289,1 40387,0 40390,1 40455,0 40526,1 40532,0 40574,1 40611,0 40648,1 40737,0 40808,1 40829,0 40842,1 40864,0 40929,1 40979,0 40988,1 41051,0 41151,1 41240,0 41328,1 41365,0 41427,1 41516,0 41564,1 41627,0 41706,1 41728,0 41736,1 41817,0 41825,1 41880,0 41959,1 42019,0 42102,1 42126,0 42188,1 42210,0 42273,1 42275,0 42352,1 42429,0 42510,1 42579,0 42654,1 42691,0 42757,1 42825,0 42893,1 42944,0 43021,1 43050,0 43056,1 43108,0 43120,1 43156,0 43256,1 43327,0 43333,1 43378,0 43382,1 43385,0 43463,1 43537,0 43618,1 43705,0 43714,1 43738,0 43777,1 43846,0 43901,1 43909,0 43954,1 44023,0 44027,1 44125,0 44207,1 44226,0 44305,1 44336,0 44378,1 44382,0 44464,1 44528,0 44583,1 44627,0 44638,1 44686,0 44755,1 44769,0 44797,1 44829,0 44894,1 44959,0 44972,1 45019,0 45059,1 45078,0 45082,1 45095,0 45171,1 45243,0 45338,1 45365,0 45451,1 45470,0 45482,1 45566,0 45661,1 45668,0 45671,1 45710,0 45716,1 45733,0 45820,1 45879,0 45915,1 46005,0 46099,1 46115,0 46147,1 46229,0 46288,1 46375,0 46423,1 46488,0 46495,1 46519,0 46583,1 46649,0 46714,1 46774,0 46856,1 46952,0 46980,1 47078,0 47112,1 47166,0 47258,1 47340,0 47430,1 47447,0 47483,1 47501,0 47597,1 47697,0 47769,1 47779,0 47867,1 47905,0 47989,1 48063,0 48078,1 48165,0 48214,1 48234,0 48295,1 48303,0 48396,1 48429,0 48521,1 48581,0 48582,1 48665,0 48689,1 48780,0 48871,1 48886,0 48922,1 49014,0 49026,1 49105,0 49137,1 49140,0 49194,1 49202,0 49284,1 49370,0 49387,1 49457,0 49474,1 49527,0 49617,1 49669,0 49750,1 49821,0 49826,1 49907,0 50001,1 50005,0 50023,1 50033,0 50112,1 50204,0 50297,1 50335,0 50426,1 50434,0 50436,1 50453,0 50467,1 50487,0 50496,1 50575,0 50655,1 end initlist c2 0,0 46,1 126,0 221,1 293,0 358,1 383,0 447,1 538,0 596,1 597,0 657,1 734,0 740,1 801,0 857,1 875,0 886,1 900,0 909,1 957,0 1045,1 1144,0 1169,1 1186,0 1203,1 1265,0 1288,1 1293,0 1362,1 1415,0 1476,1 1560,0 1593,1 1663,0 1727,1 1757,0 1818,1 1859,0 1907,1 1929,0 1936,1 1949,0 1985,1 2063,0 2068,1 2108,0 2164,1 2253,0 2350,1 2368,0 2412,1 2480,0 2550,1 2632,0 2688,1 2736,0 2747,1 2779,0 2839,1 2872,0 2901,1 2924,0 2992,1 3010,0 3058,1 3146,0 3243,1 3262,0 3300,1 3391,0 3443,1 3453,0 3520,1 3577,0 3592,1 3595,0 3611,1 3679,0 3739,1 3761,0 3809,1 3813,0 3836,1 3926,0 3978,1 4066,0 4106,1 4169,0 4184,1 4198,0 4235,1 4302,0 4379,1 4449,0 4518,1 4521,0 4585,1 4586,0 4676,1 4724,0 4778,1 4795,0 4861,1 4938,0 4965,1 5025,0 5100,1 5121,0 5151,1 5237,0 5303,1 5377,0 5457,1 5524,0 5526,1 5536,0 5563,1 5608,0 5638,1 5678,0 5748,1 5758,0 5775,1 5778,0 5820,1 5908,0 5959,1 6022,0 6068,1 6130,0 6154,1 6219,0 6254,1 6294,0 6304,1 6361,0 6370,1 6469,0 6565,1 6595,0 6671,1 6677,0 6760,1 6853,0 6869,1 6872,0 6904,1 6906,0 6988,1 6995,0 7080,1 7169,0 7196,1 7281,0 7313,1 7350,0 7423,1 7491,0 7579,1 7654,0 7703,1 7712,0 7754,1 7791,0 7794,1 7807,0 7863,1 7951,0 7972,1 8071,0 8165,1 8191,0 8217,1 8280,0 8314,1 8389,0 8447,1 8499,0 8536,1 8601,0 8608,1 8629,0 8630,1 8633,0 8650,1 8656,0 8754,1 8812,0 8869,1 8937,0 8969,1 9023,0 9061,1 9117,0 9207,1 9286,0 9310,1 9317,0 9338,1 9389,0 9484,1 9505,0 9580,1 9625,0 9708,1 9731,0 9741,1 9830,0 9845,1 9886,0 9957,1 9997,0 10036,1 10082,0 10128,1 10228,0 10258,1 10353,0 10423,1 10459,0 10495,1 10551,0 10639,1 10664,0 10751,1 10753,0 10813,1 10889,0 10898,1 10975,0 10993,1 10999,0 11077,1 11161,0 11219,1 11317,0 11404,1 11479,0 11499,1 11512,0 11558,1 11632,0 11650,1 11703,0 11793,1 11879,0 11951,1 12030,0 12103,1 12143,0 12237,1 12268,0 12336,1 12416,0 12426,1 12461,0 12477,1 12499,0 12593,1 12642,0 12673,1 12744,0 12826,1 12918,0 12928,1 13021,0 13042,1 13114,0 13117,1 13198,0 13296,1 13325,0 13368,1 13410,0 13470,1 13486,0 13495,1 13573,0 13605,1 13659,0 13691,1 13724,0 13735,1 13820,0 13916,1 13919,0 13999,1 14048,0 14049,1 14140,0 14238,1 14252,0 14255,1 14272,0 14316,1 14323,0 14365,1 14455,0 14471,1 14501,0 14526,1 14547,0 14560,1 14599,0 14631,1 14694,0 14789,1 14845,0 14885,1 14983,0 15048,1 15063,0 15073,1 15142,0 15190,1 15246,0 15300,1 15366,0 15374,1 15467,0 15481,1 15559,0 15569,1 15659,0 15723,1 15772,0 15865,1 15923,0 15975,1 15985,0 15994,1 16072,0 16124,1 16205,0 16230,1 16268,0 16291,1 16343,0 16368,1 16379,0 16382,1 16396,0 16494,1 16556,0 16641,1 16700,0 16759,1 16777,0 16859,1 16881,0 16893,1 16962,0 17011,1 17088,0 17170,1 17261,0 17294,1 17310,0 17382,1 17482,0 17485,1 17560,0 17640,1 17665,0 17666,1 17707,0 17758,1 17858,0 17923,1 17943,0 18028,1 18070,0 18144,1 18207,0 18212,1 18282,0 18306,1 18320,0 18385,1 18388,0 18475,1 18563,0 18586,1 18614,0 18685,1 18696,0 18708,1 18784,0 18850,1 18873,0 18946,1 18973,0 19062,1 19131,0 19191,1 19203,0 19281,1 19295,0 19371,1 19400,0 19457,1 19552,0 19605,1 19623,0 19716,1 19794,0 19885,1 19904,0 19933,1 19972,0 20001,1 20025,0 20121,1 20199,0 20271,1 20284,0 20336,1 20399,0 20493,1 20573,0 20653,1 20717,0 20779,1 20843,0 20870,1 20941,0 20960,1 21002,0 21085,1 21160,0 21226,1 21248,0 21313,1 21396,0 21487,1 21503,0 21564,1 21593,0 21623,1 21683,0 21721,1 21820,0 21860,1 21885,0 21957,1 22004,0 22102,1 22151,0 22180,1 22273,0 22290,1 22389,0 22479,1 22563,0 22564,1 22581,0 22625,1 22689,0 22786,1 22851,0 22936,1 22978,0 23021,1 23116,0 23211,1 23255,0 23325,1 23423,0 23495,1 23515,0 23538,1 23591,0 23647,1 23744,0 23779,1 23796,0 23808,1 23828,0 23862,1 23882,0 23934,1 24014,0 24092,1 24153,0 24252,1 24276,0 24280,1 24285,0 24384,1 24478,0 24562,1 24636,0 24657,1 24710,0 24757,1 24780,0 24846,1 24860,0 24893,1 24990,0 25028,1 25030,0 25053,1 25076,0 25113,1 25133,0 25147,1 25189,0 25196,1 25227,0 25251,1 25335,0 25388,1 25423,0 25475,1 25523,0 25531,1 25540,0 25622,1 25687,0 25695,1 25711,0 25747,1 25801,0 25873,1 25965,0 26029,1 26068,0 26111,1 26144,0 26180,1 26258,0 26294,1 26333,0 26399,1 26405,0 26407,1 26507,0 26517,1 26540,0 26637,1 26679,0 26692,1 26764,0 26861,1 26917,0 26989,1 27000,0 27080,1 27092,0 27129,1 27167,0 27265,1 27348,0 27402,1 27441,0 27497,1 27507,0 27548,1 27600,0 27674,1 27697,0 27717,1 27735,0 27794,1 27881,0 27957,1 27963,0 27976,1 28018,0 28066,1 28108,0 28177,1 28260,0 28325,1 28357,0 28428,1 28479,0 28536,1 28557,0 28584,1 28643,0 28676,1 28694,0 28763,1 28786,0 28876,1 28906,0 28909,1 29001,0 29072,1 29092,0 29174,1 29252,0 29328,1 29383,0 29473,1 29511,0 29586,1 29621,0 29685,1 29749,0 29799,1 29899,0 29963,1 30024,0 30081,1 30132,0 30173,1 30267,0 30334,1 30361,0 30402,1 30417,0 30430,1 30528,0 30616,1 30677,0 30691,1 30700,0 30747,1 30773,0 30837,1 30883,0 30942,1 31041,0 31073,1 31126,0 31193,1 31252,0 31319,1 31399,0 31448,1 31461,0 31496,1 31508,0 31533,1 31630,0 31633,1 31659,0 31708,1 31768,0 31865,1 31914,0 31966,1 31970,0 31974,1 32033,0 32112,1 32142,0 32154,1 32175,0 32273,1 32288,0 32366,1 32392,0 32413,1 32449,0 32481,1 32520,0 32605,1 32614,0 32645,1 32683,0 32721,1 32805,0 32879,1 32957,0 33002,1 33030,0 33084,1 33099,0 33182,1 33267,0 33358,1 33427,0 33467,1 33487,0 33551,1 33625,0 33677,1 33701,0 33749,1 33802,0 33833,1 33921,0 33971,1 33992,0 34057,1 34140,0 34179,1 34243,0 34328,1 34380,0 34457,1 34541,0 34565,1 34578,0 34602,1 34693,0 34763,1 34802,0 34823,1 34852,0 34933,1 34941,0 34952,1 35015,0 35071,1 35138,0 35152,1 35199,0 35231,1 35268,0 35318,1 35399,0 35453,1 35512,0 35592,1 35671,0 35747,1 35825,0 35859,1 35877,0 35952,1 35987,0 36006,1 36014,0 36103,1 36192,0 36215,1 36240,0 36329,1 36390,0 36468,1 36476,0 36493,1 36533,0 36545,1 36576,0 36591,1 36673,0 36685,1 36750,0 36776,1 36828,0 36892,1 36904,0 37002,1 37083,0 37100,1 37184,0 37234,1 37288,0 37323,1 37406,0 37448,1 37524,0 37540,1 37625,0 37661,1 37681,0 37755,1 37805,0 37892,1 37987,0 38081,1 38127,0 38137,1 38150,0 38230,1 38299,0 38384,1 38385,0 38403,1 38494,0 38573,1 38589,0 38622,1 38710,0 38792,1 38841,0 38932,1 38986,0 39048,1 39144,0 39151,1 39192,0 39291,1 39306,0 39325,1 39336,0 39375,1 39402,0 39476,1 39514,0 39599,1 39602,0 39643,1 39731,0 39751,1 39804,0 39877,1 39911,0 39962,1 39965,0 40060,1 40126,0 40208,1 40258,0 40300,1 40397,0 40497,1 40498,0 40558,1 40624,0 40671,1 40720,0 40725,1 40734,0 40751,1 40815,0 40905,1 40977,0 41037,1 41039,0 41078,1 41172,0 41207,1 41240,0 41261,1 41337,0 41407,1 41445,0 41469,1 41526,0 41608,1 41697,0 41797,1 41847,0 41908,1 41974,0 42060,1 42102,0 42183,1 42245,0 42339,1 42369,0 42398,1 42429,0 42525,1 42562,0 42654,1 42682,0 42712,1 42798,0 42883,1 42954,0 43034,1 43098,0 43111,1 43113,0 43199,1 43281,0 43334,1 43414,0 43465,1 43510,0 43576,1 43624,0 43643,1 43720,0 43739,1 43746,0 43755,1 43765,0 43843,1 43937,0 44008,1 44095,0 44152,1 44251,0 44266,1 44299,0 44305,1 44336,0 44413,1 44481,0 44507,1 44548,0 44614,1 44706,0 44764,1 44774,0 44843,1 44917,0 44977,1 45064,0 45087,1 45121,0 45167,1 45228,0 45311,1 45360,0 45426,1 45515,0 45577,1 45585,0 45610,1 45690,0 45714,1 45778,0 45780,1 45802,0 45815,1 45865,0 45879,1 45883,0 45898,1 45972,0 46012,1 46058,0 46098,1 46133,0 46150,1 46173,0 46174,1 46246,0 46344,1 46397,0 46434,1 46459,0 46488,1 46569,0 46603,1 46638,0 46728,1 46811,0 46846,1 46940,0 46960,1 46981,0 47064,1 47107,0 47159,1 47259,0 47281,1 47375,0 47400,1 47477,0 47521,1 47592,0 47612,1 47684,0 47711,1 47744,0 47769,1 47851,0 47903,1 47947,0 47980,1 48009,0 48065,1 48145,0 48244,1 48297,0 48369,1 48394,0 48415,1 48500,0 48503,1 48579,0 48663,1 48729,0 48806,1 48899,0 48964,1 49055,0 49073,1 49076,0 49090,1 49127,0 49201,1 49274,0 49372,1 49461,0 49551,1 49590,0 49593,1 49671,0 49721,1 49812,0 49823,1 49838,0 49884,1 49980,0 50076,1 50097,0 50141,1 50214,0 50258,1 end initlist c3 0,0 27,1 82,0 87,1 127,0 176,1 211,0 227,1 253,0 350,1 363,0 410,1 435,0 529,1 604,0 623,1 640,0 695,1 772,0 773,1 860,0 916,1 943,0 1005,1 1022,0 1065,1 1145,0 1178,1 1276,0 1344,1 1366,0 1369,1 1463,0 1546,1 1572,0 1613,1 1680,0 1746,1 1783,0 1836,1 1894,0 1935,1 1956,0 2044,1 2052,0 2058,1 2100,0 2110,1 2135,0 2166,1 2185,0 2194,1 2260,0 2346,1 2387,0 2451,1 2456,0 2531,1 2577,0 2611,1 2688,0 2724,1 2748,0 2753,1 2757,0 2766,1 2786,0 2794,1 2876,0 2935,1 3004,0 3014,1 3059,0 3066,1 3138,0 3209,1 3250,0 3264,1 3297,0 3378,1 3408,0 3475,1 3499,0 3583,1 3650,0 3708,1 3731,0 3742,1 3805,0 3895,1 3911,0 4002,1 4057,0 4144,1 4166,0 4254,1 4288,0 4373,1 4408,0 4427,1 4515,0 4551,1 4583,0 4617,1 4717,0 4801,1 4803,0 4879,1 4969,0 5007,1 5014,0 5061,1 5138,0 5238,1 5250,0 5292,1 5327,0 5380,1 5388,0 5443,1 5500,0 5595,1 5614,0 5709,1 5735,0 5781,1 5865,0 5897,1 5956,0 6040,1 6111,0 6112,1 6164,0 6258,1 6305,0 6322,1 6368,0 6424,1 6493,0 6585,1 6644,0 6721,1 6764,0 6835,1 6927,0 6948,1 6994,0 7092,1 7161,0 7189,1 7274,0 7333,1 7341,0 7354,1 7430,0 7478,1 7570,0 7651,1 7668,0 7756,1 7785,0 7832,1 7885,0 7964,1 8022,0 8114,1 8132,0 8182,1 8228,0 8328,1 8396,0 8456,1 8522,0 8603,1 8662,0 8671,1 8711,0 8767,1 8782,0 8821,1 8870,0 8953,1 8982,0 9036,1 9076,0 9078,1 9120,0 9172,1 9225,0 9289,1 9328,0 9408,1 9499,0 9582,1 9613,0 9677,1 9751,0 9765,1 9859,0 9958,1 10001,0 10043,1 10111,0 10145,1 10162,0 10180,1 10183,0 10268,1 10326,0 10338,1 10346,0 10389,1 10407,0 10449,1 10504,0 10546,1 10618,0 10672,1 10677,0 10729,1 10746,0 10815,1 10859,0 10918,1 11008,0 11084,1 11172,0 11176,1 11182,0 11270,1 11352,0 11392,1 11445,0 11453,1 11483,0 11496,1 11505,0 11519,1 11579,0 11612,1 11708,0 11752,1 11783,0 11853,1 11910,0 11921,1 11979,0 12056,1 12133,0 12150,1 12245,0 12314,1 12379,0 12435,1 12448,0 12503,1 12523,0 12543,1 12579,0 12611,1 12677,0 12769,1 12836,0 12841,1 12907,0 12940,1 13011,0 13104,1 13127,0 13218,1 13234,0 13306,1 13340,0 13423,1 13448,0 13533,1 13549,0 13605,1 13673,0 13764,1 13843,0 13847,1 13897,0 13979,1 14008,0 14095,1 14195,0 14274,1 14337,0 14391,1 14405,0 14483,1 14502,0 14520,1 14595,0 14689,1 14782,0 14856,1 14954,0 15035,1 15082,0 15156,1 15200,0 15250,1 15263,0 15342,1 15372,0 15441,1 15479,0 15535,1 15626,0 15628,1 15656,0 15676,1 15767,0 15863,1 15895,0 15922,1 15993,0 16021,1 16097,0 16131,1 16207,0 16295,1 16344,0 16370,1 16420,0 16421,1 16449,0 16524,1 16605,0 16646,1 16744,0 16748,1 16797,0 16817,1 16849,0 16868,1 16907,0 16961,1 16994,0 17070,1 17146,0 17214,1 17314,0 17391,1 17448,0 17510,1 17550,0 17635,1 17664,0 17702,1 17765,0 17858,1 17942,0 18035,1 18044,0 18088,1 18156,0 18255,1 18320,0 18357,1 18369,0 18464,1 18531,0 18542,1 18575,0 18659,1 18723,0 18771,1 18871,0 18918,1 18973,0 18984,1 19035,0 19055,1 19146,0 19177,1 19217,0 19302,1 19375,0 19406,1 19475,0 19517,1 19615,0 19664,1 19740,0 19832,1 19909,0 19984,1 20053,0 20092,1 20101,0 20140,1 20231,0 20284,1 20339,0 20434,1 20452,0 20522,1 20566,0 20635,1 20655,0 20734,1 20752,0 20809,1 20909,0 20947,1 20968,0 20970,1 21060,0 21145,1 21176,0 21231,1 21271,0 21339,1 21372,0 21374,1 21437,0 21523,1 21531,0 21573,1 21602,0 21617,1 21673,0 21737,1 21833,0 21841,1 21891,0 21961,1 22050,0 22129,1 22195,0 22241,1 22246,0 22284,1 22308,0 22354,1 22355,0 22372,1 22410,0 22429,1 22451,0 22490,1 22565,0 22573,1 22603,0 22653,1 22708,0 22773,1 22858,0 22882,1 22972,0 23002,1 23041,0 23080,1 23148,0 23229,1 23322,0 23373,1 23457,0 23472,1 23570,0 23629,1 23681,0 23767,1 23768,0 23805,1 23836,0 23852,1 23857,0 23920,1 23957,0 24005,1 24083,0 24162,1 24190,0 24267,1 24315,0 24397,1 24427,0 24523,1 24618,0 24718,1 24804,0 24888,1 24923,0 24999,1 25010,0 25036,1 25061,0 25119,1 25149,0 25239,1 25322,0 25377,1 25421,0 25449,1 25531,0 25590,1 25609,0 25650,1 25731,0 25814,1 25883,0 25923,1 25928,0 26007,1 26035,0 26080,1 26129,0 26199,1 26294,0 26359,1 26367,0 26427,1 26523,0 26619,1 26649,0 26650,1 26737,0 26776,1 26802,0 26891,1 26973,0 27026,1 27080,0 27164,1 27217,0 27316,1 27345,0 27380,1 27391,0 27479,1 27575,0 27589,1 27663,0 27734,1 27816,0 27899,1 27902,0 27993,1 28030,0 28077,1 28112,0 28127,1 28206,0 28273,1 28363,0 28404,1 28502,0 28512,1 28547,0 28550,1 28585,0 28646,1 28723,0 28766,1 28857,0 28940,1 28970,0 29063,1 29121,0 29128,1 29217,0 29265,1 29334,0 29370,1 29467,0 29561,1 29628,0 29666,1 29760,0 29823,1 29845,0 29914,1 29927,0 29986,1 30032,0 30100,1 30174,0 30185,1 30246,0 30292,1 30318,0 30360,1 30390,0 30435,1 30530,0 30603,1 30607,0 30697,1 30707,0 30712,1 30756,0 30771,1 30829,0 30915,1 30963,0 30986,1 31018,0 31103,1 31193,0 31249,1 31252,0 31350,1 31402,0 31484,1 31569,0 31645,1 31735,0 31757,1 31773,0 31775,1 31800,0 31893,1 31913,0 31925,1 31973,0 31992,1 31996,0 32076,1 32093,0 32181,1 32249,0 32340,1 32429,0 32503,1 32514,0 32582,1 32653,0 32737,1 32788,0 32796,1 32859,0 32942,1 33034,0 33057,1 33154,0 33227,1 33283,0 33324,1 33400,0 33432,1 33440,0 33523,1 33544,0 33618,1 33637,0 33693,1 33734,0 33788,1 33875,0 33960,1 33961,0 34049,1 34088,0 34176,1 34262,0 34341,1 34385,0 34388,1 34439,0 34481,1 34534,0 34594,1 34636,0 34644,1 34744,0 34829,1 34842,0 34921,1 34958,0 35007,1 35012,0 35046,1 35143,0 35176,1 35272,0 35292,1 35383,0 35442,1 35459,0 35519,1 35521,0 35536,1 35575,0 35650,1 35715,0 35766,1 35796,0 35884,1 35949,0 36013,1 36046,0 36146,1 36154,0 36203,1 36205,0 36265,1 36281,0 36353,1 36404,0 36503,1 36541,0 36621,1 36666,0 36762,1 36801,0 36856,1 36863,0 36913,1 36994,0 37043,1 37047,0 37102,1 37141,0 37175,1 37216,0 37307,1 37309,0 37370,1 37392,0 37438,1 37492,0 37521,1 37608,0 37651,1 37667,0 37711,1 37779,0 37839,1 37908,0 37976,1 38031,0 38078,1 38130,0 38185,1 38257,0 38326,1 38353,0 38405,1 38474,0 38481,1 38569,0 38587,1 38597,0 38600,1 38698,0 38728,1 38809,0 38893,1 38943,0 38984,1 39007,0 39086,1 39113,0 39205,1 39278,0 39311,1 39366,0 39424,1 39478,0 39537,1 39610,0 39702,1 39797,0 39812,1 39902,0 39934,1 40029,0 40073,1 40118,0 40211,1 40309,0 40328,1 40375,0 40453,1 40461,0 40530,1 40598,0 40618,1 40716,0 40801,1 40846,0 40888,1 40988,0 41018,1 41059,0 41159,1 41189,0 41223,1 41279,0 41286,1 41349,0 41372,1 41463,0 41534,1 41631,0 41714,1 41715,0 41809,1 41899,0 41973,1 42069,0 42097,1 42112,0 42124,1 42184,0 42219,1 42226,0 42272,1 42307,0 42310,1 42319,0 42384,1 42455,0 42502,1 42521,0 42592,1 42594,0 42653,1 42702,0 42735,1 42797,0 42801,1 42888,0 42901,1 42951,0 43048,1 43050,0 43076,1 43111,0 43188,1 43198,0 43288,1 43337,0 43338,1 43383,0 43425,1 43463,0 43471,1 43526,0 43623,1 43698,0 43736,1 43822,0 43834,1 43879,0 43917,1 43949,0 43995,1 44014,0 44078,1 44147,0 44245,1 44255,0 44274,1 44354,0 44361,1 44440,0 44462,1 44489,0 44563,1 44567,0 44659,1 44679,0 44766,1 44832,0 44842,1 44914,0 45001,1 45096,0 45151,1 45178,0 45254,1 45341,0 45406,1 45458,0 45542,1 45549,0 45629,1 45644,0 45743,1 45806,0 45809,1 45856,0 45869,1 45967,0 46045,1 46066,0 46083,1 46181,0 46216,1 46272,0 46348,1 46429,0 46511,1 46603,0 46609,1 46656,0 46718,1 46810,0 46865,1 46912,0 46965,1 47010,0 47060,1 47072,0 47120,1 47157,0 47246,1 47337,0 47409,1 47504,0 47538,1 47607,0 47687,1 47747,0 47815,1 47898,0 47937,1 47989,0 48041,1 48069,0 48145,1 48168,0 48177,1 48267,0 48344,1 48371,0 48447,1 48503,0 48582,1 48606,0 48658,1 48726,0 48803,1 48883,0 48895,1 48981,0 49057,1 49108,0 49152,1 49160,0 49169,1 49195,0 49246,1 49281,0 49289,1 49375,0 49398,1 49454,0 49546,1 49557,0 49629,1 49682,0 49714,1 49749,0 49838,1 49883,0 49970,1 50022,0 50089,1 50152,0 50250,1 50266,0 50327,1 50377,0 50417,1 50509,0 50604,1 50686,0 50752,1 50769,0 50817,1 50908,0 50928,1 50990,0 51011,1 51089,0 51124,1 51223,0 51239,1 51285,0 51329,1 51362,0 51449,1 51547,0 51614,1 51701,0 51734,1 51812,0 51895,1 51925,0 52018,1 52083,0 52105,1 52115,0 52207,1 52225,0 52254,1 end initlist c4 0,0 43,1 109,0 193,1 228,0 255,1 300,0 367,1 380,0 451,1 485,0 569,1 598,0 659,1 718,0 730,1 754,0 807,1 861,0 932,1 977,0 987,1 1009,0 1013,1 1035,0 1078,1 1104,0 1133,1 1196,0 1296,1 1333,0 1382,1 1482,0 1542,1 1576,0 1632,1 1710,0 1764,1 1864,0 1958,1 2045,0 2098,1 2188,0 2190,1 2284,0 2306,1 2376,0 2428,1 2502,0 2574,1 2584,0 2593,1 2669,0 2685,1 2699,0 2790,1 2857,0 2955,1 3019,0 3030,1 3066,0 3119,1 3206,0 3254,1 3328,0 3389,1 3420,0 3455,1 3461,0 3543,1 3600,0 3607,1 3674,0 3768,1 3830,0 3878,1 3933,0 3940,1 4034,0 4041,1 4108,0 4132,1 4140,0 4234,1 4289,0 4364,1 4418,0 4479,1 4518,0 4618,1 4627,0 4720,1 4774,0 4796,1 4868,0 4897,1 4983,0 5013,1 5020,0 5041,1 5131,0 5132,1 5155,0 5202,1 5297,0 5319,1 5412,0 5460,1 5527,0 5557,1 5618,0 5700,1 5701,0 5708,1 5802,0 5875,1 5909,0 5998,1 6039,0 6128,1 6196,0 6249,1 6346,0 6348,1 6404,0 6421,1 6473,0 6523,1 6561,0 6632,1 6730,0 6731,1 6804,0 6820,1 6843,0 6938,1 6984,0 6990,1 7069,0 7153,1 7244,0 7324,1 7356,0 7411,1 7434,0 7461,1 7534,0 7576,1 7651,0 7750,1 7839,0 7885,1 7964,0 7983,1 8022,0 8068,1 8121,0 8196,1 8227,0 8279,1 8288,0 8376,1 8388,0 8440,1 8526,0 8544,1 8626,0 8702,1 8707,0 8760,1 8836,0 8926,1 8930,0 8968,1 9054,0 9068,1 9098,0 9182,1 9207,0 9250,1 9295,0 9380,1 9424,0 9452,1 9527,0 9538,1 9555,0 9583,1 9585,0 9672,1 9694,0 9751,1 9813,0 9873,1 9959,0 10050,1 10072,0 10147,1 10233,0 10321,1 10379,0 10427,1 10523,0 10564,1 10628,0 10699,1 10789,0 10861,1 10865,0 10951,1 10969,0 10991,1 11077,0 11081,1 11176,0 11214,1 11270,0 11319,1 11405,0 11484,1 11574,0 11589,1 11628,0 11693,1 11702,0 11739,1 11799,0 11803,1 11831,0 11914,1 11978,0 12064,1 12123,0 12216,1 12247,0 12248,1 12265,0 12316,1 12324,0 12340,1 12358,0 12361,1 12414,0 12508,1 12539,0 12558,1 12600,0 12647,1 12678,0 12717,1 12748,0 12822,1 12882,0 12958,1 13000,0 13014,1 13095,0 13128,1 13145,0 13159,1 13204,0 13232,1 13276,0 13372,1 13470,0 13558,1 13617,0 13676,1 13734,0 13783,1 13785,0 13818,1 13892,0 13936,1 13954,0 14027,1 14123,0 14189,1 14248,0 14261,1 14333,0 14354,1 14390,0 14450,1 14483,0 14503,1 14600,0 14639,1 14682,0 14719,1 14769,0 14805,1 14874,0 14897,1 14941,0 15031,1 15081,0 15090,1 15171,0 15191,1 15217,0 15280,1 15346,0 15413,1 15435,0 15520,1 15595,0 15613,1 15624,0 15636,1 15648,0 15725,1 15783,0 15825,1 15830,0 15900,1 15981,0 16037,1 16135,0 16221,1 16247,0 16267,1 16361,0 16427,1 16493,0 16545,1 16570,0 16646,1 16676,0 16710,1 16750,0 16844,1 16914,0 16930,1 16980,0 17036,1 17040,0 17043,1 17090,0 17119,1 17151,0 17198,1 17270,0 17285,1 17341,0 17434,1 17525,0 17571,1 17669,0 17760,1 17771,0 17807,1 17907,0 17975,1 18046,0 18102,1 18198,0 18276,1 18355,0 18419,1 18437,0 18499,1 18574,0 18606,1 18635,0 18717,1 18740,0 18840,1 18914,0 18988,1 19034,0 19095,1 19190,0 19268,1 19353,0 19427,1 19431,0 19505,1 19587,0 19640,1 19650,0 19662,1 19725,0 19803,1 19859,0 19959,1 19979,0 20012,1 20014,0 20081,1 20170,0 20213,1 20309,0 20388,1 20441,0 20506,1 20602,0 20698,1 20720,0 20727,1 20783,0 20859,1 20957,0 20962,1 21008,0 21053,1 21090,0 21144,1 21167,0 21191,1 21283,0 21288,1 21383,0 21454,1 21517,0 21608,1 21651,0 21672,1 21698,0 21789,1 21889,0 21968,1 21984,0 22011,1 22072,0 22088,1 22117,0 22202,1 22297,0 22376,1 22412,0 22485,1 22555,0 22605,1 22613,0 22678,1 22689,0 22731,1 22802,0 22884,1 22908,0 22983,1 22994,0 23059,1 23095,0 23121,1 23192,0 23276,1 23282,0 23335,1 23370,0 23402,1 23441,0 23512,1 23570,0 23587,1 23629,0 23693,1 23790,0 23822,1 23857,0 23908,1 23996,0 24030,1 24125,0 24196,1 24220,0 24236,1 24286,0 24356,1 24361,0 24389,1 24451,0 24524,1 24587,0 24663,1 24749,0 24830,1 24921,0 24952,1 25028,0 25037,1 25118,0 25202,1 25266,0 25329,1 25367,0 25405,1 25495,0 25561,1 25628,0 25652,1 25739,0 25801,1 25843,0 25904,1 25906,0 25982,1 26027,0 26080,1 26128,0 26206,1 26306,0 26321,1 26393,0 26420,1 26434,0 26497,1 26565,0 26644,1 26662,0 26732,1 26800,0 26836,1 26917,0 26980,1 27018,0 27038,1 27105,0 27189,1 27270,0 27344,1 27366,0 27456,1 27482,0 27494,1 27503,0 27523,1 27547,0 27647,1 27662,0 27679,1 27763,0 27814,1 27844,0 27915,1 27967,0 27986,1 28078,0 28128,1 28207,0 28303,1 28308,0 28315,1 28346,0 28353,1 28402,0 28416,1 28497,0 28499,1 28526,0 28561,1 28650,0 28739,1 28750,0 28800,1 28807,0 28887,1 28970,0 29046,1 29144,0 29215,1 29288,0 29313,1 29351,0 29428,1 29527,0 29597,1 29631,0 29675,1 29739,0 29807,1 29846,0 29934,1 30021,0 30088,1 30184,0 30268,1 30353,0 30447,1 30510,0 30530,1 30569,0 30660,1 30729,0 30781,1 30801,0 30896,1 30897,0 30945,1 31013,0 31079,1 31119,0 31130,1 31216,0 31278,1 31370,0 31432,1 31490,0 31514,1 31611,0 31624,1 31642,0 31713,1 31751,0 31787,1 31809,0 31870,1 31957,0 31975,1 32054,0 32094,1 32096,0 32162,1 32212,0 32290,1 32303,0 32332,1 32410,0 32422,1 32487,0 32527,1 32572,0 32584,1 32679,0 32680,1 32716,0 32804,1 32852,0 32884,1 32964,0 33023,1 33095,0 33176,1 33276,0 33309,1 33339,0 33393,1 33487,0 33586,1 33615,0 33650,1 33730,0 33801,1 33838,0 33887,1 33981,0 34041,1 34055,0 34098,1 34139,0 34153,1 34226,0 34273,1 34295,0 34296,1 34316,0 34361,1 34458,0 34558,1 34602,0 34676,1 34704,0 34740,1 34827,0 34875,1 34937,0 35007,1 35032,0 35114,1 35141,0 35154,1 35164,0 35219,1 35312,0 35390,1 35485,0 35489,1 35572,0 35607,1 35612,0 35711,1 35722,0 35736,1 35814,0 35880,1 35907,0 35920,1 35959,0 35960,1 36010,0 36021,1 36024,0 36086,1 36158,0 36228,1 36232,0 36303,1 36365,0 36396,1 36421,0 36471,1 36536,0 36570,1 36620,0 36706,1 36744,0 36795,1 36820,0 36825,1 36895,0 36926,1 36931,0 36990,1 37025,0 37123,1 37164,0 37196,1 37282,0 37291,1 37323,0 37340,1 37343,0 37429,1 37491,0 37525,1 37539,0 37620,1 37711,0 37772,1 37845,0 37863,1 37926,0 37950,1 38011,0 38086,1 38105,0 38169,1 38200,0 38289,1 38331,0 38386,1 38426,0 38509,1 38550,0 38559,1 38594,0 38646,1 38732,0 38797,1 38834,0 38903,1 38906,0 38927,1 38977,0 39071,1 39111,0 39155,1 39211,0 39262,1 39362,0 39446,1 39495,0 39571,1 39654,0 39677,1 39712,0 39774,1 39835,0 39898,1 39933,0 39989,1 40021,0 40099,1 40175,0 40199,1 40272,0 40344,1 40365,0 40446,1 40469,0 40568,1 40605,0 40695,1 40765,0 40792,1 40811,0 40830,1 40919,0 40985,1 41062,0 41071,1 41135,0 41186,1 41284,0 41291,1 41316,0 41341,1 41375,0 41460,1 41533,0 41587,1 41613,0 41618,1 41675,0 41758,1 41805,0 41842,1 41941,0 41961,1 41995,0 42074,1 42173,0 42207,1 42211,0 42244,1 42283,0 42375,1 42452,0 42531,1 42609,0 42690,1 42736,0 42758,1 42767,0 42778,1 42785,0 42849,1 42894,0 42922,1 42992,0 43080,1 43166,0 43194,1 43232,0 43294,1 43332,0 43376,1 43451,0 43486,1 43553,0 43583,1 43657,0 43658,1 43672,0 43746,1 43792,0 43828,1 43835,0 43924,1 43939,0 43951,1 44020,0 44023,1 44075,0 44093,1 44180,0 44211,1 44292,0 44348,1 44397,0 44414,1 44472,0 44548,1 44643,0 44711,1 44721,0 44794,1 44820,0 44854,1 44881,0 44883,1 44936,0 44965,1 45019,0 45103,1 45171,0 45250,1 45278,0 45345,1 45387,0 45414,1 45500,0 45570,1 45586,0 45682,1 45758,0 45767,1 45779,0 45860,1 45894,0 45936,1 45993,0 46072,1 46094,0 46161,1 46162,0 46261,1 46282,0 46287,1 46339,0 46427,1 46508,0 46558,1 46620,0 46720,1 46764,0 46821,1 46892,0 46897,1 46927,0 46973,1 47062,0 47154,1 47190,0 47266,1 47327,0 47361,1 47420,0 47471,1 47501,0 47502,1 47590,0 47628,1 47705,0 47724,1 47738,0 47797,1 47799,0 47866,1 47899,0 47924,1 47998,0 48017,1 48034,0 48087,1 48176,0 48243,1 48278,0 48291,1 48373,0 48440,1 48481,0 48491,1 48549,0 48585,1 48661,0 48751,1 48808,0 48850,1 48880,0 48881,1 48970,0 49058,1 49083,0 49084,1 49106,0 49141,1 49238,0 49284,1 49370,0 49378,1 49381,0 49396,1 49486,0 49539,1 49625,0 49711,1 49805,0 49840,1 49938,0 50010,1 50028,0 50103,1 50141,0 50191,1 50229,0 50309,1 50359,0 50397,1 50474,0 50561,1 50591,0 50607,1 50646,0 50690,1 50742,0 50782,1 50801,0 50883,1 50918,0 50957,1 51037,0 51083,1 51104,0 51180,1 51239,0 51266,1 51271,0 51312,1 51365,0 51394,1 end initlist c5 0,0 62,1 159,0 243,1 246,0 253,1 328,0 423,1 497,0 545,1 600,0 660,1 706,0 789,1 828,0 857,1 916,0 936,1 1029,0 1106,1 1110,0 1166,1 1211,0 1214,1 1287,0 1296,1 1367,0 1448,1 1454,0 1473,1 1529,0 1541,1 1606,0 1691,1 1693,0 1773,1 1807,0 1858,1 1927,0 2015,1 2075,0 2086,1 2166,0 2205,1 2233,0 2307,1 2345,0 2392,1 2443,0 2490,1 2529,0 2570,1 2624,0 2641,1 2691,0 2760,1 2831,0 2878,1 2922,0 3011,1 3067,0 3166,1 3182,0 3199,1 3232,0 3279,1 3298,0 3319,1 3345,0 3379,1 3443,0 3519,1 3526,0 3611,1 3688,0 3695,1 3767,0 3839,1 3864,0 3910,1 3947,0 3948,1 4020,0 4117,1 4191,0 4233,1 4289,0 4389,1 4390,0 4450,1 4538,0 4635,1 4676,0 4690,1 4754,0 4812,1 4826,0 4855,1 4908,0 4949,1 5013,0 5029,1 5128,0 5172,1 5206,0 5266,1 5268,0 5333,1 5426,0 5482,1 5511,0 5526,1 5594,0 5680,1 5689,0 5769,1 5844,0 5905,1 5927,0 6010,1 6055,0 6088,1 6181,0 6245,1 6319,0 6335,1 6421,0 6496,1 6592,0 6621,1 6718,0 6728,1 6762,0 6784,1 6798,0 6809,1 6822,0 6885,1 6976,0 6983,1 6996,0 7090,1 7144,0 7181,1 7270,0 7362,1 7427,0 7446,1 7513,0 7540,1 7606,0 7646,1 7659,0 7745,1 7771,0 7779,1 7873,0 7894,1 7908,0 7989,1 8030,0 8075,1 8109,0 8137,1 8207,0 8209,1 8222,0 8291,1 8350,0 8390,1 8401,0 8486,1 8521,0 8533,1 8616,0 8709,1 8777,0 8819,1 8871,0 8956,1 9052,0 9081,1 9147,0 9193,1 9288,0 9365,1 9373,0 9415,1 9515,0 9609,1 9701,0 9759,1 9797,0 9804,1 9902,0 9941,1 9979,0 10007,1 10075,0 10168,1 10266,0 10348,1 10357,0 10374,1 10379,0 10406,1 10482,0 10534,1 10580,0 10583,1 10643,0 10734,1 10759,0 10845,1 10859,0 10911,1 11006,0 11072,1 11091,0 11150,1 11247,0 11275,1 11336,0 11395,1 11405,0 11483,1 11511,0 11529,1 11615,0 11693,1 11789,0 11879,1 11905,0 11950,1 11990,0 12062,1 12071,0 12144,1 12147,0 12154,1 12209,0 12308,1 12359,0 12438,1 12463,0 12498,1 12584,0 12646,1 12734,0 12738,1 12828,0 12862,1 12879,0 12914,1 12929,0 13012,1 13025,0 13118,1 13190,0 13271,1 13301,0 13361,1 13428,0 13446,1 13487,0 13506,1 13599,0 13691,1 13760,0 13836,1 13918,0 14013,1 14075,0 14159,1 14190,0 14248,1 14259,0 14358,1 14415,0 14426,1 14502,0 14590,1 14627,0 14707,1 14750,0 14768,1 14836,0 14899,1 14978,0 15053,1 15145,0 15213,1 15227,0 15247,1 15346,0 15382,1 15452,0 15536,1 15620,0 15624,1 15692,0 15727,1 15772,0 15842,1 15921,0 15941,1 15992,0 16038,1 16126,0 16180,1 16202,0 16204,1 16270,0 16309,1 16383,0 16402,1 16407,0 16475,1 16574,0 16593,1 16654,0 16743,1 16758,0 16803,1 16893,0 16988,1 17059,0 17093,1 17159,0 17175,1 17235,0 17293,1 17367,0 17412,1 17423,0 17474,1 17571,0 17584,1 17656,0 17708,1 17749,0 17820,1 17899,0 17940,1 17970,0 18011,1 18078,0 18088,1 18174,0 18213,1 18215,0 18247,1 18264,0 18335,1 18418,0 18498,1 18587,0 18629,1 18656,0 18749,1 18751,0 18833,1 18896,0 18950,1 19045,0 19077,1 19168,0 19193,1 19282,0 19333,1 19398,0 19451,1 19482,0 19543,1 19551,0 19575,1 19587,0 19597,1 19673,0 19760,1 19856,0 19897,1 19910,0 19990,1 20083,0 20176,1 20232,0 20274,1 20279,0 20300,1 20302,0 20317,1 20352,0 20435,1 20443,0 20451,1 20481,0 20510,1 20599,0 20632,1 20665,0 20671,1 20744,0 20771,1 20814,0 20901,1 20913,0 20953,1 21052,0 21076,1 21101,0 21157,1 21217,0 21233,1 21283,0 21369,1 21418,0 21426,1 21431,0 21506,1 21570,0 21621,1 21657,0 21750,1 21817,0 21910,1 21927,0 22022,1 22076,0 22130,1 22178,0 22179,1 22185,0 22222,1 22227,0 22305,1 22338,0 22428,1 22489,0 22498,1 22540,0 22616,1 22683,0 22689,1 22755,0 22789,1 22810,0 22855,1 22942,0 22969,1 23035,0 23120,1 23139,0 23148,1 23160,0 23212,1 23283,0 23317,1 23387,0 23418,1 23419,0 23460,1 23544,0 23604,1 23608,0 23660,1 23664,0 23672,1 23705,0 23784,1 23873,0 23913,1 23960,0 24052,1 24135,0 24207,1 24238,0 24309,1 24365,0 24416,1 24433,0 24511,1 24592,0 24602,1 24623,0 24649,1 24723,0 24744,1 24768,0 24821,1 24835,0 24875,1 24946,0 25019,1 25086,0 25093,1 25113,0 25188,1 25221,0 25307,1 25358,0 25384,1 25481,0 25512,1 25523,0 25597,1 25661,0 25676,1 25711,0 25712,1 25804,0 25807,1 25831,0 25923,1 26019,0 26023,1 26036,0 26037,1 26117,0 26200,1 26298,0 26337,1 26424,0 26479,1 26525,0 26581,1 26674,0 26731,1 26791,0 26864,1 26904,0 26971,1 26998,0 27031,1 27046,0 27126,1 27159,0 27168,1 27202,0 27262,1 27324,0 27402,1 27495,0 27515,1 27593,0 27677,1 27732,0 27734,1 27745,0 27771,1 27803,0 27854,1 27911,0 27950,1 28046,0 28048,1 28079,0 28086,1 28181,0 28219,1 28233,0 28317,1 28363,0 28371,1 28460,0 28469,1 28533,0 28577,1 28636,0 28732,1 28786,0 28828,1 28837,0 28868,1 28892,0 28913,1 28955,0 29001,1 29041,0 29138,1 29238,0 29269,1 29301,0 29332,1 29348,0 29358,1 29372,0 29395,1 29482,0 29563,1 29617,0 29694,1 29748,0 29758,1 29761,0 29786,1 29850,0 29857,1 29932,0 29941,1 29957,0 30002,1 30073,0 30081,1 30094,0 30135,1 30185,0 30215,1 30234,0 30274,1 30290,0 30385,1 30400,0 30422,1 30449,0 30451,1 30456,0 30530,1 30567,0 30646,1 30657,0 30659,1 30702,0 30721,1 30730,0 30735,1 30815,0 30875,1 30964,0 31042,1 31053,0 31054,1 31126,0 31218,1 31257,0 31299,1 31333,0 31376,1 31377,0 31412,1 31422,0 31431,1 31450,0 31545,1 31594,0 31660,1 31739,0 31823,1 31916,0 31924,1 31970,0 32062,1 32157,0 32207,1 32283,0 32337,1 32385,0 32418,1 32441,0 32521,1 32592,0 32677,1 32727,0 32744,1 32826,0 32912,1 33007,0 33042,1 33105,0 33203,1 33253,0 33326,1 33423,0 33502,1 33547,0 33581,1 33612,0 33659,1 33670,0 33698,1 33718,0 33757,1 33795,0 33863,1 33894,0 33933,1 34019,0 34082,1 34126,0 34146,1 34182,0 34267,1 34322,0 34353,1 34422,0 34515,1 34585,0 34679,1 34684,0 34756,1 34839,0 34937,1 35006,0 35080,1 35119,0 35209,1 35300,0 35361,1 35400,0 35477,1 35570,0 35658,1 35745,0 35818,1 35885,0 35942,1 35948,0 35999,1 36005,0 36082,1 36134,0 36209,1 36247,0 36303,1 36341,0 36390,1 36468,0 36555,1 36645,0 36717,1 36771,0 36849,1 36903,0 36945,1 37036,0 37062,1 37067,0 37068,1 37157,0 37236,1 37321,0 37403,1 37503,0 37524,1 37576,0 37599,1 37640,0 37738,1 37770,0 37840,1 37925,0 37985,1 38050,0 38055,1 38096,0 38105,1 38195,0 38203,1 38273,0 38286,1 38309,0 38374,1 38396,0 38470,1 38531,0 38570,1 38614,0 38714,1 38721,0 38764,1 38857,0 38868,1 38897,0 38928,1 39028,0 39095,1 39184,0 39266,1 39300,0 39397,1 39464,0 39530,1 39535,0 39627,1 39711,0 39806,1 39815,0 39898,1 39923,0 40000,1 40020,0 40094,1 40147,0 40208,1 40302,0 40395,1 40462,0 40545,1 40555,0 40558,1 40629,0 40664,1 40727,0 40764,1 40835,0 40892,1 40923,0 40976,1 41028,0 41115,1 41178,0 41270,1 41347,0 41424,1 41456,0 41546,1 41604,0 41699,1 41726,0 41765,1 41834,0 41841,1 41925,0 41978,1 42063,0 42143,1 42202,0 42203,1 42249,0 42306,1 42341,0 42420,1 42435,0 42482,1 42579,0 42636,1 42699,0 42706,1 42802,0 42879,1 42975,0 43007,1 43077,0 43127,1 43218,0 43263,1 43328,0 43351,1 43406,0 43466,1 43528,0 43624,1 43717,0 43789,1 43854,0 43859,1 43895,0 43913,1 43958,0 44045,1 44059,0 44074,1 44150,0 44193,1 44258,0 44291,1 44359,0 44377,1 44388,0 44474,1 44520,0 44547,1 44556,0 44622,1 44690,0 44742,1 44826,0 44877,1 44903,0 44965,1 45054,0 45147,1 45179,0 45249,1 45279,0 45301,1 45377,0 45387,1 45452,0 45474,1 45510,0 45563,1 45603,0 45683,1 45783,0 45856,1 45924,0 45930,1 46029,0 46105,1 46194,0 46235,1 46327,0 46396,1 46398,0 46445,1 46544,0 46556,1 46615,0 46616,1 46657,0 46683,1 46764,0 46821,1 46878,0 46939,1 47000,0 47005,1 47063,0 47076,1 47161,0 47187,1 47219,0 47290,1 47351,0 47379,1 47386,0 47399,1 47449,0 47534,1 47581,0 47599,1 47641,0 47662,1 47758,0 47827,1 47831,0 47912,1 47964,0 48038,1 48109,0 48117,1 48185,0 48256,1 48338,0 48419,1 48452,0 48482,1 48574,0 48671,1 48676,0 48712,1 48722,0 48733,1 48824,0 48871,1 48932,0 49021,1 49046,0 49105,1 49180,0 49262,1 49291,0 49303,1 49314,0 49408,1 49496,0 49589,1 49609,0 49618,1 49711,0 49771,1 49798,0 49831,1 49843,0 49906,1 49924,0 49953,1 50032,0 50064,1 50151,0 50246,1 50290,0 50372,1 50450,0 50479,1 50484,0 50527,1 50603,0 50632,1 50642,0 50681,1 50722,0 50784,1 50837,0 50866,1 50898,0 50928,1 51002,0 51036,1 51130,0 51219,1 end initlist c6 0,0 58,1 138,0 179,1 197,0 283,1 378,0 391,1 466,0 471,1 510,0 512,1 535,0 559,1 657,0 677,1 729,0 803,1 813,0 859,1 914,0 942,1 1018,0 1100,1 1147,0 1237,1 1325,0 1393,1 1437,0 1499,1 1517,0 1546,1 1563,0 1615,1 1715,0 1783,1 1855,0 1918,1 2018,0 2039,1 2072,0 2130,1 2149,0 2222,1 2226,0 2276,1 2312,0 2411,1 2500,0 2599,1 2685,0 2783,1 2879,0 2925,1 2986,0 2990,1 3073,0 3126,1 3196,0 3208,1 3215,0 3289,1 3328,0 3349,1 3398,0 3415,1 3494,0 3576,1 3639,0 3715,1 3813,0 3851,1 3947,0 4040,1 4042,0 4043,1 4085,0 4115,1 4187,0 4277,1 4292,0 4367,1 4460,0 4546,1 4555,0 4643,1 4732,0 4759,1 4821,0 4838,1 4896,0 4921,1 4928,0 5017,1 5092,0 5134,1 5199,0 5203,1 5247,0 5288,1 5338,0 5437,1 5473,0 5504,1 5533,0 5543,1 5643,0 5738,1 5804,0 5883,1 5914,0 5955,1 6036,0 6051,1 6057,0 6096,1 6155,0 6177,1 6196,0 6263,1 6266,0 6313,1 6360,0 6401,1 6499,0 6565,1 6591,0 6632,1 6653,0 6665,1 6720,0 6814,1 6838,0 6921,1 6993,0 7031,1 7100,0 7124,1 7146,0 7161,1 7251,0 7270,1 7327,0 7395,1 7427,0 7488,1 7506,0 7595,1 7623,0 7719,1 7808,0 7824,1 7906,0 7970,1 8045,0 8050,1 8126,0 8216,1 8253,0 8351,1 8407,0 8441,1 8442,0 8518,1 8614,0 8690,1 8739,0 8828,1 8913,0 8917,1 8955,0 9017,1 9048,0 9091,1 9183,0 9215,1 9217,0 9248,1 9329,0 9426,1 9523,0 9531,1 9587,0 9652,1 9685,0 9704,1 9736,0 9828,1 9887,0 9898,1 9942,0 10028,1 10109,0 10176,1 10255,0 10297,1 10384,0 10476,1 10478,0 10572,1 10613,0 10647,1 10685,0 10764,1 10815,0 10893,1 10907,0 10957,1 10981,0 11035,1 11076,0 11135,1 11187,0 11221,1 11224,0 11253,1 11338,0 11352,1 11437,0 11474,1 11565,0 11663,1 11670,0 11760,1 11787,0 11820,1 11829,0 11922,1 11985,0 12049,1 12123,0 12186,1 12203,0 12259,1 12297,0 12392,1 12435,0 12441,1 12503,0 12590,1 12600,0 12636,1 12681,0 12692,1 12760,0 12838,1 12888,0 12895,1 12975,0 12989,1 13065,0 13131,1 13170,0 13257,1 13317,0 13358,1 13427,0 13489,1 13529,0 13566,1 13644,0 13696,1 13746,0 13828,1 13863,0 13888,1 13977,0 14053,1 14105,0 14199,1 14235,0 14323,1 14375,0 14397,1 14444,0 14455,1 14475,0 14559,1 14605,0 14656,1 14680,0 14700,1 14749,0 14778,1 14810,0 14860,1 14908,0 14909,1 14920,0 15000,1 15079,0 15122,1 15187,0 15217,1 15219,0 15238,1 15284,0 15332,1 15356,0 15387,1 15425,0 15491,1 15571,0 15653,1 15742,0 15825,1 15912,0 15939,1 16001,0 16075,1 16144,0 16211,1 16226,0 16258,1 16297,0 16325,1 16405,0 16454,1 16544,0 16602,1 16657,0 16728,1 16741,0 16774,1 16797,0 16823,1 16889,0 16989,1 17007,0 17049,1 17057,0 17065,1 17134,0 17232,1 17267,0 17300,1 17395,0 17396,1 17461,0 17558,1 17599,0 17647,1 17735,0 17760,1 17768,0 17830,1 17920,0 17987,1 18025,0 18038,1 18061,0 18142,1 18159,0 18197,1 18264,0 18332,1 18390,0 18439,1 18445,0 18544,1 18629,0 18696,1 18733,0 18791,1 18859,0 18910,1 18995,0 19054,1 19090,0 19169,1 19256,0 19353,1 19432,0 19532,1 19587,0 19588,1 19649,0 19702,1 19747,0 19817,1 19869,0 19876,1 19942,0 20024,1 20062,0 20093,1 20133,0 20195,1 20221,0 20281,1 20312,0 20324,1 20326,0 20408,1 20436,0 20523,1 20593,0 20615,1 20676,0 20774,1 20820,0 20865,1 20878,0 20952,1 21033,0 21041,1 21086,0 21116,1 21122,0 21157,1 21215,0 21258,1 21307,0 21327,1 21400,0 21438,1 21475,0 21561,1 21639,0 21738,1 21764,0 21801,1 21890,0 21925,1 21976,0 22053,1 22117,0 22187,1 22238,0 22282,1 22329,0 22377,1 22451,0 22541,1 22609,0 22708,1 22735,0 22771,1 22799,0 22888,1 22901,0 22991,1 23064,0 23160,1 23167,0 23205,1 23215,0 23230,1 23293,0 23319,1 23359,0 23438,1 23525,0 23606,1 23622,0 23649,1 23713,0 23736,1 23765,0 23822,1 23889,0 23980,1 24019,0 24063,1 24108,0 24198,1 24261,0 24341,1 24416,0 24420,1 24519,0 24607,1 24682,0 24741,1 24775,0 24779,1 24852,0 24899,1 24909,0 24968,1 25049,0 25118,1 25203,0 25267,1 25280,0 25293,1 25355,0 25439,1 25533,0 25539,1 25632,0 25676,1 25723,0 25762,1 25776,0 25796,1 25889,0 25960,1 26035,0 26122,1 26177,0 26257,1 26278,0 26279,1 26359,0 26415,1 26472,0 26509,1 26567,0 26581,1 26635,0 26726,1 26791,0 26796,1 26848,0 26896,1 26922,0 26942,1 27012,0 27103,1 27200,0 27276,1 27372,0 27405,1 27418,0 27452,1 27490,0 27588,1 27608,0 27661,1 27696,0 27745,1 27818,0 27852,1 27895,0 27987,1 28001,0 28020,1 28060,0 28084,1 28165,0 28166,1 28205,0 28262,1 28290,0 28365,1 28443,0 28476,1 28535,0 28618,1 28658,0 28746,1 28812,0 28883,1 28963,0 29014,1 29067,0 29079,1 29175,0 29241,1 29252,0 29284,1 29365,0 29424,1 29428,0 29442,1 29472,0 29563,1 29610,0 29681,1 29704,0 29791,1 29880,0 29937,1 30003,0 30094,1 30137,0 30157,1 30246,0 30282,1 30331,0 30391,1 30425,0 30438,1 30516,0 30587,1 30600,0 30673,1 30681,0 30704,1 30764,0 30852,1 30927,0 30981,1 30994,0 31037,1 31137,0 31223,1 31274,0 31334,1 31379,0 31402,1 31495,0 31501,1 31526,0 31568,1 31578,0 31615,1 31631,0 31668,1 31708,0 31791,1 31870,0 31920,1 31993,0 32054,1 32151,0 32166,1 32229,0 32315,1 32345,0 32365,1 32432,0 32526,1 32586,0 32601,1 32618,0 32671,1 32753,0 32848,1 32849,0 32861,1 32932,0 33011,1 33056,0 33119,1 33198,0 33225,1 33241,0 33313,1 33361,0 33454,1 33481,0 33530,1 33556,0 33563,1 33639,0 33653,1 33725,0 33781,1 33855,0 33925,1 33963,0 33999,1 34053,0 34061,1 34140,0 34200,1 34288,0 34299,1 34347,0 34438,1 34506,0 34522,1 34536,0 34625,1 34698,0 34705,1 34785,0 34814,1 34895,0 34990,1 35032,0 35093,1 35136,0 35221,1 35275,0 35322,1 35411,0 35509,1 35521,0 35596,1 35675,0 35694,1 35748,0 35779,1 35869,0 35926,1 35933,0 35938,1 35962,0 36037,1 36104,0 36176,1 36210,0 36269,1 36365,0 36465,1 36495,0 36593,1 36659,0 36682,1 36737,0 36759,1 36765,0 36767,1 36781,0 36862,1 36869,0 36958,1 37014,0 37113,1 37162,0 37194,1 37217,0 37288,1 37323,0 37364,1 37426,0 37436,1 37437,0 37494,1 37517,0 37588,1 37678,0 37777,1 37808,0 37901,1 37922,0 37980,1 37994,0 38079,1 38091,0 38177,1 38202,0 38237,1 38336,0 38412,1 38484,0 38508,1 38564,0 38565,1 38641,0 38653,1 38720,0 38799,1 38819,0 38904,1 38990,0 39064,1 39137,0 39143,1 39227,0 39290,1 39329,0 39365,1 39404,0 39428,1 39444,0 39480,1 39574,0 39578,1 39601,0 39648,1 39668,0 39686,1 39714,0 39762,1 39828,0 39926,1 39936,0 40027,1 40073,0 40150,1 40162,0 40216,1 40251,0 40257,1 40275,0 40296,1 40362,0 40380,1 40461,0 40472,1 40527,0 40572,1 40623,0 40647,1 40669,0 40757,1 40771,0 40834,1 40911,0 40939,1 40971,0 41048,1 41120,0 41217,1 41260,0 41278,1 41308,0 41323,1 41399,0 41434,1 41525,0 41539,1 41617,0 41712,1 41713,0 41771,1 41779,0 41859,1 41935,0 41943,1 41992,0 42054,1 42112,0 42194,1 42287,0 42319,1 42344,0 42376,1 42450,0 42496,1 42526,0 42536,1 42580,0 42608,1 42659,0 42671,1 42679,0 42759,1 42822,0 42865,1 42911,0 42918,1 42987,0 43018,1 43093,0 43164,1 43247,0 43320,1 43343,0 43372,1 43415,0 43503,1 43554,0 43593,1 43672,0 43731,1 43817,0 43900,1 43925,0 44011,1 44105,0 44194,1 44271,0 44290,1 44354,0 44452,1 44465,0 44491,1 44509,0 44535,1 44548,0 44560,1 44598,0 44669,1 44741,0 44816,1 44836,0 44838,1 44868,0 44962,1 45060,0 45159,1 45242,0 45275,1 45349,0 45373,1 45385,0 45459,1 45502,0 45537,1 45619,0 45682,1 45742,0 45751,1 45809,0 45817,1 45860,0 45942,1 45983,0 46003,1 46057,0 46061,1 46079,0 46156,1 46163,0 46218,1 46270,0 46347,1 46351,0 46447,1 46521,0 46536,1 46553,0 46617,1 46678,0 46758,1 46836,0 46927,1 46963,0 46978,1 47047,0 47084,1 47141,0 47172,1 47221,0 47231,1 47242,0 47298,1 47340,0 47402,1 47438,0 47501,1 47584,0 47647,1 47713,0 47746,1 47821,0 47915,1 47931,0 48024,1 48083,0 48145,1 48198,0 48282,1 48288,0 48378,1 48406,0 48412,1 48472,0 48558,1 48626,0 48704,1 48735,0 48753,1 48852,0 48944,1 48999,0 49005,1 49040,0 49051,1 49131,0 49194,1 49293,0 49365,1 49462,0 49481,1 49535,0 49539,1 49587,0 49597,1 49627,0 49725,1 49774,0 49775,1 49809,0 49851,1 49887,0 49960,1 50020,0 50038,1 50107,0 50133,1 50169,0 50248,1 50281,0 50309,1 50377,0 50421,1 50493,0 50533,1 50620,0 50702,1 50789,0 50828,1 50880,0 50969,1 50988,0 51059,1 51139,0 51165,1 51228,0 51314,1 51377,0 51437,1 51498,0 51512,1 51601,0 51634,1 end initlist c7 0,0 56,1 91,0 157,1 253,0 279,1 377,0 394,1 483,0 538,1 638,0 660,1 700,0 701,1 744,0 803,1 829,0 871,1 916,0 957,1 1006,0 1055,1 1078,0 1120,1 1130,0 1157,1 1231,0 1266,1 1330,0 1369,1 1452,0 1539,1 1576,0 1614,1 1636,0 1645,1 1682,0 1780,1 1856,0 1950,1 2016,0 2113,1 2183,0 2222,1 2259,0 2277,1 2376,0 2464,1 2556,0 2585,1 2607,0 2689,1 2762,0 2839,1 2915,0 2989,1 3088,0 3171,1 3267,0 3289,1 3320,0 3419,1 3488,0 3523,1 3597,0 3657,1 3710,0 3795,1 3855,0 3931,1 3966,0 4052,1 4072,0 4156,1 4174,0 4181,1 4222,0 4281,1 4326,0 4369,1 4424,0 4490,1 4558,0 4652,1 4691,0 4727,1 4742,0 4816,1 4916,0 4983,1 5064,0 5113,1 5185,0 5281,1 5368,0 5395,1 5435,0 5526,1 5595,0 5617,1 5632,0 5633,1 5719,0 5816,1 5876,0 5960,1 6032,0 6078,1 6117,0 6190,1 6260,0 6311,1 6312,0 6366,1 6398,0 6468,1 6559,0 6583,1 6644,0 6726,1 6747,0 6843,1 6940,0 6986,1 7026,0 7103,1 7197,0 7250,1 7258,0 7278,1 7315,0 7349,1 7391,0 7395,1 7397,0 7424,1 7510,0 7590,1 7614,0 7713,1 7745,0 7833,1 7901,0 8001,1 8018,0 8020,1 8109,0 8140,1 8157,0 8218,1 8249,0 8299,1 8364,0 8405,1 8425,0 8517,1 8540,0 8611,1 8665,0 8677,1 8734,0 8821,1 8875,0 8969,1 9012,0 9099,1 9176,0 9188,1 9246,0 9306,1 9314,0 9367,1 9417,0 9462,1 9536,0 9607,1 9629,0 9701,1 9739,0 9768,1 9838,0 9857,1 9912,0 9966,1 10016,0 10056,1 10142,0 10165,1 10194,0 10276,1 10298,0 10379,1 10453,0 10507,1 10511,0 10578,1 10677,0 10697,1 10757,0 10784,1 10793,0 10849,1 10853,0 10886,1 10958,0 11008,1 11058,0 11119,1 11219,0 11315,1 11394,0 11417,1 11471,0 11556,1 11558,0 11563,1 11632,0 11718,1 11812,0 11840,1 11856,0 11862,1 11957,0 12049,1 12132,0 12214,1 12232,0 12290,1 12295,0 12376,1 12412,0 12422,1 12462,0 12466,1 12558,0 12582,1 12604,0 12690,1 12766,0 12794,1 12877,0 12894,1 12908,0 12916,1 12973,0 12976,1 13036,0 13131,1 13216,0 13274,1 13365,0 13367,1 13379,0 13438,1 13528,0 13594,1 13634,0 13681,1 13761,0 13781,1 13830,0 13836,1 13912,0 13965,1 14019,0 14074,1 14103,0 14166,1 14245,0 14292,1 14362,0 14383,1 14414,0 14512,1 14543,0 14562,1 14609,0 14647,1 14681,0 14731,1 14797,0 14832,1 14927,0 15027,1 15103,0 15127,1 15214,0 15266,1 15327,0 15386,1 15432,0 15510,1 15610,0 15699,1 15728,0 15743,1 15814,0 15815,1 15906,0 15971,1 16029,0 16063,1 16080,0 16124,1 16186,0 16247,1 16253,0 16337,1 16350,0 16377,1 16468,0 16483,1 16527,0 16568,1 16583,0 16619,1 16676,0 16686,1 16783,0 16809,1 16829,0 16856,1 16860,0 16872,1 16924,0 17014,1 17112,0 17118,1 17204,0 17260,1 17283,0 17296,1 17396,0 17468,1 17509,0 17607,1 17685,0 17776,1 17870,0 17924,1 18000,0 18053,1 18072,0 18114,1 18149,0 18229,1 18232,0 18321,1 18414,0 18452,1 18550,0 18639,1 18704,0 18722,1 18761,0 18819,1 18892,0 18982,1 19022,0 19103,1 19115,0 19170,1 19231,0 19318,1 19362,0 19446,1 19512,0 19571,1 19618,0 19683,1 19719,0 19801,1 19836,0 19933,1 19979,0 19995,1 20058,0 20062,1 20063,0 20117,1 20216,0 20237,1 20330,0 20364,1 20384,0 20452,1 20510,0 20577,1 20583,0 20637,1 20697,0 20714,1 20768,0 20771,1 20833,0 20887,1 20888,0 20980,1 21012,0 21043,1 21116,0 21169,1 21213,0 21292,1 21380,0 21405,1 21467,0 21546,1 21597,0 21657,1 21679,0 21776,1 21780,0 21872,1 21908,0 21914,1 22013,0 22102,1 22104,0 22183,1 22264,0 22312,1 22345,0 22439,1 22515,0 22553,1 22556,0 22654,1 22659,0 22736,1 22835,0 22873,1 22898,0 22943,1 22967,0 22984,1 23078,0 23124,1 23128,0 23225,1 23250,0 23334,1 23358,0 23416,1 23488,0 23499,1 23583,0 23612,1 23614,0 23633,1 23659,0 23722,1 23795,0 23853,1 23860,0 23919,1 24019,0 24077,1 24170,0 24179,1 24259,0 24315,1 24318,0 24410,1 24470,0 24511,1 24573,0 24589,1 24590,0 24689,1 24734,0 24755,1 24826,0 24893,1 24918,0 24974,1 25054,0 25077,1 25095,0 25131,1 25161,0 25236,1 25303,0 25364,1 25443,0 25503,1 25548,0 25645,1 25737,0 25786,1 25833,0 25848,1 25923,0 25949,1 25952,0 26049,1 26142,0 26214,1 26257,0 26321,1 26333,0 26362,1 26407,0 26495,1 26509,0 26574,1 26577,0 26619,1 26689,0 26694,1 26770,0 26823,1 26902,0 26952,1 27026,0 27034,1 27066,0 27164,1 27208,0 27290,1 27378,0 27462,1 27543,0 27619,1 27632,0 27655,1 27732,0 27762,1 27832,0 27924,1 27974,0 28011,1 28046,0 28120,1 28126,0 28156,1 28205,0 28292,1 28330,0 28390,1 28448,0 28495,1 28568,0 28661,1 28708,0 28717,1 28751,0 28801,1 28837,0 28850,1 28944,0 28983,1 28985,0 29000,1 29064,0 29073,1 29084,0 29136,1 29145,0 29205,1 29295,0 29384,1 29470,0 29515,1 29566,0 29614,1 29705,0 29710,1 29798,0 29823,1 29866,0 29908,1 29939,0 29976,1 30003,0 30010,1 30042,0 30074,1 30127,0 30165,1 30215,0 30293,1 30308,0 30387,1 30457,0 30504,1 30590,0 30677,1 30693,0 30716,1 30746,0 30785,1 30805,0 30871,1 30942,0 31016,1 31089,0 31129,1 31175,0 31221,1 31293,0 31353,1 31390,0 31416,1 31499,0 31572,1 31636,0 31675,1 31710,0 31762,1 31802,0 31829,1 31901,0 31983,1 32008,0 32062,1 32146,0 32148,1 32244,0 32308,1 32321,0 32382,1 32425,0 32461,1 32526,0 32582,1 32655,0 32712,1 32744,0 32843,1 32924,0 32957,1 33042,0 33052,1 33053,0 33056,1 33105,0 33181,1 33220,0 33260,1 33312,0 33353,1 33388,0 33430,1 33518,0 33538,1 33539,0 33614,1 33676,0 33726,1 33776,0 33854,1 33894,0 33927,1 33934,0 33978,1 34014,0 34108,1 34115,0 34159,1 34198,0 34238,1 34300,0 34377,1 34411,0 34473,1 34553,0 34632,1 34712,0 34751,1 34784,0 34870,1 34951,0 35050,1 35102,0 35154,1 35173,0 35212,1 35277,0 35337,1 35434,0 35492,1 35512,0 35583,1 35667,0 35698,1 35703,0 35725,1 35785,0 35808,1 35878,0 35882,1 35965,0 36005,1 36066,0 36099,1 36144,0 36177,1 36251,0 36330,1 36337,0 36408,1 36472,0 36529,1 36537,0 36616,1 36679,0 36691,1 36714,0 36799,1 36852,0 36891,1 36946,0 37027,1 37053,0 37149,1 37233,0 37319,1 37385,0 37407,1 37409,0 37476,1 37523,0 37534,1 37539,0 37588,1 37596,0 37616,1 37630,0 37652,1 37713,0 37769,1 37823,0 37900,1 37977,0 37994,1 38005,0 38028,1 38116,0 38133,1 38143,0 38145,1 38166,0 38253,1 38301,0 38384,1 38411,0 38452,1 38457,0 38491,1 38568,0 38605,1 38626,0 38651,1 38694,0 38769,1 38774,0 38867,1 38876,0 38951,1 39020,0 39116,1 39134,0 39184,1 39221,0 39254,1 39298,0 39354,1 39396,0 39427,1 39464,0 39479,1 39577,0 39612,1 39645,0 39668,1 39718,0 39817,1 39841,0 39870,1 39906,0 39911,1 39955,0 39999,1 40035,0 40078,1 40178,0 40237,1 40263,0 40353,1 40423,0 40430,1 40530,0 40585,1 40666,0 40709,1 40720,0 40819,1 40865,0 40900,1 40935,0 40973,1 41029,0 41068,1 41160,0 41252,1 41337,0 41362,1 41456,0 41477,1 41512,0 41559,1 41599,0 41678,1 41726,0 41796,1 41832,0 41833,1 41864,0 41894,1 41963,0 42025,1 42102,0 42195,1 42285,0 42326,1 42411,0 42482,1 42488,0 42516,1 42583,0 42671,1 42753,0 42790,1 42809,0 42904,1 43004,0 43006,1 43007,0 43029,1 43043,0 43079,1 43156,0 43205,1 43246,0 43300,1 43347,0 43386,1 43472,0 43550,1 43585,0 43589,1 43680,0 43742,1 43825,0 43896,1 43917,0 43939,1 43997,0 44030,1 44036,0 44046,1 44112,0 44145,1 44181,0 44270,1 44297,0 44367,1 44435,0 44465,1 44544,0 44644,1 44704,0 44779,1 44799,0 44884,1 44947,0 45029,1 45100,0 45160,1 45254,0 45292,1 45335,0 45357,1 45388,0 45472,1 45532,0 45603,1 45681,0 45701,1 45792,0 45838,1 45862,0 45871,1 45930,0 45970,1 46059,0 46157,1 46218,0 46314,1 46373,0 46470,1 46477,0 46548,1 46613,0 46639,1 46684,0 46685,1 46778,0 46801,1 46870,0 46955,1 47011,0 47097,1 47133,0 47154,1 47166,0 47169,1 47223,0 47269,1 47289,0 47306,1 47359,0 47369,1 47383,0 47427,1 47512,0 47609,1 47679,0 47743,1 47769,0 47802,1 47853,0 47903,1 47921,0 47999,1 48082,0 48131,1 48210,0 48279,1 48292,0 48351,1 48394,0 48400,1 48475,0 48522,1 48611,0 48648,1 48729,0 48824,1 48920,0 48966,1 49032,0 49130,1 49132,0 49148,1 49229,0 49288,1 49374,0 49421,1 49443,0 49543,1 49607,0 49618,1 49691,0 49729,1 49754,0 49803,1 49880,0 49942,1 49974,0 50069,1 50115,0 50148,1 50183,0 50213,1 50267,0 50288,1 50384,0 50385,1 50408,0 50485,1 50513,0 50595,1 50629,0 50709,1 50730,0 50787,1 50817,0 50848,1 50900,0 50922,1 51019,0 51054,1 51104,0 51188,1 51249,0 51289,1 51385,0 51473,1 51558,0 51578,1 end outputs s0, s1, s2, s3, s4, s5, s6, s7 t0, t1, t2, t3, t4, t5, t6, t7 end outvalues s0 1, s1 1, s2 1, s3 1, s4 1, s5 1, s6 1, s7 1, t0 1, t1 1, t2 1, t3 1, t4 1, t5 1, t6 1, t7 1, end netlist inv(a0n,a0)#4 inv(b0n,b0)#4 inv(c0n,c0)#4 and2(a0nb0n,a0n,b0n)#2 and2(a0nb0,a0n,b0)#2 and2(a0b0n,a0,b0n)#2 and2(a0b0,a0,b0)#3 and2(a0b0c0,a0b0,c0)#2 and2(a0nb0nc0,a0nb0n,c0)#2 and2(a0nb0c0n,a0nb0,c0n)#2 and2(a0b0nc0n,a0b0n,c0n)#2 and2(b0c0,b0,c0)#2 and2(a0c0,c0,a0)#2 or2(s0w42,a0b0nc0n,a0nb0c0n)#3 or2(s0w71,a0b0c0, a0nb0nc0)#3 or2(s0,s0w42,s0w71)#3 or2(s0w35, b0c0, a0c0)#3 or2(t0,s0w35,a0b0)#5 end netlist inv(a1n,a1)#4 inv(b1n,b1)#4 inv(c1n,c1)#4 and2(a1nb1n,a1n,b1n)#2 and2(a1nb1,a1n,b1)#2 and2(a1b1n,a1,b1n)#2 and2(a1b1,a1,b1)#3 and2(a1b1c1,a1b1,c1)#2 and2(a1nb1nc1,a1nb1n,c1)#2 and2(a1nb1c1n,a1nb1,c1n)#2 and2(a1b1nc1n,a1b1n,c1n)#2 and2(b1c1,b1,c1)#2 and2(a1c1,c1,a1)#2 or2(s1w42,a1b1nc1n,a1nb1c1n)#3 or2(s1w71,a1b1c1, a1nb1nc1)#3 or2(s1,s1w42,s1w71)#3 or2(s1w35, b1c1, a1c1)#3 or2(t1,s1w35,a1b1)#5 end netlist inv(a2n,a2)#4 inv(b2n,b2)#4 inv(c2n,c2)#4 and2(a2nb2n,a2n,b2n)#2 and2(a2nb2,a2n,b2)#2 and2(a2b2n,a2,b2n)#2 and2(a2b2,a2,b2)#3 and2(a2b2c2,a2b2,c2)#2 and2(a2nb2nc2,a2nb2n,c2)#2 and2(a2nb2c2n,a2nb2,c2n)#2 and2(a2b2nc2n,a2b2n,c2n)#2 and2(b2c2,b2,c2)#2 and2(a2c2,c2,a2)#2 or2(s2w42,a2b2nc2n,a2nb2c2n)#3 or2(s2w71,a2b2c2, a2nb2nc2)#3 or2(s2,s2w42,s2w71)#3 or2(s2w35, b2c2, a2c2)#3 or2(t2,s2w35,a2b2)#5 end netlist inv(a3n,a3)#4 inv(b3n,b3)#4 inv(c3n,c3)#4 and2(a3nb3n,a3n,b3n)#2 and2(a3nb3,a3n,b3)#2 and2(a3b3n,a3,b3n)#2 and2(a3b3,a3,b3)#3 and2(a3b3c3,a3b3,c3)#2 and2(a3nb3nc3,a3nb3n,c3)#2 and2(a3nb3c3n,a3nb3,c3n)#2 and2(a3b3nc3n,a3b3n,c3n)#2 and2(b3c3,b3,c3)#2 and2(a3c3,c3,a3)#2 or2(s3w42,a3b3nc3n,a3nb3c3n)#3 or2(s3w71,a3b3c3, a3nb3nc3)#3 or2(s3,s3w42,s3w71)#3 or2(s3w35, b3c3, a3c3)#3 or2(t3,s3w35,a3b3)#5 end netlist inv(a4n,a4)#4 inv(b4n,b4)#4 inv(c4n,c4)#4 and2(a4nb4n,a4n,b4n)#2 and2(a4nb4,a4n,b4)#2 and2(a4b4n,a4,b4n)#2 and2(a4b4,a4,b4)#3 and2(a4b4c4,a4b4,c4)#2 and2(a4nb4nc4,a4nb4n,c4)#2 and2(a4nb4c4n,a4nb4,c4n)#2 and2(a4b4nc4n,a4b4n,c4n)#2 and2(b4c4,b4,c4)#2 and2(a4c4,c4,a4)#2 or2(s4w42,a4b4nc4n,a4nb4c4n)#3 or2(s4w71,a4b4c4, a4nb4nc4)#3 or2(s4,s4w42,s4w71)#3 or2(s4w35, b4c4, a4c4)#3 or2(t4,s4w35,a4b4)#5 end netlist inv(a5n,a5)#4 inv(b5n,b5)#4 inv(c5n,c5)#4 and2(a5nb5n,a5n,b5n)#2 and2(a5nb5,a5n,b5)#2 and2(a5b5n,a5,b5n)#2 and2(a5b5,a5,b5)#3 and2(a5b5c5,a5b5,c5)#2 and2(a5nb5nc5,a5nb5n,c5)#2 and2(a5nb5c5n,a5nb5,c5n)#2 and2(a5b5nc5n,a5b5n,c5n)#2 and2(b5c5,b5,c5)#2 and2(a5c5,c5,a5)#2 or2(s5w42,a5b5nc5n,a5nb5c5n)#3 or2(s5w71,a5b5c5, a5nb5nc5)#3 or2(s5,s5w42,s5w71)#3 or2(s5w35, b5c5, a5c5)#3 or2(t5,s5w35,a5b5)#5 end netlist inv(a6n,a6)#4 inv(b6n,b6)#4 inv(c6n,c6)#4 and2(a6nb6n,a6n,b6n)#2 and2(a6nb6,a6n,b6)#2 and2(a6b6n,a6,b6n)#2 and2(a6b6,a6,b6)#3 and2(a6b6c6,a6b6,c6)#2 and2(a6nb6nc6,a6nb6n,c6)#2 and2(a6nb6c6n,a6nb6,c6n)#2 and2(a6b6nc6n,a6b6n,c6n)#2 and2(b6c6,b6,c6)#2 and2(a6c6,c6,a6)#2 or2(s6w42,a6b6nc6n,a6nb6c6n)#3 or2(s6w71,a6b6c6, a6nb6nc6)#3 or2(s6,s6w42,s6w71)#3 or2(s6w35, b6c6, a6c6)#3 or2(t6,s6w35,a6b6)#5 end netlist inv(a7n,a7)#4 inv(b7n,b7)#4 inv(c7n,c7)#4 and2(a7nb7n,a7n,b7n)#2 and2(a7nb7,a7n,b7)#2 and2(a7b7n,a7,b7n)#2 and2(a7b7,a7,b7)#3 and2(a7b7c7,a7b7,c7)#2 and2(a7nb7nc7,a7nb7n,c7)#2 and2(a7nb7c7n,a7nb7,c7n)#2 and2(a7b7nc7n,a7b7n,c7n)#2 and2(b7c7,b7,c7)#2 and2(a7c7,c7,a7)#2 or2(s7w42,a7b7nc7n,a7nb7c7n)#3 or2(s7w71,a7b7c7, a7nb7nc7)#3 or2(s7,s7w42,s7w71)#3 or2(s7w35, b7c7, a7c7)#3 or2(t7,s7w35,a7b7)#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/des/koggeStone128bit.net
finish 100000 inputs cin, a0, a1, a2, a3, a4, a5, a6, a7, a8, a9, a10, a11, a12, a13, a14, a15, a16, a17, a18, a19, a20, a21, a22, a23, a24, a25, a26, a27, a28, a29, a30, a31, a32, a33, a34, a35, a36, a37, a38, a39, a40, a41, a42, a43, a44, a45, a46, a47, a48, a49, a50, a51, a52, a53, a54, a55, a56, a57, a58, a59, a60, a61, a62, a63, a64, a65, a66, a67, a68, a69, a70, a71, a72, a73, a74, a75, a76, a77, a78, a79, a80, a81, a82, a83, a84, a85, a86, a87, a88, a89, a90, a91, a92, a93, a94, a95, a96, a97, a98, a99, a100, a101, a102, a103, a104, a105, a106, a107, a108, a109, a110, a111, a112, a113, a114, a115, a116, a117, a118, a119, a120, a121, a122, a123, a124, a125, a126, a127, b0, b1, b2, b3, b4, b5, b6, b7, b8, b9, b10, b11, b12, b13, b14, b15, b16, b17, b18, b19, b20, b21, b22, b23, b24, b25, b26, b27, b28, b29, b30, b31, b32, b33, b34, b35, b36, b37, b38, b39, b40, b41, b42, b43, b44, b45, b46, b47, b48, b49, b50, b51, b52, b53, b54, b55, b56, b57, b58, b59, b60, b61, b62, b63, b64, b65, b66, b67, b68, b69, b70, b71, b72, b73, b74, b75, b76, b77, b78, b79, b80, b81, b82, b83, b84, b85, b86, b87, b88, b89, b90, b91, b92, b93, b94, b95, b96, b97, b98, b99, b100, b101, b102, b103, b104, b105, b106, b107, b108, b109, b110, b111, b112, b113, b114, b115, b116, b117, b118, b119, b120, b121, b122, b123, b124, b125, b126, b127 end outputs cout, s0, s1, s2, s3, s4, s5, s6, s7, s8, s9, s10, s11, s12, s13, s14, s15, s16, s17, s18, s19, s20, s21, s22, s23, s24, s25, s26, s27, s28, s29, s30, s31, s32, s33, s34, s35, s36, s37, s38, s39, s40, s41, s42, s43, s44, s45, s46, s47, s48, s49, s50, s51, s52, s53, s54, s55, s56, s57, s58, s59, s60, s61, s62, s63, s64, s65, s66, s67, s68, s69, s70, s71, s72, s73, s74, s75, s76, s77, s78, s79, s80, s81, s82, s83, s84, s85, s86, s87, s88, s89, s90, s91, s92, s93, s94, s95, s96, s97, s98, s99, s100, s101, s102, s103, s104, s105, s106, s107, s108, s109, s110, s111, s112, s113, s114, s115, s116, s117, s118, s119, s120, s121, s122, s123, s124, s125, s126, s127 end initlist a0 0,0 30,1 92,0 136,1 153,0 187,1 281,0 378,1 446,0 458,1 550,0 622,1 690,0 756,1 824,0 834,1 893,0 902,1 904,0 937,1 1028,0 1057,1 1074,0 1151,1 1181,0 1248,1 1306,0 1339,1 1386,0 1396,1 1443,0 1445,1 1453,0 1485,1 1515,0 1547,1 1634,0 1663,1 1664,0 1675,1 1729,0 1805,1 1879,0 1928,1 1945,0 1992,1 2054,0 2112,1 2134,0 2180,1 2204,0 2259,1 2343,0 2426,1 2463,0 2489,1 2582,0 2608,1 2698,0 2793,1 2859,0 2936,1 3023,0 3121,1 3204,0 3233,1 3269,0 3290,1 3329,0 3347,1 3366,0 3373,1 3401,0 3477,1 3482,0 3564,1 3586,0 3676,1 3697,0 3714,1 3721,0 3808,1 3906,0 3957,1 3994,0 4026,1 4068,0 4142,1 4225,0 4284,1 4344,0 4366,1 4389,0 4441,1 4484,0 4488,1 4511,0 4557,1 4582,0 4630,1 4671,0 4718,1 4736,0 4748,1 4813,0 4883,1 4956,0 5003,1 5035,0 5117,1 5175,0 5219,1 5303,0 5357,1 5370,0 5393,1 5395,0 5422,1 5499,0 5515,1 5551,0 5570,1 5616,0 5632,1 5635,0 5721,1 5751,0 5810,1 5854,0 5899,1 5994,0 6011,1 6066,0 6151,1 6213,0 6277,1 6299,0 6360,1 6458,0 6496,1 6499,0 6542,1 6551,0 6596,1 6611,0 6624,1 6724,0 6753,1 6767,0 6782,1 6797,0 6838,1 6936,0 6970,1 6977,0 7034,1 7089,0 7132,1 7213,0 7309,1 7352,0 7371,1 7390,0 7454,1 7494,0 7535,1 7577,0 7641,1 7656,0 7700,1 7752,0 7851,1 7896,0 7905,1 7922,0 7948,1 8048,0 8065,1 8153,0 8201,1 8251,0 8322,1 8401,0 8487,1 8533,0 8535,1 8536,0 8613,1 8623,0 8713,1 8796,0 8827,1 8908,0 8971,1 9009,0 9096,1 9178,0 9258,1 9261,0 9350,1 9433,0 9531,1 9610,0 9704,1 9720,0 9795,1 9831,0 9892,1 9911,0 9975,1 10039,0 10091,1 10135,0 10206,1 10288,0 10363,1 10367,0 10414,1 10432,0 10529,1 10595,0 10666,1 10709,0 10789,1 10888,0 10956,1 10968,0 10991,1 10994,0 11093,1 11108,0 11133,1 11216,0 11285,1 11350,0 11423,1 11440,0 11504,1 11576,0 11613,1 11628,0 11727,1 11732,0 11765,1 11766,0 11802,1 11848,0 11943,1 11973,0 12053,1 12153,0 12234,1 12324,0 12352,1 12395,0 12482,1 12574,0 12672,1 end initlist a1 0,0 39,1 126,0 223,1 241,0 277,1 327,0 398,1 485,0 493,1 570,0 578,1 647,0 700,1 720,0 806,1 825,0 844,1 881,0 952,1 971,0 996,1 1058,0 1067,1 1106,0 1183,1 1241,0 1321,1 1341,0 1353,1 1450,0 1468,1 1557,0 1586,1 1643,0 1691,1 1709,0 1732,1 1767,0 1791,1 1865,0 1906,1 1947,0 1981,1 1992,0 2028,1 2125,0 2141,1 2175,0 2222,1 2267,0 2286,1 2356,0 2365,1 2380,0 2385,1 2422,0 2503,1 2564,0 2618,1 2708,0 2804,1 2830,0 2897,1 2925,0 2978,1 3007,0 3078,1 3172,0 3205,1 3210,0 3242,1 3339,0 3390,1 3423,0 3504,1 3573,0 3604,1 3644,0 3646,1 3670,0 3753,1 3827,0 3880,1 3916,0 3956,1 3959,0 3983,1 4052,0 4145,1 4180,0 4271,1 4290,0 4338,1 4423,0 4488,1 4546,0 4584,1 4591,0 4628,1 4697,0 4769,1 4782,0 4826,1 4831,0 4887,1 4977,0 5006,1 5039,0 5123,1 5172,0 5211,1 5265,0 5314,1 5328,0 5385,1 5431,0 5437,1 5448,0 5481,1 5524,0 5573,1 5636,0 5638,1 5676,0 5681,1 5777,0 5817,1 5877,0 5923,1 5991,0 6016,1 6025,0 6064,1 6133,0 6216,1 6218,0 6287,1 6385,0 6422,1 6447,0 6503,1 6513,0 6600,1 6688,0 6782,1 6872,0 6944,1 6968,0 7007,1 7066,0 7164,1 7233,0 7325,1 7383,0 7439,1 7462,0 7556,1 7622,0 7638,1 7697,0 7790,1 7855,0 7904,1 8004,0 8008,1 8097,0 8098,1 8119,0 8150,1 8206,0 8238,1 8279,0 8347,1 8380,0 8478,1 8529,0 8575,1 8635,0 8723,1 8816,0 8817,1 8872,0 8942,1 9010,0 9091,1 9163,0 9192,1 9238,0 9261,1 9308,0 9384,1 9397,0 9450,1 9452,0 9472,1 9504,0 9600,1 9699,0 9724,1 9749,0 9772,1 9869,0 9899,1 9964,0 10015,1 10031,0 10063,1 10064,0 10143,1 10177,0 10258,1 10358,0 10431,1 10449,0 10540,1 10575,0 10610,1 10683,0 10699,1 10715,0 10718,1 10776,0 10826,1 10852,0 10855,1 10900,0 10977,1 11024,0 11044,1 11097,0 11121,1 11127,0 11176,1 11261,0 11309,1 11315,0 11363,1 11437,0 11466,1 11514,0 11563,1 11602,0 11663,1 11705,0 11727,1 11780,0 11832,1 11864,0 11917,1 11960,0 12018,1 12085,0 12128,1 12228,0 12302,1 12337,0 12392,1 end initlist a2 0,0 8,1 68,0 151,1 234,0 245,1 323,0 343,1 349,0 416,1 478,0 576,1 605,0 607,1 673,0 749,1 783,0 876,1 942,0 948,1 1033,0 1129,1 1194,0 1225,1 1277,0 1317,1 1356,0 1399,1 1492,0 1505,1 1577,0 1605,1 1629,0 1704,1 1752,0 1839,1 1884,0 1916,1 1981,0 1992,1 2000,0 2014,1 2066,0 2093,1 2148,0 2152,1 2226,0 2242,1 2286,0 2314,1 2386,0 2393,1 2414,0 2423,1 2517,0 2595,1 2686,0 2762,1 2856,0 2881,1 2936,0 2985,1 2992,0 3028,1 3115,0 3213,1 3247,0 3282,1 3370,0 3390,1 3434,0 3510,1 3519,0 3521,1 3611,0 3642,1 3702,0 3750,1 3792,0 3812,1 3851,0 3878,1 3916,0 3967,1 4052,0 4105,1 4201,0 4226,1 4236,0 4304,1 4393,0 4454,1 4483,0 4558,1 4616,0 4674,1 4752,0 4773,1 4847,0 4851,1 4856,0 4949,1 5019,0 5038,1 5121,0 5209,1 5228,0 5238,1 5314,0 5413,1 5491,0 5587,1 5601,0 5614,1 5688,0 5772,1 5838,0 5841,1 5864,0 5929,1 5981,0 5982,1 5990,0 6022,1 6066,0 6153,1 6224,0 6277,1 6347,0 6446,1 6514,0 6569,1 6571,0 6573,1 6664,0 6707,1 6803,0 6831,1 6900,0 6922,1 6996,0 7068,1 7123,0 7150,1 7245,0 7281,1 7329,0 7403,1 7455,0 7498,1 7524,0 7571,1 7575,0 7638,1 7655,0 7677,1 7697,0 7765,1 7790,0 7858,1 7954,0 7980,1 7999,0 8081,1 8115,0 8185,1 8266,0 8300,1 8332,0 8419,1 8490,0 8572,1 8633,0 8687,1 8705,0 8766,1 8860,0 8886,1 8889,0 8964,1 9017,0 9021,1 9054,0 9144,1 9166,0 9262,1 9301,0 9331,1 9336,0 9384,1 9462,0 9498,1 9558,0 9621,1 9637,0 9692,1 9731,0 9818,1 9881,0 9965,1 9984,0 10080,1 10088,0 10139,1 10218,0 10281,1 10358,0 10449,1 10534,0 10577,1 10606,0 10636,1 10693,0 10776,1 10798,0 10873,1 10944,0 10956,1 11043,0 11119,1 11174,0 11182,1 11209,0 11218,1 11301,0 11382,1 11482,0 11514,1 11526,0 11543,1 11599,0 11698,1 11707,0 11800,1 11855,0 11881,1 11944,0 12012,1 12067,0 12160,1 12197,0 12285,1 12316,0 12361,1 12403,0 12404,1 12468,0 12506,1 12554,0 12584,1 12614,0 12672,1 12755,0 12843,1 12897,0 12957,1 12994,0 13090,1 end initlist a3 0,0 63,1 139,0 219,1 290,0 309,1 363,0 412,1 424,0 488,1 506,0 516,1 554,0 580,1 639,0 701,1 713,0 772,1 782,0 799,1 847,0 918,1 960,0 988,1 1069,0 1079,1 1177,0 1229,1 1268,0 1342,1 1356,0 1373,1 1394,0 1403,1 1432,0 1447,1 1530,0 1548,1 1581,0 1595,1 1663,0 1701,1 1741,0 1837,1 1904,0 1913,1 2005,0 2027,1 2114,0 2155,1 2247,0 2273,1 2333,0 2339,1 2389,0 2474,1 2500,0 2583,1 2626,0 2667,1 2746,0 2824,1 2886,0 2890,1 2904,0 2969,1 3065,0 3108,1 3165,0 3256,1 3261,0 3294,1 3371,0 3420,1 3488,0 3494,1 3513,0 3563,1 3655,0 3713,1 3793,0 3850,1 3922,0 3994,1 4086,0 4185,1 4257,0 4297,1 4345,0 4367,1 4414,0 4457,1 4551,0 4630,1 4722,0 4784,1 4825,0 4880,1 4967,0 5067,1 5082,0 5114,1 5213,0 5279,1 5350,0 5390,1 5416,0 5435,1 5481,0 5541,1 5546,0 5618,1 5697,0 5734,1 5787,0 5801,1 5812,0 5841,1 5863,0 5943,1 5997,0 6036,1 6053,0 6103,1 6140,0 6181,1 6186,0 6209,1 6239,0 6246,1 6311,0 6388,1 6406,0 6480,1 6488,0 6571,1 6632,0 6706,1 6742,0 6842,1 6879,0 6923,1 6984,0 7009,1 7036,0 7129,1 7141,0 7221,1 7316,0 7326,1 7364,0 7372,1 7426,0 7497,1 7537,0 7606,1 7688,0 7715,1 7770,0 7784,1 7829,0 7870,1 7923,0 7937,1 8022,0 8121,1 8214,0 8308,1 8394,0 8469,1 8566,0 8613,1 8646,0 8724,1 8805,0 8809,1 8821,0 8889,1 8917,0 8965,1 9016,0 9056,1 9080,0 9147,1 9194,0 9279,1 9340,0 9349,1 9417,0 9439,1 9504,0 9570,1 9622,0 9707,1 9763,0 9847,1 9934,0 9968,1 9981,0 10060,1 10064,0 10069,1 10093,0 10142,1 10211,0 10300,1 10367,0 10460,1 10519,0 10550,1 10598,0 10646,1 10679,0 10736,1 10781,0 10867,1 10951,0 10993,1 11054,0 11071,1 11171,0 11244,1 11313,0 11379,1 11387,0 11449,1 11476,0 11500,1 11542,0 11625,1 11685,0 11750,1 11836,0 11870,1 11886,0 11976,1 12063,0 12135,1 12191,0 12200,1 12278,0 12358,1 12390,0 12427,1 12511,0 12570,1 12619,0 12622,1 12663,0 12749,1 12819,0 12900,1 12942,0 12946,1 12984,0 13079,1 13105,0 13123,1 end initlist a4 0,0 55,1 115,0 190,1 233,0 254,1 261,0 296,1 350,0 444,1 522,0 605,1 621,0 700,1 758,0 780,1 875,0 910,1 993,0 1068,1 1099,0 1141,1 1158,0 1225,1 1320,0 1409,1 1480,0 1546,1 1604,0 1629,1 1633,0 1712,1 1731,0 1736,1 1810,0 1901,1 1957,0 1992,1 2013,0 2031,1 2110,0 2164,1 2172,0 2184,1 2252,0 2308,1 2352,0 2442,1 2540,0 2610,1 2637,0 2711,1 2739,0 2824,1 2835,0 2878,1 2920,0 2964,1 3028,0 3122,1 3123,0 3210,1 3286,0 3366,1 3448,0 3512,1 3579,0 3584,1 3627,0 3716,1 3730,0 3750,1 3842,0 3939,1 3992,0 4022,1 4118,0 4128,1 4224,0 4267,1 4328,0 4333,1 4396,0 4398,1 4478,0 4531,1 4533,0 4543,1 4579,0 4629,1 4721,0 4808,1 4866,0 4908,1 4934,0 5026,1 5103,0 5155,1 5222,0 5312,1 5387,0 5392,1 5453,0 5463,1 5537,0 5614,1 5710,0 5711,1 5719,0 5744,1 5804,0 5879,1 5905,0 5946,1 6028,0 6057,1 6095,0 6103,1 6168,0 6187,1 6252,0 6260,1 6341,0 6386,1 6404,0 6499,1 6595,0 6612,1 6681,0 6715,1 6743,0 6822,1 6852,0 6912,1 7006,0 7040,1 7125,0 7143,1 7223,0 7259,1 7311,0 7316,1 7413,0 7500,1 7570,0 7598,1 7641,0 7693,1 7744,0 7781,1 7869,0 7914,1 7928,0 7930,1 7948,0 7987,1 8043,0 8135,1 8214,0 8231,1 8259,0 8355,1 8429,0 8512,1 8592,0 8597,1 8626,0 8636,1 8665,0 8721,1 8722,0 8723,1 8804,0 8893,1 8944,0 8955,1 9033,0 9094,1 9098,0 9110,1 9193,0 9199,1 9290,0 9306,1 9399,0 9448,1 9545,0 9600,1 9636,0 9692,1 9725,0 9740,1 9812,0 9837,1 9880,0 9949,1 10017,0 10030,1 10128,0 10189,1 10248,0 10297,1 10324,0 10370,1 10469,0 10532,1 10559,0 10609,1 10679,0 10684,1 10765,0 10860,1 10917,0 10991,1 11074,0 11088,1 11123,0 11155,1 11255,0 11336,1 11367,0 11412,1 11447,0 11471,1 11563,0 11611,1 11676,0 11724,1 11740,0 11767,1 11804,0 11846,1 11925,0 11929,1 11980,0 11993,1 12063,0 12092,1 12121,0 12187,1 12215,0 12231,1 12298,0 12370,1 12413,0 12441,1 12530,0 12625,1 12637,0 12726,1 12785,0 12878,1 12894,0 12982,1 13007,0 13068,1 13162,0 13245,1 end initlist a5 0,0 40,1 69,0 90,1 129,0 193,1 204,0 287,1 373,0 444,1 511,0 521,1 596,0 613,1 685,0 766,1 844,0 926,1 950,0 1020,1 1093,0 1191,1 1260,0 1269,1 1361,0 1411,1 1503,0 1587,1 1636,0 1714,1 1796,0 1834,1 1879,0 1943,1 2019,0 2100,1 2164,0 2179,1 2270,0 2353,1 2387,0 2402,1 2502,0 2536,1 2628,0 2649,1 2732,0 2822,1 2861,0 2942,1 2945,0 3032,1 3081,0 3175,1 3179,0 3201,1 3274,0 3338,1 3375,0 3409,1 3478,0 3559,1 3566,0 3649,1 3705,0 3744,1 3780,0 3794,1 3844,0 3922,1 3996,0 4082,1 4139,0 4213,1 4269,0 4271,1 4371,0 4444,1 4515,0 4603,1 4672,0 4756,1 4836,0 4874,1 4877,0 4885,1 4983,0 5000,1 5049,0 5070,1 5101,0 5182,1 5211,0 5237,1 5309,0 5341,1 5365,0 5401,1 5473,0 5475,1 5553,0 5630,1 5648,0 5699,1 5747,0 5840,1 5876,0 5880,1 5899,0 5995,1 6069,0 6092,1 6102,0 6184,1 6211,0 6212,1 6287,0 6333,1 6398,0 6408,1 6493,0 6544,1 6644,0 6683,1 6783,0 6795,1 6850,0 6939,1 6958,0 7006,1 7062,0 7088,1 7090,0 7147,1 7234,0 7329,1 7394,0 7468,1 7490,0 7542,1 7593,0 7605,1 7615,0 7670,1 7718,0 7769,1 7862,0 7888,1 7945,0 7989,1 8077,0 8084,1 8150,0 8166,1 8192,0 8217,1 8226,0 8296,1 8335,0 8343,1 8357,0 8446,1 8529,0 8562,1 8644,0 8664,1 8750,0 8839,1 8882,0 8905,1 8979,0 8992,1 8996,0 9007,1 9055,0 9110,1 9192,0 9237,1 9241,0 9287,1 9344,0 9440,1 9533,0 9596,1 9690,0 9704,1 9779,0 9816,1 9906,0 9990,1 10046,0 10101,1 10134,0 10219,1 10250,0 10341,1 10390,0 10449,1 10483,0 10575,1 10638,0 10655,1 10712,0 10751,1 10772,0 10800,1 10883,0 10947,1 10962,0 10963,1 11022,0 11107,1 11141,0 11150,1 11241,0 11251,1 11258,0 11267,1 11348,0 11399,1 11461,0 11507,1 11561,0 11626,1 11682,0 11693,1 11741,0 11816,1 11880,0 11926,1 11956,0 12036,1 12089,0 12105,1 12139,0 12187,1 12256,0 12346,1 12409,0 12450,1 12484,0 12504,1 12565,0 12601,1 12643,0 12677,1 12711,0 12805,1 12822,0 12871,1 12885,0 12980,1 13053,0 13153,1 13204,0 13221,1 13252,0 13272,1 end initlist a6 0,0 92,1 133,0 153,1 168,0 236,1 245,0 299,1 395,0 485,1 486,0 505,1 577,0 604,1 688,0 708,1 767,0 796,1 839,0 885,1 904,0 944,1 1029,0 1095,1 1102,0 1119,1 1162,0 1249,1 1276,0 1290,1 1379,0 1429,1 1450,0 1530,1 1561,0 1584,1 1588,0 1622,1 1702,0 1707,1 1725,0 1750,1 1775,0 1855,1 1873,0 1969,1 2006,0 2051,1 2151,0 2206,1 2250,0 2293,1 2333,0 2368,1 2369,0 2382,1 2397,0 2419,1 2498,0 2535,1 2543,0 2565,1 2611,0 2634,1 2679,0 2684,1 2750,0 2774,1 2862,0 2920,1 2954,0 2963,1 2992,0 3063,1 3095,0 3138,1 3209,0 3273,1 3335,0 3433,1 3464,0 3500,1 3525,0 3581,1 3643,0 3710,1 3801,0 3823,1 3844,0 3875,1 3960,0 3969,1 4008,0 4065,1 4066,0 4090,1 4149,0 4209,1 4282,0 4315,1 4383,0 4428,1 4474,0 4479,1 4573,0 4659,1 4749,0 4816,1 4887,0 4939,1 4945,0 5042,1 5045,0 5099,1 5129,0 5165,1 5227,0 5258,1 5307,0 5405,1 5435,0 5519,1 5526,0 5623,1 5647,0 5722,1 5729,0 5758,1 5828,0 5856,1 5953,0 6029,1 6087,0 6148,1 6201,0 6223,1 6279,0 6348,1 6436,0 6508,1 6569,0 6629,1 6662,0 6696,1 6699,0 6734,1 6824,0 6858,1 6952,0 7016,1 7092,0 7106,1 7184,0 7267,1 7295,0 7394,1 7401,0 7409,1 7437,0 7465,1 7549,0 7622,1 7668,0 7707,1 7733,0 7737,1 7820,0 7869,1 7907,0 7959,1 8008,0 8095,1 8155,0 8236,1 8281,0 8283,1 8376,0 8423,1 8520,0 8602,1 8618,0 8681,1 8756,0 8845,1 8930,0 8942,1 8977,0 9050,1 9147,0 9193,1 9231,0 9265,1 9306,0 9312,1 9333,0 9385,1 9415,0 9435,1 9446,0 9523,1 9583,0 9594,1 9630,0 9717,1 9764,0 9778,1 9846,0 9899,1 9973,0 10053,1 10057,0 10099,1 10150,0 10209,1 10307,0 10361,1 10405,0 10411,1 10497,0 10528,1 10550,0 10598,1 10696,0 10751,1 10765,0 10818,1 10904,0 10969,1 10975,0 10986,1 11008,0 11069,1 11078,0 11130,1 11146,0 11149,1 11157,0 11192,1 11230,0 11279,1 11291,0 11364,1 11434,0 11505,1 11524,0 11545,1 11565,0 11637,1 11722,0 11743,1 11809,0 11815,1 11897,0 11932,1 11996,0 12071,1 12157,0 12242,1 end initlist a7 0,0 13,1 75,0 140,1 227,0 327,1 379,0 396,1 425,0 434,1 444,0 539,1 611,0 647,1 678,0 774,1 788,0 817,1 861,0 954,1 973,0 1042,1 1090,0 1170,1 1217,0 1273,1 1322,0 1354,1 1364,0 1431,1 1519,0 1600,1 1664,0 1738,1 1799,0 1820,1 1827,0 1846,1 1897,0 1990,1 2010,0 2103,1 2192,0 2242,1 2280,0 2315,1 2401,0 2447,1 2533,0 2536,1 2635,0 2671,1 2678,0 2762,1 2850,0 2869,1 2896,0 2975,1 3071,0 3123,1 3184,0 3216,1 3263,0 3347,1 3393,0 3395,1 3455,0 3498,1 3567,0 3637,1 3672,0 3738,1 3784,0 3785,1 3860,0 3900,1 3964,0 4058,1 4094,0 4154,1 4248,0 4288,1 4328,0 4388,1 4466,0 4490,1 4544,0 4568,1 4589,0 4653,1 4725,0 4788,1 4883,0 4945,1 5010,0 5019,1 5119,0 5124,1 5189,0 5228,1 5312,0 5392,1 5393,0 5476,1 5519,0 5588,1 5652,0 5708,1 5800,0 5856,1 5873,0 5887,1 5919,0 5923,1 5982,0 6042,1 6069,0 6078,1 6136,0 6182,1 6252,0 6341,1 6404,0 6426,1 6471,0 6538,1 6570,0 6629,1 6707,0 6758,1 6822,0 6868,1 6968,0 7038,1 7118,0 7128,1 7206,0 7283,1 7305,0 7328,1 7396,0 7400,1 7490,0 7581,1 7615,0 7686,1 7708,0 7781,1 7874,0 7888,1 7950,0 8038,1 8043,0 8080,1 8098,0 8159,1 8177,0 8230,1 8309,0 8336,1 8349,0 8440,1 8530,0 8609,1 8627,0 8636,1 8712,0 8808,1 8832,0 8878,1 8921,0 8999,1 9096,0 9113,1 9144,0 9222,1 9283,0 9379,1 9445,0 9459,1 9468,0 9553,1 9570,0 9586,1 9650,0 9681,1 9714,0 9723,1 9737,0 9796,1 9858,0 9958,1 10019,0 10092,1 10109,0 10173,1 10215,0 10221,1 10293,0 10330,1 10396,0 10413,1 10426,0 10480,1 10576,0 10652,1 10713,0 10790,1 10867,0 10945,1 11008,0 11048,1 11071,0 11095,1 11193,0 11288,1 11333,0 11427,1 11478,0 11537,1 11615,0 11667,1 11763,0 11860,1 11927,0 12008,1 12057,0 12093,1 12127,0 12215,1 12275,0 12277,1 12356,0 12451,1 12474,0 12505,1 12511,0 12595,1 12646,0 12734,1 12793,0 12885,1 12985,0 13065,1 13106,0 13188,1 13275,0 13287,1 13357,0 13424,1 13476,0 13489,1 13524,0 13596,1 13695,0 13703,1 13786,0 13852,1 end initlist a8 0,0 56,1 85,0 87,1 119,0 153,1 218,0 248,1 323,0 403,1 502,0 512,1 540,0 611,1 627,0 719,1 750,0 771,1 772,0 800,1 822,0 874,1 901,0 993,1 1064,0 1122,1 1195,0 1246,1 1280,0 1378,1 1451,0 1460,1 1470,0 1555,1 1577,0 1662,1 1736,0 1752,1 1841,0 1894,1 1922,0 2006,1 2091,0 2190,1 2243,0 2254,1 2292,0 2298,1 2300,0 2384,1 2430,0 2469,1 2472,0 2538,1 2549,0 2647,1 2665,0 2689,1 2707,0 2781,1 2860,0 2900,1 2961,0 3042,1 3113,0 3136,1 3214,0 3296,1 3360,0 3402,1 3424,0 3474,1 3546,0 3635,1 3726,0 3782,1 3864,0 3907,1 4004,0 4096,1 4134,0 4213,1 4305,0 4308,1 4329,0 4362,1 4369,0 4436,1 4500,0 4550,1 4566,0 4575,1 4659,0 4717,1 4801,0 4881,1 4953,0 4995,1 5036,0 5103,1 5124,0 5197,1 5243,0 5305,1 5307,0 5333,1 5428,0 5510,1 5560,0 5619,1 5678,0 5739,1 5802,0 5874,1 5966,0 6004,1 6074,0 6120,1 6201,0 6225,1 6247,0 6318,1 6345,0 6416,1 6435,0 6488,1 6501,0 6502,1 6565,0 6653,1 6684,0 6738,1 6750,0 6828,1 6864,0 6934,1 6943,0 6976,1 7043,0 7076,1 7155,0 7210,1 7306,0 7389,1 7466,0 7565,1 7599,0 7626,1 7701,0 7751,1 7752,0 7795,1 7796,0 7877,1 7921,0 7987,1 8055,0 8084,1 8121,0 8153,1 8177,0 8232,1 8316,0 8366,1 8404,0 8439,1 8511,0 8572,1 8619,0 8639,1 8685,0 8698,1 8762,0 8844,1 8875,0 8943,1 9033,0 9113,1 9197,0 9207,1 9234,0 9286,1 9383,0 9431,1 9450,0 9472,1 9489,0 9543,1 9628,0 9664,1 9675,0 9768,1 9825,0 9827,1 9830,0 9882,1 9930,0 9933,1 9995,0 10024,1 10029,0 10085,1 10114,0 10187,1 10202,0 10241,1 10247,0 10278,1 10350,0 10356,1 10403,0 10449,1 10450,0 10465,1 10516,0 10579,1 10614,0 10620,1 10643,0 10687,1 10718,0 10789,1 10843,0 10932,1 10933,0 10995,1 11043,0 11082,1 11139,0 11156,1 11172,0 11209,1 11222,0 11312,1 11341,0 11397,1 11492,0 11546,1 11566,0 11658,1 11720,0 11744,1 11751,0 11850,1 11924,0 11937,1 12014,0 12075,1 12131,0 12152,1 12169,0 12234,1 12265,0 12358,1 12397,0 12419,1 12466,0 12545,1 end initlist a9 0,0 37,1 136,0 227,1 278,0 309,1 325,0 387,1 477,0 511,1 572,0 586,1 672,0 757,1 820,0 903,1 904,0 997,1 1072,0 1092,1 1163,0 1186,1 1252,0 1318,1 1367,0 1390,1 1461,0 1481,1 1569,0 1596,1 1614,0 1686,1 1735,0 1822,1 1881,0 1916,1 1921,0 1953,1 1980,0 2032,1 2053,0 2095,1 2146,0 2180,1 2199,0 2245,1 2319,0 2341,1 2437,0 2453,1 2547,0 2566,1 2620,0 2677,1 2723,0 2746,1 2819,0 2835,1 2857,0 2865,1 2913,0 3006,1 3015,0 3083,1 3175,0 3238,1 3289,0 3307,1 3365,0 3382,1 3434,0 3489,1 3519,0 3619,1 3689,0 3702,1 3791,0 3823,1 3904,0 3923,1 4017,0 4056,1 4078,0 4105,1 4155,0 4246,1 4306,0 4392,1 4397,0 4432,1 4531,0 4560,1 4564,0 4664,1 4699,0 4705,1 4718,0 4796,1 4864,0 4947,1 4992,0 5058,1 5117,0 5132,1 5218,0 5230,1 5247,0 5315,1 5403,0 5467,1 5483,0 5493,1 5555,0 5568,1 5586,0 5652,1 5658,0 5734,1 5738,0 5746,1 5842,0 5935,1 6031,0 6051,1 6125,0 6192,1 6288,0 6367,1 6375,0 6457,1 6529,0 6537,1 6542,0 6584,1 6675,0 6721,1 6740,0 6791,1 6814,0 6893,1 6901,0 6992,1 7007,0 7093,1 7153,0 7199,1 7250,0 7331,1 7380,0 7419,1 7420,0 7472,1 7538,0 7553,1 7599,0 7671,1 7728,0 7805,1 7833,0 7913,1 7964,0 7984,1 8069,0 8079,1 8128,0 8195,1 8218,0 8300,1 8308,0 8353,1 8433,0 8439,1 8503,0 8588,1 8680,0 8693,1 8772,0 8819,1 8859,0 8872,1 8931,0 9026,1 9124,0 9206,1 9222,0 9294,1 9315,0 9330,1 9382,0 9463,1 9495,0 9570,1 9604,0 9676,1 9705,0 9801,1 9896,0 9988,1 10041,0 10062,1 10138,0 10207,1 10290,0 10343,1 10397,0 10469,1 10558,0 10610,1 10636,0 10723,1 10775,0 10807,1 10843,0 10934,1 10939,0 11014,1 11082,0 11131,1 11199,0 11279,1 11297,0 11348,1 11362,0 11456,1 11533,0 11589,1 11645,0 11646,1 11680,0 11704,1 11763,0 11776,1 11811,0 11911,1 11930,0 11966,1 12063,0 12073,1 12148,0 12200,1 12245,0 12293,1 12316,0 12408,1 12425,0 12462,1 12496,0 12501,1 12576,0 12578,1 12601,0 12689,1 12743,0 12763,1 12855,0 12880,1 12980,0 13006,1 end initlist a10 0,0 18,1 86,0 136,1 206,0 287,1 343,0 374,1 464,0 530,1 540,0 549,1 556,0 573,1 612,0 691,1 775,0 824,1 879,0 958,1 1020,0 1109,1 1156,0 1223,1 1275,0 1328,1 1350,0 1384,1 1451,0 1462,1 1486,0 1549,1 1567,0 1603,1 1622,0 1703,1 1725,0 1805,1 1830,0 1878,1 1969,0 2014,1 2110,0 2169,1 2262,0 2263,1 2342,0 2412,1 2484,0 2569,1 2589,0 2688,1 2744,0 2797,1 2858,0 2926,1 2992,0 3072,1 3092,0 3139,1 3144,0 3160,1 3190,0 3252,1 3258,0 3264,1 3333,0 3365,1 3430,0 3447,1 3455,0 3555,1 3564,0 3641,1 3697,0 3757,1 3778,0 3805,1 3843,0 3844,1 3917,0 3943,1 3971,0 3972,1 4013,0 4039,1 4124,0 4165,1 4246,0 4283,1 4336,0 4338,1 4437,0 4481,1 4576,0 4579,1 4675,0 4774,1 4800,0 4822,1 4851,0 4860,1 4949,0 5043,1 5048,0 5146,1 5231,0 5273,1 5304,0 5355,1 5367,0 5439,1 5522,0 5614,1 5694,0 5746,1 5773,0 5831,1 5846,0 5856,1 5863,0 5864,1 5896,0 5927,1 6017,0 6088,1 6101,0 6125,1 6157,0 6164,1 6205,0 6298,1 6351,0 6360,1 6383,0 6458,1 6480,0 6555,1 6594,0 6657,1 6694,0 6698,1 6756,0 6782,1 6879,0 6965,1 6984,0 7042,1 7136,0 7172,1 7269,0 7280,1 7359,0 7413,1 7500,0 7562,1 7620,0 7691,1 7769,0 7771,1 7810,0 7885,1 7922,0 7970,1 7977,0 8030,1 8094,0 8133,1 8193,0 8270,1 8355,0 8446,1 8526,0 8582,1 8672,0 8770,1 8827,0 8900,1 8931,0 9025,1 9087,0 9152,1 9247,0 9264,1 9349,0 9382,1 9460,0 9552,1 9631,0 9672,1 9697,0 9795,1 9880,0 9961,1 10051,0 10100,1 10117,0 10159,1 10243,0 10284,1 10367,0 10426,1 10517,0 10551,1 10552,0 10612,1 10698,0 10724,1 10742,0 10763,1 10772,0 10817,1 10906,0 11004,1 11087,0 11179,1 11223,0 11323,1 11413,0 11431,1 11458,0 11490,1 11504,0 11600,1 11672,0 11679,1 11772,0 11820,1 11869,0 11958,1 12004,0 12056,1 12127,0 12214,1 12235,0 12282,1 12368,0 12403,1 12451,0 12525,1 12526,0 12590,1 12626,0 12705,1 12757,0 12829,1 12831,0 12853,1 12914,0 13010,1 13056,0 13142,1 13214,0 13257,1 13343,0 13420,1 13465,0 13516,1 end initlist a11 0,0 67,1 144,0 242,1 335,0 402,1 427,0 523,1 606,0 700,1 764,0 792,1 826,0 909,1 931,0 988,1 1013,0 1045,1 1070,0 1127,1 1209,0 1261,1 1330,0 1354,1 1382,0 1388,1 1470,0 1486,1 1516,0 1581,1 1668,0 1711,1 1747,0 1807,1 1875,0 1910,1 1997,0 2037,1 2044,0 2099,1 2114,0 2146,1 2176,0 2232,1 2282,0 2310,1 2381,0 2398,1 2467,0 2487,1 2578,0 2613,1 2676,0 2717,1 2728,0 2824,1 2858,0 2954,1 3001,0 3033,1 3101,0 3142,1 3182,0 3231,1 3286,0 3372,1 3410,0 3472,1 3481,0 3516,1 3574,0 3595,1 3689,0 3761,1 3813,0 3899,1 3908,0 3909,1 3920,0 3981,1 3995,0 4045,1 4128,0 4194,1 4209,0 4278,1 4373,0 4404,1 4476,0 4481,1 4523,0 4564,1 4597,0 4681,1 4693,0 4789,1 4803,0 4860,1 4956,0 4975,1 5024,0 5092,1 5109,0 5161,1 5192,0 5270,1 5309,0 5350,1 5442,0 5444,1 5449,0 5519,1 5577,0 5628,1 5689,0 5774,1 5802,0 5880,1 5965,0 6054,1 6056,0 6078,1 6098,0 6182,1 6224,0 6275,1 6353,0 6425,1 6442,0 6499,1 6524,0 6528,1 6544,0 6594,1 6667,0 6683,1 6776,0 6781,1 6856,0 6947,1 7005,0 7030,1 7064,0 7155,1 7241,0 7280,1 7284,0 7308,1 7370,0 7395,1 7412,0 7497,1 7581,0 7629,1 7691,0 7730,1 7829,0 7846,1 7877,0 7945,1 7982,0 7986,1 8060,0 8102,1 8183,0 8276,1 8365,0 8442,1 8458,0 8526,1 8600,0 8655,1 8741,0 8774,1 8834,0 8929,1 9006,0 9053,1 9059,0 9088,1 9103,0 9130,1 9179,0 9205,1 9275,0 9307,1 9324,0 9356,1 9371,0 9372,1 9422,0 9460,1 9502,0 9556,1 9592,0 9660,1 9705,0 9717,1 9740,0 9836,1 9860,0 9929,1 10001,0 10035,1 10052,0 10091,1 10144,0 10183,1 10279,0 10294,1 10374,0 10388,1 10434,0 10466,1 10490,0 10575,1 10585,0 10677,1 10776,0 10869,1 10896,0 10918,1 10963,0 10967,1 10969,0 11068,1 11100,0 11163,1 11243,0 11314,1 11321,0 11413,1 11419,0 11434,1 11527,0 11532,1 11558,0 11610,1 11641,0 11665,1 11756,0 11761,1 11861,0 11952,1 12052,0 12106,1 12127,0 12193,1 12249,0 12309,1 12408,0 12412,1 12494,0 12532,1 12589,0 12644,1 12688,0 12787,1 end initlist a12 0,0 75,1 170,0 261,1 288,0 310,1 330,0 419,1 423,0 484,1 519,0 599,1 622,0 686,1 749,0 811,1 884,0 924,1 965,0 1040,1 1083,0 1107,1 1207,0 1286,1 1293,0 1341,1 1433,0 1470,1 1492,0 1525,1 1536,0 1633,1 1647,0 1698,1 1719,0 1776,1 1803,0 1835,1 1842,0 1917,1 1925,0 2009,1 2073,0 2108,1 2170,0 2268,1 2305,0 2356,1 2417,0 2479,1 2535,0 2626,1 2639,0 2712,1 2753,0 2834,1 2933,0 3021,1 3040,0 3054,1 3082,0 3131,1 3202,0 3288,1 3361,0 3432,1 3526,0 3617,1 3708,0 3722,1 3727,0 3808,1 3813,0 3890,1 3904,0 3923,1 3984,0 4016,1 4077,0 4169,1 4227,0 4326,1 4343,0 4352,1 4353,0 4395,1 4480,0 4505,1 4531,0 4542,1 4554,0 4626,1 4703,0 4722,1 4746,0 4754,1 4781,0 4827,1 4849,0 4925,1 4981,0 5022,1 5025,0 5054,1 5077,0 5145,1 5198,0 5244,1 5315,0 5337,1 5378,0 5464,1 5532,0 5609,1 5669,0 5716,1 5814,0 5904,1 5996,0 6049,1 6112,0 6204,1 6292,0 6323,1 6370,0 6418,1 6474,0 6533,1 6591,0 6619,1 6662,0 6689,1 6694,0 6763,1 6822,0 6874,1 6908,0 6943,1 7037,0 7065,1 7160,0 7203,1 7253,0 7291,1 7349,0 7392,1 7452,0 7498,1 7500,0 7545,1 7575,0 7606,1 7618,0 7713,1 7738,0 7760,1 7841,0 7905,1 7910,0 7962,1 8026,0 8104,1 8151,0 8174,1 8227,0 8303,1 8386,0 8424,1 8471,0 8498,1 8552,0 8561,1 8602,0 8668,1 8741,0 8758,1 8763,0 8796,1 8807,0 8839,1 8875,0 8934,1 8955,0 9028,1 9096,0 9167,1 9194,0 9277,1 9367,0 9372,1 9390,0 9466,1 9563,0 9662,1 9673,0 9735,1 9755,0 9855,1 9901,0 10000,1 10063,0 10083,1 10114,0 10213,1 10295,0 10393,1 10483,0 10558,1 10582,0 10615,1 10642,0 10674,1 10773,0 10866,1 10885,0 10982,1 11045,0 11075,1 11106,0 11185,1 11273,0 11352,1 11414,0 11458,1 11539,0 11631,1 11719,0 11818,1 11879,0 11909,1 11951,0 12031,1 12060,0 12112,1 12166,0 12196,1 12271,0 12314,1 12339,0 12436,1 12440,0 12533,1 12562,0 12646,1 12730,0 12810,1 12884,0 12948,1 12993,0 13005,1 13012,0 13084,1 13091,0 13168,1 13197,0 13290,1 13372,0 13455,1 end initlist a13 0,0 3,1 94,0 185,1 189,0 260,1 338,0 381,1 479,0 534,1 547,0 640,1 656,0 676,1 679,0 692,1 722,0 787,1 885,0 901,1 912,0 946,1 983,0 1010,1 1025,0 1036,1 1049,0 1107,1 1172,0 1268,1 1339,0 1399,1 1471,0 1478,1 1515,0 1565,1 1615,0 1689,1 1709,0 1775,1 1795,0 1798,1 1819,0 1835,1 1920,0 2016,1 2097,0 2111,1 2193,0 2202,1 2218,0 2287,1 2291,0 2334,1 2367,0 2438,1 2479,0 2498,1 2584,0 2647,1 2673,0 2759,1 2821,0 2888,1 2936,0 2971,1 2993,0 3069,1 3105,0 3199,1 3238,0 3326,1 3384,0 3442,1 3505,0 3532,1 3598,0 3620,1 3699,0 3756,1 3810,0 3902,1 3922,0 4019,1 4111,0 4175,1 4269,0 4319,1 4406,0 4422,1 4495,0 4528,1 4608,0 4683,1 4696,0 4732,1 4763,0 4786,1 4833,0 4850,1 4919,0 5008,1 5019,0 5115,1 5212,0 5215,1 5307,0 5385,1 5427,0 5501,1 5517,0 5591,1 5600,0 5616,1 5656,0 5701,1 5797,0 5798,1 5845,0 5878,1 5934,0 6006,1 6075,0 6100,1 6154,0 6254,1 6350,0 6355,1 6435,0 6467,1 6547,0 6591,1 6688,0 6753,1 6845,0 6941,1 7016,0 7100,1 7101,0 7155,1 7190,0 7202,1 7269,0 7325,1 7386,0 7486,1 7496,0 7571,1 7590,0 7642,1 7730,0 7783,1 7799,0 7867,1 7885,0 7920,1 7950,0 7974,1 8043,0 8087,1 8109,0 8133,1 8211,0 8224,1 8285,0 8351,1 8368,0 8404,1 8468,0 8494,1 8548,0 8553,1 8557,0 8592,1 8646,0 8672,1 8677,0 8679,1 8698,0 8770,1 8790,0 8845,1 8891,0 8897,1 8976,0 8986,1 8991,0 9065,1 9112,0 9206,1 9278,0 9288,1 9343,0 9394,1 9433,0 9451,1 9504,0 9589,1 9684,0 9772,1 9869,0 9932,1 9936,0 10020,1 10022,0 10079,1 10097,0 10195,1 10243,0 10327,1 10347,0 10413,1 10429,0 10493,1 10576,0 10598,1 10624,0 10718,1 10780,0 10867,1 10947,0 10999,1 11022,0 11122,1 11191,0 11288,1 11307,0 11404,1 11427,0 11454,1 11521,0 11549,1 11615,0 11661,1 11712,0 11757,1 11802,0 11871,1 11967,0 12007,1 12096,0 12142,1 12174,0 12203,1 12257,0 12282,1 12350,0 12419,1 12466,0 12526,1 12561,0 12602,1 12665,0 12712,1 12763,0 12810,1 12849,0 12876,1 end initlist a14 0,0 79,1 114,0 199,1 294,0 359,1 432,0 493,1 550,0 626,1 681,0 734,1 747,0 822,1 825,0 908,1 1006,0 1094,1 1187,0 1209,1 1287,0 1370,1 1405,0 1444,1 1531,0 1590,1 1655,0 1656,1 1752,0 1778,1 1875,0 1910,1 2002,0 2010,1 2020,0 2102,1 2135,0 2161,1 2181,0 2271,1 2277,0 2301,1 2358,0 2455,1 2493,0 2551,1 2627,0 2692,1 2710,0 2795,1 2838,0 2863,1 2917,0 2928,1 2964,0 2975,1 3072,0 3170,1 3233,0 3257,1 3304,0 3330,1 3371,0 3380,1 3426,0 3487,1 3526,0 3573,1 3659,0 3675,1 3715,0 3746,1 3784,0 3847,1 3902,0 3917,1 4004,0 4104,1 4196,0 4255,1 4285,0 4374,1 4403,0 4496,1 4504,0 4555,1 4562,0 4609,1 4691,0 4789,1 4858,0 4886,1 4978,0 4982,1 5009,0 5108,1 5116,0 5196,1 5271,0 5293,1 5309,0 5409,1 5480,0 5548,1 5556,0 5645,1 5689,0 5732,1 5779,0 5840,1 5904,0 5939,1 6015,0 6039,1 6090,0 6160,1 6196,0 6209,1 6225,0 6300,1 6343,0 6438,1 6517,0 6571,1 6648,0 6741,1 6760,0 6763,1 6807,0 6842,1 6935,0 7005,1 7043,0 7069,1 7142,0 7202,1 7288,0 7293,1 7356,0 7367,1 7401,0 7428,1 7507,0 7578,1 7587,0 7616,1 7683,0 7706,1 7746,0 7795,1 7857,0 7860,1 7926,0 7963,1 7988,0 8046,1 8117,0 8216,1 8256,0 8331,1 8430,0 8465,1 8494,0 8540,1 8559,0 8617,1 8693,0 8791,1 8811,0 8860,1 8861,0 8906,1 8956,0 9004,1 9012,0 9054,1 9133,0 9225,1 9302,0 9331,1 9401,0 9457,1 9554,0 9604,1 9690,0 9764,1 9794,0 9817,1 9839,0 9889,1 9958,0 10050,1 10081,0 10153,1 10171,0 10242,1 10322,0 10340,1 10431,0 10514,1 10536,0 10635,1 10649,0 10697,1 10762,0 10805,1 10895,0 10920,1 10955,0 11009,1 11026,0 11122,1 11129,0 11144,1 11174,0 11220,1 11231,0 11278,1 11280,0 11337,1 11417,0 11440,1 11451,0 11492,1 11506,0 11534,1 11606,0 11657,1 11733,0 11816,1 11837,0 11839,1 11862,0 11885,1 11886,0 11969,1 12046,0 12071,1 12090,0 12125,1 12153,0 12249,1 12294,0 12344,1 12386,0 12390,1 12447,0 12483,1 12505,0 12556,1 12560,0 12591,1 12595,0 12616,1 12644,0 12721,1 12755,0 12771,1 end initlist a15 0,0 61,1 66,0 143,1 224,0 242,1 267,0 316,1 320,0 413,1 440,0 533,1 622,0 632,1 697,0 726,1 811,0 837,1 897,0 975,1 1025,0 1095,1 1137,0 1167,1 1264,0 1332,1 1340,0 1371,1 1414,0 1457,1 1460,0 1514,1 1600,0 1641,1 1679,0 1692,1 1743,0 1803,1 1899,0 1965,1 1976,0 2073,1 2107,0 2195,1 2220,0 2292,1 2357,0 2393,1 2406,0 2416,1 2447,0 2481,1 2533,0 2630,1 2664,0 2688,1 2735,0 2826,1 2835,0 2875,1 2972,0 3070,1 3086,0 3161,1 3226,0 3303,1 3328,0 3369,1 3371,0 3437,1 3483,0 3520,1 3573,0 3626,1 3697,0 3788,1 3879,0 3929,1 3954,0 3969,1 4053,0 4074,1 4103,0 4179,1 4221,0 4237,1 4294,0 4353,1 4405,0 4465,1 4537,0 4605,1 4702,0 4795,1 4876,0 4937,1 4993,0 5008,1 5047,0 5112,1 5139,0 5160,1 5257,0 5317,1 5386,0 5438,1 5499,0 5544,1 5549,0 5634,1 5731,0 5747,1 5755,0 5773,1 5854,0 5902,1 5918,0 5920,1 5993,0 6036,1 6088,0 6159,1 6206,0 6232,1 6248,0 6326,1 6395,0 6461,1 6539,0 6589,1 6673,0 6744,1 6774,0 6831,1 6929,0 6946,1 6951,0 7008,1 7100,0 7189,1 7199,0 7237,1 7251,0 7276,1 7310,0 7394,1 7397,0 7421,1 7429,0 7477,1 7527,0 7593,1 7690,0 7770,1 7850,0 7916,1 7937,0 7958,1 7977,0 7999,1 8065,0 8106,1 8185,0 8217,1 8311,0 8342,1 8386,0 8477,1 8502,0 8596,1 8637,0 8658,1 8711,0 8739,1 8796,0 8893,1 8979,0 9063,1 9068,0 9134,1 9166,0 9188,1 9259,0 9280,1 9294,0 9323,1 9366,0 9412,1 9468,0 9500,1 9570,0 9600,1 9603,0 9631,1 9678,0 9690,1 9757,0 9819,1 9841,0 9852,1 9864,0 9908,1 9975,0 10058,1 10085,0 10127,1 10142,0 10165,1 10219,0 10262,1 10284,0 10292,1 10355,0 10447,1 10539,0 10617,1 10715,0 10739,1 10784,0 10835,1 10850,0 10915,1 10932,0 10942,1 10964,0 11051,1 11102,0 11153,1 11251,0 11321,1 11373,0 11428,1 11434,0 11531,1 11540,0 11563,1 11602,0 11656,1 11750,0 11821,1 11888,0 11891,1 11912,0 11942,1 12035,0 12123,1 12139,0 12178,1 12234,0 12317,1 12405,0 12410,1 12468,0 12541,1 12571,0 12626,1 12659,0 12750,1 end initlist a16 0,0 36,1 78,0 155,1 221,0 274,1 355,0 374,1 394,0 450,1 531,0 571,1 585,0 603,1 669,0 705,1 801,0 840,1 916,0 932,1 971,0 987,1 1033,0 1103,1 1129,0 1137,1 1183,0 1206,1 1248,0 1348,1 1391,0 1416,1 1429,0 1453,1 1547,0 1579,1 1629,0 1719,1 1742,0 1743,1 1824,0 1852,1 1901,0 1974,1 2027,0 2103,1 2154,0 2234,1 2321,0 2413,1 2461,0 2464,1 2503,0 2579,1 2663,0 2675,1 2726,0 2789,1 2877,0 2950,1 3027,0 3082,1 3141,0 3229,1 3263,0 3265,1 3350,0 3379,1 3438,0 3503,1 3510,0 3590,1 3671,0 3698,1 3759,0 3854,1 3908,0 3978,1 4054,0 4060,1 4112,0 4131,1 4183,0 4272,1 4364,0 4445,1 4465,0 4547,1 4582,0 4681,1 4726,0 4773,1 4844,0 4938,1 5006,0 5019,1 5100,0 5176,1 5272,0 5301,1 5321,0 5399,1 5432,0 5475,1 5525,0 5614,1 5671,0 5673,1 5709,0 5712,1 5783,0 5875,1 5889,0 5982,1 6003,0 6063,1 6148,0 6174,1 6221,0 6316,1 6352,0 6422,1 6466,0 6503,1 6523,0 6619,1 6714,0 6729,1 6816,0 6830,1 6877,0 6930,1 6984,0 7017,1 7100,0 7105,1 7155,0 7176,1 7243,0 7284,1 7292,0 7354,1 7404,0 7413,1 7420,0 7486,1 7566,0 7623,1 7664,0 7735,1 7795,0 7884,1 7895,0 7925,1 7928,0 8007,1 8033,0 8077,1 8146,0 8173,1 8248,0 8296,1 8396,0 8487,1 8576,0 8592,1 8687,0 8701,1 8740,0 8770,1 8848,0 8869,1 8908,0 8961,1 9059,0 9114,1 9131,0 9223,1 9225,0 9289,1 9384,0 9397,1 9437,0 9523,1 9559,0 9642,1 9736,0 9800,1 9843,0 9867,1 9933,0 9957,1 10010,0 10087,1 10164,0 10198,1 10220,0 10240,1 10291,0 10327,1 10372,0 10407,1 10428,0 10435,1 10523,0 10548,1 10633,0 10655,1 10691,0 10761,1 10855,0 10880,1 10937,0 10950,1 11017,0 11092,1 11141,0 11148,1 11214,0 11276,1 11286,0 11332,1 11342,0 11351,1 11406,0 11429,1 11463,0 11502,1 11587,0 11623,1 11664,0 11748,1 11847,0 11930,1 11967,0 11986,1 12044,0 12089,1 12161,0 12240,1 12333,0 12403,1 12482,0 12526,1 12624,0 12656,1 12698,0 12743,1 12825,0 12852,1 12918,0 12991,1 13026,0 13053,1 13134,0 13173,1 13243,0 13325,1 end initlist a17 0,0 56,1 79,0 143,1 237,0 280,1 313,0 387,1 418,0 481,1 488,0 498,1 563,0 597,1 686,0 698,1 781,0 789,1 803,0 818,1 841,0 881,1 918,0 946,1 1019,0 1027,1 1104,0 1158,1 1166,0 1252,1 1265,0 1299,1 1336,0 1345,1 1433,0 1461,1 1536,0 1611,1 1676,0 1772,1 1818,0 1822,1 1862,0 1962,1 1997,0 2075,1 2108,0 2139,1 2191,0 2263,1 2285,0 2311,1 2347,0 2415,1 2470,0 2564,1 2644,0 2695,1 2726,0 2776,1 2807,0 2829,1 2912,0 2913,1 2980,0 2988,1 3062,0 3162,1 3226,0 3289,1 3294,0 3343,1 3411,0 3428,1 3494,0 3564,1 3578,0 3661,1 3744,0 3798,1 3818,0 3853,1 3941,0 3982,1 4058,0 4116,1 4202,0 4287,1 4361,0 4371,1 4419,0 4462,1 4500,0 4514,1 4565,0 4644,1 4651,0 4696,1 4744,0 4784,1 4864,0 4938,1 5034,0 5083,1 5164,0 5242,1 5323,0 5392,1 5420,0 5451,1 5519,0 5591,1 5662,0 5735,1 5821,0 5889,1 5960,0 6023,1 6108,0 6183,1 6184,0 6274,1 6303,0 6344,1 6394,0 6437,1 6514,0 6564,1 6578,0 6613,1 6622,0 6702,1 6747,0 6831,1 6881,0 6911,1 6973,0 7051,1 7128,0 7160,1 7174,0 7233,1 7328,0 7427,1 7508,0 7540,1 7630,0 7715,1 7815,0 7904,1 7974,0 7987,1 8032,0 8082,1 8162,0 8228,1 8279,0 8322,1 8386,0 8426,1 8509,0 8528,1 8576,0 8640,1 8671,0 8764,1 8814,0 8893,1 8925,0 9009,1 9109,0 9181,1 9205,0 9304,1 9369,0 9463,1 9521,0 9616,1 9621,0 9677,1 9706,0 9731,1 9809,0 9823,1 9907,0 9988,1 10065,0 10093,1 10152,0 10247,1 10320,0 10417,1 10484,0 10566,1 10571,0 10604,1 10650,0 10729,1 10754,0 10846,1 10921,0 10954,1 11031,0 11080,1 11094,0 11147,1 11187,0 11280,1 11283,0 11349,1 11370,0 11385,1 11484,0 11503,1 11535,0 11618,1 11651,0 11678,1 11697,0 11788,1 11795,0 11881,1 11888,0 11986,1 12025,0 12063,1 12153,0 12178,1 12274,0 12281,1 12350,0 12437,1 12512,0 12513,1 12577,0 12623,1 12706,0 12745,1 12753,0 12772,1 12821,0 12879,1 12935,0 13012,1 13045,0 13089,1 13158,0 13185,1 13219,0 13231,1 13258,0 13335,1 13430,0 13499,1 13512,0 13580,1 13655,0 13676,1 end initlist a18 0,0 4,1 28,0 115,1 181,0 227,1 246,0 260,1 354,0 407,1 417,0 424,1 504,0 602,1 615,0 647,1 655,0 678,1 719,0 812,1 824,0 905,1 1001,0 1029,1 1039,0 1075,1 1140,0 1211,1 1294,0 1366,1 1408,0 1477,1 1519,0 1539,1 1546,0 1550,1 1621,0 1644,1 1710,0 1797,1 1815,0 1825,1 1844,0 1863,1 1929,0 2017,1 2058,0 2085,1 2173,0 2254,1 2258,0 2304,1 2381,0 2400,1 2417,0 2487,1 2509,0 2532,1 2554,0 2628,1 2703,0 2705,1 2725,0 2787,1 2850,0 2908,1 2961,0 2992,1 3078,0 3083,1 3100,0 3177,1 3246,0 3312,1 3315,0 3396,1 3449,0 3523,1 3538,0 3564,1 3613,0 3622,1 3686,0 3778,1 3867,0 3868,1 3922,0 3957,1 3960,0 3997,1 4037,0 4137,1 4223,0 4256,1 4330,0 4352,1 4377,0 4409,1 4461,0 4507,1 4521,0 4611,1 4635,0 4682,1 4689,0 4729,1 4819,0 4831,1 4875,0 4897,1 4990,0 5071,1 5125,0 5196,1 5250,0 5349,1 5387,0 5475,1 5535,0 5592,1 5674,0 5741,1 5838,0 5881,1 5916,0 5933,1 5987,0 6007,1 6104,0 6189,1 6254,0 6309,1 6317,0 6337,1 6397,0 6497,1 6543,0 6555,1 6568,0 6665,1 6758,0 6842,1 6843,0 6922,1 6969,0 7069,1 7113,0 7204,1 7244,0 7314,1 7373,0 7437,1 7482,0 7581,1 7603,0 7653,1 7721,0 7725,1 7759,0 7820,1 7906,0 7997,1 8089,0 8094,1 8143,0 8209,1 8252,0 8302,1 8330,0 8365,1 8400,0 8455,1 8459,0 8461,1 8483,0 8578,1 8596,0 8666,1 8747,0 8800,1 8822,0 8836,1 8851,0 8901,1 8907,0 8930,1 9027,0 9080,1 9088,0 9128,1 9188,0 9211,1 9263,0 9323,1 9414,0 9448,1 9495,0 9595,1 9653,0 9706,1 9719,0 9812,1 9851,0 9946,1 9997,0 10064,1 10080,0 10149,1 10242,0 10338,1 10438,0 10525,1 10574,0 10593,1 10629,0 10669,1 10703,0 10730,1 10776,0 10792,1 10853,0 10897,1 10946,0 10983,1 10984,0 11072,1 11073,0 11076,1 11084,0 11184,1 11239,0 11300,1 11355,0 11451,1 11488,0 11508,1 11592,0 11665,1 11666,0 11726,1 11748,0 11758,1 11831,0 11910,1 11956,0 11993,1 12055,0 12137,1 12219,0 12255,1 12327,0 12385,1 12420,0 12427,1 12503,0 12580,1 12659,0 12687,1 end initlist a19 0,0 17,1 75,0 96,1 142,0 186,1 224,0 320,1 346,0 385,1 410,0 476,1 497,0 565,1 597,0 599,1 672,0 700,1 726,0 786,1 791,0 875,1 924,0 989,1 1031,0 1109,1 1200,0 1211,1 1275,0 1289,1 1290,0 1318,1 1325,0 1399,1 1479,0 1492,1 1541,0 1593,1 1677,0 1710,1 1722,0 1767,1 1813,0 1907,1 1933,0 1993,1 2003,0 2090,1 2154,0 2253,1 2321,0 2343,1 2376,0 2435,1 2495,0 2529,1 2609,0 2644,1 2679,0 2696,1 2788,0 2864,1 2951,0 3019,1 3063,0 3136,1 3203,0 3229,1 3298,0 3395,1 3427,0 3449,1 3517,0 3616,1 3714,0 3759,1 3824,0 3899,1 3965,0 4000,1 4098,0 4152,1 4228,0 4279,1 4292,0 4337,1 4340,0 4349,1 4439,0 4476,1 4526,0 4594,1 4672,0 4764,1 4797,0 4821,1 4856,0 4884,1 4980,0 5039,1 5104,0 5115,1 5170,0 5216,1 5265,0 5320,1 5382,0 5393,1 5422,0 5467,1 5552,0 5599,1 5629,0 5687,1 5745,0 5794,1 5875,0 5909,1 6003,0 6006,1 6036,0 6136,1 6172,0 6179,1 6192,0 6284,1 6331,0 6414,1 6445,0 6493,1 6513,0 6547,1 6584,0 6666,1 6706,0 6720,1 6793,0 6816,1 6884,0 6948,1 6973,0 7005,1 7056,0 7095,1 7172,0 7174,1 7188,0 7233,1 7322,0 7330,1 7355,0 7360,1 7435,0 7482,1 7543,0 7640,1 7704,0 7741,1 7837,0 7936,1 8016,0 8051,1 8104,0 8132,1 8232,0 8282,1 8353,0 8383,1 8449,0 8463,1 8486,0 8581,1 8651,0 8652,1 8671,0 8675,1 8712,0 8783,1 8883,0 8915,1 8965,0 9057,1 9109,0 9166,1 9227,0 9271,1 9327,0 9363,1 9422,0 9465,1 9524,0 9547,1 9618,0 9649,1 9727,0 9749,1 9794,0 9811,1 9894,0 9993,1 10061,0 10121,1 10157,0 10255,1 10299,0 10309,1 10312,0 10327,1 10349,0 10438,1 10494,0 10538,1 10619,0 10647,1 10718,0 10802,1 10823,0 10837,1 10862,0 10870,1 10930,0 10982,1 11003,0 11092,1 11120,0 11189,1 11239,0 11267,1 11307,0 11317,1 11345,0 11439,1 11498,0 11550,1 11632,0 11657,1 11689,0 11767,1 11819,0 11829,1 11908,0 11995,1 12028,0 12059,1 12076,0 12127,1 12164,0 12189,1 12256,0 12356,1 12394,0 12454,1 12501,0 12508,1 12591,0 12603,1 12622,0 12700,1 end initlist a20 0,0 21,1 43,0 54,1 119,0 124,1 180,0 237,1 275,0 351,1 428,0 450,1 523,0 567,1 583,0 627,1 681,0 773,1 853,0 881,1 959,0 1025,1 1037,0 1094,1 1114,0 1145,1 1166,0 1250,1 1313,0 1323,1 1378,0 1390,1 1479,0 1538,1 1596,0 1662,1 1719,0 1720,1 1792,0 1816,1 1857,0 1934,1 2008,0 2104,1 2173,0 2237,1 2305,0 2372,1 2389,0 2484,1 2508,0 2513,1 2517,0 2604,1 2658,0 2670,1 2730,0 2820,1 2854,0 2857,1 2864,0 2959,1 2964,0 3004,1 3104,0 3192,1 3286,0 3385,1 3437,0 3444,1 3516,0 3567,1 3608,0 3704,1 3766,0 3841,1 3869,0 3874,1 3931,0 4007,1 4104,0 4170,1 4173,0 4226,1 4244,0 4315,1 4379,0 4403,1 4459,0 4503,1 4551,0 4621,1 4638,0 4703,1 4712,0 4729,1 4768,0 4793,1 4886,0 4921,1 4933,0 4967,1 4973,0 5023,1 5097,0 5149,1 5243,0 5302,1 5362,0 5406,1 5475,0 5490,1 5585,0 5640,1 5650,0 5696,1 5703,0 5711,1 5805,0 5806,1 5828,0 5864,1 5871,0 5936,1 5960,0 6050,1 6080,0 6149,1 6232,0 6269,1 6302,0 6362,1 6373,0 6380,1 6421,0 6441,1 6539,0 6552,1 6602,0 6621,1 6712,0 6763,1 6828,0 6843,1 6900,0 6962,1 7049,0 7143,1 7243,0 7315,1 7332,0 7346,1 7412,0 7427,1 7433,0 7476,1 7491,0 7541,1 7601,0 7606,1 7685,0 7777,1 7778,0 7864,1 7874,0 7938,1 7981,0 8013,1 8084,0 8180,1 8215,0 8302,1 8322,0 8391,1 8433,0 8478,1 8541,0 8611,1 8630,0 8703,1 8790,0 8813,1 8820,0 8896,1 8944,0 9035,1 9082,0 9097,1 9137,0 9232,1 9281,0 9286,1 9310,0 9347,1 9436,0 9443,1 9488,0 9513,1 9585,0 9659,1 9662,0 9717,1 9724,0 9813,1 9896,0 9923,1 9966,0 10058,1 10062,0 10092,1 10152,0 10210,1 10295,0 10393,1 10468,0 10494,1 10519,0 10538,1 10590,0 10596,1 10656,0 10723,1 10815,0 10877,1 10915,0 10972,1 11049,0 11129,1 11201,0 11271,1 11335,0 11354,1 11367,0 11380,1 11468,0 11557,1 11562,0 11585,1 11624,0 11644,1 11721,0 11788,1 11854,0 11887,1 11964,0 12013,1 12113,0 12154,1 12203,0 12256,1 12343,0 12376,1 12474,0 12487,1 12528,0 12547,1 12548,0 12627,1 end initlist a21 0,0 21,1 30,0 53,1 142,0 173,1 235,0 296,1 393,0 406,1 473,0 527,1 566,0 632,1 696,0 762,1 791,0 853,1 946,0 1042,1 1101,0 1115,1 1169,0 1207,1 1220,0 1260,1 1321,0 1354,1 1417,0 1479,1 1557,0 1645,1 1689,0 1702,1 1752,0 1770,1 1809,0 1847,1 1917,0 2012,1 2023,0 2071,1 2083,0 2175,1 2205,0 2242,1 2340,0 2386,1 2441,0 2453,1 2480,0 2563,1 2569,0 2653,1 2659,0 2664,1 2697,0 2698,1 2777,0 2871,1 2965,0 2985,1 3080,0 3139,1 3159,0 3229,1 3241,0 3336,1 3407,0 3415,1 3420,0 3475,1 3486,0 3536,1 3584,0 3608,1 3654,0 3751,1 3788,0 3860,1 3957,0 3984,1 4078,0 4168,1 4180,0 4230,1 4325,0 4391,1 4413,0 4423,1 4474,0 4571,1 4634,0 4656,1 4702,0 4755,1 4757,0 4836,1 4927,0 5019,1 5088,0 5187,1 5243,0 5251,1 5271,0 5278,1 5348,0 5386,1 5405,0 5473,1 5489,0 5579,1 5630,0 5698,1 5772,0 5834,1 5869,0 5926,1 5990,0 6086,1 6186,0 6284,1 6379,0 6467,1 6493,0 6560,1 6649,0 6681,1 6720,0 6786,1 6873,0 6911,1 6960,0 6966,1 7016,0 7053,1 7097,0 7099,1 7124,0 7180,1 7272,0 7301,1 7306,0 7333,1 7378,0 7471,1 7498,0 7553,1 7602,0 7643,1 7727,0 7801,1 7852,0 7949,1 7976,0 7998,1 8021,0 8092,1 8177,0 8211,1 8252,0 8292,1 8357,0 8373,1 8457,0 8501,1 8569,0 8618,1 8650,0 8722,1 8812,0 8874,1 8883,0 8964,1 9061,0 9081,1 9120,0 9124,1 9128,0 9168,1 9229,0 9243,1 9325,0 9393,1 9446,0 9492,1 9530,0 9578,1 9632,0 9725,1 9747,0 9824,1 9855,0 9902,1 9998,0 10016,1 10100,0 10152,1 10195,0 10247,1 10275,0 10359,1 10361,0 10412,1 10461,0 10518,1 10545,0 10551,1 10630,0 10659,1 10744,0 10782,1 10802,0 10804,1 10859,0 10869,1 10888,0 10953,1 10994,0 11031,1 11044,0 11074,1 11169,0 11232,1 11304,0 11400,1 11436,0 11510,1 11598,0 11667,1 11728,0 11775,1 11849,0 11854,1 11939,0 11990,1 12012,0 12027,1 12107,0 12163,1 12222,0 12226,1 12292,0 12337,1 12401,0 12480,1 12511,0 12529,1 12549,0 12571,1 12607,0 12616,1 12639,0 12665,1 12755,0 12799,1 12821,0 12833,1 end initlist a22 0,0 92,1 177,0 212,1 256,0 296,1 377,0 381,1 476,0 504,1 570,0 669,1 737,0 751,1 829,0 874,1 970,0 1032,1 1120,0 1182,1 1238,0 1262,1 1263,0 1283,1 1352,0 1415,1 1423,0 1445,1 1484,0 1512,1 1593,0 1683,1 1725,0 1751,1 1765,0 1795,1 1809,0 1830,1 1853,0 1944,1 2033,0 2090,1 2185,0 2206,1 2214,0 2292,1 2346,0 2351,1 2377,0 2450,1 2518,0 2602,1 2667,0 2694,1 2704,0 2789,1 2869,0 2932,1 3000,0 3049,1 3073,0 3077,1 3142,0 3145,1 3244,0 3283,1 3375,0 3467,1 3477,0 3506,1 3511,0 3590,1 3592,0 3653,1 3718,0 3746,1 3805,0 3855,1 3907,0 4004,1 4032,0 4088,1 4122,0 4196,1 4198,0 4298,1 4379,0 4390,1 4431,0 4456,1 4493,0 4582,1 4664,0 4756,1 4796,0 4871,1 4929,0 5029,1 5106,0 5109,1 5151,0 5205,1 5277,0 5348,1 5370,0 5385,1 5432,0 5503,1 5530,0 5589,1 5658,0 5722,1 5728,0 5792,1 5840,0 5890,1 5948,0 5953,1 5964,0 5993,1 6047,0 6097,1 6188,0 6198,1 6209,0 6257,1 6330,0 6427,1 6512,0 6568,1 6601,0 6634,1 6636,0 6726,1 6732,0 6737,1 6773,0 6825,1 6909,0 6959,1 7041,0 7080,1 7131,0 7223,1 7261,0 7356,1 7435,0 7438,1 7451,0 7473,1 7511,0 7530,1 7626,0 7715,1 7808,0 7869,1 7905,0 7978,1 8013,0 8029,1 8052,0 8128,1 8182,0 8249,1 8295,0 8299,1 8363,0 8444,1 8475,0 8506,1 8507,0 8534,1 8560,0 8615,1 8654,0 8725,1 8794,0 8890,1 8975,0 9006,1 9029,0 9049,1 9099,0 9108,1 9186,0 9197,1 9254,0 9319,1 9355,0 9430,1 9465,0 9512,1 9522,0 9611,1 9625,0 9635,1 9640,0 9706,1 9785,0 9867,1 9897,0 9956,1 9984,0 10048,1 10057,0 10129,1 10133,0 10148,1 10201,0 10292,1 10321,0 10381,1 10439,0 10452,1 10545,0 10624,1 10695,0 10732,1 10788,0 10857,1 10904,0 10994,1 11046,0 11109,1 11161,0 11213,1 11277,0 11371,1 11439,0 11534,1 11615,0 11654,1 11667,0 11674,1 11678,0 11723,1 11745,0 11835,1 11928,0 12021,1 12102,0 12158,1 12235,0 12248,1 12291,0 12355,1 12368,0 12421,1 12453,0 12455,1 12478,0 12573,1 12639,0 12651,1 12678,0 12707,1 12736,0 12743,1 end initlist a23 0,0 45,1 103,0 190,1 265,0 346,1 437,0 501,1 581,0 674,1 694,0 725,1 746,0 820,1 836,0 904,1 920,0 958,1 1017,0 1063,1 1135,0 1233,1 1327,0 1413,1 1504,0 1508,1 1548,0 1577,1 1644,0 1696,1 1700,0 1760,1 1833,0 1894,1 1933,0 1994,1 2086,0 2158,1 2257,0 2261,1 2340,0 2425,1 2448,0 2451,1 2490,0 2579,1 2613,0 2627,1 2727,0 2805,1 2811,0 2882,1 2898,0 2948,1 3033,0 3053,1 3151,0 3159,1 3238,0 3330,1 3334,0 3353,1 3445,0 3535,1 3559,0 3615,1 3643,0 3695,1 3726,0 3823,1 3867,0 3918,1 3937,0 3946,1 3971,0 4038,1 4098,0 4101,1 4188,0 4217,1 4221,0 4302,1 4387,0 4484,1 4562,0 4622,1 4642,0 4669,1 4725,0 4730,1 4754,0 4838,1 4871,0 4939,1 5004,0 5055,1 5062,0 5122,1 5162,0 5222,1 5320,0 5352,1 5429,0 5498,1 5536,0 5555,1 5612,0 5673,1 5682,0 5751,1 5822,0 5862,1 5883,0 5968,1 6036,0 6056,1 6072,0 6086,1 6159,0 6221,1 6320,0 6334,1 6413,0 6481,1 6555,0 6647,1 6670,0 6702,1 6744,0 6781,1 6828,0 6869,1 6873,0 6908,1 6974,0 7013,1 7080,0 7091,1 7155,0 7172,1 7179,0 7259,1 7313,0 7356,1 7434,0 7490,1 7572,0 7613,1 7641,0 7735,1 7814,0 7869,1 7955,0 8005,1 8056,0 8116,1 8168,0 8207,1 8244,0 8273,1 8331,0 8427,1 8460,0 8546,1 8614,0 8626,1 8710,0 8731,1 8812,0 8815,1 8848,0 8889,1 8936,0 8981,1 8989,0 9044,1 9080,0 9130,1 9188,0 9253,1 9311,0 9334,1 9433,0 9454,1 9514,0 9573,1 9635,0 9708,1 9718,0 9797,1 9827,0 9836,1 9859,0 9870,1 9871,0 9909,1 10002,0 10047,1 10146,0 10184,1 10202,0 10240,1 10292,0 10313,1 10408,0 10453,1 10548,0 10553,1 10555,0 10559,1 10630,0 10667,1 10763,0 10858,1 10949,0 10993,1 11069,0 11071,1 11083,0 11098,1 11165,0 11225,1 11255,0 11296,1 11393,0 11395,1 11401,0 11474,1 11523,0 11569,1 11669,0 11725,1 11808,0 11876,1 11914,0 11943,1 12014,0 12027,1 12088,0 12109,1 12209,0 12225,1 12243,0 12328,1 12346,0 12396,1 12458,0 12507,1 12556,0 12599,1 12643,0 12742,1 12824,0 12855,1 12920,0 12969,1 13054,0 13076,1 end initlist a24 0,0 46,1 62,0 96,1 158,0 189,1 265,0 269,1 316,0 322,1 382,0 447,1 451,0 540,1 599,0 657,1 716,0 803,1 821,0 840,1 880,0 917,1 960,0 1044,1 1117,0 1181,1 1206,0 1287,1 1346,0 1388,1 1424,0 1443,1 1455,0 1522,1 1545,0 1592,1 1603,0 1663,1 1690,0 1786,1 1797,0 1895,1 1949,0 1975,1 2054,0 2118,1 2152,0 2200,1 2277,0 2345,1 2359,0 2454,1 2487,0 2585,1 2643,0 2666,1 2707,0 2765,1 2826,0 2903,1 2909,0 2961,1 2982,0 3007,1 3061,0 3100,1 3199,0 3227,1 3302,0 3352,1 3429,0 3485,1 3549,0 3599,1 3666,0 3752,1 3833,0 3919,1 3999,0 4048,1 4069,0 4115,1 4182,0 4187,1 4199,0 4244,1 4298,0 4367,1 4394,0 4459,1 4462,0 4517,1 4522,0 4590,1 4643,0 4674,1 4768,0 4807,1 4887,0 4905,1 4913,0 4988,1 5020,0 5095,1 5148,0 5183,1 5199,0 5264,1 5291,0 5294,1 5316,0 5374,1 5438,0 5480,1 5509,0 5598,1 5611,0 5640,1 5662,0 5696,1 5708,0 5756,1 5789,0 5849,1 5938,0 6000,1 6039,0 6098,1 6169,0 6170,1 6222,0 6311,1 6332,0 6358,1 6424,0 6513,1 6565,0 6596,1 6671,0 6771,1 6859,0 6956,1 7033,0 7058,1 7114,0 7151,1 7158,0 7226,1 7279,0 7379,1 7430,0 7490,1 7492,0 7515,1 7565,0 7600,1 7631,0 7654,1 7695,0 7750,1 7753,0 7838,1 7873,0 7958,1 8024,0 8097,1 8128,0 8155,1 8178,0 8242,1 8290,0 8350,1 8446,0 8520,1 8582,0 8622,1 8681,0 8718,1 8775,0 8869,1 8968,0 9003,1 9099,0 9162,1 9202,0 9287,1 9299,0 9367,1 9394,0 9486,1 9578,0 9678,1 9766,0 9865,1 9963,0 9996,1 10000,0 10012,1 10110,0 10126,1 10131,0 10211,1 10296,0 10386,1 10408,0 10427,1 10459,0 10495,1 10513,0 10546,1 10574,0 10663,1 10697,0 10775,1 10783,0 10834,1 10904,0 10988,1 11020,0 11118,1 11209,0 11301,1 11388,0 11454,1 11515,0 11567,1 11619,0 11695,1 11770,0 11835,1 11920,0 12000,1 12063,0 12159,1 12248,0 12278,1 12373,0 12433,1 12460,0 12512,1 12536,0 12626,1 12636,0 12661,1 12713,0 12769,1 12834,0 12903,1 13001,0 13014,1 13017,0 13035,1 13133,0 13217,1 13304,0 13352,1 13413,0 13467,1 end initlist a25 0,0 57,1 128,0 168,1 242,0 252,1 337,0 408,1 483,0 538,1 611,0 698,1 778,0 829,1 837,0 936,1 972,0 1000,1 1002,0 1061,1 1071,0 1136,1 1151,0 1155,1 1188,0 1261,1 1297,0 1333,1 1342,0 1432,1 1477,0 1538,1 1582,0 1602,1 1699,0 1741,1 1779,0 1807,1 1896,0 1958,1 2037,0 2134,1 2229,0 2264,1 2311,0 2364,1 2403,0 2475,1 2557,0 2598,1 2659,0 2759,1 2768,0 2787,1 2863,0 2903,1 2919,0 2954,1 3000,0 3003,1 3067,0 3099,1 3112,0 3115,1 3191,0 3198,1 3243,0 3266,1 3313,0 3315,1 3351,0 3449,1 3498,0 3519,1 3541,0 3581,1 3584,0 3633,1 3677,0 3775,1 3814,0 3902,1 4002,0 4091,1 4156,0 4164,1 4213,0 4302,1 4329,0 4415,1 4462,0 4479,1 4536,0 4578,1 4646,0 4744,1 4764,0 4798,1 4811,0 4883,1 4952,0 5005,1 5059,0 5076,1 5138,0 5213,1 5280,0 5370,1 5421,0 5457,1 5553,0 5598,1 5665,0 5698,1 5718,0 5792,1 5833,0 5878,1 5950,0 5961,1 5975,0 6066,1 6137,0 6214,1 6216,0 6248,1 6311,0 6341,1 6367,0 6449,1 6526,0 6548,1 6563,0 6604,1 6697,0 6797,1 6810,0 6852,1 6861,0 6927,1 6937,0 6994,1 7050,0 7079,1 7098,0 7165,1 7238,0 7332,1 7393,0 7478,1 7519,0 7560,1 7611,0 7628,1 7694,0 7711,1 7803,0 7847,1 7857,0 7882,1 7891,0 7983,1 8057,0 8134,1 8205,0 8237,1 8309,0 8320,1 8398,0 8423,1 8469,0 8547,1 8622,0 8672,1 8732,0 8759,1 8782,0 8783,1 8836,0 8910,1 8912,0 8969,1 9012,0 9098,1 9176,0 9250,1 9333,0 9368,1 9373,0 9392,1 9480,0 9505,1 9598,0 9677,1 9730,0 9827,1 9838,0 9928,1 9998,0 10056,1 10058,0 10121,1 10196,0 10268,1 10303,0 10355,1 10365,0 10398,1 10449,0 10470,1 10538,0 10560,1 10562,0 10598,1 10663,0 10726,1 10825,0 10848,1 10864,0 10964,1 11063,0 11106,1 11187,0 11215,1 11282,0 11308,1 11357,0 11360,1 11419,0 11476,1 11488,0 11514,1 11575,0 11611,1 11671,0 11745,1 11841,0 11932,1 11957,0 12040,1 12070,0 12101,1 12173,0 12225,1 12265,0 12302,1 12329,0 12368,1 12443,0 12538,1 12592,0 12626,1 12656,0 12756,1 12762,0 12794,1 12805,0 12807,1 end initlist a26 0,0 19,1 64,0 116,1 176,0 188,1 223,0 278,1 290,0 313,1 323,0 394,1 414,0 423,1 458,0 504,1 559,0 631,1 639,0 676,1 731,0 823,1 842,0 920,1 991,0 1071,1 1159,0 1223,1 1323,0 1405,1 1443,0 1481,1 1536,0 1633,1 1722,0 1761,1 1765,0 1774,1 1844,0 1921,1 2000,0 2017,1 2063,0 2132,1 2182,0 2258,1 2274,0 2349,1 2385,0 2477,1 2503,0 2529,1 2543,0 2637,1 2665,0 2702,1 2783,0 2862,1 2930,0 2948,1 2979,0 3054,1 3125,0 3214,1 3242,0 3259,1 3326,0 3414,1 3506,0 3559,1 3586,0 3595,1 3612,0 3648,1 3671,0 3715,1 3744,0 3835,1 3851,0 3871,1 3958,0 3979,1 4069,0 4115,1 4192,0 4234,1 4274,0 4317,1 4376,0 4380,1 4452,0 4531,1 4602,0 4693,1 4746,0 4805,1 4864,0 4919,1 4966,0 4994,1 5022,0 5115,1 5156,0 5249,1 5298,0 5387,1 5394,0 5452,1 5456,0 5519,1 5575,0 5651,1 5691,0 5698,1 5720,0 5723,1 5780,0 5831,1 5841,0 5895,1 5910,0 5948,1 6025,0 6090,1 6115,0 6158,1 6243,0 6313,1 6407,0 6441,1 6506,0 6594,1 6651,0 6658,1 6687,0 6717,1 6765,0 6790,1 6811,0 6910,1 6954,0 7014,1 7020,0 7105,1 7153,0 7194,1 7262,0 7315,1 7401,0 7445,1 7490,0 7539,1 7608,0 7630,1 7660,0 7724,1 7752,0 7820,1 7918,0 7994,1 8079,0 8133,1 8205,0 8298,1 8375,0 8413,1 8419,0 8479,1 8491,0 8508,1 8516,0 8616,1 8654,0 8733,1 8802,0 8840,1 8927,0 9013,1 9041,0 9098,1 9196,0 9270,1 9351,0 9442,1 9539,0 9619,1 9712,0 9719,1 9789,0 9805,1 9808,0 9824,1 9836,0 9917,1 9973,0 10010,1 10101,0 10174,1 10204,0 10263,1 10351,0 10446,1 10518,0 10548,1 10604,0 10637,1 10653,0 10712,1 10717,0 10816,1 10887,0 10944,1 10997,0 11028,1 11125,0 11159,1 11199,0 11204,1 11293,0 11315,1 11405,0 11496,1 11501,0 11595,1 11668,0 11730,1 11798,0 11820,1 11855,0 11884,1 11894,0 11920,1 12006,0 12051,1 12094,0 12175,1 12263,0 12350,1 12445,0 12475,1 12551,0 12645,1 12736,0 12754,1 12837,0 12898,1 12936,0 12972,1 13001,0 13045,1 13051,0 13082,1 13167,0 13226,1 13258,0 13274,1 13286,0 13386,1 end initlist a27 0,0 21,1 93,0 136,1 213,0 253,1 338,0 360,1 403,0 430,1 449,0 487,1 509,0 589,1 600,0 603,1 698,0 759,1 857,0 948,1 1010,0 1087,1 1111,0 1178,1 1219,0 1317,1 1331,0 1424,1 1437,0 1450,1 1496,0 1504,1 1556,0 1563,1 1575,0 1662,1 1733,0 1741,1 1814,0 1869,1 1942,0 2024,1 2069,0 2079,1 2127,0 2133,1 2221,0 2239,1 2279,0 2301,1 2381,0 2425,1 2436,0 2509,1 2570,0 2599,1 2688,0 2738,1 2759,0 2851,1 2861,0 2938,1 2960,0 2964,1 3054,0 3124,1 3153,0 3210,1 3240,0 3266,1 3315,0 3374,1 3445,0 3514,1 3521,0 3553,1 3586,0 3618,1 3643,0 3681,1 3749,0 3810,1 3847,0 3893,1 3949,0 4036,1 4100,0 4125,1 4154,0 4187,1 4245,0 4318,1 4366,0 4369,1 4461,0 4559,1 4645,0 4655,1 4742,0 4754,1 4759,0 4785,1 4867,0 4954,1 4999,0 5036,1 5065,0 5145,1 5239,0 5336,1 5378,0 5396,1 5449,0 5487,1 5539,0 5633,1 5667,0 5749,1 5773,0 5842,1 5903,0 5928,1 5942,0 5965,1 5997,0 6081,1 6088,0 6157,1 6215,0 6253,1 6285,0 6361,1 6376,0 6465,1 6532,0 6602,1 6638,0 6719,1 6810,0 6858,1 6953,0 6956,1 7046,0 7101,1 7134,0 7232,1 7305,0 7310,1 7377,0 7455,1 7532,0 7552,1 7560,0 7585,1 7646,0 7731,1 7804,0 7855,1 7894,0 7969,1 8007,0 8064,1 8107,0 8206,1 8267,0 8306,1 8321,0 8323,1 8371,0 8408,1 8427,0 8432,1 8445,0 8536,1 8604,0 8694,1 8769,0 8793,1 8822,0 8872,1 8949,0 8953,1 9033,0 9064,1 9146,0 9177,1 9272,0 9309,1 9387,0 9390,1 9439,0 9513,1 9516,0 9519,1 9606,0 9676,1 9678,0 9738,1 9815,0 9879,1 9896,0 9941,1 9981,0 9985,1 9995,0 10039,1 10056,0 10122,1 10161,0 10246,1 10319,0 10351,1 10427,0 10524,1 10562,0 10623,1 10633,0 10646,1 10708,0 10744,1 10813,0 10818,1 10904,0 10930,1 10962,0 10972,1 10981,0 11070,1 11099,0 11184,1 11216,0 11258,1 11309,0 11356,1 11388,0 11464,1 11530,0 11610,1 11679,0 11761,1 11843,0 11862,1 11952,0 12037,1 12118,0 12210,1 12239,0 12240,1 12300,0 12341,1 12348,0 12428,1 12522,0 12605,1 12643,0 12656,1 12674,0 12703,1 end initlist a28 0,0 21,1 112,0 191,1 204,0 222,1 295,0 305,1 369,0 414,1 492,0 522,1 599,0 675,1 773,0 827,1 842,0 876,1 900,0 903,1 973,0 1061,1 1123,0 1152,1 1174,0 1191,1 1241,0 1314,1 1408,0 1410,1 1452,0 1462,1 1539,0 1582,1 1620,0 1681,1 1772,0 1797,1 1881,0 1937,1 2033,0 2057,1 2087,0 2110,1 2193,0 2270,1 2312,0 2350,1 2379,0 2404,1 2501,0 2560,1 2654,0 2738,1 2814,0 2843,1 2927,0 3017,1 3071,0 3102,1 3193,0 3209,1 3277,0 3292,1 3330,0 3360,1 3411,0 3428,1 3448,0 3475,1 3548,0 3592,1 3600,0 3687,1 3781,0 3843,1 3908,0 3972,1 4037,0 4116,1 4209,0 4282,1 4284,0 4340,1 4438,0 4497,1 4560,0 4589,1 4656,0 4750,1 4808,0 4873,1 4930,0 4943,1 5040,0 5061,1 5152,0 5202,1 5218,0 5311,1 5347,0 5430,1 5497,0 5580,1 5619,0 5641,1 5693,0 5726,1 5761,0 5837,1 5936,0 5998,1 6064,0 6140,1 6146,0 6151,1 6222,0 6283,1 6287,0 6297,1 6365,0 6413,1 6435,0 6533,1 6582,0 6611,1 6616,0 6699,1 6798,0 6857,1 6884,0 6938,1 6952,0 7018,1 7048,0 7080,1 7170,0 7199,1 7225,0 7317,1 7333,0 7427,1 7489,0 7565,1 7643,0 7674,1 7694,0 7791,1 7878,0 7912,1 7995,0 8058,1 8141,0 8143,1 8155,0 8230,1 8326,0 8359,1 8408,0 8445,1 8459,0 8478,1 8492,0 8588,1 8622,0 8698,1 8747,0 8824,1 8866,0 8949,1 9039,0 9049,1 9143,0 9206,1 9275,0 9301,1 9311,0 9330,1 9412,0 9432,1 9468,0 9471,1 9512,0 9514,1 9528,0 9561,1 9592,0 9623,1 9631,0 9648,1 9732,0 9797,1 9848,0 9858,1 9948,0 9959,1 10046,0 10114,1 10179,0 10212,1 10266,0 10308,1 10339,0 10379,1 10478,0 10491,1 10579,0 10612,1 10679,0 10692,1 10789,0 10821,1 10920,0 10944,1 11035,0 11062,1 11134,0 11175,1 11193,0 11209,1 11263,0 11267,1 11337,0 11433,1 11505,0 11598,1 11692,0 11738,1 11775,0 11845,1 11931,0 11967,1 12055,0 12130,1 12229,0 12275,1 12354,0 12372,1 12468,0 12548,1 12643,0 12697,1 12782,0 12853,1 12872,0 12892,1 12937,0 13030,1 13059,0 13122,1 13187,0 13274,1 13309,0 13327,1 13426,0 13487,1 13532,0 13599,1 end initlist a29 0,0 57,1 78,0 92,1 107,0 152,1 202,0 211,1 254,0 260,1 293,0 393,1 431,0 522,1 569,0 655,1 703,0 784,1 816,0 843,1 922,0 930,1 965,0 1053,1 1134,0 1140,1 1185,0 1212,1 1282,0 1379,1 1448,0 1457,1 1521,0 1572,1 1599,0 1673,1 1736,0 1774,1 1846,0 1864,1 1949,0 1964,1 2018,0 2052,1 2063,0 2163,1 2258,0 2282,1 2316,0 2362,1 2431,0 2486,1 2541,0 2622,1 2719,0 2810,1 2868,0 2890,1 2954,0 2986,1 2992,0 3041,1 3097,0 3111,1 3165,0 3238,1 3335,0 3426,1 3463,0 3470,1 3520,0 3584,1 3655,0 3728,1 3739,0 3828,1 3853,0 3892,1 3926,0 3949,1 4022,0 4054,1 4127,0 4128,1 4141,0 4170,1 4188,0 4226,1 4285,0 4300,1 4342,0 4429,1 4503,0 4510,1 4556,0 4625,1 4708,0 4713,1 4766,0 4771,1 4818,0 4820,1 4912,0 4995,1 5048,0 5093,1 5125,0 5134,1 5166,0 5238,1 5279,0 5284,1 5293,0 5350,1 5422,0 5517,1 5600,0 5661,1 5682,0 5746,1 5751,0 5760,1 5811,0 5891,1 5940,0 5958,1 6036,0 6101,1 6114,0 6126,1 6143,0 6154,1 6189,0 6284,1 6288,0 6298,1 6378,0 6459,1 6509,0 6533,1 6590,0 6610,1 6674,0 6747,1 6793,0 6826,1 6832,0 6839,1 6903,0 6977,1 7031,0 7039,1 7048,0 7054,1 7074,0 7111,1 7190,0 7216,1 7274,0 7277,1 7284,0 7301,1 7316,0 7320,1 7416,0 7481,1 7483,0 7515,1 7540,0 7630,1 7680,0 7754,1 7792,0 7866,1 7944,0 7959,1 7961,0 8061,1 8082,0 8135,1 8163,0 8170,1 8217,0 8262,1 8308,0 8383,1 8480,0 8482,1 8574,0 8575,1 8645,0 8745,1 8752,0 8761,1 8793,0 8851,1 8884,0 8918,1 8980,0 8989,1 9047,0 9090,1 9110,0 9182,1 9243,0 9298,1 9319,0 9334,1 9413,0 9437,1 9485,0 9533,1 9609,0 9671,1 9682,0 9700,1 9710,0 9712,1 9772,0 9867,1 9882,0 9929,1 9943,0 10042,1 10106,0 10140,1 10201,0 10271,1 10349,0 10433,1 10475,0 10500,1 10542,0 10628,1 10697,0 10750,1 10784,0 10861,1 10945,0 11031,1 11037,0 11128,1 11218,0 11280,1 11282,0 11317,1 11368,0 11392,1 11486,0 11545,1 11549,0 11611,1 11677,0 11710,1 11810,0 11867,1 11919,0 11932,1 end initlist a30 0,0 8,1 36,0 87,1 104,0 146,1 169,0 242,1 330,0 385,1 442,0 489,1 544,0 631,1 643,0 644,1 710,0 711,1 724,0 824,1 833,0 862,1 864,0 930,1 980,0 1048,1 1145,0 1195,1 1288,0 1358,1 1397,0 1442,1 1492,0 1580,1 1636,0 1727,1 1821,0 1860,1 1921,0 1962,1 2042,0 2116,1 2206,0 2283,1 2303,0 2402,1 2419,0 2425,1 2480,0 2549,1 2617,0 2696,1 2763,0 2799,1 2877,0 2945,1 3010,0 3060,1 3133,0 3158,1 3222,0 3306,1 3389,0 3458,1 3521,0 3602,1 3675,0 3683,1 3709,0 3763,1 3817,0 3859,1 3908,0 3968,1 4001,0 4076,1 4158,0 4211,1 4247,0 4289,1 4312,0 4405,1 4488,0 4517,1 4572,0 4589,1 4598,0 4603,1 4614,0 4671,1 4697,0 4782,1 4868,0 4887,1 4967,0 4988,1 4990,0 5061,1 5091,0 5117,1 5154,0 5249,1 5289,0 5384,1 5400,0 5447,1 5474,0 5475,1 5565,0 5664,1 5680,0 5712,1 5733,0 5800,1 5845,0 5932,1 6004,0 6104,1 6188,0 6248,1 6309,0 6347,1 6398,0 6399,1 6440,0 6483,1 6506,0 6571,1 6668,0 6717,1 6787,0 6827,1 6905,0 6944,1 6967,0 6994,1 7059,0 7097,1 7185,0 7227,1 7278,0 7332,1 7350,0 7396,1 7467,0 7516,1 7573,0 7627,1 7637,0 7718,1 7747,0 7751,1 7822,0 7881,1 7945,0 8025,1 8078,0 8082,1 8145,0 8232,1 8318,0 8325,1 8381,0 8437,1 8456,0 8542,1 8591,0 8652,1 8714,0 8761,1 8783,0 8856,1 8892,0 8984,1 9040,0 9063,1 9111,0 9156,1 9183,0 9206,1 9227,0 9245,1 9306,0 9329,1 9341,0 9401,1 9470,0 9561,1 9589,0 9672,1 9715,0 9752,1 9830,0 9910,1 9932,0 9988,1 10075,0 10119,1 10179,0 10235,1 10253,0 10291,1 10350,0 10353,1 10403,0 10431,1 10454,0 10457,1 10493,0 10571,1 10671,0 10714,1 10746,0 10818,1 10870,0 10913,1 10994,0 11047,1 11127,0 11225,1 11279,0 11346,1 11385,0 11409,1 11504,0 11598,1 11600,0 11645,1 11731,0 11830,1 11901,0 11972,1 12022,0 12056,1 12138,0 12205,1 12302,0 12344,1 12412,0 12448,1 12519,0 12587,1 12670,0 12671,1 12753,0 12814,1 12853,0 12935,1 12958,0 13057,1 13120,0 13185,1 13228,0 13321,1 13392,0 13393,1 13441,0 13493,1 end initlist a31 0,0 73,1 85,0 145,1 156,0 189,1 256,0 340,1 376,0 463,1 467,0 555,1 655,0 707,1 720,0 776,1 872,0 898,1 944,0 965,1 1029,0 1071,1 1152,0 1175,1 1203,0 1230,1 1303,0 1336,1 1340,0 1370,1 1466,0 1556,1 1584,0 1659,1 1746,0 1784,1 1872,0 1890,1 1925,0 1974,1 1976,0 2001,1 2073,0 2138,1 2152,0 2205,1 2266,0 2340,1 2427,0 2523,1 2541,0 2563,1 2593,0 2634,1 2712,0 2732,1 2777,0 2813,1 2913,0 2938,1 3017,0 3086,1 3132,0 3140,1 3148,0 3203,1 3210,0 3229,1 3328,0 3416,1 3491,0 3513,1 3549,0 3637,1 3692,0 3752,1 3847,0 3908,1 3977,0 4038,1 4105,0 4200,1 4230,0 4281,1 4331,0 4373,1 4429,0 4519,1 4584,0 4657,1 4672,0 4766,1 4835,0 4845,1 4909,0 4997,1 5023,0 5099,1 5168,0 5219,1 5273,0 5363,1 5440,0 5498,1 5542,0 5607,1 5620,0 5687,1 5737,0 5752,1 5825,0 5911,1 5956,0 6039,1 6088,0 6142,1 6163,0 6173,1 6201,0 6248,1 6292,0 6304,1 6344,0 6367,1 6383,0 6405,1 6420,0 6441,1 6492,0 6551,1 6561,0 6597,1 6624,0 6651,1 6723,0 6797,1 6893,0 6944,1 6958,0 7010,1 7080,0 7101,1 7171,0 7257,1 7326,0 7366,1 7399,0 7410,1 7485,0 7585,1 7594,0 7605,1 7648,0 7707,1 7730,0 7740,1 7817,0 7824,1 7852,0 7933,1 8008,0 8094,1 8151,0 8188,1 8240,0 8303,1 8389,0 8412,1 8459,0 8483,1 8494,0 8568,1 8630,0 8659,1 8661,0 8669,1 8675,0 8708,1 8772,0 8863,1 8873,0 8913,1 8927,0 9024,1 9094,0 9189,1 9266,0 9276,1 9301,0 9362,1 9371,0 9413,1 9460,0 9492,1 9504,0 9511,1 9558,0 9559,1 9606,0 9611,1 9692,0 9757,1 9763,0 9817,1 9890,0 9973,1 10029,0 10037,1 10127,0 10149,1 10191,0 10276,1 10353,0 10377,1 10419,0 10497,1 10572,0 10650,1 10686,0 10727,1 10783,0 10824,1 10920,0 10995,1 11002,0 11071,1 11078,0 11102,1 11128,0 11222,1 11229,0 11316,1 11416,0 11482,1 11538,0 11573,1 11630,0 11656,1 11693,0 11750,1 11758,0 11829,1 11900,0 11938,1 12009,0 12057,1 12154,0 12211,1 12226,0 12290,1 12357,0 12382,1 12461,0 12468,1 12482,0 12554,1 12622,0 12714,1 end initlist a32 0,0 95,1 140,0 173,1 207,0 231,1 284,0 323,1 386,0 449,1 460,0 492,1 578,0 644,1 647,0 688,1 689,0 694,1 745,0 818,1 880,0 967,1 985,0 1051,1 1128,0 1134,1 1229,0 1236,1 1311,0 1383,1 1443,0 1541,1 1553,0 1558,1 1620,0 1681,1 1742,0 1784,1 1841,0 1877,1 1939,0 1950,1 1984,0 2069,1 2077,0 2119,1 2159,0 2207,1 2252,0 2339,1 2437,0 2446,1 2508,0 2566,1 2655,0 2670,1 2764,0 2819,1 2855,0 2885,1 2921,0 2980,1 3016,0 3065,1 3145,0 3182,1 3275,0 3276,1 3344,0 3385,1 3400,0 3407,1 3504,0 3590,1 3683,0 3745,1 3821,0 3849,1 3883,0 3887,1 3931,0 3986,1 3987,0 4037,1 4038,0 4051,1 4128,0 4222,1 4311,0 4401,1 4499,0 4596,1 4693,0 4771,1 4869,0 4959,1 5035,0 5062,1 5115,0 5182,1 5198,0 5283,1 5380,0 5478,1 5550,0 5590,1 5666,0 5675,1 5754,0 5763,1 5815,0 5898,1 5944,0 5973,1 5990,0 6017,1 6053,0 6112,1 6138,0 6233,1 6323,0 6364,1 6396,0 6460,1 6537,0 6629,1 6718,0 6796,1 6821,0 6857,1 6930,0 6987,1 7026,0 7064,1 7118,0 7150,1 7189,0 7229,1 7322,0 7422,1 7483,0 7550,1 7608,0 7704,1 7752,0 7823,1 7919,0 8015,1 8113,0 8160,1 8195,0 8218,1 8306,0 8382,1 8386,0 8459,1 8489,0 8581,1 8622,0 8664,1 8747,0 8774,1 8778,0 8865,1 8939,0 9019,1 9068,0 9096,1 9155,0 9217,1 9312,0 9317,1 9334,0 9364,1 9463,0 9527,1 9566,0 9599,1 9638,0 9648,1 9742,0 9775,1 9778,0 9816,1 9880,0 9940,1 9975,0 10053,1 10080,0 10167,1 10207,0 10211,1 10255,0 10312,1 10364,0 10427,1 10495,0 10579,1 10607,0 10634,1 10635,0 10703,1 10747,0 10811,1 10893,0 10933,1 10998,0 11060,1 11150,0 11210,1 11244,0 11292,1 11325,0 11356,1 11398,0 11429,1 11497,0 11522,1 11537,0 11545,1 11604,0 11620,1 11693,0 11698,1 11722,0 11773,1 11786,0 11813,1 11833,0 11836,1 11916,0 11995,1 12018,0 12046,1 12131,0 12213,1 12267,0 12361,1 12404,0 12490,1 12524,0 12623,1 12717,0 12760,1 12851,0 12948,1 12952,0 13035,1 13054,0 13150,1 13193,0 13276,1 13376,0 13448,1 13461,0 13537,1 13597,0 13604,1 end initlist a33 0,0 33,1 67,0 156,1 170,0 221,1 267,0 354,1 382,0 450,1 491,0 507,1 607,0 643,1 738,0 746,1 802,0 859,1 930,0 1017,1 1110,0 1195,1 1265,0 1313,1 1360,0 1400,1 1461,0 1552,1 1619,0 1696,1 1711,0 1799,1 1869,0 1938,1 1950,0 1996,1 2064,0 2111,1 2169,0 2232,1 2254,0 2318,1 2349,0 2442,1 2454,0 2534,1 2608,0 2681,1 2738,0 2750,1 2793,0 2802,1 2893,0 2933,1 2976,0 3046,1 3055,0 3148,1 3186,0 3275,1 3360,0 3382,1 3385,0 3429,1 3467,0 3543,1 3594,0 3686,1 3690,0 3766,1 3856,0 3919,1 3983,0 4029,1 4123,0 4125,1 4203,0 4231,1 4307,0 4308,1 4367,0 4436,1 4489,0 4534,1 4586,0 4659,1 4711,0 4811,1 4908,0 4976,1 5051,0 5083,1 5179,0 5202,1 5227,0 5253,1 5299,0 5387,1 5457,0 5466,1 5529,0 5624,1 5713,0 5776,1 5867,0 5921,1 6016,0 6060,1 6123,0 6156,1 6238,0 6280,1 6343,0 6402,1 6430,0 6499,1 6543,0 6590,1 6644,0 6732,1 6733,0 6785,1 6879,0 6946,1 6997,0 7072,1 7112,0 7206,1 7276,0 7315,1 7330,0 7424,1 7491,0 7586,1 7613,0 7671,1 7761,0 7780,1 7878,0 7964,1 8058,0 8145,1 8187,0 8240,1 8324,0 8411,1 8447,0 8472,1 8514,0 8569,1 8623,0 8632,1 8724,0 8795,1 8880,0 8979,1 9009,0 9097,1 9145,0 9173,1 9190,0 9254,1 9293,0 9307,1 9310,0 9386,1 9387,0 9389,1 9488,0 9576,1 9647,0 9732,1 9801,0 9878,1 9908,0 9921,1 9937,0 10036,1 10136,0 10208,1 10267,0 10285,1 10327,0 10392,1 10486,0 10517,1 10600,0 10602,1 10690,0 10694,1 10697,0 10719,1 10756,0 10803,1 10811,0 10854,1 10922,0 11000,1 11052,0 11138,1 11148,0 11247,1 11346,0 11347,1 11443,0 11523,1 11606,0 11696,1 11745,0 11762,1 11825,0 11853,1 11916,0 11967,1 12020,0 12066,1 12131,0 12166,1 12232,0 12278,1 12314,0 12412,1 12445,0 12480,1 12491,0 12541,1 12634,0 12662,1 12679,0 12773,1 12818,0 12911,1 12912,0 12962,1 12989,0 13042,1 13135,0 13220,1 13274,0 13281,1 13380,0 13459,1 13520,0 13586,1 13614,0 13660,1 13685,0 13688,1 13734,0 13761,1 13776,0 13874,1 13908,0 13925,1 14025,0 14104,1 14173,0 14258,1 end initlist a34 0,0 89,1 120,0 195,1 226,0 285,1 381,0 440,1 466,0 467,1 533,0 550,1 606,0 657,1 708,0 782,1 833,0 886,1 907,0 968,1 991,0 1075,1 1153,0 1181,1 1189,0 1285,1 1309,0 1323,1 1414,0 1479,1 1548,0 1630,1 1698,0 1707,1 1714,0 1767,1 1838,0 1872,1 1911,0 1959,1 1985,0 2037,1 2092,0 2151,1 2156,0 2243,1 2326,0 2381,1 2424,0 2474,1 2512,0 2586,1 2591,0 2616,1 2656,0 2734,1 2817,0 2825,1 2897,0 2905,1 2987,0 3084,1 3183,0 3269,1 3286,0 3303,1 3350,0 3374,1 3443,0 3486,1 3532,0 3594,1 3628,0 3700,1 3708,0 3770,1 3802,0 3814,1 3907,0 3925,1 4019,0 4024,1 4062,0 4088,1 4146,0 4167,1 4262,0 4340,1 4419,0 4466,1 4526,0 4543,1 4555,0 4641,1 4734,0 4807,1 4841,0 4878,1 4942,0 4952,1 5000,0 5005,1 5030,0 5047,1 5142,0 5172,1 5175,0 5181,1 5234,0 5301,1 5354,0 5424,1 5491,0 5496,1 5521,0 5531,1 5582,0 5605,1 5689,0 5726,1 5812,0 5854,1 5893,0 5973,1 5997,0 5998,1 6068,0 6091,1 6117,0 6208,1 6254,0 6272,1 6307,0 6337,1 6435,0 6468,1 6513,0 6597,1 6615,0 6635,1 6638,0 6646,1 6663,0 6692,1 6702,0 6722,1 6729,0 6745,1 6831,0 6922,1 6988,0 6997,1 7078,0 7081,1 7145,0 7231,1 7257,0 7305,1 7398,0 7399,1 7415,0 7432,1 7479,0 7576,1 7675,0 7684,1 7707,0 7766,1 7798,0 7832,1 7915,0 7972,1 8008,0 8071,1 8091,0 8094,1 8117,0 8172,1 8232,0 8262,1 8307,0 8329,1 8413,0 8493,1 8565,0 8605,1 8642,0 8725,1 8786,0 8861,1 8890,0 8974,1 9061,0 9083,1 9131,0 9174,1 9198,0 9224,1 9269,0 9351,1 9446,0 9513,1 9534,0 9630,1 9709,0 9759,1 9779,0 9809,1 9907,0 9962,1 9968,0 9983,1 9995,0 9996,1 10014,0 10081,1 10099,0 10198,1 10259,0 10286,1 10350,0 10431,1 10519,0 10590,1 10607,0 10612,1 10665,0 10681,1 10761,0 10788,1 10822,0 10903,1 10947,0 10997,1 11032,0 11047,1 11051,0 11085,1 11128,0 11145,1 11209,0 11235,1 11270,0 11294,1 11300,0 11348,1 11371,0 11453,1 11529,0 11595,1 11663,0 11701,1 11752,0 11822,1 11904,0 11916,1 11970,0 11994,1 end initlist a35 0,0 59,1 75,0 116,1 214,0 272,1 335,0 414,1 415,0 492,1 568,0 610,1 650,0 720,1 744,0 838,1 933,0 971,1 974,0 1061,1 1160,0 1203,1 1218,0 1237,1 1324,0 1373,1 1465,0 1550,1 1650,0 1707,1 1723,0 1798,1 1828,0 1886,1 1952,0 2045,1 2056,0 2100,1 2147,0 2175,1 2199,0 2270,1 2363,0 2381,1 2388,0 2414,1 2474,0 2510,1 2596,0 2686,1 2701,0 2786,1 2856,0 2886,1 2958,0 3046,1 3104,0 3172,1 3183,0 3260,1 3350,0 3399,1 3490,0 3574,1 3612,0 3628,1 3683,0 3769,1 3841,0 3903,1 3935,0 3954,1 3972,0 3981,1 3991,0 4022,1 4028,0 4039,1 4062,0 4153,1 4206,0 4243,1 4304,0 4394,1 4454,0 4477,1 4512,0 4524,1 4554,0 4629,1 4632,0 4702,1 4722,0 4728,1 4782,0 4881,1 4958,0 5039,1 5121,0 5207,1 5249,0 5262,1 5268,0 5326,1 5363,0 5373,1 5430,0 5481,1 5564,0 5596,1 5644,0 5660,1 5665,0 5700,1 5722,0 5791,1 5834,0 5866,1 5953,0 6005,1 6087,0 6187,1 6279,0 6328,1 6407,0 6445,1 6516,0 6592,1 6663,0 6728,1 6800,0 6862,1 6921,0 6951,1 6994,0 7057,1 7099,0 7148,1 7171,0 7230,1 7308,0 7393,1 7397,0 7485,1 7486,0 7581,1 7676,0 7722,1 7811,0 7902,1 7947,0 7976,1 7991,0 8039,1 8133,0 8172,1 8186,0 8227,1 8304,0 8325,1 8421,0 8485,1 8570,0 8643,1 8671,0 8756,1 8800,0 8889,1 8985,0 9028,1 9128,0 9137,1 9204,0 9227,1 9317,0 9391,1 9433,0 9516,1 9567,0 9571,1 9651,0 9663,1 9727,0 9797,1 9804,0 9877,1 9973,0 10004,1 10032,0 10067,1 10083,0 10123,1 10194,0 10244,1 10339,0 10340,1 10355,0 10366,1 10428,0 10436,1 10484,0 10501,1 10551,0 10588,1 10663,0 10750,1 10842,0 10912,1 10928,0 10943,1 11032,0 11092,1 11149,0 11155,1 11204,0 11237,1 11332,0 11395,1 11467,0 11557,1 11635,0 11719,1 11783,0 11860,1 11888,0 11975,1 12045,0 12117,1 12129,0 12153,1 12219,0 12311,1 12375,0 12393,1 12433,0 12513,1 12535,0 12556,1 12585,0 12640,1 12698,0 12718,1 12726,0 12774,1 12826,0 12831,1 12872,0 12926,1 12939,0 13027,1 13126,0 13223,1 13240,0 13269,1 13348,0 13439,1 13453,0 13493,1 end initlist a36 0,0 13,1 41,0 49,1 123,0 126,1 166,0 213,1 230,0 329,1 375,0 401,1 443,0 508,1 509,0 562,1 651,0 731,1 815,0 876,1 934,0 940,1 1012,0 1069,1 1135,0 1151,1 1220,0 1257,1 1258,0 1278,1 1295,0 1362,1 1458,0 1469,1 1552,0 1569,1 1645,0 1736,1 1750,0 1752,1 1805,0 1850,1 1855,0 1906,1 1909,0 1919,1 2019,0 2075,1 2171,0 2208,1 2251,0 2252,1 2269,0 2367,1 2447,0 2461,1 2462,0 2547,1 2559,0 2628,1 2681,0 2686,1 2754,0 2784,1 2860,0 2902,1 2940,0 2967,1 3053,0 3054,1 3067,0 3160,1 3226,0 3261,1 3276,0 3285,1 3290,0 3375,1 3427,0 3481,1 3485,0 3545,1 3550,0 3554,1 3556,0 3585,1 3637,0 3646,1 3674,0 3762,1 3819,0 3885,1 3948,0 3982,1 4009,0 4048,1 4115,0 4208,1 4283,0 4286,1 4339,0 4426,1 4487,0 4530,1 4605,0 4685,1 4762,0 4764,1 4772,0 4847,1 4920,0 4965,1 5004,0 5089,1 5111,0 5205,1 5268,0 5279,1 5366,0 5385,1 5411,0 5441,1 5471,0 5518,1 5578,0 5628,1 5701,0 5745,1 5785,0 5813,1 5819,0 5825,1 5834,0 5930,1 5968,0 5991,1 6034,0 6124,1 6155,0 6178,1 6264,0 6316,1 6366,0 6431,1 6495,0 6498,1 6554,0 6559,1 6566,0 6570,1 6613,0 6615,1 6669,0 6748,1 6840,0 6877,1 6903,0 6971,1 7064,0 7073,1 7163,0 7236,1 7247,0 7313,1 7360,0 7383,1 7392,0 7481,1 7564,0 7643,1 7708,0 7805,1 7888,0 7969,1 7998,0 8021,1 8119,0 8207,1 8237,0 8323,1 8361,0 8399,1 8482,0 8485,1 8528,0 8535,1 8563,0 8617,1 8631,0 8667,1 8709,0 8754,1 8811,0 8869,1 8889,0 8967,1 8990,0 9041,1 9050,0 9061,1 9121,0 9221,1 9300,0 9378,1 9386,0 9476,1 9526,0 9616,1 9668,0 9681,1 9738,0 9771,1 9814,0 9853,1 9859,0 9924,1 9939,0 10014,1 10018,0 10115,1 10157,0 10229,1 10307,0 10323,1 10400,0 10460,1 10552,0 10597,1 10659,0 10700,1 10730,0 10766,1 10797,0 10841,1 10899,0 10986,1 11028,0 11069,1 11070,0 11164,1 11170,0 11260,1 11337,0 11359,1 11367,0 11396,1 11491,0 11508,1 11561,0 11573,1 11634,0 11713,1 11723,0 11747,1 11788,0 11871,1 11881,0 11893,1 end initlist a37 0,0 35,1 84,0 158,1 251,0 300,1 358,0 429,1 494,0 592,1 604,0 680,1 727,0 764,1 832,0 931,1 936,0 1011,1 1075,0 1151,1 1185,0 1232,1 1306,0 1310,1 1356,0 1445,1 1509,0 1597,1 1612,0 1637,1 1660,0 1756,1 1775,0 1798,1 1863,0 1942,1 2008,0 2071,1 2089,0 2137,1 2207,0 2249,1 2284,0 2343,1 2440,0 2447,1 2452,0 2522,1 2598,0 2609,1 2665,0 2692,1 2751,0 2776,1 2787,0 2824,1 2844,0 2879,1 2930,0 2954,1 2964,0 3041,1 3124,0 3216,1 3245,0 3301,1 3304,0 3352,1 3426,0 3502,1 3602,0 3689,1 3724,0 3793,1 3829,0 3913,1 3943,0 3991,1 4060,0 4155,1 4157,0 4175,1 4239,0 4247,1 4325,0 4413,1 4458,0 4476,1 4543,0 4635,1 4688,0 4717,1 4773,0 4866,1 4872,0 4906,1 4918,0 4930,1 5030,0 5071,1 5101,0 5185,1 5263,0 5332,1 5421,0 5516,1 5532,0 5611,1 5621,0 5711,1 5720,0 5812,1 5851,0 5875,1 5970,0 6051,1 6138,0 6182,1 6275,0 6331,1 6397,0 6414,1 6445,0 6524,1 6581,0 6628,1 6723,0 6802,1 6806,0 6854,1 6883,0 6954,1 7023,0 7030,1 7071,0 7103,1 7123,0 7147,1 7247,0 7285,1 7344,0 7368,1 7395,0 7408,1 7473,0 7515,1 7614,0 7638,1 7709,0 7788,1 7834,0 7895,1 7953,0 7986,1 8009,0 8105,1 8126,0 8135,1 8190,0 8268,1 8317,0 8405,1 8470,0 8531,1 8556,0 8582,1 8654,0 8656,1 8704,0 8715,1 8770,0 8828,1 8908,0 8991,1 9044,0 9049,1 9119,0 9194,1 9264,0 9315,1 9355,0 9364,1 9368,0 9436,1 9483,0 9544,1 9565,0 9607,1 9644,0 9646,1 9706,0 9728,1 9735,0 9798,1 9868,0 9898,1 9981,0 10053,1 10068,0 10087,1 10113,0 10192,1 10281,0 10293,1 10341,0 10424,1 10504,0 10566,1 10606,0 10700,1 10767,0 10844,1 10915,0 10931,1 10972,0 11052,1 11103,0 11142,1 11193,0 11289,1 11313,0 11361,1 11371,0 11395,1 11465,0 11507,1 11535,0 11599,1 11681,0 11689,1 11774,0 11785,1 11788,0 11834,1 11906,0 11935,1 12023,0 12110,1 12201,0 12240,1 12307,0 12345,1 12380,0 12391,1 12414,0 12512,1 12534,0 12607,1 12658,0 12721,1 12819,0 12864,1 12876,0 12921,1 12926,0 12998,1 13027,0 13030,1 end initlist a38 0,0 3,1 27,0 125,1 191,0 262,1 308,0 323,1 423,0 456,1 475,0 489,1 507,0 563,1 629,0 669,1 743,0 799,1 889,0 952,1 954,0 1009,1 1028,0 1108,1 1127,0 1159,1 1207,0 1305,1 1346,0 1361,1 1377,0 1435,1 1440,0 1490,1 1531,0 1604,1 1694,0 1775,1 1811,0 1855,1 1948,0 2020,1 2110,0 2177,1 2271,0 2293,1 2308,0 2387,1 2471,0 2556,1 2596,0 2649,1 2728,0 2821,1 2898,0 2913,1 2952,0 3033,1 3062,0 3092,1 3135,0 3197,1 3226,0 3277,1 3375,0 3416,1 3452,0 3485,1 3502,0 3583,1 3607,0 3701,1 3784,0 3843,1 3862,0 3866,1 3889,0 3955,1 4026,0 4066,1 4087,0 4116,1 4200,0 4258,1 4274,0 4341,1 4440,0 4443,1 4491,0 4496,1 4530,0 4592,1 4598,0 4698,1 4798,0 4865,1 4898,0 4949,1 4989,0 5030,1 5096,0 5171,1 5192,0 5236,1 5317,0 5361,1 5378,0 5470,1 5483,0 5534,1 5591,0 5656,1 5734,0 5736,1 5804,0 5820,1 5916,0 5996,1 6091,0 6191,1 6222,0 6236,1 6251,0 6301,1 6375,0 6387,1 6394,0 6432,1 6445,0 6503,1 6535,0 6575,1 6656,0 6734,1 6758,0 6778,1 6843,0 6894,1 6935,0 6986,1 7027,0 7061,1 7126,0 7133,1 7164,0 7194,1 7234,0 7250,1 7274,0 7296,1 7323,0 7361,1 7451,0 7546,1 7633,0 7639,1 7738,0 7830,1 7843,0 7923,1 7958,0 8056,1 8132,0 8178,1 8241,0 8272,1 8356,0 8387,1 8478,0 8570,1 8575,0 8576,1 8616,0 8698,1 8733,0 8822,1 8825,0 8852,1 8896,0 8950,1 9039,0 9086,1 9145,0 9245,1 9277,0 9353,1 9354,0 9448,1 9545,0 9601,1 9642,0 9705,1 9788,0 9830,1 9915,0 9929,1 9995,0 10006,1 10064,0 10103,1 10166,0 10215,1 10250,0 10308,1 10350,0 10394,1 10434,0 10485,1 10577,0 10597,1 10667,0 10755,1 10853,0 10929,1 10956,0 10990,1 11024,0 11120,1 11219,0 11319,1 11419,0 11456,1 11544,0 11638,1 11649,0 11670,1 11737,0 11791,1 11872,0 11954,1 11958,0 12044,1 12057,0 12150,1 12179,0 12217,1 12257,0 12282,1 12311,0 12337,1 12355,0 12409,1 12430,0 12502,1 12533,0 12592,1 12663,0 12730,1 12776,0 12797,1 12878,0 12898,1 12936,0 12942,1 13042,0 13091,1 13161,0 13234,1 end initlist a39 0,0 20,1 56,0 135,1 171,0 243,1 292,0 322,1 384,0 436,1 440,0 455,1 473,0 537,1 637,0 684,1 718,0 746,1 838,0 914,1 975,0 1068,1 1129,0 1195,1 1256,0 1308,1 1346,0 1360,1 1429,0 1522,1 1546,0 1573,1 1622,0 1716,1 1745,0 1794,1 1875,0 1904,1 1970,0 1980,1 2055,0 2094,1 2116,0 2178,1 2217,0 2238,1 2245,0 2270,1 2323,0 2407,1 2481,0 2573,1 2585,0 2652,1 2719,0 2780,1 2816,0 2904,1 2925,0 2940,1 2947,0 2986,1 3023,0 3062,1 3087,0 3183,1 3220,0 3313,1 3332,0 3409,1 3488,0 3530,1 3543,0 3585,1 3654,0 3754,1 3772,0 3859,1 3862,0 3948,1 4009,0 4045,1 4051,0 4086,1 4162,0 4239,1 4265,0 4320,1 4354,0 4429,1 4524,0 4531,1 4613,0 4701,1 4741,0 4746,1 4828,0 4914,1 4982,0 4992,1 5062,0 5079,1 5132,0 5155,1 5178,0 5247,1 5285,0 5358,1 5450,0 5462,1 5542,0 5619,1 5633,0 5717,1 5736,0 5765,1 5852,0 5864,1 5925,0 5983,1 6014,0 6083,1 6133,0 6210,1 6291,0 6359,1 6446,0 6521,1 6613,0 6707,1 6799,0 6844,1 6923,0 7018,1 7025,0 7034,1 7038,0 7119,1 7218,0 7251,1 7315,0 7384,1 7439,0 7493,1 7553,0 7595,1 7687,0 7781,1 7784,0 7870,1 7889,0 7962,1 8056,0 8086,1 8102,0 8157,1 8198,0 8207,1 8225,0 8271,1 8342,0 8377,1 8426,0 8453,1 8533,0 8631,1 8658,0 8747,1 8753,0 8830,1 8889,0 8911,1 8961,0 9021,1 9121,0 9220,1 9237,0 9245,1 9254,0 9261,1 9287,0 9304,1 9311,0 9347,1 9395,0 9472,1 9545,0 9620,1 9716,0 9768,1 9859,0 9866,1 9904,0 9952,1 9982,0 10043,1 10082,0 10118,1 10207,0 10214,1 10227,0 10254,1 10333,0 10356,1 10451,0 10483,1 10531,0 10628,1 10712,0 10808,1 10851,0 10892,1 10938,0 10962,1 11037,0 11073,1 11102,0 11120,1 11149,0 11178,1 11192,0 11272,1 11302,0 11375,1 11415,0 11444,1 11457,0 11479,1 11530,0 11593,1 11656,0 11747,1 11786,0 11797,1 11883,0 11908,1 11997,0 12042,1 12082,0 12125,1 12158,0 12231,1 12326,0 12354,1 12394,0 12483,1 12574,0 12642,1 12739,0 12834,1 12871,0 12923,1 12980,0 13012,1 13037,0 13105,1 13186,0 13278,1 end initlist a40 0,0 77,1 173,0 191,1 289,0 315,1 358,0 366,1 457,0 501,1 548,0 584,1 624,0 672,1 687,0 734,1 794,0 847,1 936,0 938,1 977,0 1045,1 1114,0 1151,1 1163,0 1242,1 1243,0 1270,1 1314,0 1361,1 1362,0 1384,1 1399,0 1463,1 1490,0 1572,1 1647,0 1704,1 1734,0 1789,1 1885,0 1904,1 1982,0 2016,1 2081,0 2116,1 2177,0 2215,1 2255,0 2267,1 2273,0 2305,1 2395,0 2476,1 2556,0 2575,1 2651,0 2729,1 2793,0 2825,1 2895,0 2909,1 2989,0 3075,1 3104,0 3126,1 3135,0 3173,1 3265,0 3309,1 3345,0 3438,1 3479,0 3486,1 3564,0 3567,1 3568,0 3665,1 3726,0 3728,1 3759,0 3772,1 3821,0 3869,1 3879,0 3910,1 4009,0 4058,1 4073,0 4167,1 4237,0 4283,1 4309,0 4380,1 4411,0 4436,1 4518,0 4616,1 4693,0 4793,1 4797,0 4867,1 4889,0 4906,1 4958,0 5007,1 5101,0 5125,1 5171,0 5210,1 5216,0 5279,1 5339,0 5378,1 5429,0 5487,1 5528,0 5534,1 5590,0 5662,1 5680,0 5719,1 5740,0 5829,1 5851,0 5877,1 5931,0 6031,1 6069,0 6077,1 6136,0 6192,1 6284,0 6293,1 6326,0 6397,1 6427,0 6443,1 6477,0 6504,1 6600,0 6636,1 6682,0 6732,1 6736,0 6771,1 6806,0 6865,1 6916,0 7005,1 7078,0 7155,1 7199,0 7271,1 7295,0 7382,1 7396,0 7491,1 7564,0 7585,1 7658,0 7714,1 7725,0 7786,1 7881,0 7885,1 7908,0 7953,1 7979,0 8057,1 8121,0 8215,1 8301,0 8322,1 8381,0 8444,1 8481,0 8563,1 8650,0 8747,1 8781,0 8841,1 8903,0 8946,1 9004,0 9026,1 9081,0 9151,1 9188,0 9288,1 9319,0 9419,1 9509,0 9551,1 9575,0 9606,1 9616,0 9674,1 9708,0 9749,1 9795,0 9832,1 9884,0 9888,1 9918,0 9980,1 10065,0 10138,1 10180,0 10276,1 10366,0 10413,1 10457,0 10495,1 10590,0 10681,1 10717,0 10805,1 10819,0 10861,1 10932,0 11017,1 11101,0 11162,1 11188,0 11189,1 11197,0 11267,1 11320,0 11420,1 11495,0 11565,1 11631,0 11691,1 11735,0 11829,1 11848,0 11920,1 12001,0 12014,1 12039,0 12121,1 12211,0 12273,1 12352,0 12385,1 12393,0 12475,1 12568,0 12631,1 12646,0 12730,1 12807,0 12889,1 12920,0 12988,1 13087,0 13130,1 end initlist a41 0,0 50,1 51,0 146,1 213,0 278,1 292,0 380,1 437,0 523,1 594,0 610,1 709,0 760,1 857,0 948,1 959,0 998,1 1030,0 1123,1 1150,0 1245,1 1258,0 1340,1 1379,0 1444,1 1484,0 1553,1 1640,0 1684,1 1695,0 1722,1 1743,0 1791,1 1819,0 1873,1 1934,0 2013,1 2031,0 2130,1 2201,0 2270,1 2296,0 2304,1 2354,0 2439,1 2471,0 2511,1 2565,0 2620,1 2644,0 2714,1 2778,0 2799,1 2864,0 2886,1 2919,0 3002,1 3028,0 3091,1 3189,0 3230,1 3329,0 3425,1 3426,0 3446,1 3545,0 3607,1 3634,0 3687,1 3742,0 3812,1 3826,0 3858,1 3867,0 3936,1 3937,0 4011,1 4079,0 4081,1 4113,0 4181,1 4207,0 4215,1 4293,0 4317,1 4363,0 4449,1 4548,0 4551,1 4578,0 4627,1 4684,0 4732,1 4755,0 4756,1 4814,0 4906,1 4913,0 4999,1 5097,0 5189,1 5201,0 5257,1 5261,0 5345,1 5348,0 5406,1 5443,0 5484,1 5508,0 5515,1 5553,0 5635,1 5703,0 5785,1 5806,0 5855,1 5938,0 5960,1 6019,0 6038,1 6058,0 6107,1 6159,0 6177,1 6201,0 6231,1 6303,0 6356,1 6441,0 6477,1 6540,0 6581,1 6634,0 6679,1 6737,0 6816,1 6878,0 6920,1 6998,0 7043,1 7107,0 7197,1 7260,0 7283,1 7339,0 7349,1 7380,0 7443,1 7461,0 7504,1 7517,0 7530,1 7605,0 7607,1 7632,0 7658,1 7680,0 7704,1 7763,0 7858,1 7903,0 7912,1 7918,0 7970,1 7972,0 7975,1 8060,0 8074,1 8116,0 8174,1 8208,0 8307,1 8357,0 8382,1 8474,0 8572,1 8644,0 8735,1 8740,0 8835,1 8883,0 8922,1 9000,0 9026,1 9118,0 9138,1 9181,0 9206,1 9267,0 9351,1 9441,0 9461,1 9467,0 9500,1 9565,0 9587,1 9596,0 9657,1 9685,0 9766,1 9862,0 9941,1 9990,0 10050,1 10081,0 10091,1 10105,0 10147,1 10246,0 10307,1 10313,0 10383,1 10445,0 10501,1 10504,0 10520,1 10530,0 10614,1 10685,0 10771,1 10786,0 10839,1 10893,0 10927,1 10996,0 11039,1 11100,0 11124,1 11147,0 11156,1 11171,0 11213,1 11285,0 11331,1 11404,0 11445,1 11471,0 11532,1 11626,0 11713,1 11719,0 11730,1 11809,0 11874,1 11909,0 11919,1 11928,0 11976,1 12035,0 12045,1 12055,0 12140,1 12237,0 12271,1 12278,0 12374,1 end initlist a42 0,0 80,1 136,0 186,1 188,0 248,1 278,0 335,1 392,0 458,1 545,0 563,1 646,0 681,1 749,0 815,1 818,0 872,1 894,0 993,1 1040,0 1049,1 1108,0 1116,1 1196,0 1268,1 1314,0 1350,1 1436,0 1476,1 1572,0 1634,1 1706,0 1747,1 1829,0 1873,1 1945,0 2018,1 2052,0 2097,1 2127,0 2205,1 2207,0 2259,1 2317,0 2359,1 2423,0 2503,1 2569,0 2636,1 2705,0 2730,1 2781,0 2819,1 2828,0 2880,1 2963,0 3015,1 3066,0 3069,1 3134,0 3218,1 3231,0 3295,1 3324,0 3332,1 3356,0 3406,1 3485,0 3501,1 3540,0 3547,1 3563,0 3588,1 3633,0 3703,1 3734,0 3785,1 3830,0 3903,1 3907,0 3935,1 3971,0 4067,1 4095,0 4110,1 4192,0 4240,1 4286,0 4381,1 4477,0 4530,1 4559,0 4583,1 4672,0 4686,1 4726,0 4761,1 4789,0 4875,1 4935,0 4953,1 4999,0 5061,1 5107,0 5165,1 5226,0 5230,1 5278,0 5287,1 5296,0 5396,1 5461,0 5491,1 5591,0 5611,1 5645,0 5707,1 5724,0 5739,1 5767,0 5828,1 5876,0 5955,1 6036,0 6107,1 6121,0 6194,1 6227,0 6236,1 6252,0 6268,1 6329,0 6362,1 6430,0 6453,1 6459,0 6499,1 6529,0 6536,1 6626,0 6694,1 6746,0 6827,1 6891,0 6947,1 6978,0 6993,1 7089,0 7098,1 7129,0 7136,1 7221,0 7235,1 7316,0 7321,1 7399,0 7473,1 7485,0 7495,1 7538,0 7567,1 7627,0 7674,1 7744,0 7766,1 7819,0 7830,1 7865,0 7881,1 7937,0 8020,1 8066,0 8095,1 8162,0 8170,1 8219,0 8242,1 8300,0 8341,1 8352,0 8381,1 8396,0 8461,1 8509,0 8609,1 8678,0 8696,1 8728,0 8781,1 8796,0 8835,1 8850,0 8927,1 8980,0 9041,1 9136,0 9235,1 9285,0 9297,1 9385,0 9437,1 9507,0 9596,1 9651,0 9675,1 9690,0 9764,1 9816,0 9856,1 9908,0 9985,1 10012,0 10079,1 10173,0 10222,1 10301,0 10398,1 10498,0 10506,1 10512,0 10605,1 10632,0 10726,1 10826,0 10856,1 10871,0 10877,1 10933,0 10939,1 11016,0 11056,1 11057,0 11128,1 11208,0 11286,1 11357,0 11446,1 11539,0 11601,1 11656,0 11694,1 11763,0 11860,1 11914,0 11934,1 11944,0 12041,1 12111,0 12115,1 12191,0 12264,1 12321,0 12371,1 12394,0 12491,1 12507,0 12575,1 end initlist a43 0,0 94,1 110,0 141,1 200,0 239,1 291,0 326,1 371,0 396,1 415,0 504,1 568,0 642,1 690,0 730,1 745,0 764,1 855,0 911,1 924,0 1003,1 1057,0 1084,1 1086,0 1122,1 1142,0 1207,1 1225,0 1258,1 1317,0 1411,1 1431,0 1436,1 1530,0 1539,1 1562,0 1597,1 1661,0 1679,1 1775,0 1858,1 1912,0 1915,1 2001,0 2047,1 2114,0 2171,1 2223,0 2316,1 2396,0 2478,1 2508,0 2582,1 2620,0 2715,1 2765,0 2827,1 2864,0 2882,1 2889,0 2942,1 3020,0 3106,1 3115,0 3177,1 3197,0 3201,1 3254,0 3273,1 3293,0 3351,1 3399,0 3484,1 3521,0 3536,1 3557,0 3573,1 3577,0 3653,1 3694,0 3702,1 3780,0 3847,1 3886,0 3955,1 4033,0 4105,1 4163,0 4176,1 4243,0 4321,1 4405,0 4461,1 4533,0 4597,1 4628,0 4680,1 4713,0 4776,1 4841,0 4898,1 4960,0 5028,1 5113,0 5193,1 5203,0 5287,1 5357,0 5386,1 5416,0 5472,1 5559,0 5581,1 5628,0 5700,1 5762,0 5780,1 5854,0 5905,1 6001,0 6034,1 6074,0 6077,1 6099,0 6120,1 6220,0 6298,1 6333,0 6427,1 6451,0 6499,1 6581,0 6607,1 6659,0 6712,1 6775,0 6778,1 6830,0 6857,1 6885,0 6915,1 6988,0 7080,1 7100,0 7157,1 7163,0 7171,1 7227,0 7229,1 7273,0 7336,1 7410,0 7499,1 7510,0 7567,1 7583,0 7643,1 7673,0 7682,1 7721,0 7771,1 7785,0 7795,1 7890,0 7913,1 8009,0 8015,1 8048,0 8146,1 8221,0 8268,1 8282,0 8341,1 8382,0 8476,1 8559,0 8656,1 8680,0 8762,1 8793,0 8882,1 8973,0 9024,1 9081,0 9176,1 9242,0 9306,1 9307,0 9378,1 9461,0 9532,1 9577,0 9593,1 9627,0 9656,1 9664,0 9667,1 9688,0 9765,1 9776,0 9822,1 9911,0 9941,1 9990,0 10073,1 10134,0 10163,1 10196,0 10292,1 10357,0 10394,1 10464,0 10548,1 10599,0 10629,1 10694,0 10749,1 10771,0 10826,1 10868,0 10950,1 10985,0 11006,1 11096,0 11154,1 11248,0 11303,1 11403,0 11434,1 11485,0 11527,1 11585,0 11625,1 11641,0 11702,1 11714,0 11771,1 11860,0 11958,1 11965,0 12017,1 12049,0 12059,1 12064,0 12150,1 12211,0 12304,1 12397,0 12483,1 12583,0 12651,1 12680,0 12704,1 12793,0 12805,1 12897,0 12941,1 end initlist a44 0,0 64,1 70,0 134,1 207,0 248,1 295,0 308,1 382,0 452,1 456,0 494,1 524,0 546,1 634,0 646,1 650,0 699,1 785,0 863,1 884,0 898,1 990,0 1007,1 1084,0 1177,1 1206,0 1239,1 1332,0 1333,1 1381,0 1423,1 1430,0 1452,1 1533,0 1604,1 1687,0 1692,1 1747,0 1779,1 1853,0 1935,1 1946,0 2045,1 2114,0 2204,1 2244,0 2321,1 2405,0 2451,1 2521,0 2586,1 2593,0 2626,1 2700,0 2732,1 2747,0 2847,1 2933,0 3010,1 3058,0 3145,1 3237,0 3322,1 3330,0 3361,1 3376,0 3378,1 3421,0 3424,1 3487,0 3570,1 3612,0 3620,1 3709,0 3731,1 3771,0 3822,1 3831,0 3857,1 3950,0 4033,1 4085,0 4175,1 4249,0 4274,1 4361,0 4423,1 4475,0 4543,1 4579,0 4644,1 4729,0 4805,1 4878,0 4922,1 4959,0 5040,1 5094,0 5105,1 5203,0 5228,1 5257,0 5303,1 5352,0 5414,1 5511,0 5607,1 5609,0 5660,1 5689,0 5707,1 5751,0 5825,1 5921,0 6013,1 6035,0 6096,1 6133,0 6145,1 6183,0 6271,1 6364,0 6391,1 6451,0 6496,1 6538,0 6573,1 6576,0 6632,1 6712,0 6768,1 6800,0 6829,1 6889,0 6953,1 6984,0 7026,1 7028,0 7038,1 7091,0 7100,1 7174,0 7176,1 7187,0 7245,1 7260,0 7346,1 7389,0 7425,1 7452,0 7539,1 7632,0 7635,1 7690,0 7705,1 7787,0 7887,1 7915,0 7944,1 8010,0 8076,1 8119,0 8180,1 8235,0 8317,1 8334,0 8336,1 8375,0 8454,1 8516,0 8599,1 8695,0 8745,1 8772,0 8814,1 8873,0 8931,1 9004,0 9082,1 9148,0 9201,1 9236,0 9289,1 9341,0 9414,1 9421,0 9445,1 9495,0 9538,1 9588,0 9591,1 9653,0 9659,1 9709,0 9749,1 9769,0 9819,1 9899,0 9966,1 10063,0 10144,1 10218,0 10243,1 10300,0 10369,1 10404,0 10464,1 10539,0 10638,1 10714,0 10793,1 10870,0 10951,1 11031,0 11098,1 11138,0 11184,1 11212,0 11279,1 11352,0 11431,1 11452,0 11488,1 11558,0 11639,1 11704,0 11763,1 11817,0 11912,1 11938,0 11957,1 11962,0 12062,1 12104,0 12195,1 12211,0 12258,1 12345,0 12391,1 12466,0 12472,1 12560,0 12622,1 12681,0 12729,1 12755,0 12803,1 12825,0 12918,1 12956,0 13012,1 13036,0 13051,1 13061,0 13155,1 13216,0 13269,1 end initlist a45 0,0 57,1 118,0 142,1 159,0 230,1 284,0 337,1 423,0 436,1 499,0 596,1 684,0 747,1 832,0 858,1 918,0 949,1 973,0 978,1 982,0 1056,1 1075,0 1166,1 1210,0 1244,1 1302,0 1380,1 1471,0 1571,1 1633,0 1635,1 1697,0 1759,1 1778,0 1785,1 1787,0 1814,1 1891,0 1977,1 2053,0 2091,1 2118,0 2187,1 2204,0 2222,1 2271,0 2297,1 2342,0 2356,1 2449,0 2502,1 2514,0 2606,1 2692,0 2715,1 2804,0 2883,1 2933,0 3018,1 3031,0 3126,1 3189,0 3227,1 3286,0 3287,1 3350,0 3353,1 3379,0 3394,1 3433,0 3503,1 3568,0 3661,1 3738,0 3740,1 3839,0 3868,1 3882,0 3893,1 3931,0 3983,1 4018,0 4112,1 4135,0 4165,1 4253,0 4321,1 4400,0 4479,1 4519,0 4549,1 4561,0 4596,1 4623,0 4648,1 4672,0 4769,1 4802,0 4853,1 4903,0 5000,1 5076,0 5093,1 5100,0 5124,1 5141,0 5183,1 5195,0 5273,1 5310,0 5334,1 5336,0 5343,1 5357,0 5359,1 5425,0 5504,1 5595,0 5610,1 5707,0 5714,1 5718,0 5743,1 5744,0 5793,1 5840,0 5886,1 5973,0 6035,1 6133,0 6217,1 6297,0 6368,1 6374,0 6382,1 6387,0 6453,1 6538,0 6575,1 6617,0 6621,1 6676,0 6768,1 6783,0 6798,1 6836,0 6869,1 6892,0 6906,1 6954,0 7046,1 7069,0 7089,1 7161,0 7249,1 7318,0 7343,1 7422,0 7498,1 7534,0 7610,1 7617,0 7706,1 7723,0 7798,1 7824,0 7894,1 7924,0 7992,1 8069,0 8146,1 8187,0 8272,1 8321,0 8406,1 8413,0 8455,1 8530,0 8585,1 8618,0 8688,1 8786,0 8822,1 8891,0 8909,1 8948,0 9003,1 9068,0 9080,1 9113,0 9143,1 9178,0 9212,1 9224,0 9234,1 9301,0 9357,1 9425,0 9489,1 9511,0 9514,1 9614,0 9706,1 9805,0 9894,1 9920,0 9993,1 10020,0 10050,1 10092,0 10132,1 10194,0 10214,1 10254,0 10255,1 10274,0 10279,1 10308,0 10382,1 10400,0 10436,1 10447,0 10503,1 10522,0 10618,1 10630,0 10680,1 10731,0 10783,1 10842,0 10857,1 10888,0 10972,1 10984,0 11043,1 11124,0 11183,1 11257,0 11324,1 11347,0 11408,1 11477,0 11559,1 11573,0 11646,1 11687,0 11718,1 11737,0 11819,1 11892,0 11938,1 11993,0 12055,1 12090,0 12113,1 12115,0 12202,1 end initlist a46 0,0 70,1 90,0 155,1 194,0 231,1 286,0 320,1 376,0 472,1 546,0 622,1 687,0 710,1 769,0 822,1 839,0 879,1 972,0 981,1 1057,0 1079,1 1159,0 1251,1 1298,0 1346,1 1377,0 1424,1 1479,0 1491,1 1531,0 1599,1 1618,0 1682,1 1766,0 1809,1 1894,0 1964,1 1980,0 2067,1 2074,0 2105,1 2135,0 2148,1 2234,0 2319,1 2360,0 2361,1 2418,0 2514,1 2526,0 2615,1 2656,0 2730,1 2822,0 2914,1 2942,0 2968,1 2977,0 3031,1 3123,0 3129,1 3204,0 3271,1 3321,0 3416,1 3468,0 3542,1 3613,0 3642,1 3664,0 3729,1 3774,0 3858,1 3907,0 3999,1 4069,0 4077,1 4112,0 4146,1 4238,0 4270,1 4363,0 4371,1 4443,0 4499,1 4522,0 4602,1 4619,0 4707,1 4718,0 4722,1 4799,0 4834,1 4846,0 4945,1 5014,0 5047,1 5118,0 5136,1 5164,0 5238,1 5282,0 5309,1 5405,0 5504,1 5542,0 5620,1 5631,0 5722,1 5808,0 5866,1 5942,0 5986,1 5996,0 6035,1 6052,0 6072,1 6105,0 6161,1 6208,0 6252,1 6343,0 6407,1 6408,0 6484,1 6583,0 6586,1 6607,0 6639,1 6703,0 6777,1 6805,0 6889,1 6940,0 7012,1 7084,0 7105,1 7194,0 7201,1 7208,0 7237,1 7314,0 7329,1 7416,0 7489,1 7531,0 7597,1 7616,0 7631,1 7645,0 7737,1 7798,0 7819,1 7904,0 7954,1 7964,0 8063,1 8098,0 8125,1 8179,0 8248,1 8311,0 8365,1 8463,0 8563,1 8581,0 8604,1 8662,0 8664,1 8665,0 8727,1 8774,0 8787,1 8792,0 8874,1 8916,0 8920,1 8990,0 9089,1 9188,0 9219,1 9307,0 9337,1 9365,0 9420,1 9517,0 9540,1 9556,0 9564,1 9616,0 9630,1 9637,0 9687,1 9780,0 9783,1 9871,0 9891,1 9927,0 10022,1 10085,0 10133,1 10187,0 10248,1 10311,0 10369,1 10447,0 10457,1 10544,0 10595,1 10650,0 10714,1 10741,0 10751,1 10792,0 10879,1 10929,0 10978,1 11059,0 11093,1 11106,0 11115,1 11148,0 11207,1 11223,0 11281,1 11329,0 11354,1 11414,0 11514,1 11588,0 11688,1 11788,0 11837,1 11935,0 11941,1 11961,0 12052,1 12123,0 12186,1 12206,0 12213,1 12246,0 12273,1 12307,0 12400,1 12430,0 12449,1 12464,0 12507,1 12550,0 12595,1 12637,0 12722,1 12750,0 12840,1 12916,0 12967,1 end initlist a47 0,0 25,1 88,0 121,1 130,0 179,1 211,0 237,1 283,0 380,1 432,0 501,1 561,0 568,1 665,0 666,1 746,0 833,1 923,0 932,1 982,0 1007,1 1095,0 1139,1 1179,0 1222,1 1223,0 1277,1 1281,0 1284,1 1302,0 1303,1 1308,0 1347,1 1418,0 1461,1 1551,0 1599,1 1680,0 1685,1 1772,0 1861,1 1899,0 1932,1 1944,0 2039,1 2082,0 2169,1 2253,0 2289,1 2301,0 2338,1 2373,0 2394,1 2488,0 2573,1 2623,0 2646,1 2732,0 2761,1 2781,0 2869,1 2871,0 2922,1 2938,0 2939,1 2991,0 3060,1 3136,0 3184,1 3226,0 3268,1 3283,0 3378,1 3410,0 3481,1 3563,0 3654,1 3683,0 3735,1 3764,0 3862,1 3873,0 3892,1 3916,0 4002,1 4012,0 4104,1 4197,0 4216,1 4232,0 4321,1 4348,0 4405,1 4500,0 4558,1 4594,0 4678,1 4766,0 4834,1 4844,0 4944,1 4988,0 5019,1 5068,0 5122,1 5159,0 5214,1 5274,0 5294,1 5295,0 5334,1 5387,0 5467,1 5559,0 5594,1 5675,0 5757,1 5835,0 5895,1 5901,0 5915,1 5947,0 6016,1 6104,0 6113,1 6115,0 6128,1 6202,0 6243,1 6266,0 6343,1 6366,0 6370,1 6443,0 6521,1 6611,0 6612,1 6635,0 6672,1 6740,0 6759,1 6844,0 6936,1 7002,0 7033,1 7084,0 7181,1 7187,0 7208,1 7224,0 7270,1 7299,0 7369,1 7387,0 7464,1 7490,0 7571,1 7587,0 7648,1 7678,0 7693,1 7745,0 7765,1 7779,0 7829,1 7846,0 7885,1 7912,0 7978,1 7988,0 8022,1 8024,0 8065,1 8119,0 8139,1 8168,0 8196,1 8202,0 8234,1 8248,0 8338,1 8411,0 8448,1 8526,0 8622,1 8642,0 8661,1 8752,0 8810,1 8877,0 8921,1 9014,0 9114,1 9173,0 9262,1 9347,0 9400,1 9408,0 9435,1 9504,0 9530,1 9602,0 9688,1 9691,0 9768,1 9796,0 9841,1 9879,0 9901,1 9907,0 9966,1 10056,0 10074,1 10079,0 10090,1 10095,0 10101,1 10199,0 10209,1 10286,0 10309,1 10357,0 10417,1 10489,0 10589,1 10645,0 10673,1 10756,0 10802,1 10887,0 10930,1 10996,0 11071,1 11077,0 11120,1 11204,0 11250,1 11335,0 11412,1 11474,0 11496,1 11564,0 11567,1 11643,0 11646,1 11746,0 11791,1 11839,0 11840,1 11911,0 11957,1 11993,0 12087,1 12143,0 12220,1 12316,0 12352,1 end initlist a48 0,0 81,1 167,0 265,1 341,0 388,1 457,0 528,1 571,0 585,1 617,0 696,1 796,0 798,1 872,0 938,1 971,0 1056,1 1151,0 1192,1 1281,0 1297,1 1308,0 1362,1 1411,0 1510,1 1582,0 1607,1 1616,0 1629,1 1678,0 1715,1 1759,0 1844,1 1923,0 1985,1 2038,0 2074,1 2160,0 2242,1 2275,0 2324,1 2363,0 2426,1 2515,0 2519,1 2554,0 2652,1 2683,0 2751,1 2765,0 2844,1 2846,0 2920,1 2946,0 2960,1 3046,0 3105,1 3203,0 3255,1 3347,0 3442,1 3533,0 3541,1 3565,0 3648,1 3667,0 3673,1 3674,0 3678,1 3737,0 3760,1 3776,0 3852,1 3924,0 4007,1 4062,0 4110,1 4180,0 4247,1 4253,0 4318,1 4326,0 4410,1 4439,0 4499,1 4583,0 4632,1 4649,0 4700,1 4723,0 4785,1 4859,0 4903,1 4969,0 5059,1 5151,0 5153,1 5207,0 5229,1 5297,0 5315,1 5356,0 5368,1 5400,0 5498,1 5551,0 5612,1 5691,0 5708,1 5714,0 5781,1 5802,0 5900,1 5964,0 6022,1 6088,0 6180,1 6225,0 6246,1 6281,0 6286,1 6386,0 6406,1 6497,0 6586,1 6603,0 6625,1 6694,0 6776,1 6842,0 6923,1 6956,0 6993,1 7037,0 7103,1 7159,0 7253,1 7333,0 7348,1 7399,0 7443,1 7515,0 7524,1 7577,0 7664,1 7723,0 7726,1 7727,0 7808,1 7812,0 7905,1 7943,0 7959,1 7969,0 7994,1 8027,0 8079,1 8096,0 8118,1 8195,0 8270,1 8361,0 8413,1 8479,0 8513,1 8549,0 8634,1 8706,0 8733,1 8744,0 8788,1 8791,0 8833,1 8850,0 8941,1 8991,0 9087,1 9138,0 9172,1 9241,0 9303,1 9323,0 9331,1 9408,0 9491,1 9568,0 9603,1 9677,0 9736,1 9807,0 9894,1 9964,0 9967,1 10064,0 10144,1 10147,0 10242,1 10339,0 10426,1 10429,0 10488,1 10527,0 10558,1 10621,0 10696,1 10703,0 10782,1 10841,0 10900,1 10958,0 11038,1 11083,0 11115,1 11138,0 11168,1 11250,0 11320,1 11415,0 11429,1 11489,0 11521,1 11544,0 11545,1 11625,0 11637,1 11710,0 11778,1 11836,0 11888,1 11894,0 11908,1 11963,0 12002,1 12070,0 12092,1 12159,0 12188,1 12247,0 12270,1 12357,0 12384,1 12454,0 12465,1 12468,0 12507,1 12587,0 12676,1 12714,0 12784,1 12880,0 12970,1 13034,0 13133,1 13153,0 13187,1 13276,0 13359,1 end initlist a49 0,0 83,1 97,0 149,1 247,0 331,1 413,0 437,1 531,0 623,1 630,0 725,1 747,0 800,1 885,0 901,1 1001,0 1062,1 1108,0 1122,1 1212,0 1254,1 1347,0 1373,1 1376,0 1397,1 1438,0 1445,1 1520,0 1609,1 1661,0 1680,1 1718,0 1754,1 1807,0 1895,1 1937,0 2006,1 2025,0 2125,1 2223,0 2298,1 2381,0 2448,1 2466,0 2540,1 2547,0 2606,1 2685,0 2711,1 2805,0 2825,1 2828,0 2875,1 2927,0 2942,1 2947,0 2991,1 3077,0 3126,1 3190,0 3251,1 3263,0 3317,1 3321,0 3333,1 3385,0 3416,1 3452,0 3502,1 3535,0 3584,1 3629,0 3650,1 3678,0 3737,1 3817,0 3855,1 3936,0 4015,1 4115,0 4124,1 4192,0 4223,1 4307,0 4313,1 4372,0 4407,1 4460,0 4550,1 4556,0 4595,1 4622,0 4631,1 4697,0 4762,1 4841,0 4849,1 4866,0 4911,1 4957,0 4983,1 5056,0 5143,1 5232,0 5300,1 5342,0 5424,1 5446,0 5498,1 5564,0 5588,1 5679,0 5757,1 5793,0 5803,1 5850,0 5892,1 5979,0 6053,1 6136,0 6152,1 6221,0 6258,1 6339,0 6376,1 6434,0 6521,1 6567,0 6609,1 6654,0 6682,1 6779,0 6812,1 6833,0 6858,1 6862,0 6909,1 6918,0 6998,1 7000,0 7050,1 7061,0 7114,1 7121,0 7195,1 7244,0 7320,1 7374,0 7395,1 7440,0 7518,1 7568,0 7642,1 7730,0 7826,1 7883,0 7964,1 7991,0 8072,1 8162,0 8234,1 8325,0 8330,1 8390,0 8477,1 8550,0 8571,1 8670,0 8754,1 8777,0 8869,1 8892,0 8957,1 8970,0 9031,1 9128,0 9138,1 9140,0 9234,1 9237,0 9257,1 9298,0 9369,1 9437,0 9481,1 9565,0 9588,1 9673,0 9739,1 9831,0 9887,1 9958,0 10035,1 10114,0 10138,1 10154,0 10156,1 10213,0 10305,1 10363,0 10422,1 10455,0 10484,1 10546,0 10627,1 10716,0 10814,1 10852,0 10900,1 10967,0 11059,1 11092,0 11095,1 11113,0 11177,1 11178,0 11227,1 11300,0 11384,1 11436,0 11499,1 11564,0 11646,1 11737,0 11788,1 11821,0 11920,1 11974,0 11996,1 12030,0 12061,1 12092,0 12095,1 12154,0 12176,1 12185,0 12202,1 12287,0 12381,1 12388,0 12410,1 12479,0 12529,1 12612,0 12636,1 12726,0 12729,1 12763,0 12800,1 12867,0 12965,1 13041,0 13050,1 13079,0 13130,1 13155,0 13217,1 end initlist a50 0,0 48,1 117,0 171,1 195,0 237,1 329,0 386,1 451,0 469,1 548,0 596,1 688,0 782,1 846,0 865,1 908,0 935,1 960,0 1015,1 1058,0 1099,1 1197,0 1286,1 1337,0 1435,1 1516,0 1565,1 1602,0 1646,1 1678,0 1717,1 1737,0 1810,1 1908,0 1912,1 1950,0 1964,1 2044,0 2077,1 2084,0 2109,1 2122,0 2149,1 2174,0 2183,1 2218,0 2221,1 2269,0 2310,1 2363,0 2412,1 2480,0 2524,1 2607,0 2637,1 2693,0 2744,1 2812,0 2821,1 2870,0 2898,1 2982,0 3056,1 3068,0 3121,1 3209,0 3306,1 3351,0 3399,1 3497,0 3510,1 3582,0 3589,1 3674,0 3757,1 3765,0 3859,1 3904,0 3950,1 3976,0 4020,1 4097,0 4184,1 4189,0 4219,1 4291,0 4294,1 4358,0 4383,1 4466,0 4541,1 4553,0 4612,1 4663,0 4684,1 4729,0 4798,1 4834,0 4897,1 4975,0 5028,1 5039,0 5100,1 5177,0 5264,1 5277,0 5334,1 5358,0 5442,1 5500,0 5566,1 5664,0 5760,1 5815,0 5827,1 5871,0 5946,1 5981,0 6053,1 6062,0 6162,1 6166,0 6169,1 6170,0 6225,1 6243,0 6300,1 6357,0 6391,1 6396,0 6480,1 6491,0 6521,1 6586,0 6609,1 6694,0 6779,1 6873,0 6933,1 6964,0 7062,1 7127,0 7196,1 7266,0 7316,1 7413,0 7499,1 7543,0 7591,1 7664,0 7754,1 7779,0 7815,1 7875,0 7897,1 7946,0 8016,1 8072,0 8145,1 8184,0 8283,1 8326,0 8369,1 8417,0 8467,1 8482,0 8544,1 8545,0 8630,1 8728,0 8752,1 8846,0 8941,1 9033,0 9056,1 9086,0 9140,1 9217,0 9266,1 9323,0 9390,1 9409,0 9467,1 9539,0 9611,1 9634,0 9710,1 9764,0 9841,1 9859,0 9925,1 9944,0 9955,1 9957,0 10012,1 10013,0 10068,1 10084,0 10094,1 10133,0 10155,1 10227,0 10242,1 10325,0 10352,1 10440,0 10452,1 10489,0 10515,1 10598,0 10682,1 10734,0 10753,1 10776,0 10806,1 10867,0 10928,1 10973,0 11023,1 11024,0 11082,1 11111,0 11132,1 11190,0 11265,1 11283,0 11317,1 11385,0 11441,1 11461,0 11542,1 11563,0 11597,1 11611,0 11634,1 11650,0 11698,1 11738,0 11760,1 11799,0 11869,1 11901,0 11947,1 12025,0 12117,1 12197,0 12201,1 12236,0 12238,1 12318,0 12325,1 12349,0 12431,1 12458,0 12513,1 12525,0 12595,1 end initlist a51 0,0 91,1 125,0 219,1 282,0 322,1 422,0 469,1 503,0 566,1 581,0 654,1 667,0 713,1 813,0 898,1 956,0 981,1 1073,0 1099,1 1165,0 1199,1 1245,0 1289,1 1306,0 1356,1 1359,0 1452,1 1454,0 1554,1 1607,0 1611,1 1688,0 1703,1 1742,0 1787,1 1884,0 1896,1 1994,0 2086,1 2137,0 2185,1 2257,0 2305,1 2338,0 2365,1 2401,0 2476,1 2532,0 2605,1 2678,0 2706,1 2723,0 2744,1 2761,0 2836,1 2847,0 2848,1 2866,0 2909,1 2928,0 2996,1 3064,0 3126,1 3180,0 3200,1 3222,0 3276,1 3324,0 3352,1 3369,0 3448,1 3529,0 3597,1 3674,0 3759,1 3784,0 3883,1 3914,0 4010,1 4029,0 4086,1 4121,0 4183,1 4262,0 4361,1 4385,0 4462,1 4550,0 4650,1 4711,0 4728,1 4814,0 4881,1 4890,0 4957,1 4978,0 5038,1 5080,0 5161,1 5175,0 5249,1 5334,0 5410,1 5424,0 5444,1 5541,0 5575,1 5585,0 5656,1 5738,0 5829,1 5852,0 5915,1 5990,0 6076,1 6100,0 6104,1 6181,0 6228,1 6272,0 6297,1 6389,0 6455,1 6521,0 6593,1 6689,0 6752,1 6848,0 6853,1 6882,0 6930,1 7001,0 7026,1 7029,0 7095,1 7171,0 7228,1 7237,0 7238,1 7252,0 7271,1 7326,0 7357,1 7432,0 7478,1 7487,0 7566,1 7665,0 7666,1 7737,0 7739,1 7757,0 7852,1 7868,0 7921,1 7951,0 7981,1 7984,0 8068,1 8109,0 8201,1 8294,0 8385,1 8426,0 8482,1 8575,0 8628,1 8663,0 8665,1 8695,0 8720,1 8737,0 8812,1 8887,0 8893,1 8944,0 9018,1 9112,0 9131,1 9202,0 9269,1 9330,0 9344,1 9368,0 9455,1 9555,0 9567,1 9589,0 9616,1 9676,0 9719,1 9781,0 9855,1 9878,0 9957,1 10044,0 10052,1 10119,0 10145,1 10176,0 10267,1 10344,0 10380,1 10474,0 10570,1 10664,0 10679,1 10698,0 10797,1 10860,0 10918,1 10957,0 11008,1 11096,0 11131,1 11166,0 11168,1 11229,0 11250,1 11296,0 11356,1 11418,0 11447,1 11455,0 11483,1 11504,0 11561,1 11659,0 11725,1 11782,0 11847,1 11914,0 11977,1 12020,0 12063,1 12077,0 12126,1 12224,0 12321,1 12406,0 12414,1 12428,0 12468,1 12526,0 12607,1 12683,0 12767,1 12813,0 12827,1 12896,0 12916,1 12945,0 13001,1 13015,0 13088,1 13122,0 13179,1 end initlist a52 0,0 8,1 61,0 71,1 166,0 222,1 236,0 259,1 346,0 444,1 453,0 486,1 559,0 632,1 670,0 696,1 796,0 804,1 819,0 837,1 883,0 963,1 985,0 1082,1 1146,0 1171,1 1220,0 1233,1 1318,0 1417,1 1439,0 1502,1 1558,0 1635,1 1641,0 1652,1 1739,0 1771,1 1850,0 1882,1 1919,0 1920,1 1972,0 2008,1 2067,0 2076,1 2101,0 2150,1 2194,0 2224,1 2316,0 2355,1 2372,0 2398,1 2486,0 2562,1 2610,0 2672,1 2704,0 2712,1 2733,0 2810,1 2892,0 2899,1 2976,0 2998,1 3064,0 3152,1 3221,0 3269,1 3275,0 3356,1 3452,0 3505,1 3537,0 3618,1 3621,0 3703,1 3790,0 3824,1 3890,0 3937,1 4032,0 4061,1 4116,0 4194,1 4220,0 4287,1 4325,0 4336,1 4410,0 4497,1 4500,0 4504,1 4570,0 4655,1 4702,0 4798,1 4806,0 4862,1 4881,0 4934,1 5012,0 5085,1 5103,0 5143,1 5208,0 5293,1 5382,0 5439,1 5508,0 5606,1 5617,0 5659,1 5712,0 5757,1 5805,0 5812,1 5883,0 5978,1 5980,0 6072,1 6082,0 6115,1 6159,0 6248,1 6260,0 6272,1 6361,0 6427,1 6445,0 6465,1 6505,0 6585,1 6679,0 6687,1 6696,0 6730,1 6757,0 6776,1 6807,0 6877,1 6879,0 6931,1 6966,0 7001,1 7093,0 7120,1 7155,0 7247,1 7278,0 7286,1 7344,0 7419,1 7484,0 7515,1 7542,0 7605,1 7616,0 7690,1 7790,0 7874,1 7875,0 7910,1 7958,0 7976,1 8048,0 8083,1 8158,0 8232,1 8307,0 8347,1 8394,0 8434,1 8534,0 8614,1 8696,0 8775,1 8842,0 8875,1 8945,0 8961,1 8980,0 9035,1 9063,0 9121,1 9188,0 9207,1 9272,0 9364,1 9457,0 9529,1 9556,0 9612,1 9664,0 9749,1 9768,0 9858,1 9878,0 9895,1 9981,0 9990,1 10057,0 10089,1 10092,0 10143,1 10199,0 10293,1 10368,0 10426,1 10518,0 10562,1 10623,0 10716,1 10799,0 10805,1 10828,0 10850,1 10918,0 10986,1 11028,0 11128,1 11166,0 11232,1 11234,0 11267,1 11314,0 11381,1 11419,0 11517,1 11561,0 11627,1 11629,0 11651,1 11654,0 11745,1 11822,0 11894,1 11963,0 11996,1 12096,0 12137,1 12142,0 12212,1 12266,0 12361,1 12459,0 12522,1 12547,0 12548,1 12573,0 12614,1 12628,0 12665,1 12701,0 12774,1 12855,0 12951,1 end initlist a53 0,0 14,1 112,0 136,1 224,0 246,1 344,0 364,1 376,0 423,1 432,0 530,1 572,0 634,1 663,0 677,1 724,0 768,1 797,0 888,1 899,0 940,1 956,0 965,1 994,0 1074,1 1137,0 1235,1 1285,0 1358,1 1430,0 1456,1 1517,0 1520,1 1533,0 1579,1 1649,0 1659,1 1708,0 1791,1 1855,0 1941,1 1947,0 1953,1 2042,0 2075,1 2082,0 2105,1 2174,0 2218,1 2246,0 2262,1 2358,0 2390,1 2481,0 2538,1 2635,0 2641,1 2720,0 2735,1 2748,0 2814,1 2880,0 2887,1 2969,0 3015,1 3115,0 3128,1 3186,0 3204,1 3217,0 3226,1 3290,0 3357,1 3421,0 3507,1 3534,0 3536,1 3606,0 3611,1 3614,0 3668,1 3679,0 3729,1 3794,0 3859,1 3898,0 3906,1 4000,0 4050,1 4076,0 4101,1 4147,0 4170,1 4212,0 4253,1 4327,0 4349,1 4367,0 4433,1 4509,0 4522,1 4573,0 4657,1 4675,0 4746,1 4755,0 4775,1 4846,0 4934,1 4938,0 5033,1 5073,0 5148,1 5164,0 5181,1 5251,0 5346,1 5361,0 5368,1 5428,0 5467,1 5550,0 5563,1 5566,0 5628,1 5722,0 5770,1 5797,0 5894,1 5952,0 5986,1 6059,0 6062,1 6071,0 6140,1 6148,0 6205,1 6294,0 6308,1 6351,0 6433,1 6509,0 6518,1 6577,0 6585,1 6677,0 6719,1 6738,0 6762,1 6774,0 6862,1 6873,0 6967,1 7012,0 7082,1 7125,0 7163,1 7210,0 7264,1 7318,0 7400,1 7482,0 7578,1 7586,0 7620,1 7628,0 7705,1 7753,0 7805,1 7807,0 7858,1 7949,0 7995,1 8044,0 8087,1 8175,0 8211,1 8241,0 8329,1 8414,0 8449,1 8519,0 8570,1 8655,0 8749,1 8816,0 8839,1 8907,0 8947,1 8986,0 9079,1 9093,0 9154,1 9159,0 9167,1 9212,0 9291,1 9347,0 9410,1 9494,0 9506,1 9532,0 9540,1 9635,0 9650,1 9737,0 9739,1 9802,0 9811,1 9867,0 9951,1 10004,0 10033,1 10072,0 10155,1 10217,0 10269,1 10307,0 10368,1 10425,0 10522,1 10622,0 10699,1 10776,0 10811,1 10870,0 10902,1 10918,0 10952,1 10973,0 11053,1 11145,0 11165,1 11257,0 11261,1 11353,0 11375,1 11460,0 11463,1 11513,0 11578,1 11608,0 11684,1 11745,0 11760,1 11794,0 11854,1 11855,0 11900,1 11925,0 11934,1 11984,0 12031,1 12032,0 12083,1 12152,0 12193,1 end initlist a54 0,0 96,1 130,0 226,1 233,0 254,1 310,0 327,1 390,0 454,1 466,0 552,1 576,0 655,1 668,0 749,1 803,0 817,1 889,0 960,1 1053,0 1083,1 1087,0 1134,1 1188,0 1226,1 1325,0 1363,1 1384,0 1473,1 1491,0 1538,1 1621,0 1697,1 1779,0 1823,1 1842,0 1932,1 1959,0 1973,1 2016,0 2073,1 2074,0 2156,1 2212,0 2302,1 2363,0 2397,1 2488,0 2531,1 2550,0 2591,1 2684,0 2730,1 2749,0 2813,1 2867,0 2942,1 3028,0 3030,1 3116,0 3212,1 3267,0 3331,1 3369,0 3460,1 3475,0 3532,1 3619,0 3671,1 3770,0 3801,1 3868,0 3934,1 3976,0 4066,1 4142,0 4186,1 4267,0 4303,1 4328,0 4393,1 4455,0 4482,1 4494,0 4574,1 4651,0 4680,1 4700,0 4791,1 4859,0 4918,1 4926,0 4965,1 5059,0 5121,1 5200,0 5277,1 5288,0 5376,1 5406,0 5474,1 5537,0 5624,1 5694,0 5727,1 5774,0 5840,1 5892,0 5915,1 5945,0 5958,1 5989,0 6077,1 6121,0 6201,1 6209,0 6239,1 6325,0 6386,1 6467,0 6496,1 6541,0 6590,1 6658,0 6742,1 6835,0 6882,1 6946,0 7009,1 7028,0 7112,1 7166,0 7264,1 7298,0 7395,1 7417,0 7435,1 7503,0 7531,1 7562,0 7662,1 7702,0 7761,1 7772,0 7861,1 7944,0 8024,1 8102,0 8163,1 8171,0 8177,1 8262,0 8355,1 8434,0 8472,1 8571,0 8577,1 8652,0 8655,1 8706,0 8804,1 8809,0 8887,1 8944,0 8979,1 9037,0 9131,1 9191,0 9213,1 9244,0 9334,1 9384,0 9479,1 9521,0 9570,1 9599,0 9631,1 9721,0 9779,1 9788,0 9851,1 9912,0 9965,1 9986,0 10065,1 10069,0 10132,1 10215,0 10231,1 10290,0 10375,1 10453,0 10484,1 10536,0 10545,1 10558,0 10606,1 10632,0 10727,1 10738,0 10838,1 10866,0 10954,1 10985,0 11007,1 11035,0 11111,1 11160,0 11216,1 11287,0 11353,1 11361,0 11411,1 11477,0 11489,1 11532,0 11574,1 11603,0 11683,1 11742,0 11824,1 11873,0 11919,1 11977,0 12035,1 12104,0 12195,1 12274,0 12279,1 12339,0 12401,1 12437,0 12469,1 12514,0 12531,1 12550,0 12609,1 12686,0 12720,1 12729,0 12790,1 12849,0 12872,1 12971,0 13028,1 13114,0 13141,1 13200,0 13224,1 13312,0 13384,1 13484,0 13497,1 13526,0 13574,1 13628,0 13649,1 end initlist a55 0,0 68,1 79,0 163,1 262,0 279,1 288,0 354,1 441,0 494,1 553,0 554,1 652,0 677,1 692,0 789,1 860,0 896,1 906,0 913,1 984,0 1084,1 1122,0 1142,1 1160,0 1254,1 1299,0 1392,1 1433,0 1441,1 1445,0 1506,1 1589,0 1628,1 1710,0 1742,1 1797,0 1851,1 1861,0 1924,1 1961,0 1988,1 2016,0 2086,1 2117,0 2119,1 2182,0 2243,1 2333,0 2420,1 2473,0 2476,1 2543,0 2617,1 2706,0 2771,1 2773,0 2802,1 2894,0 2987,1 3052,0 3122,1 3128,0 3194,1 3240,0 3336,1 3348,0 3436,1 3481,0 3492,1 3534,0 3597,1 3669,0 3700,1 3795,0 3871,1 3881,0 3887,1 3924,0 3951,1 3988,0 4028,1 4072,0 4118,1 4189,0 4261,1 4342,0 4418,1 4508,0 4550,1 4593,0 4674,1 4769,0 4842,1 4929,0 4953,1 5004,0 5029,1 5072,0 5165,1 5242,0 5304,1 5338,0 5392,1 5454,0 5488,1 5533,0 5540,1 5577,0 5625,1 5653,0 5698,1 5779,0 5821,1 5872,0 5942,1 5972,0 6027,1 6097,0 6190,1 6258,0 6348,1 6428,0 6518,1 6573,0 6635,1 6693,0 6694,1 6711,0 6807,1 6905,0 6947,1 7042,0 7120,1 7177,0 7210,1 7227,0 7315,1 7415,0 7481,1 7522,0 7554,1 7646,0 7691,1 7734,0 7749,1 7816,0 7894,1 7909,0 7934,1 7951,0 7974,1 8017,0 8089,1 8137,0 8179,1 8266,0 8291,1 8384,0 8427,1 8490,0 8572,1 8664,0 8764,1 8820,0 8879,1 8888,0 8985,1 9083,0 9120,1 9202,0 9288,1 9365,0 9372,1 9407,0 9432,1 9436,0 9487,1 9542,0 9629,1 9650,0 9705,1 9772,0 9796,1 9875,0 9895,1 9913,0 9959,1 9971,0 10028,1 10108,0 10110,1 10183,0 10222,1 10288,0 10376,1 10390,0 10475,1 10524,0 10535,1 10559,0 10652,1 10693,0 10720,1 10730,0 10785,1 10791,0 10828,1 10908,0 11001,1 11022,0 11089,1 11099,0 11166,1 11265,0 11340,1 11378,0 11456,1 11506,0 11522,1 11622,0 11699,1 11721,0 11816,1 11854,0 11951,1 12026,0 12117,1 12195,0 12216,1 12236,0 12248,1 12281,0 12320,1 12339,0 12356,1 12381,0 12432,1 12487,0 12510,1 12516,0 12561,1 12646,0 12680,1 12721,0 12814,1 12909,0 12933,1 12949,0 12980,1 12995,0 13037,1 13123,0 13175,1 13180,0 13204,1 13247,0 13256,1 end initlist a56 0,0 97,1 146,0 232,1 286,0 315,1 410,0 446,1 542,0 628,1 702,0 725,1 780,0 867,1 901,0 980,1 1053,0 1144,1 1190,0 1242,1 1325,0 1405,1 1426,0 1512,1 1549,0 1563,1 1645,0 1745,1 1809,0 1822,1 1836,0 1870,1 1880,0 1884,1 1951,0 2002,1 2087,0 2099,1 2125,0 2145,1 2169,0 2173,1 2248,0 2290,1 2371,0 2460,1 2466,0 2485,1 2520,0 2521,1 2567,0 2591,1 2596,0 2678,1 2706,0 2730,1 2827,0 2871,1 2882,0 2929,1 3024,0 3044,1 3073,0 3099,1 3136,0 3186,1 3189,0 3200,1 3243,0 3292,1 3334,0 3393,1 3476,0 3542,1 3547,0 3607,1 3704,0 3758,1 3772,0 3852,1 3854,0 3889,1 3894,0 3991,1 4068,0 4131,1 4152,0 4210,1 4238,0 4318,1 4408,0 4502,1 4557,0 4568,1 4661,0 4756,1 4813,0 4830,1 4913,0 4979,1 5034,0 5109,1 5188,0 5246,1 5271,0 5342,1 5389,0 5416,1 5516,0 5583,1 5673,0 5758,1 5766,0 5864,1 5880,0 5953,1 5954,0 6027,1 6080,0 6163,1 6246,0 6338,1 6426,0 6437,1 6452,0 6548,1 6644,0 6647,1 6701,0 6786,1 6874,0 6889,1 6939,0 6976,1 7059,0 7073,1 7131,0 7193,1 7254,0 7333,1 7353,0 7452,1 7467,0 7481,1 7570,0 7610,1 7704,0 7765,1 7794,0 7865,1 7894,0 7908,1 7973,0 8051,1 8077,0 8097,1 8195,0 8246,1 8252,0 8272,1 8305,0 8363,1 8428,0 8500,1 8511,0 8555,1 8609,0 8616,1 8638,0 8738,1 8837,0 8917,1 8924,0 8986,1 9058,0 9064,1 9118,0 9138,1 9152,0 9173,1 9203,0 9271,1 9301,0 9399,1 9493,0 9535,1 9616,0 9709,1 9779,0 9818,1 9878,0 9945,1 10015,0 10025,1 10050,0 10145,1 10195,0 10263,1 10329,0 10336,1 10389,0 10404,1 10412,0 10459,1 10500,0 10567,1 10649,0 10673,1 10713,0 10807,1 10869,0 10909,1 10996,0 11042,1 11088,0 11147,1 11211,0 11286,1 11383,0 11444,1 11528,0 11603,1 11668,0 11728,1 11815,0 11906,1 11953,0 12034,1 12089,0 12122,1 12151,0 12171,1 12227,0 12308,1 12378,0 12379,1 12401,0 12444,1 12533,0 12558,1 12568,0 12569,1 12599,0 12613,1 12703,0 12788,1 12855,0 12870,1 12924,0 13009,1 13081,0 13158,1 13188,0 13250,1 13326,0 13408,1 13485,0 13537,1 end initlist a57 0,0 76,1 160,0 203,1 260,0 281,1 314,0 374,1 443,0 478,1 479,0 570,1 635,0 672,1 674,0 694,1 785,0 798,1 857,0 932,1 1007,0 1090,1 1108,0 1140,1 1177,0 1220,1 1302,0 1339,1 1410,0 1500,1 1540,0 1581,1 1612,0 1647,1 1741,0 1826,1 1911,0 1969,1 1980,0 2065,1 2088,0 2175,1 2181,0 2210,1 2248,0 2345,1 2371,0 2409,1 2439,0 2491,1 2515,0 2560,1 2600,0 2633,1 2701,0 2709,1 2749,0 2792,1 2816,0 2894,1 2987,0 2994,1 3061,0 3147,1 3201,0 3218,1 3258,0 3301,1 3372,0 3421,1 3515,0 3605,1 3630,0 3725,1 3748,0 3827,1 3919,0 3995,1 4050,0 4085,1 4146,0 4235,1 4278,0 4316,1 4351,0 4419,1 4469,0 4551,1 4583,0 4656,1 4747,0 4777,1 4813,0 4827,1 4828,0 4858,1 4862,0 4864,1 4921,0 5002,1 5054,0 5127,1 5163,0 5206,1 5278,0 5289,1 5363,0 5417,1 5450,0 5533,1 5591,0 5612,1 5652,0 5708,1 5787,0 5868,1 5932,0 5999,1 6045,0 6091,1 6113,0 6137,1 6226,0 6264,1 6360,0 6396,1 6401,0 6473,1 6569,0 6614,1 6683,0 6764,1 6838,0 6884,1 6936,0 6990,1 7028,0 7078,1 7132,0 7202,1 7204,0 7286,1 7378,0 7430,1 7450,0 7531,1 7546,0 7641,1 7708,0 7771,1 7841,0 7913,1 7951,0 7980,1 8011,0 8039,1 8104,0 8111,1 8186,0 8253,1 8282,0 8380,1 8421,0 8453,1 8456,0 8471,1 8476,0 8519,1 8582,0 8588,1 8600,0 8657,1 8749,0 8841,1 8936,0 9023,1 9047,0 9077,1 9104,0 9182,1 9215,0 9232,1 9313,0 9371,1 9385,0 9450,1 9529,0 9560,1 9583,0 9591,1 9667,0 9728,1 9769,0 9868,1 9923,0 9958,1 10052,0 10089,1 10090,0 10161,1 10180,0 10240,1 10259,0 10358,1 10436,0 10513,1 10553,0 10576,1 10627,0 10688,1 10705,0 10741,1 10815,0 10828,1 10837,0 10903,1 10998,0 11071,1 11162,0 11213,1 11275,0 11302,1 11378,0 11418,1 11451,0 11544,1 11585,0 11657,1 11705,0 11791,1 11814,0 11911,1 12008,0 12035,1 12091,0 12146,1 12245,0 12332,1 12335,0 12394,1 12472,0 12492,1 12511,0 12520,1 12553,0 12649,1 12720,0 12727,1 12804,0 12845,1 12870,0 12919,1 13012,0 13101,1 13112,0 13145,1 13153,0 13173,1 end initlist a58 0,0 38,1 128,0 144,1 189,0 258,1 262,0 342,1 426,0 517,1 520,0 568,1 654,0 738,1 794,0 796,1 838,0 900,1 928,0 974,1 996,0 1089,1 1116,0 1183,1 1279,0 1323,1 1388,0 1473,1 1570,0 1598,1 1627,0 1704,1 1743,0 1753,1 1807,0 1905,1 1934,0 1978,1 2034,0 2071,1 2116,0 2199,1 2268,0 2298,1 2328,0 2379,1 2404,0 2468,1 2568,0 2586,1 2656,0 2699,1 2769,0 2790,1 2825,0 2904,1 2972,0 3053,1 3114,0 3204,1 3261,0 3344,1 3394,0 3463,1 3484,0 3579,1 3595,0 3689,1 3774,0 3812,1 3826,0 3919,1 3932,0 3997,1 4077,0 4090,1 4125,0 4157,1 4255,0 4274,1 4333,0 4432,1 4487,0 4492,1 4539,0 4585,1 4616,0 4658,1 4714,0 4721,1 4820,0 4822,1 4826,0 4830,1 4872,0 4893,1 4957,0 4964,1 5007,0 5047,1 5080,0 5144,1 5230,0 5264,1 5347,0 5406,1 5504,0 5554,1 5645,0 5678,1 5718,0 5815,1 5886,0 5924,1 5950,0 5998,1 6064,0 6073,1 6157,0 6211,1 6273,0 6326,1 6367,0 6460,1 6475,0 6484,1 6497,0 6565,1 6660,0 6724,1 6799,0 6898,1 6975,0 7068,1 7112,0 7189,1 7211,0 7281,1 7359,0 7363,1 7433,0 7435,1 7477,0 7572,1 7654,0 7673,1 7753,0 7832,1 7852,0 7877,1 7880,0 7923,1 7963,0 8000,1 8086,0 8173,1 8199,0 8297,1 8389,0 8395,1 8479,0 8560,1 8594,0 8637,1 8697,0 8727,1 8790,0 8868,1 8959,0 8968,1 8981,0 9011,1 9089,0 9109,1 9157,0 9224,1 9302,0 9400,1 9485,0 9555,1 9567,0 9649,1 9704,0 9783,1 9788,0 9836,1 9857,0 9879,1 9908,0 9995,1 10036,0 10105,1 10146,0 10226,1 10282,0 10364,1 10453,0 10553,1 10583,0 10593,1 10648,0 10747,1 10846,0 10913,1 11013,0 11052,1 11122,0 11171,1 11215,0 11283,1 11318,0 11321,1 11420,0 11489,1 11574,0 11653,1 11706,0 11740,1 11764,0 11794,1 11877,0 11903,1 11983,0 12047,1 12088,0 12158,1 12252,0 12340,1 12341,0 12416,1 12503,0 12575,1 12608,0 12616,1 12699,0 12791,1 12885,0 12926,1 12958,0 13034,1 13094,0 13106,1 13109,0 13145,1 13235,0 13305,1 13382,0 13465,1 13515,0 13562,1 13630,0 13649,1 13742,0 13795,1 13868,0 13898,1 13913,0 13955,1 end initlist a59 0,0 26,1 93,0 96,1 98,0 128,1 198,0 226,1 292,0 329,1 399,0 469,1 523,0 531,1 563,0 570,1 573,0 602,1 642,0 684,1 769,0 790,1 798,0 824,1 912,0 988,1 1063,0 1076,1 1115,0 1133,1 1184,0 1259,1 1293,0 1330,1 1353,0 1405,1 1487,0 1525,1 1556,0 1564,1 1569,0 1584,1 1665,0 1686,1 1766,0 1851,1 1853,0 1872,1 1967,0 1972,1 2028,0 2055,1 2085,0 2099,1 2176,0 2217,1 2228,0 2317,1 2366,0 2380,1 2442,0 2446,1 2540,0 2549,1 2557,0 2571,1 2640,0 2648,1 2690,0 2771,1 2861,0 2920,1 3008,0 3042,1 3076,0 3126,1 3213,0 3229,1 3278,0 3316,1 3374,0 3465,1 3492,0 3589,1 3638,0 3713,1 3744,0 3799,1 3834,0 3910,1 3995,0 4067,1 4141,0 4211,1 4216,0 4221,1 4226,0 4235,1 4273,0 4296,1 4363,0 4400,1 4406,0 4499,1 4561,0 4596,1 4655,0 4682,1 4689,0 4698,1 4789,0 4806,1 4807,0 4843,1 4882,0 4886,1 4901,0 4991,1 5000,0 5066,1 5068,0 5126,1 5148,0 5175,1 5176,0 5210,1 5228,0 5279,1 5285,0 5302,1 5335,0 5349,1 5364,0 5453,1 5505,0 5532,1 5624,0 5694,1 5785,0 5845,1 5945,0 6041,1 6056,0 6080,1 6125,0 6152,1 6203,0 6237,1 6277,0 6346,1 6361,0 6423,1 6472,0 6548,1 6582,0 6642,1 6668,0 6687,1 6721,0 6773,1 6840,0 6856,1 6932,0 6993,1 7089,0 7134,1 7170,0 7182,1 7209,0 7285,1 7310,0 7405,1 7433,0 7474,1 7548,0 7645,1 7725,0 7762,1 7788,0 7879,1 7946,0 7985,1 8033,0 8063,1 8095,0 8166,1 8215,0 8252,1 8270,0 8321,1 8332,0 8368,1 8443,0 8475,1 8478,0 8573,1 8612,0 8640,1 8736,0 8783,1 8827,0 8893,1 8962,0 8977,1 9065,0 9096,1 9130,0 9131,1 9206,0 9217,1 9266,0 9354,1 9443,0 9488,1 9517,0 9601,1 9654,0 9663,1 9675,0 9749,1 9786,0 9844,1 9865,0 9938,1 9999,0 10060,1 10116,0 10126,1 10141,0 10227,1 10250,0 10276,1 10301,0 10309,1 10370,0 10454,1 10515,0 10516,1 10519,0 10549,1 10615,0 10660,1 10712,0 10716,1 10747,0 10833,1 10917,0 10970,1 11016,0 11037,1 11053,0 11127,1 11210,0 11243,1 11257,0 11334,1 11372,0 11383,1 end initlist a60 0,0 16,1 74,0 129,1 208,0 267,1 348,0 358,1 382,0 476,1 564,0 584,1 629,0 630,1 646,0 651,1 751,0 776,1 807,0 874,1 932,0 953,1 1034,0 1095,1 1176,0 1252,1 1332,0 1357,1 1366,0 1426,1 1456,0 1466,1 1481,0 1515,1 1599,0 1616,1 1703,0 1730,1 1784,0 1866,1 1944,0 2043,1 2053,0 2097,1 2159,0 2180,1 2264,0 2348,1 2365,0 2395,1 2490,0 2492,1 2535,0 2602,1 2696,0 2710,1 2714,0 2799,1 2891,0 2962,1 3045,0 3135,1 3216,0 3302,1 3347,0 3360,1 3389,0 3441,1 3527,0 3561,1 3627,0 3662,1 3744,0 3774,1 3785,0 3788,1 3874,0 3902,1 3911,0 3924,1 3989,0 3992,1 4064,0 4149,1 4236,0 4240,1 4316,0 4349,1 4434,0 4436,1 4453,0 4476,1 4541,0 4556,1 4632,0 4708,1 4720,0 4796,1 4872,0 4895,1 4948,0 5046,1 5061,0 5126,1 5214,0 5234,1 5284,0 5336,1 5388,0 5436,1 5459,0 5545,1 5627,0 5691,1 5754,0 5843,1 5882,0 5937,1 5942,0 6004,1 6051,0 6073,1 6146,0 6214,1 6290,0 6339,1 6392,0 6487,1 6553,0 6640,1 6713,0 6727,1 6765,0 6825,1 6895,0 6944,1 6947,0 6977,1 7071,0 7146,1 7189,0 7286,1 7308,0 7399,1 7458,0 7459,1 7538,0 7562,1 7637,0 7715,1 7729,0 7800,1 7844,0 7925,1 7947,0 8001,1 8059,0 8063,1 8137,0 8174,1 8243,0 8309,1 8394,0 8492,1 8553,0 8570,1 8665,0 8716,1 8804,0 8876,1 8956,0 9014,1 9091,0 9190,1 9216,0 9227,1 9240,0 9321,1 9403,0 9415,1 9489,0 9491,1 9591,0 9612,1 9673,0 9719,1 9789,0 9796,1 9843,0 9937,1 9960,0 10031,1 10114,0 10160,1 10195,0 10291,1 10369,0 10402,1 10473,0 10476,1 10556,0 10579,1 10645,0 10657,1 10733,0 10775,1 10808,0 10879,1 10881,0 10905,1 10932,0 11026,1 11120,0 11194,1 11248,0 11277,1 11352,0 11383,1 11464,0 11491,1 11541,0 11549,1 11585,0 11678,1 11702,0 11736,1 11805,0 11892,1 11970,0 12048,1 12091,0 12116,1 12214,0 12228,1 12256,0 12263,1 12331,0 12356,1 12390,0 12461,1 12491,0 12589,1 12657,0 12670,1 12760,0 12817,1 12872,0 12972,1 12988,0 12995,1 13065,0 13092,1 13180,0 13273,1 13372,0 13385,1 13418,0 13425,1 end initlist a61 0,0 8,1 28,0 65,1 110,0 176,1 196,0 269,1 285,0 334,1 409,0 490,1 536,0 550,1 620,0 715,1 807,0 876,1 887,0 920,1 942,0 1016,1 1066,0 1146,1 1181,0 1186,1 1240,0 1288,1 1293,0 1376,1 1466,0 1477,1 1489,0 1515,1 1587,0 1598,1 1685,0 1770,1 1867,0 1926,1 2014,0 2069,1 2086,0 2144,1 2220,0 2241,1 2297,0 2321,1 2421,0 2485,1 2492,0 2568,1 2569,0 2606,1 2698,0 2748,1 2836,0 2919,1 2969,0 3055,1 3128,0 3171,1 3175,0 3244,1 3255,0 3275,1 3278,0 3366,1 3409,0 3508,1 3589,0 3658,1 3691,0 3738,1 3811,0 3886,1 3960,0 3976,1 4040,0 4097,1 4182,0 4219,1 4220,0 4233,1 4274,0 4286,1 4315,0 4378,1 4383,0 4412,1 4510,0 4563,1 4592,0 4637,1 4715,0 4766,1 4779,0 4875,1 4939,0 5012,1 5093,0 5163,1 5209,0 5308,1 5322,0 5389,1 5395,0 5471,1 5564,0 5656,1 5733,0 5741,1 5796,0 5843,1 5887,0 5981,1 5982,0 6029,1 6122,0 6214,1 6241,0 6294,1 6394,0 6465,1 6511,0 6585,1 6614,0 6676,1 6742,0 6797,1 6799,0 6833,1 6853,0 6869,1 6900,0 6965,1 7036,0 7109,1 7156,0 7162,1 7184,0 7260,1 7345,0 7431,1 7449,0 7512,1 7548,0 7575,1 7639,0 7667,1 7669,0 7738,1 7809,0 7849,1 7896,0 7917,1 7971,0 8035,1 8121,0 8193,1 8225,0 8317,1 8328,0 8410,1 8494,0 8533,1 8621,0 8656,1 8663,0 8706,1 8753,0 8826,1 8848,0 8948,1 8967,0 9057,1 9107,0 9169,1 9171,0 9204,1 9293,0 9391,1 9450,0 9470,1 9545,0 9642,1 9666,0 9763,1 9815,0 9913,1 9929,0 9961,1 9976,0 10070,1 10160,0 10173,1 10197,0 10245,1 10253,0 10330,1 10407,0 10494,1 10588,0 10680,1 10776,0 10829,1 10872,0 10924,1 10964,0 10988,1 11070,0 11170,1 11245,0 11334,1 11396,0 11447,1 11542,0 11570,1 11572,0 11630,1 11633,0 11676,1 11706,0 11758,1 11839,0 11892,1 11929,0 12008,1 12086,0 12100,1 12175,0 12267,1 12295,0 12388,1 12429,0 12499,1 12554,0 12651,1 12679,0 12753,1 12804,0 12894,1 12901,0 12982,1 13051,0 13066,1 13139,0 13174,1 13241,0 13313,1 13374,0 13425,1 13456,0 13511,1 13609,0 13614,1 13641,0 13719,1 end initlist a62 0,0 55,1 84,0 181,1 196,0 200,1 276,0 338,1 409,0 505,1 581,0 598,1 680,0 753,1 755,0 809,1 830,0 915,1 1001,0 1082,1 1163,0 1251,1 1310,0 1321,1 1383,0 1390,1 1426,0 1511,1 1519,0 1556,1 1643,0 1683,1 1706,0 1804,1 1877,0 1882,1 1901,0 1909,1 1961,0 2007,1 2048,0 2069,1 2103,0 2201,1 2204,0 2225,1 2313,0 2398,1 2422,0 2496,1 2526,0 2576,1 2631,0 2688,1 2754,0 2776,1 2833,0 2853,1 2931,0 2952,1 2955,0 2966,1 3064,0 3075,1 3080,0 3102,1 3117,0 3152,1 3208,0 3251,1 3298,0 3330,1 3348,0 3442,1 3460,0 3504,1 3569,0 3579,1 3581,0 3648,1 3719,0 3790,1 3862,0 3869,1 3917,0 3936,1 3995,0 4080,1 4168,0 4257,1 4295,0 4342,1 4440,0 4443,1 4531,0 4566,1 4620,0 4698,1 4712,0 4801,1 4825,0 4910,1 4936,0 4976,1 5008,0 5089,1 5160,0 5214,1 5313,0 5335,1 5363,0 5421,1 5507,0 5583,1 5585,0 5684,1 5746,0 5832,1 5931,0 6008,1 6081,0 6168,1 6205,0 6284,1 6299,0 6303,1 6323,0 6386,1 6426,0 6433,1 6445,0 6524,1 6611,0 6700,1 6774,0 6817,1 6873,0 6945,1 6951,0 6985,1 7058,0 7138,1 7140,0 7204,1 7237,0 7319,1 7345,0 7353,1 7403,0 7437,1 7506,0 7513,1 7570,0 7598,1 7619,0 7685,1 7761,0 7828,1 7924,0 7971,1 8008,0 8097,1 8184,0 8274,1 8284,0 8356,1 8402,0 8417,1 8481,0 8506,1 8561,0 8610,1 8666,0 8687,1 8727,0 8810,1 8869,0 8904,1 9004,0 9029,1 9066,0 9113,1 9141,0 9171,1 9187,0 9249,1 9333,0 9360,1 9369,0 9451,1 9456,0 9486,1 9549,0 9631,1 9709,0 9733,1 9812,0 9893,1 9940,0 10025,1 10118,0 10191,1 10278,0 10290,1 10373,0 10404,1 10420,0 10425,1 10478,0 10503,1 10560,0 10581,1 10635,0 10703,1 10733,0 10737,1 10815,0 10872,1 10884,0 10938,1 11016,0 11034,1 11062,0 11099,1 11155,0 11171,1 11203,0 11276,1 11340,0 11431,1 11525,0 11575,1 11619,0 11664,1 11738,0 11799,1 11871,0 11928,1 11943,0 11989,1 12037,0 12078,1 12164,0 12245,1 12284,0 12292,1 12328,0 12348,1 12371,0 12387,1 12459,0 12484,1 12583,0 12659,1 12729,0 12731,1 12761,0 12845,1 end initlist a63 0,0 22,1 81,0 146,1 229,0 230,1 322,0 403,1 442,0 474,1 552,0 588,1 661,0 704,1 751,0 792,1 850,0 855,1 881,0 925,1 976,0 1068,1 1146,0 1237,1 1317,0 1341,1 1432,0 1501,1 1523,0 1570,1 1573,0 1637,1 1714,0 1804,1 1817,0 1914,1 1960,0 2007,1 2071,0 2143,1 2165,0 2169,1 2263,0 2314,1 2344,0 2360,1 2451,0 2515,1 2608,0 2690,1 2789,0 2799,1 2824,0 2920,1 2950,0 3012,1 3085,0 3168,1 3234,0 3310,1 3337,0 3433,1 3462,0 3530,1 3560,0 3619,1 3643,0 3712,1 3783,0 3854,1 3925,0 3944,1 4018,0 4040,1 4076,0 4097,1 4151,0 4250,1 4345,0 4410,1 4500,0 4554,1 4598,0 4653,1 4721,0 4753,1 4825,0 4891,1 4911,0 5009,1 5098,0 5136,1 5214,0 5266,1 5324,0 5414,1 5419,0 5491,1 5507,0 5594,1 5657,0 5702,1 5718,0 5764,1 5821,0 5828,1 5892,0 5987,1 6023,0 6051,1 6077,0 6115,1 6185,0 6280,1 6323,0 6345,1 6406,0 6506,1 6515,0 6556,1 6576,0 6660,1 6758,0 6764,1 6773,0 6806,1 6870,0 6961,1 7036,0 7132,1 7136,0 7199,1 7238,0 7316,1 7375,0 7439,1 7475,0 7531,1 7575,0 7659,1 7718,0 7799,1 7873,0 7947,1 7962,0 8035,1 8088,0 8129,1 8180,0 8277,1 8333,0 8367,1 8454,0 8524,1 8594,0 8604,1 8697,0 8797,1 8832,0 8900,1 8963,0 9020,1 9092,0 9138,1 9197,0 9290,1 9310,0 9406,1 9424,0 9479,1 9494,0 9520,1 9546,0 9579,1 9643,0 9694,1 9713,0 9783,1 9875,0 9929,1 9971,0 9984,1 10009,0 10059,1 10099,0 10103,1 10174,0 10234,1 10297,0 10327,1 10355,0 10396,1 10472,0 10511,1 10547,0 10597,1 10626,0 10665,1 10674,0 10757,1 10806,0 10896,1 10989,0 11047,1 11073,0 11130,1 11154,0 11202,1 11268,0 11348,1 11382,0 11437,1 11523,0 11588,1 11629,0 11665,1 11739,0 11804,1 11882,0 11972,1 12060,0 12111,1 12129,0 12217,1 12299,0 12310,1 12336,0 12351,1 12392,0 12471,1 12566,0 12609,1 12630,0 12710,1 12771,0 12802,1 12894,0 12905,1 12987,0 13086,1 13164,0 13233,1 13279,0 13368,1 13396,0 13445,1 13489,0 13512,1 13581,0 13622,1 13630,0 13695,1 13767,0 13864,1 13866,0 13918,1 14017,0 14042,1 end initlist a64 0,0 49,1 112,0 202,1 205,0 302,1 320,0 365,1 465,0 474,1 503,0 504,1 578,0 607,1 676,0 770,1 798,0 835,1 902,0 960,1 997,0 1018,1 1114,0 1196,1 1208,0 1223,1 1245,0 1270,1 1302,0 1394,1 1474,0 1492,1 1524,0 1604,1 1684,0 1704,1 1728,0 1757,1 1830,0 1859,1 1902,0 1952,1 1989,0 2062,1 2125,0 2132,1 2208,0 2222,1 2291,0 2344,1 2385,0 2403,1 2481,0 2508,1 2533,0 2613,1 2705,0 2708,1 2790,0 2834,1 2914,0 2963,1 3011,0 3049,1 3129,0 3154,1 3155,0 3211,1 3216,0 3267,1 3348,0 3374,1 3434,0 3519,1 3532,0 3537,1 3637,0 3698,1 3719,0 3794,1 3819,0 3894,1 3990,0 4000,1 4056,0 4089,1 4114,0 4173,1 4260,0 4357,1 4443,0 4507,1 4542,0 4568,1 4581,0 4622,1 4643,0 4661,1 4678,0 4735,1 4788,0 4869,1 4924,0 5006,1 5044,0 5097,1 5100,0 5197,1 5260,0 5283,1 5365,0 5458,1 5548,0 5618,1 5619,0 5689,1 5739,0 5799,1 5869,0 5962,1 5968,0 6008,1 6018,0 6049,1 6120,0 6166,1 6217,0 6286,1 6290,0 6377,1 6460,0 6517,1 6574,0 6586,1 6663,0 6719,1 6781,0 6806,1 6873,0 6905,1 6989,0 7042,1 7049,0 7087,1 7153,0 7197,1 7272,0 7303,1 7348,0 7396,1 7442,0 7520,1 7603,0 7642,1 7647,0 7684,1 7719,0 7796,1 7821,0 7869,1 7946,0 8001,1 8059,0 8091,1 8183,0 8278,1 8343,0 8389,1 8402,0 8484,1 8528,0 8561,1 8594,0 8607,1 8672,0 8744,1 8791,0 8834,1 8848,0 8905,1 8956,0 8958,1 9012,0 9018,1 9082,0 9124,1 9135,0 9208,1 9247,0 9307,1 9339,0 9355,1 9430,0 9440,1 9469,0 9518,1 9573,0 9589,1 9633,0 9708,1 9756,0 9789,1 9813,0 9888,1 9933,0 9934,1 9939,0 9962,1 9968,0 10032,1 10067,0 10136,1 10208,0 10290,1 10335,0 10362,1 10459,0 10524,1 10618,0 10673,1 10705,0 10725,1 10807,0 10901,1 10919,0 10930,1 11015,0 11057,1 11144,0 11192,1 11239,0 11332,1 11351,0 11379,1 11452,0 11534,1 11575,0 11589,1 11663,0 11681,1 11708,0 11718,1 11795,0 11833,1 11913,0 11976,1 11997,0 12050,1 12136,0 12179,1 12244,0 12304,1 12387,0 12424,1 12491,0 12549,1 12637,0 12696,1 end initlist a65 0,0 64,1 134,0 145,1 244,0 270,1 306,0 376,1 381,0 431,1 501,0 585,1 666,0 701,1 759,0 797,1 848,0 868,1 940,0 983,1 1023,0 1071,1 1105,0 1157,1 1197,0 1213,1 1248,0 1272,1 1372,0 1421,1 1482,0 1508,1 1519,0 1569,1 1580,0 1638,1 1659,0 1753,1 1852,0 1932,1 1961,0 2041,1 2124,0 2154,1 2161,0 2209,1 2258,0 2346,1 2381,0 2445,1 2509,0 2562,1 2568,0 2619,1 2708,0 2766,1 2846,0 2889,1 2913,0 2933,1 2949,0 2987,1 3037,0 3041,1 3093,0 3143,1 3166,0 3182,1 3215,0 3283,1 3355,0 3433,1 3499,0 3527,1 3596,0 3616,1 3619,0 3675,1 3743,0 3763,1 3767,0 3788,1 3834,0 3849,1 3923,0 3940,1 3949,0 3986,1 4019,0 4098,1 4153,0 4248,1 4259,0 4260,1 4297,0 4314,1 4326,0 4341,1 4388,0 4450,1 4541,0 4596,1 4674,0 4773,1 4830,0 4850,1 4900,0 4962,1 4986,0 5011,1 5012,0 5103,1 5164,0 5238,1 5333,0 5363,1 5434,0 5508,1 5608,0 5696,1 5718,0 5734,1 5790,0 5874,1 5949,0 5994,1 6062,0 6105,1 6151,0 6193,1 6275,0 6297,1 6377,0 6409,1 6495,0 6525,1 6542,0 6610,1 6647,0 6702,1 6784,0 6878,1 6879,0 6880,1 6913,0 6954,1 7001,0 7041,1 7117,0 7201,1 7219,0 7294,1 7389,0 7434,1 7464,0 7503,1 7509,0 7556,1 7590,0 7627,1 7676,0 7698,1 7796,0 7896,1 7949,0 8016,1 8042,0 8118,1 8155,0 8194,1 8225,0 8227,1 8312,0 8391,1 8415,0 8462,1 8558,0 8566,1 8626,0 8696,1 8725,0 8733,1 8764,0 8852,1 8860,0 8936,1 8985,0 9048,1 9144,0 9190,1 9280,0 9364,1 9412,0 9479,1 9502,0 9555,1 9635,0 9678,1 9743,0 9771,1 9785,0 9822,1 9898,0 9961,1 9996,0 10082,1 10168,0 10264,1 10357,0 10434,1 10526,0 10555,1 10643,0 10736,1 10813,0 10828,1 10903,0 10979,1 10998,0 10999,1 11018,0 11105,1 11122,0 11206,1 11219,0 11303,1 11361,0 11390,1 11454,0 11468,1 11470,0 11525,1 11608,0 11627,1 11720,0 11727,1 11787,0 11865,1 11961,0 12053,1 12066,0 12132,1 12157,0 12165,1 12220,0 12241,1 12290,0 12363,1 12390,0 12482,1 12542,0 12594,1 12650,0 12677,1 12766,0 12768,1 12824,0 12854,1 end initlist a66 0,0 82,1 122,0 174,1 237,0 254,1 336,0 410,1 434,0 504,1 600,0 605,1 658,0 670,1 738,0 797,1 833,0 932,1 973,0 1019,1 1103,0 1177,1 1225,0 1273,1 1367,0 1418,1 1464,0 1489,1 1580,0 1655,1 1704,0 1752,1 1759,0 1836,1 1851,0 1866,1 1872,0 1905,1 1909,0 1978,1 2025,0 2056,1 2119,0 2171,1 2242,0 2311,1 2408,0 2492,1 2562,0 2660,1 2719,0 2753,1 2775,0 2798,1 2895,0 2904,1 2993,0 2995,1 3031,0 3077,1 3169,0 3229,1 3253,0 3271,1 3318,0 3355,1 3432,0 3462,1 3542,0 3582,1 3672,0 3768,1 3784,0 3844,1 3874,0 3882,1 3980,0 4014,1 4063,0 4078,1 4149,0 4195,1 4198,0 4235,1 4322,0 4335,1 4389,0 4468,1 4541,0 4621,1 4676,0 4692,1 4693,0 4790,1 4881,0 4958,1 4987,0 4998,1 5002,0 5025,1 5112,0 5146,1 5155,0 5167,1 5183,0 5189,1 5213,0 5225,1 5322,0 5356,1 5443,0 5481,1 5500,0 5552,1 5596,0 5677,1 5748,0 5784,1 5788,0 5835,1 5879,0 5943,1 6038,0 6050,1 6129,0 6198,1 6213,0 6232,1 6326,0 6341,1 6352,0 6372,1 6400,0 6409,1 6464,0 6487,1 6502,0 6542,1 6564,0 6576,1 6607,0 6610,1 6680,0 6757,1 6799,0 6863,1 6909,0 7004,1 7058,0 7145,1 7207,0 7210,1 7264,0 7327,1 7370,0 7377,1 7438,0 7531,1 7561,0 7613,1 7702,0 7790,1 7809,0 7863,1 7935,0 8002,1 8098,0 8193,1 8235,0 8335,1 8431,0 8499,1 8520,0 8533,1 8626,0 8662,1 8717,0 8794,1 8840,0 8938,1 8960,0 8975,1 8985,0 9031,1 9053,0 9102,1 9140,0 9160,1 9162,0 9188,1 9267,0 9365,1 9463,0 9483,1 9529,0 9612,1 9648,0 9736,1 9753,0 9764,1 9828,0 9906,1 10004,0 10028,1 10040,0 10059,1 10092,0 10124,1 10127,0 10173,1 10247,0 10256,1 10261,0 10334,1 10383,0 10421,1 10507,0 10570,1 10669,0 10736,1 10808,0 10829,1 10897,0 10927,1 10949,0 10955,1 11036,0 11102,1 11197,0 11209,1 11295,0 11298,1 11310,0 11314,1 11345,0 11439,1 11532,0 11614,1 11648,0 11733,1 11805,0 11860,1 11948,0 11995,1 12076,0 12167,1 12173,0 12266,1 12287,0 12324,1 12379,0 12431,1 12449,0 12531,1 12533,0 12611,1 12643,0 12737,1 end initlist a67 0,0 81,1 123,0 217,1 294,0 311,1 349,0 360,1 427,0 495,1 520,0 548,1 564,0 662,1 671,0 684,1 772,0 826,1 889,0 894,1 945,0 999,1 1014,0 1101,1 1181,0 1241,1 1308,0 1377,1 1436,0 1471,1 1539,0 1614,1 1662,0 1718,1 1797,0 1896,1 1971,0 2031,1 2118,0 2172,1 2202,0 2257,1 2342,0 2379,1 2386,0 2400,1 2459,0 2489,1 2548,0 2582,1 2635,0 2734,1 2815,0 2904,1 2959,0 3012,1 3097,0 3100,1 3120,0 3137,1 3194,0 3294,1 3326,0 3379,1 3478,0 3546,1 3561,0 3610,1 3678,0 3758,1 3787,0 3875,1 3967,0 4029,1 4039,0 4129,1 4190,0 4284,1 4356,0 4431,1 4479,0 4508,1 4512,0 4581,1 4633,0 4653,1 4692,0 4731,1 4733,0 4737,1 4806,0 4834,1 4915,0 4971,1 5023,0 5074,1 5101,0 5128,1 5200,0 5241,1 5252,0 5318,1 5376,0 5411,1 5450,0 5469,1 5550,0 5605,1 5622,0 5671,1 5737,0 5750,1 5833,0 5853,1 5882,0 5965,1 6063,0 6078,1 6177,0 6223,1 6255,0 6264,1 6270,0 6311,1 6397,0 6406,1 6479,0 6531,1 6550,0 6647,1 6717,0 6740,1 6780,0 6809,1 6819,0 6846,1 6880,0 6974,1 7039,0 7092,1 7182,0 7246,1 7284,0 7380,1 7420,0 7485,1 7510,0 7590,1 7620,0 7681,1 7757,0 7856,1 7940,0 8006,1 8028,0 8119,1 8194,0 8248,1 8295,0 8373,1 8432,0 8526,1 8527,0 8547,1 8622,0 8658,1 8659,0 8740,1 8748,0 8818,1 8906,0 8974,1 9065,0 9087,1 9106,0 9205,1 9292,0 9296,1 9323,0 9357,1 9440,0 9521,1 9559,0 9633,1 9684,0 9687,1 9721,0 9743,1 9838,0 9928,1 9987,0 10026,1 10123,0 10128,1 10141,0 10200,1 10273,0 10293,1 10377,0 10461,1 10547,0 10594,1 10658,0 10726,1 10786,0 10810,1 10832,0 10907,1 10948,0 10958,1 11040,0 11088,1 11141,0 11200,1 11256,0 11298,1 11352,0 11436,1 11531,0 11555,1 11634,0 11695,1 11764,0 11864,1 11916,0 12006,1 12052,0 12092,1 12097,0 12135,1 12149,0 12171,1 12182,0 12237,1 12290,0 12365,1 12447,0 12503,1 12553,0 12614,1 12689,0 12737,1 12753,0 12765,1 12829,0 12859,1 12863,0 12865,1 12871,0 12944,1 13002,0 13056,1 13153,0 13214,1 13253,0 13301,1 13390,0 13400,1 end initlist a68 0,0 88,1 181,0 266,1 267,0 303,1 311,0 317,1 405,0 496,1 547,0 575,1 628,0 630,1 642,0 674,1 761,0 792,1 873,0 902,1 976,0 989,1 1012,0 1050,1 1118,0 1150,1 1242,0 1282,1 1352,0 1437,1 1532,0 1562,1 1596,0 1673,1 1763,0 1780,1 1829,0 1905,1 1972,0 2003,1 2049,0 2085,1 2119,0 2176,1 2192,0 2227,1 2314,0 2409,1 2426,0 2509,1 2532,0 2571,1 2648,0 2694,1 2766,0 2815,1 2864,0 2946,1 3022,0 3040,1 3096,0 3103,1 3167,0 3213,1 3287,0 3304,1 3347,0 3446,1 3448,0 3508,1 3523,0 3606,1 3611,0 3701,1 3785,0 3845,1 3856,0 3874,1 3925,0 3985,1 3998,0 4093,1 4180,0 4228,1 4320,0 4359,1 4427,0 4444,1 4537,0 4567,1 4635,0 4735,1 4739,0 4779,1 4800,0 4874,1 4973,0 5026,1 5076,0 5114,1 5166,0 5200,1 5295,0 5385,1 5472,0 5506,1 5585,0 5647,1 5685,0 5737,1 5775,0 5841,1 5853,0 5909,1 5943,0 6027,1 6097,0 6145,1 6146,0 6180,1 6186,0 6283,1 6382,0 6430,1 6440,0 6534,1 6617,0 6637,1 6718,0 6771,1 6804,0 6835,1 6875,0 6887,1 6891,0 6932,1 7000,0 7040,1 7073,0 7131,1 7205,0 7288,1 7321,0 7350,1 7385,0 7433,1 7532,0 7587,1 7677,0 7748,1 7839,0 7842,1 7860,0 7903,1 7959,0 7970,1 7979,0 7984,1 8064,0 8155,1 8166,0 8209,1 8233,0 8285,1 8347,0 8368,1 8449,0 8466,1 8539,0 8543,1 8593,0 8611,1 8691,0 8757,1 8769,0 8797,1 8816,0 8876,1 8886,0 8972,1 9034,0 9112,1 9120,0 9178,1 9275,0 9328,1 9365,0 9374,1 9437,0 9516,1 9606,0 9705,1 9758,0 9821,1 9858,0 9863,1 9927,0 10013,1 10100,0 10157,1 10176,0 10222,1 10224,0 10241,1 10339,0 10374,1 10466,0 10472,1 10570,0 10603,1 10633,0 10679,1 10706,0 10708,1 10739,0 10783,1 10812,0 10827,1 10877,0 10946,1 11025,0 11076,1 11093,0 11104,1 11174,0 11240,1 11336,0 11420,1 11493,0 11589,1 11629,0 11654,1 11699,0 11732,1 11787,0 11826,1 11922,0 11948,1 12000,0 12014,1 12103,0 12194,1 12270,0 12274,1 12298,0 12356,1 12425,0 12451,1 12462,0 12510,1 12592,0 12652,1 12748,0 12775,1 12839,0 12900,1 12981,0 13018,1 end initlist a69 0,0 46,1 141,0 149,1 169,0 217,1 227,0 310,1 380,0 381,1 385,0 396,1 493,0 553,1 621,0 656,1 756,0 800,1 886,0 951,1 961,0 980,1 1032,0 1044,1 1071,0 1083,1 1159,0 1254,1 1305,0 1335,1 1340,0 1436,1 1501,0 1515,1 1610,0 1640,1 1647,0 1744,1 1771,0 1792,1 1811,0 1866,1 1937,0 1978,1 1982,0 2048,1 2105,0 2148,1 2164,0 2175,1 2224,0 2292,1 2357,0 2448,1 2494,0 2545,1 2591,0 2682,1 2699,0 2785,1 2835,0 2845,1 2898,0 2981,1 3002,0 3068,1 3152,0 3230,1 3253,0 3282,1 3335,0 3342,1 3419,0 3465,1 3528,0 3556,1 3633,0 3639,1 3697,0 3782,1 3847,0 3904,1 3962,0 3969,1 3991,0 4057,1 4115,0 4155,1 4240,0 4313,1 4337,0 4340,1 4343,0 4363,1 4391,0 4397,1 4497,0 4595,1 4610,0 4642,1 4726,0 4812,1 4877,0 4920,1 5004,0 5081,1 5146,0 5242,1 5291,0 5366,1 5373,0 5469,1 5471,0 5523,1 5615,0 5622,1 5667,0 5686,1 5726,0 5768,1 5786,0 5790,1 5793,0 5885,1 5979,0 5996,1 6002,0 6097,1 6167,0 6204,1 6265,0 6334,1 6359,0 6395,1 6405,0 6426,1 6429,0 6510,1 6558,0 6642,1 6727,0 6827,1 6902,0 6932,1 6940,0 7006,1 7040,0 7107,1 7199,0 7279,1 7366,0 7464,1 7483,0 7548,1 7559,0 7561,1 7642,0 7698,1 7788,0 7790,1 7861,0 7929,1 8022,0 8073,1 8127,0 8195,1 8271,0 8322,1 8330,0 8374,1 8439,0 8460,1 8525,0 8616,1 8708,0 8722,1 8788,0 8832,1 8834,0 8863,1 8928,0 8988,1 9079,0 9143,1 9154,0 9237,1 9261,0 9323,1 9376,0 9409,1 9467,0 9539,1 9575,0 9650,1 9676,0 9771,1 9828,0 9900,1 10000,0 10026,1 10086,0 10110,1 10184,0 10189,1 10261,0 10357,1 10446,0 10509,1 10586,0 10587,1 10653,0 10716,1 10735,0 10740,1 10808,0 10831,1 10845,0 10920,1 10994,0 11064,1 11070,0 11137,1 11185,0 11187,1 11245,0 11250,1 11320,0 11403,1 11483,0 11564,1 11636,0 11721,1 11810,0 11849,1 11877,0 11905,1 11926,0 11942,1 12025,0 12116,1 12165,0 12257,1 12356,0 12365,1 12451,0 12485,1 12487,0 12491,1 12528,0 12610,1 12675,0 12739,1 12743,0 12816,1 12831,0 12858,1 12931,0 12976,1 end initlist a70 0,0 41,1 92,0 149,1 150,0 231,1 240,0 297,1 342,0 441,1 535,0 539,1 585,0 661,1 740,0 772,1 865,0 878,1 910,0 982,1 1068,0 1123,1 1197,0 1261,1 1284,0 1337,1 1343,0 1396,1 1460,0 1488,1 1570,0 1666,1 1696,0 1785,1 1805,0 1832,1 1839,0 1891,1 1902,0 1934,1 2024,0 2089,1 2177,0 2255,1 2318,0 2320,1 2370,0 2393,1 2451,0 2490,1 2522,0 2576,1 2633,0 2727,1 2769,0 2859,1 2898,0 2913,1 2960,0 3030,1 3082,0 3116,1 3209,0 3278,1 3331,0 3415,1 3417,0 3508,1 3533,0 3559,1 3634,0 3679,1 3736,0 3766,1 3810,0 3865,1 3903,0 3987,1 4076,0 4087,1 4172,0 4255,1 4327,0 4382,1 4440,0 4527,1 4555,0 4606,1 4671,0 4744,1 4748,0 4814,1 4893,0 4961,1 5010,0 5077,1 5092,0 5106,1 5157,0 5210,1 5282,0 5318,1 5386,0 5442,1 5521,0 5532,1 5586,0 5634,1 5641,0 5685,1 5761,0 5771,1 5840,0 5865,1 5918,0 5942,1 5982,0 6000,1 6055,0 6148,1 6235,0 6250,1 6270,0 6280,1 6319,0 6345,1 6347,0 6353,1 6422,0 6467,1 6559,0 6569,1 6666,0 6685,1 6700,0 6796,1 6841,0 6894,1 6974,0 6994,1 7049,0 7067,1 7130,0 7143,1 7194,0 7197,1 7209,0 7297,1 7359,0 7422,1 7518,0 7569,1 7593,0 7655,1 7697,0 7715,1 7751,0 7837,1 7876,0 7897,1 7908,0 7996,1 8080,0 8103,1 8168,0 8195,1 8241,0 8272,1 8350,0 8366,1 8379,0 8454,1 8516,0 8543,1 8607,0 8646,1 8704,0 8739,1 8811,0 8822,1 8837,0 8932,1 8980,0 9038,1 9039,0 9075,1 9140,0 9166,1 9200,0 9291,1 9387,0 9426,1 9492,0 9530,1 9607,0 9637,1 9690,0 9767,1 9861,0 9955,1 9963,0 10050,1 10072,0 10137,1 10200,0 10254,1 10347,0 10360,1 10408,0 10428,1 10430,0 10450,1 10535,0 10581,1 10647,0 10709,1 10753,0 10833,1 10843,0 10921,1 10961,0 11038,1 11075,0 11097,1 11106,0 11114,1 11206,0 11256,1 11340,0 11433,1 11516,0 11555,1 11564,0 11628,1 11691,0 11729,1 11804,0 11876,1 11879,0 11900,1 11928,0 12014,1 12057,0 12109,1 12198,0 12287,1 12299,0 12380,1 12443,0 12514,1 12579,0 12583,1 12661,0 12733,1 12799,0 12806,1 12901,0 12943,1 end initlist a71 0,0 93,1 121,0 192,1 288,0 345,1 409,0 445,1 510,0 583,1 675,0 700,1 779,0 865,1 872,0 967,1 983,0 1016,1 1072,0 1099,1 1191,0 1267,1 1325,0 1391,1 1478,0 1530,1 1543,0 1544,1 1573,0 1597,1 1612,0 1630,1 1655,0 1747,1 1809,0 1817,1 1895,0 1990,1 2050,0 2079,1 2092,0 2109,1 2194,0 2249,1 2345,0 2417,1 2465,0 2503,1 2517,0 2519,1 2533,0 2556,1 2644,0 2649,1 2709,0 2761,1 2828,0 2893,1 2968,0 3053,1 3091,0 3095,1 3156,0 3233,1 3297,0 3334,1 3411,0 3467,1 3495,0 3569,1 3589,0 3597,1 3637,0 3671,1 3705,0 3737,1 3789,0 3869,1 3935,0 4005,1 4062,0 4136,1 4161,0 4245,1 4251,0 4256,1 4327,0 4363,1 4388,0 4421,1 4436,0 4508,1 4577,0 4630,1 4655,0 4731,1 4805,0 4844,1 4932,0 5025,1 5064,0 5084,1 5165,0 5206,1 5273,0 5298,1 5384,0 5405,1 5449,0 5524,1 5544,0 5561,1 5643,0 5665,1 5671,0 5704,1 5734,0 5789,1 5825,0 5886,1 5951,0 6004,1 6006,0 6097,1 6190,0 6285,1 6313,0 6338,1 6367,0 6445,1 6540,0 6587,1 6659,0 6757,1 6789,0 6799,1 6810,0 6854,1 6925,0 6998,1 7088,0 7169,1 7202,0 7240,1 7302,0 7347,1 7402,0 7473,1 7489,0 7580,1 7672,0 7705,1 7738,0 7780,1 7827,0 7848,1 7883,0 7923,1 7997,0 8078,1 8103,0 8154,1 8232,0 8326,1 8426,0 8523,1 8558,0 8588,1 8651,0 8682,1 8702,0 8777,1 8816,0 8907,1 8908,0 8912,1 8927,0 9019,1 9049,0 9065,1 9102,0 9200,1 9258,0 9300,1 9382,0 9451,1 9544,0 9585,1 9590,0 9609,1 9697,0 9782,1 9879,0 9975,1 9998,0 10048,1 10050,0 10104,1 10135,0 10223,1 10309,0 10354,1 10431,0 10445,1 10532,0 10566,1 10599,0 10602,1 10603,0 10609,1 10699,0 10758,1 10839,0 10916,1 10919,0 10938,1 11017,0 11022,1 11042,0 11061,1 11124,0 11216,1 11243,0 11288,1 11347,0 11405,1 11446,0 11457,1 11502,0 11569,1 11625,0 11646,1 11741,0 11785,1 11856,0 11858,1 11909,0 11960,1 12046,0 12055,1 12112,0 12134,1 12188,0 12193,1 12277,0 12303,1 12381,0 12447,1 12453,0 12493,1 12530,0 12620,1 12680,0 12772,1 12855,0 12862,1 12959,0 12998,1 end initlist a72 0,0 29,1 128,0 140,1 194,0 224,1 241,0 295,1 360,0 444,1 458,0 503,1 514,0 526,1 605,0 619,1 695,0 715,1 751,0 767,1 847,0 876,1 900,0 924,1 958,0 1051,1 1115,0 1128,1 1175,0 1237,1 1317,0 1391,1 1467,0 1478,1 1535,0 1556,1 1651,0 1721,1 1784,0 1836,1 1881,0 1951,1 2045,0 2052,1 2096,0 2107,1 2112,0 2167,1 2242,0 2246,1 2291,0 2382,1 2459,0 2524,1 2544,0 2564,1 2596,0 2665,1 2701,0 2753,1 2776,0 2828,1 2871,0 2969,1 2983,0 3017,1 3056,0 3143,1 3172,0 3242,1 3244,0 3340,1 3383,0 3464,1 3528,0 3570,1 3594,0 3595,1 3693,0 3750,1 3824,0 3863,1 3867,0 3914,1 3996,0 4015,1 4061,0 4072,1 4171,0 4267,1 4286,0 4296,1 4351,0 4417,1 4423,0 4428,1 4432,0 4469,1 4528,0 4604,1 4626,0 4630,1 4677,0 4764,1 4774,0 4816,1 4819,0 4828,1 4873,0 4949,1 4985,0 5053,1 5071,0 5161,1 5258,0 5295,1 5329,0 5380,1 5401,0 5451,1 5490,0 5542,1 5618,0 5699,1 5796,0 5880,1 5941,0 6034,1 6128,0 6197,1 6230,0 6232,1 6329,0 6425,1 6524,0 6535,1 6591,0 6619,1 6660,0 6678,1 6749,0 6753,1 6782,0 6856,1 6943,0 6976,1 7064,0 7156,1 7208,0 7260,1 7342,0 7414,1 7434,0 7516,1 7600,0 7616,1 7680,0 7734,1 7812,0 7894,1 7942,0 8039,1 8116,0 8134,1 8172,0 8191,1 8221,0 8231,1 8293,0 8385,1 8393,0 8480,1 8546,0 8641,1 8701,0 8799,1 8805,0 8855,1 8916,0 8918,1 8980,0 9072,1 9132,0 9176,1 9263,0 9358,1 9444,0 9536,1 9622,0 9626,1 9719,0 9738,1 9793,0 9840,1 9938,0 9983,1 10031,0 10085,1 10147,0 10221,1 10314,0 10414,1 10417,0 10506,1 10605,0 10619,1 10654,0 10745,1 10807,0 10893,1 10973,0 11035,1 11124,0 11187,1 11268,0 11333,1 11420,0 11518,1 11604,0 11623,1 11676,0 11688,1 11734,0 11741,1 11810,0 11851,1 11899,0 11900,1 11986,0 12062,1 12069,0 12075,1 12127,0 12136,1 12158,0 12233,1 12268,0 12341,1 12352,0 12403,1 12485,0 12507,1 12541,0 12575,1 12636,0 12702,1 12765,0 12828,1 12898,0 12985,1 13009,0 13033,1 13116,0 13196,1 13202,0 13292,1 13330,0 13400,1 end initlist a73 0,0 63,1 126,0 183,1 196,0 212,1 227,0 266,1 324,0 422,1 505,0 599,1 650,0 692,1 731,0 753,1 767,0 768,1 855,0 943,1 1041,0 1064,1 1103,0 1114,1 1202,0 1300,1 1359,0 1430,1 1502,0 1543,1 1594,0 1654,1 1709,0 1772,1 1805,0 1888,1 1905,0 1989,1 2066,0 2118,1 2216,0 2225,1 2238,0 2239,1 2248,0 2336,1 2355,0 2366,1 2408,0 2495,1 2534,0 2580,1 2663,0 2752,1 2765,0 2771,1 2829,0 2894,1 2994,0 3057,1 3111,0 3202,1 3270,0 3305,1 3360,0 3410,1 3445,0 3467,1 3482,0 3540,1 3565,0 3655,1 3695,0 3792,1 3796,0 3895,1 3919,0 3967,1 4064,0 4075,1 4102,0 4195,1 4272,0 4310,1 4407,0 4430,1 4446,0 4534,1 4553,0 4638,1 4704,0 4717,1 4719,0 4793,1 4880,0 4920,1 4972,0 5028,1 5042,0 5115,1 5191,0 5192,1 5202,0 5294,1 5330,0 5372,1 5439,0 5500,1 5520,0 5585,1 5671,0 5704,1 5767,0 5827,1 5923,0 5982,1 6018,0 6060,1 6146,0 6164,1 6234,0 6287,1 6314,0 6378,1 6381,0 6472,1 6521,0 6620,1 6708,0 6796,1 6865,0 6891,1 6938,0 7011,1 7097,0 7190,1 7271,0 7333,1 7355,0 7409,1 7430,0 7471,1 7536,0 7597,1 7607,0 7640,1 7735,0 7775,1 7867,0 7927,1 7933,0 8029,1 8054,0 8121,1 8155,0 8169,1 8199,0 8274,1 8311,0 8390,1 8474,0 8505,1 8595,0 8695,1 8712,0 8768,1 8838,0 8842,1 8893,0 8960,1 9047,0 9058,1 9152,0 9185,1 9253,0 9296,1 9300,0 9301,1 9302,0 9397,1 9456,0 9472,1 9515,0 9562,1 9589,0 9673,1 9706,0 9707,1 9722,0 9758,1 9835,0 9914,1 9915,0 9957,1 9982,0 10007,1 10049,0 10140,1 10165,0 10175,1 10230,0 10259,1 10341,0 10398,1 10420,0 10476,1 10537,0 10619,1 10652,0 10724,1 10783,0 10831,1 10876,0 10909,1 10949,0 10970,1 11058,0 11073,1 11084,0 11159,1 11244,0 11290,1 11343,0 11390,1 11479,0 11484,1 11531,0 11541,1 11636,0 11709,1 11725,0 11726,1 11757,0 11769,1 11845,0 11875,1 11939,0 12003,1 12065,0 12160,1 12181,0 12189,1 12221,0 12282,1 12307,0 12365,1 12368,0 12448,1 12458,0 12466,1 12484,0 12580,1 12584,0 12605,1 12691,0 12777,1 12853,0 12928,1 end initlist a74 0,0 61,1 121,0 216,1 267,0 361,1 368,0 414,1 435,0 482,1 547,0 588,1 635,0 672,1 751,0 837,1 839,0 917,1 958,0 1051,1 1087,0 1123,1 1216,0 1248,1 1317,0 1340,1 1347,0 1419,1 1466,0 1484,1 1573,0 1622,1 1703,0 1712,1 1787,0 1825,1 1908,0 1954,1 2033,0 2084,1 2090,0 2184,1 2260,0 2272,1 2368,0 2407,1 2440,0 2442,1 2456,0 2495,1 2550,0 2608,1 2669,0 2745,1 2756,0 2802,1 2868,0 2911,1 2952,0 2990,1 3087,0 3151,1 3223,0 3293,1 3320,0 3328,1 3424,0 3443,1 3446,0 3524,1 3590,0 3626,1 3711,0 3766,1 3864,0 3948,1 4038,0 4068,1 4166,0 4203,1 4248,0 4347,1 4362,0 4396,1 4461,0 4540,1 4603,0 4656,1 4737,0 4751,1 4754,0 4816,1 4914,0 4985,1 5006,0 5091,1 5133,0 5219,1 5261,0 5321,1 5357,0 5420,1 5464,0 5497,1 5524,0 5606,1 5627,0 5722,1 5770,0 5813,1 5859,0 5951,1 6034,0 6094,1 6169,0 6248,1 6330,0 6334,1 6357,0 6444,1 6483,0 6512,1 6593,0 6690,1 6778,0 6818,1 6865,0 6936,1 6966,0 7029,1 7112,0 7128,1 7159,0 7181,1 7211,0 7241,1 7292,0 7305,1 7394,0 7438,1 7445,0 7473,1 7563,0 7580,1 7649,0 7735,1 7737,0 7766,1 7813,0 7854,1 7952,0 8018,1 8100,0 8118,1 8154,0 8169,1 8186,0 8246,1 8300,0 8372,1 8447,0 8468,1 8478,0 8575,1 8612,0 8681,1 8744,0 8770,1 8852,0 8865,1 8962,0 9055,1 9114,0 9147,1 9192,0 9226,1 9270,0 9334,1 9385,0 9457,1 9537,0 9580,1 9674,0 9701,1 9731,0 9826,1 9848,0 9904,1 9946,0 9947,1 9959,0 10034,1 10072,0 10089,1 10133,0 10203,1 10302,0 10391,1 10452,0 10549,1 10575,0 10580,1 10624,0 10634,1 10653,0 10725,1 10730,0 10758,1 10781,0 10811,1 10828,0 10859,1 10952,0 10959,1 11057,0 11136,1 11213,0 11264,1 11345,0 11369,1 11441,0 11463,1 11508,0 11585,1 11599,0 11685,1 11717,0 11785,1 11787,0 11868,1 11909,0 11918,1 11920,0 11989,1 12073,0 12162,1 12213,0 12246,1 12319,0 12367,1 12405,0 12422,1 12519,0 12594,1 12681,0 12734,1 12768,0 12807,1 12882,0 12893,1 12962,0 13058,1 13153,0 13186,1 13206,0 13293,1 13377,0 13474,1 end initlist a75 0,0 89,1 168,0 193,1 229,0 260,1 296,0 391,1 425,0 462,1 470,0 492,1 562,0 570,1 648,0 658,1 727,0 748,1 790,0 866,1 914,0 959,1 1052,0 1113,1 1146,0 1206,1 1292,0 1357,1 1438,0 1503,1 1528,0 1543,1 1628,0 1660,1 1717,0 1768,1 1844,0 1867,1 1893,0 1958,1 1996,0 1998,1 2066,0 2083,1 2107,0 2136,1 2155,0 2254,1 2324,0 2420,1 2517,0 2612,1 2643,0 2682,1 2717,0 2782,1 2862,0 2943,1 2971,0 3039,1 3120,0 3185,1 3237,0 3305,1 3347,0 3397,1 3493,0 3573,1 3599,0 3636,1 3710,0 3780,1 3862,0 3883,1 3948,0 4031,1 4078,0 4101,1 4140,0 4211,1 4257,0 4276,1 4365,0 4403,1 4498,0 4568,1 4598,0 4660,1 4689,0 4708,1 4804,0 4846,1 4922,0 4927,1 5020,0 5069,1 5159,0 5226,1 5255,0 5264,1 5320,0 5339,1 5379,0 5431,1 5475,0 5523,1 5568,0 5602,1 5647,0 5672,1 5701,0 5754,1 5833,0 5838,1 5896,0 5973,1 6026,0 6103,1 6161,0 6169,1 6218,0 6280,1 6339,0 6426,1 6469,0 6556,1 6560,0 6624,1 6723,0 6770,1 6773,0 6780,1 6830,0 6872,1 6950,0 6990,1 7089,0 7161,1 7257,0 7331,1 7347,0 7444,1 7477,0 7478,1 7568,0 7647,1 7676,0 7693,1 7756,0 7809,1 7888,0 7901,1 7922,0 7940,1 8007,0 8027,1 8044,0 8137,1 8156,0 8180,1 8182,0 8273,1 8336,0 8386,1 8428,0 8484,1 8495,0 8507,1 8599,0 8643,1 8658,0 8660,1 8688,0 8758,1 8849,0 8900,1 8943,0 9030,1 9091,0 9115,1 9165,0 9256,1 9341,0 9348,1 9381,0 9443,1 9513,0 9539,1 9619,0 9635,1 9682,0 9733,1 9779,0 9851,1 9865,0 9935,1 10022,0 10056,1 10063,0 10131,1 10148,0 10203,1 10223,0 10240,1 10311,0 10408,1 10447,0 10538,1 10552,0 10625,1 10707,0 10806,1 10882,0 10921,1 10991,0 11030,1 11032,0 11091,1 11167,0 11215,1 11270,0 11317,1 11365,0 11397,1 11435,0 11497,1 11506,0 11557,1 11650,0 11709,1 11719,0 11790,1 11839,0 11858,1 11888,0 11896,1 11956,0 12022,1 12055,0 12069,1 12143,0 12211,1 12291,0 12306,1 12315,0 12355,1 12432,0 12498,1 12578,0 12597,1 12623,0 12701,1 12762,0 12788,1 12846,0 12922,1 12959,0 12963,1 end initlist a76 0,0 93,1 125,0 211,1 231,0 305,1 401,0 487,1 500,0 596,1 655,0 665,1 688,0 717,1 807,0 855,1 905,0 985,1 988,0 1026,1 1111,0 1189,1 1269,0 1361,1 1389,0 1420,1 1507,0 1596,1 1642,0 1736,1 1756,0 1790,1 1855,0 1937,1 2015,0 2061,1 2107,0 2149,1 2197,0 2238,1 2248,0 2347,1 2362,0 2424,1 2472,0 2558,1 2576,0 2659,1 2675,0 2751,1 2757,0 2851,1 2899,0 2927,1 2948,0 2995,1 3008,0 3015,1 3065,0 3090,1 3115,0 3126,1 3160,0 3238,1 3282,0 3287,1 3331,0 3397,1 3436,0 3475,1 3559,0 3598,1 3680,0 3770,1 3849,0 3929,1 3981,0 4005,1 4103,0 4193,1 4217,0 4267,1 4345,0 4357,1 4389,0 4433,1 4464,0 4551,1 4624,0 4697,1 4715,0 4809,1 4838,0 4870,1 4954,0 5043,1 5103,0 5169,1 5171,0 5257,1 5315,0 5320,1 5329,0 5407,1 5496,0 5511,1 5582,0 5682,1 5710,0 5718,1 5807,0 5906,1 5954,0 5997,1 6046,0 6143,1 6238,0 6300,1 6394,0 6403,1 6457,0 6521,1 6602,0 6669,1 6733,0 6767,1 6847,0 6869,1 6953,0 7039,1 7114,0 7163,1 7261,0 7295,1 7368,0 7448,1 7484,0 7547,1 7555,0 7604,1 7612,0 7695,1 7774,0 7860,1 7959,0 7977,1 8014,0 8051,1 8147,0 8172,1 8185,0 8209,1 8302,0 8390,1 8465,0 8533,1 8552,0 8563,1 8657,0 8673,1 8735,0 8786,1 8812,0 8848,1 8860,0 8930,1 8971,0 8980,1 9000,0 9008,1 9060,0 9076,1 9161,0 9195,1 9233,0 9245,1 9309,0 9380,1 9411,0 9423,1 9440,0 9481,1 9557,0 9646,1 9738,0 9742,1 9828,0 9886,1 9962,0 10047,1 10108,0 10199,1 10284,0 10329,1 10384,0 10400,1 10440,0 10539,1 10609,0 10702,1 10749,0 10830,1 10912,0 11010,1 11058,0 11064,1 11164,0 11199,1 11208,0 11245,1 11254,0 11313,1 11408,0 11481,1 11543,0 11621,1 11690,0 11745,1 11844,0 11859,1 11931,0 12030,1 12069,0 12103,1 12140,0 12234,1 12284,0 12362,1 12437,0 12529,1 12580,0 12673,1 12707,0 12726,1 12751,0 12839,1 12902,0 12943,1 12951,0 12987,1 13087,0 13127,1 13169,0 13199,1 13244,0 13248,1 13279,0 13298,1 13344,0 13444,1 13475,0 13559,1 13591,0 13647,1 13719,0 13746,1 13843,0 13928,1 end initlist a77 0,0 51,1 136,0 169,1 225,0 287,1 373,0 453,1 512,0 531,1 578,0 662,1 736,0 834,1 847,0 936,1 979,0 997,1 1096,0 1184,1 1212,0 1264,1 1344,0 1347,1 1365,0 1389,1 1429,0 1477,1 1520,0 1615,1 1688,0 1715,1 1721,0 1779,1 1874,0 1942,1 1974,0 2061,1 2161,0 2194,1 2196,0 2230,1 2244,0 2248,1 2299,0 2351,1 2450,0 2463,1 2500,0 2566,1 2636,0 2698,1 2722,0 2748,1 2765,0 2835,1 2850,0 2870,1 2876,0 2909,1 3006,0 3051,1 3110,0 3206,1 3259,0 3321,1 3338,0 3420,1 3518,0 3566,1 3616,0 3624,1 3645,0 3663,1 3762,0 3789,1 3794,0 3866,1 3899,0 3965,1 3998,0 4086,1 4119,0 4169,1 4216,0 4250,1 4313,0 4407,1 4488,0 4572,1 4656,0 4671,1 4732,0 4757,1 4769,0 4772,1 4834,0 4856,1 4890,0 4978,1 4998,0 5092,1 5130,0 5148,1 5197,0 5211,1 5228,0 5327,1 5376,0 5415,1 5479,0 5560,1 5655,0 5753,1 5773,0 5856,1 5860,0 5948,1 6043,0 6077,1 6145,0 6166,1 6220,0 6236,1 6311,0 6367,1 6370,0 6410,1 6420,0 6466,1 6515,0 6582,1 6593,0 6602,1 6650,0 6700,1 6793,0 6880,1 6887,0 6934,1 6970,0 7061,1 7077,0 7158,1 7228,0 7299,1 7307,0 7371,1 7424,0 7430,1 7458,0 7494,1 7516,0 7556,1 7627,0 7692,1 7754,0 7852,1 7888,0 7927,1 7962,0 8005,1 8011,0 8079,1 8113,0 8194,1 8198,0 8243,1 8287,0 8318,1 8401,0 8476,1 8505,0 8582,1 8648,0 8691,1 8756,0 8842,1 8860,0 8925,1 9007,0 9091,1 9183,0 9218,1 9233,0 9239,1 9278,0 9371,1 9418,0 9473,1 9559,0 9626,1 9656,0 9718,1 9760,0 9774,1 9790,0 9875,1 9903,0 9942,1 9953,0 10043,1 10120,0 10194,1 10232,0 10272,1 10274,0 10305,1 10319,0 10418,1 10492,0 10536,1 10547,0 10551,1 10591,0 10628,1 10675,0 10717,1 10802,0 10870,1 10947,0 10985,1 11009,0 11019,1 11076,0 11085,1 11184,0 11230,1 11235,0 11261,1 11318,0 11417,1 11456,0 11500,1 11515,0 11606,1 11675,0 11744,1 11825,0 11872,1 11874,0 11969,1 12016,0 12056,1 12128,0 12155,1 12186,0 12215,1 12265,0 12288,1 12384,0 12395,1 12460,0 12489,1 12580,0 12678,1 12705,0 12753,1 end initlist a78 0,0 71,1 145,0 182,1 278,0 340,1 355,0 419,1 446,0 527,1 534,0 578,1 661,0 734,1 774,0 846,1 916,0 969,1 1049,0 1071,1 1096,0 1146,1 1213,0 1266,1 1277,0 1351,1 1397,0 1431,1 1522,0 1579,1 1599,0 1606,1 1686,0 1707,1 1776,0 1824,1 1921,0 1943,1 2043,0 2093,1 2188,0 2206,1 2280,0 2305,1 2393,0 2405,1 2443,0 2530,1 2531,0 2588,1 2660,0 2683,1 2688,0 2787,1 2880,0 2928,1 3019,0 3063,1 3101,0 3102,1 3186,0 3216,1 3297,0 3394,1 3408,0 3430,1 3478,0 3573,1 3645,0 3651,1 3687,0 3744,1 3778,0 3788,1 3851,0 3864,1 3918,0 3931,1 3979,0 4062,1 4104,0 4119,1 4125,0 4182,1 4246,0 4278,1 4309,0 4335,1 4380,0 4457,1 4523,0 4565,1 4590,0 4643,1 4692,0 4712,1 4812,0 4881,1 4901,0 4922,1 4925,0 4934,1 4964,0 5056,1 5075,0 5083,1 5155,0 5207,1 5287,0 5300,1 5360,0 5427,1 5433,0 5454,1 5494,0 5505,1 5543,0 5597,1 5606,0 5618,1 5638,0 5716,1 5791,0 5797,1 5851,0 5893,1 5942,0 6038,1 6107,0 6131,1 6148,0 6176,1 6196,0 6287,1 6307,0 6406,1 6413,0 6451,1 6493,0 6502,1 6572,0 6650,1 6685,0 6702,1 6775,0 6874,1 6972,0 7069,1 7155,0 7217,1 7281,0 7342,1 7390,0 7465,1 7534,0 7544,1 7591,0 7616,1 7649,0 7671,1 7700,0 7722,1 7795,0 7796,1 7865,0 7938,1 8024,0 8046,1 8132,0 8177,1 8211,0 8264,1 8357,0 8380,1 8469,0 8489,1 8572,0 8573,1 8621,0 8666,1 8726,0 8784,1 8857,0 8920,1 8971,0 9054,1 9143,0 9223,1 9257,0 9271,1 9283,0 9320,1 9387,0 9396,1 9406,0 9436,1 9440,0 9477,1 9490,0 9506,1 9560,0 9584,1 9601,0 9616,1 9686,0 9692,1 9755,0 9764,1 9828,0 9872,1 9967,0 9983,1 10000,0 10002,1 10059,0 10065,1 10159,0 10227,1 10245,0 10327,1 10383,0 10456,1 10515,0 10607,1 10615,0 10670,1 10732,0 10825,1 10856,0 10937,1 10998,0 11020,1 11082,0 11171,1 11184,0 11232,1 11260,0 11295,1 11385,0 11434,1 11469,0 11522,1 11577,0 11586,1 11605,0 11638,1 11666,0 11712,1 11745,0 11821,1 11901,0 11983,1 12023,0 12053,1 12119,0 12129,1 12208,0 12292,1 end initlist a79 0,0 96,1 122,0 188,1 273,0 353,1 446,0 519,1 547,0 602,1 666,0 752,1 796,0 840,1 851,0 897,1 947,0 989,1 1064,0 1129,1 1157,0 1255,1 1289,0 1293,1 1370,0 1438,1 1448,0 1455,1 1538,0 1629,1 1676,0 1713,1 1800,0 1889,1 1950,0 2015,1 2033,0 2075,1 2169,0 2268,1 2357,0 2456,1 2530,0 2546,1 2634,0 2730,1 2830,0 2926,1 2972,0 3006,1 3030,0 3046,1 3088,0 3116,1 3174,0 3185,1 3250,0 3310,1 3362,0 3454,1 3496,0 3530,1 3567,0 3659,1 3704,0 3797,1 3855,0 3910,1 3977,0 3992,1 4026,0 4074,1 4135,0 4190,1 4191,0 4216,1 4218,0 4254,1 4326,0 4408,1 4478,0 4538,1 4588,0 4646,1 4715,0 4764,1 4799,0 4852,1 4925,0 4992,1 5031,0 5041,1 5112,0 5135,1 5187,0 5282,1 5327,0 5377,1 5461,0 5497,1 5505,0 5549,1 5640,0 5687,1 5771,0 5840,1 5843,0 5864,1 5946,0 5963,1 5964,0 6002,1 6017,0 6072,1 6105,0 6157,1 6254,0 6271,1 6284,0 6333,1 6379,0 6447,1 6515,0 6537,1 6604,0 6628,1 6664,0 6694,1 6695,0 6705,1 6714,0 6807,1 6897,0 6986,1 7040,0 7119,1 7170,0 7190,1 7252,0 7342,1 7372,0 7430,1 7471,0 7564,1 7579,0 7624,1 7702,0 7720,1 7798,0 7838,1 7876,0 7881,1 7908,0 7988,1 8010,0 8063,1 8101,0 8154,1 8210,0 8276,1 8335,0 8419,1 8455,0 8525,1 8593,0 8653,1 8720,0 8814,1 8855,0 8929,1 9018,0 9086,1 9105,0 9175,1 9205,0 9227,1 9260,0 9354,1 9367,0 9381,1 9472,0 9513,1 9531,0 9606,1 9614,0 9621,1 9642,0 9650,1 9664,0 9685,1 9712,0 9717,1 9746,0 9755,1 9802,0 9861,1 9910,0 9922,1 10011,0 10043,1 10086,0 10133,1 10221,0 10238,1 10262,0 10302,1 10400,0 10417,1 10510,0 10595,1 10631,0 10680,1 10705,0 10798,1 10854,0 10923,1 11010,0 11046,1 11112,0 11157,1 11215,0 11295,1 11350,0 11355,1 11433,0 11483,1 11575,0 11628,1 11712,0 11750,1 11802,0 11829,1 11841,0 11876,1 11918,0 12013,1 12083,0 12119,1 12128,0 12183,1 12193,0 12257,1 12273,0 12354,1 12406,0 12490,1 12574,0 12624,1 12708,0 12710,1 12730,0 12765,1 12788,0 12885,1 12937,0 13024,1 13083,0 13183,1 end initlist a80 0,0 86,1 90,0 159,1 182,0 221,1 236,0 253,1 296,0 353,1 393,0 444,1 527,0 536,1 619,0 691,1 699,0 738,1 797,0 816,1 883,0 939,1 1019,0 1099,1 1102,0 1190,1 1280,0 1366,1 1399,0 1473,1 1494,0 1505,1 1536,0 1594,1 1652,0 1658,1 1746,0 1801,1 1824,0 1843,1 1925,0 1949,1 1981,0 2044,1 2085,0 2101,1 2192,0 2210,1 2283,0 2307,1 2356,0 2385,1 2411,0 2467,1 2527,0 2532,1 2620,0 2639,1 2713,0 2757,1 2807,0 2830,1 2831,0 2907,1 2952,0 3043,1 3129,0 3190,1 3197,0 3225,1 3300,0 3337,1 3407,0 3451,1 3533,0 3540,1 3603,0 3606,1 3624,0 3688,1 3738,0 3802,1 3902,0 3951,1 3984,0 4037,1 4044,0 4087,1 4173,0 4188,1 4269,0 4359,1 4379,0 4458,1 4546,0 4646,1 4707,0 4738,1 4831,0 4912,1 4919,0 5009,1 5070,0 5128,1 5228,0 5296,1 5394,0 5399,1 5460,0 5492,1 5530,0 5566,1 5575,0 5622,1 5715,0 5810,1 5835,0 5910,1 5949,0 6046,1 6065,0 6134,1 6230,0 6264,1 6330,0 6424,1 6477,0 6527,1 6536,0 6620,1 6650,0 6667,1 6705,0 6802,1 6833,0 6852,1 6861,0 6864,1 6934,0 7026,1 7067,0 7146,1 7222,0 7260,1 7312,0 7313,1 7350,0 7405,1 7471,0 7503,1 7590,0 7657,1 7706,0 7800,1 7823,0 7841,1 7843,0 7857,1 7937,0 7945,1 8016,0 8091,1 8166,0 8264,1 8298,0 8324,1 8383,0 8421,1 8437,0 8465,1 8501,0 8518,1 8573,0 8580,1 8588,0 8619,1 8666,0 8689,1 8732,0 8813,1 8844,0 8899,1 8913,0 9003,1 9011,0 9107,1 9108,0 9183,1 9189,0 9252,1 9328,0 9419,1 9432,0 9530,1 9550,0 9567,1 9606,0 9618,1 9638,0 9664,1 9721,0 9800,1 9873,0 9889,1 9903,0 9937,1 10028,0 10082,1 10162,0 10188,1 10231,0 10253,1 10327,0 10416,1 10492,0 10576,1 10643,0 10675,1 10752,0 10829,1 10922,0 10981,1 11013,0 11051,1 11123,0 11153,1 11183,0 11248,1 11275,0 11338,1 11380,0 11414,1 11512,0 11560,1 11621,0 11625,1 11648,0 11696,1 11774,0 11823,1 11903,0 11969,1 12062,0 12092,1 12111,0 12206,1 12278,0 12341,1 12426,0 12433,1 12512,0 12538,1 12557,0 12648,1 12649,0 12680,1 12713,0 12752,1 end initlist a81 0,0 6,1 79,0 159,1 168,0 241,1 332,0 371,1 411,0 482,1 510,0 588,1 604,0 661,1 690,0 759,1 760,0 775,1 874,0 911,1 919,0 959,1 1018,0 1114,1 1178,0 1213,1 1256,0 1343,1 1363,0 1386,1 1463,0 1519,1 1562,0 1578,1 1588,0 1656,1 1692,0 1716,1 1790,0 1880,1 1938,0 1974,1 2020,0 2102,1 2142,0 2224,1 2271,0 2350,1 2370,0 2399,1 2482,0 2526,1 2534,0 2588,1 2592,0 2673,1 2684,0 2780,1 2872,0 2954,1 3006,0 3065,1 3092,0 3097,1 3178,0 3219,1 3305,0 3390,1 3442,0 3461,1 3525,0 3578,1 3615,0 3654,1 3720,0 3745,1 3752,0 3781,1 3799,0 3895,1 3896,0 3913,1 3958,0 4042,1 4089,0 4144,1 4170,0 4242,1 4282,0 4292,1 4293,0 4300,1 4333,0 4420,1 4480,0 4498,1 4520,0 4595,1 4602,0 4690,1 4729,0 4756,1 4801,0 4864,1 4865,0 4944,1 4954,0 5033,1 5119,0 5152,1 5186,0 5261,1 5312,0 5396,1 5479,0 5513,1 5594,0 5674,1 5676,0 5720,1 5800,0 5896,1 5921,0 5978,1 5986,0 6085,1 6178,0 6251,1 6338,0 6385,1 6425,0 6507,1 6535,0 6540,1 6620,0 6659,1 6745,0 6812,1 6850,0 6912,1 6935,0 6993,1 7023,0 7097,1 7159,0 7208,1 7301,0 7392,1 7458,0 7500,1 7532,0 7571,1 7617,0 7682,1 7782,0 7862,1 7869,0 7922,1 7990,0 8002,1 8020,0 8023,1 8049,0 8073,1 8149,0 8164,1 8193,0 8289,1 8361,0 8450,1 8547,0 8564,1 8640,0 8694,1 8744,0 8812,1 8870,0 8894,1 8900,0 8991,1 9048,0 9136,1 9197,0 9271,1 9293,0 9336,1 9378,0 9463,1 9465,0 9505,1 9561,0 9607,1 9656,0 9753,1 9761,0 9824,1 9879,0 9934,1 9988,0 10055,1 10137,0 10236,1 10264,0 10317,1 10366,0 10404,1 10465,0 10539,1 10594,0 10633,1 10685,0 10784,1 10852,0 10875,1 10898,0 10988,1 11025,0 11076,1 11113,0 11150,1 11229,0 11326,1 11368,0 11394,1 11424,0 11477,1 11483,0 11579,1 11618,0 11680,1 11737,0 11819,1 11914,0 12007,1 12010,0 12023,1 12098,0 12155,1 12220,0 12279,1 12288,0 12333,1 12352,0 12385,1 12427,0 12433,1 12472,0 12550,1 12632,0 12705,1 12780,0 12874,1 12961,0 13000,1 13031,0 13122,1 13179,0 13210,1 end initlist a82 0,0 97,1 170,0 192,1 230,0 237,1 295,0 322,1 418,0 438,1 528,0 616,1 706,0 765,1 831,0 917,1 979,0 999,1 1062,0 1133,1 1139,0 1174,1 1221,0 1229,1 1315,0 1387,1 1424,0 1426,1 1460,0 1485,1 1569,0 1610,1 1670,0 1729,1 1737,0 1747,1 1783,0 1881,1 1935,0 1954,1 1988,0 2004,1 2085,0 2129,1 2153,0 2252,1 2260,0 2266,1 2277,0 2340,1 2385,0 2421,1 2466,0 2478,1 2545,0 2621,1 2703,0 2747,1 2786,0 2855,1 2951,0 2983,1 3030,0 3125,1 3213,0 3220,1 3254,0 3311,1 3386,0 3390,1 3415,0 3510,1 3537,0 3591,1 3676,0 3718,1 3783,0 3788,1 3881,0 3903,1 3988,0 4018,1 4042,0 4141,1 4229,0 4262,1 4319,0 4401,1 4446,0 4506,1 4528,0 4584,1 4609,0 4643,1 4717,0 4781,1 4867,0 4963,1 5042,0 5124,1 5139,0 5200,1 5246,0 5281,1 5343,0 5366,1 5403,0 5482,1 5512,0 5587,1 5603,0 5671,1 5678,0 5734,1 5806,0 5902,1 5925,0 5993,1 6048,0 6086,1 6116,0 6168,1 6231,0 6317,1 6384,0 6484,1 6545,0 6602,1 6674,0 6693,1 6769,0 6780,1 6840,0 6875,1 6914,0 6923,1 7007,0 7013,1 7103,0 7120,1 7190,0 7222,1 7291,0 7331,1 7360,0 7381,1 7386,0 7393,1 7483,0 7536,1 7551,0 7577,1 7662,0 7670,1 7754,0 7838,1 7851,0 7899,1 7995,0 8029,1 8126,0 8198,1 8293,0 8309,1 8332,0 8365,1 8431,0 8460,1 8530,0 8592,1 8621,0 8701,1 8781,0 8872,1 8907,0 8955,1 8972,0 9003,1 9027,0 9039,1 9042,0 9055,1 9058,0 9060,1 9141,0 9151,1 9237,0 9336,1 9357,0 9414,1 9470,0 9562,1 9601,0 9611,1 9621,0 9695,1 9709,0 9808,1 9832,0 9891,1 9914,0 10001,1 10040,0 10095,1 10123,0 10177,1 10269,0 10271,1 10340,0 10369,1 10405,0 10429,1 10443,0 10529,1 10543,0 10632,1 10720,0 10785,1 10858,0 10906,1 10989,0 11017,1 11060,0 11066,1 11130,0 11198,1 11285,0 11301,1 11398,0 11435,1 11441,0 11491,1 11534,0 11613,1 11710,0 11750,1 11830,0 11849,1 11948,0 12015,1 12048,0 12132,1 12141,0 12158,1 12228,0 12248,1 12328,0 12330,1 12386,0 12468,1 12486,0 12508,1 12515,0 12604,1 12624,0 12694,1 12698,0 12786,1 end initlist a83 0,0 13,1 25,0 87,1 121,0 191,1 219,0 245,1 324,0 345,1 428,0 477,1 508,0 605,1 658,0 706,1 715,0 811,1 833,0 855,1 929,0 945,1 1017,0 1054,1 1084,0 1101,1 1124,0 1172,1 1232,0 1330,1 1420,0 1504,1 1593,0 1629,1 1657,0 1729,1 1740,0 1808,1 1814,0 1849,1 1874,0 1924,1 1991,0 2016,1 2047,0 2131,1 2207,0 2293,1 2357,0 2453,1 2475,0 2493,1 2579,0 2623,1 2624,0 2644,1 2702,0 2794,1 2859,0 2913,1 2962,0 2978,1 3057,0 3139,1 3197,0 3247,1 3279,0 3307,1 3367,0 3449,1 3503,0 3599,1 3678,0 3748,1 3843,0 3885,1 3942,0 3961,1 4010,0 4032,1 4112,0 4201,1 4213,0 4260,1 4305,0 4360,1 4374,0 4380,1 4465,0 4539,1 4639,0 4698,1 4718,0 4785,1 4790,0 4821,1 4907,0 5005,1 5073,0 5170,1 5192,0 5215,1 5303,0 5375,1 5443,0 5518,1 5537,0 5555,1 5598,0 5686,1 5732,0 5830,1 5905,0 6005,1 6073,0 6149,1 6178,0 6234,1 6277,0 6367,1 6420,0 6455,1 6465,0 6558,1 6643,0 6669,1 6709,0 6759,1 6769,0 6779,1 6852,0 6920,1 6968,0 7009,1 7027,0 7091,1 7179,0 7262,1 7321,0 7359,1 7425,0 7522,1 7524,0 7548,1 7637,0 7678,1 7744,0 7769,1 7825,0 7880,1 7889,0 7976,1 8033,0 8040,1 8065,0 8105,1 8175,0 8199,1 8260,0 8290,1 8302,0 8362,1 8436,0 8507,1 8603,0 8690,1 8706,0 8787,1 8825,0 8894,1 8971,0 8980,1 9074,0 9115,1 9192,0 9257,1 9266,0 9352,1 9368,0 9417,1 9509,0 9527,1 9561,0 9629,1 9657,0 9704,1 9712,0 9718,1 9720,0 9733,1 9786,0 9819,1 9847,0 9918,1 9934,0 9951,1 9969,0 10067,1 10112,0 10151,1 10158,0 10227,1 10268,0 10317,1 10393,0 10481,1 10540,0 10605,1 10617,0 10635,1 10691,0 10740,1 10816,0 10898,1 10946,0 10979,1 10981,0 11066,1 11127,0 11174,1 11249,0 11340,1 11405,0 11462,1 11558,0 11576,1 11655,0 11663,1 11740,0 11766,1 11773,0 11812,1 11902,0 11995,1 12029,0 12092,1 12135,0 12174,1 12211,0 12273,1 12276,0 12285,1 12332,0 12422,1 12518,0 12549,1 12587,0 12686,1 12723,0 12743,1 12746,0 12843,1 12878,0 12887,1 12951,0 12963,1 12995,0 13091,1 end initlist a84 0,0 23,1 87,0 145,1 238,0 285,1 349,0 415,1 427,0 491,1 533,0 577,1 589,0 590,1 633,0 701,1 779,0 811,1 864,0 952,1 971,0 1051,1 1079,0 1094,1 1098,0 1167,1 1224,0 1268,1 1308,0 1358,1 1419,0 1459,1 1538,0 1555,1 1579,0 1588,1 1677,0 1755,1 1810,0 1906,1 1960,0 1972,1 2023,0 2116,1 2213,0 2238,1 2313,0 2333,1 2405,0 2505,1 2596,0 2686,1 2766,0 2780,1 2838,0 2936,1 3006,0 3085,1 3175,0 3234,1 3266,0 3326,1 3394,0 3435,1 3478,0 3482,1 3538,0 3610,1 3706,0 3779,1 3790,0 3874,1 3944,0 4029,1 4075,0 4130,1 4158,0 4224,1 4317,0 4383,1 4421,0 4432,1 4452,0 4464,1 4525,0 4533,1 4620,0 4685,1 4729,0 4754,1 4827,0 4925,1 4944,0 4980,1 4997,0 5046,1 5134,0 5180,1 5231,0 5278,1 5338,0 5400,1 5467,0 5530,1 5544,0 5549,1 5618,0 5657,1 5695,0 5750,1 5804,0 5862,1 5870,0 5896,1 5904,0 5959,1 6010,0 6071,1 6126,0 6222,1 6228,0 6262,1 6315,0 6331,1 6354,0 6439,1 6478,0 6536,1 6546,0 6550,1 6572,0 6620,1 6695,0 6697,1 6791,0 6832,1 6922,0 7022,1 7103,0 7136,1 7161,0 7260,1 7311,0 7385,1 7461,0 7559,1 7570,0 7631,1 7669,0 7767,1 7842,0 7896,1 7934,0 7983,1 8047,0 8112,1 8116,0 8119,1 8218,0 8297,1 8382,0 8481,1 8559,0 8648,1 8685,0 8742,1 8817,0 8887,1 8903,0 8946,1 9019,0 9062,1 9160,0 9233,1 9328,0 9406,1 9499,0 9571,1 9670,0 9676,1 9735,0 9835,1 9905,0 10004,1 10016,0 10094,1 10139,0 10210,1 10220,0 10306,1 10312,0 10398,1 10496,0 10510,1 10533,0 10592,1 10679,0 10725,1 10735,0 10818,1 10871,0 10946,1 10957,0 11034,1 11076,0 11104,1 11154,0 11166,1 11216,0 11252,1 11280,0 11296,1 11365,0 11391,1 11444,0 11448,1 11522,0 11593,1 11615,0 11709,1 11782,0 11787,1 11862,0 11875,1 11956,0 12020,1 12030,0 12064,1 12103,0 12201,1 12291,0 12331,1 12378,0 12467,1 12522,0 12555,1 12613,0 12702,1 12748,0 12812,1 12891,0 12980,1 12982,0 13022,1 13038,0 13113,1 13126,0 13134,1 13197,0 13254,1 13344,0 13440,1 13539,0 13618,1 13627,0 13690,1 13693,0 13708,1 end initlist a85 0,0 31,1 106,0 202,1 287,0 291,1 345,0 388,1 485,0 508,1 534,0 552,1 615,0 650,1 722,0 766,1 833,0 921,1 952,0 982,1 1019,0 1068,1 1133,0 1156,1 1169,0 1220,1 1221,0 1233,1 1330,0 1369,1 1430,0 1492,1 1570,0 1629,1 1693,0 1731,1 1784,0 1796,1 1820,0 1833,1 1884,0 1908,1 1934,0 1937,1 1980,0 2015,1 2017,0 2068,1 2133,0 2152,1 2248,0 2261,1 2343,0 2348,1 2378,0 2438,1 2535,0 2606,1 2674,0 2761,1 2806,0 2887,1 2914,0 2946,1 2984,0 3010,1 3029,0 3045,1 3074,0 3130,1 3175,0 3218,1 3273,0 3305,1 3343,0 3398,1 3418,0 3426,1 3488,0 3531,1 3566,0 3605,1 3659,0 3713,1 3753,0 3809,1 3858,0 3941,1 3944,0 4017,1 4053,0 4092,1 4181,0 4234,1 4322,0 4336,1 4400,0 4456,1 4512,0 4519,1 4560,0 4593,1 4617,0 4667,1 4693,0 4726,1 4806,0 4811,1 4901,0 4931,1 5021,0 5039,1 5118,0 5165,1 5213,0 5245,1 5266,0 5356,1 5431,0 5525,1 5610,0 5667,1 5671,0 5672,1 5720,0 5729,1 5735,0 5776,1 5831,0 5856,1 5885,0 5961,1 6060,0 6061,1 6137,0 6186,1 6232,0 6242,1 6252,0 6273,1 6346,0 6443,1 6520,0 6549,1 6553,0 6637,1 6722,0 6778,1 6800,0 6850,1 6943,0 7004,1 7011,0 7074,1 7147,0 7203,1 7235,0 7263,1 7323,0 7405,1 7475,0 7565,1 7576,0 7580,1 7668,0 7731,1 7759,0 7811,1 7879,0 7890,1 7951,0 7983,1 7998,0 8015,1 8082,0 8096,1 8184,0 8197,1 8213,0 8297,1 8373,0 8439,1 8516,0 8552,1 8610,0 8659,1 8677,0 8740,1 8815,0 8840,1 8867,0 8872,1 8961,0 8993,1 9052,0 9068,1 9104,0 9170,1 9267,0 9286,1 9290,0 9329,1 9338,0 9405,1 9429,0 9474,1 9564,0 9565,1 9566,0 9610,1 9660,0 9741,1 9828,0 9869,1 9911,0 9978,1 10070,0 10086,1 10118,0 10145,1 10165,0 10182,1 10206,0 10249,1 10305,0 10378,1 10394,0 10473,1 10560,0 10645,1 10727,0 10759,1 10836,0 10872,1 10923,0 11001,1 11068,0 11071,1 11141,0 11181,1 11213,0 11264,1 11272,0 11337,1 11349,0 11392,1 11434,0 11479,1 11512,0 11565,1 11660,0 11736,1 11745,0 11756,1 11810,0 11816,1 11875,0 11887,1 end initlist a86 0,0 99,1 100,0 140,1 172,0 193,1 230,0 280,1 369,0 401,1 473,0 482,1 517,0 589,1 612,0 697,1 734,0 739,1 816,0 838,1 877,0 934,1 978,0 989,1 1014,0 1031,1 1107,0 1130,1 1173,0 1178,1 1189,0 1278,1 1304,0 1329,1 1427,0 1431,1 1463,0 1538,1 1634,0 1652,1 1675,0 1739,1 1763,0 1785,1 1838,0 1856,1 1875,0 1942,1 2033,0 2117,1 2165,0 2176,1 2208,0 2231,1 2238,0 2292,1 2369,0 2370,1 2416,0 2438,1 2481,0 2537,1 2586,0 2623,1 2718,0 2738,1 2803,0 2824,1 2856,0 2927,1 2938,0 3017,1 3042,0 3141,1 3153,0 3171,1 3195,0 3236,1 3334,0 3381,1 3468,0 3530,1 3623,0 3712,1 3765,0 3820,1 3835,0 3849,1 3941,0 4029,1 4048,0 4089,1 4138,0 4173,1 4241,0 4311,1 4404,0 4472,1 4477,0 4571,1 4656,0 4719,1 4776,0 4840,1 4884,0 4984,1 5002,0 5073,1 5111,0 5127,1 5208,0 5229,1 5310,0 5353,1 5444,0 5462,1 5509,0 5522,1 5523,0 5583,1 5638,0 5651,1 5661,0 5749,1 5798,0 5886,1 5890,0 5932,1 6032,0 6076,1 6152,0 6242,1 6299,0 6364,1 6454,0 6510,1 6544,0 6603,1 6663,0 6710,1 6729,0 6753,1 6816,0 6844,1 6897,0 6935,1 6939,0 6976,1 6989,0 7050,1 7108,0 7193,1 7262,0 7312,1 7324,0 7412,1 7481,0 7580,1 7593,0 7681,1 7761,0 7846,1 7939,0 7988,1 7996,0 8096,1 8158,0 8216,1 8281,0 8298,1 8385,0 8417,1 8439,0 8528,1 8602,0 8683,1 8717,0 8761,1 8834,0 8858,1 8900,0 8969,1 9051,0 9142,1 9234,0 9303,1 9312,0 9347,1 9441,0 9453,1 9521,0 9573,1 9658,0 9701,1 9734,0 9798,1 9800,0 9814,1 9822,0 9875,1 9955,0 9983,1 9986,0 10057,1 10124,0 10179,1 10189,0 10248,1 10339,0 10379,1 10436,0 10483,1 10495,0 10498,1 10507,0 10603,1 10615,0 10688,1 10715,0 10809,1 10840,0 10855,1 10897,0 10991,1 11009,0 11091,1 11107,0 11178,1 11271,0 11284,1 11332,0 11344,1 11361,0 11390,1 11453,0 11543,1 11607,0 11642,1 11740,0 11837,1 11930,0 11969,1 12022,0 12085,1 12157,0 12220,1 12315,0 12320,1 12363,0 12420,1 12496,0 12502,1 12600,0 12626,1 12687,0 12727,1 12752,0 12806,1 end initlist a87 0,0 79,1 83,0 112,1 169,0 222,1 321,0 402,1 452,0 540,1 585,0 657,1 752,0 789,1 829,0 861,1 918,0 967,1 1060,0 1144,1 1156,0 1240,1 1244,0 1313,1 1349,0 1405,1 1445,0 1522,1 1553,0 1604,1 1606,0 1656,1 1673,0 1691,1 1758,0 1801,1 1889,0 1916,1 1933,0 2015,1 2047,0 2097,1 2148,0 2198,1 2211,0 2276,1 2288,0 2316,1 2355,0 2419,1 2466,0 2535,1 2582,0 2599,1 2628,0 2630,1 2641,0 2686,1 2742,0 2809,1 2843,0 2883,1 2925,0 2938,1 2970,0 3013,1 3081,0 3137,1 3145,0 3205,1 3264,0 3280,1 3365,0 3457,1 3486,0 3526,1 3600,0 3613,1 3640,0 3730,1 3826,0 3848,1 3881,0 3975,1 4039,0 4071,1 4122,0 4212,1 4303,0 4342,1 4353,0 4370,1 4424,0 4489,1 4505,0 4554,1 4561,0 4644,1 4715,0 4786,1 4875,0 4963,1 5053,0 5070,1 5122,0 5222,1 5260,0 5307,1 5350,0 5429,1 5455,0 5513,1 5520,0 5532,1 5543,0 5605,1 5664,0 5674,1 5706,0 5739,1 5789,0 5883,1 5955,0 6012,1 6044,0 6079,1 6124,0 6206,1 6222,0 6232,1 6235,0 6309,1 6348,0 6379,1 6421,0 6472,1 6490,0 6508,1 6543,0 6588,1 6652,0 6736,1 6793,0 6890,1 6918,0 7003,1 7030,0 7091,1 7126,0 7132,1 7136,0 7197,1 7253,0 7263,1 7341,0 7342,1 7437,0 7528,1 7610,0 7661,1 7723,0 7742,1 7832,0 7861,1 7958,0 7990,1 8028,0 8116,1 8134,0 8156,1 8157,0 8242,1 8286,0 8340,1 8414,0 8503,1 8571,0 8595,1 8693,0 8792,1 8829,0 8849,1 8870,0 8882,1 8906,0 8918,1 8929,0 8988,1 9008,0 9031,1 9130,0 9193,1 9218,0 9232,1 9278,0 9362,1 9445,0 9523,1 9550,0 9647,1 9744,0 9762,1 9769,0 9795,1 9862,0 9948,1 10037,0 10093,1 10162,0 10230,1 10306,0 10311,1 10400,0 10467,1 10486,0 10554,1 10591,0 10671,1 10676,0 10693,1 10745,0 10839,1 10903,0 10922,1 10964,0 11027,1 11106,0 11167,1 11244,0 11268,1 11319,0 11360,1 11423,0 11441,1 11490,0 11554,1 11638,0 11677,1 11712,0 11804,1 11856,0 11857,1 11915,0 11930,1 12001,0 12080,1 12147,0 12149,1 12150,0 12231,1 12305,0 12322,1 12361,0 12372,1 12427,0 12479,1 12559,0 12611,1 end initlist a88 0,0 65,1 131,0 191,1 284,0 302,1 386,0 481,1 513,0 527,1 625,0 664,1 764,0 844,1 869,0 946,1 1037,0 1121,1 1141,0 1229,1 1236,0 1255,1 1332,0 1398,1 1433,0 1510,1 1528,0 1532,1 1537,0 1581,1 1617,0 1658,1 1665,0 1697,1 1776,0 1846,1 1927,0 1944,1 2037,0 2083,1 2120,0 2139,1 2219,0 2287,1 2372,0 2436,1 2526,0 2583,1 2588,0 2663,1 2672,0 2750,1 2802,0 2854,1 2906,0 2977,1 3072,0 3169,1 3224,0 3262,1 3320,0 3352,1 3370,0 3421,1 3446,0 3458,1 3523,0 3557,1 3598,0 3624,1 3691,0 3787,1 3852,0 3933,1 3937,0 3972,1 3989,0 4063,1 4088,0 4175,1 4238,0 4293,1 4359,0 4382,1 4482,0 4494,1 4542,0 4612,1 4673,0 4733,1 4803,0 4842,1 4886,0 4936,1 4950,0 5046,1 5104,0 5110,1 5175,0 5183,1 5255,0 5324,1 5371,0 5373,1 5436,0 5497,1 5582,0 5623,1 5649,0 5698,1 5781,0 5819,1 5894,0 5917,1 5975,0 6067,1 6158,0 6200,1 6217,0 6291,1 6391,0 6460,1 6508,0 6567,1 6577,0 6582,1 6608,0 6634,1 6648,0 6660,1 6668,0 6758,1 6837,0 6907,1 6965,0 6968,1 7046,0 7081,1 7156,0 7229,1 7269,0 7293,1 7363,0 7418,1 7428,0 7431,1 7522,0 7602,1 7680,0 7703,1 7773,0 7840,1 7843,0 7921,1 7947,0 7952,1 8027,0 8032,1 8064,0 8083,1 8096,0 8167,1 8168,0 8221,1 8272,0 8318,1 8352,0 8367,1 8382,0 8428,1 8493,0 8514,1 8603,0 8698,1 8788,0 8811,1 8869,0 8910,1 8957,0 9049,1 9080,0 9166,1 9174,0 9229,1 9283,0 9360,1 9364,0 9413,1 9483,0 9499,1 9588,0 9595,1 9655,0 9726,1 9769,0 9806,1 9905,0 9912,1 9987,0 10068,1 10079,0 10158,1 10186,0 10221,1 10224,0 10261,1 10288,0 10327,1 10343,0 10435,1 10517,0 10535,1 10563,0 10615,1 10632,0 10709,1 10741,0 10764,1 10790,0 10875,1 10963,0 10968,1 10973,0 11030,1 11097,0 11173,1 11192,0 11260,1 11275,0 11363,1 11445,0 11463,1 11551,0 11562,1 11610,0 11666,1 11693,0 11724,1 11745,0 11796,1 11866,0 11905,1 11933,0 11981,1 12075,0 12110,1 12173,0 12221,1 12241,0 12315,1 12390,0 12490,1 12577,0 12592,1 12633,0 12663,1 12756,0 12763,1 end initlist a89 0,0 7,1 44,0 142,1 231,0 257,1 270,0 296,1 391,0 475,1 555,0 575,1 623,0 717,1 719,0 722,1 729,0 760,1 844,0 864,1 932,0 973,1 1044,0 1099,1 1180,0 1202,1 1298,0 1394,1 1415,0 1480,1 1554,0 1595,1 1644,0 1723,1 1728,0 1814,1 1866,0 1868,1 1884,0 1891,1 1906,0 1937,1 1941,0 2023,1 2066,0 2132,1 2171,0 2259,1 2279,0 2284,1 2376,0 2411,1 2510,0 2555,1 2633,0 2712,1 2783,0 2880,1 2894,0 2967,1 2991,0 3032,1 3044,0 3109,1 3122,0 3132,1 3194,0 3266,1 3306,0 3314,1 3402,0 3484,1 3552,0 3559,1 3652,0 3708,1 3715,0 3728,1 3764,0 3789,1 3828,0 3858,1 3904,0 3960,1 3970,0 4046,1 4082,0 4118,1 4210,0 4233,1 4251,0 4319,1 4343,0 4421,1 4479,0 4516,1 4534,0 4607,1 4628,0 4642,1 4697,0 4708,1 4745,0 4756,1 4784,0 4822,1 4864,0 4929,1 4956,0 4979,1 5048,0 5101,1 5143,0 5188,1 5206,0 5303,1 5312,0 5381,1 5471,0 5538,1 5594,0 5646,1 5730,0 5770,1 5796,0 5895,1 5919,0 5942,1 5980,0 6036,1 6101,0 6134,1 6194,0 6234,1 6248,0 6272,1 6303,0 6379,1 6430,0 6453,1 6458,0 6554,1 6569,0 6666,1 6766,0 6866,1 6920,0 6965,1 6995,0 7069,1 7135,0 7185,1 7216,0 7293,1 7334,0 7412,1 7447,0 7531,1 7590,0 7609,1 7666,0 7717,1 7738,0 7748,1 7786,0 7854,1 7855,0 7913,1 7956,0 7958,1 8055,0 8127,1 8208,0 8243,1 8245,0 8255,1 8340,0 8346,1 8347,0 8351,1 8375,0 8417,1 8426,0 8468,1 8509,0 8559,1 8575,0 8646,1 8722,0 8747,1 8828,0 8926,1 9024,0 9102,1 9194,0 9251,1 9307,0 9323,1 9374,0 9382,1 9430,0 9507,1 9526,0 9530,1 9549,0 9634,1 9709,0 9746,1 9815,0 9845,1 9866,0 9870,1 9919,0 9987,1 10071,0 10132,1 10143,0 10206,1 10247,0 10335,1 10339,0 10397,1 10438,0 10455,1 10513,0 10586,1 10607,0 10611,1 10674,0 10719,1 10744,0 10806,1 10822,0 10890,1 10891,0 10900,1 10902,0 10966,1 10988,0 11060,1 11124,0 11223,1 11272,0 11344,1 11395,0 11437,1 11452,0 11525,1 11548,0 11594,1 11653,0 11659,1 11702,0 11707,1 11777,0 11804,1 11815,0 11823,1 end initlist a90 0,0 5,1 53,0 149,1 230,0 307,1 353,0 358,1 379,0 447,1 545,0 624,1 661,0 674,1 718,0 769,1 817,0 857,1 938,0 984,1 1039,0 1120,1 1141,0 1156,1 1176,0 1260,1 1308,0 1319,1 1416,0 1486,1 1542,0 1570,1 1657,0 1700,1 1723,0 1746,1 1760,0 1803,1 1852,0 1876,1 1897,0 1973,1 2034,0 2060,1 2145,0 2241,1 2339,0 2387,1 2459,0 2528,1 2574,0 2665,1 2678,0 2729,1 2781,0 2867,1 2941,0 3014,1 3077,0 3150,1 3153,0 3241,1 3329,0 3382,1 3444,0 3482,1 3515,0 3603,1 3642,0 3713,1 3786,0 3827,1 3913,0 3935,1 4030,0 4094,1 4117,0 4129,1 4225,0 4295,1 4318,0 4328,1 4336,0 4401,1 4407,0 4490,1 4586,0 4641,1 4735,0 4781,1 4806,0 4894,1 4932,0 4953,1 4965,0 4973,1 5004,0 5032,1 5132,0 5224,1 5292,0 5349,1 5390,0 5444,1 5495,0 5534,1 5604,0 5686,1 5690,0 5754,1 5768,0 5789,1 5807,0 5877,1 5939,0 5957,1 6045,0 6098,1 6133,0 6147,1 6158,0 6174,1 6246,0 6322,1 6408,0 6427,1 6501,0 6545,1 6603,0 6677,1 6760,0 6845,1 6927,0 6952,1 6999,0 7095,1 7183,0 7206,1 7274,0 7297,1 7367,0 7467,1 7538,0 7623,1 7705,0 7709,1 7782,0 7835,1 7840,0 7890,1 7914,0 7961,1 7973,0 8041,1 8098,0 8175,1 8268,0 8279,1 8371,0 8395,1 8459,0 8536,1 8541,0 8626,1 8685,0 8694,1 8755,0 8771,1 8792,0 8824,1 8873,0 8948,1 8952,0 9009,1 9049,0 9101,1 9110,0 9193,1 9229,0 9298,1 9337,0 9341,1 9347,0 9382,1 9442,0 9497,1 9544,0 9586,1 9662,0 9690,1 9771,0 9829,1 9883,0 9934,1 9990,0 10002,1 10042,0 10123,1 10190,0 10274,1 10343,0 10371,1 10471,0 10491,1 10503,0 10523,1 10621,0 10652,1 10709,0 10758,1 10782,0 10805,1 10808,0 10892,1 10974,0 10998,1 11081,0 11111,1 11141,0 11142,1 11153,0 11210,1 11247,0 11303,1 11315,0 11337,1 11338,0 11390,1 11457,0 11538,1 11607,0 11685,1 11769,0 11851,1 11863,0 11957,1 11971,0 12004,1 12061,0 12066,1 12120,0 12130,1 12208,0 12282,1 12328,0 12345,1 12410,0 12501,1 12568,0 12574,1 12646,0 12723,1 12748,0 12829,1 12858,0 12911,1 12928,0 13017,1 end initlist a91 0,0 64,1 90,0 154,1 247,0 265,1 359,0 380,1 408,0 437,1 441,0 512,1 547,0 579,1 659,0 713,1 749,0 839,1 873,0 882,1 964,0 1060,1 1122,0 1145,1 1195,0 1276,1 1344,0 1416,1 1476,0 1529,1 1563,0 1613,1 1622,0 1645,1 1743,0 1832,1 1851,0 1869,1 1901,0 1906,1 1986,0 2022,1 2069,0 2075,1 2118,0 2209,1 2271,0 2355,1 2446,0 2470,1 2471,0 2568,1 2602,0 2645,1 2676,0 2730,1 2827,0 2847,1 2919,0 2934,1 3024,0 3123,1 3159,0 3166,1 3209,0 3280,1 3367,0 3395,1 3405,0 3449,1 3464,0 3489,1 3581,0 3598,1 3599,0 3670,1 3727,0 3773,1 3809,0 3862,1 3921,0 3954,1 3960,0 4057,1 4151,0 4214,1 4250,0 4350,1 4361,0 4389,1 4484,0 4577,1 4589,0 4656,1 4716,0 4720,1 4743,0 4834,1 4853,0 4911,1 4994,0 5034,1 5112,0 5135,1 5225,0 5271,1 5283,0 5293,1 5314,0 5336,1 5413,0 5471,1 5481,0 5487,1 5518,0 5530,1 5595,0 5638,1 5667,0 5748,1 5803,0 5895,1 5981,0 6068,1 6155,0 6161,1 6205,0 6300,1 6384,0 6389,1 6461,0 6519,1 6614,0 6653,1 6740,0 6760,1 6797,0 6851,1 6892,0 6954,1 7049,0 7112,1 7161,0 7191,1 7260,0 7283,1 7336,0 7379,1 7402,0 7407,1 7412,0 7426,1 7439,0 7461,1 7522,0 7595,1 7626,0 7629,1 7685,0 7762,1 7782,0 7813,1 7887,0 7970,1 7986,0 8036,1 8072,0 8099,1 8177,0 8201,1 8227,0 8289,1 8384,0 8409,1 8462,0 8562,1 8572,0 8606,1 8659,0 8745,1 8779,0 8877,1 8904,0 8940,1 8959,0 9043,1 9104,0 9190,1 9207,0 9295,1 9345,0 9350,1 9449,0 9459,1 9554,0 9642,1 9693,0 9764,1 9834,0 9931,1 9950,0 10022,1 10116,0 10199,1 10234,0 10333,1 10387,0 10483,1 10546,0 10586,1 10633,0 10715,1 10754,0 10798,1 10810,0 10902,1 10946,0 10972,1 11057,0 11110,1 11131,0 11223,1 11257,0 11259,1 11260,0 11303,1 11380,0 11396,1 11448,0 11527,1 11612,0 11676,1 11750,0 11793,1 11881,0 11955,1 11990,0 12016,1 12066,0 12122,1 12166,0 12177,1 12267,0 12336,1 12404,0 12474,1 12480,0 12521,1 12600,0 12675,1 12741,0 12787,1 12845,0 12869,1 12873,0 12949,1 12973,0 12981,1 end initlist a92 0,0 70,1 106,0 198,1 226,0 278,1 295,0 352,1 450,0 497,1 538,0 579,1 616,0 654,1 731,0 824,1 919,0 1018,1 1117,0 1140,1 1144,0 1165,1 1179,0 1264,1 1281,0 1304,1 1309,0 1357,1 1455,0 1548,1 1570,0 1670,1 1743,0 1751,1 1795,0 1825,1 1861,0 1885,1 1952,0 1997,1 2021,0 2118,1 2143,0 2149,1 2239,0 2245,1 2322,0 2368,1 2437,0 2483,1 2539,0 2633,1 2687,0 2761,1 2857,0 2894,1 2941,0 2993,1 3073,0 3144,1 3220,0 3305,1 3355,0 3448,1 3545,0 3628,1 3638,0 3662,1 3746,0 3813,1 3864,0 3938,1 3961,0 4058,1 4078,0 4159,1 4188,0 4216,1 4219,0 4319,1 4401,0 4475,1 4508,0 4543,1 4583,0 4653,1 4715,0 4748,1 4761,0 4857,1 4901,0 4959,1 5031,0 5073,1 5159,0 5257,1 5282,0 5343,1 5346,0 5395,1 5483,0 5545,1 5561,0 5573,1 5601,0 5602,1 5688,0 5756,1 5791,0 5882,1 5913,0 5941,1 5975,0 6056,1 6071,0 6146,1 6170,0 6262,1 6297,0 6395,1 6416,0 6464,1 6480,0 6547,1 6604,0 6696,1 6790,0 6811,1 6879,0 6880,1 6918,0 6975,1 7074,0 7122,1 7175,0 7242,1 7342,0 7411,1 7422,0 7504,1 7517,0 7527,1 7561,0 7636,1 7691,0 7716,1 7734,0 7737,1 7822,0 7871,1 7967,0 8020,1 8052,0 8095,1 8164,0 8165,1 8201,0 8244,1 8327,0 8395,1 8483,0 8493,1 8516,0 8557,1 8624,0 8649,1 8660,0 8732,1 8788,0 8878,1 8938,0 9021,1 9082,0 9172,1 9204,0 9210,1 9223,0 9228,1 9262,0 9326,1 9420,0 9432,1 9448,0 9529,1 9556,0 9629,1 9670,0 9674,1 9697,0 9743,1 9775,0 9780,1 9830,0 9832,1 9850,0 9894,1 9930,0 10030,1 10080,0 10081,1 10147,0 10212,1 10285,0 10290,1 10361,0 10428,1 10433,0 10476,1 10502,0 10554,1 10592,0 10638,1 10669,0 10683,1 10732,0 10785,1 10849,0 10945,1 10970,0 11069,1 11154,0 11241,1 11333,0 11370,1 11467,0 11564,1 11656,0 11725,1 11730,0 11828,1 11912,0 11975,1 12065,0 12159,1 12213,0 12273,1 12292,0 12392,1 12393,0 12435,1 12439,0 12444,1 12536,0 12616,1 12625,0 12672,1 12704,0 12760,1 12853,0 12924,1 13002,0 13010,1 13100,0 13130,1 13146,0 13198,1 13277,0 13300,1 end initlist a93 0,0 1,1 39,0 50,1 53,0 114,1 144,0 230,1 259,0 268,1 314,0 406,1 450,0 545,1 616,0 705,1 796,0 811,1 826,0 856,1 866,0 923,1 1005,0 1081,1 1162,0 1254,1 1273,0 1290,1 1378,0 1438,1 1520,0 1530,1 1584,0 1635,1 1685,0 1776,1 1859,0 1886,1 1927,0 1977,1 1999,0 2071,1 2087,0 2178,1 2240,0 2291,1 2311,0 2347,1 2438,0 2495,1 2515,0 2572,1 2635,0 2681,1 2692,0 2750,1 2831,0 2922,1 2941,0 3016,1 3061,0 3074,1 3109,0 3196,1 3245,0 3338,1 3423,0 3481,1 3513,0 3551,1 3590,0 3622,1 3668,0 3747,1 3812,0 3891,1 3928,0 3955,1 3964,0 4040,1 4060,0 4082,1 4140,0 4157,1 4186,0 4188,1 4248,0 4290,1 4333,0 4429,1 4518,0 4604,1 4608,0 4610,1 4652,0 4671,1 4711,0 4714,1 4722,0 4777,1 4869,0 4915,1 5001,0 5082,1 5097,0 5133,1 5200,0 5204,1 5214,0 5307,1 5348,0 5380,1 5452,0 5463,1 5546,0 5557,1 5558,0 5615,1 5648,0 5666,1 5687,0 5693,1 5754,0 5822,1 5915,0 5934,1 6005,0 6035,1 6043,0 6129,1 6156,0 6183,1 6192,0 6229,1 6241,0 6313,1 6375,0 6405,1 6442,0 6509,1 6524,0 6609,1 6652,0 6674,1 6774,0 6784,1 6799,0 6865,1 6960,0 7055,1 7080,0 7175,1 7177,0 7229,1 7258,0 7345,1 7431,0 7461,1 7522,0 7598,1 7610,0 7675,1 7717,0 7789,1 7843,0 7888,1 7926,0 7983,1 8015,0 8047,1 8090,0 8156,1 8208,0 8279,1 8328,0 8424,1 8475,0 8570,1 8601,0 8691,1 8708,0 8790,1 8820,0 8907,1 8909,0 8974,1 9012,0 9029,1 9119,0 9121,1 9143,0 9167,1 9174,0 9182,1 9229,0 9234,1 9314,0 9325,1 9358,0 9455,1 9480,0 9532,1 9564,0 9641,1 9692,0 9755,1 9837,0 9911,1 9943,0 10022,1 10059,0 10124,1 10189,0 10253,1 10263,0 10266,1 10290,0 10311,1 10319,0 10375,1 10422,0 10431,1 10484,0 10538,1 10553,0 10578,1 10608,0 10609,1 10662,0 10691,1 10741,0 10763,1 10819,0 10895,1 10920,0 10945,1 11016,0 11040,1 11113,0 11136,1 11183,0 11266,1 11329,0 11379,1 11431,0 11502,1 11564,0 11655,1 11725,0 11824,1 11879,0 11933,1 12030,0 12095,1 12122,0 12140,1 12224,0 12231,1 end initlist a94 0,0 24,1 83,0 92,1 118,0 214,1 281,0 342,1 403,0 414,1 496,0 591,1 627,0 699,1 714,0 759,1 812,0 838,1 856,0 919,1 1008,0 1051,1 1130,0 1153,1 1159,0 1189,1 1190,0 1250,1 1278,0 1372,1 1396,0 1496,1 1535,0 1585,1 1623,0 1715,1 1750,0 1822,1 1865,0 1891,1 1901,0 1914,1 1971,0 2026,1 2088,0 2094,1 2135,0 2184,1 2266,0 2290,1 2390,0 2416,1 2459,0 2464,1 2545,0 2612,1 2643,0 2707,1 2734,0 2814,1 2849,0 2903,1 2986,0 3073,1 3124,0 3145,1 3157,0 3167,1 3171,0 3227,1 3308,0 3371,1 3377,0 3435,1 3448,0 3506,1 3562,0 3586,1 3593,0 3596,1 3693,0 3695,1 3765,0 3798,1 3842,0 3915,1 4014,0 4105,1 4164,0 4201,1 4258,0 4339,1 4345,0 4385,1 4452,0 4515,1 4560,0 4590,1 4592,0 4671,1 4760,0 4816,1 4818,0 4916,1 4940,0 4954,1 5032,0 5077,1 5158,0 5252,1 5323,0 5407,1 5455,0 5490,1 5525,0 5580,1 5627,0 5670,1 5747,0 5769,1 5773,0 5808,1 5886,0 5981,1 6061,0 6139,1 6179,0 6258,1 6317,0 6417,1 6447,0 6536,1 6629,0 6725,1 6801,0 6817,1 6820,0 6852,1 6931,0 6966,1 7036,0 7115,1 7190,0 7234,1 7286,0 7385,1 7446,0 7469,1 7544,0 7564,1 7630,0 7676,1 7697,0 7746,1 7813,0 7906,1 7927,0 7989,1 8089,0 8104,1 8110,0 8133,1 8173,0 8215,1 8300,0 8388,1 8486,0 8505,1 8603,0 8659,1 8734,0 8754,1 8849,0 8917,1 8932,0 8947,1 8990,0 9038,1 9045,0 9141,1 9192,0 9268,1 9299,0 9360,1 9386,0 9438,1 9465,0 9558,1 9608,0 9696,1 9789,0 9855,1 9910,0 9964,1 10012,0 10038,1 10098,0 10119,1 10169,0 10207,1 10295,0 10335,1 10348,0 10386,1 10460,0 10551,1 10553,0 10593,1 10682,0 10764,1 10765,0 10856,1 10955,0 11005,1 11084,0 11094,1 11183,0 11202,1 11287,0 11363,1 11422,0 11442,1 11476,0 11550,1 11627,0 11629,1 11691,0 11751,1 11840,0 11886,1 11973,0 12020,1 12091,0 12119,1 12194,0 12288,1 12382,0 12465,1 12533,0 12602,1 12702,0 12727,1 12739,0 12752,1 12803,0 12864,1 12883,0 12933,1 12983,0 13015,1 13109,0 13171,1 13209,0 13219,1 13224,0 13280,1 13325,0 13394,1 end initlist a95 0,0 17,1 85,0 91,1 168,0 174,1 226,0 230,1 273,0 326,1 390,0 464,1 501,0 557,1 639,0 643,1 730,0 803,1 836,0 862,1 938,0 981,1 987,0 1086,1 1102,0 1107,1 1117,0 1209,1 1257,0 1315,1 1393,0 1487,1 1576,0 1675,1 1706,0 1782,1 1864,0 1902,1 1973,0 2012,1 2056,0 2078,1 2123,0 2153,1 2249,0 2307,1 2387,0 2412,1 2455,0 2456,1 2529,0 2539,1 2614,0 2668,1 2723,0 2799,1 2871,0 2910,1 2987,0 3058,1 3123,0 3214,1 3244,0 3270,1 3284,0 3353,1 3413,0 3427,1 3524,0 3548,1 3631,0 3635,1 3718,0 3750,1 3837,0 3928,1 3978,0 4017,1 4109,0 4128,1 4218,0 4277,1 4317,0 4329,1 4414,0 4508,1 4601,0 4644,1 4677,0 4698,1 4790,0 4873,1 4945,0 4986,1 5019,0 5111,1 5113,0 5197,1 5254,0 5332,1 5357,0 5375,1 5453,0 5526,1 5561,0 5657,1 5728,0 5749,1 5809,0 5814,1 5878,0 5894,1 5920,0 5944,1 6008,0 6027,1 6029,0 6061,1 6096,0 6168,1 6188,0 6217,1 6309,0 6338,1 6385,0 6419,1 6475,0 6483,1 6532,0 6548,1 6638,0 6650,1 6716,0 6779,1 6853,0 6938,1 6970,0 6978,1 7050,0 7128,1 7212,0 7273,1 7329,0 7351,1 7353,0 7445,1 7527,0 7555,1 7640,0 7692,1 7699,0 7704,1 7726,0 7825,1 7905,0 7918,1 7973,0 8039,1 8112,0 8159,1 8185,0 8248,1 8305,0 8373,1 8392,0 8396,1 8427,0 8487,1 8547,0 8592,1 8655,0 8744,1 8791,0 8802,1 8820,0 8838,1 8938,0 9028,1 9065,0 9147,1 9191,0 9285,1 9338,0 9369,1 9441,0 9476,1 9517,0 9597,1 9622,0 9654,1 9666,0 9739,1 9799,0 9868,1 9934,0 10004,1 10027,0 10103,1 10136,0 10183,1 10254,0 10262,1 10275,0 10340,1 10434,0 10479,1 10565,0 10593,1 10677,0 10706,1 10717,0 10784,1 10869,0 10969,1 11014,0 11043,1 11095,0 11183,1 11255,0 11283,1 11338,0 11424,1 11482,0 11524,1 11540,0 11565,1 11567,0 11633,1 11707,0 11723,1 11798,0 11877,1 11926,0 11971,1 11984,0 12002,1 12099,0 12173,1 12216,0 12302,1 12374,0 12432,1 12508,0 12540,1 12605,0 12621,1 12633,0 12673,1 12763,0 12803,1 12884,0 12930,1 13003,0 13065,1 13107,0 13159,1 13185,0 13269,1 end initlist a96 0,0 14,1 29,0 101,1 163,0 166,1 235,0 329,1 335,0 338,1 371,0 418,1 465,0 473,1 535,0 624,1 685,0 775,1 836,0 928,1 1016,0 1078,1 1178,0 1268,1 1315,0 1411,1 1436,0 1460,1 1466,0 1552,1 1611,0 1631,1 1691,0 1772,1 1840,0 1889,1 1963,0 2037,1 2129,0 2192,1 2281,0 2317,1 2353,0 2442,1 2462,0 2552,1 2644,0 2679,1 2733,0 2825,1 2889,0 2935,1 2962,0 2989,1 3078,0 3127,1 3220,0 3264,1 3361,0 3383,1 3465,0 3501,1 3533,0 3534,1 3568,0 3573,1 3651,0 3681,1 3717,0 3776,1 3800,0 3829,1 3845,0 3867,1 3878,0 3935,1 3941,0 4009,1 4078,0 4111,1 4142,0 4197,1 4229,0 4265,1 4326,0 4327,1 4390,0 4402,1 4403,0 4438,1 4486,0 4504,1 4592,0 4633,1 4725,0 4751,1 4796,0 4879,1 4883,0 4946,1 5032,0 5099,1 5163,0 5253,1 5350,0 5378,1 5402,0 5441,1 5513,0 5549,1 5589,0 5687,1 5691,0 5729,1 5829,0 5909,1 5960,0 5966,1 6055,0 6064,1 6128,0 6152,1 6211,0 6252,1 6294,0 6328,1 6406,0 6432,1 6532,0 6535,1 6591,0 6687,1 6712,0 6734,1 6740,0 6839,1 6861,0 6912,1 7004,0 7051,1 7075,0 7147,1 7199,0 7283,1 7374,0 7463,1 7535,0 7559,1 7568,0 7608,1 7669,0 7705,1 7725,0 7798,1 7815,0 7860,1 7942,0 7994,1 8090,0 8127,1 8177,0 8193,1 8209,0 8229,1 8285,0 8333,1 8339,0 8391,1 8442,0 8483,1 8536,0 8557,1 8592,0 8672,1 8691,0 8736,1 8739,0 8795,1 8866,0 8948,1 9015,0 9081,1 9108,0 9118,1 9166,0 9253,1 9313,0 9352,1 9384,0 9439,1 9536,0 9603,1 9699,0 9739,1 9751,0 9798,1 9892,0 9904,1 9993,0 10083,1 10104,0 10117,1 10203,0 10234,1 10296,0 10340,1 10369,0 10452,1 10527,0 10563,1 10597,0 10610,1 10660,0 10731,1 10826,0 10904,1 10926,0 10990,1 11074,0 11097,1 11181,0 11272,1 11317,0 11389,1 11456,0 11493,1 11558,0 11628,1 11647,0 11724,1 11774,0 11826,1 11883,0 11971,1 12008,0 12024,1 12031,0 12098,1 12171,0 12180,1 12182,0 12226,1 12261,0 12286,1 12292,0 12365,1 12408,0 12500,1 12573,0 12576,1 12668,0 12762,1 12811,0 12864,1 12871,0 12946,1 12959,0 12976,1 end initlist a97 0,0 88,1 141,0 229,1 240,0 247,1 305,0 404,1 444,0 529,1 553,0 618,1 631,0 651,1 736,0 742,1 765,0 826,1 837,0 869,1 968,0 984,1 1022,0 1030,1 1064,0 1068,1 1144,0 1161,1 1249,0 1279,1 1365,0 1442,1 1462,0 1522,1 1615,0 1713,1 1722,0 1759,1 1792,0 1823,1 1891,0 1912,1 1996,0 2014,1 2050,0 2053,1 2135,0 2158,1 2210,0 2218,1 2226,0 2289,1 2294,0 2322,1 2363,0 2411,1 2417,0 2418,1 2425,0 2517,1 2611,0 2659,1 2731,0 2818,1 2844,0 2894,1 2919,0 2926,1 2989,0 3053,1 3111,0 3141,1 3204,0 3268,1 3348,0 3363,1 3384,0 3443,1 3468,0 3484,1 3505,0 3540,1 3542,0 3599,1 3671,0 3708,1 3715,0 3727,1 3824,0 3866,1 3918,0 3954,1 4025,0 4097,1 4119,0 4142,1 4182,0 4199,1 4296,0 4390,1 4445,0 4485,1 4556,0 4566,1 4586,0 4675,1 4736,0 4831,1 4926,0 5007,1 5050,0 5149,1 5243,0 5275,1 5314,0 5353,1 5395,0 5444,1 5504,0 5530,1 5608,0 5613,1 5693,0 5774,1 5836,0 5845,1 5910,0 6009,1 6012,0 6069,1 6151,0 6251,1 6342,0 6407,1 6496,0 6593,1 6619,0 6717,1 6764,0 6767,1 6830,0 6853,1 6867,0 6869,1 6898,0 6949,1 7046,0 7088,1 7118,0 7189,1 7191,0 7272,1 7276,0 7278,1 7337,0 7397,1 7435,0 7500,1 7584,0 7609,1 7694,0 7728,1 7789,0 7878,1 7940,0 7950,1 8035,0 8123,1 8125,0 8221,1 8301,0 8345,1 8360,0 8369,1 8383,0 8418,1 8517,0 8571,1 8623,0 8630,1 8707,0 8712,1 8780,0 8782,1 8840,0 8867,1 8886,0 8986,1 9073,0 9153,1 9234,0 9324,1 9424,0 9475,1 9523,0 9616,1 9660,0 9733,1 9811,0 9856,1 9882,0 9895,1 9952,0 9983,1 10029,0 10030,1 10085,0 10086,1 10157,0 10173,1 10183,0 10271,1 10351,0 10445,1 10464,0 10546,1 10562,0 10634,1 10667,0 10698,1 10739,0 10780,1 10816,0 10826,1 10923,0 10926,1 11009,0 11094,1 11117,0 11159,1 11243,0 11319,1 11413,0 11442,1 11463,0 11531,1 11588,0 11669,1 11708,0 11710,1 11785,0 11831,1 11871,0 11872,1 11929,0 12028,1 12042,0 12065,1 12141,0 12210,1 12274,0 12339,1 12341,0 12374,1 12399,0 12410,1 12495,0 12573,1 end initlist a98 0,0 67,1 97,0 162,1 253,0 332,1 381,0 460,1 511,0 543,1 579,0 650,1 723,0 809,1 903,0 939,1 1011,0 1069,1 1160,0 1259,1 1294,0 1318,1 1351,0 1450,1 1460,0 1491,1 1580,0 1592,1 1656,0 1680,1 1750,0 1778,1 1814,0 1879,1 1941,0 1947,1 2021,0 2045,1 2135,0 2157,1 2245,0 2329,1 2332,0 2350,1 2439,0 2529,1 2574,0 2577,1 2613,0 2637,1 2672,0 2719,1 2757,0 2787,1 2825,0 2839,1 2933,0 2975,1 2996,0 3017,1 3043,0 3116,1 3207,0 3276,1 3308,0 3359,1 3405,0 3493,1 3561,0 3660,1 3678,0 3691,1 3765,0 3785,1 3827,0 3876,1 3897,0 3943,1 3973,0 4002,1 4051,0 4137,1 4204,0 4264,1 4352,0 4408,1 4461,0 4504,1 4545,0 4591,1 4678,0 4776,1 4818,0 4847,1 4892,0 4925,1 4947,0 4968,1 5029,0 5044,1 5046,0 5048,1 5109,0 5125,1 5223,0 5304,1 5382,0 5389,1 5431,0 5531,1 5561,0 5617,1 5688,0 5724,1 5764,0 5779,1 5841,0 5936,1 5995,0 6080,1 6125,0 6172,1 6231,0 6272,1 6305,0 6383,1 6417,0 6471,1 6488,0 6535,1 6602,0 6658,1 6693,0 6746,1 6760,0 6839,1 6917,0 6972,1 7004,0 7037,1 7103,0 7175,1 7252,0 7304,1 7340,0 7358,1 7362,0 7447,1 7497,0 7558,1 7603,0 7618,1 7705,0 7751,1 7764,0 7794,1 7870,0 7907,1 7938,0 8018,1 8026,0 8031,1 8127,0 8196,1 8223,0 8292,1 8363,0 8448,1 8487,0 8551,1 8557,0 8594,1 8607,0 8618,1 8717,0 8761,1 8768,0 8805,1 8836,0 8889,1 8982,0 9018,1 9073,0 9122,1 9208,0 9247,1 9303,0 9378,1 9472,0 9482,1 9519,0 9526,1 9573,0 9607,1 9636,0 9705,1 9761,0 9801,1 9804,0 9897,1 9939,0 9983,1 10035,0 10117,1 10146,0 10157,1 10160,0 10173,1 10255,0 10287,1 10331,0 10346,1 10434,0 10485,1 10585,0 10610,1 10628,0 10671,1 10726,0 10741,1 10760,0 10801,1 10815,0 10901,1 10905,0 10978,1 11066,0 11081,1 11106,0 11177,1 11190,0 11209,1 11217,0 11287,1 11381,0 11436,1 11451,0 11512,1 11579,0 11659,1 11676,0 11724,1 11824,0 11832,1 11844,0 11893,1 11966,0 12008,1 12072,0 12152,1 12204,0 12210,1 12307,0 12322,1 12360,0 12421,1 12483,0 12520,1 end initlist a99 0,0 25,1 75,0 92,1 133,0 161,1 164,0 264,1 336,0 367,1 409,0 422,1 488,0 560,1 614,0 631,1 694,0 775,1 796,0 816,1 905,0 934,1 957,0 987,1 1071,0 1147,1 1203,0 1273,1 1335,0 1362,1 1443,0 1455,1 1514,0 1537,1 1591,0 1633,1 1644,0 1723,1 1743,0 1744,1 1837,0 1921,1 2008,0 2103,1 2191,0 2223,1 2296,0 2325,1 2346,0 2376,1 2426,0 2483,1 2522,0 2597,1 2632,0 2731,1 2811,0 2848,1 2910,0 2995,1 2997,0 3082,1 3121,0 3189,1 3266,0 3347,1 3392,0 3421,1 3475,0 3483,1 3559,0 3597,1 3639,0 3675,1 3736,0 3751,1 3816,0 3891,1 3898,0 3905,1 3928,0 4023,1 4044,0 4082,1 4177,0 4191,1 4217,0 4265,1 4331,0 4354,1 4440,0 4533,1 4632,0 4662,1 4755,0 4841,1 4928,0 4964,1 4966,0 4977,1 5018,0 5089,1 5140,0 5161,1 5245,0 5256,1 5267,0 5326,1 5381,0 5397,1 5448,0 5536,1 5556,0 5588,1 5649,0 5703,1 5800,0 5807,1 5830,0 5831,1 5912,0 5985,1 6013,0 6089,1 6144,0 6175,1 6180,0 6189,1 6227,0 6275,1 6311,0 6369,1 6408,0 6469,1 6487,0 6499,1 6530,0 6575,1 6597,0 6659,1 6709,0 6790,1 6869,0 6895,1 6953,0 7053,1 7090,0 7128,1 7206,0 7295,1 7351,0 7402,1 7477,0 7535,1 7580,0 7635,1 7642,0 7667,1 7731,0 7740,1 7839,0 7864,1 7937,0 8036,1 8109,0 8143,1 8160,0 8173,1 8241,0 8337,1 8393,0 8414,1 8427,0 8455,1 8553,0 8597,1 8635,0 8654,1 8700,0 8762,1 8856,0 8951,1 8980,0 8989,1 9047,0 9083,1 9151,0 9180,1 9250,0 9306,1 9342,0 9400,1 9460,0 9484,1 9579,0 9669,1 9767,0 9819,1 9827,0 9922,1 9999,0 10046,1 10051,0 10122,1 10219,0 10231,1 10282,0 10333,1 10352,0 10378,1 10448,0 10536,1 10635,0 10682,1 10701,0 10730,1 10787,0 10803,1 10865,0 10961,1 11048,0 11131,1 11215,0 11312,1 11324,0 11403,1 11489,0 11566,1 11592,0 11614,1 11681,0 11705,1 11803,0 11855,1 11879,0 11950,1 12026,0 12078,1 12105,0 12167,1 12202,0 12290,1 12367,0 12421,1 12520,0 12575,1 12613,0 12670,1 12719,0 12808,1 12891,0 12902,1 12916,0 12927,1 12952,0 12987,1 13046,0 13052,1 end initlist a100 0,0 45,1 48,0 125,1 192,0 262,1 312,0 400,1 467,0 539,1 573,0 632,1 676,0 692,1 785,0 848,1 867,0 966,1 981,0 1030,1 1098,0 1197,1 1253,0 1258,1 1340,0 1420,1 1436,0 1455,1 1456,0 1510,1 1546,0 1549,1 1592,0 1688,1 1699,0 1780,1 1859,0 1879,1 1962,0 1983,1 2011,0 2050,1 2128,0 2153,1 2219,0 2293,1 2352,0 2450,1 2494,0 2543,1 2557,0 2586,1 2629,0 2691,1 2751,0 2758,1 2827,0 2919,1 2929,0 2943,1 3032,0 3035,1 3087,0 3159,1 3217,0 3280,1 3364,0 3457,1 3469,0 3528,1 3555,0 3633,1 3649,0 3727,1 3752,0 3784,1 3822,0 3853,1 3895,0 3976,1 4050,0 4061,1 4078,0 4141,1 4214,0 4292,1 4387,0 4465,1 4467,0 4560,1 4656,0 4661,1 4752,0 4825,1 4856,0 4868,1 4967,0 5020,1 5107,0 5184,1 5237,0 5258,1 5271,0 5353,1 5420,0 5440,1 5450,0 5495,1 5570,0 5581,1 5648,0 5681,1 5713,0 5788,1 5854,0 5871,1 5889,0 5905,1 5939,0 6020,1 6031,0 6063,1 6123,0 6191,1 6211,0 6302,1 6379,0 6405,1 6413,0 6507,1 6559,0 6645,1 6681,0 6758,1 6838,0 6863,1 6931,0 6936,1 6978,0 7026,1 7113,0 7210,1 7254,0 7300,1 7382,0 7430,1 7435,0 7481,1 7486,0 7571,1 7595,0 7634,1 7647,0 7662,1 7698,0 7744,1 7827,0 7877,1 7965,0 8042,1 8119,0 8203,1 8255,0 8278,1 8310,0 8325,1 8387,0 8426,1 8524,0 8605,1 8687,0 8759,1 8838,0 8935,1 8954,0 9029,1 9040,0 9139,1 9161,0 9170,1 9202,0 9236,1 9271,0 9288,1 9380,0 9470,1 9565,0 9644,1 9737,0 9809,1 9843,0 9875,1 9946,0 10044,1 10068,0 10164,1 10245,0 10260,1 10276,0 10333,1 10391,0 10418,1 10481,0 10577,1 10672,0 10741,1 10837,0 10926,1 10940,0 11028,1 11091,0 11130,1 11163,0 11227,1 11317,0 11341,1 11437,0 11508,1 11532,0 11573,1 11632,0 11677,1 11701,0 11786,1 11875,0 11877,1 11961,0 12002,1 12005,0 12060,1 12124,0 12142,1 12186,0 12235,1 12265,0 12344,1 12406,0 12446,1 12507,0 12533,1 12570,0 12601,1 12662,0 12746,1 12800,0 12899,1 12917,0 13004,1 13100,0 13159,1 13188,0 13208,1 13306,0 13399,1 13412,0 13416,1 13513,0 13536,1 end initlist a101 0,0 89,1 152,0 204,1 220,0 288,1 351,0 358,1 448,0 477,1 536,0 614,1 697,0 774,1 775,0 794,1 837,0 876,1 973,0 1058,1 1135,0 1219,1 1252,0 1316,1 1329,0 1355,1 1362,0 1375,1 1398,0 1490,1 1553,0 1643,1 1677,0 1764,1 1788,0 1830,1 1853,0 1875,1 1953,0 2014,1 2032,0 2039,1 2117,0 2120,1 2213,0 2301,1 2322,0 2409,1 2425,0 2452,1 2453,0 2460,1 2463,0 2500,1 2546,0 2559,1 2572,0 2632,1 2650,0 2750,1 2840,0 2858,1 2861,0 2900,1 2993,0 3013,1 3071,0 3091,1 3160,0 3245,1 3270,0 3343,1 3370,0 3431,1 3516,0 3607,1 3622,0 3712,1 3768,0 3826,1 3911,0 3965,1 4064,0 4160,1 4178,0 4224,1 4266,0 4326,1 4392,0 4396,1 4429,0 4458,1 4508,0 4545,1 4620,0 4679,1 4766,0 4777,1 4809,0 4827,1 4916,0 4932,1 4947,0 4950,1 4968,0 4974,1 5027,0 5048,1 5123,0 5130,1 5143,0 5236,1 5255,0 5310,1 5377,0 5413,1 5445,0 5496,1 5502,0 5553,1 5569,0 5667,1 5733,0 5767,1 5801,0 5836,1 5844,0 5901,1 5938,0 5943,1 5976,0 6017,1 6036,0 6097,1 6176,0 6203,1 6295,0 6383,1 6463,0 6542,1 6603,0 6645,1 6709,0 6761,1 6762,0 6809,1 6891,0 6986,1 7053,0 7145,1 7196,0 7294,1 7384,0 7440,1 7491,0 7585,1 7685,0 7768,1 7829,0 7841,1 7860,0 7957,1 7960,0 7998,1 8085,0 8123,1 8201,0 8208,1 8225,0 8235,1 8246,0 8279,1 8288,0 8313,1 8398,0 8408,1 8447,0 8473,1 8512,0 8516,1 8590,0 8658,1 8700,0 8788,1 8835,0 8855,1 8915,0 8937,1 8949,0 8972,1 8979,0 9010,1 9037,0 9042,1 9139,0 9149,1 9160,0 9235,1 9238,0 9288,1 9307,0 9320,1 9346,0 9401,1 9441,0 9481,1 9525,0 9588,1 9651,0 9683,1 9782,0 9788,1 9843,0 9908,1 9950,0 9959,1 10032,0 10115,1 10151,0 10181,1 10275,0 10306,1 10396,0 10429,1 10487,0 10531,1 10624,0 10625,1 10641,0 10689,1 10711,0 10717,1 10755,0 10817,1 10883,0 10929,1 11024,0 11080,1 11174,0 11180,1 11230,0 11266,1 11301,0 11304,1 11358,0 11370,1 11390,0 11425,1 11485,0 11535,1 11595,0 11617,1 11636,0 11668,1 11687,0 11702,1 11752,0 11786,1 end initlist a102 0,0 19,1 47,0 102,1 169,0 190,1 252,0 263,1 357,0 378,1 478,0 508,1 527,0 553,1 649,0 686,1 777,0 778,1 855,0 918,1 931,0 1010,1 1041,0 1091,1 1171,0 1200,1 1249,0 1310,1 1402,0 1443,1 1482,0 1509,1 1518,0 1560,1 1648,0 1716,1 1779,0 1858,1 1927,0 1943,1 2007,0 2051,1 2124,0 2126,1 2190,0 2215,1 2297,0 2360,1 2365,0 2457,1 2459,0 2550,1 2557,0 2609,1 2639,0 2696,1 2755,0 2831,1 2928,0 3017,1 3067,0 3106,1 3113,0 3117,1 3185,0 3243,1 3250,0 3268,1 3297,0 3341,1 3410,0 3458,1 3515,0 3563,1 3654,0 3674,1 3760,0 3837,1 3866,0 3868,1 3952,0 3997,1 4035,0 4082,1 4175,0 4192,1 4203,0 4248,1 4302,0 4390,1 4428,0 4455,1 4499,0 4515,1 4573,0 4576,1 4597,0 4659,1 4728,0 4812,1 4870,0 4920,1 4978,0 5039,1 5138,0 5148,1 5215,0 5300,1 5321,0 5409,1 5414,0 5430,1 5525,0 5549,1 5561,0 5648,1 5745,0 5818,1 5879,0 5976,1 6075,0 6154,1 6164,0 6208,1 6274,0 6278,1 6323,0 6341,1 6417,0 6426,1 6513,0 6545,1 6575,0 6599,1 6639,0 6665,1 6696,0 6765,1 6817,0 6911,1 7008,0 7059,1 7122,0 7128,1 7218,0 7250,1 7328,0 7407,1 7503,0 7548,1 7585,0 7618,1 7681,0 7739,1 7806,0 7831,1 7843,0 7904,1 7947,0 7949,1 7976,0 8028,1 8074,0 8103,1 8109,0 8146,1 8169,0 8235,1 8316,0 8343,1 8434,0 8466,1 8559,0 8584,1 8664,0 8749,1 8814,0 8842,1 8917,0 8945,1 9029,0 9073,1 9079,0 9102,1 9155,0 9196,1 9244,0 9307,1 9373,0 9461,1 9491,0 9588,1 9665,0 9749,1 9841,0 9886,1 9949,0 9994,1 10000,0 10011,1 10017,0 10058,1 10087,0 10120,1 10179,0 10242,1 10246,0 10286,1 10355,0 10414,1 10465,0 10486,1 10487,0 10541,1 10635,0 10674,1 10761,0 10835,1 10858,0 10892,1 10965,0 10999,1 11003,0 11087,1 11151,0 11190,1 11194,0 11290,1 11327,0 11407,1 11416,0 11438,1 11462,0 11493,1 11497,0 11524,1 11579,0 11629,1 11670,0 11696,1 11744,0 11843,1 11933,0 11961,1 12054,0 12137,1 12141,0 12159,1 12176,0 12267,1 12327,0 12418,1 12468,0 12493,1 12565,0 12653,1 12677,0 12691,1 end initlist a103 0,0 97,1 174,0 186,1 212,0 298,1 331,0 352,1 413,0 510,1 561,0 610,1 702,0 765,1 807,0 857,1 863,0 869,1 894,0 945,1 973,0 1020,1 1070,0 1084,1 1166,0 1229,1 1271,0 1357,1 1436,0 1505,1 1592,0 1645,1 1685,0 1693,1 1726,0 1740,1 1779,0 1873,1 1944,0 1988,1 2032,0 2107,1 2158,0 2185,1 2197,0 2256,1 2295,0 2344,1 2423,0 2468,1 2547,0 2611,1 2627,0 2673,1 2757,0 2759,1 2764,0 2798,1 2851,0 2926,1 2974,0 3035,1 3119,0 3128,1 3203,0 3232,1 3249,0 3299,1 3362,0 3398,1 3488,0 3561,1 3590,0 3671,1 3717,0 3786,1 3789,0 3877,1 3895,0 3940,1 3984,0 4025,1 4072,0 4131,1 4187,0 4233,1 4291,0 4351,1 4443,0 4447,1 4475,0 4523,1 4560,0 4628,1 4711,0 4726,1 4778,0 4784,1 4880,0 4932,1 5016,0 5073,1 5151,0 5229,1 5326,0 5349,1 5440,0 5474,1 5557,0 5650,1 5702,0 5775,1 5802,0 5893,1 5934,0 5996,1 6055,0 6153,1 6197,0 6261,1 6277,0 6368,1 6382,0 6408,1 6468,0 6537,1 6570,0 6667,1 6708,0 6799,1 6833,0 6897,1 6979,0 7004,1 7091,0 7143,1 7190,0 7199,1 7285,0 7299,1 7302,0 7315,1 7414,0 7503,1 7569,0 7652,1 7654,0 7685,1 7763,0 7819,1 7845,0 7853,1 7899,0 7925,1 8009,0 8086,1 8159,0 8200,1 8263,0 8285,1 8355,0 8423,1 8450,0 8493,1 8514,0 8572,1 8601,0 8635,1 8724,0 8804,1 8897,0 8991,1 9060,0 9110,1 9151,0 9224,1 9235,0 9269,1 9317,0 9339,1 9356,0 9397,1 9474,0 9532,1 9585,0 9589,1 9636,0 9638,1 9670,0 9736,1 9828,0 9908,1 9968,0 9980,1 9999,0 10094,1 10125,0 10159,1 10255,0 10256,1 10286,0 10376,1 10384,0 10462,1 10472,0 10510,1 10525,0 10625,1 10674,0 10767,1 10794,0 10815,1 10865,0 10883,1 10967,0 11047,1 11068,0 11074,1 11113,0 11126,1 11166,0 11242,1 11282,0 11341,1 11362,0 11408,1 11466,0 11488,1 11526,0 11580,1 11632,0 11694,1 11759,0 11842,1 11866,0 11896,1 11950,0 12023,1 12088,0 12118,1 12153,0 12202,1 12245,0 12256,1 12274,0 12317,1 12383,0 12398,1 12496,0 12539,1 12573,0 12616,1 12633,0 12703,1 12797,0 12860,1 12917,0 12933,1 end initlist a104 0,0 50,1 64,0 146,1 229,0 270,1 274,0 329,1 346,0 404,1 477,0 536,1 569,0 662,1 732,0 767,1 864,0 951,1 959,0 992,1 1017,0 1058,1 1079,0 1132,1 1207,0 1242,1 1295,0 1349,1 1414,0 1502,1 1528,0 1562,1 1625,0 1662,1 1706,0 1785,1 1826,0 1896,1 1951,0 1973,1 2058,0 2127,1 2133,0 2187,1 2252,0 2282,1 2332,0 2413,1 2436,0 2476,1 2497,0 2558,1 2609,0 2690,1 2741,0 2817,1 2865,0 2959,1 3026,0 3122,1 3141,0 3180,1 3250,0 3310,1 3335,0 3418,1 3432,0 3506,1 3586,0 3597,1 3690,0 3714,1 3802,0 3840,1 3920,0 3944,1 4010,0 4102,1 4179,0 4217,1 4254,0 4341,1 4438,0 4448,1 4479,0 4506,1 4525,0 4608,1 4613,0 4617,1 4620,0 4623,1 4712,0 4804,1 4857,0 4881,1 4902,0 4984,1 5081,0 5120,1 5127,0 5197,1 5265,0 5307,1 5403,0 5448,1 5537,0 5550,1 5573,0 5651,1 5745,0 5825,1 5850,0 5851,1 5930,0 6028,1 6037,0 6120,1 6209,0 6274,1 6296,0 6323,1 6361,0 6409,1 6474,0 6495,1 6567,0 6619,1 6697,0 6764,1 6800,0 6865,1 6959,0 7049,1 7131,0 7189,1 7254,0 7349,1 7374,0 7444,1 7498,0 7540,1 7564,0 7646,1 7701,0 7729,1 7778,0 7807,1 7890,0 7957,1 8007,0 8043,1 8054,0 8139,1 8200,0 8281,1 8311,0 8350,1 8396,0 8409,1 8445,0 8502,1 8537,0 8626,1 8656,0 8659,1 8728,0 8770,1 8817,0 8868,1 8907,0 8918,1 8923,0 8925,1 8949,0 8960,1 9057,0 9110,1 9201,0 9241,1 9245,0 9297,1 9317,0 9349,1 9401,0 9494,1 9558,0 9602,1 9604,0 9673,1 9725,0 9775,1 9862,0 9947,1 9958,0 9982,1 10043,0 10067,1 10101,0 10119,1 10165,0 10183,1 10260,0 10288,1 10334,0 10366,1 10370,0 10422,1 10519,0 10588,1 10620,0 10687,1 10763,0 10824,1 10861,0 10873,1 10962,0 11021,1 11043,0 11085,1 11089,0 11107,1 11162,0 11225,1 11229,0 11307,1 11342,0 11363,1 11444,0 11448,1 11455,0 11512,1 11589,0 11619,1 11634,0 11639,1 11662,0 11747,1 11828,0 11843,1 11911,0 11927,1 11933,0 12011,1 12045,0 12089,1 12165,0 12262,1 12319,0 12331,1 12341,0 12406,1 12414,0 12430,1 12510,0 12516,1 12518,0 12534,1 end initlist a105 0,0 34,1 69,0 70,1 75,0 114,1 154,0 220,1 300,0 371,1 466,0 485,1 489,0 573,1 658,0 696,1 728,0 826,1 847,0 880,1 894,0 943,1 963,0 1034,1 1047,0 1054,1 1134,0 1151,1 1207,0 1281,1 1327,0 1409,1 1447,0 1530,1 1551,0 1620,1 1667,0 1683,1 1729,0 1779,1 1846,0 1862,1 1953,0 2010,1 2070,0 2160,1 2210,0 2213,1 2280,0 2286,1 2330,0 2331,1 2399,0 2438,1 2454,0 2506,1 2592,0 2634,1 2685,0 2700,1 2797,0 2820,1 2852,0 2867,1 2898,0 2956,1 2991,0 3066,1 3145,0 3172,1 3184,0 3210,1 3293,0 3353,1 3415,0 3430,1 3511,0 3534,1 3608,0 3654,1 3672,0 3759,1 3786,0 3801,1 3867,0 3879,1 3896,0 3904,1 3932,0 3953,1 3996,0 4051,1 4126,0 4178,1 4207,0 4209,1 4271,0 4352,1 4420,0 4520,1 4531,0 4565,1 4586,0 4680,1 4686,0 4727,1 4816,0 4910,1 4914,0 4992,1 5044,0 5107,1 5126,0 5146,1 5233,0 5265,1 5355,0 5420,1 5513,0 5565,1 5614,0 5713,1 5774,0 5789,1 5857,0 5935,1 5991,0 6071,1 6073,0 6091,1 6166,0 6223,1 6305,0 6310,1 6369,0 6416,1 6462,0 6548,1 6608,0 6694,1 6715,0 6722,1 6723,0 6775,1 6831,0 6884,1 6980,0 7030,1 7097,0 7150,1 7240,0 7320,1 7406,0 7439,1 7495,0 7587,1 7662,0 7709,1 7803,0 7807,1 7890,0 7970,1 8023,0 8090,1 8172,0 8222,1 8223,0 8286,1 8378,0 8456,1 8518,0 8616,1 8664,0 8695,1 8734,0 8737,1 8773,0 8838,1 8912,0 8932,1 8999,0 9043,1 9063,0 9147,1 9192,0 9272,1 9348,0 9420,1 9469,0 9496,1 9592,0 9659,1 9708,0 9780,1 9781,0 9815,1 9821,0 9836,1 9901,0 9940,1 9950,0 10035,1 10075,0 10153,1 10241,0 10257,1 10356,0 10417,1 10493,0 10509,1 10596,0 10685,1 10751,0 10817,1 10866,0 10892,1 10907,0 10986,1 11070,0 11092,1 11133,0 11220,1 11290,0 11292,1 11337,0 11379,1 11411,0 11469,1 11544,0 11624,1 11719,0 11746,1 11788,0 11799,1 11848,0 11945,1 11962,0 12030,1 12058,0 12144,1 12203,0 12213,1 12238,0 12333,1 12426,0 12500,1 12534,0 12573,1 12596,0 12663,1 12678,0 12752,1 12851,0 12873,1 12935,0 12963,1 13061,0 13142,1 end initlist a106 0,0 68,1 101,0 179,1 198,0 212,1 224,0 289,1 292,0 363,1 395,0 454,1 460,0 490,1 571,0 572,1 614,0 704,1 793,0 821,1 826,0 881,1 885,0 930,1 1025,0 1035,1 1056,0 1132,1 1204,0 1209,1 1275,0 1308,1 1330,0 1420,1 1518,0 1601,1 1662,0 1667,1 1756,0 1792,1 1857,0 1888,1 1890,0 1984,1 2025,0 2106,1 2133,0 2209,1 2276,0 2334,1 2351,0 2440,1 2506,0 2511,1 2551,0 2616,1 2682,0 2761,1 2767,0 2770,1 2859,0 2943,1 2945,0 3025,1 3119,0 3189,1 3257,0 3329,1 3340,0 3400,1 3493,0 3503,1 3555,0 3622,1 3633,0 3679,1 3711,0 3807,1 3882,0 3954,1 3997,0 4047,1 4065,0 4140,1 4237,0 4303,1 4378,0 4474,1 4548,0 4593,1 4622,0 4680,1 4769,0 4821,1 4853,0 4876,1 4949,0 4997,1 5008,0 5055,1 5132,0 5189,1 5208,0 5246,1 5305,0 5320,1 5362,0 5370,1 5431,0 5505,1 5562,0 5657,1 5661,0 5738,1 5832,0 5929,1 6004,0 6052,1 6086,0 6122,1 6196,0 6215,1 6257,0 6258,1 6319,0 6386,1 6422,0 6458,1 6538,0 6543,1 6560,0 6610,1 6661,0 6675,1 6763,0 6797,1 6880,0 6915,1 6971,0 7019,1 7095,0 7171,1 7215,0 7310,1 7314,0 7316,1 7404,0 7460,1 7548,0 7562,1 7568,0 7663,1 7706,0 7762,1 7825,0 7846,1 7903,0 7987,1 8030,0 8090,1 8177,0 8254,1 8260,0 8320,1 8324,0 8380,1 8401,0 8438,1 8536,0 8589,1 8628,0 8677,1 8729,0 8827,1 8849,0 8908,1 8996,0 9063,1 9093,0 9111,1 9163,0 9224,1 9243,0 9298,1 9373,0 9407,1 9481,0 9508,1 9545,0 9606,1 9638,0 9705,1 9771,0 9829,1 9854,0 9867,1 9894,0 9962,1 10011,0 10031,1 10115,0 10167,1 10229,0 10259,1 10279,0 10355,1 10383,0 10394,1 10433,0 10474,1 10481,0 10515,1 10519,0 10619,1 10627,0 10633,1 10703,0 10728,1 10776,0 10842,1 10941,0 10972,1 10979,0 11045,1 11091,0 11141,1 11231,0 11316,1 11404,0 11469,1 11494,0 11510,1 11593,0 11667,1 11755,0 11761,1 11782,0 11857,1 11949,0 12031,1 12080,0 12109,1 12195,0 12254,1 12279,0 12360,1 12445,0 12545,1 12600,0 12686,1 12738,0 12819,1 12881,0 12952,1 12975,0 13070,1 13082,0 13090,1 end initlist a107 0,0 21,1 120,0 158,1 194,0 277,1 353,0 356,1 423,0 505,1 527,0 552,1 571,0 612,1 705,0 770,1 780,0 846,1 854,0 903,1 925,0 1018,1 1116,0 1212,1 1245,0 1324,1 1415,0 1450,1 1500,0 1582,1 1641,0 1653,1 1668,0 1675,1 1680,0 1713,1 1727,0 1821,1 1869,0 1918,1 1969,0 2049,1 2080,0 2146,1 2152,0 2163,1 2165,0 2231,1 2261,0 2344,1 2363,0 2364,1 2441,0 2525,1 2553,0 2600,1 2647,0 2708,1 2731,0 2767,1 2843,0 2914,1 2964,0 2972,1 3039,0 3116,1 3196,0 3199,1 3217,0 3290,1 3382,0 3384,1 3408,0 3464,1 3509,0 3561,1 3614,0 3636,1 3703,0 3708,1 3728,0 3771,1 3822,0 3839,1 3859,0 3914,1 3945,0 4033,1 4093,0 4098,1 4148,0 4149,1 4160,0 4248,1 4261,0 4294,1 4381,0 4479,1 4575,0 4610,1 4634,0 4706,1 4716,0 4742,1 4830,0 4873,1 4899,0 4993,1 5034,0 5092,1 5162,0 5250,1 5332,0 5345,1 5433,0 5528,1 5585,0 5613,1 5640,0 5740,1 5808,0 5822,1 5917,0 5959,1 6049,0 6140,1 6233,0 6326,1 6364,0 6441,1 6451,0 6454,1 6553,0 6587,1 6607,0 6634,1 6648,0 6711,1 6772,0 6870,1 6950,0 6964,1 7024,0 7041,1 7129,0 7162,1 7242,0 7274,1 7328,0 7406,1 7471,0 7495,1 7520,0 7554,1 7588,0 7683,1 7694,0 7739,1 7772,0 7847,1 7924,0 8016,1 8041,0 8061,1 8130,0 8169,1 8201,0 8228,1 8259,0 8261,1 8323,0 8404,1 8479,0 8523,1 8580,0 8650,1 8699,0 8788,1 8870,0 8956,1 8961,0 8969,1 9060,0 9127,1 9198,0 9276,1 9340,0 9350,1 9380,0 9476,1 9527,0 9528,1 9529,0 9552,1 9628,0 9660,1 9719,0 9808,1 9889,0 9897,1 9947,0 10045,1 10101,0 10157,1 10174,0 10248,1 10319,0 10364,1 10368,0 10374,1 10418,0 10440,1 10540,0 10612,1 10613,0 10703,1 10739,0 10817,1 10896,0 10941,1 10957,0 10988,1 11047,0 11131,1 11167,0 11183,1 11258,0 11284,1 11335,0 11342,1 11402,0 11459,1 11468,0 11543,1 11552,0 11589,1 11658,0 11684,1 11772,0 11811,1 11882,0 11890,1 11980,0 12073,1 12117,0 12157,1 12174,0 12205,1 12277,0 12295,1 12390,0 12483,1 12508,0 12583,1 12664,0 12698,1 12717,0 12768,1 end initlist a108 0,0 91,1 182,0 206,1 273,0 370,1 455,0 521,1 602,0 633,1 642,0 723,1 819,0 886,1 983,0 1004,1 1092,0 1138,1 1139,0 1213,1 1238,0 1279,1 1301,0 1376,1 1475,0 1573,1 1581,0 1605,1 1675,0 1767,1 1834,0 1860,1 1893,0 1982,1 2073,0 2081,1 2113,0 2164,1 2216,0 2312,1 2397,0 2407,1 2426,0 2522,1 2572,0 2575,1 2660,0 2679,1 2729,0 2790,1 2874,0 2896,1 2930,0 2964,1 3005,0 3027,1 3098,0 3138,1 3215,0 3254,1 3344,0 3410,1 3468,0 3548,1 3638,0 3738,1 3828,0 3854,1 3888,0 3931,1 3988,0 4035,1 4111,0 4149,1 4188,0 4282,1 4352,0 4356,1 4402,0 4477,1 4544,0 4623,1 4716,0 4799,1 4893,0 4970,1 5021,0 5025,1 5031,0 5074,1 5157,0 5211,1 5253,0 5301,1 5304,0 5324,1 5329,0 5377,1 5462,0 5504,1 5556,0 5652,1 5693,0 5791,1 5798,0 5859,1 5904,0 5916,1 5936,0 5973,1 6046,0 6121,1 6217,0 6219,1 6317,0 6341,1 6434,0 6484,1 6566,0 6642,1 6682,0 6748,1 6761,0 6787,1 6886,0 6912,1 6935,0 6983,1 7017,0 7033,1 7125,0 7126,1 7168,0 7199,1 7253,0 7326,1 7380,0 7404,1 7471,0 7488,1 7550,0 7627,1 7688,0 7708,1 7732,0 7832,1 7902,0 8000,1 8005,0 8006,1 8098,0 8195,1 8249,0 8328,1 8388,0 8450,1 8470,0 8506,1 8582,0 8606,1 8686,0 8751,1 8800,0 8877,1 8931,0 8988,1 9021,0 9085,1 9108,0 9139,1 9194,0 9243,1 9333,0 9367,1 9454,0 9489,1 9556,0 9570,1 9575,0 9579,1 9606,0 9633,1 9705,0 9797,1 9817,0 9909,1 9981,0 9986,1 9990,0 10049,1 10059,0 10114,1 10154,0 10238,1 10303,0 10308,1 10316,0 10333,1 10374,0 10375,1 10438,0 10449,1 10466,0 10477,1 10494,0 10580,1 10637,0 10737,1 10828,0 10842,1 10861,0 10911,1 11003,0 11048,1 11090,0 11188,1 11275,0 11374,1 11463,0 11543,1 11573,0 11633,1 11663,0 11687,1 11695,0 11705,1 11782,0 11818,1 11877,0 11915,1 11941,0 11973,1 11998,0 12095,1 12174,0 12214,1 12292,0 12370,1 12461,0 12500,1 12599,0 12638,1 12721,0 12775,1 12780,0 12860,1 12935,0 12978,1 13020,0 13087,1 13117,0 13177,1 13204,0 13213,1 13214,0 13224,1 13280,0 13344,1 end initlist a109 0,0 72,1 129,0 142,1 170,0 206,1 266,0 303,1 402,0 407,1 424,0 512,1 550,0 621,1 658,0 689,1 786,0 820,1 879,0 930,1 969,0 987,1 1086,0 1179,1 1232,0 1305,1 1386,0 1424,1 1473,0 1533,1 1589,0 1660,1 1720,0 1726,1 1774,0 1813,1 1892,0 1940,1 2021,0 2042,1 2050,0 2094,1 2157,0 2169,1 2223,0 2245,1 2264,0 2298,1 2344,0 2365,1 2449,0 2471,1 2474,0 2520,1 2588,0 2632,1 2691,0 2766,1 2840,0 2846,1 2897,0 2974,1 3002,0 3071,1 3110,0 3192,1 3196,0 3226,1 3247,0 3311,1 3391,0 3412,1 3497,0 3544,1 3611,0 3705,1 3772,0 3838,1 3885,0 3930,1 3965,0 3996,1 4076,0 4100,1 4103,0 4109,1 4160,0 4247,1 4255,0 4347,1 4412,0 4472,1 4478,0 4492,1 4501,0 4557,1 4624,0 4665,1 4745,0 4802,1 4878,0 4893,1 4922,0 5002,1 5079,0 5175,1 5185,0 5281,1 5310,0 5313,1 5398,0 5437,1 5468,0 5516,1 5551,0 5647,1 5666,0 5765,1 5803,0 5877,1 5952,0 5989,1 6063,0 6083,1 6095,0 6133,1 6230,0 6312,1 6370,0 6470,1 6488,0 6565,1 6630,0 6661,1 6703,0 6728,1 6752,0 6759,1 6773,0 6871,1 6948,0 7009,1 7091,0 7092,1 7185,0 7277,1 7353,0 7361,1 7418,0 7464,1 7555,0 7580,1 7606,0 7646,1 7727,0 7826,1 7917,0 7948,1 7988,0 8020,1 8083,0 8089,1 8177,0 8206,1 8226,0 8247,1 8285,0 8385,1 8476,0 8528,1 8615,0 8618,1 8682,0 8765,1 8789,0 8839,1 8887,0 8977,1 8996,0 9081,1 9134,0 9234,1 9282,0 9287,1 9299,0 9343,1 9352,0 9387,1 9394,0 9445,1 9505,0 9516,1 9605,0 9640,1 9650,0 9740,1 9783,0 9803,1 9855,0 9860,1 9956,0 10006,1 10100,0 10110,1 10128,0 10207,1 10305,0 10399,1 10402,0 10432,1 10452,0 10540,1 10596,0 10633,1 10639,0 10674,1 10751,0 10753,1 10812,0 10817,1 10834,0 10930,1 10958,0 11028,1 11105,0 11117,1 11216,0 11230,1 11300,0 11347,1 11405,0 11497,1 11549,0 11624,1 11653,0 11743,1 11791,0 11797,1 11828,0 11868,1 11931,0 11976,1 12051,0 12087,1 12120,0 12207,1 12249,0 12333,1 12353,0 12364,1 12423,0 12505,1 12514,0 12530,1 12554,0 12570,1 12580,0 12657,1 end initlist a110 0,0 76,1 105,0 190,1 211,0 254,1 313,0 327,1 364,0 371,1 392,0 474,1 501,0 542,1 568,0 653,1 732,0 748,1 838,0 895,1 958,0 965,1 1044,0 1111,1 1157,0 1236,1 1300,0 1385,1 1412,0 1456,1 1533,0 1619,1 1678,0 1695,1 1722,0 1764,1 1864,0 1951,1 1953,0 1993,1 2071,0 2124,1 2166,0 2221,1 2313,0 2372,1 2387,0 2423,1 2511,0 2570,1 2627,0 2643,1 2652,0 2705,1 2712,0 2713,1 2751,0 2803,1 2855,0 2888,1 2958,0 3054,1 3098,0 3114,1 3127,0 3189,1 3190,0 3217,1 3291,0 3390,1 3454,0 3502,1 3541,0 3566,1 3620,0 3642,1 3739,0 3806,1 3816,0 3904,1 3920,0 3970,1 4043,0 4046,1 4101,0 4140,1 4174,0 4273,1 4315,0 4373,1 4376,0 4408,1 4490,0 4534,1 4596,0 4684,1 4739,0 4794,1 4875,0 4908,1 4982,0 5041,1 5090,0 5091,1 5137,0 5159,1 5200,0 5229,1 5291,0 5294,1 5325,0 5344,1 5349,0 5404,1 5410,0 5443,1 5540,0 5611,1 5623,0 5652,1 5702,0 5724,1 5745,0 5802,1 5805,0 5846,1 5855,0 5913,1 5974,0 6031,1 6046,0 6131,1 6178,0 6186,1 6210,0 6285,1 6354,0 6382,1 6427,0 6428,1 6523,0 6607,1 6614,0 6668,1 6762,0 6823,1 6851,0 6885,1 6955,0 6970,1 6976,0 7030,1 7035,0 7103,1 7135,0 7146,1 7240,0 7241,1 7259,0 7261,1 7327,0 7411,1 7460,0 7520,1 7556,0 7612,1 7702,0 7765,1 7854,0 7898,1 7952,0 8047,1 8119,0 8217,1 8255,0 8350,1 8388,0 8399,1 8416,0 8484,1 8541,0 8585,1 8590,0 8683,1 8731,0 8818,1 8915,0 8975,1 8978,0 9049,1 9139,0 9239,1 9267,0 9279,1 9334,0 9403,1 9438,0 9471,1 9519,0 9577,1 9628,0 9685,1 9733,0 9797,1 9891,0 9905,1 9979,0 9992,1 10008,0 10054,1 10072,0 10100,1 10191,0 10259,1 10319,0 10415,1 10483,0 10554,1 10558,0 10651,1 10678,0 10720,1 10762,0 10846,1 10935,0 10953,1 11006,0 11036,1 11076,0 11127,1 11142,0 11214,1 11233,0 11326,1 11381,0 11471,1 11549,0 11603,1 11653,0 11674,1 11745,0 11843,1 11885,0 11943,1 12030,0 12118,1 12119,0 12187,1 12281,0 12328,1 12425,0 12511,1 12542,0 12592,1 12648,0 12656,1 12755,0 12837,1 end initlist a111 0,0 84,1 90,0 173,1 192,0 248,1 290,0 299,1 305,0 370,1 400,0 408,1 497,0 550,1 650,0 674,1 749,0 777,1 837,0 904,1 940,0 1022,1 1031,0 1108,1 1194,0 1290,1 1385,0 1448,1 1475,0 1538,1 1624,0 1671,1 1692,0 1771,1 1803,0 1864,1 1929,0 1985,1 2044,0 2090,1 2146,0 2208,1 2232,0 2261,1 2262,0 2300,1 2318,0 2349,1 2350,0 2376,1 2392,0 2413,1 2453,0 2456,1 2466,0 2488,1 2501,0 2542,1 2582,0 2600,1 2633,0 2651,1 2709,0 2753,1 2847,0 2919,1 2922,0 2960,1 2972,0 2977,1 3065,0 3140,1 3161,0 3162,1 3182,0 3281,1 3343,0 3417,1 3512,0 3526,1 3575,0 3633,1 3726,0 3784,1 3854,0 3918,1 3971,0 3978,1 4059,0 4086,1 4119,0 4127,1 4172,0 4188,1 4208,0 4224,1 4255,0 4271,1 4330,0 4389,1 4447,0 4480,1 4504,0 4513,1 4611,0 4621,1 4685,0 4765,1 4842,0 4890,1 4958,0 4979,1 5007,0 5104,1 5182,0 5277,1 5297,0 5391,1 5468,0 5528,1 5588,0 5665,1 5758,0 5838,1 5861,0 5864,1 5938,0 5993,1 6031,0 6074,1 6098,0 6118,1 6131,0 6175,1 6194,0 6226,1 6263,0 6305,1 6405,0 6503,1 6556,0 6642,1 6733,0 6811,1 6878,0 6899,1 6982,0 7008,1 7069,0 7080,1 7126,0 7135,1 7217,0 7308,1 7407,0 7435,1 7469,0 7490,1 7549,0 7619,1 7639,0 7660,1 7707,0 7771,1 7812,0 7829,1 7885,0 7912,1 7977,0 8017,1 8059,0 8090,1 8115,0 8161,1 8207,0 8272,1 8318,0 8406,1 8489,0 8532,1 8563,0 8623,1 8697,0 8794,1 8796,0 8830,1 8864,0 8934,1 8991,0 9042,1 9129,0 9133,1 9219,0 9276,1 9372,0 9395,1 9449,0 9540,1 9636,0 9711,1 9752,0 9814,1 9866,0 9932,1 9943,0 9959,1 10044,0 10118,1 10148,0 10231,1 10257,0 10290,1 10291,0 10370,1 10439,0 10517,1 10534,0 10549,1 10615,0 10621,1 10654,0 10750,1 10814,0 10866,1 10938,0 10943,1 10992,0 11082,1 11098,0 11121,1 11187,0 11257,1 11259,0 11275,1 11366,0 11460,1 11484,0 11573,1 11650,0 11749,1 11793,0 11879,1 11951,0 11966,1 12040,0 12081,1 12101,0 12163,1 12259,0 12348,1 12374,0 12421,1 12435,0 12483,1 12504,0 12538,1 12575,0 12583,1 end initlist a112 0,0 42,1 82,0 178,1 213,0 235,1 237,0 283,1 335,0 408,1 473,0 482,1 528,0 625,1 636,0 695,1 712,0 723,1 797,0 859,1 889,0 893,1 944,0 1022,1 1073,0 1087,1 1113,0 1161,1 1163,0 1188,1 1266,0 1355,1 1406,0 1427,1 1499,0 1534,1 1557,0 1611,1 1675,0 1771,1 1839,0 1840,1 1922,0 1965,1 1977,0 1988,1 2052,0 2068,1 2165,0 2172,1 2189,0 2284,1 2378,0 2424,1 2451,0 2520,1 2587,0 2590,1 2662,0 2718,1 2783,0 2786,1 2847,0 2927,1 2979,0 3014,1 3024,0 3080,1 3147,0 3214,1 3238,0 3245,1 3318,0 3413,1 3475,0 3531,1 3554,0 3562,1 3635,0 3687,1 3775,0 3789,1 3822,0 3828,1 3849,0 3936,1 3959,0 3972,1 4055,0 4137,1 4218,0 4274,1 4370,0 4411,1 4463,0 4485,1 4537,0 4584,1 4607,0 4699,1 4789,0 4887,1 4903,0 4955,1 5015,0 5021,1 5046,0 5063,1 5119,0 5147,1 5189,0 5266,1 5312,0 5339,1 5419,0 5471,1 5472,0 5486,1 5532,0 5599,1 5670,0 5751,1 5782,0 5861,1 5906,0 5907,1 5922,0 6011,1 6069,0 6149,1 6245,0 6302,1 6334,0 6353,1 6358,0 6409,1 6449,0 6480,1 6538,0 6579,1 6667,0 6699,1 6753,0 6803,1 6862,0 6867,1 6931,0 6943,1 6953,0 7046,1 7139,0 7178,1 7241,0 7288,1 7298,0 7320,1 7347,0 7359,1 7378,0 7403,1 7477,0 7557,1 7584,0 7618,1 7679,0 7745,1 7809,0 7892,1 7975,0 8068,1 8074,0 8130,1 8135,0 8206,1 8215,0 8313,1 8407,0 8428,1 8484,0 8497,1 8578,0 8642,1 8649,0 8686,1 8705,0 8805,1 8884,0 8887,1 8980,0 9061,1 9161,0 9203,1 9290,0 9310,1 9389,0 9394,1 9400,0 9460,1 9487,0 9523,1 9545,0 9592,1 9630,0 9728,1 9764,0 9767,1 9796,0 9837,1 9863,0 9954,1 10049,0 10087,1 10179,0 10222,1 10256,0 10337,1 10412,0 10442,1 10494,0 10544,1 10584,0 10653,1 10689,0 10722,1 10768,0 10779,1 10826,0 10926,1 10954,0 11009,1 11063,0 11101,1 11169,0 11203,1 11235,0 11302,1 11357,0 11455,1 11465,0 11529,1 11614,0 11641,1 11674,0 11742,1 11787,0 11867,1 11883,0 11906,1 11935,0 12024,1 12035,0 12119,1 12127,0 12224,1 12300,0 12362,1 12452,0 12517,1 end initlist a113 0,0 88,1 176,0 178,1 247,0 322,1 356,0 432,1 494,0 544,1 643,0 735,1 832,0 873,1 955,0 1030,1 1101,0 1162,1 1260,0 1320,1 1354,0 1441,1 1477,0 1493,1 1509,0 1542,1 1595,0 1618,1 1633,0 1705,1 1779,0 1852,1 1911,0 1974,1 2057,0 2112,1 2168,0 2209,1 2249,0 2282,1 2328,0 2348,1 2361,0 2375,1 2435,0 2503,1 2568,0 2585,1 2640,0 2719,1 2802,0 2863,1 2952,0 2957,1 2958,0 2968,1 3025,0 3085,1 3129,0 3159,1 3257,0 3330,1 3414,0 3450,1 3502,0 3548,1 3648,0 3744,1 3791,0 3845,1 3884,0 3981,1 4045,0 4053,1 4120,0 4142,1 4209,0 4233,1 4282,0 4345,1 4376,0 4431,1 4503,0 4587,1 4687,0 4769,1 4836,0 4851,1 4867,0 4941,1 4993,0 5056,1 5060,0 5086,1 5176,0 5253,1 5350,0 5386,1 5403,0 5420,1 5461,0 5473,1 5535,0 5584,1 5659,0 5669,1 5758,0 5772,1 5779,0 5789,1 5794,0 5830,1 5870,0 5881,1 5942,0 6001,1 6079,0 6140,1 6162,0 6251,1 6258,0 6276,1 6308,0 6322,1 6386,0 6410,1 6461,0 6528,1 6549,0 6593,1 6687,0 6767,1 6833,0 6857,1 6859,0 6862,1 6921,0 6939,1 6958,0 7020,1 7037,0 7075,1 7082,0 7113,1 7162,0 7176,1 7212,0 7240,1 7334,0 7414,1 7427,0 7486,1 7523,0 7547,1 7645,0 7679,1 7714,0 7792,1 7892,0 7954,1 8042,0 8130,1 8224,0 8293,1 8373,0 8414,1 8435,0 8466,1 8473,0 8485,1 8510,0 8568,1 8586,0 8608,1 8648,0 8705,1 8721,0 8807,1 8847,0 8890,1 8931,0 9018,1 9113,0 9171,1 9250,0 9331,1 9343,0 9376,1 9447,0 9472,1 9498,0 9567,1 9593,0 9637,1 9696,0 9737,1 9788,0 9853,1 9939,0 9976,1 10020,0 10051,1 10082,0 10157,1 10248,0 10287,1 10304,0 10335,1 10372,0 10393,1 10414,0 10494,1 10589,0 10634,1 10662,0 10724,1 10814,0 10832,1 10850,0 10864,1 10940,0 11002,1 11078,0 11178,1 11234,0 11256,1 11353,0 11385,1 11460,0 11523,1 11622,0 11678,1 11778,0 11842,1 11859,0 11948,1 12003,0 12032,1 12070,0 12080,1 12093,0 12114,1 12127,0 12174,1 12222,0 12305,1 12395,0 12443,1 12454,0 12475,1 12543,0 12545,1 12614,0 12635,1 12675,0 12753,1 12816,0 12914,1 end initlist a114 0,0 15,1 80,0 155,1 221,0 276,1 372,0 375,1 396,0 427,1 457,0 544,1 614,0 665,1 751,0 753,1 790,0 882,1 892,0 929,1 968,0 1019,1 1067,0 1082,1 1146,0 1235,1 1252,0 1269,1 1332,0 1382,1 1427,0 1508,1 1563,0 1629,1 1642,0 1671,1 1745,0 1836,1 1841,0 1882,1 1908,0 1986,1 2069,0 2109,1 2204,0 2267,1 2276,0 2363,1 2398,0 2466,1 2469,0 2509,1 2559,0 2618,1 2647,0 2682,1 2764,0 2808,1 2836,0 2936,1 2954,0 3013,1 3018,0 3041,1 3141,0 3184,1 3249,0 3339,1 3377,0 3451,1 3539,0 3565,1 3651,0 3665,1 3680,0 3684,1 3761,0 3808,1 3885,0 3917,1 3974,0 4028,1 4088,0 4161,1 4198,0 4286,1 4348,0 4385,1 4433,0 4468,1 4528,0 4563,1 4603,0 4646,1 4723,0 4739,1 4818,0 4904,1 4947,0 4978,1 5037,0 5106,1 5140,0 5176,1 5267,0 5286,1 5354,0 5418,1 5476,0 5571,1 5622,0 5684,1 5702,0 5765,1 5801,0 5852,1 5879,0 5973,1 6002,0 6087,1 6187,0 6286,1 6370,0 6399,1 6414,0 6487,1 6574,0 6656,1 6720,0 6755,1 6786,0 6863,1 6915,0 6965,1 6975,0 7034,1 7111,0 7193,1 7254,0 7260,1 7311,0 7390,1 7433,0 7444,1 7533,0 7622,1 7669,0 7723,1 7802,0 7837,1 7844,0 7883,1 7951,0 8000,1 8049,0 8146,1 8219,0 8239,1 8300,0 8331,1 8380,0 8478,1 8523,0 8593,1 8632,0 8720,1 8777,0 8790,1 8820,0 8872,1 8939,0 8952,1 9031,0 9086,1 9115,0 9127,1 9149,0 9165,1 9256,0 9306,1 9351,0 9352,1 9442,0 9487,1 9538,0 9636,1 9646,0 9652,1 9717,0 9735,1 9800,0 9896,1 9910,0 9977,1 9993,0 10011,1 10012,0 10099,1 10152,0 10225,1 10275,0 10287,1 10288,0 10302,1 10396,0 10457,1 10479,0 10531,1 10590,0 10597,1 10599,0 10633,1 10666,0 10675,1 10677,0 10745,1 10841,0 10881,1 10972,0 11057,1 11094,0 11165,1 11204,0 11284,1 11378,0 11419,1 11441,0 11516,1 11569,0 11666,1 11741,0 11803,1 11856,0 11873,1 11943,0 11964,1 11988,0 12063,1 12149,0 12207,1 12289,0 12314,1 12390,0 12403,1 12412,0 12414,1 12447,0 12456,1 12480,0 12493,1 12533,0 12588,1 12652,0 12667,1 12752,0 12794,1 12812,0 12815,1 end initlist a115 0,0 28,1 33,0 124,1 193,0 227,1 290,0 332,1 379,0 431,1 453,0 463,1 527,0 530,1 592,0 638,1 669,0 698,1 708,0 802,1 821,0 894,1 959,0 1018,1 1025,0 1056,1 1093,0 1190,1 1207,0 1250,1 1347,0 1404,1 1412,0 1485,1 1566,0 1619,1 1710,0 1720,1 1808,0 1810,1 1846,0 1870,1 1925,0 1991,1 2073,0 2153,1 2244,0 2301,1 2315,0 2349,1 2366,0 2373,1 2438,0 2503,1 2578,0 2588,1 2654,0 2702,1 2778,0 2833,1 2874,0 2899,1 2963,0 2996,1 3013,0 3081,1 3142,0 3195,1 3263,0 3312,1 3378,0 3454,1 3463,0 3485,1 3528,0 3553,1 3623,0 3635,1 3666,0 3698,1 3701,0 3788,1 3857,0 3858,1 3911,0 3971,1 3982,0 4030,1 4064,0 4081,1 4111,0 4146,1 4185,0 4219,1 4232,0 4283,1 4325,0 4364,1 4375,0 4408,1 4488,0 4562,1 4660,0 4723,1 4817,0 4871,1 4885,0 4900,1 4907,0 4988,1 5013,0 5112,1 5113,0 5158,1 5219,0 5260,1 5312,0 5406,1 5462,0 5495,1 5581,0 5608,1 5699,0 5768,1 5787,0 5833,1 5898,0 5976,1 6022,0 6102,1 6194,0 6277,1 6358,0 6408,1 6422,0 6510,1 6555,0 6595,1 6667,0 6689,1 6736,0 6754,1 6793,0 6879,1 6892,0 6894,1 6976,0 7058,1 7151,0 7206,1 7220,0 7270,1 7284,0 7371,1 7440,0 7536,1 7568,0 7637,1 7735,0 7786,1 7830,0 7889,1 7986,0 8066,1 8150,0 8213,1 8224,0 8230,1 8271,0 8277,1 8338,0 8411,1 8436,0 8527,1 8594,0 8640,1 8731,0 8770,1 8780,0 8864,1 8961,0 9046,1 9070,0 9156,1 9249,0 9335,1 9432,0 9514,1 9551,0 9620,1 9622,0 9657,1 9721,0 9747,1 9810,0 9910,1 9993,0 10049,1 10145,0 10220,1 10311,0 10322,1 10400,0 10413,1 10455,0 10523,1 10621,0 10690,1 10753,0 10853,1 10856,0 10882,1 10935,0 10998,1 10999,0 11011,1 11108,0 11187,1 11201,0 11258,1 11345,0 11428,1 11461,0 11465,1 11476,0 11548,1 11564,0 11611,1 11667,0 11741,1 11833,0 11887,1 11906,0 11923,1 11999,0 12008,1 12022,0 12114,1 12137,0 12175,1 12273,0 12324,1 12389,0 12452,1 12465,0 12494,1 12568,0 12580,1 12587,0 12664,1 12720,0 12820,1 12911,0 12990,1 13015,0 13090,1 13174,0 13269,1 end initlist a116 0,0 2,1 46,0 59,1 136,0 201,1 281,0 340,1 341,0 362,1 393,0 403,1 446,0 458,1 521,0 561,1 628,0 632,1 707,0 753,1 839,0 896,1 915,0 975,1 1047,0 1078,1 1110,0 1207,1 1221,0 1321,1 1386,0 1389,1 1411,0 1463,1 1520,0 1543,1 1590,0 1599,1 1668,0 1687,1 1694,0 1731,1 1801,0 1844,1 1855,0 1873,1 1936,0 2022,1 2113,0 2172,1 2237,0 2247,1 2290,0 2306,1 2399,0 2487,1 2534,0 2537,1 2608,0 2660,1 2705,0 2735,1 2739,0 2822,1 2849,0 2872,1 2950,0 3032,1 3104,0 3155,1 3244,0 3306,1 3346,0 3445,1 3485,0 3546,1 3589,0 3653,1 3682,0 3710,1 3744,0 3777,1 3822,0 3895,1 3931,0 4001,1 4007,0 4013,1 4058,0 4117,1 4205,0 4290,1 4321,0 4324,1 4385,0 4410,1 4418,0 4504,1 4533,0 4597,1 4626,0 4644,1 4710,0 4767,1 4867,0 4891,1 4894,0 4976,1 4996,0 5043,1 5069,0 5111,1 5150,0 5228,1 5298,0 5354,1 5447,0 5534,1 5608,0 5696,1 5704,0 5788,1 5809,0 5868,1 5949,0 5989,1 6027,0 6076,1 6142,0 6221,1 6257,0 6265,1 6294,0 6308,1 6366,0 6412,1 6468,0 6474,1 6558,0 6593,1 6686,0 6715,1 6800,0 6840,1 6925,0 7024,1 7091,0 7125,1 7198,0 7210,1 7300,0 7386,1 7456,0 7470,1 7567,0 7625,1 7631,0 7641,1 7715,0 7760,1 7801,0 7813,1 7838,0 7937,1 8010,0 8082,1 8140,0 8218,1 8284,0 8330,1 8343,0 8383,1 8438,0 8487,1 8523,0 8590,1 8656,0 8659,1 8666,0 8714,1 8759,0 8852,1 8860,0 8904,1 8944,0 8957,1 8967,0 9002,1 9015,0 9023,1 9029,0 9093,1 9136,0 9174,1 9256,0 9327,1 9395,0 9405,1 9475,0 9537,1 9565,0 9596,1 9645,0 9744,1 9819,0 9831,1 9846,0 9916,1 10010,0 10083,1 10148,0 10223,1 10282,0 10321,1 10350,0 10398,1 10417,0 10425,1 10432,0 10525,1 10625,0 10646,1 10703,0 10734,1 10778,0 10850,1 10882,0 10896,1 10946,0 11003,1 11019,0 11104,1 11194,0 11294,1 11334,0 11358,1 11420,0 11429,1 11460,0 11557,1 11644,0 11726,1 11763,0 11780,1 11815,0 11890,1 11920,0 12000,1 12017,0 12079,1 12103,0 12136,1 12226,0 12282,1 12352,0 12449,1 12521,0 12604,1 end initlist a117 0,0 96,1 195,0 266,1 358,0 367,1 421,0 493,1 564,0 620,1 692,0 783,1 791,0 887,1 967,0 1049,1 1077,0 1118,1 1163,0 1216,1 1241,0 1248,1 1253,0 1257,1 1357,0 1396,1 1431,0 1508,1 1571,0 1639,1 1650,0 1708,1 1731,0 1787,1 1793,0 1885,1 1934,0 1996,1 2091,0 2158,1 2204,0 2269,1 2296,0 2361,1 2440,0 2456,1 2502,0 2528,1 2551,0 2613,1 2668,0 2736,1 2836,0 2887,1 2938,0 2994,1 3063,0 3139,1 3140,0 3143,1 3164,0 3238,1 3271,0 3357,1 3397,0 3492,1 3567,0 3605,1 3636,0 3699,1 3778,0 3822,1 3898,0 3976,1 4053,0 4091,1 4182,0 4236,1 4242,0 4342,1 4432,0 4532,1 4621,0 4636,1 4645,0 4686,1 4723,0 4763,1 4828,0 4841,1 4874,0 4919,1 4928,0 4963,1 5028,0 5121,1 5145,0 5199,1 5251,0 5312,1 5409,0 5491,1 5503,0 5525,1 5539,0 5577,1 5619,0 5684,1 5718,0 5755,1 5832,0 5849,1 5868,0 5921,1 5985,0 6030,1 6103,0 6180,1 6272,0 6364,1 6439,0 6491,1 6567,0 6607,1 6652,0 6675,1 6699,0 6782,1 6813,0 6875,1 6944,0 7009,1 7067,0 7117,1 7159,0 7228,1 7242,0 7321,1 7329,0 7353,1 7378,0 7427,1 7512,0 7557,1 7584,0 7680,1 7742,0 7788,1 7861,0 7878,1 7889,0 7921,1 8019,0 8111,1 8202,0 8219,1 8236,0 8273,1 8308,0 8391,1 8441,0 8521,1 8528,0 8568,1 8605,0 8672,1 8707,0 8757,1 8788,0 8818,1 8911,0 8970,1 9007,0 9072,1 9166,0 9190,1 9276,0 9286,1 9323,0 9329,1 9411,0 9472,1 9484,0 9561,1 9643,0 9705,1 9805,0 9869,1 9942,0 10019,1 10082,0 10091,1 10135,0 10151,1 10152,0 10205,1 10248,0 10324,1 10392,0 10397,1 10458,0 10543,1 10577,0 10672,1 10675,0 10747,1 10766,0 10854,1 10903,0 11000,1 11071,0 11119,1 11167,0 11212,1 11242,0 11329,1 11362,0 11419,1 11471,0 11475,1 11480,0 11503,1 11568,0 11653,1 11683,0 11747,1 11771,0 11822,1 11841,0 11919,1 12006,0 12093,1 12172,0 12189,1 12190,0 12272,1 12321,0 12345,1 12409,0 12499,1 12539,0 12583,1 12641,0 12652,1 12710,0 12779,1 12780,0 12788,1 12831,0 12862,1 12928,0 12939,1 13030,0 13111,1 13196,0 13257,1 13297,0 13397,1 end initlist a118 0,0 18,1 48,0 134,1 139,0 228,1 244,0 267,1 336,0 361,1 458,0 465,1 552,0 601,1 637,0 685,1 766,0 801,1 810,0 851,1 896,0 897,1 950,0 1043,1 1046,0 1144,1 1170,0 1209,1 1252,0 1315,1 1407,0 1421,1 1433,0 1532,1 1630,0 1701,1 1736,0 1801,1 1805,0 1877,1 1955,0 2022,1 2105,0 2152,1 2178,0 2236,1 2245,0 2331,1 2413,0 2443,1 2473,0 2542,1 2620,0 2682,1 2758,0 2827,1 2834,0 2915,1 2935,0 3013,1 3020,0 3112,1 3125,0 3203,1 3293,0 3301,1 3316,0 3355,1 3422,0 3485,1 3571,0 3643,1 3718,0 3810,1 3864,0 3960,1 4034,0 4104,1 4120,0 4170,1 4229,0 4305,1 4319,0 4406,1 4463,0 4503,1 4585,0 4645,1 4709,0 4795,1 4848,0 4903,1 4915,0 5003,1 5075,0 5132,1 5165,0 5208,1 5238,0 5323,1 5357,0 5378,1 5405,0 5464,1 5492,0 5578,1 5597,0 5673,1 5717,0 5740,1 5758,0 5800,1 5803,0 5829,1 5901,0 5938,1 6035,0 6109,1 6146,0 6212,1 6308,0 6371,1 6454,0 6539,1 6574,0 6579,1 6648,0 6713,1 6750,0 6779,1 6869,0 6924,1 7006,0 7020,1 7062,0 7081,1 7136,0 7209,1 7292,0 7313,1 7334,0 7388,1 7473,0 7572,1 7587,0 7625,1 7709,0 7735,1 7808,0 7895,1 7908,0 7987,1 8046,0 8145,1 8213,0 8312,1 8412,0 8477,1 8514,0 8551,1 8637,0 8714,1 8755,0 8773,1 8856,0 8924,1 9003,0 9059,1 9132,0 9215,1 9285,0 9308,1 9311,0 9385,1 9413,0 9495,1 9585,0 9652,1 9687,0 9760,1 9775,0 9852,1 9872,0 9966,1 9989,0 10045,1 10067,0 10114,1 10164,0 10202,1 10246,0 10279,1 10309,0 10380,1 10389,0 10448,1 10463,0 10560,1 10579,0 10678,1 10712,0 10732,1 10751,0 10806,1 10828,0 10843,1 10907,0 10975,1 11055,0 11075,1 11109,0 11116,1 11210,0 11266,1 11357,0 11433,1 11499,0 11528,1 11586,0 11587,1 11623,0 11647,1 11678,0 11769,1 11831,0 11884,1 11962,0 11997,1 12070,0 12072,1 12119,0 12121,1 12204,0 12277,1 12371,0 12388,1 12389,0 12405,1 12465,0 12473,1 12491,0 12513,1 12585,0 12630,1 12698,0 12777,1 12822,0 12880,1 12898,0 12973,1 13064,0 13073,1 13137,0 13235,1 13301,0 13343,1 13426,0 13461,1 end initlist a119 0,0 29,1 73,0 125,1 216,0 250,1 345,0 352,1 384,0 463,1 527,0 536,1 619,0 718,1 805,0 828,1 871,0 930,1 946,0 964,1 975,0 976,1 983,0 1001,1 1079,0 1104,1 1164,0 1218,1 1275,0 1320,1 1400,0 1477,1 1577,0 1669,1 1731,0 1791,1 1854,0 1936,1 1967,0 1971,1 2020,0 2106,1 2162,0 2207,1 2292,0 2320,1 2363,0 2419,1 2457,0 2555,1 2625,0 2666,1 2760,0 2837,1 2847,0 2871,1 2942,0 2944,1 3029,0 3097,1 3111,0 3113,1 3114,0 3165,1 3210,0 3269,1 3360,0 3362,1 3376,0 3473,1 3547,0 3596,1 3696,0 3738,1 3827,0 3838,1 3857,0 3898,1 3998,0 4068,1 4111,0 4157,1 4187,0 4231,1 4286,0 4318,1 4351,0 4380,1 4474,0 4503,1 4575,0 4622,1 4634,0 4697,1 4775,0 4781,1 4877,0 4977,1 5051,0 5139,1 5147,0 5159,1 5245,0 5324,1 5417,0 5503,1 5555,0 5582,1 5602,0 5630,1 5681,0 5683,1 5774,0 5782,1 5810,0 5894,1 5896,0 5996,1 6090,0 6125,1 6149,0 6225,1 6259,0 6266,1 6348,0 6363,1 6388,0 6454,1 6534,0 6581,1 6600,0 6626,1 6690,0 6730,1 6789,0 6853,1 6933,0 6990,1 7048,0 7079,1 7118,0 7180,1 7234,0 7289,1 7369,0 7382,1 7472,0 7482,1 7545,0 7607,1 7624,0 7661,1 7683,0 7732,1 7799,0 7858,1 7865,0 7886,1 7972,0 8002,1 8063,0 8142,1 8242,0 8267,1 8283,0 8370,1 8412,0 8421,1 8432,0 8520,1 8529,0 8543,1 8599,0 8662,1 8746,0 8784,1 8846,0 8875,1 8975,0 9035,1 9064,0 9079,1 9178,0 9232,1 9296,0 9320,1 9394,0 9471,1 9516,0 9556,1 9566,0 9665,1 9697,0 9774,1 9828,0 9916,1 10002,0 10078,1 10093,0 10136,1 10230,0 10309,1 10335,0 10387,1 10462,0 10547,1 10645,0 10728,1 10810,0 10873,1 10883,0 10932,1 10952,0 11025,1 11073,0 11153,1 11238,0 11312,1 11391,0 11485,1 11544,0 11546,1 11613,0 11624,1 11703,0 11784,1 11845,0 11870,1 11891,0 11941,1 12001,0 12030,1 12127,0 12219,1 12241,0 12306,1 12349,0 12439,1 12489,0 12506,1 12546,0 12637,1 12674,0 12691,1 12754,0 12824,1 12872,0 12952,1 12961,0 13002,1 13007,0 13057,1 13150,0 13237,1 13269,0 13322,1 13412,0 13419,1 end initlist a120 0,0 25,1 60,0 122,1 200,0 272,1 335,0 388,1 408,0 443,1 513,0 568,1 611,0 634,1 660,0 666,1 742,0 743,1 815,0 913,1 1003,0 1089,1 1184,0 1274,1 1288,0 1328,1 1384,0 1443,1 1495,0 1512,1 1604,0 1650,1 1730,0 1757,1 1782,0 1841,1 1872,0 1944,1 1952,0 1968,1 2041,0 2043,1 2117,0 2206,1 2297,0 2307,1 2369,0 2418,1 2443,0 2493,1 2576,0 2662,1 2667,0 2676,1 2691,0 2727,1 2768,0 2837,1 2861,0 2945,1 3015,0 3090,1 3162,0 3210,1 3228,0 3317,1 3412,0 3440,1 3523,0 3585,1 3684,0 3692,1 3733,0 3734,1 3780,0 3794,1 3861,0 3875,1 3919,0 3948,1 3967,0 3993,1 4072,0 4125,1 4164,0 4206,1 4243,0 4299,1 4346,0 4444,1 4449,0 4499,1 4515,0 4561,1 4591,0 4628,1 4662,0 4665,1 4719,0 4770,1 4832,0 4911,1 4998,0 5020,1 5097,0 5122,1 5161,0 5196,1 5269,0 5364,1 5370,0 5469,1 5560,0 5581,1 5670,0 5702,1 5733,0 5765,1 5769,0 5843,1 5943,0 5976,1 6072,0 6073,1 6133,0 6213,1 6296,0 6334,1 6429,0 6505,1 6513,0 6528,1 6558,0 6648,1 6715,0 6735,1 6787,0 6816,1 6906,0 6924,1 7017,0 7052,1 7083,0 7149,1 7228,0 7301,1 7393,0 7438,1 7476,0 7542,1 7571,0 7645,1 7717,0 7779,1 7830,0 7877,1 7887,0 7985,1 8022,0 8026,1 8109,0 8144,1 8219,0 8223,1 8247,0 8332,1 8358,0 8442,1 8479,0 8487,1 8545,0 8586,1 8670,0 8724,1 8768,0 8834,1 8855,0 8904,1 8917,0 8994,1 9021,0 9024,1 9116,0 9133,1 9176,0 9264,1 9328,0 9352,1 9416,0 9444,1 9500,0 9587,1 9620,0 9676,1 9753,0 9768,1 9779,0 9800,1 9889,0 9949,1 9998,0 10046,1 10108,0 10135,1 10230,0 10268,1 10350,0 10352,1 10380,0 10447,1 10462,0 10554,1 10564,0 10645,1 10680,0 10761,1 10770,0 10837,1 10897,0 10965,1 10973,0 11059,1 11121,0 11219,1 11280,0 11325,1 11377,0 11418,1 11433,0 11483,1 11567,0 11624,1 11650,0 11656,1 11697,0 11707,1 11772,0 11796,1 11815,0 11904,1 12001,0 12013,1 12064,0 12108,1 12176,0 12216,1 12228,0 12301,1 12335,0 12424,1 12472,0 12502,1 12528,0 12558,1 12652,0 12656,1 12722,0 12766,1 end initlist a121 0,0 47,1 118,0 172,1 176,0 265,1 302,0 374,1 445,0 455,1 530,0 580,1 672,0 758,1 822,0 828,1 915,0 927,1 958,0 977,1 1000,0 1055,1 1125,0 1129,1 1201,0 1294,1 1300,0 1358,1 1414,0 1506,1 1517,0 1556,1 1650,0 1685,1 1742,0 1788,1 1856,0 1880,1 1945,0 1967,1 2008,0 2065,1 2099,0 2122,1 2143,0 2168,1 2172,0 2218,1 2276,0 2294,1 2333,0 2406,1 2498,0 2587,1 2615,0 2629,1 2630,0 2672,1 2691,0 2750,1 2816,0 2864,1 2949,0 2972,1 2988,0 2993,1 3090,0 3120,1 3125,0 3130,1 3173,0 3258,1 3346,0 3364,1 3441,0 3457,1 3500,0 3550,1 3557,0 3591,1 3620,0 3643,1 3671,0 3703,1 3721,0 3775,1 3793,0 3868,1 3941,0 4011,1 4018,0 4040,1 4120,0 4195,1 4247,0 4343,1 4402,0 4482,1 4573,0 4628,1 4700,0 4744,1 4754,0 4758,1 4804,0 4806,1 4864,0 4886,1 4952,0 4994,1 5082,0 5148,1 5168,0 5229,1 5242,0 5321,1 5406,0 5491,1 5528,0 5572,1 5662,0 5748,1 5814,0 5907,1 5932,0 5983,1 6030,0 6035,1 6091,0 6101,1 6113,0 6195,1 6276,0 6305,1 6330,0 6418,1 6492,0 6583,1 6640,0 6685,1 6781,0 6824,1 6851,0 6900,1 6974,0 7067,1 7157,0 7165,1 7244,0 7245,1 7286,0 7358,1 7412,0 7465,1 7558,0 7603,1 7665,0 7737,1 7774,0 7784,1 7833,0 7920,1 7958,0 8013,1 8077,0 8105,1 8117,0 8190,1 8236,0 8326,1 8403,0 8414,1 8438,0 8532,1 8574,0 8648,1 8706,0 8718,1 8763,0 8808,1 8886,0 8935,1 8983,0 9068,1 9088,0 9155,1 9249,0 9307,1 9396,0 9481,1 9569,0 9661,1 9689,0 9731,1 9744,0 9828,1 9899,0 9980,1 10071,0 10118,1 10143,0 10200,1 10213,0 10231,1 10251,0 10314,1 10320,0 10386,1 10486,0 10521,1 10539,0 10550,1 10580,0 10630,1 10704,0 10773,1 10819,0 10878,1 10968,0 11012,1 11097,0 11130,1 11145,0 11215,1 11250,0 11313,1 11382,0 11383,1 11455,0 11479,1 11548,0 11648,1 11701,0 11775,1 11834,0 11900,1 11981,0 12007,1 12099,0 12177,1 12199,0 12257,1 12309,0 12384,1 12429,0 12439,1 12476,0 12477,1 12569,0 12613,1 12691,0 12776,1 12807,0 12878,1 12947,0 13020,1 13096,0 13181,1 end initlist a122 0,0 64,1 86,0 93,1 185,0 211,1 262,0 288,1 291,0 381,1 384,0 472,1 503,0 572,1 633,0 638,1 644,0 725,1 772,0 826,1 858,0 938,1 1015,0 1044,1 1143,0 1243,1 1263,0 1332,1 1432,0 1442,1 1468,0 1477,1 1491,0 1584,1 1670,0 1693,1 1747,0 1791,1 1881,0 1974,1 2060,0 2140,1 2206,0 2236,1 2253,0 2267,1 2344,0 2389,1 2422,0 2445,1 2511,0 2606,1 2691,0 2772,1 2857,0 2950,1 3043,0 3109,1 3144,0 3185,1 3261,0 3281,1 3379,0 3417,1 3439,0 3450,1 3549,0 3613,1 3641,0 3687,1 3786,0 3817,1 3842,0 3934,1 3972,0 3996,1 4013,0 4094,1 4182,0 4239,1 4263,0 4268,1 4293,0 4358,1 4439,0 4513,1 4593,0 4638,1 4675,0 4757,1 4763,0 4826,1 4855,0 4949,1 5001,0 5073,1 5135,0 5163,1 5219,0 5272,1 5307,0 5382,1 5468,0 5521,1 5528,0 5531,1 5621,0 5721,1 5732,0 5820,1 5907,0 5962,1 6008,0 6091,1 6179,0 6276,1 6287,0 6337,1 6343,0 6424,1 6513,0 6546,1 6597,0 6676,1 6734,0 6812,1 6875,0 6876,1 6945,0 6966,1 7033,0 7055,1 7079,0 7151,1 7155,0 7237,1 7249,0 7260,1 7305,0 7398,1 7473,0 7530,1 7539,0 7619,1 7718,0 7723,1 7770,0 7775,1 7855,0 7937,1 7943,0 7987,1 8066,0 8136,1 8163,0 8219,1 8261,0 8343,1 8382,0 8419,1 8498,0 8509,1 8567,0 8601,1 8640,0 8651,1 8732,0 8793,1 8853,0 8919,1 8952,0 9047,1 9117,0 9191,1 9273,0 9290,1 9310,0 9381,1 9458,0 9508,1 9518,0 9540,1 9634,0 9724,1 9819,0 9874,1 9911,0 9961,1 9985,0 10026,1 10034,0 10101,1 10126,0 10182,1 10266,0 10324,1 10382,0 10406,1 10434,0 10473,1 10523,0 10610,1 10670,0 10678,1 10701,0 10704,1 10761,0 10810,1 10898,0 10925,1 10945,0 11019,1 11054,0 11075,1 11085,0 11137,1 11219,0 11227,1 11318,0 11336,1 11343,0 11396,1 11408,0 11478,1 11537,0 11558,1 11564,0 11593,1 11663,0 11741,1 11810,0 11890,1 11918,0 11921,1 11983,0 12050,1 12110,0 12125,1 12202,0 12302,1 12372,0 12429,1 12498,0 12560,1 12631,0 12659,1 12693,0 12754,1 12852,0 12862,1 12925,0 12930,1 12954,0 13010,1 13065,0 13117,1 13166,0 13221,1 end initlist a123 0,0 93,1 158,0 193,1 245,0 285,1 336,0 389,1 474,0 568,1 627,0 654,1 732,0 757,1 779,0 862,1 882,0 974,1 1041,0 1113,1 1117,0 1207,1 1272,0 1367,1 1381,0 1390,1 1455,0 1486,1 1581,0 1654,1 1696,0 1698,1 1737,0 1813,1 1883,0 1951,1 2011,0 2025,1 2061,0 2156,1 2246,0 2327,1 2336,0 2394,1 2455,0 2473,1 2539,0 2631,1 2703,0 2746,1 2809,0 2871,1 2890,0 2989,1 3088,0 3137,1 3141,0 3229,1 3297,0 3357,1 3379,0 3432,1 3437,0 3499,1 3554,0 3585,1 3677,0 3689,1 3767,0 3864,1 3898,0 3918,1 3925,0 3943,1 4015,0 4047,1 4137,0 4210,1 4303,0 4321,1 4358,0 4375,1 4434,0 4494,1 4562,0 4591,1 4655,0 4671,1 4738,0 4770,1 4812,0 4907,1 4986,0 5053,1 5071,0 5103,1 5122,0 5145,1 5211,0 5249,1 5262,0 5306,1 5374,0 5391,1 5403,0 5434,1 5512,0 5595,1 5623,0 5636,1 5719,0 5810,1 5879,0 5977,1 6020,0 6086,1 6145,0 6241,1 6291,0 6332,1 6350,0 6371,1 6460,0 6483,1 6509,0 6575,1 6635,0 6711,1 6743,0 6804,1 6817,0 6848,1 6924,0 6977,1 7067,0 7079,1 7098,0 7172,1 7266,0 7362,1 7366,0 7430,1 7497,0 7502,1 7556,0 7597,1 7690,0 7747,1 7779,0 7834,1 7898,0 7982,1 8005,0 8022,1 8066,0 8162,1 8210,0 8288,1 8354,0 8392,1 8490,0 8520,1 8549,0 8552,1 8553,0 8626,1 8725,0 8740,1 8795,0 8804,1 8840,0 8892,1 8958,0 9032,1 9100,0 9124,1 9133,0 9187,1 9195,0 9232,1 9274,0 9320,1 9331,0 9339,1 9428,0 9520,1 9535,0 9599,1 9601,0 9676,1 9677,0 9723,1 9788,0 9814,1 9831,0 9922,1 9988,0 10081,1 10123,0 10184,1 10196,0 10201,1 10297,0 10363,1 10447,0 10476,1 10541,0 10629,1 10649,0 10663,1 10674,0 10762,1 10838,0 10870,1 10948,0 11032,1 11081,0 11100,1 11150,0 11181,1 11227,0 11267,1 11355,0 11389,1 11411,0 11481,1 11508,0 11593,1 11651,0 11697,1 11738,0 11827,1 11861,0 11882,1 11905,0 11971,1 12040,0 12136,1 12190,0 12260,1 12331,0 12408,1 12478,0 12568,1 12604,0 12689,1 12751,0 12802,1 12809,0 12867,1 12964,0 13039,1 13052,0 13057,1 13120,0 13166,1 13195,0 13223,1 end initlist a124 0,0 25,1 63,0 104,1 194,0 289,1 389,0 470,1 488,0 499,1 571,0 628,1 679,0 730,1 761,0 786,1 816,0 912,1 947,0 995,1 1069,0 1082,1 1175,0 1263,1 1268,0 1357,1 1448,0 1507,1 1593,0 1674,1 1730,0 1830,1 1834,0 1904,1 1912,0 1985,1 1994,0 2008,1 2074,0 2100,1 2148,0 2199,1 2212,0 2308,1 2358,0 2434,1 2463,0 2547,1 2577,0 2630,1 2639,0 2687,1 2778,0 2795,1 2878,0 2919,1 2953,0 2967,1 2970,0 3029,1 3115,0 3166,1 3240,0 3252,1 3294,0 3326,1 3407,0 3422,1 3509,0 3533,1 3549,0 3579,1 3648,0 3734,1 3778,0 3782,1 3855,0 3940,1 3965,0 3969,1 4058,0 4107,1 4175,0 4264,1 4349,0 4437,1 4469,0 4517,1 4616,0 4642,1 4733,0 4818,1 4827,0 4849,1 4919,0 5000,1 5001,0 5008,1 5035,0 5037,1 5041,0 5043,1 5109,0 5156,1 5201,0 5227,1 5228,0 5256,1 5268,0 5356,1 5397,0 5488,1 5533,0 5568,1 5651,0 5672,1 5706,0 5714,1 5722,0 5812,1 5852,0 5876,1 5970,0 5984,1 6010,0 6100,1 6177,0 6229,1 6270,0 6346,1 6380,0 6477,1 6483,0 6570,1 6604,0 6614,1 6683,0 6752,1 6810,0 6884,1 6923,0 6926,1 6946,0 6998,1 7079,0 7166,1 7251,0 7346,1 7368,0 7443,1 7504,0 7517,1 7558,0 7638,1 7659,0 7693,1 7753,0 7826,1 7843,0 7903,1 7981,0 8041,1 8122,0 8128,1 8220,0 8241,1 8336,0 8381,1 8445,0 8532,1 8551,0 8593,1 8602,0 8608,1 8641,0 8671,1 8696,0 8697,1 8764,0 8810,1 8865,0 8957,1 8974,0 9032,1 9118,0 9157,1 9206,0 9283,1 9304,0 9397,1 9402,0 9410,1 9463,0 9489,1 9572,0 9660,1 9741,0 9803,1 9824,0 9893,1 9913,0 9925,1 9934,0 9957,1 10009,0 10024,1 10112,0 10191,1 10194,0 10258,1 10350,0 10442,1 10527,0 10598,1 10682,0 10764,1 10846,0 10905,1 10925,0 10969,1 11029,0 11052,1 11127,0 11134,1 11204,0 11282,1 11357,0 11368,1 11463,0 11489,1 11551,0 11565,1 11665,0 11749,1 11761,0 11773,1 11865,0 11933,1 12024,0 12070,1 12141,0 12178,1 12241,0 12252,1 12319,0 12397,1 12413,0 12467,1 12538,0 12567,1 12587,0 12649,1 12729,0 12787,1 12874,0 12920,1 12965,0 12968,1 end initlist a125 0,0 76,1 87,0 104,1 112,0 127,1 164,0 243,1 251,0 349,1 426,0 486,1 524,0 527,1 602,0 698,1 718,0 811,1 854,0 883,1 972,0 1065,1 1097,0 1099,1 1125,0 1200,1 1230,0 1279,1 1317,0 1368,1 1384,0 1411,1 1423,0 1504,1 1599,0 1668,1 1696,0 1722,1 1770,0 1833,1 1901,0 1996,1 2036,0 2071,1 2103,0 2157,1 2183,0 2211,1 2242,0 2278,1 2340,0 2418,1 2507,0 2576,1 2595,0 2605,1 2653,0 2668,1 2671,0 2757,1 2849,0 2885,1 2946,0 2974,1 2993,0 3034,1 3084,0 3151,1 3204,0 3288,1 3322,0 3356,1 3403,0 3462,1 3487,0 3557,1 3601,0 3651,1 3664,0 3670,1 3726,0 3748,1 3826,0 3834,1 3913,0 3936,1 3941,0 3985,1 4072,0 4125,1 4181,0 4226,1 4276,0 4371,1 4462,0 4489,1 4514,0 4581,1 4677,0 4773,1 4823,0 4880,1 4980,0 5055,1 5067,0 5149,1 5155,0 5214,1 5296,0 5334,1 5392,0 5455,1 5474,0 5521,1 5524,0 5575,1 5611,0 5691,1 5767,0 5861,1 5943,0 5986,1 6077,0 6146,1 6203,0 6276,1 6290,0 6376,1 6420,0 6446,1 6480,0 6530,1 6538,0 6542,1 6640,0 6660,1 6757,0 6857,1 6888,0 6967,1 7010,0 7072,1 7139,0 7209,1 7238,0 7318,1 7370,0 7403,1 7471,0 7513,1 7535,0 7620,1 7624,0 7671,1 7697,0 7740,1 7806,0 7844,1 7885,0 7912,1 7933,0 7987,1 8042,0 8052,1 8150,0 8188,1 8270,0 8361,1 8417,0 8459,1 8503,0 8582,1 8657,0 8737,1 8753,0 8818,1 8855,0 8867,1 8874,0 8944,1 8974,0 9060,1 9064,0 9123,1 9151,0 9228,1 9253,0 9269,1 9307,0 9389,1 9488,0 9525,1 9526,0 9594,1 9625,0 9700,1 9800,0 9866,1 9911,0 9963,1 9976,0 10050,1 10126,0 10167,1 10248,0 10321,1 10385,0 10418,1 10495,0 10514,1 10532,0 10598,1 10630,0 10695,1 10717,0 10742,1 10777,0 10830,1 10838,0 10866,1 10869,0 10929,1 10947,0 10973,1 11067,0 11159,1 11231,0 11267,1 11329,0 11404,1 11488,0 11538,1 11616,0 11701,1 11746,0 11828,1 11834,0 11844,1 11916,0 11985,1 11998,0 12085,1 12148,0 12200,1 12209,0 12294,1 12336,0 12434,1 12532,0 12568,1 12570,0 12668,1 12712,0 12800,1 12834,0 12846,1 12926,0 13008,1 end initlist a126 0,0 69,1 72,0 110,1 113,0 162,1 244,0 313,1 385,0 403,1 449,0 521,1 529,0 582,1 666,0 734,1 765,0 806,1 837,0 923,1 1008,0 1031,1 1035,0 1134,1 1205,0 1285,1 1306,0 1348,1 1428,0 1489,1 1551,0 1564,1 1629,0 1723,1 1790,0 1832,1 1878,0 1895,1 1936,0 2025,1 2089,0 2173,1 2192,0 2287,1 2335,0 2360,1 2366,0 2438,1 2519,0 2559,1 2624,0 2720,1 2804,0 2812,1 2894,0 2931,1 2937,0 2962,1 2989,0 3018,1 3073,0 3151,1 3210,0 3287,1 3365,0 3458,1 3487,0 3585,1 3638,0 3689,1 3777,0 3793,1 3837,0 3925,1 3964,0 4010,1 4097,0 4098,1 4114,0 4186,1 4259,0 4281,1 4337,0 4342,1 4383,0 4393,1 4433,0 4493,1 4523,0 4622,1 4666,0 4683,1 4751,0 4834,1 4861,0 4886,1 4907,0 4937,1 4990,0 5085,1 5149,0 5232,1 5237,0 5287,1 5299,0 5373,1 5407,0 5410,1 5433,0 5501,1 5581,0 5657,1 5748,0 5833,1 5919,0 5998,1 6073,0 6131,1 6148,0 6232,1 6307,0 6338,1 6369,0 6403,1 6423,0 6494,1 6572,0 6642,1 6646,0 6677,1 6767,0 6805,1 6836,0 6921,1 6998,0 7062,1 7106,0 7203,1 7252,0 7285,1 7345,0 7365,1 7382,0 7439,1 7459,0 7513,1 7549,0 7615,1 7616,0 7665,1 7762,0 7808,1 7851,0 7852,1 7863,0 7887,1 7975,0 8045,1 8063,0 8143,1 8166,0 8245,1 8270,0 8281,1 8357,0 8423,1 8476,0 8497,1 8592,0 8630,1 8638,0 8714,1 8736,0 8805,1 8871,0 8955,1 9013,0 9048,1 9122,0 9140,1 9169,0 9223,1 9247,0 9287,1 9384,0 9439,1 9506,0 9572,1 9611,0 9612,1 9688,0 9690,1 9701,0 9800,1 9898,0 9929,1 9970,0 10014,1 10042,0 10132,1 10229,0 10312,1 10367,0 10427,1 10494,0 10506,1 10587,0 10605,1 10634,0 10639,1 10659,0 10679,1 10752,0 10778,1 10854,0 10938,1 11014,0 11029,1 11079,0 11131,1 11191,0 11199,1 11296,0 11391,1 11423,0 11523,1 11565,0 11579,1 11653,0 11710,1 11726,0 11755,1 11852,0 11868,1 11906,0 11913,1 11970,0 12051,1 12086,0 12121,1 12178,0 12241,1 12314,0 12387,1 12414,0 12483,1 12520,0 12595,1 12673,0 12684,1 12726,0 12814,1 12883,0 12978,1 13027,0 13029,1 13073,0 13091,1 end initlist a127 0,0 99,1 130,0 132,1 183,0 225,1 295,0 392,1 462,0 532,1 614,0 634,1 675,0 720,1 737,0 781,1 801,0 828,1 906,0 954,1 961,0 989,1 1057,0 1112,1 1126,0 1164,1 1209,0 1261,1 1304,0 1398,1 1420,0 1428,1 1523,0 1579,1 1662,0 1706,1 1801,0 1817,1 1881,0 1909,1 1999,0 2029,1 2055,0 2123,1 2201,0 2207,1 2268,0 2274,1 2320,0 2358,1 2423,0 2430,1 2441,0 2476,1 2528,0 2620,1 2717,0 2790,1 2833,0 2902,1 2936,0 3021,1 3046,0 3108,1 3179,0 3231,1 3289,0 3297,1 3374,0 3409,1 3445,0 3471,1 3532,0 3581,1 3615,0 3629,1 3659,0 3712,1 3776,0 3791,1 3846,0 3933,1 3970,0 4024,1 4053,0 4150,1 4193,0 4282,1 4367,0 4443,1 4527,0 4622,1 4675,0 4692,1 4754,0 4795,1 4814,0 4826,1 4833,0 4865,1 4900,0 4964,1 5061,0 5111,1 5149,0 5175,1 5192,0 5229,1 5242,0 5263,1 5286,0 5384,1 5439,0 5529,1 5582,0 5619,1 5693,0 5787,1 5864,0 5885,1 5922,0 5989,1 5993,0 6020,1 6117,0 6118,1 6140,0 6213,1 6285,0 6329,1 6340,0 6346,1 6408,0 6451,1 6513,0 6608,1 6658,0 6691,1 6700,0 6755,1 6839,0 6882,1 6892,0 6938,1 6965,0 6968,1 6989,0 7035,1 7046,0 7134,1 7156,0 7176,1 7199,0 7276,1 7372,0 7395,1 7452,0 7455,1 7542,0 7546,1 7563,0 7631,1 7687,0 7723,1 7767,0 7845,1 7873,0 7917,1 7923,0 7975,1 8033,0 8071,1 8075,0 8117,1 8186,0 8254,1 8328,0 8412,1 8452,0 8465,1 8476,0 8543,1 8623,0 8637,1 8667,0 8688,1 8727,0 8740,1 8761,0 8856,1 8884,0 8893,1 8959,0 8973,1 8978,0 9077,1 9156,0 9211,1 9276,0 9295,1 9359,0 9360,1 9422,0 9450,1 9488,0 9548,1 9623,0 9693,1 9791,0 9830,1 9876,0 9897,1 9990,0 10040,1 10062,0 10063,1 10118,0 10201,1 10293,0 10330,1 10368,0 10449,1 10450,0 10481,1 10571,0 10610,1 10690,0 10715,1 10737,0 10772,1 10826,0 10907,1 10923,0 11012,1 11099,0 11108,1 11155,0 11235,1 11258,0 11329,1 11373,0 11396,1 11403,0 11491,1 11530,0 11614,1 11622,0 11700,1 11738,0 11796,1 11807,0 11863,1 11865,0 11894,1 11977,0 11986,1 12036,0 12055,1 end initlist b0 0,0 33,1 115,0 129,1 206,0 250,1 259,0 285,1 347,0 381,1 454,0 483,1 574,0 662,1 706,0 785,1 822,0 842,1 892,0 991,1 993,0 1025,1 1122,0 1202,1 1211,0 1232,1 1325,0 1328,1 1400,0 1413,1 1437,0 1510,1 1576,0 1613,1 1696,0 1737,1 1777,0 1840,1 1879,0 1968,1 2045,0 2134,1 2178,0 2223,1 2265,0 2359,1 2456,0 2486,1 2560,0 2625,1 2643,0 2704,1 2786,0 2847,1 2938,0 3033,1 3111,0 3114,1 3159,0 3258,1 3291,0 3360,1 3401,0 3430,1 3442,0 3498,1 3593,0 3663,1 3676,0 3710,1 3799,0 3843,1 3908,0 3919,1 4013,0 4106,1 4139,0 4208,1 4282,0 4343,1 4398,0 4452,1 4494,0 4517,1 4581,0 4679,1 4689,0 4737,1 4748,0 4803,1 4825,0 4879,1 4882,0 4929,1 5006,0 5062,1 5078,0 5120,1 5195,0 5215,1 5238,0 5295,1 5324,0 5424,1 5456,0 5472,1 5490,0 5561,1 5569,0 5578,1 5582,0 5594,1 5617,0 5656,1 5693,0 5710,1 5769,0 5805,1 5845,0 5881,1 5920,0 5977,1 6038,0 6125,1 6168,0 6250,1 6294,0 6378,1 6428,0 6437,1 6439,0 6443,1 6519,0 6609,1 6655,0 6682,1 6715,0 6810,1 6910,0 6996,1 7071,0 7093,1 7154,0 7223,1 7251,0 7265,1 7295,0 7340,1 7369,0 7407,1 7435,0 7482,1 7556,0 7559,1 7626,0 7726,1 7778,0 7846,1 7882,0 7892,1 7990,0 8027,1 8069,0 8084,1 8149,0 8244,1 8298,0 8351,1 8449,0 8473,1 8507,0 8559,1 8590,0 8671,1 8750,0 8754,1 8811,0 8885,1 8941,0 9003,1 9054,0 9060,1 9145,0 9206,1 9267,0 9319,1 9344,0 9358,1 9405,0 9425,1 9514,0 9585,1 9616,0 9660,1 9760,0 9838,1 9860,0 9952,1 10047,0 10071,1 10097,0 10108,1 10160,0 10195,1 10209,0 10269,1 10344,0 10386,1 10451,0 10530,1 10614,0 10682,1 10734,0 10814,1 10818,0 10850,1 10886,0 10924,1 10970,0 11050,1 11067,0 11104,1 11178,0 11238,1 11247,0 11344,1 11361,0 11402,1 11439,0 11503,1 11594,0 11676,1 11699,0 11738,1 11828,0 11910,1 11971,0 12055,1 12080,0 12178,1 12235,0 12298,1 12386,0 12447,1 12483,0 12504,1 12552,0 12565,1 12620,0 12718,1 12796,0 12894,1 12972,0 12974,1 13050,0 13100,1 13147,0 13237,1 end initlist b1 0,0 46,1 90,0 100,1 182,0 260,1 349,0 374,1 411,0 471,1 478,0 570,1 622,0 674,1 714,0 769,1 815,0 863,1 944,0 1011,1 1039,0 1095,1 1159,0 1181,1 1242,0 1289,1 1305,0 1316,1 1406,0 1503,1 1563,0 1572,1 1626,0 1697,1 1712,0 1792,1 1866,0 1965,1 2047,0 2099,1 2149,0 2227,1 2279,0 2375,1 2450,0 2517,1 2545,0 2574,1 2580,0 2678,1 2699,0 2759,1 2794,0 2817,1 2909,0 2991,1 3048,0 3128,1 3166,0 3174,1 3183,0 3231,1 3258,0 3329,1 3370,0 3385,1 3436,0 3521,1 3537,0 3616,1 3686,0 3732,1 3780,0 3860,1 3868,0 3924,1 4021,0 4038,1 4110,0 4120,1 4159,0 4259,1 4302,0 4324,1 4373,0 4465,1 4551,0 4571,1 4655,0 4693,1 4791,0 4872,1 4917,0 4987,1 5001,0 5011,1 5051,0 5130,1 5155,0 5253,1 5327,0 5377,1 5435,0 5488,1 5507,0 5511,1 5524,0 5581,1 5603,0 5694,1 5762,0 5820,1 5908,0 5981,1 6020,0 6115,1 6172,0 6191,1 6272,0 6299,1 6391,0 6432,1 6492,0 6584,1 6635,0 6668,1 6701,0 6762,1 6827,0 6906,1 6982,0 7072,1 7125,0 7196,1 7218,0 7292,1 7297,0 7352,1 7356,0 7406,1 7429,0 7460,1 7513,0 7542,1 7599,0 7639,1 7644,0 7698,1 7784,0 7844,1 7858,0 7925,1 7961,0 7970,1 8049,0 8098,1 8127,0 8202,1 8207,0 8307,1 8377,0 8389,1 8414,0 8493,1 8499,0 8586,1 8588,0 8656,1 8683,0 8719,1 8778,0 8866,1 8932,0 8935,1 8978,0 9058,1 9148,0 9177,1 9250,0 9262,1 9288,0 9309,1 9320,0 9329,1 9364,0 9439,1 9520,0 9534,1 9594,0 9605,1 9627,0 9723,1 9769,0 9783,1 9861,0 9959,1 10015,0 10102,1 10152,0 10177,1 10227,0 10297,1 10369,0 10393,1 10400,0 10467,1 10549,0 10635,1 10677,0 10678,1 10717,0 10788,1 10888,0 10917,1 10980,0 11048,1 11051,0 11088,1 11099,0 11181,1 11212,0 11299,1 11361,0 11449,1 11487,0 11544,1 11597,0 11643,1 11709,0 11713,1 11809,0 11892,1 11927,0 12002,1 12041,0 12122,1 12130,0 12145,1 12223,0 12310,1 12323,0 12350,1 12401,0 12488,1 12500,0 12576,1 12617,0 12623,1 12711,0 12781,1 12881,0 12954,1 12959,0 12963,1 13057,0 13089,1 13134,0 13165,1 end initlist b2 0,0 87,1 158,0 187,1 197,0 268,1 297,0 332,1 370,0 437,1 512,0 539,1 542,0 592,1 638,0 710,1 798,0 802,1 876,0 905,1 986,0 1075,1 1115,0 1196,1 1273,0 1367,1 1457,0 1543,1 1623,0 1665,1 1739,0 1780,1 1842,0 1919,1 1944,0 1948,1 2004,0 2044,1 2072,0 2149,1 2196,0 2286,1 2311,0 2332,1 2384,0 2446,1 2496,0 2537,1 2567,0 2655,1 2684,0 2730,1 2743,0 2809,1 2823,0 2862,1 2962,0 2974,1 3065,0 3100,1 3194,0 3236,1 3323,0 3406,1 3434,0 3435,1 3485,0 3556,1 3656,0 3660,1 3706,0 3786,1 3794,0 3816,1 3821,0 3853,1 3900,0 3968,1 3971,0 4050,1 4088,0 4126,1 4220,0 4302,1 4349,0 4410,1 4487,0 4553,1 4627,0 4684,1 4721,0 4795,1 4851,0 4897,1 4941,0 4971,1 5070,0 5134,1 5178,0 5218,1 5308,0 5310,1 5410,0 5484,1 5513,0 5612,1 5696,0 5777,1 5871,0 5913,1 5989,0 6006,1 6076,0 6120,1 6153,0 6219,1 6294,0 6347,1 6371,0 6387,1 6430,0 6485,1 6525,0 6570,1 6634,0 6665,1 6712,0 6770,1 6845,0 6873,1 6929,0 6993,1 7024,0 7110,1 7209,0 7253,1 7349,0 7421,1 7433,0 7476,1 7562,0 7585,1 7629,0 7723,1 7728,0 7793,1 7851,0 7899,1 7948,0 8003,1 8046,0 8103,1 8109,0 8168,1 8261,0 8316,1 8411,0 8463,1 8555,0 8640,1 8699,0 8771,1 8826,0 8843,1 8845,0 8942,1 8955,0 9030,1 9126,0 9211,1 9304,0 9337,1 9364,0 9405,1 9484,0 9534,1 9587,0 9681,1 9740,0 9838,1 9922,0 10017,1 10044,0 10094,1 10135,0 10205,1 10207,0 10278,1 10343,0 10436,1 10535,0 10617,1 10634,0 10666,1 10698,0 10772,1 10837,0 10846,1 10881,0 10911,1 10960,0 11059,1 11061,0 11134,1 11191,0 11249,1 11286,0 11299,1 11375,0 11410,1 11494,0 11532,1 11614,0 11694,1 11784,0 11878,1 11925,0 11947,1 12043,0 12060,1 12099,0 12174,1 12238,0 12250,1 12324,0 12395,1 12474,0 12534,1 12552,0 12637,1 12707,0 12729,1 12814,0 12825,1 12914,0 12985,1 13022,0 13119,1 13207,0 13254,1 13334,0 13363,1 13394,0 13449,1 13480,0 13481,1 13528,0 13607,1 13680,0 13775,1 13821,0 13824,1 13831,0 13882,1 13971,0 14011,1 14016,0 14041,1 end initlist b3 0,0 97,1 186,0 231,1 318,0 331,1 348,0 372,1 378,0 406,1 483,0 528,1 606,0 655,1 748,0 754,1 843,0 931,1 980,0 993,1 1012,0 1013,1 1029,0 1088,1 1169,0 1221,1 1283,0 1379,1 1438,0 1466,1 1538,0 1593,1 1680,0 1761,1 1841,0 1845,1 1850,0 1912,1 1952,0 1953,1 1969,0 2023,1 2078,0 2094,1 2132,0 2197,1 2266,0 2365,1 2452,0 2526,1 2588,0 2677,1 2772,0 2863,1 2929,0 2991,1 3072,0 3114,1 3141,0 3214,1 3284,0 3292,1 3370,0 3423,1 3489,0 3523,1 3593,0 3610,1 3654,0 3666,1 3672,0 3771,1 3782,0 3829,1 3857,0 3863,1 3940,0 4022,1 4091,0 4169,1 4216,0 4252,1 4300,0 4304,1 4402,0 4455,1 4501,0 4504,1 4566,0 4613,1 4618,0 4682,1 4767,0 4838,1 4867,0 4928,1 5002,0 5066,1 5156,0 5251,1 5272,0 5362,1 5415,0 5444,1 5526,0 5622,1 5664,0 5761,1 5828,0 5895,1 5906,0 5983,1 6078,0 6134,1 6145,0 6196,1 6253,0 6286,1 6330,0 6424,1 6456,0 6538,1 6634,0 6701,1 6731,0 6825,1 6845,0 6859,1 6957,0 7056,1 7099,0 7169,1 7198,0 7267,1 7271,0 7277,1 7351,0 7366,1 7373,0 7389,1 7487,0 7523,1 7620,0 7713,1 7728,0 7828,1 7920,0 7988,1 8079,0 8095,1 8193,0 8277,1 8366,0 8464,1 8472,0 8562,1 8567,0 8586,1 8606,0 8700,1 8702,0 8796,1 8846,0 8901,1 8903,0 8922,1 8947,0 9033,1 9041,0 9086,1 9134,0 9148,1 9233,0 9246,1 9255,0 9355,1 9407,0 9484,1 9516,0 9607,1 9687,0 9701,1 9794,0 9875,1 9949,0 9996,1 10013,0 10087,1 10110,0 10180,1 10277,0 10370,1 10372,0 10426,1 10522,0 10533,1 10588,0 10629,1 10651,0 10742,1 10785,0 10880,1 10915,0 10956,1 10966,0 10968,1 10993,0 11071,1 11102,0 11155,1 11220,0 11260,1 11289,0 11352,1 11366,0 11377,1 11387,0 11404,1 11433,0 11479,1 11487,0 11567,1 11631,0 11648,1 11729,0 11774,1 11813,0 11868,1 11890,0 11933,1 11957,0 12050,1 12081,0 12162,1 12195,0 12285,1 12316,0 12409,1 12479,0 12577,1 12601,0 12665,1 12765,0 12823,1 12874,0 12951,1 12981,0 13012,1 13054,0 13134,1 13207,0 13262,1 13344,0 13444,1 13460,0 13532,1 13609,0 13636,1 end initlist b4 0,0 21,1 77,0 142,1 230,0 237,1 331,0 354,1 450,0 467,1 504,0 519,1 594,0 677,1 704,0 729,1 814,0 851,1 934,0 988,1 1007,0 1027,1 1118,0 1171,1 1177,0 1184,1 1219,0 1225,1 1244,0 1323,1 1417,0 1421,1 1491,0 1539,1 1625,0 1714,1 1805,0 1815,1 1879,0 1931,1 2013,0 2026,1 2072,0 2121,1 2211,0 2238,1 2330,0 2405,1 2409,0 2467,1 2549,0 2606,1 2626,0 2662,1 2714,0 2812,1 2908,0 2966,1 3027,0 3049,1 3120,0 3166,1 3230,0 3282,1 3378,0 3443,1 3495,0 3515,1 3603,0 3693,1 3756,0 3833,1 3867,0 3879,1 3952,0 4026,1 4116,0 4121,1 4181,0 4184,1 4227,0 4287,1 4295,0 4384,1 4407,0 4419,1 4461,0 4463,1 4540,0 4603,1 4623,0 4663,1 4713,0 4748,1 4810,0 4827,1 4927,0 4928,1 5013,0 5109,1 5157,0 5215,1 5250,0 5251,1 5252,0 5348,1 5382,0 5467,1 5501,0 5525,1 5598,0 5608,1 5703,0 5770,1 5790,0 5818,1 5891,0 5991,1 6072,0 6146,1 6160,0 6212,1 6290,0 6313,1 6317,0 6344,1 6346,0 6359,1 6360,0 6374,1 6391,0 6407,1 6475,0 6544,1 6627,0 6675,1 6698,0 6738,1 6813,0 6881,1 6971,0 7039,1 7049,0 7115,1 7212,0 7288,1 7318,0 7347,1 7372,0 7436,1 7469,0 7569,1 7662,0 7692,1 7766,0 7790,1 7845,0 7872,1 7893,0 7905,1 7972,0 8071,1 8169,0 8170,1 8171,0 8261,1 8268,0 8289,1 8353,0 8392,1 8492,0 8592,1 8670,0 8687,1 8784,0 8842,1 8867,0 8954,1 8967,0 9050,1 9057,0 9148,1 9184,0 9219,1 9231,0 9235,1 9326,0 9347,1 9429,0 9438,1 9473,0 9536,1 9611,0 9613,1 9630,0 9649,1 9719,0 9728,1 9765,0 9771,1 9855,0 9951,1 9956,0 10032,1 10045,0 10111,1 10149,0 10195,1 10224,0 10285,1 10326,0 10393,1 10491,0 10556,1 10607,0 10689,1 10732,0 10739,1 10804,0 10805,1 10839,0 10916,1 10970,0 11016,1 11063,0 11156,1 11213,0 11235,1 11251,0 11294,1 11310,0 11385,1 11483,0 11522,1 11591,0 11605,1 11704,0 11711,1 11720,0 11789,1 11866,0 11938,1 12018,0 12042,1 12102,0 12156,1 12248,0 12320,1 12328,0 12388,1 12463,0 12501,1 12514,0 12529,1 12594,0 12694,1 12701,0 12745,1 end initlist b5 0,0 53,1 88,0 122,1 192,0 281,1 300,0 384,1 388,0 441,1 518,0 526,1 625,0 689,1 755,0 807,1 890,0 902,1 939,0 1023,1 1094,0 1179,1 1204,0 1231,1 1272,0 1329,1 1360,0 1434,1 1491,0 1560,1 1646,0 1680,1 1754,0 1843,1 1914,0 1951,1 2014,0 2047,1 2132,0 2209,1 2248,0 2302,1 2376,0 2401,1 2499,0 2596,1 2635,0 2687,1 2691,0 2716,1 2751,0 2846,1 2879,0 2965,1 2982,0 3050,1 3142,0 3155,1 3181,0 3190,1 3220,0 3318,1 3346,0 3369,1 3459,0 3547,1 3642,0 3653,1 3713,0 3808,1 3858,0 3859,1 3944,0 4008,1 4092,0 4164,1 4256,0 4289,1 4322,0 4369,1 4463,0 4482,1 4567,0 4629,1 4729,0 4777,1 4803,0 4885,1 4912,0 4951,1 4954,0 4995,1 5033,0 5101,1 5181,0 5221,1 5318,0 5369,1 5374,0 5378,1 5394,0 5473,1 5563,0 5564,1 5631,0 5721,1 5770,0 5860,1 5936,0 5998,1 6060,0 6089,1 6124,0 6206,1 6229,0 6307,1 6324,0 6366,1 6451,0 6486,1 6562,0 6601,1 6647,0 6744,1 6751,0 6779,1 6864,0 6961,1 6972,0 7057,1 7129,0 7225,1 7237,0 7269,1 7354,0 7360,1 7423,0 7503,1 7602,0 7617,1 7658,0 7661,1 7708,0 7739,1 7784,0 7875,1 7942,0 7979,1 8008,0 8023,1 8033,0 8056,1 8097,0 8174,1 8247,0 8250,1 8318,0 8357,1 8405,0 8417,1 8444,0 8526,1 8624,0 8633,1 8663,0 8741,1 8770,0 8863,1 8956,0 9056,1 9099,0 9102,1 9114,0 9133,1 9136,0 9173,1 9245,0 9318,1 9391,0 9473,1 9482,0 9505,1 9546,0 9634,1 9713,0 9813,1 9874,0 9923,1 9934,0 9977,1 9980,0 10067,1 10072,0 10153,1 10174,0 10268,1 10357,0 10417,1 10489,0 10571,1 10650,0 10672,1 10763,0 10812,1 10893,0 10945,1 10984,0 11034,1 11056,0 11148,1 11215,0 11273,1 11312,0 11396,1 11449,0 11461,1 11555,0 11653,1 11672,0 11749,1 11817,0 11892,1 11894,0 11974,1 11977,0 12065,1 12113,0 12176,1 12235,0 12259,1 12314,0 12342,1 12362,0 12434,1 12475,0 12533,1 12633,0 12653,1 12656,0 12719,1 12791,0 12891,1 12920,0 12941,1 12968,0 12980,1 13067,0 13088,1 13161,0 13211,1 13275,0 13318,1 13394,0 13446,1 13534,0 13625,1 13655,0 13734,1 end initlist b6 0,0 40,1 139,0 151,1 159,0 258,1 314,0 360,1 438,0 440,1 445,0 520,1 540,0 580,1 668,0 680,1 695,0 740,1 804,0 870,1 941,0 982,1 1035,0 1044,1 1135,0 1172,1 1270,0 1330,1 1345,0 1438,1 1472,0 1513,1 1563,0 1568,1 1668,0 1743,1 1822,0 1889,1 1968,0 2056,1 2134,0 2210,1 2265,0 2272,1 2277,0 2377,1 2455,0 2528,1 2584,0 2592,1 2690,0 2714,1 2725,0 2810,1 2860,0 2943,1 3012,0 3040,1 3083,0 3180,1 3224,0 3249,1 3284,0 3344,1 3413,0 3478,1 3491,0 3499,1 3573,0 3663,1 3728,0 3747,1 3780,0 3859,1 3926,0 3964,1 4029,0 4087,1 4101,0 4190,1 4202,0 4206,1 4252,0 4341,1 4363,0 4406,1 4414,0 4442,1 4475,0 4519,1 4529,0 4540,1 4557,0 4633,1 4646,0 4692,1 4747,0 4765,1 4862,0 4945,1 5036,0 5105,1 5198,0 5214,1 5314,0 5336,1 5391,0 5446,1 5522,0 5603,1 5692,0 5732,1 5798,0 5826,1 5917,0 5950,1 6020,0 6110,1 6157,0 6208,1 6307,0 6384,1 6392,0 6429,1 6493,0 6507,1 6588,0 6660,1 6733,0 6812,1 6888,0 6982,1 7053,0 7080,1 7124,0 7217,1 7227,0 7254,1 7294,0 7373,1 7429,0 7432,1 7477,0 7508,1 7554,0 7646,1 7689,0 7727,1 7781,0 7801,1 7846,0 7887,1 7937,0 7956,1 8052,0 8069,1 8114,0 8121,1 8155,0 8220,1 8272,0 8288,1 8311,0 8372,1 8418,0 8475,1 8569,0 8626,1 8726,0 8735,1 8789,0 8818,1 8913,0 8972,1 8992,0 9040,1 9087,0 9155,1 9210,0 9250,1 9290,0 9314,1 9405,0 9432,1 9449,0 9532,1 9559,0 9629,1 9655,0 9678,1 9738,0 9786,1 9800,0 9857,1 9887,0 9962,1 10036,0 10135,1 10172,0 10201,1 10253,0 10341,1 10379,0 10446,1 10528,0 10545,1 10583,0 10639,1 10702,0 10719,1 10777,0 10807,1 10827,0 10876,1 10879,0 10916,1 11007,0 11069,1 11084,0 11177,1 11267,0 11329,1 11363,0 11412,1 11447,0 11455,1 11468,0 11494,1 11527,0 11555,1 11560,0 11650,1 11746,0 11816,1 11902,0 11911,1 11922,0 11993,1 12007,0 12083,1 12181,0 12234,1 12284,0 12363,1 12411,0 12472,1 12528,0 12616,1 12636,0 12733,1 12805,0 12842,1 12878,0 12949,1 12984,0 12993,1 13003,0 13029,1 end initlist b7 0,0 3,1 79,0 90,1 160,0 192,1 290,0 300,1 352,0 448,1 476,0 563,1 601,0 605,1 694,0 787,1 884,0 983,1 1006,0 1104,1 1186,0 1274,1 1363,0 1395,1 1479,0 1553,1 1558,0 1572,1 1654,0 1700,1 1754,0 1806,1 1817,0 1884,1 1906,0 1951,1 1967,0 2066,1 2089,0 2169,1 2175,0 2226,1 2245,0 2250,1 2256,0 2318,1 2356,0 2372,1 2433,0 2434,1 2492,0 2494,1 2540,0 2550,1 2626,0 2672,1 2762,0 2849,1 2887,0 2939,1 2975,0 3057,1 3132,0 3227,1 3283,0 3305,1 3397,0 3466,1 3548,0 3578,1 3635,0 3706,1 3786,0 3801,1 3859,0 3894,1 3986,0 4036,1 4083,0 4164,1 4191,0 4242,1 4249,0 4256,1 4275,0 4366,1 4420,0 4428,1 4441,0 4469,1 4484,0 4501,1 4540,0 4632,1 4692,0 4726,1 4730,0 4803,1 4842,0 4941,1 4992,0 5065,1 5102,0 5150,1 5228,0 5292,1 5309,0 5379,1 5432,0 5485,1 5519,0 5548,1 5602,0 5675,1 5773,0 5789,1 5826,0 5879,1 5951,0 5965,1 6000,0 6091,1 6133,0 6197,1 6283,0 6383,1 6428,0 6490,1 6566,0 6614,1 6680,0 6709,1 6781,0 6808,1 6855,0 6862,1 6925,0 6945,1 7021,0 7115,1 7117,0 7160,1 7215,0 7247,1 7325,0 7385,1 7392,0 7438,1 7452,0 7486,1 7492,0 7555,1 7591,0 7686,1 7745,0 7774,1 7807,0 7816,1 7829,0 7882,1 7982,0 8039,1 8089,0 8166,1 8207,0 8259,1 8297,0 8360,1 8388,0 8420,1 8514,0 8519,1 8597,0 8653,1 8678,0 8742,1 8783,0 8859,1 8873,0 8939,1 9006,0 9074,1 9153,0 9243,1 9339,0 9351,1 9377,0 9475,1 9508,0 9556,1 9563,0 9598,1 9609,0 9648,1 9741,0 9765,1 9791,0 9821,1 9835,0 9878,1 9879,0 9931,1 10011,0 10063,1 10089,0 10095,1 10179,0 10270,1 10286,0 10347,1 10370,0 10430,1 10434,0 10467,1 10552,0 10585,1 10641,0 10646,1 10689,0 10719,1 10730,0 10821,1 10920,0 10927,1 10979,0 11031,1 11109,0 11116,1 11204,0 11213,1 11262,0 11300,1 11317,0 11376,1 11386,0 11427,1 11452,0 11473,1 11507,0 11540,1 11598,0 11698,1 11700,0 11765,1 11804,0 11812,1 11859,0 11939,1 12002,0 12050,1 12085,0 12133,1 12151,0 12154,1 12222,0 12282,1 12331,0 12363,1 end initlist b8 0,0 47,1 67,0 110,1 203,0 264,1 322,0 334,1 417,0 470,1 517,0 542,1 566,0 583,1 624,0 674,1 682,0 763,1 793,0 857,1 858,0 941,1 989,0 1071,1 1138,0 1210,1 1301,0 1312,1 1379,0 1415,1 1439,0 1520,1 1523,0 1609,1 1660,0 1677,1 1696,0 1716,1 1765,0 1863,1 1932,0 1978,1 2071,0 2110,1 2121,0 2194,1 2242,0 2319,1 2382,0 2449,1 2512,0 2555,1 2650,0 2659,1 2704,0 2795,1 2841,0 2909,1 2940,0 2958,1 3000,0 3011,1 3039,0 3069,1 3127,0 3162,1 3193,0 3233,1 3312,0 3329,1 3338,0 3393,1 3444,0 3515,1 3552,0 3594,1 3690,0 3723,1 3754,0 3852,1 3906,0 3931,1 4018,0 4099,1 4156,0 4199,1 4260,0 4298,1 4366,0 4463,1 4508,0 4539,1 4633,0 4727,1 4820,0 4844,1 4929,0 5023,1 5052,0 5091,1 5123,0 5183,1 5252,0 5255,1 5313,0 5399,1 5429,0 5449,1 5498,0 5592,1 5648,0 5687,1 5781,0 5850,1 5932,0 6025,1 6085,0 6137,1 6181,0 6263,1 6275,0 6372,1 6439,0 6515,1 6572,0 6654,1 6674,0 6732,1 6806,0 6877,1 6924,0 6993,1 7043,0 7080,1 7154,0 7245,1 7275,0 7328,1 7408,0 7434,1 7526,0 7552,1 7577,0 7665,1 7698,0 7721,1 7771,0 7833,1 7910,0 8002,1 8004,0 8103,1 8194,0 8285,1 8362,0 8384,1 8462,0 8505,1 8531,0 8544,1 8599,0 8614,1 8680,0 8716,1 8788,0 8789,1 8816,0 8881,1 8955,0 8980,1 9059,0 9154,1 9254,0 9320,1 9328,0 9342,1 9381,0 9473,1 9531,0 9626,1 9717,0 9721,1 9818,0 9894,1 9937,0 10032,1 10118,0 10176,1 10259,0 10350,1 10422,0 10467,1 10496,0 10582,1 10676,0 10744,1 10821,0 10847,1 10877,0 10937,1 10953,0 10981,1 11031,0 11091,1 11140,0 11181,1 11261,0 11339,1 11422,0 11423,1 11521,0 11582,1 11643,0 11736,1 11794,0 11850,1 11912,0 11957,1 12002,0 12012,1 12037,0 12058,1 12093,0 12172,1 12197,0 12221,1 12282,0 12351,1 12418,0 12501,1 12595,0 12655,1 12667,0 12766,1 12811,0 12832,1 12907,0 12982,1 13024,0 13106,1 13194,0 13236,1 13266,0 13305,1 13325,0 13384,1 13467,0 13550,1 13635,0 13641,1 13698,0 13732,1 13794,0 13845,1 13919,0 13991,1 14038,0 14087,1 end initlist b9 0,0 20,1 50,0 129,1 215,0 262,1 351,0 391,1 418,0 488,1 517,0 599,1 635,0 680,1 778,0 863,1 962,0 1012,1 1046,0 1071,1 1096,0 1170,1 1268,0 1286,1 1287,0 1305,1 1344,0 1355,1 1383,0 1425,1 1501,0 1558,1 1608,0 1695,1 1711,0 1805,1 1867,0 1964,1 2037,0 2087,1 2126,0 2188,1 2198,0 2255,1 2307,0 2405,1 2447,0 2479,1 2548,0 2579,1 2593,0 2622,1 2631,0 2680,1 2707,0 2725,1 2752,0 2797,1 2885,0 2913,1 2945,0 3034,1 3113,0 3150,1 3172,0 3272,1 3278,0 3363,1 3451,0 3463,1 3484,0 3493,1 3593,0 3673,1 3682,0 3713,1 3789,0 3876,1 3901,0 3936,1 3998,0 4087,1 4100,0 4120,1 4209,0 4296,1 4323,0 4330,1 4421,0 4472,1 4510,0 4586,1 4634,0 4646,1 4681,0 4773,1 4857,0 4865,1 4891,0 4946,1 4997,0 5044,1 5135,0 5227,1 5280,0 5347,1 5426,0 5481,1 5503,0 5564,1 5612,0 5653,1 5664,0 5690,1 5740,0 5816,1 5835,0 5892,1 5913,0 5972,1 5995,0 6087,1 6133,0 6144,1 6186,0 6283,1 6364,0 6397,1 6436,0 6511,1 6529,0 6550,1 6624,0 6703,1 6770,0 6840,1 6907,0 6923,1 7001,0 7021,1 7063,0 7107,1 7183,0 7213,1 7257,0 7353,1 7369,0 7449,1 7484,0 7560,1 7651,0 7653,1 7674,0 7746,1 7765,0 7817,1 7910,0 7917,1 7957,0 8053,1 8080,0 8107,1 8117,0 8198,1 8272,0 8276,1 8298,0 8347,1 8381,0 8383,1 8407,0 8491,1 8573,0 8587,1 8648,0 8719,1 8790,0 8845,1 8928,0 8987,1 9001,0 9050,1 9114,0 9214,1 9278,0 9297,1 9332,0 9410,1 9449,0 9512,1 9519,0 9568,1 9578,0 9582,1 9600,0 9627,1 9704,0 9741,1 9833,0 9933,1 10009,0 10038,1 10089,0 10142,1 10214,0 10312,1 10344,0 10434,1 10476,0 10495,1 10567,0 10652,1 10670,0 10713,1 10761,0 10813,1 10877,0 10883,1 10978,0 10983,1 11056,0 11126,1 11157,0 11188,1 11241,0 11298,1 11347,0 11398,1 11458,0 11522,1 11559,0 11600,1 11689,0 11724,1 11747,0 11811,1 11812,0 11851,1 11890,0 11982,1 11990,0 12007,1 12055,0 12147,1 12244,0 12281,1 12351,0 12416,1 12501,0 12562,1 12624,0 12712,1 12771,0 12805,1 12870,0 12943,1 12986,0 13038,1 end initlist b10 0,0 48,1 135,0 202,1 213,0 228,1 244,0 249,1 265,0 315,1 341,0 365,1 444,0 522,1 621,0 679,1 736,0 811,1 870,0 947,1 961,0 1015,1 1065,0 1156,1 1167,0 1189,1 1197,0 1289,1 1320,0 1348,1 1408,0 1504,1 1523,0 1551,1 1598,0 1641,1 1704,0 1742,1 1762,0 1856,1 1865,0 1928,1 1982,0 2031,1 2050,0 2094,1 2137,0 2199,1 2270,0 2362,1 2374,0 2469,1 2489,0 2500,1 2589,0 2666,1 2685,0 2711,1 2791,0 2870,1 2929,0 2957,1 3028,0 3032,1 3132,0 3182,1 3280,0 3312,1 3398,0 3441,1 3462,0 3538,1 3624,0 3711,1 3781,0 3846,1 3933,0 4015,1 4087,0 4169,1 4253,0 4313,1 4401,0 4439,1 4511,0 4579,1 4606,0 4621,1 4673,0 4743,1 4785,0 4852,1 4894,0 4984,1 5046,0 5117,1 5176,0 5270,1 5298,0 5305,1 5323,0 5372,1 5400,0 5478,1 5496,0 5579,1 5677,0 5722,1 5806,0 5875,1 5887,0 5985,1 6046,0 6065,1 6079,0 6097,1 6126,0 6223,1 6254,0 6348,1 6392,0 6436,1 6513,0 6605,1 6635,0 6690,1 6715,0 6805,1 6880,0 6956,1 7010,0 7076,1 7127,0 7150,1 7211,0 7310,1 7355,0 7433,1 7450,0 7536,1 7582,0 7665,1 7711,0 7808,1 7888,0 7903,1 7963,0 8011,1 8021,0 8117,1 8194,0 8262,1 8353,0 8372,1 8382,0 8454,1 8486,0 8571,1 8659,0 8668,1 8767,0 8814,1 8841,0 8885,1 8969,0 9004,1 9070,0 9095,1 9104,0 9164,1 9176,0 9210,1 9282,0 9288,1 9330,0 9409,1 9481,0 9533,1 9534,0 9593,1 9680,0 9749,1 9754,0 9850,1 9889,0 9900,1 9928,0 9949,1 10005,0 10031,1 10127,0 10162,1 10170,0 10217,1 10279,0 10280,1 10354,0 10379,1 10400,0 10443,1 10450,0 10530,1 10618,0 10656,1 10735,0 10752,1 10852,0 10873,1 10874,0 10973,1 11016,0 11037,1 11045,0 11093,1 11190,0 11290,1 11296,0 11372,1 11463,0 11474,1 11561,0 11654,1 11685,0 11712,1 11717,0 11760,1 11840,0 11875,1 11918,0 11965,1 11966,0 11976,1 12075,0 12175,1 12254,0 12344,1 12361,0 12382,1 12439,0 12504,1 12508,0 12535,1 12607,0 12610,1 12617,0 12642,1 12676,0 12683,1 12776,0 12858,1 12919,0 12968,1 13024,0 13030,1 13040,0 13073,1 13097,0 13112,1 end initlist b11 0,0 74,1 124,0 224,1 268,0 300,1 325,0 358,1 415,0 427,1 525,0 535,1 596,0 692,1 752,0 820,1 823,0 890,1 918,0 957,1 981,0 1042,1 1050,0 1084,1 1101,0 1112,1 1122,0 1183,1 1221,0 1246,1 1259,0 1342,1 1374,0 1450,1 1517,0 1526,1 1611,0 1703,1 1752,0 1784,1 1854,0 1935,1 1975,0 2037,1 2106,0 2128,1 2157,0 2234,1 2244,0 2268,1 2345,0 2349,1 2422,0 2463,1 2467,0 2500,1 2574,0 2644,1 2720,0 2796,1 2832,0 2896,1 2994,0 3037,1 3106,0 3163,1 3245,0 3317,1 3351,0 3367,1 3399,0 3491,1 3555,0 3620,1 3676,0 3761,1 3764,0 3809,1 3902,0 3984,1 4010,0 4063,1 4154,0 4250,1 4279,0 4294,1 4371,0 4410,1 4473,0 4509,1 4548,0 4554,1 4590,0 4658,1 4704,0 4708,1 4727,0 4755,1 4820,0 4886,1 4979,0 5019,1 5105,0 5153,1 5196,0 5251,1 5269,0 5366,1 5386,0 5406,1 5416,0 5472,1 5505,0 5591,1 5603,0 5642,1 5740,0 5789,1 5819,0 5827,1 5833,0 5858,1 5862,0 5900,1 5951,0 6021,1 6056,0 6076,1 6126,0 6199,1 6217,0 6299,1 6360,0 6408,1 6473,0 6519,1 6585,0 6619,1 6652,0 6683,1 6721,0 6723,1 6806,0 6869,1 6948,0 7000,1 7021,0 7070,1 7076,0 7170,1 7234,0 7239,1 7306,0 7403,1 7460,0 7492,1 7563,0 7636,1 7673,0 7718,1 7765,0 7843,1 7898,0 7928,1 8006,0 8071,1 8166,0 8251,1 8332,0 8396,1 8433,0 8458,1 8484,0 8540,1 8618,0 8626,1 8693,0 8764,1 8797,0 8880,1 8946,0 8965,1 8992,0 9085,1 9134,0 9141,1 9181,0 9189,1 9202,0 9211,1 9257,0 9356,1 9360,0 9458,1 9516,0 9556,1 9638,0 9683,1 9687,0 9752,1 9819,0 9832,1 9845,0 9869,1 9960,0 10041,1 10050,0 10065,1 10077,0 10089,1 10156,0 10176,1 10275,0 10348,1 10439,0 10495,1 10533,0 10571,1 10652,0 10734,1 10833,0 10871,1 10958,0 11022,1 11029,0 11048,1 11095,0 11125,1 11175,0 11184,1 11194,0 11197,1 11224,0 11231,1 11326,0 11375,1 11470,0 11558,1 11593,0 11666,1 11674,0 11738,1 11821,0 11835,1 11881,0 11888,1 11892,0 11910,1 11920,0 11984,1 12018,0 12106,1 12186,0 12208,1 12269,0 12368,1 12421,0 12477,1 end initlist b12 0,0 26,1 99,0 152,1 232,0 235,1 295,0 378,1 391,0 403,1 497,0 557,1 654,0 681,1 698,0 768,1 845,0 942,1 1034,0 1072,1 1105,0 1178,1 1271,0 1353,1 1439,0 1519,1 1568,0 1646,1 1693,0 1780,1 1874,0 1947,1 1993,0 2040,1 2064,0 2156,1 2218,0 2303,1 2335,0 2371,1 2415,0 2515,1 2599,0 2606,1 2688,0 2726,1 2799,0 2893,1 2914,0 2971,1 2996,0 3055,1 3098,0 3119,1 3145,0 3182,1 3282,0 3313,1 3353,0 3446,1 3463,0 3545,1 3570,0 3659,1 3740,0 3785,1 3835,0 3891,1 3912,0 3922,1 3971,0 3992,1 3997,0 4063,1 4116,0 4204,1 4241,0 4293,1 4331,0 4404,1 4408,0 4410,1 4444,0 4499,1 4558,0 4627,1 4698,0 4774,1 4820,0 4918,1 5017,0 5031,1 5123,0 5149,1 5214,0 5278,1 5309,0 5402,1 5429,0 5480,1 5492,0 5565,1 5612,0 5636,1 5685,0 5703,1 5799,0 5843,1 5934,0 5973,1 6006,0 6054,1 6063,0 6138,1 6211,0 6263,1 6309,0 6310,1 6364,0 6420,1 6500,0 6559,1 6586,0 6681,1 6688,0 6759,1 6853,0 6953,1 6962,0 6994,1 7021,0 7079,1 7177,0 7186,1 7227,0 7326,1 7413,0 7455,1 7493,0 7553,1 7599,0 7669,1 7745,0 7758,1 7760,0 7787,1 7842,0 7855,1 7913,0 7963,1 8047,0 8103,1 8132,0 8228,1 8263,0 8305,1 8330,0 8366,1 8418,0 8442,1 8467,0 8482,1 8560,0 8618,1 8642,0 8674,1 8743,0 8787,1 8879,0 8932,1 9000,0 9048,1 9108,0 9171,1 9210,0 9253,1 9305,0 9376,1 9419,0 9518,1 9567,0 9634,1 9670,0 9691,1 9761,0 9793,1 9878,0 9941,1 10015,0 10060,1 10063,0 10080,1 10165,0 10191,1 10211,0 10298,1 10384,0 10472,1 10520,0 10599,1 10671,0 10752,1 10849,0 10870,1 10921,0 10991,1 11014,0 11104,1 11114,0 11138,1 11224,0 11298,1 11305,0 11313,1 11401,0 11441,1 11534,0 11561,1 11636,0 11662,1 11687,0 11740,1 11782,0 11820,1 11898,0 11919,1 11941,0 12007,1 12049,0 12103,1 12190,0 12274,1 12309,0 12355,1 12439,0 12443,1 12499,0 12500,1 12513,0 12606,1 12627,0 12635,1 12671,0 12690,1 12754,0 12762,1 12796,0 12896,1 12986,0 13071,1 13088,0 13169,1 13216,0 13224,1 13231,0 13317,1 13322,0 13355,1 end initlist b13 0,0 5,1 47,0 74,1 109,0 132,1 166,0 175,1 233,0 313,1 338,0 438,1 439,0 495,1 556,0 639,1 670,0 753,1 834,0 856,1 930,0 972,1 1045,0 1064,1 1086,0 1146,1 1235,0 1238,1 1249,0 1284,1 1345,0 1441,1 1448,0 1468,1 1491,0 1503,1 1527,0 1536,1 1633,0 1701,1 1706,0 1751,1 1801,0 1825,1 1861,0 1875,1 1944,0 1981,1 2007,0 2099,1 2132,0 2192,1 2253,0 2349,1 2430,0 2433,1 2464,0 2474,1 2497,0 2520,1 2523,0 2551,1 2614,0 2690,1 2789,0 2827,1 2844,0 2906,1 2959,0 2981,1 3014,0 3029,1 3102,0 3177,1 3178,0 3205,1 3265,0 3314,1 3336,0 3349,1 3427,0 3480,1 3553,0 3606,1 3675,0 3753,1 3847,0 3851,1 3870,0 3958,1 4021,0 4044,1 4100,0 4161,1 4243,0 4253,1 4348,0 4434,1 4496,0 4534,1 4634,0 4667,1 4714,0 4771,1 4821,0 4830,1 4840,0 4903,1 4985,0 5055,1 5095,0 5096,1 5098,0 5125,1 5156,0 5229,1 5254,0 5289,1 5292,0 5316,1 5359,0 5445,1 5515,0 5611,1 5700,0 5793,1 5832,0 5835,1 5843,0 5846,1 5909,0 6009,1 6013,0 6101,1 6155,0 6204,1 6267,0 6316,1 6373,0 6423,1 6424,0 6442,1 6449,0 6525,1 6539,0 6551,1 6569,0 6574,1 6656,0 6746,1 6776,0 6864,1 6870,0 6938,1 7001,0 7050,1 7136,0 7165,1 7173,0 7252,1 7341,0 7385,1 7403,0 7459,1 7478,0 7529,1 7616,0 7641,1 7736,0 7786,1 7837,0 7873,1 7935,0 7958,1 7998,0 8051,1 8098,0 8198,1 8274,0 8313,1 8314,0 8346,1 8358,0 8411,1 8473,0 8537,1 8589,0 8607,1 8652,0 8737,1 8827,0 8834,1 8843,0 8932,1 8993,0 8999,1 9081,0 9147,1 9172,0 9270,1 9313,0 9343,1 9434,0 9515,1 9581,0 9663,1 9685,0 9781,1 9845,0 9905,1 9983,0 10067,1 10130,0 10186,1 10204,0 10301,1 10385,0 10390,1 10486,0 10507,1 10525,0 10621,1 10694,0 10711,1 10777,0 10795,1 10870,0 10906,1 10932,0 11003,1 11063,0 11115,1 11162,0 11211,1 11278,0 11372,1 11375,0 11390,1 11448,0 11499,1 11518,0 11524,1 11548,0 11600,1 11650,0 11723,1 11768,0 11803,1 11833,0 11893,1 11902,0 11994,1 12090,0 12124,1 12165,0 12220,1 12278,0 12359,1 end initlist b14 0,0 35,1 47,0 146,1 185,0 268,1 363,0 431,1 438,0 483,1 560,0 606,1 658,0 753,1 795,0 802,1 894,0 985,1 1052,0 1109,1 1189,0 1235,1 1250,0 1324,1 1330,0 1413,1 1466,0 1541,1 1608,0 1678,1 1714,0 1795,1 1833,0 1859,1 1869,0 1902,1 1969,0 1989,1 1997,0 2028,1 2037,0 2126,1 2163,0 2220,1 2305,0 2361,1 2442,0 2510,1 2602,0 2677,1 2721,0 2804,1 2902,0 2938,1 2982,0 3028,1 3032,0 3111,1 3184,0 3253,1 3276,0 3347,1 3375,0 3470,1 3559,0 3635,1 3696,0 3707,1 3796,0 3863,1 3921,0 3943,1 3997,0 4067,1 4167,0 4231,1 4283,0 4337,1 4384,0 4465,1 4481,0 4569,1 4664,0 4709,1 4770,0 4796,1 4881,0 4907,1 4918,0 4931,1 4986,0 4991,1 5001,0 5021,1 5053,0 5063,1 5141,0 5213,1 5236,0 5334,1 5384,0 5474,1 5477,0 5521,1 5610,0 5623,1 5712,0 5758,1 5856,0 5863,1 5946,0 5949,1 6047,0 6095,1 6194,0 6266,1 6351,0 6396,1 6490,0 6540,1 6627,0 6646,1 6659,0 6726,1 6748,0 6783,1 6789,0 6833,1 6923,0 7021,1 7089,0 7145,1 7230,0 7255,1 7313,0 7345,1 7429,0 7454,1 7466,0 7552,1 7604,0 7639,1 7690,0 7700,1 7720,0 7743,1 7842,0 7865,1 7946,0 8029,1 8055,0 8125,1 8177,0 8194,1 8278,0 8296,1 8305,0 8350,1 8424,0 8427,1 8442,0 8482,1 8489,0 8520,1 8592,0 8623,1 8687,0 8716,1 8789,0 8854,1 8859,0 8897,1 8992,0 9056,1 9067,0 9145,1 9167,0 9242,1 9320,0 9407,1 9461,0 9481,1 9554,0 9583,1 9612,0 9652,1 9670,0 9745,1 9788,0 9792,1 9873,0 9903,1 9910,0 9933,1 9945,0 9969,1 10061,0 10117,1 10124,0 10134,1 10154,0 10252,1 10344,0 10399,1 10436,0 10442,1 10508,0 10571,1 10609,0 10651,1 10692,0 10694,1 10726,0 10806,1 10888,0 10973,1 11008,0 11084,1 11098,0 11154,1 11184,0 11273,1 11310,0 11385,1 11399,0 11418,1 11507,0 11534,1 11584,0 11630,1 11673,0 11751,1 11802,0 11884,1 11982,0 12021,1 12098,0 12148,1 12163,0 12183,1 12198,0 12230,1 12315,0 12375,1 12474,0 12547,1 12647,0 12700,1 12770,0 12841,1 12872,0 12957,1 12987,0 13035,1 13132,0 13165,1 13166,0 13245,1 end initlist b15 0,0 45,1 98,0 111,1 183,0 259,1 267,0 269,1 318,0 397,1 443,0 536,1 559,0 638,1 667,0 732,1 793,0 876,1 907,0 958,1 1016,0 1113,1 1207,0 1252,1 1294,0 1332,1 1408,0 1429,1 1471,0 1518,1 1530,0 1569,1 1605,0 1614,1 1634,0 1644,1 1646,0 1686,1 1742,0 1783,1 1799,0 1899,1 1915,0 2014,1 2087,0 2130,1 2188,0 2285,1 2369,0 2412,1 2482,0 2527,1 2618,0 2633,1 2660,0 2760,1 2811,0 2861,1 2914,0 2979,1 3003,0 3013,1 3071,0 3168,1 3205,0 3243,1 3284,0 3329,1 3415,0 3448,1 3465,0 3472,1 3556,0 3595,1 3651,0 3681,1 3690,0 3752,1 3777,0 3857,1 3941,0 4028,1 4075,0 4165,1 4171,0 4176,1 4259,0 4338,1 4431,0 4523,1 4596,0 4624,1 4635,0 4696,1 4708,0 4796,1 4839,0 4920,1 4982,0 5051,1 5137,0 5196,1 5252,0 5272,1 5346,0 5381,1 5428,0 5432,1 5501,0 5580,1 5581,0 5674,1 5730,0 5737,1 5793,0 5815,1 5882,0 5963,1 6041,0 6131,1 6172,0 6231,1 6303,0 6401,1 6405,0 6479,1 6513,0 6544,1 6604,0 6641,1 6741,0 6811,1 6836,0 6850,1 6925,0 6930,1 6979,0 7036,1 7045,0 7057,1 7111,0 7131,1 7152,0 7251,1 7288,0 7323,1 7374,0 7388,1 7446,0 7506,1 7551,0 7559,1 7569,0 7668,1 7684,0 7733,1 7829,0 7891,1 7934,0 7988,1 8025,0 8086,1 8121,0 8147,1 8223,0 8309,1 8378,0 8470,1 8542,0 8569,1 8655,0 8728,1 8797,0 8889,1 8912,0 8919,1 8957,0 9051,1 9107,0 9186,1 9240,0 9265,1 9327,0 9402,1 9470,0 9560,1 9638,0 9651,1 9672,0 9730,1 9767,0 9790,1 9879,0 9941,1 9953,0 10018,1 10086,0 10092,1 10098,0 10129,1 10180,0 10234,1 10324,0 10352,1 10400,0 10459,1 10558,0 10618,1 10646,0 10714,1 10721,0 10732,1 10742,0 10818,1 10873,0 10922,1 11000,0 11046,1 11061,0 11159,1 11163,0 11251,1 11278,0 11287,1 11288,0 11345,1 11421,0 11516,1 11557,0 11650,1 11745,0 11819,1 11838,0 11867,1 11932,0 12032,1 12117,0 12140,1 12221,0 12231,1 12238,0 12280,1 12345,0 12354,1 12403,0 12498,1 12592,0 12629,1 12713,0 12723,1 12799,0 12804,1 12844,0 12926,1 12966,0 13040,1 13084,0 13097,1 end initlist b16 0,0 32,1 72,0 80,1 150,0 236,1 322,0 326,1 355,0 363,1 445,0 480,1 561,0 591,1 612,0 650,1 716,0 781,1 824,0 886,1 889,0 948,1 1030,0 1046,1 1129,0 1138,1 1141,0 1223,1 1303,0 1355,1 1368,0 1443,1 1489,0 1525,1 1571,0 1643,1 1707,0 1764,1 1775,0 1802,1 1881,0 1895,1 1995,0 2028,1 2118,0 2179,1 2235,0 2307,1 2399,0 2427,1 2434,0 2435,1 2477,0 2484,1 2518,0 2576,1 2608,0 2703,1 2796,0 2853,1 2930,0 3012,1 3103,0 3158,1 3169,0 3172,1 3269,0 3312,1 3389,0 3418,1 3486,0 3585,1 3613,0 3689,1 3693,0 3778,1 3779,0 3857,1 3949,0 3974,1 4009,0 4023,1 4031,0 4124,1 4149,0 4248,1 4324,0 4348,1 4391,0 4475,1 4507,0 4589,1 4646,0 4656,1 4709,0 4753,1 4790,0 4849,1 4936,0 4961,1 5009,0 5074,1 5087,0 5129,1 5209,0 5216,1 5247,0 5315,1 5330,0 5370,1 5394,0 5447,1 5545,0 5590,1 5638,0 5678,1 5712,0 5748,1 5785,0 5878,1 5927,0 5990,1 6041,0 6061,1 6136,0 6206,1 6236,0 6254,1 6320,0 6419,1 6439,0 6524,1 6601,0 6605,1 6621,0 6624,1 6660,0 6681,1 6776,0 6781,1 6873,0 6905,1 6994,0 7064,1 7097,0 7151,1 7187,0 7236,1 7313,0 7367,1 7418,0 7482,1 7579,0 7593,1 7623,0 7659,1 7678,0 7732,1 7734,0 7794,1 7830,0 7922,1 7979,0 7981,1 8023,0 8104,1 8121,0 8125,1 8225,0 8259,1 8310,0 8364,1 8452,0 8530,1 8615,0 8692,1 8750,0 8765,1 8861,0 8897,1 8985,0 9008,1 9015,0 9076,1 9175,0 9188,1 9256,0 9335,1 9358,0 9458,1 9531,0 9607,1 9668,0 9762,1 9849,0 9850,1 9936,0 10007,1 10097,0 10172,1 10262,0 10283,1 10371,0 10436,1 10488,0 10543,1 10554,0 10582,1 10594,0 10691,1 10697,0 10764,1 10861,0 10873,1 10926,0 10986,1 11005,0 11027,1 11028,0 11104,1 11171,0 11257,1 11357,0 11440,1 11498,0 11507,1 11561,0 11612,1 11701,0 11729,1 11811,0 11840,1 11849,0 11946,1 12037,0 12092,1 12134,0 12175,1 12268,0 12271,1 12341,0 12436,1 12469,0 12546,1 12576,0 12627,1 12709,0 12779,1 12824,0 12833,1 12864,0 12917,1 12934,0 12941,1 12967,0 12989,1 13060,0 13115,1 end initlist b17 0,0 3,1 75,0 81,1 127,0 198,1 213,0 242,1 299,0 337,1 387,0 389,1 460,0 505,1 528,0 618,1 709,0 801,1 818,0 912,1 977,0 1047,1 1075,0 1166,1 1239,0 1333,1 1395,0 1453,1 1518,0 1591,1 1638,0 1683,1 1759,0 1841,1 1929,0 1935,1 1947,0 2039,1 2057,0 2087,1 2120,0 2181,1 2228,0 2291,1 2325,0 2328,1 2399,0 2421,1 2508,0 2521,1 2602,0 2681,1 2683,0 2686,1 2741,0 2834,1 2931,0 2967,1 3002,0 3069,1 3105,0 3144,1 3175,0 3272,1 3334,0 3399,1 3488,0 3550,1 3639,0 3724,1 3758,0 3812,1 3820,0 3861,1 3902,0 3903,1 3967,0 4066,1 4122,0 4170,1 4240,0 4265,1 4335,0 4384,1 4414,0 4470,1 4494,0 4520,1 4612,0 4645,1 4692,0 4770,1 4817,0 4875,1 4930,0 4956,1 4978,0 5007,1 5058,0 5102,1 5180,0 5186,1 5277,0 5293,1 5351,0 5426,1 5492,0 5511,1 5587,0 5597,1 5674,0 5765,1 5816,0 5861,1 5886,0 5942,1 5979,0 6034,1 6123,0 6146,1 6233,0 6251,1 6259,0 6344,1 6385,0 6440,1 6453,0 6487,1 6537,0 6587,1 6643,0 6713,1 6733,0 6793,1 6843,0 6867,1 6915,0 6985,1 7000,0 7089,1 7095,0 7142,1 7181,0 7226,1 7257,0 7350,1 7448,0 7482,1 7572,0 7666,1 7690,0 7702,1 7802,0 7858,1 7914,0 7955,1 7997,0 8067,1 8163,0 8248,1 8301,0 8363,1 8436,0 8493,1 8572,0 8581,1 8625,0 8686,1 8730,0 8737,1 8804,0 8821,1 8907,0 8923,1 8990,0 9071,1 9114,0 9213,1 9313,0 9333,1 9339,0 9378,1 9403,0 9455,1 9508,0 9521,1 9614,0 9708,1 9717,0 9799,1 9896,0 9957,1 10034,0 10057,1 10093,0 10120,1 10174,0 10266,1 10274,0 10348,1 10439,0 10479,1 10560,0 10623,1 10641,0 10659,1 10721,0 10792,1 10819,0 10872,1 10956,0 11014,1 11084,0 11160,1 11184,0 11275,1 11355,0 11445,1 11448,0 11464,1 11564,0 11651,1 11739,0 11809,1 11890,0 11943,1 12029,0 12042,1 12125,0 12138,1 12172,0 12198,1 12205,0 12267,1 12286,0 12373,1 12375,0 12399,1 12466,0 12549,1 12623,0 12655,1 12752,0 12779,1 12859,0 12921,1 12981,0 13000,1 13062,0 13101,1 13127,0 13198,1 13207,0 13300,1 13330,0 13379,1 13399,0 13474,1 end initlist b18 0,0 10,1 36,0 106,1 162,0 189,1 244,0 285,1 385,0 410,1 470,0 514,1 606,0 680,1 689,0 690,1 768,0 843,1 888,0 915,1 923,0 992,1 1045,0 1115,1 1162,0 1180,1 1256,0 1280,1 1338,0 1383,1 1398,0 1473,1 1502,0 1544,1 1560,0 1660,1 1720,0 1804,1 1898,0 1936,1 2022,0 2045,1 2129,0 2154,1 2206,0 2236,1 2288,0 2290,1 2340,0 2349,1 2362,0 2370,1 2434,0 2460,1 2560,0 2586,1 2592,0 2643,1 2648,0 2707,1 2754,0 2770,1 2779,0 2868,1 2956,0 3020,1 3118,0 3210,1 3234,0 3304,1 3305,0 3386,1 3434,0 3527,1 3612,0 3668,1 3703,0 3801,1 3840,0 3868,1 3893,0 3939,1 3962,0 4035,1 4081,0 4086,1 4150,0 4225,1 4270,0 4283,1 4358,0 4360,1 4397,0 4465,1 4559,0 4609,1 4655,0 4721,1 4787,0 4814,1 4880,0 4901,1 4950,0 4991,1 5079,0 5127,1 5148,0 5232,1 5307,0 5315,1 5332,0 5372,1 5454,0 5521,1 5527,0 5627,1 5683,0 5783,1 5818,0 5898,1 5949,0 5992,1 6079,0 6113,1 6149,0 6210,1 6257,0 6334,1 6350,0 6356,1 6434,0 6446,1 6466,0 6506,1 6531,0 6615,1 6684,0 6778,1 6829,0 6915,1 6964,0 7030,1 7082,0 7175,1 7200,0 7296,1 7347,0 7364,1 7414,0 7468,1 7479,0 7491,1 7544,0 7609,1 7654,0 7726,1 7775,0 7842,1 7939,0 8004,1 8092,0 8124,1 8154,0 8184,1 8268,0 8297,1 8382,0 8393,1 8488,0 8587,1 8615,0 8640,1 8733,0 8786,1 8804,0 8899,1 8991,0 9084,1 9143,0 9177,1 9270,0 9320,1 9321,0 9406,1 9500,0 9557,1 9580,0 9660,1 9720,0 9783,1 9844,0 9866,1 9870,0 9872,1 9965,0 9986,1 10083,0 10084,1 10114,0 10156,1 10256,0 10286,1 10334,0 10412,1 10465,0 10545,1 10643,0 10734,1 10739,0 10807,1 10873,0 10911,1 10979,0 10996,1 11072,0 11141,1 11204,0 11228,1 11250,0 11253,1 11320,0 11321,1 11352,0 11414,1 11507,0 11570,1 11619,0 11663,1 11751,0 11788,1 11818,0 11846,1 11874,0 11886,1 11915,0 11948,1 11966,0 12005,1 12065,0 12095,1 12100,0 12186,1 12194,0 12283,1 12351,0 12444,1 12532,0 12588,1 12611,0 12710,1 12779,0 12848,1 12871,0 12879,1 12930,0 12933,1 12952,0 12988,1 end initlist b19 0,0 82,1 160,0 194,1 217,0 277,1 302,0 325,1 373,0 411,1 478,0 563,1 663,0 718,1 768,0 795,1 887,0 938,1 1018,0 1061,1 1062,0 1099,1 1100,0 1188,1 1239,0 1338,1 1349,0 1381,1 1426,0 1474,1 1488,0 1585,1 1639,0 1707,1 1805,0 1899,1 1925,0 1929,1 2008,0 2015,1 2079,0 2130,1 2203,0 2301,1 2314,0 2407,1 2459,0 2522,1 2546,0 2606,1 2609,0 2640,1 2729,0 2744,1 2759,0 2763,1 2787,0 2882,1 2948,0 3004,1 3012,0 3070,1 3131,0 3144,1 3148,0 3179,1 3275,0 3338,1 3392,0 3450,1 3523,0 3599,1 3616,0 3686,1 3772,0 3806,1 3860,0 3888,1 3972,0 4031,1 4084,0 4121,1 4191,0 4235,1 4310,0 4398,1 4439,0 4517,1 4593,0 4691,1 4779,0 4857,1 4942,0 5038,1 5049,0 5064,1 5091,0 5177,1 5245,0 5336,1 5395,0 5495,1 5497,0 5571,1 5590,0 5646,1 5698,0 5750,1 5819,0 5847,1 5870,0 5878,1 5977,0 6076,1 6129,0 6164,1 6221,0 6285,1 6353,0 6364,1 6421,0 6496,1 6529,0 6595,1 6646,0 6676,1 6713,0 6725,1 6747,0 6794,1 6850,0 6873,1 6888,0 6953,1 7048,0 7143,1 7178,0 7208,1 7302,0 7394,1 7469,0 7533,1 7596,0 7665,1 7753,0 7775,1 7839,0 7863,1 7901,0 7993,1 8036,0 8109,1 8191,0 8261,1 8330,0 8331,1 8362,0 8457,1 8523,0 8560,1 8563,0 8597,1 8648,0 8657,1 8701,0 8786,1 8850,0 8901,1 8992,0 9086,1 9104,0 9143,1 9188,0 9252,1 9349,0 9435,1 9508,0 9532,1 9597,0 9600,1 9607,0 9652,1 9662,0 9752,1 9795,0 9891,1 9940,0 9947,1 10031,0 10041,1 10086,0 10111,1 10177,0 10215,1 10262,0 10293,1 10313,0 10347,1 10356,0 10435,1 10491,0 10498,1 10526,0 10558,1 10619,0 10620,1 10635,0 10673,1 10677,0 10695,1 10712,0 10713,1 10744,0 10791,1 10839,0 10908,1 10926,0 10947,1 10960,0 10999,1 11066,0 11105,1 11148,0 11200,1 11204,0 11285,1 11352,0 11356,1 11371,0 11405,1 11454,0 11465,1 11502,0 11590,1 11661,0 11709,1 11757,0 11803,1 11888,0 11966,1 12025,0 12028,1 12076,0 12102,1 12114,0 12189,1 12237,0 12274,1 12291,0 12386,1 12443,0 12522,1 12539,0 12590,1 12655,0 12740,1 12775,0 12814,1 end initlist b20 0,0 29,1 117,0 142,1 215,0 216,1 295,0 338,1 421,0 509,1 525,0 591,1 631,0 685,1 694,0 716,1 741,0 819,1 887,0 943,1 1039,0 1111,1 1128,0 1158,1 1222,0 1241,1 1325,0 1337,1 1362,0 1376,1 1475,0 1553,1 1614,0 1702,1 1778,0 1819,1 1899,0 1987,1 2075,0 2146,1 2186,0 2194,1 2213,0 2215,1 2265,0 2302,1 2355,0 2384,1 2450,0 2497,1 2578,0 2674,1 2770,0 2830,1 2843,0 2846,1 2874,0 2915,1 2964,0 3017,1 3071,0 3129,1 3134,0 3172,1 3218,0 3239,1 3339,0 3434,1 3447,0 3452,1 3468,0 3517,1 3576,0 3611,1 3631,0 3636,1 3671,0 3694,1 3745,0 3793,1 3817,0 3827,1 3848,0 3883,1 3921,0 3942,1 3984,0 4007,1 4099,0 4152,1 4169,0 4186,1 4285,0 4328,1 4368,0 4416,1 4440,0 4526,1 4529,0 4586,1 4686,0 4785,1 4881,0 4889,1 4947,0 5035,1 5113,0 5138,1 5229,0 5290,1 5345,0 5388,1 5393,0 5422,1 5495,0 5540,1 5546,0 5614,1 5684,0 5717,1 5767,0 5787,1 5789,0 5832,1 5865,0 5879,1 5949,0 5958,1 6043,0 6060,1 6093,0 6095,1 6194,0 6211,1 6226,0 6242,1 6336,0 6363,1 6451,0 6546,1 6563,0 6637,1 6692,0 6755,1 6759,0 6794,1 6814,0 6895,1 6980,0 7016,1 7107,0 7154,1 7229,0 7247,1 7314,0 7394,1 7433,0 7520,1 7578,0 7670,1 7688,0 7697,1 7703,0 7730,1 7743,0 7806,1 7896,0 7925,1 7942,0 7971,1 7979,0 8002,1 8056,0 8108,1 8208,0 8219,1 8233,0 8321,1 8332,0 8383,1 8407,0 8451,1 8467,0 8468,1 8500,0 8574,1 8584,0 8653,1 8656,0 8673,1 8718,0 8760,1 8860,0 8882,1 8967,0 9012,1 9022,0 9049,1 9124,0 9134,1 9209,0 9274,1 9289,0 9304,1 9346,0 9412,1 9460,0 9507,1 9514,0 9518,1 9587,0 9590,1 9624,0 9675,1 9679,0 9683,1 9776,0 9810,1 9811,0 9901,1 9955,0 9985,1 10071,0 10110,1 10200,0 10285,1 10321,0 10342,1 10357,0 10375,1 10412,0 10481,1 10522,0 10538,1 10579,0 10597,1 10651,0 10714,1 10727,0 10795,1 10844,0 10926,1 11023,0 11096,1 11169,0 11206,1 11303,0 11331,1 11426,0 11517,1 11551,0 11594,1 11692,0 11733,1 11747,0 11805,1 11879,0 11898,1 end initlist b21 0,0 92,1 187,0 284,1 360,0 419,1 487,0 497,1 579,0 626,1 718,0 771,1 860,0 902,1 922,0 1018,1 1111,0 1134,1 1169,0 1232,1 1322,0 1331,1 1417,0 1496,1 1546,0 1574,1 1668,0 1676,1 1716,0 1767,1 1862,0 1877,1 1925,0 2018,1 2049,0 2079,1 2160,0 2181,1 2221,0 2225,1 2275,0 2345,1 2441,0 2457,1 2542,0 2625,1 2712,0 2722,1 2805,0 2851,1 2880,0 2973,1 2995,0 3000,1 3063,0 3142,1 3183,0 3225,1 3271,0 3274,1 3341,0 3384,1 3472,0 3534,1 3586,0 3633,1 3701,0 3755,1 3799,0 3803,1 3885,0 3934,1 3975,0 3986,1 3999,0 4085,1 4100,0 4195,1 4209,0 4268,1 4290,0 4311,1 4394,0 4451,1 4529,0 4573,1 4604,0 4701,1 4781,0 4819,1 4909,0 4987,1 5034,0 5086,1 5183,0 5231,1 5318,0 5373,1 5469,0 5564,1 5661,0 5730,1 5794,0 5860,1 5874,0 5970,1 6050,0 6138,1 6202,0 6240,1 6247,0 6296,1 6365,0 6400,1 6410,0 6486,1 6571,0 6582,1 6589,0 6612,1 6685,0 6744,1 6817,0 6844,1 6869,0 6932,1 7023,0 7085,1 7134,0 7191,1 7211,0 7218,1 7275,0 7341,1 7441,0 7467,1 7531,0 7603,1 7665,0 7746,1 7818,0 7828,1 7892,0 7918,1 8016,0 8058,1 8064,0 8119,1 8204,0 8208,1 8219,0 8261,1 8325,0 8385,1 8430,0 8453,1 8503,0 8559,1 8644,0 8648,1 8669,0 8718,1 8785,0 8843,1 8848,0 8856,1 8901,0 8929,1 8990,0 9078,1 9107,0 9174,1 9209,0 9269,1 9358,0 9369,1 9392,0 9461,1 9479,0 9505,1 9525,0 9549,1 9606,0 9690,1 9727,0 9770,1 9793,0 9877,1 9942,0 10027,1 10114,0 10121,1 10172,0 10189,1 10256,0 10292,1 10313,0 10397,1 10450,0 10480,1 10571,0 10576,1 10656,0 10690,1 10733,0 10784,1 10814,0 10831,1 10921,0 11010,1 11027,0 11050,1 11138,0 11149,1 11191,0 11256,1 11308,0 11360,1 11397,0 11489,1 11538,0 11565,1 11566,0 11625,1 11632,0 11670,1 11756,0 11769,1 11811,0 11847,1 11905,0 11918,1 11954,0 12037,1 12100,0 12163,1 12250,0 12256,1 12258,0 12344,1 12414,0 12488,1 12522,0 12569,1 12628,0 12707,1 12786,0 12855,1 12892,0 12967,1 13063,0 13075,1 13127,0 13163,1 13189,0 13264,1 13346,0 13355,1 end initlist b22 0,0 30,1 43,0 124,1 192,0 206,1 301,0 357,1 364,0 415,1 479,0 573,1 659,0 699,1 713,0 732,1 828,0 838,1 895,0 958,1 968,0 985,1 1007,0 1023,1 1026,0 1050,1 1099,0 1198,1 1267,0 1288,1 1368,0 1428,1 1460,0 1558,1 1610,0 1668,1 1696,0 1761,1 1834,0 1847,1 1941,0 1951,1 2030,0 2076,1 2145,0 2171,1 2269,0 2303,1 2325,0 2328,1 2383,0 2409,1 2446,0 2454,1 2457,0 2555,1 2646,0 2675,1 2686,0 2765,1 2784,0 2854,1 2889,0 2925,1 2955,0 2964,1 3035,0 3040,1 3056,0 3127,1 3150,0 3242,1 3264,0 3282,1 3292,0 3309,1 3362,0 3420,1 3482,0 3564,1 3620,0 3631,1 3731,0 3830,1 3920,0 3987,1 4039,0 4126,1 4204,0 4239,1 4259,0 4354,1 4363,0 4463,1 4542,0 4547,1 4573,0 4653,1 4699,0 4767,1 4831,0 4888,1 4908,0 4975,1 5032,0 5116,1 5136,0 5229,1 5286,0 5371,1 5384,0 5404,1 5475,0 5527,1 5536,0 5549,1 5577,0 5645,1 5658,0 5726,1 5746,0 5794,1 5802,0 5817,1 5821,0 5831,1 5842,0 5933,1 5975,0 6050,1 6144,0 6238,1 6289,0 6321,1 6345,0 6407,1 6501,0 6514,1 6565,0 6578,1 6634,0 6716,1 6797,0 6890,1 6975,0 7033,1 7128,0 7168,1 7202,0 7245,1 7318,0 7329,1 7399,0 7487,1 7564,0 7636,1 7721,0 7769,1 7857,0 7914,1 7982,0 7986,1 8036,0 8054,1 8133,0 8152,1 8233,0 8293,1 8389,0 8466,1 8489,0 8585,1 8587,0 8590,1 8665,0 8686,1 8723,0 8752,1 8832,0 8913,1 8916,0 8933,1 8973,0 9015,1 9082,0 9132,1 9175,0 9246,1 9280,0 9281,1 9351,0 9398,1 9447,0 9541,1 9582,0 9599,1 9689,0 9746,1 9836,0 9845,1 9894,0 9916,1 9964,0 10050,1 10134,0 10194,1 10220,0 10278,1 10377,0 10476,1 10534,0 10584,1 10668,0 10701,1 10711,0 10751,1 10841,0 10875,1 10910,0 10951,1 11033,0 11065,1 11131,0 11148,1 11190,0 11205,1 11237,0 11322,1 11366,0 11387,1 11470,0 11535,1 11549,0 11639,1 11659,0 11736,1 11818,0 11906,1 11966,0 12018,1 12105,0 12170,1 12198,0 12291,1 12311,0 12337,1 12416,0 12421,1 12424,0 12430,1 12517,0 12612,1 12681,0 12709,1 12752,0 12842,1 12937,0 13008,1 end initlist b23 0,0 78,1 144,0 176,1 183,0 265,1 307,0 403,1 475,0 497,1 565,0 614,1 648,0 695,1 761,0 781,1 803,0 877,1 880,0 921,1 1009,0 1054,1 1094,0 1168,1 1191,0 1271,1 1313,0 1385,1 1386,0 1411,1 1415,0 1501,1 1546,0 1575,1 1576,0 1638,1 1674,0 1730,1 1830,0 1839,1 1917,0 1933,1 2026,0 2113,1 2147,0 2218,1 2224,0 2285,1 2353,0 2373,1 2437,0 2491,1 2562,0 2606,1 2618,0 2707,1 2800,0 2880,1 2972,0 3012,1 3105,0 3166,1 3248,0 3341,1 3361,0 3416,1 3461,0 3532,1 3558,0 3614,1 3648,0 3707,1 3747,0 3790,1 3863,0 3923,1 3935,0 4028,1 4037,0 4052,1 4059,0 4084,1 4181,0 4267,1 4355,0 4445,1 4471,0 4495,1 4593,0 4614,1 4640,0 4734,1 4771,0 4854,1 4954,0 4980,1 5022,0 5046,1 5140,0 5145,1 5225,0 5288,1 5290,0 5308,1 5333,0 5335,1 5389,0 5482,1 5542,0 5577,1 5613,0 5627,1 5660,0 5722,1 5759,0 5787,1 5843,0 5890,1 5969,0 5997,1 6046,0 6139,1 6199,0 6241,1 6267,0 6291,1 6364,0 6440,1 6503,0 6596,1 6672,0 6711,1 6754,0 6755,1 6811,0 6838,1 6929,0 6981,1 7047,0 7058,1 7116,0 7151,1 7180,0 7227,1 7228,0 7261,1 7359,0 7385,1 7411,0 7501,1 7526,0 7586,1 7598,0 7663,1 7725,0 7776,1 7806,0 7848,1 7882,0 7924,1 7953,0 8008,1 8070,0 8128,1 8205,0 8268,1 8281,0 8361,1 8404,0 8486,1 8544,0 8611,1 8671,0 8718,1 8785,0 8872,1 8956,0 9019,1 9107,0 9182,1 9245,0 9264,1 9278,0 9311,1 9364,0 9384,1 9454,0 9496,1 9522,0 9611,1 9652,0 9721,1 9768,0 9769,1 9802,0 9873,1 9973,0 9984,1 10012,0 10051,1 10091,0 10098,1 10165,0 10168,1 10186,0 10191,1 10280,0 10338,1 10360,0 10398,1 10399,0 10463,1 10478,0 10525,1 10582,0 10595,1 10664,0 10685,1 10752,0 10788,1 10865,0 10959,1 11033,0 11091,1 11182,0 11222,1 11293,0 11393,1 11443,0 11528,1 11531,0 11562,1 11658,0 11693,1 11746,0 11749,1 11837,0 11862,1 11884,0 11885,1 11926,0 11945,1 12000,0 12019,1 12041,0 12086,1 12142,0 12170,1 12199,0 12289,1 12339,0 12359,1 12380,0 12469,1 12524,0 12619,1 12712,0 12734,1 end initlist b24 0,0 4,1 95,0 102,1 181,0 183,1 264,0 300,1 354,0 427,1 512,0 569,1 646,0 711,1 789,0 873,1 969,0 991,1 1088,0 1113,1 1180,0 1234,1 1264,0 1361,1 1385,0 1445,1 1523,0 1534,1 1581,0 1642,1 1692,0 1769,1 1805,0 1881,1 1886,0 1927,1 1964,0 1969,1 1987,0 2034,1 2130,0 2154,1 2227,0 2289,1 2385,0 2469,1 2546,0 2549,1 2573,0 2662,1 2745,0 2754,1 2778,0 2836,1 2904,0 2982,1 2992,0 2998,1 3023,0 3083,1 3152,0 3216,1 3311,0 3377,1 3475,0 3546,1 3577,0 3598,1 3611,0 3674,1 3695,0 3772,1 3793,0 3804,1 3825,0 3856,1 3916,0 3983,1 4039,0 4092,1 4191,0 4207,1 4242,0 4286,1 4327,0 4413,1 4424,0 4458,1 4548,0 4594,1 4613,0 4659,1 4736,0 4793,1 4883,0 4922,1 4938,0 5002,1 5076,0 5123,1 5164,0 5253,1 5295,0 5331,1 5399,0 5404,1 5413,0 5415,1 5420,0 5498,1 5581,0 5648,1 5656,0 5687,1 5714,0 5781,1 5842,0 5919,1 6007,0 6038,1 6060,0 6128,1 6195,0 6215,1 6273,0 6285,1 6372,0 6439,1 6498,0 6521,1 6591,0 6638,1 6722,0 6781,1 6840,0 6883,1 6922,0 6931,1 7019,0 7102,1 7119,0 7203,1 7222,0 7242,1 7270,0 7282,1 7331,0 7390,1 7429,0 7458,1 7529,0 7580,1 7669,0 7691,1 7704,0 7765,1 7775,0 7796,1 7803,0 7889,1 7966,0 7999,1 8078,0 8169,1 8253,0 8300,1 8321,0 8396,1 8443,0 8461,1 8469,0 8549,1 8598,0 8674,1 8772,0 8841,1 8936,0 8952,1 8954,0 9011,1 9087,0 9088,1 9166,0 9199,1 9299,0 9355,1 9381,0 9431,1 9483,0 9557,1 9590,0 9650,1 9697,0 9783,1 9880,0 9951,1 10042,0 10101,1 10110,0 10169,1 10257,0 10354,1 10440,0 10501,1 10520,0 10576,1 10625,0 10628,1 10651,0 10735,1 10778,0 10848,1 10890,0 10936,1 10958,0 11048,1 11097,0 11102,1 11154,0 11244,1 11265,0 11277,1 11351,0 11423,1 11488,0 11569,1 11619,0 11625,1 11725,0 11741,1 11830,0 11902,1 11989,0 12024,1 12086,0 12089,1 12126,0 12158,1 12170,0 12215,1 12308,0 12310,1 12345,0 12372,1 12415,0 12513,1 12589,0 12632,1 12692,0 12767,1 12855,0 12887,1 12925,0 12948,1 12993,0 13007,1 13062,0 13149,1 end initlist b25 0,0 5,1 13,0 70,1 97,0 196,1 277,0 343,1 375,0 465,1 526,0 536,1 603,0 700,1 778,0 863,1 900,0 946,1 970,0 1053,1 1152,0 1237,1 1274,0 1358,1 1447,0 1456,1 1513,0 1578,1 1591,0 1614,1 1713,0 1747,1 1777,0 1846,1 1907,0 1988,1 2003,0 2008,1 2094,0 2175,1 2236,0 2255,1 2279,0 2353,1 2392,0 2434,1 2455,0 2554,1 2575,0 2616,1 2626,0 2679,1 2764,0 2859,1 2929,0 3027,1 3057,0 3069,1 3135,0 3163,1 3179,0 3191,1 3265,0 3356,1 3390,0 3490,1 3575,0 3624,1 3654,0 3658,1 3667,0 3753,1 3803,0 3814,1 3911,0 3919,1 3982,0 3992,1 4019,0 4116,1 4140,0 4179,1 4250,0 4281,1 4370,0 4397,1 4406,0 4447,1 4477,0 4498,1 4518,0 4548,1 4632,0 4717,1 4772,0 4795,1 4873,0 4877,1 4971,0 4973,1 4988,0 5086,1 5177,0 5243,1 5295,0 5348,1 5416,0 5488,1 5500,0 5580,1 5611,0 5654,1 5712,0 5764,1 5812,0 5813,1 5843,0 5912,1 5933,0 5991,1 6065,0 6075,1 6163,0 6192,1 6203,0 6248,1 6307,0 6384,1 6409,0 6456,1 6499,0 6515,1 6580,0 6680,1 6701,0 6796,1 6830,0 6924,1 7021,0 7049,1 7053,0 7143,1 7161,0 7232,1 7318,0 7413,1 7468,0 7554,1 7562,0 7579,1 7656,0 7738,1 7783,0 7864,1 7914,0 7927,1 7966,0 8016,1 8084,0 8146,1 8205,0 8261,1 8341,0 8424,1 8455,0 8486,1 8569,0 8631,1 8679,0 8760,1 8853,0 8937,1 9031,0 9091,1 9142,0 9184,1 9237,0 9315,1 9352,0 9451,1 9527,0 9552,1 9640,0 9659,1 9735,0 9798,1 9801,0 9832,1 9833,0 9893,1 9973,0 10033,1 10120,0 10152,1 10219,0 10286,1 10304,0 10342,1 10377,0 10399,1 10422,0 10453,1 10472,0 10495,1 10521,0 10597,1 10601,0 10628,1 10647,0 10704,1 10723,0 10729,1 10761,0 10775,1 10780,0 10860,1 10910,0 10977,1 11006,0 11032,1 11075,0 11131,1 11225,0 11228,1 11282,0 11325,1 11350,0 11417,1 11452,0 11550,1 11551,0 11573,1 11613,0 11698,1 11770,0 11829,1 11918,0 11971,1 12039,0 12129,1 12158,0 12248,1 12249,0 12261,1 12344,0 12427,1 12477,0 12485,1 12494,0 12552,1 12606,0 12631,1 12712,0 12786,1 12872,0 12931,1 12960,0 13010,1 end initlist b26 0,0 37,1 93,0 129,1 184,0 282,1 325,0 354,1 363,0 462,1 526,0 566,1 618,0 672,1 759,0 822,1 851,0 893,1 948,0 976,1 1056,0 1075,1 1127,0 1135,1 1224,0 1302,1 1326,0 1369,1 1376,0 1396,1 1470,0 1568,1 1662,0 1740,1 1766,0 1771,1 1805,0 1881,1 1902,0 1952,1 2025,0 2118,1 2153,0 2174,1 2261,0 2331,1 2399,0 2443,1 2472,0 2562,1 2586,0 2596,1 2673,0 2677,1 2718,0 2793,1 2840,0 2842,1 2883,0 2922,1 2954,0 2993,1 3022,0 3051,1 3075,0 3082,1 3089,0 3128,1 3224,0 3318,1 3402,0 3492,1 3568,0 3584,1 3614,0 3666,1 3744,0 3844,1 3943,0 3959,1 4056,0 4155,1 4237,0 4329,1 4336,0 4435,1 4440,0 4459,1 4523,0 4530,1 4586,0 4605,1 4608,0 4610,1 4665,0 4705,1 4790,0 4867,1 4963,0 5046,1 5108,0 5112,1 5175,0 5224,1 5279,0 5280,1 5321,0 5335,1 5428,0 5483,1 5562,0 5634,1 5676,0 5775,1 5796,0 5800,1 5801,0 5819,1 5907,0 5953,1 5990,0 6037,1 6054,0 6118,1 6177,0 6180,1 6236,0 6280,1 6324,0 6337,1 6392,0 6437,1 6513,0 6594,1 6627,0 6671,1 6704,0 6794,1 6829,0 6836,1 6882,0 6902,1 6989,0 7064,1 7144,0 7188,1 7204,0 7210,1 7297,0 7395,1 7411,0 7430,1 7445,0 7533,1 7576,0 7633,1 7644,0 7665,1 7755,0 7757,1 7841,0 7851,1 7879,0 7953,1 8005,0 8052,1 8064,0 8157,1 8211,0 8256,1 8290,0 8292,1 8364,0 8441,1 8452,0 8455,1 8491,0 8510,1 8519,0 8548,1 8636,0 8651,1 8709,0 8740,1 8838,0 8898,1 8984,0 9073,1 9109,0 9179,1 9249,0 9291,1 9319,0 9415,1 9430,0 9453,1 9502,0 9556,1 9650,0 9679,1 9734,0 9832,1 9902,0 9963,1 10028,0 10062,1 10085,0 10089,1 10185,0 10208,1 10305,0 10334,1 10424,0 10507,1 10540,0 10555,1 10651,0 10709,1 10796,0 10847,1 10898,0 10965,1 10976,0 11064,1 11098,0 11108,1 11182,0 11242,1 11266,0 11322,1 11372,0 11457,1 11488,0 11557,1 11618,0 11678,1 11770,0 11778,1 11800,0 11871,1 11935,0 11944,1 11991,0 12006,1 12106,0 12180,1 12199,0 12270,1 12275,0 12325,1 12422,0 12476,1 12574,0 12579,1 12674,0 12736,1 12754,0 12811,1 end initlist b27 0,0 77,1 155,0 178,1 211,0 262,1 271,0 301,1 324,0 404,1 477,0 543,1 578,0 606,1 627,0 688,1 694,0 713,1 715,0 793,1 799,0 801,1 838,0 880,1 923,0 1015,1 1049,0 1055,1 1102,0 1196,1 1291,0 1344,1 1412,0 1504,1 1547,0 1599,1 1617,0 1679,1 1739,0 1783,1 1792,0 1832,1 1894,0 1899,1 1924,0 1974,1 1980,0 2015,1 2105,0 2116,1 2142,0 2199,1 2263,0 2295,1 2354,0 2449,1 2499,0 2548,1 2641,0 2704,1 2719,0 2725,1 2824,0 2915,1 2953,0 2977,1 3027,0 3106,1 3174,0 3238,1 3259,0 3290,1 3308,0 3368,1 3395,0 3430,1 3471,0 3565,1 3580,0 3590,1 3637,0 3649,1 3736,0 3774,1 3864,0 3881,1 3904,0 3943,1 3955,0 3975,1 3997,0 4062,1 4078,0 4119,1 4184,0 4246,1 4322,0 4397,1 4408,0 4424,1 4458,0 4499,1 4500,0 4528,1 4560,0 4629,1 4693,0 4787,1 4817,0 4868,1 4884,0 4930,1 5002,0 5086,1 5147,0 5227,1 5324,0 5342,1 5421,0 5477,1 5507,0 5569,1 5620,0 5701,1 5748,0 5778,1 5789,0 5887,1 5911,0 5985,1 6032,0 6065,1 6147,0 6241,1 6292,0 6298,1 6299,0 6372,1 6449,0 6520,1 6590,0 6619,1 6705,0 6747,1 6819,0 6858,1 6886,0 6932,1 6988,0 7085,1 7108,0 7137,1 7184,0 7254,1 7350,0 7436,1 7477,0 7560,1 7617,0 7652,1 7746,0 7758,1 7785,0 7844,1 7858,0 7883,1 7955,0 7956,1 8048,0 8112,1 8121,0 8164,1 8246,0 8305,1 8390,0 8433,1 8531,0 8594,1 8672,0 8738,1 8746,0 8793,1 8872,0 8911,1 8947,0 9012,1 9032,0 9045,1 9050,0 9110,1 9165,0 9199,1 9271,0 9325,1 9422,0 9431,1 9461,0 9506,1 9541,0 9639,1 9718,0 9719,1 9736,0 9800,1 9844,0 9883,1 9894,0 9988,1 10072,0 10091,1 10125,0 10172,1 10227,0 10317,1 10348,0 10380,1 10427,0 10509,1 10608,0 10687,1 10767,0 10775,1 10815,0 10897,1 10936,0 10999,1 11054,0 11143,1 11146,0 11197,1 11283,0 11374,1 11381,0 11399,1 11464,0 11494,1 11565,0 11636,1 11639,0 11738,1 11755,0 11758,1 11800,0 11889,1 11951,0 12002,1 12064,0 12159,1 12211,0 12225,1 12228,0 12254,1 12256,0 12353,1 12397,0 12419,1 12482,0 12570,1 end initlist b28 0,0 28,1 74,0 159,1 190,0 270,1 358,0 444,1 459,0 533,1 541,0 554,1 572,0 603,1 634,0 638,1 719,0 811,1 880,0 926,1 1023,0 1062,1 1156,0 1208,1 1270,0 1338,1 1366,0 1455,1 1477,0 1496,1 1543,0 1546,1 1618,0 1708,1 1794,0 1823,1 1861,0 1946,1 2044,0 2114,1 2194,0 2270,1 2315,0 2415,1 2476,0 2496,1 2527,0 2610,1 2686,0 2782,1 2798,0 2880,1 2942,0 2947,1 2980,0 3067,1 3097,0 3101,1 3127,0 3151,1 3167,0 3200,1 3232,0 3315,1 3337,0 3411,1 3440,0 3489,1 3570,0 3589,1 3651,0 3709,1 3784,0 3815,1 3844,0 3856,1 3932,0 4004,1 4079,0 4103,1 4140,0 4142,1 4199,0 4281,1 4307,0 4326,1 4389,0 4486,1 4523,0 4602,1 4624,0 4684,1 4704,0 4781,1 4815,0 4905,1 5000,0 5034,1 5082,0 5161,1 5260,0 5319,1 5387,0 5468,1 5540,0 5589,1 5628,0 5629,1 5641,0 5662,1 5688,0 5763,1 5822,0 5884,1 5943,0 5947,1 6029,0 6031,1 6046,0 6138,1 6205,0 6247,1 6249,0 6280,1 6342,0 6372,1 6391,0 6417,1 6476,0 6477,1 6514,0 6604,1 6653,0 6735,1 6740,0 6761,1 6808,0 6878,1 6922,0 6955,1 7043,0 7123,1 7169,0 7266,1 7349,0 7385,1 7419,0 7448,1 7513,0 7543,1 7631,0 7711,1 7747,0 7773,1 7793,0 7870,1 7968,0 8018,1 8082,0 8172,1 8228,0 8312,1 8370,0 8465,1 8535,0 8613,1 8617,0 8618,1 8636,0 8695,1 8786,0 8865,1 8948,0 8978,1 8982,0 9028,1 9075,0 9135,1 9183,0 9245,1 9309,0 9342,1 9400,0 9494,1 9496,0 9584,1 9591,0 9666,1 9729,0 9752,1 9841,0 9862,1 9901,0 9967,1 9994,0 10001,1 10067,0 10162,1 10180,0 10196,1 10249,0 10293,1 10335,0 10366,1 10429,0 10520,1 10555,0 10599,1 10621,0 10649,1 10734,0 10745,1 10834,0 10881,1 10923,0 10996,1 11083,0 11107,1 11151,0 11246,1 11326,0 11350,1 11402,0 11463,1 11490,0 11539,1 11613,0 11712,1 11780,0 11837,1 11928,0 11963,1 11971,0 12054,1 12057,0 12127,1 12213,0 12254,1 12255,0 12350,1 12441,0 12502,1 12527,0 12613,1 12646,0 12706,1 12785,0 12844,1 12892,0 12921,1 12979,0 13026,1 13103,0 13151,1 13239,0 13326,1 13348,0 13440,1 end initlist b29 0,0 37,1 46,0 54,1 63,0 125,1 165,0 209,1 279,0 372,1 421,0 469,1 486,0 586,1 678,0 696,1 775,0 844,1 918,0 1000,1 1020,0 1094,1 1130,0 1181,1 1212,0 1298,1 1357,0 1429,1 1481,0 1486,1 1539,0 1580,1 1674,0 1718,1 1761,0 1837,1 1880,0 1938,1 1977,0 2054,1 2113,0 2131,1 2167,0 2174,1 2238,0 2316,1 2381,0 2441,1 2499,0 2573,1 2609,0 2630,1 2669,0 2722,1 2805,0 2905,1 2965,0 3023,1 3071,0 3127,1 3192,0 3211,1 3222,0 3238,1 3313,0 3328,1 3360,0 3452,1 3498,0 3525,1 3541,0 3636,1 3684,0 3761,1 3830,0 3880,1 3943,0 4030,1 4059,0 4126,1 4223,0 4274,1 4356,0 4446,1 4497,0 4578,1 4655,0 4727,1 4730,0 4780,1 4804,0 4848,1 4854,0 4908,1 4950,0 4964,1 4967,0 5021,1 5103,0 5155,1 5181,0 5235,1 5287,0 5306,1 5369,0 5438,1 5513,0 5548,1 5557,0 5609,1 5673,0 5700,1 5764,0 5823,1 5883,0 5915,1 5985,0 6083,1 6086,0 6184,1 6277,0 6330,1 6412,0 6449,1 6523,0 6601,1 6655,0 6669,1 6682,0 6753,1 6828,0 6924,1 6996,0 7017,1 7105,0 7133,1 7143,0 7186,1 7279,0 7360,1 7429,0 7505,1 7600,0 7699,1 7755,0 7821,1 7854,0 7952,1 7955,0 7963,1 7985,0 8042,1 8113,0 8129,1 8155,0 8188,1 8233,0 8237,1 8240,0 8249,1 8325,0 8410,1 8481,0 8536,1 8614,0 8667,1 8720,0 8740,1 8764,0 8807,1 8872,0 8898,1 8985,0 9043,1 9055,0 9141,1 9175,0 9182,1 9249,0 9283,1 9345,0 9436,1 9472,0 9488,1 9586,0 9589,1 9671,0 9734,1 9777,0 9800,1 9876,0 9943,1 10003,0 10061,1 10119,0 10125,1 10129,0 10224,1 10263,0 10319,1 10407,0 10500,1 10539,0 10576,1 10650,0 10703,1 10788,0 10792,1 10871,0 10875,1 10877,0 10910,1 10939,0 11011,1 11029,0 11107,1 11144,0 11168,1 11222,0 11294,1 11307,0 11319,1 11415,0 11429,1 11469,0 11481,1 11576,0 11588,1 11601,0 11690,1 11730,0 11748,1 11798,0 11879,1 11905,0 11993,1 12030,0 12063,1 12079,0 12164,1 12179,0 12275,1 12314,0 12383,1 12409,0 12412,1 12451,0 12531,1 12601,0 12684,1 12735,0 12758,1 12830,0 12892,1 12983,0 13059,1 13062,0 13138,1 end initlist b30 0,0 14,1 96,0 124,1 202,0 237,1 298,0 304,1 389,0 465,1 556,0 560,1 565,0 655,1 734,0 790,1 807,0 815,1 904,0 934,1 946,0 1002,1 1102,0 1107,1 1201,0 1268,1 1317,0 1378,1 1468,0 1552,1 1599,0 1696,1 1714,0 1725,1 1820,0 1895,1 1902,0 1942,1 2026,0 2114,1 2208,0 2217,1 2310,0 2389,1 2409,0 2474,1 2565,0 2585,1 2671,0 2727,1 2821,0 2918,1 2978,0 2979,1 2988,0 2998,1 3012,0 3047,1 3069,0 3143,1 3211,0 3258,1 3269,0 3343,1 3345,0 3439,1 3498,0 3547,1 3599,0 3696,1 3781,0 3788,1 3857,0 3924,1 3947,0 4039,1 4081,0 4135,1 4144,0 4215,1 4271,0 4280,1 4357,0 4390,1 4453,0 4479,1 4515,0 4547,1 4604,0 4628,1 4709,0 4801,1 4834,0 4909,1 5000,0 5086,1 5120,0 5144,1 5175,0 5228,1 5275,0 5314,1 5351,0 5360,1 5368,0 5380,1 5393,0 5485,1 5492,0 5544,1 5621,0 5644,1 5705,0 5761,1 5808,0 5881,1 5911,0 5965,1 6045,0 6092,1 6101,0 6119,1 6187,0 6274,1 6293,0 6321,1 6377,0 6446,1 6484,0 6492,1 6557,0 6628,1 6668,0 6759,1 6814,0 6904,1 6946,0 7000,1 7061,0 7077,1 7120,0 7177,1 7236,0 7305,1 7337,0 7353,1 7360,0 7361,1 7418,0 7504,1 7529,0 7530,1 7556,0 7595,1 7618,0 7653,1 7721,0 7807,1 7855,0 7933,1 7942,0 8031,1 8064,0 8077,1 8123,0 8164,1 8240,0 8252,1 8288,0 8308,1 8386,0 8403,1 8486,0 8511,1 8547,0 8631,1 8637,0 8649,1 8680,0 8767,1 8805,0 8816,1 8832,0 8904,1 8951,0 8996,1 9090,0 9093,1 9155,0 9236,1 9312,0 9323,1 9423,0 9509,1 9574,0 9664,1 9692,0 9744,1 9775,0 9861,1 9890,0 9945,1 10007,0 10070,1 10099,0 10129,1 10134,0 10172,1 10175,0 10214,1 10297,0 10358,1 10400,0 10470,1 10500,0 10526,1 10603,0 10675,1 10772,0 10810,1 10846,0 10882,1 10903,0 10993,1 11090,0 11123,1 11185,0 11250,1 11324,0 11370,1 11408,0 11464,1 11534,0 11601,1 11668,0 11754,1 11775,0 11830,1 11844,0 11941,1 11943,0 11981,1 12016,0 12115,1 12211,0 12240,1 12247,0 12249,1 12332,0 12395,1 12493,0 12526,1 12533,0 12609,1 12621,0 12646,1 12659,0 12722,1 end initlist b31 0,0 33,1 59,0 65,1 88,0 163,1 212,0 307,1 401,0 405,1 425,0 479,1 564,0 648,1 670,0 748,1 802,0 836,1 895,0 933,1 939,0 1015,1 1091,0 1160,1 1188,0 1233,1 1327,0 1419,1 1479,0 1497,1 1528,0 1606,1 1706,0 1710,1 1756,0 1839,1 1898,0 1982,1 2005,0 2007,1 2035,0 2052,1 2124,0 2214,1 2249,0 2329,1 2392,0 2439,1 2456,0 2523,1 2537,0 2611,1 2709,0 2756,1 2826,0 2889,1 2986,0 2999,1 3086,0 3123,1 3199,0 3200,1 3243,0 3289,1 3378,0 3426,1 3490,0 3525,1 3555,0 3604,1 3686,0 3755,1 3806,0 3819,1 3910,0 3942,1 4019,0 4085,1 4140,0 4199,1 4291,0 4358,1 4402,0 4409,1 4481,0 4575,1 4603,0 4679,1 4779,0 4789,1 4873,0 4905,1 4959,0 5048,1 5113,0 5209,1 5241,0 5326,1 5364,0 5455,1 5477,0 5485,1 5579,0 5646,1 5679,0 5736,1 5806,0 5892,1 5895,0 5901,1 5992,0 6001,1 6061,0 6085,1 6111,0 6187,1 6240,0 6241,1 6280,0 6361,1 6405,0 6499,1 6584,0 6633,1 6682,0 6699,1 6732,0 6792,1 6861,0 6873,1 6909,0 6951,1 7021,0 7059,1 7131,0 7143,1 7183,0 7196,1 7233,0 7314,1 7403,0 7458,1 7479,0 7577,1 7641,0 7679,1 7753,0 7807,1 7877,0 7881,1 7920,0 7977,1 7996,0 8039,1 8088,0 8136,1 8173,0 8250,1 8255,0 8284,1 8347,0 8444,1 8541,0 8631,1 8701,0 8773,1 8832,0 8849,1 8855,0 8925,1 9021,0 9110,1 9200,0 9286,1 9300,0 9397,1 9483,0 9557,1 9644,0 9707,1 9717,0 9812,1 9853,0 9909,1 10001,0 10043,1 10133,0 10154,1 10242,0 10283,1 10341,0 10436,1 10460,0 10559,1 10578,0 10617,1 10652,0 10747,1 10818,0 10905,1 10916,0 11012,1 11052,0 11144,1 11185,0 11201,1 11244,0 11325,1 11421,0 11480,1 11523,0 11574,1 11598,0 11617,1 11672,0 11711,1 11752,0 11779,1 11868,0 11870,1 11913,0 12013,1 12041,0 12117,1 12161,0 12222,1 12247,0 12318,1 12332,0 12398,1 12450,0 12459,1 12488,0 12571,1 12591,0 12643,1 12733,0 12801,1 12844,0 12899,1 12922,0 13000,1 13100,0 13182,1 13217,0 13250,1 13289,0 13317,1 13386,0 13426,1 13495,0 13497,1 13569,0 13627,1 13674,0 13741,1 13814,0 13835,1 end initlist b32 0,0 56,1 118,0 174,1 192,0 276,1 354,0 431,1 453,0 546,1 576,0 603,1 627,0 717,1 760,0 762,1 783,0 824,1 910,0 919,1 987,0 1017,1 1049,0 1106,1 1146,0 1230,1 1260,0 1300,1 1360,0 1381,1 1458,0 1553,1 1558,0 1604,1 1688,0 1733,1 1823,0 1828,1 1858,0 1892,1 1963,0 1978,1 1984,0 2042,1 2063,0 2105,1 2193,0 2235,1 2257,0 2292,1 2321,0 2346,1 2383,0 2398,1 2486,0 2495,1 2521,0 2595,1 2619,0 2662,1 2732,0 2739,1 2838,0 2889,1 2917,0 2928,1 2972,0 3041,1 3079,0 3169,1 3180,0 3246,1 3290,0 3307,1 3357,0 3427,1 3464,0 3478,1 3576,0 3649,1 3697,0 3730,1 3767,0 3867,1 3923,0 4002,1 4072,0 4094,1 4119,0 4155,1 4226,0 4292,1 4366,0 4407,1 4461,0 4532,1 4612,0 4642,1 4658,0 4726,1 4793,0 4825,1 4865,0 4880,1 4979,0 5012,1 5104,0 5138,1 5158,0 5175,1 5185,0 5195,1 5281,0 5360,1 5399,0 5425,1 5436,0 5525,1 5551,0 5605,1 5684,0 5737,1 5781,0 5786,1 5830,0 5878,1 5955,0 5995,1 6020,0 6060,1 6064,0 6075,1 6126,0 6215,1 6235,0 6332,1 6385,0 6386,1 6432,0 6444,1 6446,0 6460,1 6462,0 6560,1 6635,0 6700,1 6772,0 6820,1 6856,0 6915,1 6985,0 7002,1 7006,0 7053,1 7071,0 7072,1 7098,0 7112,1 7189,0 7261,1 7343,0 7364,1 7462,0 7520,1 7594,0 7630,1 7671,0 7738,1 7819,0 7835,1 7860,0 7951,1 8011,0 8062,1 8079,0 8153,1 8186,0 8282,1 8378,0 8445,1 8480,0 8532,1 8541,0 8611,1 8655,0 8741,1 8750,0 8807,1 8888,0 8928,1 8957,0 8989,1 9007,0 9099,1 9166,0 9208,1 9264,0 9336,1 9361,0 9447,1 9502,0 9568,1 9590,0 9613,1 9684,0 9697,1 9735,0 9740,1 9783,0 9880,1 9955,0 10034,1 10051,0 10114,1 10138,0 10169,1 10170,0 10183,1 10276,0 10330,1 10384,0 10434,1 10488,0 10544,1 10563,0 10566,1 10602,0 10645,1 10648,0 10690,1 10761,0 10817,1 10880,0 10893,1 10967,0 10969,1 11063,0 11104,1 11185,0 11243,1 11263,0 11291,1 11360,0 11389,1 11468,0 11501,1 11582,0 11677,1 11742,0 11781,1 11826,0 11874,1 11880,0 11970,1 11993,0 12011,1 12096,0 12130,1 end initlist b33 0,0 8,1 91,0 127,1 140,0 179,1 245,0 313,1 370,0 459,1 491,0 551,1 629,0 656,1 685,0 720,1 774,0 865,1 885,0 976,1 1027,0 1036,1 1105,0 1107,1 1152,0 1207,1 1286,0 1341,1 1420,0 1470,1 1567,0 1658,1 1746,0 1811,1 1819,0 1867,1 1923,0 1950,1 2050,0 2092,1 2134,0 2204,1 2247,0 2339,1 2419,0 2497,1 2502,0 2540,1 2549,0 2622,1 2647,0 2689,1 2775,0 2865,1 2874,0 2935,1 2988,0 3061,1 3111,0 3203,1 3251,0 3257,1 3352,0 3426,1 3525,0 3542,1 3634,0 3679,1 3772,0 3872,1 3920,0 3966,1 4022,0 4106,1 4199,0 4218,1 4270,0 4329,1 4331,0 4351,1 4366,0 4369,1 4420,0 4503,1 4504,0 4534,1 4618,0 4649,1 4662,0 4685,1 4704,0 4715,1 4743,0 4771,1 4823,0 4918,1 4944,0 4974,1 5004,0 5012,1 5056,0 5061,1 5152,0 5243,1 5306,0 5348,1 5363,0 5396,1 5446,0 5478,1 5498,0 5578,1 5586,0 5647,1 5665,0 5688,1 5693,0 5730,1 5760,0 5775,1 5825,0 5874,1 5940,0 6040,1 6076,0 6125,1 6132,0 6150,1 6215,0 6311,1 6365,0 6403,1 6444,0 6476,1 6565,0 6593,1 6620,0 6638,1 6701,0 6735,1 6746,0 6807,1 6882,0 6915,1 6925,0 6959,1 7039,0 7073,1 7156,0 7234,1 7273,0 7329,1 7354,0 7383,1 7454,0 7508,1 7511,0 7526,1 7590,0 7653,1 7698,0 7790,1 7823,0 7852,1 7894,0 7968,1 7999,0 8030,1 8111,0 8187,1 8275,0 8292,1 8337,0 8427,1 8486,0 8510,1 8512,0 8541,1 8602,0 8606,1 8669,0 8720,1 8755,0 8842,1 8911,0 8937,1 8996,0 9046,1 9048,0 9078,1 9080,0 9163,1 9211,0 9284,1 9285,0 9301,1 9310,0 9332,1 9432,0 9441,1 9517,0 9562,1 9580,0 9631,1 9687,0 9761,1 9822,0 9900,1 9957,0 10021,1 10063,0 10163,1 10226,0 10250,1 10337,0 10356,1 10373,0 10471,1 10545,0 10586,1 10601,0 10692,1 10777,0 10791,1 10800,0 10858,1 10925,0 10983,1 11072,0 11138,1 11235,0 11243,1 11319,0 11414,1 11489,0 11588,1 11612,0 11630,1 11660,0 11714,1 11779,0 11836,1 11889,0 11963,1 12038,0 12133,1 12139,0 12202,1 12225,0 12275,1 12277,0 12290,1 12291,0 12331,1 12353,0 12395,1 12429,0 12478,1 end initlist b34 0,0 56,1 150,0 210,1 239,0 312,1 354,0 397,1 459,0 543,1 569,0 589,1 659,0 755,1 805,0 822,1 910,0 935,1 1019,0 1046,1 1072,0 1153,1 1244,0 1320,1 1367,0 1397,1 1459,0 1472,1 1484,0 1509,1 1554,0 1562,1 1602,0 1624,1 1655,0 1736,1 1737,0 1768,1 1779,0 1834,1 1907,0 1936,1 1991,0 2069,1 2093,0 2118,1 2211,0 2299,1 2369,0 2404,1 2466,0 2551,1 2638,0 2738,1 2758,0 2845,1 2913,0 2972,1 3003,0 3101,1 3108,0 3121,1 3184,0 3206,1 3269,0 3273,1 3277,0 3374,1 3390,0 3419,1 3478,0 3498,1 3523,0 3621,1 3624,0 3627,1 3708,0 3748,1 3840,0 3913,1 3996,0 4017,1 4103,0 4135,1 4209,0 4216,1 4266,0 4355,1 4371,0 4414,1 4486,0 4543,1 4587,0 4611,1 4641,0 4714,1 4741,0 4793,1 4871,0 4930,1 4956,0 5010,1 5014,0 5042,1 5105,0 5174,1 5243,0 5276,1 5284,0 5357,1 5428,0 5451,1 5475,0 5570,1 5579,0 5663,1 5713,0 5758,1 5774,0 5775,1 5847,0 5936,1 5998,0 6093,1 6146,0 6207,1 6242,0 6246,1 6332,0 6418,1 6431,0 6530,1 6540,0 6639,1 6659,0 6747,1 6749,0 6843,1 6852,0 6888,1 6953,0 7041,1 7108,0 7144,1 7157,0 7161,1 7246,0 7332,1 7380,0 7419,1 7509,0 7519,1 7534,0 7617,1 7665,0 7675,1 7711,0 7765,1 7822,0 7829,1 7830,0 7867,1 7932,0 7944,1 8034,0 8041,1 8128,0 8140,1 8201,0 8222,1 8268,0 8337,1 8368,0 8391,1 8403,0 8452,1 8471,0 8483,1 8539,0 8585,1 8680,0 8741,1 8750,0 8761,1 8826,0 8900,1 8946,0 9037,1 9111,0 9165,1 9179,0 9241,1 9281,0 9296,1 9365,0 9462,1 9542,0 9565,1 9654,0 9737,1 9774,0 9785,1 9868,0 9931,1 10020,0 10037,1 10102,0 10182,1 10229,0 10253,1 10291,0 10337,1 10347,0 10377,1 10423,0 10487,1 10497,0 10578,1 10646,0 10697,1 10703,0 10744,1 10834,0 10884,1 10945,0 11006,1 11050,0 11061,1 11097,0 11109,1 11194,0 11256,1 11342,0 11437,1 11484,0 11556,1 11573,0 11620,1 11669,0 11740,1 11775,0 11794,1 11853,0 11945,1 11959,0 11966,1 11967,0 11988,1 12036,0 12107,1 12108,0 12166,1 12208,0 12276,1 12364,0 12457,1 12496,0 12519,1 end initlist b35 0,0 78,1 146,0 191,1 271,0 299,1 388,0 438,1 466,0 493,1 547,0 584,1 636,0 659,1 751,0 767,1 807,0 816,1 859,0 873,1 886,0 936,1 996,0 1012,1 1055,0 1074,1 1092,0 1152,1 1166,0 1210,1 1279,0 1358,1 1380,0 1425,1 1491,0 1508,1 1574,0 1630,1 1648,0 1738,1 1819,0 1874,1 1880,0 1951,1 2022,0 2086,1 2118,0 2213,1 2299,0 2330,1 2408,0 2416,1 2465,0 2467,1 2551,0 2585,1 2678,0 2720,1 2764,0 2797,1 2876,0 2952,1 3011,0 3072,1 3104,0 3200,1 3253,0 3262,1 3301,0 3327,1 3375,0 3435,1 3462,0 3538,1 3577,0 3627,1 3687,0 3770,1 3828,0 3910,1 3973,0 3999,1 4037,0 4087,1 4124,0 4139,1 4182,0 4213,1 4302,0 4330,1 4408,0 4444,1 4524,0 4621,1 4687,0 4771,1 4833,0 4915,1 4926,0 4976,1 5030,0 5059,1 5146,0 5238,1 5309,0 5369,1 5377,0 5409,1 5439,0 5490,1 5550,0 5598,1 5634,0 5640,1 5651,0 5694,1 5753,0 5778,1 5784,0 5877,1 5890,0 5912,1 5917,0 6003,1 6102,0 6153,1 6215,0 6251,1 6295,0 6349,1 6351,0 6364,1 6397,0 6438,1 6445,0 6470,1 6542,0 6545,1 6616,0 6696,1 6759,0 6823,1 6888,0 6924,1 6963,0 7017,1 7110,0 7209,1 7234,0 7266,1 7330,0 7417,1 7441,0 7461,1 7477,0 7543,1 7565,0 7590,1 7607,0 7671,1 7694,0 7784,1 7793,0 7868,1 7955,0 8017,1 8061,0 8098,1 8105,0 8178,1 8194,0 8235,1 8283,0 8290,1 8326,0 8413,1 8499,0 8533,1 8619,0 8637,1 8670,0 8770,1 8852,0 8864,1 8953,0 8959,1 9019,0 9095,1 9133,0 9213,1 9257,0 9325,1 9387,0 9390,1 9438,0 9461,1 9528,0 9608,1 9686,0 9707,1 9733,0 9775,1 9784,0 9866,1 9955,0 10022,1 10058,0 10087,1 10131,0 10135,1 10212,0 10242,1 10300,0 10308,1 10386,0 10411,1 10437,0 10533,1 10584,0 10654,1 10678,0 10734,1 10769,0 10867,1 10900,0 10979,1 11062,0 11119,1 11185,0 11218,1 11279,0 11356,1 11409,0 11473,1 11487,0 11528,1 11571,0 11613,1 11700,0 11781,1 11786,0 11876,1 11927,0 11998,1 12036,0 12057,1 12112,0 12200,1 12222,0 12280,1 12346,0 12368,1 12457,0 12555,1 12565,0 12640,1 12676,0 12763,1 end initlist b36 0,0 98,1 132,0 171,1 265,0 295,1 327,0 405,1 443,0 474,1 494,0 524,1 622,0 705,1 720,0 732,1 786,0 874,1 882,0 966,1 981,0 1043,1 1143,0 1205,1 1245,0 1328,1 1400,0 1416,1 1471,0 1526,1 1538,0 1542,1 1568,0 1647,1 1651,0 1728,1 1776,0 1836,1 1919,0 2011,1 2033,0 2039,1 2040,0 2100,1 2122,0 2127,1 2165,0 2167,1 2189,0 2282,1 2285,0 2370,1 2380,0 2381,1 2423,0 2454,1 2522,0 2549,1 2562,0 2605,1 2606,0 2684,1 2745,0 2775,1 2816,0 2870,1 2970,0 3068,1 3069,0 3075,1 3148,0 3159,1 3183,0 3249,1 3252,0 3296,1 3320,0 3408,1 3437,0 3522,1 3532,0 3540,1 3573,0 3621,1 3692,0 3758,1 3766,0 3796,1 3851,0 3904,1 3946,0 4001,1 4030,0 4078,1 4137,0 4212,1 4291,0 4334,1 4343,0 4441,1 4516,0 4605,1 4683,0 4733,1 4779,0 4794,1 4855,0 4877,1 4911,0 5001,1 5094,0 5139,1 5150,0 5207,1 5239,0 5259,1 5268,0 5303,1 5359,0 5419,1 5506,0 5529,1 5594,0 5613,1 5681,0 5738,1 5743,0 5759,1 5769,0 5828,1 5924,0 5939,1 5975,0 6036,1 6075,0 6156,1 6172,0 6232,1 6278,0 6344,1 6391,0 6401,1 6483,0 6570,1 6647,0 6725,1 6730,0 6784,1 6832,0 6913,1 6950,0 6975,1 6988,0 7028,1 7090,0 7108,1 7175,0 7235,1 7260,0 7319,1 7411,0 7441,1 7462,0 7508,1 7518,0 7543,1 7638,0 7678,1 7734,0 7737,1 7743,0 7753,1 7823,0 7840,1 7859,0 7951,1 8015,0 8095,1 8157,0 8206,1 8306,0 8354,1 8398,0 8400,1 8405,0 8467,1 8566,0 8598,1 8606,0 8649,1 8729,0 8825,1 8924,0 8989,1 9086,0 9174,1 9201,0 9229,1 9300,0 9327,1 9374,0 9430,1 9484,0 9536,1 9541,0 9558,1 9650,0 9676,1 9745,0 9841,1 9854,0 9899,1 9997,0 10036,1 10082,0 10111,1 10150,0 10225,1 10240,0 10267,1 10356,0 10424,1 10482,0 10512,1 10601,0 10641,1 10684,0 10717,1 10776,0 10781,1 10840,0 10880,1 10911,0 10935,1 11000,0 11074,1 11120,0 11154,1 11215,0 11272,1 11303,0 11358,1 11450,0 11532,1 11575,0 11642,1 11680,0 11739,1 11774,0 11832,1 11875,0 11952,1 11979,0 12023,1 12123,0 12166,1 12209,0 12241,1 end initlist b37 0,0 86,1 158,0 244,1 252,0 309,1 320,0 327,1 338,0 372,1 421,0 423,1 462,0 488,1 510,0 541,1 590,0 634,1 649,0 656,1 686,0 755,1 785,0 804,1 891,0 900,1 1000,0 1036,1 1110,0 1136,1 1166,0 1207,1 1277,0 1324,1 1390,0 1441,1 1517,0 1617,1 1700,0 1768,1 1862,0 1894,1 1951,0 1991,1 2067,0 2073,1 2074,0 2118,1 2141,0 2176,1 2179,0 2227,1 2263,0 2264,1 2277,0 2319,1 2361,0 2426,1 2463,0 2488,1 2520,0 2603,1 2676,0 2681,1 2722,0 2806,1 2831,0 2873,1 2962,0 3013,1 3086,0 3111,1 3135,0 3164,1 3251,0 3306,1 3356,0 3438,1 3489,0 3586,1 3646,0 3673,1 3713,0 3794,1 3848,0 3885,1 3946,0 3975,1 4037,0 4046,1 4071,0 4144,1 4158,0 4253,1 4349,0 4431,1 4432,0 4451,1 4502,0 4575,1 4647,0 4729,1 4815,0 4892,1 4981,0 4995,1 5048,0 5102,1 5111,0 5170,1 5208,0 5290,1 5375,0 5450,1 5518,0 5582,1 5608,0 5682,1 5720,0 5799,1 5885,0 5908,1 5935,0 5952,1 5968,0 6012,1 6050,0 6148,1 6196,0 6209,1 6298,0 6380,1 6458,0 6475,1 6492,0 6560,1 6564,0 6643,1 6737,0 6812,1 6890,0 6970,1 6998,0 7064,1 7130,0 7222,1 7257,0 7300,1 7388,0 7424,1 7487,0 7580,1 7625,0 7635,1 7690,0 7715,1 7809,0 7847,1 7869,0 7911,1 7914,0 7947,1 7988,0 8020,1 8039,0 8104,1 8198,0 8286,1 8355,0 8359,1 8446,0 8453,1 8454,0 8517,1 8597,0 8660,1 8699,0 8736,1 8761,0 8860,1 8929,0 8960,1 8980,0 9040,1 9096,0 9142,1 9188,0 9265,1 9307,0 9327,1 9370,0 9401,1 9448,0 9517,1 9608,0 9637,1 9714,0 9721,1 9741,0 9804,1 9854,0 9858,1 9900,0 9965,1 9994,0 10087,1 10187,0 10191,1 10211,0 10273,1 10313,0 10381,1 10467,0 10548,1 10632,0 10694,1 10743,0 10770,1 10805,0 10838,1 10894,0 10956,1 10995,0 10997,1 11066,0 11106,1 11200,0 11240,1 11304,0 11392,1 11444,0 11533,1 11559,0 11638,1 11657,0 11703,1 11716,0 11748,1 11841,0 11902,1 11949,0 12041,1 12099,0 12158,1 12178,0 12257,1 12275,0 12325,1 12423,0 12461,1 12535,0 12544,1 12561,0 12564,1 12658,0 12740,1 12808,0 12848,1 end initlist b38 0,0 71,1 107,0 172,1 221,0 292,1 343,0 408,1 427,0 440,1 490,0 538,1 630,0 707,1 783,0 797,1 860,0 889,1 927,0 1024,1 1046,0 1133,1 1157,0 1256,1 1266,0 1319,1 1358,0 1419,1 1484,0 1504,1 1590,0 1660,1 1751,0 1820,1 1846,0 1869,1 1944,0 1948,1 2038,0 2096,1 2119,0 2194,1 2279,0 2298,1 2314,0 2408,1 2452,0 2474,1 2557,0 2617,1 2635,0 2671,1 2738,0 2776,1 2866,0 2903,1 2909,0 2981,1 3026,0 3087,1 3103,0 3169,1 3264,0 3360,1 3388,0 3421,1 3438,0 3453,1 3527,0 3553,1 3611,0 3701,1 3766,0 3858,1 3885,0 3984,1 4009,0 4092,1 4188,0 4222,1 4286,0 4324,1 4340,0 4354,1 4420,0 4517,1 4547,0 4549,1 4636,0 4644,1 4736,0 4740,1 4757,0 4771,1 4835,0 4877,1 4959,0 4994,1 5066,0 5129,1 5203,0 5218,1 5229,0 5295,1 5369,0 5372,1 5444,0 5492,1 5574,0 5629,1 5669,0 5711,1 5782,0 5811,1 5819,0 5909,1 5934,0 5972,1 6008,0 6014,1 6029,0 6059,1 6118,0 6197,1 6201,0 6298,1 6299,0 6315,1 6327,0 6347,1 6435,0 6474,1 6533,0 6627,1 6727,0 6794,1 6863,0 6947,1 6987,0 7055,1 7066,0 7091,1 7096,0 7130,1 7170,0 7199,1 7257,0 7305,1 7341,0 7405,1 7463,0 7498,1 7528,0 7543,1 7624,0 7676,1 7741,0 7743,1 7831,0 7919,1 7941,0 7953,1 8026,0 8031,1 8042,0 8060,1 8154,0 8230,1 8327,0 8380,1 8455,0 8508,1 8541,0 8587,1 8619,0 8706,1 8723,0 8809,1 8849,0 8851,1 8886,0 8944,1 8971,0 8976,1 9043,0 9061,1 9080,0 9142,1 9191,0 9196,1 9262,0 9348,1 9378,0 9401,1 9445,0 9492,1 9592,0 9642,1 9646,0 9667,1 9700,0 9757,1 9844,0 9943,1 10010,0 10110,1 10188,0 10228,1 10290,0 10361,1 10399,0 10416,1 10458,0 10512,1 10597,0 10660,1 10708,0 10734,1 10830,0 10831,1 10895,0 10974,1 11030,0 11046,1 11073,0 11110,1 11133,0 11180,1 11255,0 11341,1 11380,0 11470,1 11552,0 11631,1 11731,0 11737,1 11776,0 11873,1 11941,0 11948,1 12027,0 12052,1 12093,0 12190,1 12204,0 12275,1 12359,0 12436,1 12442,0 12521,1 12577,0 12589,1 12606,0 12643,1 12704,0 12731,1 12814,0 12912,1 end initlist b39 0,0 57,1 99,0 105,1 171,0 230,1 302,0 344,1 357,0 397,1 442,0 500,1 519,0 568,1 639,0 647,1 695,0 701,1 778,0 866,1 933,0 935,1 1017,0 1115,1 1191,0 1195,1 1266,0 1299,1 1357,0 1447,1 1539,0 1581,1 1636,0 1664,1 1689,0 1716,1 1747,0 1815,1 1873,0 1941,1 2015,0 2040,1 2054,0 2056,1 2141,0 2144,1 2152,0 2193,1 2271,0 2297,1 2391,0 2425,1 2488,0 2513,1 2525,0 2567,1 2606,0 2662,1 2753,0 2776,1 2811,0 2874,1 2920,0 2989,1 3017,0 3117,1 3150,0 3176,1 3248,0 3342,1 3416,0 3514,1 3588,0 3687,1 3741,0 3811,1 3866,0 3928,1 4025,0 4028,1 4122,0 4186,1 4247,0 4345,1 4422,0 4463,1 4548,0 4584,1 4649,0 4715,1 4725,0 4757,1 4765,0 4813,1 4839,0 4923,1 4951,0 4992,1 5073,0 5109,1 5131,0 5146,1 5222,0 5307,1 5329,0 5397,1 5462,0 5504,1 5554,0 5623,1 5687,0 5746,1 5764,0 5852,1 5863,0 5922,1 5959,0 5967,1 6045,0 6057,1 6099,0 6181,1 6277,0 6305,1 6334,0 6407,1 6487,0 6529,1 6622,0 6717,1 6792,0 6877,1 6919,0 6993,1 7064,0 7147,1 7152,0 7226,1 7297,0 7306,1 7328,0 7384,1 7393,0 7474,1 7522,0 7596,1 7650,0 7718,1 7817,0 7847,1 7900,0 7974,1 8023,0 8086,1 8125,0 8200,1 8203,0 8265,1 8341,0 8352,1 8432,0 8454,1 8529,0 8562,1 8603,0 8637,1 8644,0 8681,1 8761,0 8837,1 8929,0 8937,1 8966,0 9027,1 9088,0 9129,1 9203,0 9218,1 9317,0 9328,1 9369,0 9372,1 9447,0 9502,1 9515,0 9538,1 9598,0 9650,1 9710,0 9773,1 9842,0 9932,1 10007,0 10094,1 10131,0 10197,1 10200,0 10226,1 10310,0 10351,1 10406,0 10482,1 10550,0 10577,1 10647,0 10709,1 10733,0 10807,1 10847,0 10935,1 11024,0 11068,1 11144,0 11221,1 11296,0 11372,1 11439,0 11493,1 11500,0 11551,1 11561,0 11652,1 11736,0 11757,1 11816,0 11841,1 11847,0 11943,1 11987,0 12026,1 12059,0 12149,1 12229,0 12267,1 12341,0 12358,1 12378,0 12431,1 12484,0 12533,1 12612,0 12646,1 12649,0 12709,1 12731,0 12815,1 12829,0 12845,1 12890,0 12950,1 13022,0 13043,1 13065,0 13119,1 13166,0 13212,1 13297,0 13339,1 end initlist b40 0,0 88,1 187,0 256,1 349,0 372,1 465,0 489,1 544,0 549,1 619,0 638,1 672,0 683,1 710,0 809,1 908,0 978,1 1003,0 1006,1 1085,0 1172,1 1250,0 1340,1 1406,0 1491,1 1580,0 1672,1 1682,0 1713,1 1777,0 1802,1 1809,0 1878,1 1942,0 2010,1 2076,0 2103,1 2202,0 2266,1 2289,0 2335,1 2347,0 2420,1 2463,0 2524,1 2544,0 2586,1 2663,0 2710,1 2750,0 2755,1 2804,0 2827,1 2904,0 2909,1 2970,0 3005,1 3039,0 3070,1 3072,0 3134,1 3152,0 3166,1 3237,0 3254,1 3339,0 3343,1 3346,0 3367,1 3434,0 3492,1 3536,0 3543,1 3596,0 3598,1 3600,0 3642,1 3675,0 3762,1 3787,0 3803,1 3891,0 3951,1 3995,0 4033,1 4052,0 4150,1 4243,0 4315,1 4347,0 4389,1 4407,0 4429,1 4522,0 4592,1 4662,0 4693,1 4755,0 4804,1 4868,0 4916,1 4972,0 5007,1 5054,0 5103,1 5157,0 5256,1 5269,0 5346,1 5365,0 5405,1 5479,0 5518,1 5605,0 5699,1 5761,0 5834,1 5841,0 5922,1 5928,0 5959,1 6014,0 6034,1 6066,0 6091,1 6136,0 6148,1 6224,0 6296,1 6337,0 6340,1 6413,0 6511,1 6572,0 6636,1 6674,0 6745,1 6803,0 6845,1 6896,0 6962,1 7062,0 7116,1 7128,0 7161,1 7204,0 7289,1 7348,0 7433,1 7454,0 7524,1 7559,0 7595,1 7639,0 7677,1 7751,0 7841,1 7873,0 7925,1 7940,0 7976,1 8043,0 8111,1 8112,0 8180,1 8243,0 8283,1 8344,0 8438,1 8467,0 8478,1 8502,0 8511,1 8528,0 8571,1 8639,0 8647,1 8651,0 8654,1 8677,0 8712,1 8758,0 8788,1 8818,0 8846,1 8878,0 8937,1 9014,0 9092,1 9176,0 9263,1 9294,0 9315,1 9389,0 9393,1 9429,0 9469,1 9498,0 9551,1 9647,0 9744,1 9804,0 9861,1 9883,0 9897,1 9935,0 9961,1 10023,0 10037,1 10047,0 10104,1 10167,0 10177,1 10246,0 10265,1 10317,0 10393,1 10436,0 10463,1 10517,0 10549,1 10619,0 10680,1 10711,0 10738,1 10826,0 10855,1 10861,0 10881,1 10908,0 10980,1 11043,0 11102,1 11190,0 11275,1 11305,0 11346,1 11437,0 11496,1 11557,0 11621,1 11674,0 11686,1 11749,0 11808,1 11816,0 11894,1 11984,0 11988,1 12028,0 12124,1 12175,0 12261,1 12272,0 12306,1 12375,0 12424,1 end initlist b41 0,0 72,1 93,0 176,1 192,0 281,1 290,0 357,1 402,0 478,1 557,0 598,1 621,0 690,1 698,0 791,1 848,0 869,1 892,0 947,1 1005,0 1038,1 1070,0 1119,1 1127,0 1181,1 1209,0 1244,1 1309,0 1389,1 1401,0 1408,1 1415,0 1490,1 1539,0 1571,1 1639,0 1725,1 1728,0 1770,1 1774,0 1780,1 1828,0 1847,1 1872,0 1918,1 1919,0 1998,1 2077,0 2144,1 2184,0 2242,1 2321,0 2326,1 2348,0 2414,1 2505,0 2555,1 2586,0 2636,1 2697,0 2754,1 2843,0 2860,1 2930,0 2960,1 2967,0 3016,1 3028,0 3088,1 3169,0 3212,1 3225,0 3263,1 3273,0 3346,1 3433,0 3504,1 3526,0 3539,1 3549,0 3596,1 3623,0 3652,1 3658,0 3667,1 3717,0 3803,1 3880,0 3970,1 4038,0 4048,1 4054,0 4119,1 4173,0 4240,1 4251,0 4306,1 4392,0 4434,1 4442,0 4497,1 4537,0 4573,1 4592,0 4665,1 4759,0 4837,1 4930,0 5002,1 5090,0 5154,1 5252,0 5345,1 5397,0 5479,1 5520,0 5528,1 5595,0 5673,1 5729,0 5749,1 5755,0 5824,1 5831,0 5895,1 5897,0 5935,1 6000,0 6096,1 6134,0 6138,1 6228,0 6248,1 6251,0 6284,1 6330,0 6424,1 6517,0 6518,1 6552,0 6591,1 6654,0 6681,1 6729,0 6780,1 6867,0 6893,1 6951,0 7037,1 7099,0 7105,1 7202,0 7260,1 7296,0 7312,1 7399,0 7425,1 7438,0 7468,1 7478,0 7564,1 7649,0 7671,1 7760,0 7860,1 7861,0 7888,1 7975,0 7977,1 7995,0 8080,1 8175,0 8191,1 8253,0 8346,1 8420,0 8475,1 8562,0 8627,1 8684,0 8705,1 8800,0 8834,1 8932,0 8945,1 8972,0 9025,1 9112,0 9179,1 9219,0 9222,1 9275,0 9312,1 9331,0 9413,1 9487,0 9584,1 9614,0 9683,1 9748,0 9779,1 9794,0 9821,1 9850,0 9921,1 10005,0 10074,1 10140,0 10206,1 10283,0 10300,1 10357,0 10393,1 10427,0 10523,1 10531,0 10623,1 10687,0 10784,1 10861,0 10921,1 10978,0 11076,1 11117,0 11164,1 11212,0 11229,1 11293,0 11326,1 11350,0 11402,1 11484,0 11549,1 11629,0 11652,1 11717,0 11799,1 11836,0 11854,1 11879,0 11924,1 11937,0 12032,1 12120,0 12207,1 12249,0 12345,1 12418,0 12463,1 12470,0 12535,1 12555,0 12558,1 12576,0 12673,1 12749,0 12792,1 end initlist b42 0,0 25,1 58,0 120,1 190,0 203,1 231,0 257,1 282,0 315,1 317,0 414,1 501,0 502,1 555,0 557,1 652,0 704,1 715,0 744,1 774,0 828,1 898,0 966,1 968,0 1007,1 1093,0 1143,1 1218,0 1301,1 1368,0 1425,1 1465,0 1499,1 1596,0 1656,1 1694,0 1790,1 1831,0 1915,1 1976,0 2072,1 2097,0 2104,1 2166,0 2233,1 2270,0 2289,1 2325,0 2327,1 2362,0 2404,1 2421,0 2436,1 2516,0 2561,1 2605,0 2641,1 2728,0 2730,1 2769,0 2814,1 2850,0 2868,1 2907,0 2962,1 3056,0 3118,1 3132,0 3222,1 3308,0 3405,1 3421,0 3445,1 3524,0 3599,1 3660,0 3689,1 3744,0 3826,1 3869,0 3949,1 4032,0 4082,1 4164,0 4171,1 4246,0 4311,1 4373,0 4399,1 4416,0 4476,1 4514,0 4547,1 4606,0 4612,1 4642,0 4722,1 4764,0 4843,1 4859,0 4865,1 4950,0 4976,1 5072,0 5119,1 5151,0 5164,1 5244,0 5287,1 5368,0 5450,1 5474,0 5513,1 5575,0 5586,1 5631,0 5660,1 5735,0 5792,1 5845,0 5917,1 5957,0 6006,1 6040,0 6047,1 6063,0 6106,1 6148,0 6169,1 6260,0 6309,1 6360,0 6459,1 6553,0 6618,1 6623,0 6682,1 6770,0 6861,1 6949,0 6989,1 7006,0 7098,1 7162,0 7178,1 7211,0 7250,1 7263,0 7338,1 7364,0 7413,1 7424,0 7459,1 7520,0 7571,1 7615,0 7649,1 7740,0 7775,1 7874,0 7926,1 7983,0 8002,1 8065,0 8096,1 8118,0 8176,1 8273,0 8291,1 8383,0 8478,1 8552,0 8565,1 8600,0 8636,1 8730,0 8774,1 8817,0 8837,1 8840,0 8902,1 8987,0 9021,1 9063,0 9130,1 9160,0 9226,1 9243,0 9306,1 9397,0 9459,1 9480,0 9536,1 9599,0 9655,1 9700,0 9726,1 9808,0 9876,1 9957,0 9960,1 10005,0 10067,1 10139,0 10185,1 10264,0 10340,1 10383,0 10470,1 10538,0 10610,1 10656,0 10714,1 10778,0 10780,1 10864,0 10956,1 11034,0 11125,1 11133,0 11196,1 11247,0 11262,1 11293,0 11302,1 11307,0 11330,1 11389,0 11422,1 11474,0 11520,1 11571,0 11636,1 11705,0 11762,1 11855,0 11884,1 11965,0 12018,1 12024,0 12056,1 12081,0 12087,1 12117,0 12168,1 12175,0 12184,1 12234,0 12238,1 12260,0 12308,1 12404,0 12482,1 12549,0 12569,1 12572,0 12623,1 end initlist b43 0,0 17,1 97,0 100,1 171,0 251,1 304,0 373,1 418,0 495,1 518,0 557,1 564,0 595,1 651,0 746,1 758,0 761,1 787,0 804,1 832,0 868,1 886,0 955,1 1011,0 1021,1 1049,0 1140,1 1175,0 1194,1 1292,0 1314,1 1324,0 1399,1 1451,0 1549,1 1645,0 1723,1 1809,0 1875,1 1970,0 2060,1 2137,0 2162,1 2180,0 2241,1 2283,0 2295,1 2382,0 2434,1 2463,0 2560,1 2655,0 2673,1 2742,0 2801,1 2872,0 2908,1 2999,0 3091,1 3161,0 3189,1 3208,0 3295,1 3306,0 3401,1 3421,0 3438,1 3479,0 3555,1 3607,0 3611,1 3656,0 3729,1 3804,0 3880,1 3945,0 4036,1 4116,0 4212,1 4255,0 4354,1 4401,0 4422,1 4520,0 4526,1 4547,0 4636,1 4679,0 4766,1 4837,0 4873,1 4889,0 4984,1 5075,0 5089,1 5119,0 5186,1 5269,0 5303,1 5382,0 5448,1 5496,0 5550,1 5637,0 5642,1 5666,0 5711,1 5787,0 5862,1 5919,0 6017,1 6084,0 6099,1 6191,0 6256,1 6351,0 6352,1 6382,0 6463,1 6517,0 6586,1 6631,0 6722,1 6814,0 6896,1 6943,0 7037,1 7079,0 7160,1 7197,0 7217,1 7282,0 7373,1 7463,0 7495,1 7503,0 7571,1 7636,0 7729,1 7730,0 7746,1 7839,0 7870,1 7899,0 7915,1 7952,0 8031,1 8054,0 8140,1 8236,0 8238,1 8324,0 8383,1 8385,0 8429,1 8496,0 8561,1 8621,0 8670,1 8679,0 8681,1 8714,0 8767,1 8861,0 8900,1 8947,0 8996,1 9022,0 9103,1 9200,0 9296,1 9387,0 9479,1 9510,0 9555,1 9591,0 9606,1 9608,0 9669,1 9686,0 9773,1 9813,0 9895,1 9948,0 9989,1 10069,0 10102,1 10130,0 10168,1 10222,0 10259,1 10321,0 10343,1 10384,0 10459,1 10500,0 10576,1 10596,0 10626,1 10713,0 10754,1 10837,0 10850,1 10869,0 10897,1 10929,0 11006,1 11013,0 11109,1 11187,0 11210,1 11235,0 11332,1 11390,0 11427,1 11445,0 11506,1 11510,0 11579,1 11586,0 11671,1 11729,0 11789,1 11815,0 11881,1 11886,0 11955,1 11971,0 12057,1 12091,0 12128,1 12193,0 12210,1 12297,0 12381,1 12467,0 12565,1 12602,0 12625,1 12636,0 12693,1 12742,0 12823,1 12899,0 12929,1 12931,0 12948,1 12982,0 13051,1 13134,0 13145,1 13171,0 13173,1 13210,0 13228,1 13263,0 13343,1 end initlist b44 0,0 99,1 179,0 180,1 226,0 297,1 359,0 370,1 415,0 508,1 592,0 649,1 716,0 765,1 863,0 885,1 950,0 1017,1 1040,0 1080,1 1127,0 1162,1 1209,0 1284,1 1374,0 1394,1 1424,0 1524,1 1617,0 1695,1 1768,0 1862,1 1929,0 1994,1 2044,0 2050,1 2058,0 2073,1 2098,0 2115,1 2198,0 2264,1 2272,0 2365,1 2425,0 2495,1 2498,0 2544,1 2619,0 2627,1 2649,0 2695,1 2792,0 2813,1 2819,0 2907,1 2971,0 3045,1 3057,0 3104,1 3107,0 3161,1 3209,0 3239,1 3246,0 3318,1 3327,0 3329,1 3354,0 3391,1 3438,0 3466,1 3527,0 3609,1 3627,0 3641,1 3716,0 3776,1 3858,0 3920,1 3991,0 4079,1 4097,0 4189,1 4231,0 4312,1 4404,0 4435,1 4459,0 4495,1 4561,0 4632,1 4674,0 4706,1 4750,0 4835,1 4860,0 4897,1 4963,0 5037,1 5112,0 5208,1 5231,0 5294,1 5384,0 5388,1 5398,0 5445,1 5464,0 5521,1 5618,0 5651,1 5719,0 5787,1 5823,0 5825,1 5916,0 6000,1 6025,0 6060,1 6109,0 6166,1 6233,0 6275,1 6311,0 6380,1 6473,0 6479,1 6523,0 6600,1 6669,0 6720,1 6748,0 6826,1 6890,0 6978,1 7053,0 7087,1 7141,0 7155,1 7252,0 7264,1 7347,0 7378,1 7412,0 7414,1 7503,0 7595,1 7614,0 7626,1 7666,0 7720,1 7766,0 7856,1 7955,0 8002,1 8069,0 8120,1 8139,0 8212,1 8296,0 8321,1 8379,0 8434,1 8453,0 8502,1 8558,0 8653,1 8729,0 8731,1 8780,0 8786,1 8795,0 8884,1 8908,0 8941,1 9016,0 9105,1 9111,0 9185,1 9282,0 9336,1 9355,0 9392,1 9403,0 9489,1 9525,0 9578,1 9622,0 9636,1 9683,0 9706,1 9753,0 9822,1 9908,0 9944,1 10003,0 10054,1 10125,0 10164,1 10246,0 10281,1 10329,0 10418,1 10431,0 10512,1 10520,0 10554,1 10588,0 10650,1 10699,0 10764,1 10768,0 10841,1 10843,0 10929,1 10943,0 10944,1 10972,0 10994,1 11059,0 11074,1 11088,0 11101,1 11151,0 11216,1 11255,0 11269,1 11317,0 11324,1 11327,0 11403,1 11428,0 11490,1 11495,0 11595,1 11689,0 11774,1 11776,0 11802,1 11866,0 11946,1 11999,0 12040,1 12092,0 12093,1 12144,0 12187,1 12258,0 12318,1 12334,0 12380,1 12388,0 12469,1 12496,0 12573,1 12611,0 12669,1 end initlist b45 0,0 16,1 22,0 60,1 129,0 186,1 242,0 256,1 355,0 440,1 522,0 615,1 712,0 724,1 820,0 829,1 887,0 945,1 1040,0 1133,1 1151,0 1237,1 1290,0 1326,1 1355,0 1410,1 1451,0 1461,1 1467,0 1493,1 1523,0 1576,1 1671,0 1686,1 1761,0 1846,1 1928,0 1985,1 2011,0 2017,1 2088,0 2089,1 2186,0 2230,1 2300,0 2358,1 2450,0 2505,1 2508,0 2571,1 2608,0 2647,1 2693,0 2763,1 2824,0 2903,1 2948,0 3019,1 3073,0 3150,1 3184,0 3278,1 3335,0 3413,1 3450,0 3527,1 3581,0 3636,1 3717,0 3733,1 3818,0 3912,1 3927,0 3942,1 4028,0 4103,1 4188,0 4219,1 4223,0 4318,1 4401,0 4469,1 4569,0 4631,1 4660,0 4737,1 4829,0 4915,1 4972,0 4993,1 5015,0 5101,1 5184,0 5252,1 5302,0 5337,1 5394,0 5427,1 5510,0 5540,1 5549,0 5563,1 5605,0 5644,1 5660,0 5719,1 5723,0 5740,1 5829,0 5901,1 5917,0 5979,1 5983,0 6025,1 6113,0 6122,1 6159,0 6259,1 6310,0 6351,1 6369,0 6459,1 6520,0 6533,1 6587,0 6687,1 6721,0 6789,1 6837,0 6851,1 6891,0 6938,1 7012,0 7058,1 7087,0 7100,1 7129,0 7152,1 7252,0 7322,1 7364,0 7393,1 7465,0 7541,1 7565,0 7648,1 7679,0 7777,1 7825,0 7868,1 7882,0 7917,1 8014,0 8099,1 8191,0 8243,1 8332,0 8355,1 8395,0 8459,1 8472,0 8529,1 8604,0 8657,1 8671,0 8752,1 8779,0 8865,1 8891,0 8960,1 9043,0 9128,1 9166,0 9205,1 9219,0 9279,1 9345,0 9440,1 9517,0 9543,1 9596,0 9655,1 9697,0 9756,1 9793,0 9864,1 9865,0 9931,1 9934,0 9993,1 10061,0 10135,1 10200,0 10281,1 10314,0 10407,1 10418,0 10494,1 10531,0 10563,1 10603,0 10612,1 10626,0 10722,1 10752,0 10834,1 10865,0 10933,1 11012,0 11071,1 11168,0 11227,1 11270,0 11335,1 11414,0 11427,1 11454,0 11463,1 11511,0 11535,1 11610,0 11644,1 11731,0 11799,1 11802,0 11861,1 11952,0 11956,1 11964,0 11981,1 12041,0 12109,1 12139,0 12237,1 12238,0 12310,1 12335,0 12399,1 12484,0 12566,1 12654,0 12684,1 12711,0 12749,1 12770,0 12776,1 12855,0 12864,1 12898,0 12923,1 13011,0 13083,1 13094,0 13135,1 13178,0 13257,1 13264,0 13317,1 end initlist b46 0,0 76,1 126,0 205,1 215,0 252,1 266,0 298,1 306,0 319,1 344,0 441,1 515,0 561,1 586,0 685,1 700,0 714,1 771,0 863,1 958,0 967,1 1057,0 1099,1 1185,0 1240,1 1328,0 1385,1 1391,0 1480,1 1580,0 1588,1 1637,0 1639,1 1697,0 1699,1 1792,0 1875,1 1876,0 1926,1 1935,0 2032,1 2055,0 2109,1 2178,0 2275,1 2312,0 2403,1 2489,0 2501,1 2571,0 2646,1 2650,0 2741,1 2776,0 2817,1 2827,0 2889,1 2964,0 3059,1 3156,0 3184,1 3239,0 3309,1 3368,0 3451,1 3550,0 3628,1 3634,0 3720,1 3795,0 3815,1 3841,0 3857,1 3927,0 3955,1 3983,0 4041,1 4112,0 4169,1 4242,0 4318,1 4380,0 4479,1 4512,0 4527,1 4616,0 4658,1 4736,0 4789,1 4824,0 4912,1 4957,0 5038,1 5065,0 5120,1 5138,0 5206,1 5277,0 5335,1 5413,0 5421,1 5490,0 5504,1 5519,0 5602,1 5695,0 5725,1 5765,0 5846,1 5899,0 5944,1 6032,0 6130,1 6177,0 6199,1 6217,0 6303,1 6376,0 6405,1 6491,0 6564,1 6644,0 6743,1 6746,0 6808,1 6872,0 6965,1 7011,0 7064,1 7086,0 7107,1 7179,0 7219,1 7281,0 7309,1 7313,0 7342,1 7428,0 7440,1 7499,0 7549,1 7605,0 7641,1 7672,0 7728,1 7767,0 7794,1 7829,0 7883,1 7903,0 7940,1 8032,0 8132,1 8157,0 8224,1 8240,0 8324,1 8363,0 8402,1 8414,0 8427,1 8503,0 8553,1 8604,0 8667,1 8675,0 8770,1 8826,0 8883,1 8952,0 8953,1 9043,0 9110,1 9155,0 9182,1 9209,0 9308,1 9348,0 9395,1 9423,0 9492,1 9587,0 9665,1 9668,0 9748,1 9769,0 9827,1 9858,0 9921,1 10006,0 10044,1 10104,0 10117,1 10122,0 10188,1 10282,0 10345,1 10401,0 10494,1 10497,0 10529,1 10530,0 10572,1 10621,0 10657,1 10692,0 10742,1 10790,0 10823,1 10829,0 10892,1 10934,0 10951,1 10988,0 11068,1 11136,0 11171,1 11239,0 11302,1 11324,0 11394,1 11484,0 11553,1 11584,0 11619,1 11714,0 11774,1 11814,0 11865,1 11892,0 11965,1 12060,0 12117,1 12125,0 12134,1 12181,0 12215,1 12228,0 12324,1 12386,0 12451,1 12483,0 12519,1 12595,0 12683,1 12767,0 12846,1 12946,0 13021,1 13084,0 13171,1 13217,0 13280,1 13342,0 13346,1 13404,0 13492,1 end initlist b47 0,0 65,1 140,0 221,1 264,0 364,1 449,0 471,1 557,0 627,1 659,0 710,1 790,0 869,1 950,0 1015,1 1049,0 1062,1 1067,0 1106,1 1132,0 1156,1 1181,0 1185,1 1255,0 1294,1 1364,0 1383,1 1454,0 1512,1 1554,0 1604,1 1637,0 1714,1 1812,0 1893,1 1931,0 1975,1 2000,0 2052,1 2078,0 2087,1 2167,0 2236,1 2326,0 2380,1 2382,0 2431,1 2529,0 2548,1 2574,0 2606,1 2607,0 2634,1 2678,0 2720,1 2761,0 2788,1 2790,0 2817,1 2885,0 2965,1 3026,0 3071,1 3163,0 3262,1 3354,0 3397,1 3449,0 3505,1 3572,0 3608,1 3675,0 3730,1 3800,0 3815,1 3850,0 3851,1 3902,0 3946,1 3961,0 4016,1 4089,0 4119,1 4192,0 4196,1 4203,0 4301,1 4303,0 4318,1 4399,0 4445,1 4534,0 4569,1 4611,0 4678,1 4744,0 4807,1 4851,0 4857,1 4922,0 4978,1 5016,0 5061,1 5071,0 5072,1 5101,0 5189,1 5264,0 5277,1 5289,0 5386,1 5466,0 5493,1 5572,0 5660,1 5733,0 5776,1 5835,0 5913,1 5938,0 5971,1 6024,0 6036,1 6078,0 6143,1 6156,0 6189,1 6234,0 6299,1 6349,0 6438,1 6451,0 6529,1 6592,0 6648,1 6670,0 6702,1 6785,0 6828,1 6837,0 6855,1 6867,0 6901,1 6954,0 7054,1 7101,0 7149,1 7224,0 7301,1 7356,0 7373,1 7427,0 7457,1 7553,0 7637,1 7690,0 7727,1 7791,0 7868,1 7896,0 7971,1 7987,0 8044,1 8135,0 8160,1 8211,0 8286,1 8367,0 8427,1 8524,0 8595,1 8684,0 8731,1 8796,0 8842,1 8883,0 8940,1 9025,0 9100,1 9192,0 9217,1 9269,0 9288,1 9330,0 9408,1 9502,0 9573,1 9592,0 9600,1 9682,0 9705,1 9724,0 9804,1 9805,0 9854,1 9861,0 9878,1 9942,0 9960,1 10016,0 10032,1 10071,0 10136,1 10195,0 10221,1 10281,0 10346,1 10423,0 10474,1 10502,0 10586,1 10641,0 10713,1 10730,0 10826,1 10865,0 10933,1 10979,0 11021,1 11107,0 11150,1 11209,0 11278,1 11334,0 11367,1 11433,0 11450,1 11498,0 11598,1 11612,0 11632,1 11708,0 11764,1 11771,0 11780,1 11829,0 11851,1 11903,0 11972,1 12017,0 12076,1 12156,0 12163,1 12180,0 12194,1 12279,0 12328,1 12427,0 12461,1 12534,0 12536,1 12572,0 12589,1 12606,0 12629,1 12630,0 12677,1 end initlist b48 0,0 74,1 102,0 196,1 248,0 300,1 301,0 336,1 358,0 424,1 463,0 466,1 480,0 563,1 627,0 639,1 665,0 694,1 736,0 782,1 822,0 848,1 898,0 946,1 1016,0 1066,1 1126,0 1129,1 1189,0 1198,1 1247,0 1310,1 1398,0 1492,1 1572,0 1609,1 1659,0 1739,1 1805,0 1883,1 1899,0 1953,1 1989,0 2050,1 2079,0 2100,1 2106,0 2204,1 2226,0 2228,1 2277,0 2319,1 2413,0 2490,1 2545,0 2598,1 2669,0 2714,1 2765,0 2858,1 2950,0 2983,1 3056,0 3145,1 3154,0 3207,1 3284,0 3349,1 3387,0 3441,1 3501,0 3529,1 3566,0 3664,1 3749,0 3814,1 3902,0 3924,1 4019,0 4073,1 4142,0 4224,1 4246,0 4277,1 4333,0 4408,1 4434,0 4502,1 4572,0 4657,1 4709,0 4745,1 4749,0 4775,1 4862,0 4948,1 5039,0 5135,1 5163,0 5199,1 5238,0 5255,1 5309,0 5310,1 5329,0 5333,1 5401,0 5432,1 5460,0 5465,1 5476,0 5562,1 5661,0 5725,1 5736,0 5833,1 5849,0 5898,1 5983,0 6063,1 6067,0 6082,1 6141,0 6180,1 6203,0 6273,1 6288,0 6296,1 6319,0 6406,1 6499,0 6519,1 6608,0 6623,1 6714,0 6767,1 6801,0 6849,1 6878,0 6916,1 6947,0 7011,1 7035,0 7106,1 7184,0 7263,1 7286,0 7375,1 7435,0 7463,1 7532,0 7552,1 7612,0 7710,1 7765,0 7844,1 7865,0 7939,1 8029,0 8103,1 8185,0 8214,1 8267,0 8307,1 8314,0 8361,1 8419,0 8437,1 8446,0 8486,1 8551,0 8639,1 8661,0 8739,1 8777,0 8814,1 8866,0 8918,1 8982,0 9043,1 9090,0 9183,1 9212,0 9297,1 9365,0 9368,1 9400,0 9482,1 9498,0 9575,1 9648,0 9703,1 9766,0 9784,1 9827,0 9892,1 9971,0 9972,1 9993,0 10067,1 10161,0 10164,1 10252,0 10330,1 10414,0 10478,1 10495,0 10519,1 10588,0 10619,1 10692,0 10779,1 10789,0 10841,1 10859,0 10881,1 10950,0 10979,1 10997,0 11057,1 11073,0 11090,1 11190,0 11278,1 11280,0 11289,1 11376,0 11397,1 11489,0 11502,1 11588,0 11594,1 11638,0 11650,1 11672,0 11714,1 11756,0 11788,1 11829,0 11838,1 11858,0 11908,1 11992,0 12003,1 12039,0 12105,1 12133,0 12156,1 12175,0 12205,1 12246,0 12267,1 12313,0 12339,1 12402,0 12465,1 12513,0 12548,1 end initlist b49 0,0 13,1 51,0 122,1 148,0 168,1 265,0 329,1 377,0 444,1 460,0 513,1 593,0 641,1 659,0 712,1 772,0 859,1 936,0 1008,1 1085,0 1108,1 1189,0 1270,1 1334,0 1344,1 1384,0 1407,1 1500,0 1518,1 1551,0 1585,1 1607,0 1672,1 1693,0 1764,1 1827,0 1831,1 1843,0 1900,1 1924,0 2012,1 2071,0 2146,1 2230,0 2232,1 2329,0 2343,1 2437,0 2456,1 2543,0 2559,1 2571,0 2577,1 2632,0 2684,1 2726,0 2763,1 2772,0 2797,1 2844,0 2875,1 2972,0 3063,1 3123,0 3209,1 3270,0 3339,1 3340,0 3379,1 3391,0 3428,1 3439,0 3528,1 3531,0 3570,1 3613,0 3661,1 3734,0 3784,1 3791,0 3838,1 3875,0 3903,1 3977,0 4070,1 4075,0 4143,1 4156,0 4211,1 4247,0 4337,1 4348,0 4397,1 4409,0 4474,1 4549,0 4562,1 4624,0 4644,1 4710,0 4798,1 4855,0 4906,1 4951,0 5050,1 5115,0 5215,1 5219,0 5310,1 5383,0 5426,1 5466,0 5552,1 5642,0 5667,1 5675,0 5698,1 5721,0 5775,1 5815,0 5817,1 5854,0 5867,1 5951,0 5962,1 6032,0 6108,1 6160,0 6195,1 6209,0 6307,1 6321,0 6395,1 6442,0 6499,1 6534,0 6581,1 6657,0 6751,1 6801,0 6867,1 6896,0 6911,1 6980,0 6988,1 7009,0 7015,1 7080,0 7144,1 7188,0 7238,1 7251,0 7338,1 7404,0 7491,1 7567,0 7644,1 7652,0 7729,1 7790,0 7851,1 7934,0 7945,1 7995,0 7998,1 8046,0 8064,1 8105,0 8155,1 8234,0 8298,1 8367,0 8402,1 8449,0 8500,1 8568,0 8653,1 8752,0 8802,1 8832,0 8896,1 8949,0 9026,1 9080,0 9099,1 9142,0 9173,1 9260,0 9271,1 9356,0 9417,1 9453,0 9506,1 9544,0 9548,1 9573,0 9628,1 9680,0 9728,1 9800,0 9884,1 9930,0 9934,1 10013,0 10077,1 10140,0 10141,1 10205,0 10230,1 10274,0 10321,1 10376,0 10470,1 10527,0 10610,1 10668,0 10703,1 10724,0 10777,1 10812,0 10875,1 10963,0 11025,1 11077,0 11152,1 11157,0 11182,1 11250,0 11347,1 11376,0 11453,1 11487,0 11566,1 11626,0 11694,1 11738,0 11772,1 11824,0 11920,1 11926,0 11967,1 11983,0 11988,1 12039,0 12079,1 12158,0 12191,1 12219,0 12288,1 12335,0 12354,1 12374,0 12397,1 12403,0 12409,1 12469,0 12568,1 end initlist b50 0,0 57,1 144,0 244,1 302,0 311,1 379,0 389,1 478,0 494,1 589,0 622,1 655,0 696,1 739,0 758,1 771,0 858,1 943,0 1033,1 1115,0 1211,1 1280,0 1327,1 1362,0 1428,1 1477,0 1527,1 1592,0 1626,1 1684,0 1702,1 1728,0 1748,1 1841,0 1926,1 1959,0 2011,1 2056,0 2143,1 2228,0 2319,1 2414,0 2498,1 2578,0 2636,1 2675,0 2755,1 2833,0 2868,1 2888,0 2950,1 2974,0 2976,1 2998,0 3036,1 3085,0 3098,1 3109,0 3204,1 3263,0 3310,1 3330,0 3408,1 3481,0 3512,1 3563,0 3620,1 3665,0 3727,1 3816,0 3831,1 3861,0 3885,1 3947,0 3950,1 3981,0 4074,1 4133,0 4209,1 4234,0 4263,1 4318,0 4359,1 4372,0 4397,1 4490,0 4557,1 4616,0 4675,1 4728,0 4828,1 4915,0 5013,1 5029,0 5102,1 5171,0 5271,1 5331,0 5421,1 5457,0 5528,1 5557,0 5570,1 5639,0 5718,1 5763,0 5830,1 5845,0 5848,1 5914,0 5999,1 6006,0 6042,1 6112,0 6125,1 6131,0 6190,1 6269,0 6301,1 6322,0 6354,1 6384,0 6419,1 6431,0 6522,1 6563,0 6617,1 6633,0 6662,1 6744,0 6786,1 6810,0 6889,1 6894,0 6898,1 6904,0 6909,1 6940,0 7005,1 7060,0 7071,1 7162,0 7198,1 7257,0 7265,1 7297,0 7304,1 7333,0 7390,1 7472,0 7565,1 7642,0 7741,1 7808,0 7908,1 7963,0 8043,1 8132,0 8170,1 8232,0 8269,1 8350,0 8389,1 8462,0 8524,1 8563,0 8570,1 8666,0 8752,1 8761,0 8804,1 8817,0 8879,1 8916,0 9009,1 9054,0 9059,1 9078,0 9165,1 9242,0 9274,1 9321,0 9414,1 9498,0 9528,1 9545,0 9605,1 9642,0 9676,1 9716,0 9809,1 9844,0 9878,1 9932,0 9967,1 10010,0 10042,1 10100,0 10143,1 10165,0 10251,1 10284,0 10375,1 10403,0 10475,1 10531,0 10550,1 10639,0 10733,1 10819,0 10870,1 10889,0 10911,1 11004,0 11019,1 11059,0 11061,1 11119,0 11169,1 11180,0 11216,1 11259,0 11298,1 11395,0 11404,1 11432,0 11447,1 11496,0 11567,1 11603,0 11612,1 11699,0 11781,1 11843,0 11864,1 11940,0 11968,1 12018,0 12085,1 12143,0 12221,1 12313,0 12405,1 12439,0 12508,1 12582,0 12615,1 12682,0 12688,1 12770,0 12865,1 12932,0 12980,1 13021,0 13116,1 13166,0 13230,1 end initlist b51 0,0 52,1 122,0 220,1 229,0 322,1 387,0 479,1 578,0 593,1 691,0 709,1 796,0 831,1 879,0 896,1 901,0 972,1 1031,0 1078,1 1130,0 1154,1 1249,0 1335,1 1425,0 1447,1 1456,0 1491,1 1498,0 1598,1 1623,0 1688,1 1750,0 1791,1 1809,0 1846,1 1931,0 2028,1 2113,0 2145,1 2168,0 2251,1 2316,0 2389,1 2413,0 2455,1 2476,0 2508,1 2517,0 2589,1 2674,0 2686,1 2726,0 2767,1 2772,0 2824,1 2917,0 2992,1 2999,0 3044,1 3126,0 3204,1 3246,0 3315,1 3338,0 3370,1 3463,0 3538,1 3582,0 3622,1 3644,0 3713,1 3738,0 3808,1 3817,0 3896,1 3972,0 4048,1 4115,0 4173,1 4204,0 4235,1 4253,0 4339,1 4438,0 4488,1 4527,0 4605,1 4629,0 4694,1 4787,0 4884,1 4958,0 5058,1 5068,0 5111,1 5139,0 5224,1 5306,0 5331,1 5355,0 5362,1 5399,0 5431,1 5486,0 5579,1 5608,0 5692,1 5734,0 5742,1 5829,0 5891,1 5958,0 5980,1 5992,0 6037,1 6050,0 6056,1 6103,0 6124,1 6161,0 6251,1 6317,0 6401,1 6473,0 6544,1 6642,0 6731,1 6811,0 6906,1 6938,0 6949,1 7024,0 7042,1 7092,0 7186,1 7243,0 7339,1 7385,0 7402,1 7471,0 7501,1 7575,0 7617,1 7715,0 7749,1 7775,0 7873,1 7945,0 8025,1 8030,0 8090,1 8132,0 8155,1 8253,0 8279,1 8320,0 8413,1 8454,0 8458,1 8521,0 8568,1 8574,0 8671,1 8738,0 8813,1 8851,0 8916,1 8959,0 8992,1 9002,0 9091,1 9093,0 9136,1 9154,0 9226,1 9278,0 9309,1 9390,0 9434,1 9491,0 9570,1 9613,0 9640,1 9653,0 9741,1 9772,0 9826,1 9912,0 9937,1 9980,0 10000,1 10066,0 10155,1 10158,0 10242,1 10274,0 10338,1 10409,0 10484,1 10578,0 10649,1 10700,0 10781,1 10804,0 10811,1 10895,0 10942,1 10985,0 11020,1 11045,0 11067,1 11071,0 11122,1 11149,0 11189,1 11226,0 11321,1 11369,0 11377,1 11411,0 11458,1 11552,0 11608,1 11612,0 11657,1 11683,0 11711,1 11806,0 11884,1 11973,0 12044,1 12066,0 12116,1 12143,0 12205,1 12245,0 12264,1 12278,0 12336,1 12377,0 12467,1 12525,0 12531,1 12596,0 12619,1 12635,0 12722,1 12778,0 12826,1 12887,0 12976,1 13069,0 13130,1 13157,0 13189,1 13289,0 13330,1 end initlist b52 0,0 31,1 56,0 95,1 182,0 195,1 287,0 342,1 409,0 430,1 512,0 590,1 651,0 667,1 723,0 748,1 805,0 864,1 958,0 998,1 1030,0 1101,1 1104,0 1157,1 1166,0 1235,1 1248,0 1284,1 1379,0 1468,1 1568,0 1633,1 1711,0 1811,1 1826,0 1886,1 1915,0 1920,1 1992,0 2074,1 2095,0 2121,1 2130,0 2147,1 2220,0 2288,1 2344,0 2402,1 2486,0 2569,1 2613,0 2626,1 2701,0 2744,1 2752,0 2776,1 2818,0 2864,1 2893,0 2948,1 3009,0 3062,1 3093,0 3134,1 3144,0 3153,1 3210,0 3262,1 3313,0 3367,1 3385,0 3408,1 3484,0 3565,1 3597,0 3625,1 3720,0 3728,1 3759,0 3814,1 3818,0 3872,1 3967,0 4020,1 4082,0 4093,1 4131,0 4137,1 4142,0 4228,1 4265,0 4308,1 4401,0 4439,1 4461,0 4505,1 4587,0 4608,1 4632,0 4717,1 4785,0 4807,1 4817,0 4881,1 4973,0 4980,1 4994,0 5053,1 5086,0 5130,1 5166,0 5232,1 5248,0 5269,1 5316,0 5346,1 5438,0 5534,1 5564,0 5644,1 5677,0 5753,1 5824,0 5869,1 5921,0 6002,1 6061,0 6123,1 6183,0 6250,1 6310,0 6326,1 6403,0 6502,1 6581,0 6588,1 6655,0 6729,1 6739,0 6759,1 6856,0 6906,1 6933,0 6986,1 7077,0 7103,1 7122,0 7204,1 7219,0 7250,1 7253,0 7286,1 7339,0 7384,1 7462,0 7502,1 7515,0 7523,1 7623,0 7687,1 7714,0 7771,1 7839,0 7922,1 8002,0 8036,1 8046,0 8138,1 8190,0 8272,1 8298,0 8314,1 8374,0 8450,1 8466,0 8554,1 8609,0 8634,1 8697,0 8701,1 8732,0 8737,1 8834,0 8836,1 8839,0 8858,1 8920,0 9008,1 9013,0 9074,1 9091,0 9143,1 9213,0 9290,1 9347,0 9393,1 9465,0 9536,1 9560,0 9595,1 9666,0 9741,1 9798,0 9877,1 9972,0 10021,1 10036,0 10068,1 10075,0 10092,1 10158,0 10253,1 10331,0 10387,1 10392,0 10456,1 10541,0 10605,1 10637,0 10646,1 10699,0 10719,1 10765,0 10800,1 10831,0 10847,1 10857,0 10858,1 10892,0 10943,1 11018,0 11047,1 11070,0 11124,1 11180,0 11228,1 11250,0 11340,1 11351,0 11402,1 11409,0 11446,1 11546,0 11556,1 11599,0 11649,1 11706,0 11726,1 11731,0 11766,1 11772,0 11802,1 11860,0 11947,1 11961,0 12001,1 12058,0 12136,1 end initlist b53 0,0 27,1 66,0 154,1 188,0 223,1 295,0 378,1 416,0 504,1 558,0 601,1 616,0 659,1 660,0 759,1 808,0 870,1 954,0 1024,1 1025,0 1034,1 1053,0 1116,1 1122,0 1142,1 1200,0 1281,1 1343,0 1405,1 1447,0 1448,1 1479,0 1560,1 1652,0 1709,1 1789,0 1884,1 1936,0 2018,1 2036,0 2046,1 2085,0 2171,1 2228,0 2326,1 2380,0 2390,1 2394,0 2458,1 2516,0 2613,1 2691,0 2769,1 2845,0 2875,1 2887,0 2986,1 3016,0 3088,1 3167,0 3211,1 3255,0 3287,1 3315,0 3361,1 3367,0 3464,1 3508,0 3556,1 3615,0 3710,1 3768,0 3806,1 3901,0 3928,1 4002,0 4016,1 4114,0 4192,1 4197,0 4206,1 4280,0 4355,1 4407,0 4482,1 4512,0 4575,1 4648,0 4677,1 4756,0 4852,1 4890,0 4920,1 4980,0 5077,1 5154,0 5196,1 5209,0 5230,1 5269,0 5360,1 5417,0 5418,1 5511,0 5553,1 5583,0 5620,1 5689,0 5697,1 5762,0 5822,1 5848,0 5865,1 5938,0 5967,1 6006,0 6103,1 6107,0 6123,1 6149,0 6238,1 6319,0 6327,1 6417,0 6498,1 6551,0 6631,1 6711,0 6761,1 6790,0 6889,1 6902,0 6911,1 6990,0 7044,1 7111,0 7136,1 7187,0 7284,1 7289,0 7383,1 7430,0 7491,1 7535,0 7580,1 7645,0 7745,1 7813,0 7824,1 7914,0 8002,1 8038,0 8127,1 8150,0 8170,1 8201,0 8227,1 8314,0 8339,1 8351,0 8400,1 8443,0 8502,1 8590,0 8669,1 8755,0 8775,1 8851,0 8883,1 8967,0 8999,1 9031,0 9077,1 9113,0 9168,1 9193,0 9244,1 9342,0 9359,1 9414,0 9506,1 9553,0 9620,1 9646,0 9710,1 9756,0 9781,1 9816,0 9825,1 9844,0 9900,1 9983,0 10002,1 10046,0 10096,1 10110,0 10162,1 10210,0 10248,1 10296,0 10338,1 10433,0 10460,1 10461,0 10499,1 10542,0 10564,1 10588,0 10636,1 10734,0 10800,1 10806,0 10868,1 10892,0 10900,1 10977,0 11050,1 11060,0 11067,1 11068,0 11118,1 11130,0 11182,1 11214,0 11276,1 11305,0 11319,1 11408,0 11467,1 11552,0 11589,1 11611,0 11703,1 11771,0 11829,1 11927,0 11959,1 12011,0 12080,1 12117,0 12123,1 12139,0 12216,1 12226,0 12303,1 12390,0 12398,1 12444,0 12504,1 12537,0 12546,1 12593,0 12658,1 12746,0 12769,1 12776,0 12873,1 end initlist b54 0,0 53,1 72,0 166,1 262,0 296,1 368,0 445,1 522,0 592,1 689,0 748,1 797,0 848,1 929,0 995,1 1044,0 1083,1 1098,0 1175,1 1191,0 1275,1 1295,0 1358,1 1372,0 1429,1 1517,0 1518,1 1615,0 1616,1 1661,0 1732,1 1800,0 1859,1 1959,0 2048,1 2078,0 2156,1 2186,0 2234,1 2327,0 2398,1 2436,0 2447,1 2521,0 2617,1 2663,0 2701,1 2793,0 2802,1 2890,0 2952,1 2973,0 2978,1 3033,0 3071,1 3165,0 3247,1 3273,0 3331,1 3348,0 3398,1 3494,0 3594,1 3620,0 3673,1 3737,0 3765,1 3846,0 3940,1 3988,0 4081,1 4131,0 4196,1 4296,0 4385,1 4444,0 4491,1 4504,0 4539,1 4618,0 4621,1 4672,0 4697,1 4733,0 4811,1 4846,0 4894,1 4949,0 4980,1 5012,0 5034,1 5068,0 5078,1 5119,0 5125,1 5154,0 5209,1 5307,0 5339,1 5371,0 5443,1 5541,0 5601,1 5623,0 5657,1 5703,0 5785,1 5839,0 5885,1 5910,0 5993,1 6048,0 6077,1 6118,0 6207,1 6306,0 6374,1 6394,0 6431,1 6462,0 6546,1 6641,0 6650,1 6714,0 6724,1 6752,0 6806,1 6816,0 6912,1 6953,0 7039,1 7052,0 7095,1 7184,0 7271,1 7351,0 7365,1 7443,0 7497,1 7529,0 7595,1 7678,0 7724,1 7765,0 7847,1 7942,0 7969,1 7995,0 8006,1 8100,0 8193,1 8219,0 8255,1 8289,0 8346,1 8367,0 8389,1 8421,0 8521,1 8585,0 8680,1 8749,0 8838,1 8847,0 8933,1 8967,0 8979,1 9035,0 9048,1 9102,0 9192,1 9243,0 9336,1 9422,0 9503,1 9555,0 9560,1 9570,0 9618,1 9677,0 9716,1 9747,0 9789,1 9851,0 9880,1 9973,0 10048,1 10107,0 10204,1 10211,0 10229,1 10234,0 10308,1 10339,0 10370,1 10416,0 10459,1 10489,0 10507,1 10589,0 10608,1 10684,0 10712,1 10810,0 10901,1 10905,0 11004,1 11005,0 11025,1 11100,0 11119,1 11122,0 11181,1 11185,0 11199,1 11233,0 11243,1 11277,0 11279,1 11319,0 11333,1 11419,0 11483,1 11527,0 11587,1 11589,0 11609,1 11708,0 11714,1 11727,0 11808,1 11879,0 11947,1 11949,0 11954,1 12036,0 12123,1 12144,0 12230,1 12292,0 12357,1 12410,0 12481,1 12501,0 12510,1 12597,0 12628,1 12646,0 12710,1 12789,0 12811,1 12867,0 12948,1 13036,0 13051,1 13081,0 13105,1 end initlist b55 0,0 94,1 135,0 216,1 238,0 257,1 315,0 389,1 390,0 417,1 507,0 511,1 565,0 586,1 619,0 628,1 724,0 760,1 815,0 833,1 903,0 1001,1 1060,0 1151,1 1213,0 1262,1 1331,0 1395,1 1435,0 1518,1 1566,0 1586,1 1589,0 1666,1 1724,0 1774,1 1836,0 1853,1 1928,0 1996,1 2070,0 2162,1 2200,0 2272,1 2276,0 2309,1 2329,0 2346,1 2439,0 2476,1 2552,0 2647,1 2707,0 2737,1 2829,0 2834,1 2928,0 2976,1 3070,0 3159,1 3187,0 3234,1 3332,0 3340,1 3403,0 3458,1 3512,0 3608,1 3620,0 3674,1 3731,0 3759,1 3828,0 3887,1 3916,0 4015,1 4089,0 4112,1 4124,0 4167,1 4207,0 4282,1 4361,0 4442,1 4522,0 4549,1 4647,0 4711,1 4732,0 4778,1 4809,0 4845,1 4889,0 4975,1 5027,0 5105,1 5151,0 5210,1 5226,0 5283,1 5312,0 5385,1 5444,0 5472,1 5525,0 5538,1 5557,0 5601,1 5641,0 5695,1 5710,0 5770,1 5772,0 5854,1 5865,0 5897,1 5943,0 5989,1 6077,0 6141,1 6237,0 6244,1 6255,0 6323,1 6396,0 6449,1 6474,0 6500,1 6549,0 6647,1 6691,0 6790,1 6806,0 6843,1 6878,0 6908,1 6935,0 6965,1 7051,0 7088,1 7094,0 7170,1 7203,0 7284,1 7359,0 7363,1 7396,0 7419,1 7485,0 7554,1 7609,0 7648,1 7669,0 7691,1 7779,0 7868,1 7873,0 7899,1 7966,0 7971,1 8070,0 8085,1 8108,0 8141,1 8203,0 8231,1 8244,0 8337,1 8378,0 8458,1 8548,0 8589,1 8621,0 8719,1 8807,0 8834,1 8873,0 8910,1 8925,0 9016,1 9025,0 9117,1 9156,0 9212,1 9275,0 9351,1 9356,0 9360,1 9384,0 9464,1 9523,0 9552,1 9609,0 9617,1 9627,0 9628,1 9629,0 9684,1 9685,0 9760,1 9849,0 9932,1 9947,0 9955,1 9985,0 10068,1 10120,0 10212,1 10291,0 10328,1 10406,0 10486,1 10502,0 10571,1 10624,0 10652,1 10657,0 10682,1 10749,0 10826,1 10917,0 10940,1 10977,0 10980,1 10990,0 11047,1 11130,0 11222,1 11265,0 11302,1 11309,0 11373,1 11444,0 11453,1 11490,0 11555,1 11557,0 11584,1 11614,0 11665,1 11675,0 11754,1 11767,0 11803,1 11810,0 11850,1 11887,0 11960,1 12028,0 12042,1 12114,0 12174,1 12259,0 12287,1 12386,0 12411,1 12508,0 12523,1 end initlist b56 0,0 5,1 30,0 43,1 131,0 221,1 304,0 339,1 371,0 440,1 535,0 587,1 653,0 705,1 765,0 839,1 933,0 987,1 1087,0 1113,1 1114,0 1198,1 1285,0 1339,1 1430,0 1463,1 1500,0 1553,1 1576,0 1625,1 1626,0 1655,1 1662,0 1719,1 1787,0 1853,1 1938,0 1949,1 1986,0 2072,1 2086,0 2121,1 2169,0 2196,1 2249,0 2278,1 2378,0 2412,1 2450,0 2478,1 2535,0 2615,1 2677,0 2754,1 2824,0 2888,1 2961,0 3020,1 3043,0 3049,1 3130,0 3154,1 3186,0 3223,1 3305,0 3383,1 3410,0 3426,1 3464,0 3499,1 3536,0 3616,1 3681,0 3695,1 3747,0 3787,1 3866,0 3880,1 3903,0 3946,1 3994,0 4048,1 4127,0 4149,1 4202,0 4212,1 4275,0 4318,1 4324,0 4361,1 4442,0 4476,1 4541,0 4589,1 4607,0 4618,1 4709,0 4785,1 4841,0 4874,1 4906,0 4925,1 4979,0 5055,1 5074,0 5097,1 5141,0 5169,1 5225,0 5242,1 5270,0 5287,1 5326,0 5349,1 5369,0 5397,1 5415,0 5434,1 5465,0 5559,1 5632,0 5696,1 5699,0 5759,1 5839,0 5915,1 5951,0 6022,1 6026,0 6074,1 6127,0 6187,1 6274,0 6330,1 6386,0 6463,1 6546,0 6610,1 6621,0 6700,1 6741,0 6775,1 6823,0 6892,1 6968,0 6994,1 7011,0 7021,1 7066,0 7154,1 7224,0 7244,1 7342,0 7425,1 7525,0 7537,1 7609,0 7679,1 7710,0 7741,1 7798,0 7868,1 7940,0 8032,1 8110,0 8116,1 8196,0 8231,1 8244,0 8252,1 8299,0 8398,1 8430,0 8465,1 8527,0 8585,1 8670,0 8735,1 8768,0 8796,1 8890,0 8966,1 9016,0 9053,1 9055,0 9124,1 9184,0 9227,1 9261,0 9317,1 9398,0 9493,1 9534,0 9633,1 9648,0 9723,1 9800,0 9879,1 9959,0 9996,1 10051,0 10097,1 10111,0 10163,1 10258,0 10310,1 10333,0 10431,1 10482,0 10487,1 10492,0 10537,1 10598,0 10613,1 10698,0 10711,1 10761,0 10782,1 10792,0 10850,1 10916,0 10931,1 11009,0 11045,1 11061,0 11095,1 11143,0 11223,1 11282,0 11290,1 11301,0 11355,1 11371,0 11453,1 11487,0 11527,1 11595,0 11629,1 11636,0 11710,1 11757,0 11774,1 11817,0 11883,1 11923,0 11946,1 11988,0 12066,1 12115,0 12213,1 12265,0 12363,1 12403,0 12459,1 12541,0 12560,1 12632,0 12634,1 end initlist b57 0,0 92,1 173,0 194,1 269,0 360,1 441,0 541,1 626,0 693,1 741,0 835,1 842,0 918,1 946,0 996,1 1056,0 1085,1 1116,0 1131,1 1231,0 1302,1 1363,0 1403,1 1469,0 1474,1 1500,0 1511,1 1538,0 1626,1 1633,0 1643,1 1645,0 1688,1 1699,0 1768,1 1792,0 1891,1 1919,0 1991,1 2072,0 2105,1 2140,0 2174,1 2263,0 2339,1 2388,0 2480,1 2532,0 2594,1 2687,0 2741,1 2772,0 2851,1 2948,0 2994,1 3087,0 3096,1 3165,0 3207,1 3210,0 3276,1 3375,0 3450,1 3513,0 3573,1 3606,0 3631,1 3660,0 3712,1 3724,0 3818,1 3835,0 3853,1 3946,0 3953,1 3975,0 3998,1 4026,0 4120,1 4198,0 4208,1 4250,0 4288,1 4356,0 4380,1 4445,0 4449,1 4493,0 4542,1 4609,0 4683,1 4696,0 4719,1 4782,0 4785,1 4852,0 4939,1 5013,0 5109,1 5158,0 5168,1 5262,0 5339,1 5391,0 5408,1 5451,0 5460,1 5510,0 5561,1 5580,0 5613,1 5707,0 5715,1 5732,0 5811,1 5842,0 5892,1 5980,0 6034,1 6062,0 6094,1 6167,0 6173,1 6216,0 6245,1 6342,0 6372,1 6464,0 6507,1 6594,0 6649,1 6682,0 6756,1 6772,0 6782,1 6808,0 6875,1 6882,0 6940,1 6954,0 6988,1 7060,0 7063,1 7125,0 7181,1 7250,0 7339,1 7417,0 7463,1 7534,0 7559,1 7613,0 7699,1 7764,0 7785,1 7865,0 7928,1 8008,0 8009,1 8018,0 8061,1 8126,0 8224,1 8247,0 8347,1 8438,0 8452,1 8508,0 8528,1 8543,0 8568,1 8573,0 8638,1 8703,0 8800,1 8883,0 8959,1 8967,0 8993,1 9089,0 9135,1 9136,0 9196,1 9225,0 9242,1 9244,0 9268,1 9303,0 9334,1 9395,0 9447,1 9449,0 9539,1 9629,0 9639,1 9738,0 9748,1 9832,0 9896,1 9902,0 9999,1 10085,0 10168,1 10189,0 10217,1 10225,0 10312,1 10373,0 10424,1 10520,0 10614,1 10684,0 10729,1 10806,0 10854,1 10922,0 11001,1 11101,0 11130,1 11229,0 11231,1 11264,0 11354,1 11406,0 11502,1 11538,0 11634,1 11652,0 11672,1 11721,0 11755,1 11846,0 11931,1 11974,0 12016,1 12100,0 12105,1 12152,0 12180,1 12245,0 12283,1 12316,0 12343,1 12399,0 12468,1 12479,0 12480,1 12522,0 12530,1 12579,0 12625,1 12709,0 12717,1 12754,0 12797,1 12826,0 12904,1 end initlist b58 0,0 96,1 130,0 134,1 200,0 261,1 272,0 322,1 345,0 354,1 367,0 431,1 525,0 569,1 625,0 647,1 708,0 797,1 808,0 852,1 905,0 963,1 984,0 1030,1 1099,0 1140,1 1169,0 1264,1 1338,0 1407,1 1416,0 1472,1 1545,0 1623,1 1712,0 1746,1 1791,0 1889,1 1931,0 1978,1 2001,0 2027,1 2071,0 2140,1 2189,0 2241,1 2251,0 2260,1 2324,0 2343,1 2352,0 2380,1 2452,0 2463,1 2486,0 2490,1 2556,0 2612,1 2636,0 2723,1 2729,0 2829,1 2902,0 2982,1 3022,0 3033,1 3077,0 3135,1 3184,0 3205,1 3247,0 3306,1 3386,0 3453,1 3542,0 3569,1 3605,0 3671,1 3725,0 3796,1 3863,0 3893,1 3905,0 3959,1 4040,0 4068,1 4122,0 4204,1 4266,0 4315,1 4385,0 4441,1 4446,0 4451,1 4486,0 4504,1 4580,0 4605,1 4705,0 4739,1 4767,0 4772,1 4798,0 4871,1 4888,0 4951,1 5008,0 5055,1 5073,0 5146,1 5161,0 5206,1 5269,0 5304,1 5398,0 5481,1 5494,0 5521,1 5573,0 5627,1 5697,0 5791,1 5793,0 5804,1 5854,0 5867,1 5953,0 5956,1 5972,0 6022,1 6109,0 6200,1 6230,0 6295,1 6318,0 6399,1 6424,0 6448,1 6536,0 6602,1 6644,0 6717,1 6739,0 6748,1 6774,0 6827,1 6926,0 6958,1 7040,0 7052,1 7065,0 7133,1 7177,0 7204,1 7215,0 7295,1 7386,0 7433,1 7441,0 7451,1 7504,0 7582,1 7627,0 7725,1 7804,0 7840,1 7936,0 8019,1 8051,0 8129,1 8133,0 8209,1 8273,0 8281,1 8354,0 8384,1 8444,0 8445,1 8470,0 8497,1 8541,0 8605,1 8701,0 8764,1 8809,0 8866,1 8874,0 8971,1 8999,0 9008,1 9033,0 9117,1 9151,0 9191,1 9213,0 9288,1 9321,0 9367,1 9418,0 9494,1 9561,0 9658,1 9750,0 9791,1 9868,0 9916,1 10001,0 10048,1 10102,0 10126,1 10169,0 10204,1 10264,0 10324,1 10356,0 10448,1 10461,0 10533,1 10570,0 10600,1 10693,0 10728,1 10796,0 10834,1 10918,0 10980,1 11009,0 11109,1 11178,0 11221,1 11277,0 11352,1 11411,0 11467,1 11535,0 11618,1 11691,0 11785,1 11864,0 11906,1 11994,0 12020,1 12034,0 12046,1 12067,0 12137,1 12212,0 12303,1 12309,0 12406,1 12498,0 12580,1 12589,0 12591,1 12686,0 12755,1 12761,0 12788,1 end initlist b59 0,0 26,1 89,0 147,1 164,0 202,1 299,0 323,1 384,0 447,1 519,0 525,1 566,0 624,1 679,0 714,1 750,0 793,1 815,0 896,1 966,0 1020,1 1076,0 1122,1 1192,0 1288,1 1318,0 1387,1 1400,0 1425,1 1451,0 1550,1 1556,0 1615,1 1629,0 1689,1 1763,0 1765,1 1852,0 1941,1 1961,0 2056,1 2135,0 2233,1 2284,0 2292,1 2379,0 2393,1 2461,0 2482,1 2558,0 2596,1 2629,0 2699,1 2764,0 2800,1 2862,0 2934,1 2985,0 3062,1 3080,0 3112,1 3123,0 3185,1 3203,0 3229,1 3286,0 3302,1 3307,0 3325,1 3333,0 3338,1 3421,0 3482,1 3508,0 3543,1 3630,0 3720,1 3760,0 3811,1 3841,0 3857,1 3903,0 3934,1 3980,0 4071,1 4085,0 4167,1 4174,0 4246,1 4320,0 4340,1 4368,0 4416,1 4440,0 4455,1 4497,0 4592,1 4633,0 4689,1 4698,0 4736,1 4803,0 4902,1 4923,0 4939,1 4948,0 4964,1 5027,0 5095,1 5144,0 5223,1 5238,0 5287,1 5383,0 5471,1 5566,0 5664,1 5752,0 5835,1 5919,0 5934,1 5952,0 6047,1 6103,0 6123,1 6164,0 6263,1 6318,0 6372,1 6470,0 6471,1 6481,0 6559,1 6575,0 6586,1 6664,0 6738,1 6756,0 6839,1 6885,0 6902,1 6953,0 7000,1 7045,0 7055,1 7138,0 7221,1 7301,0 7320,1 7369,0 7403,1 7410,0 7478,1 7544,0 7614,1 7664,0 7752,1 7795,0 7798,1 7836,0 7849,1 7919,0 8005,1 8029,0 8055,1 8130,0 8203,1 8260,0 8350,1 8369,0 8380,1 8460,0 8532,1 8580,0 8654,1 8752,0 8824,1 8905,0 8953,1 9050,0 9070,1 9138,0 9225,1 9294,0 9335,1 9355,0 9453,1 9518,0 9529,1 9594,0 9653,1 9748,0 9779,1 9867,0 9943,1 9972,0 9993,1 10031,0 10101,1 10190,0 10265,1 10314,0 10391,1 10456,0 10509,1 10513,0 10522,1 10609,0 10648,1 10725,0 10821,1 10874,0 10961,1 11021,0 11050,1 11143,0 11170,1 11256,0 11321,1 11336,0 11349,1 11362,0 11438,1 11486,0 11488,1 11536,0 11541,1 11617,0 11671,1 11677,0 11722,1 11742,0 11821,1 11876,0 11958,1 12004,0 12041,1 12076,0 12111,1 12135,0 12222,1 12302,0 12393,1 12437,0 12497,1 12572,0 12597,1 12629,0 12679,1 12727,0 12825,1 12887,0 12969,1 13053,0 13085,1 13120,0 13188,1 end initlist b60 0,0 25,1 121,0 127,1 171,0 258,1 348,0 445,1 458,0 519,1 587,0 657,1 658,0 694,1 772,0 803,1 851,0 864,1 902,0 970,1 1029,0 1112,1 1179,0 1259,1 1328,0 1402,1 1499,0 1598,1 1680,0 1748,1 1754,0 1848,1 1930,0 2021,1 2044,0 2057,1 2089,0 2130,1 2200,0 2263,1 2307,0 2383,1 2455,0 2503,1 2512,0 2515,1 2578,0 2617,1 2701,0 2717,1 2734,0 2736,1 2798,0 2819,1 2910,0 2949,1 3026,0 3126,1 3158,0 3215,1 3235,0 3278,1 3359,0 3406,1 3410,0 3485,1 3528,0 3532,1 3581,0 3663,1 3704,0 3756,1 3774,0 3795,1 3876,0 3956,1 4040,0 4125,1 4202,0 4240,1 4340,0 4359,1 4392,0 4399,1 4476,0 4510,1 4517,0 4600,1 4661,0 4712,1 4772,0 4783,1 4815,0 4871,1 4936,0 5003,1 5051,0 5065,1 5128,0 5140,1 5149,0 5172,1 5181,0 5276,1 5343,0 5349,1 5376,0 5471,1 5479,0 5512,1 5584,0 5594,1 5645,0 5692,1 5710,0 5721,1 5785,0 5854,1 5944,0 6031,1 6096,0 6145,1 6162,0 6176,1 6196,0 6197,1 6296,0 6346,1 6403,0 6464,1 6559,0 6563,1 6635,0 6722,1 6783,0 6809,1 6845,0 6871,1 6951,0 6996,1 7010,0 7097,1 7173,0 7181,1 7269,0 7352,1 7389,0 7395,1 7446,0 7522,1 7604,0 7659,1 7662,0 7711,1 7730,0 7748,1 7749,0 7821,1 7905,0 7964,1 8002,0 8081,1 8115,0 8156,1 8182,0 8235,1 8291,0 8390,1 8489,0 8490,1 8569,0 8589,1 8595,0 8647,1 8704,0 8737,1 8834,0 8890,1 8950,0 8981,1 9081,0 9139,1 9204,0 9209,1 9286,0 9341,1 9385,0 9420,1 9439,0 9466,1 9549,0 9643,1 9653,0 9736,1 9758,0 9790,1 9837,0 9909,1 9993,0 10093,1 10183,0 10221,1 10286,0 10299,1 10370,0 10382,1 10455,0 10500,1 10574,0 10579,1 10610,0 10675,1 10747,0 10764,1 10798,0 10854,1 10903,0 10984,1 11002,0 11087,1 11151,0 11167,1 11218,0 11230,1 11257,0 11337,1 11378,0 11421,1 11500,0 11517,1 11593,0 11672,1 11702,0 11744,1 11795,0 11801,1 11822,0 11855,1 11949,0 12023,1 12123,0 12178,1 12275,0 12282,1 12312,0 12376,1 12423,0 12500,1 12516,0 12599,1 12688,0 12758,1 12807,0 12831,1 12869,0 12951,1 12963,0 13019,1 end initlist b61 0,0 93,1 96,0 180,1 183,0 280,1 348,0 411,1 452,0 544,1 560,0 579,1 589,0 592,1 656,0 704,1 775,0 820,1 894,0 947,1 969,0 1044,1 1077,0 1117,1 1147,0 1247,1 1298,0 1301,1 1380,0 1400,1 1498,0 1548,1 1596,0 1603,1 1655,0 1674,1 1712,0 1786,1 1812,0 1900,1 1961,0 2054,1 2096,0 2139,1 2238,0 2299,1 2322,0 2409,1 2435,0 2534,1 2600,0 2686,1 2768,0 2795,1 2889,0 2970,1 3029,0 3080,1 3126,0 3143,1 3217,0 3219,1 3229,0 3242,1 3321,0 3348,1 3448,0 3526,1 3576,0 3597,1 3665,0 3672,1 3694,0 3710,1 3800,0 3837,1 3928,0 3997,1 4002,0 4024,1 4072,0 4082,1 4154,0 4246,1 4309,0 4385,1 4424,0 4504,1 4562,0 4623,1 4646,0 4649,1 4701,0 4753,1 4779,0 4817,1 4891,0 4926,1 4949,0 5017,1 5061,0 5151,1 5167,0 5226,1 5305,0 5337,1 5430,0 5515,1 5587,0 5667,1 5751,0 5781,1 5859,0 5880,1 5909,0 5961,1 5987,0 6045,1 6073,0 6122,1 6164,0 6181,1 6208,0 6219,1 6228,0 6230,1 6260,0 6282,1 6311,0 6365,1 6433,0 6476,1 6504,0 6523,1 6563,0 6642,1 6722,0 6783,1 6791,0 6876,1 6905,0 6912,1 6994,0 7029,1 7037,0 7061,1 7086,0 7146,1 7228,0 7305,1 7373,0 7389,1 7438,0 7464,1 7558,0 7619,1 7676,0 7758,1 7825,0 7918,1 7989,0 8071,1 8170,0 8241,1 8317,0 8330,1 8354,0 8391,1 8471,0 8533,1 8542,0 8591,1 8628,0 8720,1 8798,0 8871,1 8906,0 8989,1 9046,0 9112,1 9176,0 9253,1 9290,0 9361,1 9392,0 9441,1 9541,0 9568,1 9576,0 9604,1 9650,0 9733,1 9805,0 9813,1 9857,0 9926,1 9984,0 10003,1 10012,0 10014,1 10074,0 10089,1 10141,0 10228,1 10318,0 10382,1 10444,0 10541,1 10622,0 10678,1 10710,0 10727,1 10814,0 10838,1 10856,0 10919,1 10990,0 11038,1 11133,0 11170,1 11181,0 11190,1 11200,0 11280,1 11328,0 11390,1 11484,0 11544,1 11550,0 11579,1 11653,0 11744,1 11751,0 11798,1 11845,0 11878,1 11905,0 11959,1 12045,0 12125,1 12171,0 12252,1 12272,0 12318,1 12392,0 12446,1 12529,0 12536,1 12622,0 12721,1 12800,0 12828,1 12848,0 12887,1 12911,0 12996,1 13008,0 13051,1 end initlist b62 0,0 99,1 104,0 156,1 235,0 324,1 367,0 372,1 424,0 518,1 562,0 644,1 652,0 704,1 752,0 771,1 835,0 889,1 941,0 1013,1 1044,0 1126,1 1165,0 1229,1 1263,0 1321,1 1336,0 1343,1 1351,0 1387,1 1432,0 1450,1 1529,0 1537,1 1589,0 1680,1 1764,0 1768,1 1837,0 1915,1 1969,0 1995,1 2045,0 2089,1 2144,0 2145,1 2160,0 2179,1 2203,0 2289,1 2328,0 2354,1 2424,0 2514,1 2590,0 2672,1 2716,0 2758,1 2777,0 2785,1 2873,0 2913,1 3006,0 3059,1 3134,0 3150,1 3217,0 3245,1 3304,0 3320,1 3352,0 3398,1 3468,0 3486,1 3555,0 3591,1 3655,0 3685,1 3733,0 3735,1 3781,0 3853,1 3895,0 3951,1 4020,0 4076,1 4108,0 4165,1 4265,0 4285,1 4385,0 4407,1 4478,0 4506,1 4567,0 4591,1 4670,0 4727,1 4798,0 4842,1 4923,0 4986,1 4997,0 5033,1 5041,0 5045,1 5121,0 5219,1 5286,0 5305,1 5340,0 5426,1 5517,0 5557,1 5561,0 5643,1 5654,0 5667,1 5701,0 5786,1 5839,0 5925,1 5981,0 6006,1 6080,0 6120,1 6124,0 6215,1 6264,0 6354,1 6425,0 6471,1 6506,0 6511,1 6597,0 6600,1 6668,0 6724,1 6769,0 6774,1 6844,0 6931,1 7015,0 7073,1 7083,0 7147,1 7196,0 7251,1 7324,0 7406,1 7498,0 7502,1 7544,0 7581,1 7611,0 7665,1 7739,0 7835,1 7929,0 8025,1 8054,0 8097,1 8188,0 8226,1 8324,0 8351,1 8356,0 8369,1 8447,0 8524,1 8552,0 8624,1 8641,0 8688,1 8709,0 8793,1 8812,0 8841,1 8847,0 8883,1 8981,0 9025,1 9101,0 9152,1 9227,0 9242,1 9315,0 9319,1 9339,0 9374,1 9402,0 9436,1 9466,0 9514,1 9606,0 9679,1 9699,0 9730,1 9808,0 9830,1 9866,0 9918,1 9937,0 10035,1 10096,0 10099,1 10117,0 10127,1 10202,0 10213,1 10240,0 10317,1 10401,0 10409,1 10453,0 10499,1 10535,0 10569,1 10592,0 10673,1 10739,0 10769,1 10869,0 10898,1 10919,0 10952,1 10957,0 10985,1 11013,0 11060,1 11113,0 11143,1 11226,0 11236,1 11292,0 11301,1 11377,0 11413,1 11439,0 11506,1 11519,0 11547,1 11598,0 11659,1 11690,0 11725,1 11795,0 11852,1 11902,0 11944,1 11982,0 12067,1 12146,0 12162,1 12256,0 12299,1 12318,0 12320,1 end initlist b63 0,0 43,1 107,0 136,1 173,0 189,1 218,0 297,1 351,0 355,1 382,0 461,1 501,0 539,1 593,0 684,1 711,0 778,1 813,0 820,1 895,0 928,1 934,0 1006,1 1078,0 1121,1 1162,0 1243,1 1325,0 1365,1 1455,0 1555,1 1630,0 1657,1 1757,0 1806,1 1823,0 1894,1 1911,0 1932,1 2020,0 2092,1 2127,0 2218,1 2260,0 2308,1 2351,0 2433,1 2464,0 2491,1 2589,0 2657,1 2704,0 2707,1 2755,0 2803,1 2830,0 2863,1 2923,0 2978,1 3072,0 3155,1 3249,0 3344,1 3363,0 3453,1 3532,0 3585,1 3651,0 3703,1 3720,0 3774,1 3800,0 3820,1 3906,0 3914,1 3985,0 4038,1 4088,0 4175,1 4192,0 4246,1 4340,0 4440,1 4474,0 4559,1 4655,0 4748,1 4798,0 4888,1 4935,0 5019,1 5085,0 5113,1 5155,0 5175,1 5207,0 5211,1 5259,0 5276,1 5341,0 5350,1 5405,0 5434,1 5525,0 5621,1 5713,0 5733,1 5746,0 5782,1 5814,0 5908,1 5978,0 6071,1 6125,0 6145,1 6173,0 6237,1 6252,0 6288,1 6322,0 6379,1 6422,0 6483,1 6551,0 6635,1 6714,0 6796,1 6819,0 6895,1 6916,0 6984,1 6998,0 7019,1 7067,0 7116,1 7206,0 7263,1 7320,0 7348,1 7367,0 7372,1 7423,0 7470,1 7523,0 7589,1 7629,0 7715,1 7796,0 7798,1 7858,0 7941,1 7959,0 7980,1 7995,0 8024,1 8111,0 8207,1 8212,0 8234,1 8279,0 8347,1 8418,0 8502,1 8580,0 8677,1 8723,0 8789,1 8885,0 8915,1 8920,0 8932,1 9026,0 9034,1 9091,0 9161,1 9221,0 9292,1 9333,0 9412,1 9424,0 9469,1 9563,0 9623,1 9638,0 9696,1 9766,0 9858,1 9872,0 9945,1 9959,0 9997,1 10016,0 10103,1 10197,0 10260,1 10276,0 10371,1 10460,0 10530,1 10619,0 10673,1 10708,0 10710,1 10747,0 10750,1 10798,0 10801,1 10884,0 10962,1 11034,0 11121,1 11141,0 11216,1 11253,0 11312,1 11341,0 11430,1 11459,0 11513,1 11610,0 11703,1 11732,0 11771,1 11788,0 11791,1 11793,0 11835,1 11876,0 11899,1 11911,0 11929,1 11938,0 11994,1 12070,0 12168,1 12235,0 12240,1 12287,0 12373,1 12435,0 12511,1 12536,0 12600,1 12646,0 12717,1 12815,0 12880,1 12895,0 12983,1 13001,0 13032,1 13038,0 13059,1 13145,0 13223,1 13261,0 13291,1 end initlist b64 0,0 94,1 192,0 244,1 316,0 386,1 451,0 527,1 544,0 624,1 710,0 711,1 799,0 845,1 905,0 961,1 970,0 991,1 1081,0 1133,1 1157,0 1205,1 1305,0 1313,1 1325,0 1345,1 1438,0 1511,1 1607,0 1612,1 1635,0 1664,1 1704,0 1757,1 1847,0 1856,1 1879,0 1890,1 1921,0 1933,1 1996,0 2093,1 2107,0 2117,1 2183,0 2261,1 2274,0 2356,1 2424,0 2436,1 2536,0 2576,1 2627,0 2689,1 2718,0 2728,1 2808,0 2858,1 2934,0 2982,1 3010,0 3029,1 3034,0 3050,1 3091,0 3110,1 3194,0 3270,1 3354,0 3418,1 3485,0 3516,1 3567,0 3665,1 3724,0 3757,1 3779,0 3836,1 3880,0 3965,1 4045,0 4137,1 4165,0 4254,1 4321,0 4332,1 4430,0 4476,1 4542,0 4621,1 4641,0 4659,1 4722,0 4810,1 4909,0 4980,1 5061,0 5153,1 5178,0 5180,1 5186,0 5270,1 5337,0 5376,1 5464,0 5550,1 5598,0 5674,1 5701,0 5735,1 5811,0 5891,1 5922,0 5972,1 5982,0 6021,1 6078,0 6099,1 6126,0 6190,1 6244,0 6334,1 6423,0 6472,1 6544,0 6609,1 6696,0 6785,1 6807,0 6814,1 6900,0 6976,1 7004,0 7102,1 7166,0 7262,1 7286,0 7328,1 7412,0 7462,1 7560,0 7591,1 7668,0 7686,1 7694,0 7729,1 7829,0 7917,1 7924,0 8004,1 8039,0 8061,1 8161,0 8248,1 8256,0 8348,1 8442,0 8497,1 8546,0 8553,1 8594,0 8636,1 8700,0 8721,1 8821,0 8845,1 8932,0 9017,1 9114,0 9176,1 9186,0 9198,1 9246,0 9335,1 9375,0 9397,1 9466,0 9530,1 9578,0 9609,1 9639,0 9654,1 9676,0 9684,1 9734,0 9755,1 9833,0 9843,1 9844,0 9865,1 9907,0 9928,1 10023,0 10121,1 10179,0 10234,1 10266,0 10347,1 10441,0 10488,1 10537,0 10575,1 10665,0 10700,1 10778,0 10873,1 10941,0 10993,1 11012,0 11050,1 11149,0 11167,1 11220,0 11231,1 11312,0 11361,1 11439,0 11519,1 11542,0 11609,1 11638,0 11722,1 11729,0 11789,1 11808,0 11816,1 11903,0 11998,1 12025,0 12097,1 12158,0 12184,1 12266,0 12291,1 12318,0 12405,1 12464,0 12485,1 12502,0 12542,1 12578,0 12587,1 12628,0 12691,1 12694,0 12704,1 12777,0 12831,1 12907,0 13006,1 13104,0 13145,1 13173,0 13245,1 13302,0 13350,1 13435,0 13457,1 end initlist b65 0,0 95,1 129,0 164,1 229,0 291,1 367,0 466,1 509,0 595,1 629,0 685,1 720,0 763,1 818,0 903,1 947,0 1028,1 1076,0 1129,1 1173,0 1196,1 1242,0 1294,1 1320,0 1359,1 1360,0 1427,1 1486,0 1583,1 1607,0 1701,1 1724,0 1823,1 1873,0 1968,1 2005,0 2099,1 2173,0 2254,1 2332,0 2400,1 2454,0 2495,1 2538,0 2546,1 2577,0 2666,1 2716,0 2785,1 2885,0 2944,1 2996,0 3077,1 3104,0 3200,1 3208,0 3283,1 3284,0 3355,1 3412,0 3440,1 3496,0 3526,1 3537,0 3552,1 3644,0 3740,1 3766,0 3857,1 3865,0 3907,1 3924,0 4010,1 4088,0 4136,1 4223,0 4313,1 4342,0 4433,1 4526,0 4573,1 4630,0 4697,1 4722,0 4734,1 4766,0 4813,1 4853,0 4928,1 4973,0 4981,1 5079,0 5160,1 5161,0 5207,1 5231,0 5262,1 5263,0 5288,1 5327,0 5416,1 5471,0 5499,1 5567,0 5653,1 5689,0 5710,1 5781,0 5835,1 5903,0 5966,1 6038,0 6096,1 6193,0 6199,1 6242,0 6287,1 6307,0 6334,1 6361,0 6425,1 6491,0 6496,1 6557,0 6587,1 6663,0 6676,1 6709,0 6773,1 6785,0 6818,1 6890,0 6972,1 7015,0 7113,1 7142,0 7216,1 7250,0 7349,1 7412,0 7440,1 7523,0 7543,1 7638,0 7697,1 7769,0 7822,1 7860,0 7905,1 7952,0 8033,1 8047,0 8112,1 8185,0 8207,1 8212,0 8254,1 8315,0 8415,1 8470,0 8524,1 8599,0 8692,1 8775,0 8799,1 8806,0 8837,1 8880,0 8971,1 9006,0 9105,1 9109,0 9140,1 9191,0 9262,1 9270,0 9280,1 9377,0 9460,1 9503,0 9558,1 9638,0 9714,1 9741,0 9763,1 9782,0 9827,1 9859,0 9863,1 9877,0 9897,1 9957,0 10004,1 10076,0 10152,1 10229,0 10248,1 10266,0 10298,1 10384,0 10471,1 10544,0 10572,1 10573,0 10586,1 10631,0 10704,1 10726,0 10796,1 10833,0 10919,1 10993,0 11051,1 11148,0 11158,1 11237,0 11278,1 11309,0 11354,1 11412,0 11496,1 11524,0 11623,1 11710,0 11730,1 11781,0 11788,1 11837,0 11901,1 11915,0 11978,1 12031,0 12079,1 12145,0 12244,1 12279,0 12330,1 12394,0 12427,1 12523,0 12575,1 12636,0 12720,1 12814,0 12818,1 12836,0 12923,1 13017,0 13030,1 13095,0 13146,1 13169,0 13244,1 13336,0 13357,1 13408,0 13493,1 end initlist b66 0,0 48,1 105,0 139,1 220,0 318,1 379,0 460,1 481,0 549,1 631,0 667,1 719,0 803,1 806,0 829,1 925,0 1017,1 1114,0 1129,1 1188,0 1217,1 1308,0 1396,1 1451,0 1470,1 1565,0 1567,1 1631,0 1726,1 1820,0 1889,1 1927,0 1960,1 1961,0 1977,1 2068,0 2118,1 2210,0 2269,1 2363,0 2380,1 2423,0 2512,1 2519,0 2599,1 2627,0 2687,1 2692,0 2707,1 2724,0 2798,1 2824,0 2862,1 2890,0 2964,1 2999,0 3074,1 3136,0 3193,1 3288,0 3318,1 3400,0 3465,1 3557,0 3601,1 3618,0 3662,1 3752,0 3841,1 3931,0 4009,1 4077,0 4097,1 4128,0 4226,1 4284,0 4359,1 4443,0 4513,1 4606,0 4699,1 4736,0 4788,1 4863,0 4884,1 4960,0 4983,1 4997,0 5092,1 5110,0 5197,1 5244,0 5299,1 5370,0 5375,1 5430,0 5472,1 5527,0 5534,1 5594,0 5656,1 5682,0 5755,1 5844,0 5880,1 5931,0 6013,1 6035,0 6103,1 6172,0 6185,1 6275,0 6304,1 6381,0 6452,1 6510,0 6609,1 6702,0 6748,1 6818,0 6867,1 6914,0 6938,1 6947,0 6986,1 7080,0 7180,1 7264,0 7316,1 7357,0 7374,1 7454,0 7533,1 7605,0 7611,1 7684,0 7784,1 7862,0 7897,1 7914,0 7985,1 8078,0 8107,1 8180,0 8227,1 8299,0 8321,1 8349,0 8355,1 8387,0 8421,1 8467,0 8567,1 8622,0 8642,1 8721,0 8789,1 8881,0 8932,1 9018,0 9053,1 9102,0 9156,1 9237,0 9307,1 9395,0 9423,1 9506,0 9545,1 9612,0 9620,1 9666,0 9707,1 9713,0 9806,1 9853,0 9866,1 9919,0 10003,1 10037,0 10132,1 10160,0 10178,1 10245,0 10255,1 10348,0 10439,1 10484,0 10530,1 10563,0 10616,1 10622,0 10654,1 10671,0 10681,1 10773,0 10774,1 10873,0 10969,1 10984,0 11011,1 11107,0 11169,1 11259,0 11271,1 11304,0 11353,1 11397,0 11472,1 11567,0 11637,1 11675,0 11694,1 11772,0 11865,1 11958,0 11973,1 12012,0 12054,1 12152,0 12195,1 12262,0 12303,1 12352,0 12403,1 12429,0 12430,1 12460,0 12554,1 12566,0 12630,1 12645,0 12688,1 12695,0 12741,1 12797,0 12820,1 12871,0 12887,1 12974,0 13021,1 13075,0 13129,1 13221,0 13287,1 13381,0 13430,1 13468,0 13485,1 13492,0 13542,1 13573,0 13619,1 13661,0 13667,1 13760,0 13779,1 end initlist b67 0,0 21,1 101,0 192,1 215,0 222,1 248,0 269,1 329,0 417,1 453,0 486,1 540,0 606,1 688,0 753,1 756,0 825,1 866,0 911,1 975,0 1032,1 1112,0 1134,1 1174,0 1185,1 1220,0 1281,1 1334,0 1384,1 1421,0 1459,1 1538,0 1635,1 1651,0 1727,1 1733,0 1804,1 1847,0 1880,1 1912,0 1950,1 1953,0 2053,1 2095,0 2127,1 2185,0 2252,1 2280,0 2342,1 2351,0 2364,1 2396,0 2435,1 2528,0 2618,1 2628,0 2678,1 2760,0 2800,1 2873,0 2913,1 2957,0 3003,1 3057,0 3084,1 3154,0 3171,1 3237,0 3252,1 3257,0 3355,1 3379,0 3462,1 3511,0 3558,1 3582,0 3659,1 3687,0 3725,1 3794,0 3885,1 3977,0 4043,1 4056,0 4081,1 4174,0 4240,1 4335,0 4397,1 4448,0 4543,1 4611,0 4668,1 4671,0 4683,1 4735,0 4792,1 4834,0 4877,1 4883,0 4906,1 5000,0 5040,1 5074,0 5148,1 5213,0 5262,1 5308,0 5374,1 5433,0 5520,1 5566,0 5577,1 5620,0 5710,1 5758,0 5764,1 5839,0 5913,1 5985,0 6074,1 6121,0 6171,1 6270,0 6323,1 6409,0 6445,1 6488,0 6526,1 6541,0 6587,1 6625,0 6712,1 6784,0 6873,1 6929,0 6967,1 7023,0 7070,1 7073,0 7141,1 7143,0 7161,1 7227,0 7311,1 7342,0 7407,1 7434,0 7504,1 7587,0 7677,1 7727,0 7735,1 7801,0 7880,1 7898,0 7913,1 7918,0 7935,1 8004,0 8038,1 8102,0 8188,1 8216,0 8298,1 8372,0 8437,1 8474,0 8478,1 8570,0 8658,1 8706,0 8773,1 8829,0 8845,1 8934,0 9026,1 9045,0 9056,1 9144,0 9208,1 9292,0 9358,1 9381,0 9464,1 9470,0 9511,1 9571,0 9645,1 9694,0 9737,1 9773,0 9826,1 9899,0 9991,1 9992,0 10008,1 10032,0 10090,1 10168,0 10252,1 10274,0 10340,1 10367,0 10436,1 10463,0 10513,1 10517,0 10529,1 10609,0 10665,1 10762,0 10817,1 10824,0 10905,1 10983,0 11061,1 11120,0 11167,1 11248,0 11276,1 11311,0 11335,1 11368,0 11432,1 11437,0 11443,1 11504,0 11527,1 11586,0 11647,1 11669,0 11707,1 11727,0 11753,1 11843,0 11906,1 11945,0 11985,1 12045,0 12124,1 12216,0 12289,1 12347,0 12407,1 12503,0 12570,1 12604,0 12693,1 12751,0 12759,1 12761,0 12805,1 12844,0 12845,1 12880,0 12922,1 end initlist b68 0,0 86,1 109,0 172,1 207,0 279,1 280,0 373,1 456,0 548,1 619,0 639,1 713,0 766,1 797,0 894,1 914,0 980,1 1011,0 1033,1 1115,0 1137,1 1199,0 1234,1 1271,0 1287,1 1304,0 1396,1 1473,0 1534,1 1538,0 1567,1 1651,0 1697,1 1772,0 1778,1 1876,0 1938,1 1962,0 1982,1 2071,0 2077,1 2105,0 2146,1 2206,0 2236,1 2274,0 2311,1 2392,0 2454,1 2476,0 2498,1 2500,0 2521,1 2553,0 2624,1 2712,0 2722,1 2729,0 2787,1 2850,0 2906,1 2993,0 3020,1 3083,0 3144,1 3150,0 3236,1 3292,0 3306,1 3383,0 3392,1 3413,0 3508,1 3524,0 3571,1 3584,0 3585,1 3681,0 3758,1 3762,0 3794,1 3800,0 3899,1 3988,0 4073,1 4103,0 4164,1 4191,0 4253,1 4299,0 4379,1 4415,0 4418,1 4432,0 4441,1 4495,0 4564,1 4660,0 4713,1 4803,0 4873,1 4914,0 4917,1 4985,0 5064,1 5141,0 5150,1 5156,0 5246,1 5326,0 5366,1 5389,0 5440,1 5457,0 5522,1 5583,0 5656,1 5676,0 5734,1 5784,0 5851,1 5865,0 5910,1 5928,0 5967,1 5988,0 6027,1 6120,0 6196,1 6273,0 6308,1 6334,0 6376,1 6444,0 6530,1 6545,0 6605,1 6615,0 6712,1 6745,0 6778,1 6809,0 6838,1 6933,0 7012,1 7014,0 7062,1 7125,0 7215,1 7242,0 7255,1 7290,0 7304,1 7311,0 7342,1 7365,0 7397,1 7418,0 7438,1 7445,0 7477,1 7565,0 7643,1 7729,0 7740,1 7800,0 7886,1 7893,0 7926,1 7987,0 8075,1 8077,0 8130,1 8182,0 8220,1 8269,0 8272,1 8287,0 8363,1 8364,0 8434,1 8508,0 8578,1 8586,0 8637,1 8663,0 8751,1 8797,0 8819,1 8918,0 8938,1 9025,0 9038,1 9073,0 9107,1 9126,0 9195,1 9256,0 9264,1 9317,0 9388,1 9408,0 9495,1 9514,0 9555,1 9564,0 9625,1 9704,0 9728,1 9771,0 9824,1 9909,0 9940,1 9964,0 9978,1 10070,0 10127,1 10223,0 10295,1 10358,0 10451,1 10492,0 10531,1 10550,0 10608,1 10695,0 10771,1 10843,0 10888,1 10974,0 11044,1 11061,0 11094,1 11173,0 11198,1 11223,0 11300,1 11305,0 11374,1 11422,0 11433,1 11522,0 11578,1 11613,0 11662,1 11684,0 11732,1 11798,0 11838,1 11906,0 11976,1 11989,0 12013,1 12063,0 12110,1 12175,0 12193,1 end initlist b69 0,0 65,1 125,0 166,1 244,0 304,1 383,0 441,1 477,0 567,1 656,0 683,1 751,0 804,1 887,0 925,1 1023,0 1106,1 1143,0 1239,1 1320,0 1358,1 1391,0 1478,1 1532,0 1588,1 1672,0 1763,1 1821,0 1828,1 1880,0 1885,1 1945,0 2028,1 2037,0 2096,1 2172,0 2176,1 2272,0 2326,1 2381,0 2463,1 2473,0 2552,1 2578,0 2606,1 2704,0 2714,1 2780,0 2840,1 2888,0 2895,1 2916,0 2922,1 2964,0 2997,1 3035,0 3078,1 3082,0 3107,1 3168,0 3180,1 3238,0 3257,1 3338,0 3415,1 3470,0 3540,1 3547,0 3564,1 3612,0 3686,1 3773,0 3861,1 3951,0 4005,1 4058,0 4078,1 4104,0 4118,1 4168,0 4223,1 4280,0 4369,1 4372,0 4444,1 4535,0 4546,1 4618,0 4655,1 4693,0 4760,1 4857,0 4924,1 4965,0 5008,1 5090,0 5166,1 5252,0 5286,1 5383,0 5404,1 5435,0 5463,1 5505,0 5532,1 5627,0 5700,1 5779,0 5830,1 5912,0 5914,1 5951,0 6019,1 6020,0 6109,1 6144,0 6176,1 6251,0 6329,1 6392,0 6484,1 6518,0 6577,1 6661,0 6705,1 6716,0 6767,1 6811,0 6889,1 6957,0 6975,1 7021,0 7112,1 7167,0 7246,1 7346,0 7431,1 7502,0 7525,1 7622,0 7637,1 7716,0 7815,1 7907,0 7957,1 7981,0 8010,1 8094,0 8175,1 8261,0 8291,1 8328,0 8400,1 8456,0 8479,1 8560,0 8655,1 8661,0 8681,1 8753,0 8810,1 8874,0 8901,1 8953,0 8997,1 9078,0 9099,1 9191,0 9258,1 9297,0 9320,1 9378,0 9444,1 9524,0 9595,1 9665,0 9721,1 9771,0 9793,1 9874,0 9924,1 9959,0 9969,1 10038,0 10127,1 10185,0 10206,1 10246,0 10295,1 10355,0 10381,1 10416,0 10487,1 10508,0 10521,1 10585,0 10616,1 10619,0 10640,1 10688,0 10732,1 10742,0 10839,1 10897,0 10928,1 10980,0 11034,1 11095,0 11111,1 11158,0 11249,1 11342,0 11402,1 11452,0 11527,1 11542,0 11621,1 11721,0 11756,1 11760,0 11801,1 11809,0 11815,1 11890,0 11905,1 11976,0 11994,1 12022,0 12092,1 12114,0 12152,1 12222,0 12282,1 12355,0 12433,1 12519,0 12596,1 12671,0 12747,1 12762,0 12844,1 12866,0 12925,1 12931,0 12985,1 13075,0 13161,1 13245,0 13301,1 13378,0 13406,1 13465,0 13501,1 13567,0 13631,1 13653,0 13719,1 end initlist b70 0,0 91,1 102,0 171,1 259,0 317,1 403,0 474,1 522,0 535,1 558,0 626,1 628,0 689,1 736,0 743,1 826,0 834,1 865,0 934,1 993,0 1017,1 1077,0 1089,1 1184,0 1263,1 1279,0 1313,1 1405,0 1447,1 1492,0 1549,1 1621,0 1688,1 1739,0 1809,1 1818,0 1879,1 1967,0 2008,1 2010,0 2104,1 2173,0 2239,1 2314,0 2335,1 2371,0 2448,1 2509,0 2586,1 2640,0 2704,1 2716,0 2747,1 2788,0 2865,1 2870,0 2938,1 2958,0 3024,1 3123,0 3151,1 3194,0 3294,1 3327,0 3361,1 3397,0 3476,1 3520,0 3585,1 3662,0 3737,1 3787,0 3859,1 3948,0 4026,1 4125,0 4170,1 4189,0 4197,1 4213,0 4268,1 4343,0 4368,1 4393,0 4459,1 4490,0 4500,1 4525,0 4614,1 4652,0 4743,1 4815,0 4840,1 4925,0 4967,1 5003,0 5015,1 5106,0 5125,1 5157,0 5180,1 5257,0 5288,1 5379,0 5459,1 5550,0 5639,1 5675,0 5701,1 5713,0 5804,1 5830,0 5887,1 5950,0 6036,1 6052,0 6091,1 6137,0 6190,1 6196,0 6283,1 6372,0 6392,1 6411,0 6450,1 6490,0 6585,1 6652,0 6670,1 6706,0 6732,1 6808,0 6811,1 6845,0 6899,1 6937,0 6977,1 6998,0 7023,1 7060,0 7062,1 7138,0 7148,1 7236,0 7258,1 7298,0 7383,1 7449,0 7523,1 7552,0 7566,1 7590,0 7662,1 7740,0 7777,1 7832,0 7852,1 7871,0 7963,1 8049,0 8123,1 8216,0 8298,1 8338,0 8396,1 8432,0 8448,1 8458,0 8496,1 8499,0 8560,1 8607,0 8651,1 8659,0 8685,1 8704,0 8779,1 8852,0 8932,1 8992,0 9064,1 9151,0 9217,1 9292,0 9377,1 9413,0 9488,1 9587,0 9655,1 9740,0 9840,1 9922,0 10012,1 10084,0 10171,1 10205,0 10258,1 10327,0 10366,1 10407,0 10447,1 10536,0 10563,1 10575,0 10627,1 10630,0 10714,1 10800,0 10879,1 10952,0 10994,1 11035,0 11082,1 11170,0 11209,1 11210,0 11215,1 11299,0 11313,1 11324,0 11404,1 11463,0 11555,1 11634,0 11685,1 11686,0 11705,1 11766,0 11842,1 11913,0 11940,1 11977,0 12043,1 12092,0 12158,1 12214,0 12222,1 12224,0 12233,1 12333,0 12355,1 12413,0 12459,1 12505,0 12589,1 12664,0 12729,1 12824,0 12889,1 12948,0 13015,1 13032,0 13100,1 13145,0 13172,1 13207,0 13273,1 end initlist b71 0,0 29,1 63,0 118,1 214,0 240,1 313,0 358,1 454,0 508,1 607,0 672,1 699,0 706,1 732,0 762,1 858,0 878,1 921,0 992,1 1048,0 1099,1 1107,0 1152,1 1161,0 1238,1 1320,0 1392,1 1407,0 1441,1 1521,0 1602,1 1632,0 1706,1 1763,0 1836,1 1846,0 1887,1 1977,0 2057,1 2106,0 2124,1 2163,0 2205,1 2280,0 2374,1 2452,0 2540,1 2542,0 2601,1 2631,0 2636,1 2702,0 2775,1 2830,0 2883,1 2936,0 2992,1 3019,0 3027,1 3032,0 3072,1 3167,0 3232,1 3276,0 3326,1 3338,0 3430,1 3467,0 3542,1 3548,0 3596,1 3680,0 3707,1 3708,0 3774,1 3854,0 3934,1 3994,0 4024,1 4071,0 4090,1 4188,0 4276,1 4328,0 4344,1 4429,0 4514,1 4602,0 4670,1 4770,0 4796,1 4883,0 4894,1 4978,0 5003,1 5059,0 5089,1 5125,0 5172,1 5270,0 5323,1 5409,0 5449,1 5525,0 5542,1 5620,0 5639,1 5644,0 5736,1 5791,0 5818,1 5902,0 5992,1 6080,0 6135,1 6147,0 6202,1 6298,0 6307,1 6400,0 6460,1 6477,0 6546,1 6562,0 6633,1 6669,0 6737,1 6783,0 6881,1 6923,0 6999,1 7048,0 7067,1 7088,0 7112,1 7128,0 7186,1 7187,0 7214,1 7240,0 7332,1 7416,0 7474,1 7498,0 7513,1 7525,0 7616,1 7710,0 7715,1 7742,0 7802,1 7888,0 7889,1 7914,0 7951,1 7981,0 8021,1 8116,0 8206,1 8247,0 8272,1 8339,0 8357,1 8450,0 8537,1 8573,0 8667,1 8750,0 8821,1 8892,0 8951,1 9011,0 9018,1 9071,0 9140,1 9236,0 9299,1 9389,0 9463,1 9472,0 9560,1 9576,0 9664,1 9743,0 9840,1 9934,0 10023,1 10117,0 10199,1 10225,0 10313,1 10392,0 10435,1 10487,0 10586,1 10634,0 10664,1 10741,0 10769,1 10812,0 10866,1 10939,0 10981,1 10986,0 10992,1 11021,0 11073,1 11159,0 11162,1 11210,0 11249,1 11251,0 11306,1 11372,0 11405,1 11485,0 11514,1 11549,0 11633,1 11727,0 11758,1 11821,0 11836,1 11923,0 11969,1 11997,0 12083,1 12181,0 12235,1 12244,0 12248,1 12267,0 12317,1 12373,0 12413,1 12443,0 12530,1 12627,0 12719,1 12740,0 12788,1 12824,0 12833,1 12887,0 12922,1 12973,0 13067,1 13163,0 13231,1 13325,0 13331,1 13420,0 13465,1 13508,0 13546,1 13572,0 13645,1 end initlist b72 0,0 25,1 47,0 138,1 159,0 249,1 265,0 351,1 366,0 377,1 419,0 489,1 505,0 557,1 594,0 623,1 721,0 728,1 796,0 833,1 873,0 886,1 899,0 983,1 987,0 1066,1 1097,0 1111,1 1155,0 1171,1 1196,0 1235,1 1273,0 1351,1 1382,0 1409,1 1470,0 1534,1 1590,0 1631,1 1657,0 1754,1 1774,0 1855,1 1923,0 1999,1 2033,0 2074,1 2125,0 2132,1 2227,0 2323,1 2414,0 2430,1 2485,0 2584,1 2641,0 2691,1 2775,0 2819,1 2887,0 2938,1 2982,0 3046,1 3075,0 3153,1 3161,0 3256,1 3279,0 3304,1 3397,0 3489,1 3588,0 3665,1 3754,0 3850,1 3870,0 3916,1 3998,0 4079,1 4101,0 4140,1 4169,0 4269,1 4281,0 4365,1 4376,0 4469,1 4471,0 4525,1 4548,0 4552,1 4571,0 4577,1 4667,0 4729,1 4783,0 4879,1 4944,0 5035,1 5053,0 5057,1 5074,0 5103,1 5145,0 5240,1 5280,0 5315,1 5368,0 5391,1 5451,0 5539,1 5557,0 5589,1 5602,0 5603,1 5637,0 5732,1 5818,0 5828,1 5895,0 5917,1 5942,0 5991,1 6022,0 6028,1 6044,0 6143,1 6209,0 6276,1 6358,0 6447,1 6451,0 6473,1 6557,0 6569,1 6582,0 6649,1 6730,0 6755,1 6757,0 6838,1 6908,0 6934,1 6961,0 7040,1 7094,0 7163,1 7236,0 7296,1 7316,0 7352,1 7415,0 7417,1 7516,0 7593,1 7609,0 7686,1 7692,0 7736,1 7760,0 7806,1 7905,0 7907,1 7966,0 8033,1 8054,0 8087,1 8106,0 8120,1 8163,0 8231,1 8244,0 8256,1 8306,0 8337,1 8402,0 8491,1 8558,0 8601,1 8614,0 8672,1 8756,0 8797,1 8870,0 8934,1 9027,0 9051,1 9094,0 9183,1 9224,0 9255,1 9294,0 9308,1 9323,0 9405,1 9408,0 9450,1 9485,0 9493,1 9515,0 9519,1 9615,0 9638,1 9691,0 9758,1 9764,0 9810,1 9843,0 9845,1 9887,0 9932,1 9999,0 10059,1 10077,0 10149,1 10218,0 10254,1 10291,0 10379,1 10470,0 10531,1 10538,0 10560,1 10615,0 10685,1 10725,0 10741,1 10837,0 10869,1 10950,0 10985,1 11065,0 11106,1 11136,0 11170,1 11189,0 11274,1 11286,0 11371,1 11405,0 11427,1 11512,0 11531,1 11577,0 11579,1 11619,0 11666,1 11672,0 11683,1 11757,0 11786,1 11817,0 11881,1 11884,0 11930,1 11945,0 12005,1 end initlist b73 0,0 33,1 96,0 192,1 234,0 268,1 351,0 446,1 505,0 553,1 624,0 634,1 678,0 711,1 805,0 903,1 912,0 994,1 1026,0 1125,1 1176,0 1273,1 1366,0 1397,1 1486,0 1511,1 1517,0 1608,1 1706,0 1795,1 1829,0 1888,1 1988,0 2001,1 2087,0 2178,1 2236,0 2257,1 2303,0 2305,1 2370,0 2396,1 2415,0 2507,1 2514,0 2530,1 2569,0 2640,1 2732,0 2778,1 2872,0 2932,1 2952,0 3037,1 3130,0 3196,1 3285,0 3338,1 3426,0 3470,1 3529,0 3557,1 3586,0 3596,1 3635,0 3683,1 3705,0 3787,1 3861,0 3919,1 3953,0 4016,1 4106,0 4183,1 4260,0 4284,1 4377,0 4471,1 4560,0 4568,1 4606,0 4689,1 4734,0 4811,1 4886,0 4903,1 4969,0 4985,1 5076,0 5126,1 5129,0 5206,1 5288,0 5363,1 5459,0 5554,1 5557,0 5565,1 5616,0 5672,1 5715,0 5756,1 5778,0 5873,1 5957,0 6043,1 6055,0 6138,1 6175,0 6242,1 6264,0 6297,1 6343,0 6378,1 6441,0 6482,1 6573,0 6628,1 6688,0 6735,1 6789,0 6813,1 6866,0 6956,1 7032,0 7087,1 7091,0 7138,1 7226,0 7244,1 7343,0 7437,1 7440,0 7488,1 7525,0 7537,1 7554,0 7612,1 7627,0 7673,1 7751,0 7850,1 7886,0 7984,1 8080,0 8128,1 8162,0 8249,1 8251,0 8338,1 8427,0 8515,1 8579,0 8596,1 8674,0 8745,1 8775,0 8868,1 8875,0 8921,1 8960,0 9010,1 9054,0 9134,1 9145,0 9241,1 9249,0 9250,1 9284,0 9302,1 9314,0 9388,1 9422,0 9505,1 9583,0 9598,1 9613,0 9631,1 9675,0 9692,1 9789,0 9868,1 9933,0 9934,1 9987,0 10003,1 10086,0 10185,1 10206,0 10234,1 10332,0 10375,1 10443,0 10476,1 10530,0 10570,1 10633,0 10636,1 10683,0 10781,1 10789,0 10830,1 10915,0 10963,1 10971,0 11000,1 11074,0 11162,1 11178,0 11236,1 11275,0 11353,1 11365,0 11429,1 11514,0 11596,1 11647,0 11742,1 11744,0 11772,1 11850,0 11932,1 12001,0 12019,1 12079,0 12174,1 12201,0 12280,1 12301,0 12312,1 12314,0 12334,1 12381,0 12410,1 12455,0 12465,1 12544,0 12560,1 12643,0 12650,1 12684,0 12729,1 12824,0 12891,1 12958,0 12961,1 12972,0 12992,1 13004,0 13055,1 13103,0 13203,1 13266,0 13282,1 13313,0 13335,1 13356,0 13376,1 end initlist b74 0,0 66,1 127,0 150,1 159,0 190,1 271,0 274,1 286,0 293,1 353,0 377,1 442,0 488,1 544,0 590,1 678,0 746,1 835,0 935,1 1024,0 1030,1 1126,0 1191,1 1270,0 1352,1 1384,0 1483,1 1512,0 1560,1 1621,0 1639,1 1688,0 1739,1 1809,0 1812,1 1829,0 1881,1 1947,0 1979,1 1983,0 2006,1 2055,0 2083,1 2168,0 2238,1 2312,0 2401,1 2479,0 2531,1 2579,0 2621,1 2645,0 2705,1 2744,0 2792,1 2818,0 2886,1 2923,0 2939,1 2999,0 3030,1 3080,0 3127,1 3208,0 3263,1 3286,0 3376,1 3455,0 3476,1 3570,0 3626,1 3704,0 3729,1 3766,0 3784,1 3817,0 3910,1 3940,0 3995,1 4046,0 4051,1 4139,0 4239,1 4274,0 4348,1 4362,0 4424,1 4515,0 4574,1 4592,0 4641,1 4662,0 4706,1 4726,0 4735,1 4757,0 4801,1 4871,0 4891,1 4897,0 4970,1 5008,0 5087,1 5088,0 5101,1 5143,0 5234,1 5278,0 5371,1 5429,0 5519,1 5563,0 5661,1 5718,0 5784,1 5845,0 5879,1 5956,0 5963,1 5976,0 6036,1 6135,0 6182,1 6222,0 6294,1 6388,0 6394,1 6440,0 6471,1 6500,0 6529,1 6561,0 6660,1 6691,0 6693,1 6773,0 6828,1 6879,0 6946,1 7030,0 7106,1 7107,0 7174,1 7232,0 7262,1 7303,0 7348,1 7435,0 7475,1 7527,0 7569,1 7660,0 7686,1 7708,0 7747,1 7777,0 7873,1 7880,0 7920,1 8010,0 8024,1 8048,0 8101,1 8123,0 8210,1 8237,0 8329,1 8407,0 8449,1 8483,0 8513,1 8580,0 8588,1 8600,0 8666,1 8676,0 8730,1 8735,0 8741,1 8786,0 8821,1 8908,0 8933,1 9030,0 9060,1 9144,0 9153,1 9224,0 9263,1 9273,0 9319,1 9381,0 9443,1 9497,0 9510,1 9598,0 9694,1 9753,0 9805,1 9836,0 9877,1 9882,0 9980,1 10075,0 10100,1 10169,0 10191,1 10198,0 10280,1 10289,0 10334,1 10386,0 10460,1 10483,0 10557,1 10581,0 10655,1 10703,0 10730,1 10750,0 10761,1 10763,0 10778,1 10873,0 10962,1 11016,0 11027,1 11092,0 11185,1 11224,0 11268,1 11310,0 11327,1 11422,0 11506,1 11569,0 11652,1 11701,0 11789,1 11878,0 11972,1 12002,0 12091,1 12125,0 12225,1 12269,0 12283,1 12309,0 12380,1 12460,0 12555,1 12579,0 12601,1 12657,0 12713,1 12813,0 12889,1 end initlist b75 0,0 8,1 105,0 195,1 220,0 280,1 291,0 367,1 412,0 485,1 563,0 654,1 656,0 665,1 723,0 729,1 759,0 823,1 914,0 991,1 1061,0 1101,1 1144,0 1232,1 1291,0 1360,1 1400,0 1476,1 1485,0 1558,1 1609,0 1678,1 1756,0 1789,1 1854,0 1889,1 1946,0 1993,1 2050,0 2074,1 2158,0 2230,1 2255,0 2270,1 2299,0 2328,1 2340,0 2404,1 2489,0 2514,1 2590,0 2649,1 2718,0 2770,1 2849,0 2943,1 3043,0 3117,1 3143,0 3208,1 3229,0 3253,1 3297,0 3383,1 3465,0 3491,1 3502,0 3556,1 3594,0 3689,1 3710,0 3789,1 3849,0 3917,1 3943,0 3945,1 3950,0 4014,1 4034,0 4037,1 4118,0 4151,1 4234,0 4249,1 4337,0 4368,1 4398,0 4422,1 4520,0 4567,1 4585,0 4652,1 4662,0 4687,1 4709,0 4784,1 4834,0 4920,1 4934,0 5017,1 5053,0 5122,1 5132,0 5207,1 5303,0 5369,1 5398,0 5437,1 5495,0 5552,1 5609,0 5652,1 5707,0 5802,1 5849,0 5934,1 6022,0 6098,1 6147,0 6192,1 6204,0 6293,1 6348,0 6381,1 6476,0 6478,1 6518,0 6582,1 6596,0 6677,1 6767,0 6809,1 6813,0 6903,1 6932,0 6968,1 7018,0 7050,1 7102,0 7134,1 7219,0 7280,1 7376,0 7435,1 7445,0 7514,1 7599,0 7693,1 7709,0 7796,1 7802,0 7839,1 7925,0 8005,1 8089,0 8111,1 8138,0 8216,1 8239,0 8322,1 8372,0 8386,1 8450,0 8452,1 8464,0 8535,1 8604,0 8698,1 8712,0 8750,1 8834,0 8914,1 8984,0 9002,1 9098,0 9132,1 9218,0 9255,1 9276,0 9284,1 9312,0 9411,1 9455,0 9462,1 9527,0 9569,1 9667,0 9694,1 9716,0 9779,1 9802,0 9878,1 9888,0 9904,1 9921,0 9976,1 9988,0 10042,1 10127,0 10138,1 10146,0 10197,1 10222,0 10288,1 10379,0 10434,1 10509,0 10541,1 10547,0 10590,1 10599,0 10627,1 10677,0 10707,1 10767,0 10807,1 10849,0 10925,1 10964,0 11006,1 11105,0 11165,1 11220,0 11280,1 11311,0 11357,1 11403,0 11440,1 11507,0 11596,1 11639,0 11714,1 11751,0 11785,1 11793,0 11811,1 11869,0 11898,1 11977,0 12027,1 12052,0 12103,1 12203,0 12268,1 12310,0 12317,1 12377,0 12419,1 12501,0 12531,1 12630,0 12661,1 12750,0 12822,1 12897,0 12972,1 12974,0 12988,1 end initlist b76 0,0 1,1 64,0 72,1 87,0 139,1 237,0 286,1 381,0 434,1 524,0 566,1 660,0 691,1 786,0 846,1 909,0 919,1 961,0 974,1 985,0 1033,1 1051,0 1130,1 1177,0 1263,1 1293,0 1334,1 1367,0 1416,1 1515,0 1526,1 1539,0 1583,1 1599,0 1669,1 1754,0 1818,1 1902,0 1952,1 1993,0 1999,1 2009,0 2050,1 2067,0 2149,1 2184,0 2213,1 2277,0 2306,1 2388,0 2419,1 2515,0 2597,1 2630,0 2718,1 2755,0 2756,1 2811,0 2817,1 2844,0 2903,1 2956,0 3000,1 3080,0 3150,1 3195,0 3237,1 3325,0 3383,1 3390,0 3412,1 3499,0 3506,1 3555,0 3580,1 3593,0 3626,1 3702,0 3764,1 3782,0 3808,1 3835,0 3920,1 3949,0 4017,1 4040,0 4136,1 4168,0 4234,1 4280,0 4300,1 4342,0 4442,1 4503,0 4569,1 4619,0 4679,1 4694,0 4794,1 4816,0 4911,1 4965,0 5063,1 5127,0 5173,1 5228,0 5254,1 5285,0 5359,1 5375,0 5404,1 5497,0 5595,1 5632,0 5678,1 5683,0 5703,1 5786,0 5848,1 5918,0 5982,1 5989,0 6038,1 6050,0 6069,1 6074,0 6131,1 6187,0 6283,1 6352,0 6407,1 6467,0 6526,1 6604,0 6649,1 6739,0 6790,1 6805,0 6816,1 6869,0 6946,1 6968,0 7001,1 7047,0 7070,1 7091,0 7162,1 7240,0 7298,1 7393,0 7492,1 7540,0 7577,1 7669,0 7726,1 7814,0 7849,1 7892,0 7923,1 7938,0 8038,1 8080,0 8164,1 8229,0 8289,1 8304,0 8394,1 8423,0 8480,1 8557,0 8645,1 8706,0 8724,1 8807,0 8831,1 8855,0 8903,1 8955,0 8968,1 9042,0 9115,1 9166,0 9188,1 9206,0 9298,1 9384,0 9403,1 9497,0 9508,1 9517,0 9519,1 9577,0 9621,1 9707,0 9786,1 9791,0 9825,1 9840,0 9910,1 9934,0 9944,1 10040,0 10044,1 10143,0 10190,1 10279,0 10357,1 10388,0 10469,1 10478,0 10557,1 10572,0 10597,1 10598,0 10641,1 10694,0 10759,1 10780,0 10838,1 10863,0 10865,1 10945,0 10986,1 11034,0 11116,1 11162,0 11231,1 11241,0 11339,1 11375,0 11395,1 11406,0 11464,1 11509,0 11586,1 11590,0 11680,1 11767,0 11861,1 11878,0 11900,1 11909,0 11991,1 12018,0 12034,1 12039,0 12069,1 12108,0 12200,1 12203,0 12240,1 12262,0 12317,1 12353,0 12429,1 12469,0 12516,1 end initlist b77 0,0 51,1 121,0 149,1 153,0 202,1 276,0 284,1 346,0 399,1 411,0 459,1 558,0 616,1 678,0 697,1 793,0 850,1 892,0 949,1 1038,0 1043,1 1049,0 1101,1 1145,0 1209,1 1271,0 1357,1 1444,0 1510,1 1597,0 1635,1 1710,0 1762,1 1771,0 1803,1 1850,0 1857,1 1879,0 1968,1 1976,0 1980,1 2037,0 2072,1 2100,0 2172,1 2214,0 2252,1 2279,0 2372,1 2468,0 2545,1 2553,0 2555,1 2580,0 2643,1 2700,0 2725,1 2778,0 2852,1 2865,0 2950,1 2987,0 3068,1 3166,0 3240,1 3305,0 3325,1 3400,0 3427,1 3494,0 3519,1 3561,0 3620,1 3662,0 3669,1 3737,0 3809,1 3826,0 3887,1 3896,0 3956,1 4000,0 4100,1 4161,0 4220,1 4298,0 4313,1 4354,0 4444,1 4462,0 4494,1 4547,0 4640,1 4643,0 4672,1 4728,0 4751,1 4841,0 4906,1 4955,0 4989,1 5031,0 5053,1 5139,0 5186,1 5244,0 5261,1 5360,0 5385,1 5446,0 5463,1 5488,0 5546,1 5645,0 5712,1 5749,0 5845,1 5923,0 5958,1 6030,0 6074,1 6166,0 6177,1 6266,0 6306,1 6352,0 6445,1 6526,0 6620,1 6675,0 6733,1 6741,0 6761,1 6791,0 6802,1 6894,0 6965,1 6984,0 6988,1 6993,0 7000,1 7071,0 7156,1 7216,0 7243,1 7331,0 7397,1 7439,0 7463,1 7543,0 7565,1 7632,0 7720,1 7810,0 7831,1 7836,0 7868,1 7943,0 7986,1 8085,0 8130,1 8195,0 8198,1 8278,0 8342,1 8382,0 8434,1 8517,0 8611,1 8674,0 8703,1 8705,0 8760,1 8784,0 8812,1 8868,0 8885,1 8936,0 8952,1 9028,0 9094,1 9169,0 9235,1 9283,0 9356,1 9370,0 9435,1 9498,0 9551,1 9600,0 9668,1 9679,0 9750,1 9850,0 9859,1 9866,0 9929,1 10013,0 10087,1 10104,0 10134,1 10170,0 10200,1 10235,0 10288,1 10385,0 10473,1 10543,0 10625,1 10706,0 10780,1 10829,0 10842,1 10858,0 10898,1 10971,0 11045,1 11125,0 11137,1 11218,0 11240,1 11318,0 11344,1 11427,0 11464,1 11493,0 11518,1 11525,0 11558,1 11574,0 11610,1 11651,0 11665,1 11680,0 11700,1 11784,0 11875,1 11877,0 11973,1 12044,0 12105,1 12185,0 12199,1 12270,0 12344,1 12369,0 12395,1 12473,0 12537,1 12540,0 12591,1 12627,0 12684,1 12747,0 12778,1 12793,0 12808,1 end initlist b78 0,0 51,1 127,0 174,1 188,0 259,1 290,0 367,1 456,0 476,1 488,0 527,1 566,0 663,1 716,0 757,1 848,0 892,1 925,0 988,1 1044,0 1076,1 1092,0 1159,1 1183,0 1269,1 1353,0 1421,1 1514,0 1545,1 1577,0 1606,1 1690,0 1695,1 1742,0 1810,1 1854,0 1913,1 2009,0 2101,1 2159,0 2212,1 2302,0 2390,1 2405,0 2408,1 2433,0 2441,1 2539,0 2600,1 2621,0 2677,1 2719,0 2808,1 2854,0 2875,1 2930,0 3015,1 3016,0 3031,1 3124,0 3131,1 3165,0 3190,1 3218,0 3227,1 3287,0 3294,1 3337,0 3408,1 3484,0 3584,1 3646,0 3679,1 3680,0 3747,1 3811,0 3813,1 3912,0 4003,1 4025,0 4075,1 4138,0 4143,1 4239,0 4257,1 4357,0 4416,1 4445,0 4516,1 4605,0 4648,1 4662,0 4749,1 4763,0 4823,1 4923,0 4990,1 4992,0 5070,1 5133,0 5159,1 5254,0 5298,1 5321,0 5385,1 5480,0 5507,1 5521,0 5559,1 5620,0 5697,1 5719,0 5724,1 5728,0 5817,1 5879,0 5917,1 5973,0 5983,1 6019,0 6084,1 6112,0 6124,1 6197,0 6242,1 6309,0 6310,1 6393,0 6398,1 6447,0 6493,1 6537,0 6577,1 6649,0 6670,1 6673,0 6760,1 6849,0 6917,1 6984,0 6985,1 7026,0 7030,1 7046,0 7130,1 7173,0 7206,1 7210,0 7232,1 7325,0 7362,1 7439,0 7513,1 7534,0 7568,1 7631,0 7671,1 7727,0 7816,1 7831,0 7910,1 7947,0 8010,1 8054,0 8090,1 8138,0 8214,1 8256,0 8328,1 8404,0 8483,1 8536,0 8551,1 8618,0 8699,1 8700,0 8793,1 8888,0 8899,1 8922,0 8956,1 9000,0 9081,1 9129,0 9223,1 9232,0 9302,1 9368,0 9428,1 9521,0 9604,1 9621,0 9625,1 9657,0 9751,1 9820,0 9890,1 9954,0 9999,1 10003,0 10098,1 10152,0 10205,1 10223,0 10322,1 10414,0 10424,1 10524,0 10554,1 10632,0 10703,1 10729,0 10826,1 10843,0 10896,1 10962,0 10990,1 11009,0 11025,1 11048,0 11110,1 11128,0 11152,1 11231,0 11295,1 11337,0 11347,1 11426,0 11428,1 11469,0 11535,1 11633,0 11680,1 11692,0 11700,1 11781,0 11831,1 11864,0 11917,1 12015,0 12032,1 12103,0 12142,1 12211,0 12250,1 12293,0 12330,1 12428,0 12483,1 12581,0 12604,1 12703,0 12754,1 12767,0 12829,1 12883,0 12920,1 end initlist b79 0,0 37,1 105,0 198,1 278,0 297,1 334,0 354,1 392,0 417,1 493,0 519,1 606,0 683,1 774,0 781,1 866,0 962,1 1017,0 1067,1 1139,0 1152,1 1203,0 1230,1 1250,0 1335,1 1356,0 1359,1 1418,0 1432,1 1443,0 1446,1 1545,0 1547,1 1601,0 1673,1 1750,0 1840,1 1885,0 1944,1 1976,0 1982,1 1991,0 2049,1 2063,0 2069,1 2100,0 2109,1 2168,0 2235,1 2309,0 2387,1 2433,0 2467,1 2489,0 2498,1 2579,0 2641,1 2707,0 2807,1 2862,0 2918,1 2993,0 3049,1 3101,0 3201,1 3221,0 3321,1 3350,0 3446,1 3482,0 3506,1 3570,0 3644,1 3687,0 3776,1 3830,0 3909,1 3919,0 3956,1 4047,0 4116,1 4125,0 4219,1 4260,0 4325,1 4333,0 4420,1 4484,0 4524,1 4608,0 4693,1 4753,0 4766,1 4855,0 4873,1 4900,0 4972,1 5052,0 5091,1 5124,0 5143,1 5211,0 5255,1 5261,0 5342,1 5426,0 5431,1 5527,0 5573,1 5616,0 5648,1 5737,0 5740,1 5778,0 5845,1 5877,0 5963,1 6000,0 6084,1 6174,0 6212,1 6272,0 6320,1 6415,0 6499,1 6534,0 6626,1 6628,0 6675,1 6677,0 6770,1 6820,0 6854,1 6946,0 7026,1 7032,0 7070,1 7121,0 7171,1 7184,0 7191,1 7256,0 7289,1 7388,0 7445,1 7492,0 7526,1 7613,0 7656,1 7658,0 7709,1 7711,0 7800,1 7804,0 7898,1 7923,0 7983,1 8061,0 8117,1 8124,0 8206,1 8263,0 8295,1 8354,0 8413,1 8434,0 8446,1 8516,0 8533,1 8570,0 8657,1 8751,0 8759,1 8784,0 8839,1 8924,0 8970,1 9010,0 9036,1 9081,0 9097,1 9162,0 9167,1 9224,0 9252,1 9317,0 9380,1 9431,0 9471,1 9543,0 9583,1 9625,0 9639,1 9701,0 9734,1 9754,0 9820,1 9850,0 9893,1 9923,0 9975,1 10014,0 10105,1 10155,0 10244,1 10311,0 10396,1 10450,0 10529,1 10621,0 10657,1 10680,0 10758,1 10771,0 10779,1 10813,0 10839,1 10874,0 10970,1 11051,0 11082,1 11171,0 11239,1 11314,0 11371,1 11460,0 11545,1 11633,0 11716,1 11758,0 11830,1 11877,0 11880,1 11972,0 11981,1 12012,0 12062,1 12126,0 12203,1 12290,0 12382,1 12441,0 12509,1 12516,0 12585,1 12620,0 12669,1 12765,0 12865,1 12951,0 12962,1 13021,0 13120,1 13133,0 13137,1 13199,0 13284,1 end initlist b80 0,0 59,1 159,0 198,1 262,0 304,1 391,0 393,1 420,0 499,1 548,0 559,1 651,0 697,1 757,0 767,1 776,0 808,1 840,0 905,1 963,0 1002,1 1063,0 1132,1 1189,0 1192,1 1210,0 1288,1 1291,0 1352,1 1405,0 1445,1 1523,0 1525,1 1620,0 1665,1 1717,0 1794,1 1819,0 1841,1 1857,0 1902,1 1949,0 2046,1 2107,0 2175,1 2220,0 2290,1 2363,0 2422,1 2438,0 2487,1 2517,0 2617,1 2654,0 2733,1 2763,0 2816,1 2857,0 2891,1 2959,0 3031,1 3099,0 3144,1 3197,0 3207,1 3287,0 3340,1 3341,0 3436,1 3492,0 3583,1 3618,0 3700,1 3753,0 3851,1 3919,0 4002,1 4054,0 4115,1 4211,0 4303,1 4313,0 4335,1 4386,0 4427,1 4515,0 4517,1 4560,0 4604,1 4697,0 4777,1 4835,0 4853,1 4872,0 4875,1 4925,0 4972,1 4987,0 5013,1 5112,0 5165,1 5192,0 5292,1 5320,0 5350,1 5450,0 5466,1 5485,0 5536,1 5561,0 5602,1 5692,0 5715,1 5719,0 5783,1 5843,0 5889,1 5988,0 6061,1 6122,0 6147,1 6188,0 6203,1 6289,0 6371,1 6435,0 6479,1 6491,0 6548,1 6623,0 6706,1 6750,0 6825,1 6862,0 6944,1 6972,0 7005,1 7097,0 7099,1 7116,0 7173,1 7243,0 7249,1 7258,0 7290,1 7324,0 7340,1 7387,0 7401,1 7423,0 7437,1 7517,0 7590,1 7624,0 7694,1 7703,0 7764,1 7837,0 7932,1 7942,0 7972,1 8054,0 8150,1 8177,0 8257,1 8329,0 8414,1 8446,0 8468,1 8536,0 8570,1 8643,0 8699,1 8788,0 8850,1 8923,0 8944,1 8953,0 9045,1 9097,0 9124,1 9196,0 9204,1 9296,0 9315,1 9336,0 9373,1 9446,0 9483,1 9554,0 9642,1 9713,0 9774,1 9819,0 9912,1 9979,0 10028,1 10093,0 10120,1 10201,0 10250,1 10350,0 10405,1 10492,0 10525,1 10557,0 10594,1 10602,0 10676,1 10758,0 10789,1 10829,0 10910,1 10969,0 10971,1 11067,0 11136,1 11163,0 11250,1 11295,0 11367,1 11391,0 11440,1 11489,0 11558,1 11624,0 11639,1 11683,0 11761,1 11777,0 11870,1 11873,0 11925,1 11978,0 12016,1 12063,0 12156,1 12192,0 12195,1 12256,0 12348,1 12353,0 12378,1 12395,0 12412,1 12431,0 12492,1 12576,0 12634,1 12659,0 12692,1 12776,0 12844,1 12884,0 12895,1 12988,0 13005,1 end initlist b81 0,0 62,1 140,0 236,1 290,0 335,1 347,0 408,1 472,0 551,1 560,0 649,1 708,0 807,1 850,0 888,1 940,0 961,1 1038,0 1051,1 1066,0 1154,1 1185,0 1255,1 1352,0 1409,1 1494,0 1504,1 1557,0 1581,1 1673,0 1739,1 1816,0 1858,1 1948,0 1958,1 1985,0 1988,1 2069,0 2139,1 2197,0 2283,1 2379,0 2455,1 2463,0 2493,1 2506,0 2517,1 2572,0 2620,1 2659,0 2755,1 2853,0 2924,1 3000,0 3099,1 3154,0 3216,1 3266,0 3268,1 3305,0 3344,1 3355,0 3412,1 3416,0 3420,1 3495,0 3566,1 3574,0 3580,1 3638,0 3653,1 3692,0 3722,1 3762,0 3805,1 3808,0 3839,1 3896,0 3948,1 4033,0 4128,1 4211,0 4280,1 4364,0 4415,1 4425,0 4513,1 4553,0 4601,1 4620,0 4622,1 4708,0 4734,1 4795,0 4840,1 4903,0 4995,1 5043,0 5059,1 5105,0 5143,1 5153,0 5182,1 5239,0 5321,1 5346,0 5403,1 5477,0 5544,1 5564,0 5597,1 5651,0 5726,1 5776,0 5867,1 5930,0 6030,1 6033,0 6094,1 6104,0 6170,1 6172,0 6219,1 6286,0 6313,1 6338,0 6391,1 6439,0 6503,1 6504,0 6542,1 6595,0 6669,1 6704,0 6793,1 6885,0 6909,1 6985,0 7030,1 7128,0 7188,1 7197,0 7252,1 7329,0 7374,1 7398,0 7474,1 7490,0 7514,1 7606,0 7616,1 7690,0 7728,1 7781,0 7881,1 7900,0 7969,1 8015,0 8071,1 8139,0 8166,1 8204,0 8296,1 8387,0 8458,1 8482,0 8547,1 8584,0 8599,1 8675,0 8709,1 8719,0 8788,1 8841,0 8885,1 8897,0 8939,1 9037,0 9062,1 9115,0 9128,1 9185,0 9228,1 9269,0 9349,1 9388,0 9405,1 9491,0 9543,1 9582,0 9669,1 9687,0 9771,1 9789,0 9853,1 9869,0 9945,1 9958,0 10033,1 10096,0 10186,1 10235,0 10297,1 10327,0 10426,1 10441,0 10515,1 10558,0 10611,1 10669,0 10703,1 10705,0 10729,1 10733,0 10804,1 10854,0 10930,1 11028,0 11038,1 11115,0 11206,1 11266,0 11347,1 11366,0 11405,1 11460,0 11491,1 11574,0 11585,1 11647,0 11659,1 11742,0 11765,1 11824,0 11825,1 11843,0 11940,1 12034,0 12088,1 12110,0 12183,1 12236,0 12264,1 12276,0 12346,1 12360,0 12435,1 12474,0 12535,1 12580,0 12627,1 12725,0 12797,1 12811,0 12840,1 12884,0 12906,1 end initlist b82 0,0 19,1 100,0 200,1 264,0 296,1 365,0 459,1 489,0 568,1 618,0 656,1 726,0 815,1 867,0 924,1 930,0 1026,1 1105,0 1114,1 1155,0 1255,1 1262,0 1275,1 1315,0 1382,1 1426,0 1523,1 1581,0 1608,1 1675,0 1684,1 1756,0 1851,1 1891,0 1949,1 2013,0 2101,1 2132,0 2153,1 2185,0 2262,1 2300,0 2356,1 2452,0 2502,1 2575,0 2634,1 2679,0 2722,1 2768,0 2836,1 2865,0 2889,1 2972,0 3012,1 3031,0 3092,1 3191,0 3278,1 3283,0 3328,1 3401,0 3459,1 3495,0 3539,1 3585,0 3680,1 3745,0 3841,1 3913,0 3952,1 4011,0 4082,1 4182,0 4226,1 4282,0 4364,1 4438,0 4468,1 4564,0 4664,1 4764,0 4794,1 4887,0 4921,1 5020,0 5064,1 5148,0 5213,1 5231,0 5318,1 5350,0 5356,1 5358,0 5361,1 5386,0 5410,1 5437,0 5483,1 5582,0 5633,1 5649,0 5741,1 5753,0 5850,1 5914,0 5938,1 5996,0 6047,1 6090,0 6107,1 6196,0 6212,1 6286,0 6329,1 6346,0 6394,1 6441,0 6473,1 6547,0 6579,1 6655,0 6690,1 6691,0 6729,1 6754,0 6821,1 6916,0 6928,1 6965,0 6985,1 7043,0 7139,1 7142,0 7240,1 7309,0 7357,1 7362,0 7370,1 7452,0 7489,1 7494,0 7498,1 7528,0 7628,1 7717,0 7766,1 7781,0 7846,1 7895,0 7915,1 7929,0 8025,1 8102,0 8118,1 8169,0 8197,1 8212,0 8285,1 8359,0 8441,1 8535,0 8603,1 8635,0 8704,1 8725,0 8772,1 8822,0 8857,1 8874,0 8960,1 8976,0 9054,1 9150,0 9220,1 9248,0 9269,1 9286,0 9372,1 9397,0 9421,1 9512,0 9595,1 9633,0 9712,1 9765,0 9836,1 9875,0 9891,1 9912,0 9956,1 9974,0 10064,1 10131,0 10212,1 10288,0 10340,1 10381,0 10459,1 10480,0 10483,1 10535,0 10543,1 10561,0 10641,1 10706,0 10788,1 10867,0 10905,1 10917,0 10960,1 11017,0 11101,1 11181,0 11192,1 11267,0 11364,1 11412,0 11431,1 11471,0 11537,1 11543,0 11591,1 11611,0 11622,1 11694,0 11762,1 11805,0 11840,1 11857,0 11924,1 11983,0 12063,1 12129,0 12139,1 12200,0 12206,1 12247,0 12308,1 12332,0 12342,1 12417,0 12446,1 12470,0 12527,1 12619,0 12711,1 12735,0 12833,1 12883,0 12932,1 12982,0 13034,1 13097,0 13143,1 13178,0 13258,1 end initlist b83 0,0 21,1 90,0 122,1 210,0 304,1 378,0 436,1 514,0 560,1 602,0 611,1 643,0 669,1 745,0 791,1 828,0 830,1 925,0 949,1 1012,0 1067,1 1157,0 1239,1 1241,0 1252,1 1290,0 1338,1 1366,0 1461,1 1559,0 1627,1 1725,0 1796,1 1854,0 1866,1 1919,0 1993,1 2006,0 2105,1 2133,0 2169,1 2201,0 2281,1 2365,0 2429,1 2443,0 2507,1 2583,0 2634,1 2702,0 2716,1 2751,0 2765,1 2831,0 2911,1 2990,0 2999,1 3037,0 3102,1 3120,0 3202,1 3260,0 3334,1 3362,0 3391,1 3457,0 3521,1 3549,0 3641,1 3720,0 3767,1 3834,0 3882,1 3940,0 3969,1 4011,0 4037,1 4117,0 4170,1 4265,0 4355,1 4397,0 4425,1 4464,0 4494,1 4571,0 4630,1 4652,0 4752,1 4832,0 4840,1 4916,0 4917,1 4956,0 4977,1 5036,0 5097,1 5196,0 5281,1 5374,0 5432,1 5527,0 5559,1 5612,0 5681,1 5734,0 5760,1 5788,0 5857,1 5927,0 5991,1 5994,0 6078,1 6153,0 6243,1 6306,0 6377,1 6403,0 6454,1 6512,0 6525,1 6577,0 6667,1 6741,0 6775,1 6837,0 6906,1 6973,0 7024,1 7108,0 7129,1 7141,0 7241,1 7261,0 7302,1 7347,0 7397,1 7411,0 7468,1 7519,0 7540,1 7612,0 7680,1 7688,0 7732,1 7778,0 7850,1 7857,0 7884,1 7983,0 7996,1 8053,0 8085,1 8086,0 8107,1 8171,0 8211,1 8278,0 8285,1 8319,0 8390,1 8489,0 8549,1 8628,0 8698,1 8769,0 8770,1 8866,0 8868,1 8920,0 8929,1 8978,0 9009,1 9058,0 9059,1 9116,0 9131,1 9156,0 9196,1 9232,0 9249,1 9283,0 9340,1 9424,0 9448,1 9544,0 9643,1 9706,0 9712,1 9740,0 9746,1 9821,0 9916,1 9951,0 10005,1 10052,0 10117,1 10132,0 10204,1 10226,0 10288,1 10334,0 10420,1 10499,0 10550,1 10589,0 10628,1 10636,0 10678,1 10767,0 10824,1 10877,0 10906,1 10995,0 11026,1 11059,0 11111,1 11132,0 11197,1 11208,0 11264,1 11274,0 11304,1 11319,0 11342,1 11385,0 11386,1 11479,0 11575,1 11641,0 11671,1 11752,0 11827,1 11857,0 11867,1 11870,0 11949,1 11990,0 12055,1 12137,0 12198,1 12257,0 12320,1 12341,0 12388,1 12432,0 12437,1 12458,0 12498,1 12534,0 12594,1 12645,0 12703,1 12741,0 12814,1 12884,0 12940,1 end initlist b84 0,0 14,1 64,0 137,1 218,0 276,1 339,0 362,1 399,0 484,1 532,0 565,1 602,0 625,1 694,0 732,1 805,0 895,1 910,0 916,1 923,0 1016,1 1116,0 1174,1 1185,0 1240,1 1276,0 1365,1 1435,0 1446,1 1486,0 1579,1 1657,0 1698,1 1774,0 1783,1 1870,0 1890,1 1942,0 1998,1 2061,0 2136,1 2162,0 2222,1 2230,0 2241,1 2284,0 2323,1 2360,0 2424,1 2436,0 2511,1 2555,0 2634,1 2657,0 2726,1 2814,0 2816,1 2898,0 2971,1 3062,0 3085,1 3143,0 3157,1 3242,0 3257,1 3333,0 3397,1 3480,0 3507,1 3578,0 3664,1 3675,0 3752,1 3822,0 3869,1 3873,0 3874,1 3880,0 3922,1 3978,0 4030,1 4095,0 4106,1 4175,0 4189,1 4241,0 4249,1 4314,0 4393,1 4492,0 4538,1 4595,0 4627,1 4663,0 4703,1 4725,0 4729,1 4753,0 4807,1 4870,0 4928,1 4991,0 5052,1 5083,0 5140,1 5173,0 5180,1 5186,0 5231,1 5255,0 5318,1 5396,0 5473,1 5539,0 5623,1 5656,0 5695,1 5713,0 5722,1 5758,0 5768,1 5856,0 5878,1 5909,0 5943,1 5995,0 6055,1 6131,0 6198,1 6258,0 6303,1 6365,0 6386,1 6435,0 6533,1 6607,0 6649,1 6701,0 6743,1 6764,0 6843,1 6905,0 6991,1 7077,0 7112,1 7207,0 7243,1 7272,0 7350,1 7389,0 7428,1 7429,0 7438,1 7523,0 7565,1 7612,0 7700,1 7789,0 7792,1 7855,0 7904,1 7940,0 8028,1 8074,0 8164,1 8262,0 8279,1 8296,0 8336,1 8418,0 8488,1 8505,0 8510,1 8538,0 8576,1 8584,0 8609,1 8634,0 8662,1 8731,0 8755,1 8812,0 8892,1 8919,0 8926,1 8939,0 8986,1 9031,0 9070,1 9162,0 9168,1 9251,0 9256,1 9345,0 9385,1 9392,0 9406,1 9445,0 9490,1 9551,0 9603,1 9674,0 9686,1 9762,0 9784,1 9838,0 9842,1 9853,0 9897,1 9967,0 10063,1 10073,0 10095,1 10119,0 10138,1 10224,0 10240,1 10328,0 10353,1 10407,0 10409,1 10499,0 10531,1 10594,0 10614,1 10690,0 10706,1 10719,0 10748,1 10781,0 10823,1 10858,0 10888,1 10897,0 10961,1 10982,0 11001,1 11064,0 11076,1 11096,0 11173,1 11200,0 11270,1 11319,0 11406,1 11489,0 11560,1 11606,0 11654,1 11680,0 11767,1 11847,0 11883,1 11902,0 11995,1 12058,0 12107,1 end initlist b85 0,0 36,1 76,0 151,1 196,0 280,1 368,0 443,1 479,0 491,1 526,0 594,1 595,0 671,1 734,0 756,1 812,0 875,1 880,0 947,1 960,0 967,1 1059,0 1102,1 1165,0 1178,1 1192,0 1218,1 1301,0 1327,1 1359,0 1447,1 1493,0 1508,1 1524,0 1597,1 1637,0 1651,1 1745,0 1756,1 1794,0 1878,1 1945,0 1989,1 2083,0 2088,1 2112,0 2198,1 2224,0 2319,1 2389,0 2436,1 2453,0 2491,1 2538,0 2542,1 2632,0 2710,1 2735,0 2763,1 2861,0 2928,1 2936,0 2975,1 3001,0 3013,1 3015,0 3098,1 3120,0 3191,1 3263,0 3291,1 3300,0 3319,1 3332,0 3364,1 3432,0 3519,1 3581,0 3660,1 3722,0 3735,1 3790,0 3823,1 3905,0 3974,1 4030,0 4081,1 4142,0 4168,1 4193,0 4214,1 4250,0 4331,1 4366,0 4455,1 4465,0 4561,1 4564,0 4642,1 4650,0 4658,1 4693,0 4729,1 4799,0 4871,1 4887,0 4974,1 5025,0 5028,1 5087,0 5179,1 5181,0 5185,1 5213,0 5287,1 5320,0 5353,1 5449,0 5502,1 5523,0 5598,1 5668,0 5683,1 5726,0 5799,1 5828,0 5920,1 5924,0 5962,1 6030,0 6053,1 6113,0 6204,1 6256,0 6266,1 6292,0 6367,1 6396,0 6474,1 6530,0 6564,1 6612,0 6671,1 6707,0 6715,1 6731,0 6828,1 6926,0 6968,1 7048,0 7116,1 7174,0 7221,1 7231,0 7242,1 7333,0 7389,1 7393,0 7400,1 7456,0 7476,1 7484,0 7529,1 7571,0 7651,1 7677,0 7724,1 7773,0 7799,1 7836,0 7926,1 8017,0 8028,1 8064,0 8160,1 8260,0 8341,1 8382,0 8450,1 8471,0 8494,1 8593,0 8616,1 8619,0 8694,1 8751,0 8766,1 8793,0 8807,1 8892,0 8967,1 9023,0 9074,1 9086,0 9090,1 9127,0 9162,1 9206,0 9289,1 9350,0 9359,1 9393,0 9460,1 9461,0 9554,1 9614,0 9639,1 9670,0 9760,1 9824,0 9919,1 9969,0 9976,1 10011,0 10097,1 10146,0 10200,1 10224,0 10229,1 10289,0 10310,1 10368,0 10462,1 10473,0 10537,1 10626,0 10646,1 10732,0 10831,1 10867,0 10903,1 10958,0 10962,1 11049,0 11058,1 11135,0 11178,1 11188,0 11204,1 11239,0 11256,1 11257,0 11357,1 11437,0 11457,1 11489,0 11572,1 11618,0 11629,1 11714,0 11801,1 11864,0 11937,1 11982,0 12037,1 12090,0 12115,1 end initlist b86 0,0 8,1 31,0 111,1 117,0 126,1 127,0 143,1 163,0 224,1 229,0 328,1 364,0 464,1 488,0 489,1 577,0 612,1 654,0 722,1 738,0 792,1 793,0 803,1 826,0 844,1 849,0 865,1 954,0 973,1 1047,0 1086,1 1101,0 1164,1 1212,0 1288,1 1350,0 1441,1 1520,0 1609,1 1621,0 1654,1 1682,0 1733,1 1787,0 1791,1 1828,0 1862,1 1880,0 1885,1 1898,0 1902,1 1928,0 2011,1 2043,0 2052,1 2094,0 2158,1 2201,0 2261,1 2280,0 2311,1 2392,0 2464,1 2491,0 2521,1 2575,0 2648,1 2705,0 2758,1 2812,0 2854,1 2887,0 2947,1 3008,0 3079,1 3103,0 3132,1 3144,0 3187,1 3264,0 3360,1 3436,0 3496,1 3532,0 3549,1 3564,0 3626,1 3710,0 3771,1 3851,0 3950,1 3966,0 4057,1 4072,0 4089,1 4124,0 4187,1 4273,0 4278,1 4324,0 4359,1 4455,0 4524,1 4590,0 4638,1 4727,0 4795,1 4836,0 4904,1 4946,0 4980,1 5051,0 5146,1 5229,0 5313,1 5403,0 5406,1 5414,0 5434,1 5453,0 5456,1 5491,0 5591,1 5615,0 5669,1 5739,0 5779,1 5865,0 5935,1 6001,0 6094,1 6153,0 6209,1 6241,0 6341,1 6423,0 6483,1 6498,0 6570,1 6598,0 6679,1 6774,0 6841,1 6896,0 6951,1 6982,0 7062,1 7083,0 7147,1 7209,0 7263,1 7276,0 7351,1 7418,0 7469,1 7492,0 7553,1 7593,0 7629,1 7680,0 7706,1 7733,0 7754,1 7842,0 7865,1 7891,0 7935,1 8024,0 8061,1 8113,0 8172,1 8256,0 8314,1 8395,0 8412,1 8454,0 8478,1 8481,0 8514,1 8610,0 8686,1 8713,0 8739,1 8828,0 8835,1 8902,0 8924,1 9021,0 9102,1 9129,0 9221,1 9223,0 9306,1 9373,0 9439,1 9530,0 9556,1 9584,0 9623,1 9629,0 9683,1 9711,0 9718,1 9788,0 9799,1 9805,0 9899,1 9957,0 10039,1 10078,0 10094,1 10102,0 10127,1 10184,0 10256,1 10289,0 10297,1 10397,0 10465,1 10514,0 10533,1 10578,0 10604,1 10667,0 10764,1 10823,0 10873,1 10959,0 10995,1 11034,0 11072,1 11094,0 11178,1 11255,0 11276,1 11364,0 11409,1 11453,0 11525,1 11616,0 11659,1 11756,0 11798,1 11864,0 11883,1 11931,0 11995,1 12009,0 12025,1 12065,0 12112,1 12159,0 12177,1 12259,0 12325,1 12391,0 12451,1 end initlist b87 0,0 70,1 123,0 176,1 255,0 302,1 401,0 486,1 496,0 533,1 623,0 713,1 776,0 875,1 950,0 1034,1 1098,0 1147,1 1153,0 1192,1 1274,0 1347,1 1428,0 1485,1 1513,0 1573,1 1653,0 1673,1 1691,0 1752,1 1761,0 1852,1 1913,0 1954,1 1996,0 2023,1 2047,0 2113,1 2128,0 2199,1 2228,0 2260,1 2283,0 2360,1 2405,0 2486,1 2559,0 2580,1 2599,0 2653,1 2711,0 2808,1 2809,0 2865,1 2928,0 2950,1 3002,0 3013,1 3032,0 3103,1 3130,0 3189,1 3202,0 3215,1 3240,0 3322,1 3382,0 3388,1 3427,0 3484,1 3526,0 3617,1 3629,0 3702,1 3710,0 3751,1 3816,0 3890,1 3923,0 3980,1 4061,0 4140,1 4219,0 4225,1 4280,0 4316,1 4394,0 4438,1 4472,0 4525,1 4586,0 4640,1 4679,0 4706,1 4780,0 4810,1 4817,0 4829,1 4869,0 4908,1 4977,0 5029,1 5102,0 5172,1 5233,0 5260,1 5310,0 5399,1 5478,0 5506,1 5592,0 5636,1 5706,0 5796,1 5880,0 5900,1 5995,0 6072,1 6136,0 6212,1 6216,0 6300,1 6374,0 6437,1 6499,0 6564,1 6600,0 6698,1 6749,0 6776,1 6846,0 6884,1 6956,0 7010,1 7014,0 7082,1 7097,0 7110,1 7142,0 7148,1 7197,0 7219,1 7256,0 7258,1 7266,0 7355,1 7376,0 7401,1 7412,0 7470,1 7554,0 7641,1 7646,0 7656,1 7715,0 7798,1 7897,0 7995,1 8075,0 8119,1 8125,0 8141,1 8224,0 8291,1 8372,0 8415,1 8472,0 8545,1 8595,0 8665,1 8726,0 8738,1 8786,0 8857,1 8861,0 8940,1 8975,0 9007,1 9016,0 9099,1 9145,0 9162,1 9229,0 9303,1 9336,0 9359,1 9392,0 9445,1 9479,0 9486,1 9540,0 9634,1 9644,0 9731,1 9734,0 9789,1 9822,0 9880,1 9958,0 9992,1 10028,0 10071,1 10104,0 10147,1 10239,0 10334,1 10429,0 10490,1 10532,0 10610,1 10673,0 10700,1 10798,0 10876,1 10926,0 10947,1 11013,0 11028,1 11076,0 11175,1 11248,0 11315,1 11395,0 11470,1 11494,0 11554,1 11572,0 11653,1 11662,0 11750,1 11756,0 11827,1 11915,0 11965,1 12043,0 12081,1 12130,0 12160,1 12166,0 12236,1 12295,0 12327,1 12388,0 12445,1 12515,0 12537,1 12545,0 12617,1 12618,0 12712,1 12733,0 12801,1 12896,0 12926,1 13019,0 13044,1 13087,0 13151,1 end initlist b88 0,0 1,1 94,0 145,1 177,0 192,1 206,0 270,1 328,0 363,1 412,0 500,1 507,0 580,1 595,0 651,1 661,0 759,1 843,0 849,1 895,0 989,1 1047,0 1125,1 1179,0 1192,1 1227,0 1274,1 1296,0 1369,1 1455,0 1504,1 1599,0 1656,1 1751,0 1837,1 1909,0 1927,1 1959,0 2027,1 2074,0 2171,1 2216,0 2314,1 2382,0 2416,1 2445,0 2455,1 2456,0 2539,1 2615,0 2691,1 2759,0 2814,1 2845,0 2869,1 2897,0 2907,1 2926,0 2981,1 3066,0 3163,1 3170,0 3222,1 3303,0 3337,1 3398,0 3426,1 3447,0 3502,1 3590,0 3686,1 3766,0 3857,1 3914,0 3956,1 4010,0 4054,1 4106,0 4180,1 4239,0 4260,1 4314,0 4364,1 4381,0 4446,1 4497,0 4558,1 4656,0 4712,1 4772,0 4860,1 4887,0 4969,1 4990,0 5047,1 5063,0 5104,1 5131,0 5221,1 5293,0 5332,1 5404,0 5487,1 5549,0 5575,1 5576,0 5668,1 5693,0 5698,1 5707,0 5724,1 5796,0 5835,1 5924,0 5939,1 6009,0 6041,1 6130,0 6186,1 6191,0 6279,1 6291,0 6311,1 6332,0 6397,1 6431,0 6460,1 6551,0 6590,1 6593,0 6663,1 6691,0 6773,1 6848,0 6948,1 6954,0 7033,1 7086,0 7175,1 7235,0 7287,1 7325,0 7397,1 7482,0 7577,1 7627,0 7711,1 7788,0 7811,1 7886,0 7916,1 8013,0 8036,1 8037,0 8091,1 8108,0 8162,1 8256,0 8344,1 8441,0 8480,1 8551,0 8594,1 8633,0 8716,1 8756,0 8803,1 8883,0 8930,1 9025,0 9114,1 9193,0 9236,1 9333,0 9371,1 9454,0 9490,1 9538,0 9588,1 9613,0 9677,1 9738,0 9833,1 9911,0 9962,1 10049,0 10099,1 10195,0 10218,1 10288,0 10380,1 10405,0 10478,1 10569,0 10609,1 10614,0 10615,1 10653,0 10751,1 10826,0 10858,1 10875,0 10912,1 10964,0 10978,1 11011,0 11018,1 11051,0 11090,1 11128,0 11159,1 11256,0 11310,1 11348,0 11417,1 11428,0 11495,1 11595,0 11603,1 11639,0 11724,1 11728,0 11786,1 11827,0 11898,1 11901,0 11921,1 11923,0 11999,1 12039,0 12083,1 12128,0 12131,1 12222,0 12238,1 12266,0 12302,1 12333,0 12375,1 12466,0 12552,1 12567,0 12622,1 12692,0 12748,1 12808,0 12815,1 12820,0 12844,1 12922,0 12975,1 12999,0 13000,1 13081,0 13146,1 13202,0 13207,1 end initlist b89 0,0 37,1 73,0 140,1 186,0 193,1 275,0 342,1 424,0 518,1 556,0 609,1 643,0 662,1 732,0 788,1 833,0 894,1 939,0 942,1 945,0 965,1 983,0 1044,1 1064,0 1143,1 1222,0 1303,1 1375,0 1446,1 1541,0 1606,1 1658,0 1666,1 1760,0 1763,1 1777,0 1847,1 1853,0 1929,1 1940,0 1952,1 2051,0 2053,1 2069,0 2120,1 2154,0 2159,1 2233,0 2329,1 2366,0 2436,1 2520,0 2563,1 2651,0 2663,1 2665,0 2763,1 2859,0 2893,1 2952,0 3036,1 3101,0 3193,1 3209,0 3244,1 3341,0 3387,1 3392,0 3429,1 3476,0 3497,1 3537,0 3624,1 3705,0 3711,1 3763,0 3820,1 3881,0 3943,1 3965,0 4042,1 4139,0 4217,1 4255,0 4282,1 4378,0 4384,1 4391,0 4439,1 4470,0 4559,1 4651,0 4652,1 4742,0 4841,1 4907,0 4937,1 5036,0 5088,1 5156,0 5244,1 5251,0 5345,1 5444,0 5488,1 5508,0 5603,1 5674,0 5737,1 5823,0 5875,1 5943,0 6042,1 6124,0 6157,1 6183,0 6273,1 6312,0 6402,1 6422,0 6479,1 6518,0 6585,1 6599,0 6619,1 6650,0 6746,1 6786,0 6810,1 6837,0 6886,1 6965,0 7054,1 7107,0 7187,1 7277,0 7348,1 7361,0 7384,1 7394,0 7466,1 7557,0 7646,1 7698,0 7738,1 7822,0 7911,1 7940,0 8022,1 8062,0 8105,1 8177,0 8201,1 8265,0 8298,1 8398,0 8472,1 8559,0 8580,1 8642,0 8695,1 8720,0 8725,1 8813,0 8818,1 8910,0 8993,1 9058,0 9124,1 9224,0 9251,1 9325,0 9358,1 9362,0 9418,1 9460,0 9479,1 9509,0 9555,1 9559,0 9653,1 9728,0 9729,1 9775,0 9866,1 9872,0 9959,1 9973,0 10035,1 10099,0 10122,1 10143,0 10225,1 10280,0 10340,1 10398,0 10427,1 10440,0 10505,1 10525,0 10566,1 10646,0 10700,1 10752,0 10808,1 10818,0 10822,1 10912,0 11002,1 11064,0 11099,1 11167,0 11198,1 11273,0 11309,1 11344,0 11423,1 11466,0 11519,1 11573,0 11631,1 11719,0 11727,1 11799,0 11899,1 11930,0 12006,1 12060,0 12061,1 12079,0 12151,1 12223,0 12226,1 12230,0 12257,1 12301,0 12315,1 12336,0 12391,1 12424,0 12471,1 12541,0 12581,1 12639,0 12728,1 12780,0 12802,1 12901,0 12932,1 12996,0 13020,1 13040,0 13072,1 13172,0 13265,1 13359,0 13395,1 end initlist b90 0,0 6,1 61,0 88,1 147,0 150,1 216,0 282,1 359,0 458,1 541,0 583,1 586,0 645,1 670,0 745,1 819,0 828,1 849,0 946,1 1030,0 1033,1 1097,0 1172,1 1194,0 1240,1 1250,0 1323,1 1368,0 1456,1 1476,0 1540,1 1601,0 1688,1 1753,0 1792,1 1858,0 1897,1 1940,0 1991,1 2005,0 2080,1 2123,0 2147,1 2228,0 2233,1 2269,0 2285,1 2286,0 2350,1 2421,0 2469,1 2565,0 2592,1 2599,0 2691,1 2775,0 2820,1 2860,0 2883,1 2942,0 2949,1 3028,0 3127,1 3131,0 3142,1 3187,0 3281,1 3355,0 3455,1 3519,0 3609,1 3649,0 3703,1 3758,0 3763,1 3828,0 3876,1 3945,0 4012,1 4110,0 4117,1 4180,0 4252,1 4318,0 4344,1 4348,0 4382,1 4470,0 4508,1 4573,0 4578,1 4596,0 4627,1 4725,0 4734,1 4784,0 4826,1 4839,0 4840,1 4908,0 5002,1 5066,0 5110,1 5200,0 5289,1 5364,0 5456,1 5465,0 5471,1 5564,0 5571,1 5658,0 5751,1 5793,0 5865,1 5961,0 5991,1 6068,0 6072,1 6119,0 6194,1 6213,0 6294,1 6344,0 6345,1 6372,0 6386,1 6448,0 6482,1 6531,0 6577,1 6615,0 6655,1 6733,0 6814,1 6899,0 6906,1 6923,0 6927,1 6964,0 7018,1 7049,0 7070,1 7160,0 7214,1 7221,0 7267,1 7279,0 7364,1 7389,0 7437,1 7509,0 7585,1 7663,0 7697,1 7732,0 7828,1 7829,0 7908,1 7984,0 7996,1 8084,0 8184,1 8225,0 8264,1 8310,0 8375,1 8464,0 8500,1 8538,0 8631,1 8693,0 8707,1 8723,0 8815,1 8898,0 8929,1 8961,0 8980,1 9008,0 9086,1 9119,0 9187,1 9234,0 9278,1 9359,0 9444,1 9539,0 9639,1 9735,0 9745,1 9773,0 9795,1 9879,0 9907,1 9993,0 10000,1 10034,0 10108,1 10118,0 10172,1 10268,0 10298,1 10356,0 10410,1 10484,0 10553,1 10555,0 10654,1 10736,0 10822,1 10893,0 10921,1 10942,0 10945,1 11015,0 11044,1 11086,0 11089,1 11138,0 11141,1 11198,0 11266,1 11315,0 11412,1 11498,0 11540,1 11546,0 11638,1 11667,0 11753,1 11842,0 11872,1 11914,0 12008,1 12023,0 12076,1 12176,0 12257,1 12303,0 12342,1 12406,0 12444,1 12454,0 12455,1 12553,0 12647,1 12744,0 12836,1 12863,0 12906,1 12996,0 13083,1 13110,0 13151,1 13237,0 13327,1 end initlist b91 0,0 84,1 131,0 190,1 237,0 297,1 302,0 323,1 408,0 497,1 521,0 569,1 641,0 701,1 741,0 772,1 870,0 946,1 1045,0 1088,1 1091,0 1149,1 1167,0 1227,1 1260,0 1290,1 1358,0 1395,1 1443,0 1486,1 1525,0 1531,1 1556,0 1623,1 1665,0 1675,1 1680,0 1765,1 1817,0 1887,1 1925,0 1930,1 2001,0 2098,1 2191,0 2275,1 2356,0 2403,1 2496,0 2587,1 2626,0 2716,1 2810,0 2887,1 2897,0 2985,1 3003,0 3103,1 3105,0 3195,1 3203,0 3238,1 3285,0 3301,1 3319,0 3366,1 3368,0 3419,1 3517,0 3524,1 3611,0 3633,1 3714,0 3806,1 3827,0 3893,1 3953,0 4045,1 4142,0 4204,1 4210,0 4246,1 4249,0 4290,1 4367,0 4421,1 4468,0 4566,1 4630,0 4708,1 4781,0 4853,1 4913,0 5003,1 5099,0 5165,1 5178,0 5185,1 5205,0 5297,1 5368,0 5423,1 5436,0 5456,1 5491,0 5577,1 5589,0 5654,1 5745,0 5752,1 5757,0 5786,1 5811,0 5820,1 5835,0 5850,1 5856,0 5907,1 5936,0 6033,1 6059,0 6139,1 6218,0 6298,1 6395,0 6420,1 6514,0 6582,1 6667,0 6668,1 6704,0 6799,1 6855,0 6950,1 6951,0 6992,1 7027,0 7069,1 7090,0 7177,1 7272,0 7368,1 7375,0 7416,1 7494,0 7584,1 7587,0 7659,1 7736,0 7816,1 7830,0 7873,1 7914,0 8002,1 8051,0 8058,1 8143,0 8158,1 8237,0 8241,1 8304,0 8389,1 8404,0 8481,1 8518,0 8523,1 8615,0 8679,1 8771,0 8814,1 8866,0 8957,1 9011,0 9012,1 9106,0 9196,1 9197,0 9289,1 9378,0 9410,1 9445,0 9532,1 9582,0 9607,1 9686,0 9782,1 9809,0 9893,1 9908,0 9944,1 9973,0 10019,1 10038,0 10137,1 10156,0 10216,1 10278,0 10359,1 10390,0 10456,1 10550,0 10641,1 10726,0 10741,1 10754,0 10763,1 10791,0 10862,1 10874,0 10875,1 10884,0 10937,1 10995,0 11079,1 11145,0 11149,1 11195,0 11248,1 11293,0 11383,1 11478,0 11548,1 11637,0 11694,1 11769,0 11851,1 11879,0 11968,1 12030,0 12039,1 12109,0 12129,1 12206,0 12228,1 12260,0 12351,1 12383,0 12479,1 12554,0 12647,1 12661,0 12720,1 12811,0 12821,1 12886,0 12964,1 13029,0 13090,1 13184,0 13252,1 13279,0 13363,1 13389,0 13398,1 13464,0 13486,1 13563,0 13599,1 end initlist b92 0,0 51,1 139,0 149,1 209,0 217,1 233,0 263,1 267,0 319,1 328,0 381,1 394,0 416,1 451,0 455,1 494,0 562,1 603,0 699,1 745,0 802,1 820,0 902,1 913,0 988,1 989,0 1008,1 1038,0 1068,1 1115,0 1204,1 1223,0 1312,1 1408,0 1494,1 1552,0 1649,1 1731,0 1818,1 1879,0 1954,1 2015,0 2041,1 2098,0 2133,1 2135,0 2145,1 2203,0 2253,1 2339,0 2358,1 2368,0 2380,1 2445,0 2496,1 2570,0 2666,1 2740,0 2831,1 2906,0 2999,1 3083,0 3133,1 3230,0 3320,1 3358,0 3444,1 3521,0 3606,1 3640,0 3673,1 3750,0 3835,1 3881,0 3924,1 3999,0 4002,1 4040,0 4074,1 4157,0 4182,1 4278,0 4285,1 4339,0 4389,1 4439,0 4482,1 4510,0 4608,1 4624,0 4628,1 4719,0 4804,1 4841,0 4893,1 4904,0 4952,1 5025,0 5056,1 5149,0 5178,1 5199,0 5208,1 5236,0 5239,1 5291,0 5327,1 5377,0 5403,1 5437,0 5468,1 5548,0 5572,1 5611,0 5651,1 5698,0 5737,1 5821,0 5855,1 5896,0 5928,1 5962,0 6050,1 6128,0 6138,1 6228,0 6316,1 6336,0 6343,1 6419,0 6447,1 6526,0 6565,1 6569,0 6600,1 6690,0 6734,1 6833,0 6926,1 6952,0 7045,1 7128,0 7205,1 7252,0 7263,1 7330,0 7416,1 7420,0 7470,1 7481,0 7497,1 7592,0 7606,1 7703,0 7800,1 7801,0 7809,1 7818,0 7826,1 7871,0 7965,1 8064,0 8088,1 8147,0 8241,1 8261,0 8360,1 8440,0 8502,1 8565,0 8584,1 8603,0 8695,1 8743,0 8834,1 8931,0 8974,1 9062,0 9157,1 9206,0 9306,1 9391,0 9481,1 9539,0 9612,1 9646,0 9706,1 9717,0 9800,1 9869,0 9926,1 10021,0 10089,1 10158,0 10172,1 10258,0 10350,1 10444,0 10476,1 10548,0 10624,1 10672,0 10700,1 10757,0 10777,1 10841,0 10878,1 10904,0 10954,1 11052,0 11131,1 11158,0 11220,1 11235,0 11242,1 11300,0 11396,1 11397,0 11451,1 11471,0 11520,1 11582,0 11597,1 11690,0 11785,1 11850,0 11895,1 11990,0 12063,1 12090,0 12176,1 12221,0 12304,1 12363,0 12444,1 12452,0 12475,1 12529,0 12604,1 12628,0 12712,1 12727,0 12732,1 12740,0 12809,1 12828,0 12849,1 12866,0 12955,1 13012,0 13094,1 13185,0 13218,1 13243,0 13259,1 13341,0 13375,1 end initlist b93 0,0 22,1 93,0 172,1 239,0 267,1 364,0 368,1 410,0 418,1 458,0 501,1 531,0 618,1 624,0 700,1 796,0 866,1 938,0 981,1 1050,0 1096,1 1187,0 1262,1 1300,0 1323,1 1394,0 1485,1 1486,0 1531,1 1614,0 1651,1 1714,0 1738,1 1742,0 1776,1 1796,0 1831,1 1841,0 1877,1 1939,0 1959,1 2050,0 2137,1 2166,0 2209,1 2263,0 2269,1 2339,0 2350,1 2352,0 2367,1 2455,0 2462,1 2557,0 2640,1 2732,0 2782,1 2845,0 2889,1 2931,0 3018,1 3040,0 3091,1 3186,0 3212,1 3228,0 3256,1 3310,0 3382,1 3414,0 3453,1 3506,0 3593,1 3655,0 3748,1 3774,0 3793,1 3842,0 3853,1 3948,0 4002,1 4014,0 4050,1 4088,0 4154,1 4243,0 4331,1 4364,0 4423,1 4467,0 4520,1 4589,0 4593,1 4639,0 4669,1 4720,0 4774,1 4811,0 4854,1 4946,0 5037,1 5110,0 5192,1 5264,0 5270,1 5291,0 5310,1 5359,0 5408,1 5449,0 5482,1 5573,0 5623,1 5630,0 5676,1 5709,0 5761,1 5845,0 5924,1 6003,0 6004,1 6063,0 6089,1 6176,0 6241,1 6298,0 6355,1 6374,0 6416,1 6426,0 6462,1 6480,0 6538,1 6545,0 6591,1 6638,0 6709,1 6779,0 6800,1 6837,0 6894,1 6911,0 6939,1 7009,0 7011,1 7057,0 7111,1 7164,0 7193,1 7258,0 7289,1 7360,0 7450,1 7505,0 7570,1 7638,0 7702,1 7751,0 7824,1 7890,0 7937,1 7968,0 8045,1 8059,0 8082,1 8105,0 8193,1 8283,0 8336,1 8347,0 8393,1 8466,0 8496,1 8552,0 8625,1 8680,0 8769,1 8805,0 8884,1 8895,0 8972,1 8999,0 9005,1 9098,0 9140,1 9165,0 9229,1 9230,0 9279,1 9360,0 9386,1 9424,0 9524,1 9576,0 9581,1 9599,0 9625,1 9626,0 9713,1 9794,0 9822,1 9837,0 9884,1 9887,0 9910,1 9987,0 10048,1 10079,0 10133,1 10226,0 10264,1 10334,0 10373,1 10428,0 10485,1 10555,0 10655,1 10730,0 10796,1 10841,0 10872,1 10936,0 10962,1 10976,0 11006,1 11079,0 11139,1 11207,0 11304,1 11368,0 11388,1 11446,0 11541,1 11599,0 11694,1 11792,0 11872,1 11901,0 11942,1 12000,0 12086,1 12118,0 12149,1 12220,0 12304,1 12322,0 12404,1 12416,0 12484,1 12569,0 12595,1 12650,0 12666,1 12680,0 12762,1 12809,0 12841,1 end initlist b94 0,0 87,1 123,0 184,1 272,0 343,1 353,0 408,1 451,0 519,1 536,0 634,1 724,0 800,1 850,0 861,1 934,0 966,1 1040,0 1137,1 1158,0 1173,1 1263,0 1288,1 1302,0 1303,1 1351,0 1373,1 1387,0 1418,1 1455,0 1516,1 1520,0 1543,1 1643,0 1646,1 1743,0 1823,1 1836,0 1901,1 1907,0 1936,1 1956,0 1962,1 2021,0 2041,1 2122,0 2207,1 2258,0 2275,1 2301,0 2357,1 2401,0 2423,1 2431,0 2497,1 2594,0 2616,1 2626,0 2696,1 2769,0 2805,1 2891,0 2925,1 2949,0 2990,1 3037,0 3109,1 3136,0 3182,1 3255,0 3304,1 3375,0 3378,1 3434,0 3497,1 3519,0 3541,1 3587,0 3613,1 3623,0 3646,1 3714,0 3715,1 3734,0 3833,1 3837,0 3918,1 3976,0 3989,1 4057,0 4132,1 4217,0 4246,1 4343,0 4375,1 4384,0 4400,1 4414,0 4486,1 4520,0 4619,1 4630,0 4685,1 4754,0 4759,1 4820,0 4886,1 4941,0 5006,1 5087,0 5117,1 5135,0 5210,1 5287,0 5353,1 5359,0 5364,1 5421,0 5491,1 5528,0 5536,1 5596,0 5643,1 5666,0 5683,1 5688,0 5726,1 5823,0 5908,1 5930,0 6029,1 6040,0 6088,1 6178,0 6278,1 6300,0 6397,1 6436,0 6511,1 6560,0 6660,1 6694,0 6757,1 6840,0 6890,1 6937,0 6976,1 6999,0 7057,1 7085,0 7125,1 7175,0 7231,1 7304,0 7328,1 7379,0 7437,1 7460,0 7485,1 7506,0 7587,1 7678,0 7774,1 7842,0 7914,1 7930,0 7987,1 8061,0 8100,1 8127,0 8187,1 8253,0 8304,1 8313,0 8362,1 8404,0 8459,1 8467,0 8520,1 8557,0 8565,1 8658,0 8750,1 8844,0 8886,1 8901,0 8932,1 8988,0 9060,1 9069,0 9094,1 9102,0 9123,1 9198,0 9230,1 9268,0 9301,1 9306,0 9403,1 9474,0 9528,1 9618,0 9654,1 9718,0 9816,1 9899,0 9985,1 10075,0 10160,1 10250,0 10263,1 10278,0 10342,1 10412,0 10497,1 10511,0 10564,1 10620,0 10676,1 10736,0 10802,1 10867,0 10916,1 10978,0 11072,1 11144,0 11194,1 11270,0 11348,1 11433,0 11479,1 11514,0 11566,1 11577,0 11616,1 11624,0 11636,1 11715,0 11741,1 11765,0 11767,1 11856,0 11896,1 11977,0 12001,1 12010,0 12052,1 12146,0 12172,1 12241,0 12329,1 12387,0 12424,1 12510,0 12603,1 12684,0 12777,1 end initlist b95 0,0 52,1 109,0 110,1 172,0 256,1 351,0 433,1 497,0 503,1 593,0 634,1 709,0 731,1 808,0 853,1 938,0 1012,1 1065,0 1112,1 1175,0 1250,1 1280,0 1296,1 1329,0 1366,1 1438,0 1463,1 1543,0 1580,1 1679,0 1726,1 1776,0 1837,1 1912,0 1932,1 1991,0 2021,1 2043,0 2077,1 2120,0 2146,1 2245,0 2295,1 2346,0 2383,1 2462,0 2519,1 2531,0 2629,1 2694,0 2740,1 2761,0 2856,1 2938,0 2973,1 3029,0 3096,1 3120,0 3177,1 3251,0 3339,1 3342,0 3402,1 3423,0 3470,1 3501,0 3588,1 3684,0 3728,1 3795,0 3869,1 3941,0 3944,1 4005,0 4089,1 4131,0 4171,1 4265,0 4302,1 4309,0 4362,1 4382,0 4420,1 4471,0 4570,1 4666,0 4694,1 4785,0 4851,1 4913,0 4993,1 5071,0 5142,1 5182,0 5226,1 5289,0 5344,1 5360,0 5421,1 5496,0 5551,1 5572,0 5667,1 5699,0 5762,1 5848,0 5921,1 6010,0 6080,1 6157,0 6254,1 6268,0 6286,1 6331,0 6349,1 6420,0 6446,1 6516,0 6577,1 6624,0 6647,1 6655,0 6742,1 6743,0 6842,1 6873,0 6963,1 7031,0 7080,1 7158,0 7247,1 7262,0 7356,1 7425,0 7521,1 7607,0 7700,1 7721,0 7817,1 7888,0 7897,1 7953,0 7969,1 8020,0 8083,1 8123,0 8221,1 8291,0 8308,1 8324,0 8344,1 8418,0 8472,1 8567,0 8621,1 8702,0 8703,1 8732,0 8807,1 8896,0 8899,1 8983,0 9070,1 9156,0 9173,1 9217,0 9288,1 9309,0 9387,1 9405,0 9456,1 9492,0 9541,1 9634,0 9700,1 9773,0 9815,1 9893,0 9988,1 10007,0 10087,1 10105,0 10173,1 10252,0 10310,1 10352,0 10426,1 10468,0 10497,1 10547,0 10566,1 10586,0 10599,1 10615,0 10667,1 10728,0 10738,1 10776,0 10815,1 10816,0 10898,1 10977,0 11052,1 11085,0 11124,1 11179,0 11183,1 11211,0 11253,1 11310,0 11391,1 11430,0 11474,1 11531,0 11599,1 11683,0 11711,1 11757,0 11833,1 11895,0 11965,1 12021,0 12042,1 12116,0 12204,1 12245,0 12312,1 12370,0 12382,1 12401,0 12474,1 12560,0 12566,1 12613,0 12677,1 12764,0 12852,1 12923,0 12991,1 13011,0 13029,1 13080,0 13132,1 13202,0 13280,1 13366,0 13391,1 13453,0 13527,1 13562,0 13619,1 13628,0 13663,1 13694,0 13720,1 13725,0 13779,1 end initlist b96 0,0 7,1 48,0 54,1 85,0 96,1 163,0 216,1 307,0 401,1 441,0 497,1 544,0 635,1 662,0 716,1 803,0 819,1 872,0 873,1 971,0 1045,1 1141,0 1157,1 1165,0 1204,1 1206,0 1303,1 1361,0 1368,1 1442,0 1474,1 1512,0 1530,1 1566,0 1661,1 1739,0 1818,1 1824,0 1915,1 2008,0 2037,1 2065,0 2112,1 2147,0 2179,1 2221,0 2228,1 2239,0 2332,1 2356,0 2456,1 2505,0 2598,1 2622,0 2661,1 2699,0 2719,1 2741,0 2746,1 2807,0 2883,1 2963,0 2982,1 3052,0 3084,1 3118,0 3170,1 3253,0 3323,1 3394,0 3488,1 3494,0 3513,1 3584,0 3593,1 3654,0 3687,1 3767,0 3833,1 3863,0 3933,1 4031,0 4032,1 4101,0 4184,1 4220,0 4235,1 4251,0 4273,1 4340,0 4363,1 4403,0 4464,1 4561,0 4601,1 4657,0 4702,1 4795,0 4894,1 4931,0 5001,1 5045,0 5073,1 5133,0 5162,1 5217,0 5296,1 5376,0 5466,1 5500,0 5592,1 5685,0 5723,1 5745,0 5840,1 5862,0 5917,1 5978,0 5980,1 5987,0 6070,1 6140,0 6191,1 6201,0 6272,1 6284,0 6384,1 6466,0 6554,1 6592,0 6636,1 6657,0 6668,1 6724,0 6821,1 6875,0 6941,1 7023,0 7038,1 7083,0 7087,1 7094,0 7157,1 7194,0 7201,1 7237,0 7319,1 7346,0 7415,1 7435,0 7493,1 7497,0 7558,1 7619,0 7651,1 7721,0 7728,1 7746,0 7806,1 7884,0 7902,1 7943,0 7989,1 8039,0 8128,1 8152,0 8232,1 8318,0 8370,1 8408,0 8481,1 8577,0 8582,1 8674,0 8710,1 8767,0 8784,1 8850,0 8865,1 8907,0 8960,1 8994,0 9036,1 9102,0 9127,1 9136,0 9176,1 9210,0 9274,1 9299,0 9302,1 9314,0 9331,1 9368,0 9384,1 9390,0 9431,1 9475,0 9553,1 9650,0 9744,1 9764,0 9844,1 9891,0 9983,1 10000,0 10079,1 10115,0 10124,1 10203,0 10219,1 10270,0 10273,1 10367,0 10431,1 10437,0 10498,1 10533,0 10623,1 10704,0 10783,1 10829,0 10926,1 10983,0 11068,1 11101,0 11196,1 11296,0 11329,1 11392,0 11405,1 11428,0 11519,1 11575,0 11619,1 11621,0 11673,1 11764,0 11804,1 11860,0 11944,1 11994,0 12075,1 12082,0 12097,1 12164,0 12177,1 12273,0 12317,1 12379,0 12396,1 12456,0 12527,1 12547,0 12564,1 12636,0 12687,1 end initlist b97 0,0 53,1 116,0 117,1 214,0 223,1 277,0 336,1 362,0 445,1 506,0 582,1 669,0 683,1 754,0 824,1 857,0 955,1 1006,0 1083,1 1084,0 1135,1 1160,0 1184,1 1202,0 1227,1 1299,0 1323,1 1354,0 1366,1 1426,0 1495,1 1554,0 1616,1 1641,0 1649,1 1737,0 1742,1 1830,0 1858,1 1865,0 1879,1 1938,0 1984,1 2008,0 2090,1 2186,0 2251,1 2302,0 2328,1 2414,0 2453,1 2490,0 2555,1 2591,0 2658,1 2705,0 2722,1 2804,0 2829,1 2834,0 2884,1 2888,0 2975,1 3064,0 3109,1 3141,0 3232,1 3323,0 3356,1 3372,0 3444,1 3532,0 3600,1 3643,0 3644,1 3682,0 3742,1 3779,0 3851,1 3867,0 3896,1 3985,0 4069,1 4166,0 4266,1 4334,0 4359,1 4440,0 4446,1 4480,0 4500,1 4525,0 4561,1 4636,0 4687,1 4738,0 4797,1 4878,0 4940,1 4976,0 5066,1 5067,0 5096,1 5131,0 5224,1 5301,0 5326,1 5376,0 5435,1 5507,0 5583,1 5645,0 5662,1 5701,0 5772,1 5788,0 5876,1 5889,0 5944,1 6024,0 6105,1 6124,0 6175,1 6207,0 6307,1 6361,0 6403,1 6503,0 6530,1 6573,0 6603,1 6682,0 6770,1 6803,0 6854,1 6931,0 6971,1 7027,0 7105,1 7148,0 7209,1 7271,0 7339,1 7346,0 7440,1 7521,0 7610,1 7653,0 7702,1 7737,0 7815,1 7873,0 7942,1 7943,0 7982,1 8031,0 8051,1 8146,0 8197,1 8236,0 8262,1 8330,0 8407,1 8490,0 8538,1 8588,0 8592,1 8596,0 8638,1 8665,0 8680,1 8729,0 8794,1 8804,0 8809,1 8892,0 8948,1 8968,0 9033,1 9051,0 9099,1 9177,0 9261,1 9351,0 9430,1 9477,0 9515,1 9561,0 9651,1 9727,0 9774,1 9815,0 9819,1 9849,0 9865,1 9925,0 9967,1 10044,0 10139,1 10187,0 10220,1 10222,0 10318,1 10376,0 10451,1 10533,0 10535,1 10555,0 10605,1 10667,0 10750,1 10790,0 10815,1 10907,0 10912,1 10945,0 10969,1 11051,0 11064,1 11120,0 11180,1 11240,0 11259,1 11310,0 11403,1 11448,0 11529,1 11551,0 11571,1 11593,0 11692,1 11792,0 11874,1 11878,0 11916,1 12013,0 12021,1 12084,0 12120,1 12144,0 12188,1 12263,0 12315,1 12378,0 12422,1 12485,0 12578,1 12588,0 12652,1 12655,0 12735,1 12813,0 12820,1 12826,0 12866,1 12878,0 12929,1 end initlist b98 0,0 17,1 103,0 193,1 287,0 366,1 371,0 402,1 466,0 488,1 545,0 575,1 624,0 703,1 791,0 809,1 873,0 964,1 1042,0 1124,1 1132,0 1195,1 1255,0 1267,1 1295,0 1311,1 1373,0 1408,1 1501,0 1567,1 1575,0 1650,1 1749,0 1819,1 1843,0 1853,1 1855,0 1862,1 1921,0 1955,1 1995,0 2085,1 2136,0 2165,1 2178,0 2224,1 2309,0 2387,1 2426,0 2450,1 2544,0 2587,1 2589,0 2688,1 2717,0 2780,1 2838,0 2879,1 2891,0 2913,1 2967,0 3015,1 3016,0 3044,1 3139,0 3145,1 3181,0 3212,1 3240,0 3242,1 3277,0 3349,1 3434,0 3511,1 3584,0 3646,1 3722,0 3818,1 3907,0 3927,1 3940,0 3974,1 4062,0 4103,1 4196,0 4285,1 4322,0 4420,1 4454,0 4486,1 4538,0 4540,1 4602,0 4666,1 4678,0 4681,1 4774,0 4819,1 4832,0 4914,1 4927,0 4969,1 5062,0 5114,1 5126,0 5129,1 5181,0 5242,1 5334,0 5352,1 5437,0 5531,1 5598,0 5601,1 5684,0 5740,1 5800,0 5832,1 5895,0 5899,1 5917,0 5982,1 6058,0 6152,1 6184,0 6216,1 6217,0 6236,1 6278,0 6375,1 6447,0 6468,1 6568,0 6611,1 6681,0 6779,1 6832,0 6891,1 6983,0 7079,1 7165,0 7249,1 7264,0 7291,1 7298,0 7360,1 7392,0 7453,1 7536,0 7544,1 7642,0 7725,1 7800,0 7845,1 7920,0 7934,1 7936,0 8019,1 8040,0 8128,1 8198,0 8204,1 8273,0 8351,1 8443,0 8512,1 8569,0 8627,1 8666,0 8733,1 8759,0 8797,1 8839,0 8926,1 8933,0 9000,1 9061,0 9085,1 9134,0 9207,1 9270,0 9341,1 9377,0 9447,1 9470,0 9550,1 9569,0 9574,1 9619,0 9620,1 9690,0 9747,1 9761,0 9796,1 9875,0 9943,1 9980,0 10043,1 10058,0 10063,1 10087,0 10114,1 10162,0 10186,1 10237,0 10303,1 10357,0 10440,1 10480,0 10555,1 10617,0 10703,1 10802,0 10871,1 10897,0 10970,1 11028,0 11098,1 11158,0 11172,1 11237,0 11319,1 11325,0 11355,1 11379,0 11403,1 11419,0 11422,1 11439,0 11470,1 11537,0 11609,1 11630,0 11643,1 11743,0 11752,1 11822,0 11862,1 11953,0 12013,1 12031,0 12095,1 12099,0 12127,1 12220,0 12280,1 12302,0 12374,1 12469,0 12538,1 12544,0 12614,1 12640,0 12664,1 12759,0 12763,1 12783,0 12862,1 end initlist b99 0,0 20,1 90,0 167,1 206,0 235,1 313,0 390,1 452,0 488,1 512,0 537,1 567,0 584,1 637,0 699,1 753,0 770,1 785,0 804,1 862,0 869,1 904,0 1003,1 1064,0 1163,1 1260,0 1317,1 1341,0 1365,1 1459,0 1487,1 1528,0 1613,1 1623,0 1672,1 1752,0 1784,1 1785,0 1838,1 1936,0 1973,1 1994,0 2032,1 2128,0 2145,1 2187,0 2278,1 2355,0 2362,1 2389,0 2405,1 2476,0 2496,1 2596,0 2626,1 2628,0 2698,1 2735,0 2830,1 2857,0 2896,1 2980,0 3031,1 3123,0 3178,1 3238,0 3260,1 3298,0 3364,1 3390,0 3447,1 3506,0 3518,1 3539,0 3636,1 3686,0 3710,1 3742,0 3823,1 3862,0 3962,1 4035,0 4077,1 4141,0 4178,1 4243,0 4314,1 4397,0 4402,1 4404,0 4408,1 4477,0 4532,1 4575,0 4615,1 4641,0 4695,1 4699,0 4702,1 4726,0 4746,1 4794,0 4869,1 4924,0 4967,1 5014,0 5053,1 5145,0 5236,1 5299,0 5398,1 5434,0 5490,1 5580,0 5640,1 5666,0 5742,1 5798,0 5870,1 5930,0 6007,1 6046,0 6079,1 6144,0 6230,1 6317,0 6408,1 6474,0 6565,1 6642,0 6664,1 6685,0 6737,1 6788,0 6839,1 6870,0 6888,1 6959,0 7045,1 7069,0 7166,1 7236,0 7322,1 7345,0 7428,1 7446,0 7524,1 7580,0 7627,1 7716,0 7799,1 7896,0 7991,1 8018,0 8063,1 8069,0 8124,1 8125,0 8161,1 8213,0 8214,1 8294,0 8333,1 8418,0 8458,1 8495,0 8561,1 8624,0 8633,1 8664,0 8755,1 8836,0 8895,1 8937,0 9000,1 9089,0 9092,1 9108,0 9126,1 9172,0 9193,1 9210,0 9307,1 9395,0 9415,1 9491,0 9580,1 9677,0 9689,1 9784,0 9852,1 9914,0 9968,1 10027,0 10108,1 10177,0 10258,1 10295,0 10372,1 10420,0 10455,1 10528,0 10570,1 10614,0 10704,1 10739,0 10833,1 10917,0 10947,1 11007,0 11062,1 11157,0 11216,1 11295,0 11377,1 11457,0 11551,1 11625,0 11672,1 11768,0 11811,1 11850,0 11911,1 11921,0 12018,1 12095,0 12181,1 12274,0 12329,1 12395,0 12439,1 12484,0 12556,1 12617,0 12680,1 12748,0 12797,1 12885,0 12952,1 13006,0 13098,1 13167,0 13235,1 13249,0 13290,1 13307,0 13337,1 13415,0 13454,1 13473,0 13484,1 13488,0 13568,1 13591,0 13609,1 13690,0 13772,1 end initlist b100 0,0 65,1 153,0 190,1 232,0 298,1 312,0 406,1 457,0 464,1 550,0 640,1 684,0 773,1 802,0 833,1 893,0 912,1 978,0 1043,1 1111,0 1118,1 1200,0 1263,1 1330,0 1343,1 1392,0 1440,1 1447,0 1538,1 1553,0 1589,1 1596,0 1656,1 1742,0 1837,1 1852,0 1938,1 1944,0 2036,1 2136,0 2207,1 2226,0 2287,1 2317,0 2361,1 2408,0 2436,1 2467,0 2559,1 2589,0 2670,1 2736,0 2791,1 2875,0 2946,1 3010,0 3047,1 3143,0 3166,1 3228,0 3233,1 3311,0 3369,1 3421,0 3440,1 3517,0 3548,1 3614,0 3671,1 3712,0 3765,1 3836,0 3924,1 3996,0 4041,1 4098,0 4195,1 4214,0 4298,1 4313,0 4412,1 4439,0 4473,1 4520,0 4529,1 4542,0 4642,1 4721,0 4799,1 4826,0 4846,1 4883,0 4970,1 5022,0 5092,1 5122,0 5152,1 5212,0 5216,1 5239,0 5241,1 5323,0 5333,1 5344,0 5401,1 5497,0 5550,1 5557,0 5612,1 5616,0 5641,1 5716,0 5764,1 5803,0 5880,1 5970,0 6002,1 6030,0 6111,1 6198,0 6252,1 6321,0 6334,1 6415,0 6499,1 6503,0 6586,1 6610,0 6692,1 6699,0 6705,1 6802,0 6836,1 6847,0 6864,1 6895,0 6953,1 7021,0 7060,1 7151,0 7208,1 7226,0 7295,1 7364,0 7450,1 7516,0 7550,1 7622,0 7710,1 7712,0 7771,1 7839,0 7917,1 8002,0 8041,1 8126,0 8143,1 8160,0 8194,1 8248,0 8301,1 8308,0 8361,1 8378,0 8379,1 8401,0 8489,1 8492,0 8526,1 8622,0 8651,1 8682,0 8740,1 8776,0 8818,1 8867,0 8948,1 8992,0 9056,1 9070,0 9074,1 9146,0 9202,1 9251,0 9278,1 9370,0 9402,1 9487,0 9531,1 9549,0 9589,1 9604,0 9647,1 9718,0 9815,1 9911,0 9924,1 9972,0 9998,1 10057,0 10153,1 10221,0 10239,1 10335,0 10389,1 10449,0 10497,1 10553,0 10634,1 10671,0 10743,1 10826,0 10857,1 10930,0 10966,1 11027,0 11071,1 11142,0 11193,1 11236,0 11254,1 11352,0 11396,1 11444,0 11468,1 11489,0 11581,1 11665,0 11673,1 11677,0 11680,1 11703,0 11704,1 11718,0 11811,1 11849,0 11857,1 11860,0 11903,1 11986,0 11994,1 12033,0 12035,1 12045,0 12122,1 12209,0 12260,1 12327,0 12378,1 12466,0 12524,1 12566,0 12622,1 12692,0 12775,1 12867,0 12910,1 end initlist b101 0,0 26,1 98,0 156,1 174,0 240,1 263,0 304,1 353,0 380,1 413,0 477,1 519,0 548,1 615,0 636,1 679,0 738,1 802,0 861,1 918,0 994,1 1090,0 1190,1 1284,0 1305,1 1403,0 1461,1 1550,0 1558,1 1597,0 1658,1 1699,0 1734,1 1832,0 1924,1 1984,0 2050,1 2085,0 2133,1 2179,0 2261,1 2286,0 2304,1 2318,0 2332,1 2407,0 2488,1 2518,0 2528,1 2577,0 2593,1 2595,0 2634,1 2669,0 2740,1 2830,0 2927,1 2949,0 3005,1 3056,0 3090,1 3114,0 3213,1 3231,0 3282,1 3287,0 3353,1 3379,0 3397,1 3435,0 3462,1 3558,0 3581,1 3642,0 3644,1 3699,0 3761,1 3793,0 3892,1 3966,0 4045,1 4132,0 4158,1 4247,0 4287,1 4329,0 4425,1 4448,0 4472,1 4486,0 4542,1 4565,0 4653,1 4690,0 4757,1 4775,0 4870,1 4889,0 4945,1 4954,0 5020,1 5040,0 5046,1 5108,0 5152,1 5211,0 5310,1 5320,0 5358,1 5363,0 5374,1 5445,0 5455,1 5534,0 5586,1 5609,0 5671,1 5688,0 5766,1 5794,0 5847,1 5912,0 5932,1 5957,0 5986,1 6043,0 6045,1 6112,0 6140,1 6221,0 6284,1 6308,0 6371,1 6375,0 6429,1 6465,0 6504,1 6552,0 6590,1 6617,0 6686,1 6698,0 6717,1 6731,0 6790,1 6863,0 6947,1 6999,0 7045,1 7050,0 7067,1 7091,0 7105,1 7152,0 7162,1 7233,0 7274,1 7291,0 7306,1 7324,0 7374,1 7408,0 7429,1 7483,0 7549,1 7568,0 7574,1 7576,0 7627,1 7718,0 7780,1 7830,0 7872,1 7953,0 7973,1 8015,0 8079,1 8106,0 8170,1 8196,0 8235,1 8236,0 8317,1 8366,0 8458,1 8491,0 8569,1 8628,0 8685,1 8686,0 8743,1 8797,0 8851,1 8873,0 8920,1 8926,0 8994,1 9079,0 9174,1 9268,0 9345,1 9418,0 9460,1 9521,0 9608,1 9667,0 9699,1 9767,0 9858,1 9863,0 9928,1 10019,0 10054,1 10112,0 10202,1 10229,0 10313,1 10328,0 10343,1 10375,0 10461,1 10490,0 10511,1 10517,0 10589,1 10635,0 10706,1 10794,0 10834,1 10851,0 10856,1 10904,0 10991,1 11001,0 11084,1 11111,0 11162,1 11186,0 11263,1 11296,0 11388,1 11450,0 11538,1 11566,0 11591,1 11657,0 11729,1 11774,0 11852,1 11932,0 11961,1 12032,0 12104,1 12172,0 12187,1 12207,0 12272,1 end initlist b102 0,0 38,1 138,0 226,1 249,0 290,1 327,0 385,1 476,0 520,1 605,0 704,1 756,0 819,1 883,0 943,1 979,0 1041,1 1051,0 1072,1 1107,0 1165,1 1197,0 1263,1 1294,0 1366,1 1464,0 1527,1 1565,0 1586,1 1660,0 1698,1 1702,0 1795,1 1866,0 1947,1 1956,0 1998,1 2092,0 2103,1 2119,0 2167,1 2262,0 2273,1 2308,0 2347,1 2381,0 2403,1 2463,0 2547,1 2593,0 2676,1 2757,0 2824,1 2909,0 2951,1 3009,0 3021,1 3060,0 3152,1 3228,0 3284,1 3322,0 3355,1 3455,0 3463,1 3497,0 3540,1 3632,0 3641,1 3719,0 3760,1 3805,0 3820,1 3830,0 3863,1 3960,0 3988,1 4082,0 4089,1 4173,0 4241,1 4314,0 4410,1 4417,0 4432,1 4441,0 4513,1 4534,0 4546,1 4599,0 4614,1 4630,0 4729,1 4799,0 4859,1 4885,0 4976,1 4999,0 5079,1 5176,0 5195,1 5205,0 5258,1 5311,0 5376,1 5453,0 5477,1 5499,0 5550,1 5572,0 5586,1 5641,0 5681,1 5741,0 5760,1 5802,0 5866,1 5928,0 5983,1 6022,0 6063,1 6155,0 6215,1 6251,0 6323,1 6369,0 6425,1 6507,0 6584,1 6647,0 6719,1 6800,0 6817,1 6871,0 6938,1 6943,0 6971,1 7007,0 7044,1 7123,0 7191,1 7248,0 7271,1 7318,0 7398,1 7455,0 7463,1 7495,0 7575,1 7591,0 7680,1 7761,0 7851,1 7948,0 8047,1 8115,0 8120,1 8194,0 8244,1 8297,0 8396,1 8450,0 8486,1 8503,0 8539,1 8613,0 8648,1 8710,0 8761,1 8829,0 8859,1 8893,0 8964,1 9027,0 9038,1 9129,0 9203,1 9301,0 9399,1 9404,0 9481,1 9533,0 9599,1 9694,0 9772,1 9832,0 9884,1 9909,0 9984,1 10077,0 10118,1 10138,0 10224,1 10227,0 10319,1 10358,0 10371,1 10459,0 10537,1 10579,0 10659,1 10741,0 10762,1 10788,0 10825,1 10899,0 10940,1 11008,0 11106,1 11167,0 11173,1 11177,0 11239,1 11320,0 11335,1 11349,0 11422,1 11477,0 11545,1 11579,0 11610,1 11611,0 11680,1 11731,0 11735,1 11762,0 11822,1 11902,0 11947,1 12004,0 12096,1 12179,0 12240,1 12247,0 12301,1 12352,0 12435,1 12449,0 12541,1 12568,0 12665,1 12702,0 12796,1 12843,0 12907,1 12930,0 12964,1 13060,0 13101,1 13197,0 13226,1 13318,0 13362,1 13421,0 13475,1 13523,0 13547,1 end initlist b103 0,0 99,1 151,0 221,1 254,0 322,1 398,0 469,1 488,0 512,1 523,0 537,1 615,0 618,1 685,0 748,1 840,0 903,1 948,0 1014,1 1082,0 1084,1 1158,0 1201,1 1214,0 1277,1 1311,0 1332,1 1374,0 1402,1 1446,0 1530,1 1569,0 1645,1 1744,0 1769,1 1850,0 1911,1 1940,0 2012,1 2075,0 2174,1 2200,0 2293,1 2349,0 2378,1 2412,0 2437,1 2518,0 2576,1 2585,0 2648,1 2673,0 2686,1 2703,0 2761,1 2850,0 2905,1 2916,0 2970,1 3041,0 3118,1 3132,0 3211,1 3215,0 3281,1 3353,0 3443,1 3519,0 3561,1 3636,0 3648,1 3706,0 3772,1 3828,0 3892,1 3987,0 4004,1 4060,0 4142,1 4209,0 4236,1 4293,0 4347,1 4419,0 4517,1 4617,0 4691,1 4737,0 4745,1 4747,0 4758,1 4797,0 4825,1 4904,0 4986,1 5010,0 5079,1 5117,0 5201,1 5216,0 5254,1 5300,0 5380,1 5405,0 5505,1 5553,0 5591,1 5675,0 5728,1 5774,0 5794,1 5876,0 5940,1 5943,0 5971,1 5999,0 6092,1 6124,0 6150,1 6240,0 6282,1 6361,0 6376,1 6462,0 6537,1 6603,0 6688,1 6754,0 6822,1 6831,0 6922,1 6946,0 6992,1 7088,0 7160,1 7178,0 7223,1 7284,0 7350,1 7411,0 7421,1 7434,0 7532,1 7573,0 7602,1 7646,0 7730,1 7732,0 7823,1 7883,0 7975,1 7991,0 8069,1 8104,0 8195,1 8233,0 8263,1 8348,0 8387,1 8412,0 8503,1 8531,0 8590,1 8610,0 8632,1 8715,0 8766,1 8782,0 8816,1 8906,0 8957,1 9004,0 9038,1 9074,0 9101,1 9186,0 9205,1 9260,0 9354,1 9423,0 9489,1 9519,0 9596,1 9599,0 9677,1 9777,0 9786,1 9878,0 9930,1 10005,0 10014,1 10016,0 10032,1 10080,0 10119,1 10187,0 10243,1 10313,0 10372,1 10470,0 10527,1 10567,0 10597,1 10634,0 10658,1 10679,0 10700,1 10757,0 10771,1 10778,0 10822,1 10884,0 10901,1 10993,0 11066,1 11090,0 11144,1 11182,0 11190,1 11267,0 11268,1 11306,0 11335,1 11384,0 11442,1 11485,0 11520,1 11592,0 11689,1 11787,0 11826,1 11862,0 11892,1 11898,0 11954,1 12053,0 12123,1 12220,0 12281,1 12354,0 12373,1 12418,0 12515,1 12556,0 12637,1 12641,0 12690,1 12780,0 12781,1 12852,0 12919,1 12964,0 13037,1 13085,0 13178,1 13191,0 13282,1 end initlist b104 0,0 18,1 114,0 187,1 247,0 326,1 339,0 405,1 413,0 512,1 572,0 596,1 695,0 783,1 819,0 834,1 910,0 994,1 1025,0 1092,1 1144,0 1221,1 1249,0 1251,1 1259,0 1332,1 1384,0 1432,1 1492,0 1552,1 1603,0 1660,1 1713,0 1764,1 1777,0 1850,1 1931,0 1992,1 2054,0 2130,1 2221,0 2300,1 2313,0 2396,1 2463,0 2486,1 2578,0 2605,1 2686,0 2751,1 2756,0 2804,1 2883,0 2901,1 2994,0 3045,1 3125,0 3126,1 3138,0 3177,1 3268,0 3345,1 3381,0 3460,1 3551,0 3580,1 3645,0 3710,1 3769,0 3781,1 3852,0 3930,1 4020,0 4059,1 4113,0 4153,1 4211,0 4238,1 4303,0 4333,1 4394,0 4424,1 4521,0 4532,1 4601,0 4625,1 4697,0 4708,1 4752,0 4846,1 4903,0 4957,1 4963,0 4992,1 5092,0 5094,1 5178,0 5199,1 5266,0 5362,1 5401,0 5479,1 5550,0 5642,1 5718,0 5806,1 5841,0 5909,1 5945,0 5992,1 6010,0 6052,1 6115,0 6169,1 6243,0 6268,1 6331,0 6390,1 6447,0 6537,1 6603,0 6609,1 6683,0 6713,1 6809,0 6818,1 6897,0 6964,1 6970,0 7011,1 7075,0 7106,1 7198,0 7254,1 7302,0 7320,1 7406,0 7496,1 7520,0 7540,1 7542,0 7600,1 7658,0 7673,1 7772,0 7777,1 7806,0 7866,1 7890,0 7982,1 7989,0 8056,1 8108,0 8120,1 8156,0 8248,1 8333,0 8346,1 8409,0 8504,1 8577,0 8628,1 8659,0 8715,1 8738,0 8780,1 8829,0 8843,1 8863,0 8866,1 8890,0 8900,1 8904,0 8909,1 8977,0 9053,1 9058,0 9112,1 9159,0 9256,1 9347,0 9365,1 9447,0 9543,1 9603,0 9641,1 9679,0 9760,1 9842,0 9885,1 9892,0 9947,1 9965,0 10018,1 10037,0 10104,1 10190,0 10290,1 10341,0 10409,1 10501,0 10569,1 10621,0 10662,1 10708,0 10737,1 10743,0 10833,1 10890,0 10895,1 10945,0 11013,1 11069,0 11101,1 11151,0 11238,1 11330,0 11408,1 11442,0 11498,1 11566,0 11587,1 11622,0 11717,1 11782,0 11801,1 11804,0 11818,1 11848,0 11849,1 11882,0 11957,1 12028,0 12032,1 12066,0 12110,1 12168,0 12190,1 12217,0 12238,1 12334,0 12429,1 12491,0 12547,1 12641,0 12736,1 12776,0 12834,1 12840,0 12868,1 12873,0 12900,1 12951,0 12999,1 13086,0 13171,1 13192,0 13209,1 end initlist b105 0,0 84,1 112,0 146,1 225,0 235,1 236,0 310,1 361,0 421,1 492,0 558,1 631,0 706,1 723,0 741,1 840,0 890,1 906,0 929,1 979,0 1044,1 1110,0 1210,1 1310,0 1321,1 1393,0 1457,1 1548,0 1613,1 1634,0 1700,1 1764,0 1846,1 1939,0 2033,1 2095,0 2159,1 2225,0 2278,1 2299,0 2354,1 2447,0 2458,1 2491,0 2579,1 2674,0 2741,1 2747,0 2842,1 2905,0 2925,1 2952,0 3034,1 3035,0 3053,1 3120,0 3212,1 3286,0 3314,1 3322,0 3342,1 3382,0 3454,1 3535,0 3627,1 3642,0 3732,1 3757,0 3800,1 3897,0 3935,1 4025,0 4034,1 4083,0 4165,1 4246,0 4323,1 4375,0 4466,1 4473,0 4506,1 4584,0 4642,1 4643,0 4676,1 4749,0 4775,1 4852,0 4897,1 4950,0 5003,1 5100,0 5128,1 5223,0 5227,1 5309,0 5336,1 5362,0 5460,1 5469,0 5527,1 5543,0 5602,1 5607,0 5632,1 5640,0 5730,1 5741,0 5766,1 5834,0 5842,1 5890,0 5915,1 5994,0 5998,1 6040,0 6058,1 6104,0 6121,1 6124,0 6170,1 6184,0 6197,1 6291,0 6316,1 6361,0 6425,1 6477,0 6501,1 6589,0 6686,1 6748,0 6786,1 6873,0 6910,1 6945,0 6970,1 7050,0 7107,1 7113,0 7165,1 7204,0 7237,1 7333,0 7433,1 7447,0 7492,1 7500,0 7546,1 7624,0 7708,1 7769,0 7831,1 7914,0 7962,1 8043,0 8059,1 8062,0 8074,1 8138,0 8177,1 8209,0 8218,1 8272,0 8273,1 8373,0 8432,1 8456,0 8527,1 8559,0 8611,1 8654,0 8752,1 8756,0 8766,1 8838,0 8862,1 8880,0 8941,1 8982,0 9005,1 9103,0 9113,1 9178,0 9267,1 9339,0 9390,1 9446,0 9494,1 9591,0 9616,1 9703,0 9705,1 9804,0 9842,1 9852,0 9916,1 9935,0 10034,1 10131,0 10181,1 10245,0 10275,1 10360,0 10442,1 10448,0 10457,1 10555,0 10602,1 10689,0 10722,1 10723,0 10742,1 10839,0 10881,1 10929,0 11024,1 11045,0 11121,1 11128,0 11188,1 11277,0 11318,1 11356,0 11425,1 11436,0 11478,1 11489,0 11567,1 11630,0 11675,1 11749,0 11816,1 11900,0 11928,1 11935,0 12008,1 12042,0 12074,1 12079,0 12149,1 12173,0 12177,1 12178,0 12243,1 12298,0 12376,1 12393,0 12477,1 12551,0 12580,1 12626,0 12717,1 12730,0 12770,1 12780,0 12797,1 end initlist b106 0,0 50,1 58,0 80,1 87,0 140,1 210,0 234,1 244,0 289,1 353,0 448,1 482,0 490,1 563,0 623,1 717,0 816,1 879,0 964,1 999,0 1071,1 1098,0 1183,1 1245,0 1279,1 1367,0 1418,1 1491,0 1556,1 1656,0 1712,1 1767,0 1833,1 1883,0 1972,1 1989,0 2072,1 2165,0 2197,1 2217,0 2296,1 2381,0 2476,1 2557,0 2606,1 2702,0 2758,1 2846,0 2924,1 3015,0 3018,1 3075,0 3122,1 3222,0 3247,1 3278,0 3322,1 3420,0 3483,1 3556,0 3567,1 3569,0 3618,1 3687,0 3769,1 3786,0 3834,1 3861,0 3937,1 4037,0 4047,1 4071,0 4161,1 4189,0 4215,1 4234,0 4315,1 4382,0 4397,1 4436,0 4501,1 4526,0 4557,1 4566,0 4627,1 4686,0 4696,1 4770,0 4825,1 4922,0 5022,1 5045,0 5098,1 5106,0 5196,1 5274,0 5323,1 5354,0 5376,1 5436,0 5481,1 5532,0 5548,1 5633,0 5689,1 5709,0 5755,1 5842,0 5866,1 5966,0 6021,1 6040,0 6062,1 6151,0 6239,1 6279,0 6377,1 6477,0 6542,1 6623,0 6641,1 6662,0 6681,1 6687,0 6696,1 6778,0 6781,1 6819,0 6900,1 6916,0 6933,1 6984,0 7031,1 7072,0 7094,1 7111,0 7192,1 7290,0 7373,1 7454,0 7479,1 7536,0 7613,1 7647,0 7743,1 7781,0 7876,1 7957,0 8030,1 8035,0 8050,1 8110,0 8171,1 8205,0 8297,1 8320,0 8369,1 8458,0 8524,1 8570,0 8609,1 8681,0 8693,1 8758,0 8806,1 8861,0 8945,1 8946,0 8998,1 9070,0 9083,1 9175,0 9239,1 9302,0 9310,1 9311,0 9329,1 9401,0 9436,1 9519,0 9527,1 9541,0 9583,1 9667,0 9759,1 9801,0 9840,1 9850,0 9902,1 9935,0 9971,1 10059,0 10072,1 10112,0 10161,1 10234,0 10299,1 10371,0 10433,1 10512,0 10563,1 10652,0 10665,1 10677,0 10691,1 10772,0 10837,1 10924,0 10944,1 11005,0 11062,1 11095,0 11101,1 11169,0 11201,1 11231,0 11316,1 11347,0 11416,1 11468,0 11480,1 11558,0 11569,1 11572,0 11605,1 11611,0 11618,1 11644,0 11680,1 11746,0 11794,1 11845,0 11925,1 11990,0 12041,1 12104,0 12174,1 12266,0 12347,1 12439,0 12460,1 12500,0 12569,1 12583,0 12653,1 12738,0 12779,1 12833,0 12925,1 13012,0 13090,1 13127,0 13195,1 13202,0 13286,1 13365,0 13452,1 end initlist b107 0,0 95,1 185,0 282,1 341,0 395,1 436,0 471,1 499,0 502,1 558,0 648,1 676,0 714,1 760,0 850,1 873,0 891,1 981,0 1010,1 1038,0 1130,1 1174,0 1225,1 1268,0 1306,1 1365,0 1369,1 1450,0 1508,1 1541,0 1604,1 1676,0 1682,1 1774,0 1795,1 1849,0 1887,1 1911,0 1960,1 2011,0 2087,1 2115,0 2194,1 2234,0 2308,1 2320,0 2328,1 2414,0 2472,1 2558,0 2632,1 2633,0 2722,1 2726,0 2786,1 2851,0 2935,1 3001,0 3037,1 3077,0 3084,1 3088,0 3105,1 3144,0 3188,1 3262,0 3357,1 3364,0 3368,1 3461,0 3505,1 3515,0 3524,1 3546,0 3587,1 3600,0 3682,1 3694,0 3765,1 3777,0 3837,1 3890,0 3972,1 4046,0 4137,1 4163,0 4214,1 4307,0 4354,1 4442,0 4493,1 4504,0 4526,1 4553,0 4623,1 4709,0 4797,1 4816,0 4902,1 4927,0 4930,1 5022,0 5078,1 5083,0 5102,1 5172,0 5183,1 5271,0 5363,1 5406,0 5490,1 5588,0 5617,1 5625,0 5723,1 5733,0 5808,1 5836,0 5887,1 5987,0 5995,1 6076,0 6105,1 6117,0 6179,1 6212,0 6239,1 6277,0 6324,1 6331,0 6423,1 6502,0 6599,1 6696,0 6719,1 6790,0 6839,1 6928,0 6955,1 7017,0 7079,1 7149,0 7223,1 7233,0 7275,1 7280,0 7324,1 7394,0 7409,1 7411,0 7467,1 7483,0 7544,1 7553,0 7595,1 7634,0 7691,1 7788,0 7865,1 7935,0 7996,1 8049,0 8061,1 8119,0 8205,1 8302,0 8313,1 8390,0 8458,1 8475,0 8492,1 8581,0 8652,1 8732,0 8802,1 8823,0 8912,1 8978,0 8990,1 9067,0 9102,1 9190,0 9281,1 9354,0 9412,1 9453,0 9474,1 9487,0 9510,1 9593,0 9640,1 9666,0 9762,1 9841,0 9914,1 9920,0 10014,1 10053,0 10054,1 10134,0 10197,1 10231,0 10294,1 10319,0 10388,1 10457,0 10513,1 10581,0 10612,1 10658,0 10687,1 10768,0 10795,1 10831,0 10871,1 10896,0 10968,1 11027,0 11048,1 11124,0 11183,1 11198,0 11259,1 11336,0 11413,1 11456,0 11521,1 11599,0 11646,1 11709,0 11805,1 11889,0 11983,1 12001,0 12077,1 12128,0 12169,1 12245,0 12287,1 12367,0 12388,1 12488,0 12558,1 12628,0 12631,1 12721,0 12753,1 12767,0 12815,1 12838,0 12868,1 12879,0 12966,1 13018,0 13066,1 13140,0 13145,1 end initlist b108 0,0 99,1 125,0 195,1 290,0 384,1 469,0 525,1 569,0 650,1 702,0 744,1 765,0 809,1 830,0 843,1 883,0 973,1 1017,0 1103,1 1115,0 1160,1 1165,0 1258,1 1331,0 1374,1 1446,0 1463,1 1527,0 1620,1 1671,0 1714,1 1742,0 1764,1 1805,0 1882,1 1923,0 1960,1 1982,0 2023,1 2053,0 2095,1 2127,0 2137,1 2168,0 2208,1 2250,0 2315,1 2319,0 2411,1 2417,0 2496,1 2572,0 2615,1 2623,0 2626,1 2659,0 2671,1 2720,0 2811,1 2856,0 2925,1 3008,0 3079,1 3175,0 3230,1 3325,0 3346,1 3356,0 3381,1 3448,0 3489,1 3503,0 3582,1 3630,0 3729,1 3793,0 3882,1 3948,0 3951,1 4031,0 4080,1 4144,0 4220,1 4231,0 4263,1 4355,0 4367,1 4460,0 4503,1 4591,0 4675,1 4689,0 4778,1 4869,0 4904,1 4959,0 4989,1 5020,0 5022,1 5034,0 5094,1 5136,0 5229,1 5294,0 5311,1 5384,0 5435,1 5523,0 5598,1 5642,0 5699,1 5776,0 5794,1 5802,0 5880,1 5934,0 5995,1 6042,0 6134,1 6191,0 6260,1 6282,0 6335,1 6394,0 6449,1 6507,0 6535,1 6571,0 6573,1 6641,0 6667,1 6733,0 6754,1 6800,0 6803,1 6834,0 6934,1 6983,0 7000,1 7003,0 7055,1 7121,0 7151,1 7195,0 7253,1 7275,0 7354,1 7432,0 7483,1 7491,0 7566,1 7622,0 7670,1 7738,0 7827,1 7863,0 7899,1 7919,0 7940,1 8024,0 8087,1 8110,0 8164,1 8166,0 8224,1 8311,0 8395,1 8452,0 8546,1 8577,0 8630,1 8645,0 8674,1 8718,0 8801,1 8839,0 8866,1 8896,0 8907,1 8922,0 9008,1 9029,0 9069,1 9088,0 9114,1 9168,0 9211,1 9267,0 9283,1 9307,0 9327,1 9405,0 9474,1 9563,0 9591,1 9623,0 9673,1 9747,0 9804,1 9817,0 9889,1 9892,0 9945,1 10005,0 10061,1 10128,0 10156,1 10167,0 10176,1 10197,0 10206,1 10270,0 10364,1 10443,0 10523,1 10587,0 10599,1 10632,0 10657,1 10721,0 10813,1 10899,0 10967,1 11059,0 11103,1 11126,0 11144,1 11239,0 11299,1 11325,0 11368,1 11441,0 11477,1 11486,0 11549,1 11594,0 11682,1 11758,0 11854,1 11912,0 11960,1 11972,0 11977,1 11987,0 12026,1 12035,0 12129,1 12205,0 12210,1 12256,0 12260,1 12313,0 12370,1 12374,0 12412,1 12456,0 12555,1 end initlist b109 0,0 88,1 132,0 203,1 243,0 279,1 302,0 397,1 418,0 472,1 511,0 559,1 609,0 632,1 649,0 730,1 753,0 834,1 872,0 896,1 900,0 937,1 1004,0 1013,1 1049,0 1123,1 1201,0 1263,1 1283,0 1355,1 1421,0 1513,1 1537,0 1541,1 1564,0 1640,1 1683,0 1739,1 1834,0 1893,1 1924,0 1954,1 2041,0 2066,1 2145,0 2193,1 2268,0 2295,1 2313,0 2357,1 2359,0 2439,1 2531,0 2626,1 2701,0 2765,1 2828,0 2873,1 2924,0 2931,1 2953,0 2989,1 3069,0 3087,1 3092,0 3141,1 3225,0 3240,1 3324,0 3367,1 3459,0 3464,1 3521,0 3621,1 3660,0 3740,1 3814,0 3854,1 3925,0 3954,1 3995,0 3997,1 4094,0 4143,1 4152,0 4172,1 4242,0 4246,1 4324,0 4343,1 4413,0 4510,1 4597,0 4659,1 4732,0 4780,1 4782,0 4860,1 4878,0 4903,1 4905,0 4917,1 5017,0 5042,1 5074,0 5088,1 5104,0 5144,1 5152,0 5164,1 5223,0 5248,1 5284,0 5319,1 5347,0 5354,1 5426,0 5507,1 5606,0 5647,1 5714,0 5747,1 5824,0 5912,1 5975,0 6020,1 6081,0 6155,1 6214,0 6302,1 6391,0 6460,1 6535,0 6597,1 6631,0 6696,1 6764,0 6848,1 6877,0 6975,1 7036,0 7097,1 7101,0 7187,1 7227,0 7285,1 7385,0 7410,1 7500,0 7505,1 7604,0 7653,1 7737,0 7766,1 7787,0 7804,1 7904,0 7926,1 8017,0 8025,1 8099,0 8194,1 8273,0 8301,1 8340,0 8345,1 8364,0 8431,1 8452,0 8533,1 8599,0 8652,1 8667,0 8717,1 8812,0 8824,1 8865,0 8890,1 8961,0 9039,1 9120,0 9152,1 9176,0 9240,1 9321,0 9353,1 9430,0 9506,1 9531,0 9568,1 9609,0 9639,1 9640,0 9707,1 9807,0 9843,1 9899,0 9962,1 9984,0 10011,1 10060,0 10065,1 10075,0 10101,1 10158,0 10222,1 10313,0 10359,1 10434,0 10443,1 10534,0 10553,1 10613,0 10676,1 10726,0 10732,1 10776,0 10794,1 10831,0 10896,1 10944,0 10949,1 11008,0 11082,1 11091,0 11154,1 11191,0 11209,1 11295,0 11375,1 11472,0 11473,1 11567,0 11638,1 11692,0 11763,1 11824,0 11915,1 11935,0 11984,1 12006,0 12017,1 12117,0 12204,1 12255,0 12300,1 12315,0 12397,1 12489,0 12521,1 12620,0 12705,1 12769,0 12794,1 12888,0 12903,1 12980,0 13008,1 end initlist b110 0,0 54,1 124,0 131,1 223,0 301,1 317,0 370,1 431,0 470,1 524,0 590,1 677,0 684,1 781,0 828,1 879,0 898,1 978,0 1062,1 1103,0 1137,1 1153,0 1230,1 1325,0 1355,1 1369,0 1458,1 1550,0 1627,1 1709,0 1753,1 1851,0 1888,1 1927,0 1971,1 1981,0 2061,1 2095,0 2174,1 2176,0 2267,1 2306,0 2343,1 2394,0 2457,1 2498,0 2537,1 2635,0 2729,1 2779,0 2792,1 2834,0 2878,1 2939,0 2991,1 3047,0 3073,1 3088,0 3178,1 3247,0 3332,1 3408,0 3503,1 3559,0 3657,1 3708,0 3752,1 3824,0 3878,1 3895,0 3963,1 3971,0 4056,1 4092,0 4116,1 4205,0 4299,1 4378,0 4470,1 4541,0 4578,1 4654,0 4667,1 4732,0 4767,1 4799,0 4837,1 4876,0 4928,1 4959,0 5008,1 5052,0 5106,1 5125,0 5132,1 5230,0 5244,1 5277,0 5332,1 5432,0 5482,1 5534,0 5610,1 5651,0 5654,1 5710,0 5807,1 5903,0 5979,1 5985,0 6070,1 6153,0 6165,1 6218,0 6220,1 6307,0 6310,1 6339,0 6391,1 6427,0 6500,1 6519,0 6544,1 6597,0 6682,1 6683,0 6700,1 6758,0 6790,1 6878,0 6936,1 6963,0 6994,1 7067,0 7086,1 7133,0 7151,1 7177,0 7269,1 7287,0 7337,1 7400,0 7403,1 7454,0 7481,1 7536,0 7581,1 7652,0 7742,1 7818,0 7866,1 7954,0 8018,1 8077,0 8124,1 8215,0 8298,1 8358,0 8426,1 8461,0 8463,1 8521,0 8617,1 8646,0 8739,1 8777,0 8790,1 8795,0 8873,1 8892,0 8911,1 8945,0 9028,1 9098,0 9159,1 9215,0 9286,1 9309,0 9386,1 9414,0 9464,1 9513,0 9522,1 9542,0 9559,1 9567,0 9568,1 9647,0 9650,1 9716,0 9780,1 9861,0 9942,1 9987,0 10051,1 10082,0 10124,1 10138,0 10227,1 10272,0 10285,1 10317,0 10401,1 10420,0 10467,1 10526,0 10593,1 10665,0 10712,1 10733,0 10746,1 10810,0 10908,1 10933,0 10988,1 11049,0 11070,1 11101,0 11155,1 11189,0 11219,1 11249,0 11257,1 11344,0 11406,1 11427,0 11520,1 11531,0 11609,1 11619,0 11664,1 11755,0 11792,1 11880,0 11964,1 11993,0 12058,1 12143,0 12225,1 12256,0 12318,1 12339,0 12414,1 12484,0 12567,1 12583,0 12680,1 12690,0 12736,1 12806,0 12877,1 12962,0 13012,1 13028,0 13081,1 13122,0 13202,1 end initlist b111 0,0 92,1 180,0 263,1 289,0 303,1 381,0 447,1 530,0 620,1 625,0 686,1 760,0 806,1 839,0 906,1 912,0 960,1 1060,0 1155,1 1206,0 1228,1 1243,0 1246,1 1337,0 1340,1 1407,0 1495,1 1562,0 1652,1 1675,0 1751,1 1786,0 1837,1 1907,0 1987,1 2067,0 2155,1 2214,0 2236,1 2262,0 2343,1 2436,0 2478,1 2536,0 2608,1 2615,0 2713,1 2799,0 2862,1 2943,0 3004,1 3031,0 3108,1 3189,0 3201,1 3243,0 3265,1 3317,0 3414,1 3430,0 3490,1 3550,0 3637,1 3735,0 3821,1 3888,0 3894,1 3895,0 3957,1 4031,0 4066,1 4107,0 4183,1 4214,0 4302,1 4399,0 4428,1 4435,0 4514,1 4575,0 4582,1 4654,0 4719,1 4808,0 4815,1 4914,0 4967,1 5059,0 5077,1 5090,0 5122,1 5133,0 5188,1 5228,0 5275,1 5304,0 5384,1 5396,0 5398,1 5410,0 5495,1 5513,0 5538,1 5581,0 5671,1 5764,0 5858,1 5942,0 6033,1 6124,0 6125,1 6141,0 6211,1 6244,0 6260,1 6319,0 6400,1 6496,0 6519,1 6594,0 6675,1 6762,0 6857,1 6946,0 7045,1 7049,0 7134,1 7214,0 7278,1 7362,0 7432,1 7496,0 7569,1 7624,0 7657,1 7735,0 7769,1 7868,0 7963,1 8020,0 8042,1 8106,0 8163,1 8208,0 8240,1 8282,0 8345,1 8430,0 8510,1 8537,0 8579,1 8635,0 8728,1 8802,0 8898,1 8998,0 9022,1 9093,0 9158,1 9174,0 9235,1 9297,0 9312,1 9400,0 9422,1 9446,0 9479,1 9558,0 9579,1 9622,0 9679,1 9684,0 9718,1 9784,0 9832,1 9912,0 9942,1 9984,0 10042,1 10090,0 10140,1 10175,0 10211,1 10248,0 10309,1 10346,0 10360,1 10443,0 10516,1 10574,0 10602,1 10613,0 10693,1 10715,0 10759,1 10779,0 10791,1 10809,0 10811,1 10888,0 10914,1 10947,0 10983,1 11066,0 11117,1 11212,0 11283,1 11297,0 11390,1 11448,0 11460,1 11509,0 11591,1 11614,0 11623,1 11644,0 11668,1 11713,0 11786,1 11877,0 11925,1 12008,0 12043,1 12111,0 12118,1 12158,0 12244,1 12259,0 12330,1 12334,0 12344,1 12433,0 12497,1 12590,0 12661,1 12662,0 12707,1 12752,0 12784,1 12861,0 12862,1 12908,0 12992,1 13020,0 13093,1 13169,0 13240,1 13330,0 13333,1 13432,0 13492,1 13494,0 13536,1 13618,0 13689,1 13702,0 13749,1 end initlist b112 0,0 47,1 114,0 143,1 189,0 214,1 301,0 343,1 362,0 449,1 494,0 524,1 611,0 681,1 734,0 750,1 764,0 778,1 836,0 897,1 906,0 907,1 954,0 996,1 1026,0 1033,1 1080,0 1161,1 1179,0 1277,1 1329,0 1339,1 1394,0 1478,1 1480,0 1481,1 1497,0 1525,1 1625,0 1716,1 1804,0 1900,1 1979,0 2052,1 2115,0 2170,1 2262,0 2273,1 2300,0 2379,1 2440,0 2529,1 2563,0 2583,1 2621,0 2665,1 2682,0 2723,1 2783,0 2806,1 2884,0 2974,1 3066,0 3124,1 3145,0 3156,1 3207,0 3291,1 3316,0 3402,1 3404,0 3464,1 3548,0 3569,1 3661,0 3713,1 3718,0 3748,1 3813,0 3913,1 4010,0 4099,1 4168,0 4194,1 4236,0 4306,1 4380,0 4417,1 4423,0 4457,1 4512,0 4565,1 4638,0 4653,1 4726,0 4727,1 4780,0 4799,1 4879,0 4975,1 5025,0 5070,1 5074,0 5158,1 5207,0 5248,1 5345,0 5417,1 5508,0 5591,1 5676,0 5728,1 5814,0 5893,1 5937,0 6035,1 6087,0 6152,1 6162,0 6223,1 6281,0 6353,1 6386,0 6390,1 6488,0 6517,1 6594,0 6611,1 6711,0 6798,1 6799,0 6808,1 6894,0 6949,1 6962,0 7040,1 7068,0 7161,1 7222,0 7310,1 7370,0 7378,1 7467,0 7498,1 7584,0 7590,1 7660,0 7720,1 7728,0 7794,1 7817,0 7859,1 7877,0 7895,1 7964,0 8015,1 8056,0 8114,1 8131,0 8167,1 8246,0 8298,1 8302,0 8358,1 8441,0 8485,1 8570,0 8665,1 8709,0 8720,1 8721,0 8775,1 8866,0 8930,1 9027,0 9050,1 9108,0 9111,1 9127,0 9171,1 9230,0 9232,1 9271,0 9351,1 9376,0 9406,1 9489,0 9514,1 9523,0 9615,1 9647,0 9667,1 9716,0 9736,1 9806,0 9891,1 9970,0 10029,1 10086,0 10106,1 10156,0 10239,1 10287,0 10366,1 10464,0 10529,1 10575,0 10618,1 10666,0 10687,1 10783,0 10874,1 10940,0 10951,1 11020,0 11030,1 11033,0 11053,1 11061,0 11139,1 11142,0 11191,1 11274,0 11355,1 11430,0 11518,1 11603,0 11630,1 11722,0 11774,1 11861,0 11911,1 11981,0 12051,1 12093,0 12150,1 12248,0 12328,1 12396,0 12408,1 12430,0 12515,1 12574,0 12579,1 12671,0 12702,1 12782,0 12850,1 12934,0 13031,1 13054,0 13094,1 13177,0 13233,1 13246,0 13302,1 13355,0 13367,1 end initlist b113 0,0 27,1 31,0 49,1 96,0 170,1 183,0 202,1 242,0 338,1 349,0 433,1 496,0 531,1 543,0 622,1 660,0 734,1 829,0 844,1 941,0 1007,1 1026,0 1044,1 1098,0 1166,1 1180,0 1255,1 1263,0 1265,1 1291,0 1306,1 1383,0 1435,1 1497,0 1574,1 1611,0 1700,1 1768,0 1786,1 1855,0 1944,1 1949,0 2021,1 2113,0 2160,1 2168,0 2245,1 2250,0 2297,1 2340,0 2361,1 2370,0 2427,1 2526,0 2543,1 2584,0 2607,1 2675,0 2737,1 2776,0 2869,1 2956,0 3051,1 3077,0 3138,1 3177,0 3242,1 3310,0 3388,1 3436,0 3515,1 3567,0 3605,1 3683,0 3744,1 3794,0 3892,1 3947,0 3988,1 4029,0 4059,1 4111,0 4139,1 4230,0 4254,1 4269,0 4357,1 4441,0 4522,1 4589,0 4616,1 4689,0 4698,1 4762,0 4852,1 4932,0 4992,1 5048,0 5108,1 5161,0 5244,1 5328,0 5420,1 5503,0 5592,1 5629,0 5689,1 5784,0 5854,1 5916,0 6001,1 6094,0 6157,1 6182,0 6270,1 6291,0 6327,1 6384,0 6477,1 6559,0 6634,1 6734,0 6811,1 6899,0 6941,1 7029,0 7086,1 7104,0 7107,1 7156,0 7186,1 7258,0 7296,1 7362,0 7441,1 7485,0 7570,1 7646,0 7676,1 7760,0 7776,1 7830,0 7845,1 7904,0 7917,1 7943,0 7956,1 8022,0 8119,1 8194,0 8196,1 8251,0 8252,1 8298,0 8314,1 8367,0 8404,1 8502,0 8529,1 8588,0 8617,1 8630,0 8727,1 8731,0 8803,1 8897,0 8948,1 9015,0 9077,1 9135,0 9228,1 9321,0 9387,1 9463,0 9507,1 9558,0 9599,1 9664,0 9750,1 9821,0 9860,1 9920,0 9992,1 10068,0 10164,1 10199,0 10201,1 10289,0 10329,1 10350,0 10395,1 10487,0 10564,1 10565,0 10664,1 10702,0 10798,1 10858,0 10888,1 10986,0 11004,1 11021,0 11078,1 11149,0 11172,1 11178,0 11267,1 11321,0 11381,1 11454,0 11550,1 11613,0 11618,1 11715,0 11735,1 11779,0 11791,1 11845,0 11896,1 11990,0 12037,1 12108,0 12133,1 12139,0 12143,1 12171,0 12187,1 12216,0 12312,1 12336,0 12411,1 12452,0 12462,1 12486,0 12490,1 12498,0 12582,1 12591,0 12673,1 12674,0 12711,1 12805,0 12859,1 12865,0 12938,1 12953,0 12975,1 13017,0 13062,1 13101,0 13129,1 13229,0 13242,1 13265,0 13305,1 13386,0 13458,1 end initlist b114 0,0 24,1 110,0 131,1 135,0 151,1 230,0 232,1 255,0 328,1 330,0 361,1 409,0 503,1 564,0 595,1 665,0 737,1 770,0 841,1 922,0 936,1 943,0 983,1 1043,0 1059,1 1139,0 1224,1 1292,0 1310,1 1330,0 1403,1 1447,0 1451,1 1539,0 1558,1 1642,0 1673,1 1732,0 1735,1 1800,0 1838,1 1909,0 1918,1 1967,0 1985,1 2062,0 2129,1 2148,0 2203,1 2298,0 2356,1 2444,0 2536,1 2609,0 2698,1 2768,0 2798,1 2861,0 2880,1 2968,0 2995,1 3076,0 3130,1 3174,0 3255,1 3271,0 3302,1 3390,0 3453,1 3474,0 3491,1 3532,0 3571,1 3650,0 3743,1 3823,0 3913,1 3990,0 4068,1 4078,0 4163,1 4202,0 4236,1 4274,0 4311,1 4410,0 4455,1 4468,0 4489,1 4492,0 4566,1 4640,0 4692,1 4766,0 4817,1 4849,0 4941,1 4958,0 5012,1 5042,0 5059,1 5085,0 5141,1 5187,0 5271,1 5360,0 5423,1 5462,0 5482,1 5487,0 5552,1 5640,0 5660,1 5689,0 5706,1 5765,0 5796,1 5883,0 5975,1 6055,0 6143,1 6199,0 6260,1 6346,0 6445,1 6504,0 6549,1 6586,0 6659,1 6682,0 6717,1 6752,0 6816,1 6839,0 6920,1 6963,0 6987,1 7023,0 7033,1 7095,0 7169,1 7252,0 7276,1 7325,0 7358,1 7412,0 7497,1 7561,0 7574,1 7659,0 7660,1 7705,0 7803,1 7810,0 7834,1 7918,0 7983,1 8073,0 8133,1 8145,0 8193,1 8243,0 8312,1 8406,0 8485,1 8563,0 8637,1 8691,0 8769,1 8828,0 8846,1 8935,0 9008,1 9014,0 9049,1 9067,0 9105,1 9167,0 9191,1 9283,0 9344,1 9401,0 9478,1 9519,0 9609,1 9661,0 9735,1 9762,0 9775,1 9821,0 9835,1 9872,0 9933,1 10014,0 10095,1 10102,0 10121,1 10203,0 10227,1 10264,0 10335,1 10394,0 10493,1 10498,0 10586,1 10599,0 10630,1 10640,0 10646,1 10670,0 10673,1 10715,0 10735,1 10755,0 10801,1 10845,0 10858,1 10891,0 10968,1 11046,0 11104,1 11154,0 11219,1 11271,0 11296,1 11320,0 11360,1 11386,0 11466,1 11518,0 11598,1 11682,0 11730,1 11742,0 11748,1 11770,0 11863,1 11946,0 12035,1 12063,0 12163,1 12244,0 12335,1 12393,0 12454,1 12487,0 12523,1 12620,0 12689,1 12747,0 12820,1 12885,0 12923,1 12972,0 12990,1 13031,0 13049,1 end initlist b115 0,0 56,1 109,0 190,1 191,0 194,1 210,0 303,1 397,0 405,1 418,0 451,1 458,0 554,1 557,0 611,1 709,0 720,1 814,0 910,1 990,0 1050,1 1140,0 1185,1 1274,0 1334,1 1393,0 1443,1 1541,0 1621,1 1643,0 1674,1 1761,0 1792,1 1890,0 1908,1 1951,0 1974,1 2034,0 2102,1 2138,0 2186,1 2258,0 2261,1 2351,0 2374,1 2456,0 2527,1 2565,0 2647,1 2693,0 2742,1 2773,0 2842,1 2914,0 2928,1 2931,0 2984,1 3084,0 3135,1 3193,0 3280,1 3309,0 3369,1 3375,0 3461,1 3501,0 3511,1 3524,0 3531,1 3572,0 3666,1 3712,0 3779,1 3808,0 3852,1 3890,0 3975,1 3999,0 4080,1 4135,0 4163,1 4165,0 4221,1 4319,0 4341,1 4357,0 4448,1 4505,0 4525,1 4527,0 4606,1 4704,0 4742,1 4790,0 4838,1 4881,0 4886,1 4958,0 5039,1 5110,0 5122,1 5217,0 5253,1 5281,0 5291,1 5319,0 5334,1 5359,0 5396,1 5414,0 5467,1 5504,0 5513,1 5517,0 5578,1 5674,0 5768,1 5826,0 5882,1 5899,0 5905,1 5917,0 5936,1 5953,0 6039,1 6095,0 6137,1 6212,0 6294,1 6342,0 6353,1 6425,0 6481,1 6572,0 6588,1 6598,0 6631,1 6697,0 6706,1 6750,0 6770,1 6792,0 6857,1 6924,0 7019,1 7057,0 7117,1 7143,0 7218,1 7229,0 7243,1 7266,0 7300,1 7389,0 7417,1 7438,0 7467,1 7476,0 7538,1 7553,0 7594,1 7640,0 7685,1 7781,0 7818,1 7837,0 7847,1 7855,0 7926,1 7961,0 8027,1 8126,0 8164,1 8233,0 8312,1 8401,0 8433,1 8495,0 8595,1 8630,0 8646,1 8678,0 8756,1 8782,0 8811,1 8900,0 8990,1 9070,0 9085,1 9089,0 9111,1 9199,0 9257,1 9272,0 9355,1 9372,0 9382,1 9472,0 9501,1 9515,0 9530,1 9555,0 9634,1 9728,0 9737,1 9789,0 9797,1 9863,0 9894,1 9932,0 9997,1 10051,0 10097,1 10116,0 10163,1 10236,0 10310,1 10340,0 10406,1 10417,0 10463,1 10508,0 10561,1 10580,0 10615,1 10668,0 10752,1 10801,0 10874,1 10879,0 10895,1 10931,0 10992,1 10996,0 11012,1 11081,0 11112,1 11140,0 11157,1 11210,0 11253,1 11272,0 11286,1 11315,0 11354,1 11365,0 11411,1 11500,0 11554,1 11625,0 11640,1 11673,0 11703,1 11760,0 11856,1 11927,0 12009,1 end initlist b116 0,0 71,1 110,0 152,1 161,0 198,1 224,0 298,1 370,0 430,1 467,0 504,1 538,0 550,1 568,0 631,1 687,0 736,1 737,0 762,1 817,0 832,1 885,0 973,1 1025,0 1086,1 1099,0 1148,1 1178,0 1187,1 1193,0 1280,1 1328,0 1415,1 1482,0 1535,1 1583,0 1657,1 1682,0 1731,1 1736,0 1764,1 1797,0 1871,1 1906,0 1989,1 2084,0 2139,1 2214,0 2233,1 2286,0 2326,1 2345,0 2375,1 2462,0 2558,1 2585,0 2601,1 2632,0 2729,1 2785,0 2865,1 2884,0 2976,1 3034,0 3043,1 3117,0 3174,1 3249,0 3331,1 3404,0 3462,1 3524,0 3592,1 3647,0 3746,1 3832,0 3912,1 3932,0 3937,1 3966,0 3998,1 4029,0 4102,1 4185,0 4195,1 4283,0 4379,1 4413,0 4475,1 4494,0 4524,1 4586,0 4622,1 4650,0 4746,1 4846,0 4889,1 4926,0 4972,1 5032,0 5059,1 5078,0 5172,1 5266,0 5301,1 5371,0 5379,1 5406,0 5422,1 5436,0 5442,1 5495,0 5519,1 5565,0 5579,1 5609,0 5619,1 5676,0 5756,1 5796,0 5889,1 5936,0 6005,1 6089,0 6142,1 6173,0 6230,1 6254,0 6344,1 6396,0 6461,1 6502,0 6520,1 6608,0 6688,1 6719,0 6720,1 6814,0 6822,1 6846,0 6919,1 7001,0 7053,1 7059,0 7155,1 7209,0 7296,1 7346,0 7427,1 7511,0 7552,1 7627,0 7639,1 7693,0 7766,1 7843,0 7884,1 7965,0 8003,1 8086,0 8163,1 8170,0 8197,1 8215,0 8222,1 8300,0 8380,1 8456,0 8523,1 8593,0 8690,1 8707,0 8734,1 8832,0 8876,1 8938,0 8943,1 8956,0 8963,1 9030,0 9076,1 9114,0 9163,1 9240,0 9324,1 9377,0 9471,1 9473,0 9498,1 9505,0 9543,1 9629,0 9694,1 9712,0 9789,1 9798,0 9806,1 9850,0 9864,1 9877,0 9895,1 9907,0 9951,1 10005,0 10044,1 10116,0 10203,1 10231,0 10289,1 10307,0 10309,1 10342,0 10363,1 10416,0 10499,1 10580,0 10639,1 10678,0 10725,1 10728,0 10756,1 10800,0 10805,1 10808,0 10907,1 10996,0 11023,1 11034,0 11114,1 11213,0 11268,1 11349,0 11435,1 11530,0 11548,1 11585,0 11673,1 11728,0 11734,1 11782,0 11851,1 11945,0 11984,1 12054,0 12077,1 12137,0 12183,1 12274,0 12297,1 12356,0 12412,1 12455,0 12553,1 12581,0 12605,1 12672,0 12703,1 end initlist b117 0,0 39,1 81,0 108,1 134,0 230,1 263,0 330,1 373,0 386,1 398,0 440,1 505,0 542,1 592,0 618,1 641,0 712,1 727,0 822,1 840,0 868,1 890,0 990,1 1004,0 1090,1 1117,0 1142,1 1186,0 1187,1 1287,0 1331,1 1416,0 1462,1 1464,0 1563,1 1611,0 1643,1 1654,0 1714,1 1716,0 1797,1 1824,0 1890,1 1901,0 1976,1 1998,0 2034,1 2130,0 2140,1 2206,0 2276,1 2333,0 2380,1 2414,0 2415,1 2474,0 2525,1 2618,0 2685,1 2712,0 2796,1 2891,0 2978,1 2981,0 3046,1 3052,0 3149,1 3180,0 3211,1 3291,0 3318,1 3378,0 3387,1 3427,0 3469,1 3485,0 3499,1 3589,0 3645,1 3735,0 3759,1 3780,0 3832,1 3887,0 3905,1 3943,0 3975,1 4057,0 4134,1 4211,0 4284,1 4325,0 4379,1 4458,0 4520,1 4537,0 4600,1 4658,0 4688,1 4766,0 4814,1 4828,0 4881,1 4911,0 4925,1 4955,0 5030,1 5085,0 5131,1 5162,0 5243,1 5257,0 5296,1 5383,0 5447,1 5505,0 5592,1 5600,0 5621,1 5659,0 5737,1 5780,0 5834,1 5892,0 5988,1 6011,0 6075,1 6093,0 6113,1 6207,0 6208,1 6274,0 6324,1 6380,0 6470,1 6501,0 6513,1 6517,0 6574,1 6671,0 6725,1 6774,0 6837,1 6925,0 6976,1 7055,0 7113,1 7158,0 7247,1 7319,0 7385,1 7391,0 7448,1 7500,0 7538,1 7608,0 7664,1 7675,0 7772,1 7815,0 7868,1 7961,0 8046,1 8112,0 8138,1 8193,0 8279,1 8343,0 8381,1 8443,0 8538,1 8582,0 8679,1 8708,0 8743,1 8835,0 8862,1 8933,0 8945,1 8971,0 9000,1 9029,0 9038,1 9054,0 9118,1 9129,0 9168,1 9249,0 9315,1 9412,0 9459,1 9519,0 9530,1 9552,0 9609,1 9684,0 9750,1 9787,0 9804,1 9841,0 9894,1 9970,0 9990,1 10031,0 10111,1 10180,0 10239,1 10272,0 10276,1 10279,0 10290,1 10365,0 10443,1 10462,0 10509,1 10547,0 10608,1 10637,0 10648,1 10651,0 10728,1 10797,0 10815,1 10887,0 10968,1 11040,0 11080,1 11097,0 11168,1 11197,0 11288,1 11375,0 11455,1 11457,0 11471,1 11491,0 11557,1 11596,0 11646,1 11709,0 11732,1 11737,0 11800,1 11858,0 11864,1 11944,0 11985,1 12079,0 12120,1 12181,0 12241,1 12249,0 12302,1 12376,0 12441,1 12454,0 12525,1 end initlist b118 0,0 26,1 27,0 80,1 114,0 128,1 196,0 241,1 262,0 264,1 269,0 288,1 358,0 382,1 419,0 428,1 493,0 567,1 665,0 755,1 779,0 828,1 885,0 927,1 985,0 1048,1 1093,0 1165,1 1252,0 1292,1 1376,0 1456,1 1468,0 1485,1 1550,0 1608,1 1660,0 1701,1 1745,0 1842,1 1849,0 1858,1 1955,0 1975,1 2070,0 2169,1 2264,0 2326,1 2355,0 2429,1 2432,0 2528,1 2604,0 2660,1 2670,0 2749,1 2757,0 2790,1 2824,0 2907,1 2975,0 3031,1 3036,0 3072,1 3093,0 3115,1 3203,0 3218,1 3222,0 3284,1 3338,0 3436,1 3467,0 3561,1 3618,0 3698,1 3755,0 3831,1 3837,0 3911,1 3916,0 4000,1 4045,0 4139,1 4164,0 4223,1 4257,0 4271,1 4296,0 4361,1 4408,0 4448,1 4520,0 4582,1 4619,0 4676,1 4769,0 4804,1 4840,0 4909,1 4976,0 5007,1 5045,0 5110,1 5115,0 5195,1 5229,0 5300,1 5345,0 5434,1 5439,0 5446,1 5534,0 5599,1 5624,0 5711,1 5810,0 5883,1 5938,0 6004,1 6025,0 6112,1 6172,0 6184,1 6188,0 6275,1 6293,0 6354,1 6410,0 6499,1 6525,0 6622,1 6718,0 6745,1 6770,0 6805,1 6818,0 6876,1 6925,0 6936,1 7004,0 7060,1 7106,0 7204,1 7292,0 7384,1 7399,0 7476,1 7503,0 7545,1 7549,0 7578,1 7625,0 7637,1 7728,0 7822,1 7888,0 7982,1 8001,0 8066,1 8115,0 8170,1 8248,0 8291,1 8327,0 8359,1 8438,0 8445,1 8524,0 8568,1 8573,0 8589,1 8631,0 8701,1 8753,0 8835,1 8923,0 9012,1 9045,0 9123,1 9155,0 9255,1 9264,0 9320,1 9418,0 9490,1 9536,0 9554,1 9633,0 9715,1 9762,0 9789,1 9852,0 9931,1 9957,0 10027,1 10032,0 10077,1 10147,0 10179,1 10211,0 10255,1 10324,0 10350,1 10419,0 10491,1 10586,0 10601,1 10687,0 10713,1 10720,0 10788,1 10813,0 10896,1 10943,0 10962,1 10998,0 11069,1 11125,0 11189,1 11207,0 11300,1 11310,0 11337,1 11346,0 11354,1 11390,0 11461,1 11470,0 11514,1 11613,0 11712,1 11800,0 11865,1 11945,0 12012,1 12055,0 12109,1 12155,0 12221,1 12317,0 12353,1 12416,0 12442,1 12488,0 12509,1 12580,0 12665,1 12723,0 12737,1 12797,0 12820,1 12836,0 12910,1 12987,0 13011,1 13064,0 13113,1 end initlist b119 0,0 87,1 183,0 208,1 290,0 341,1 408,0 435,1 453,0 477,1 554,0 610,1 650,0 711,1 719,0 744,1 828,0 832,1 846,0 851,1 936,0 1022,1 1088,0 1169,1 1227,0 1319,1 1384,0 1458,1 1497,0 1594,1 1641,0 1703,1 1720,0 1783,1 1832,0 1845,1 1885,0 1889,1 1985,0 2079,1 2163,0 2201,1 2276,0 2306,1 2307,0 2356,1 2430,0 2444,1 2496,0 2524,1 2567,0 2644,1 2663,0 2676,1 2764,0 2842,1 2881,0 2887,1 2940,0 2979,1 3073,0 3090,1 3163,0 3194,1 3212,0 3310,1 3402,0 3407,1 3409,0 3470,1 3485,0 3565,1 3626,0 3702,1 3793,0 3845,1 3888,0 3941,1 3957,0 4011,1 4095,0 4118,1 4201,0 4296,1 4312,0 4407,1 4436,0 4458,1 4476,0 4484,1 4551,0 4643,1 4706,0 4766,1 4804,0 4828,1 4847,0 4886,1 4902,0 4917,1 5014,0 5057,1 5151,0 5194,1 5271,0 5282,1 5316,0 5344,1 5379,0 5409,1 5437,0 5499,1 5541,0 5640,1 5699,0 5793,1 5880,0 5977,1 6059,0 6143,1 6154,0 6180,1 6250,0 6349,1 6416,0 6516,1 6543,0 6624,1 6677,0 6742,1 6771,0 6798,1 6853,0 6854,1 6915,0 6918,1 7010,0 7107,1 7139,0 7182,1 7190,0 7231,1 7299,0 7338,1 7363,0 7371,1 7461,0 7516,1 7593,0 7633,1 7721,0 7765,1 7795,0 7881,1 7968,0 8046,1 8061,0 8155,1 8252,0 8300,1 8311,0 8325,1 8332,0 8341,1 8383,0 8480,1 8486,0 8557,1 8604,0 8663,1 8665,0 8711,1 8802,0 8835,1 8886,0 8970,1 9065,0 9161,1 9174,0 9273,1 9336,0 9369,1 9451,0 9503,1 9508,0 9536,1 9562,0 9585,1 9626,0 9641,1 9735,0 9813,1 9887,0 9960,1 10016,0 10018,1 10114,0 10205,1 10250,0 10310,1 10330,0 10384,1 10475,0 10507,1 10525,0 10566,1 10604,0 10690,1 10763,0 10803,1 10853,0 10936,1 10942,0 10983,1 11005,0 11007,1 11040,0 11063,1 11072,0 11119,1 11171,0 11215,1 11301,0 11346,1 11368,0 11442,1 11486,0 11520,1 11562,0 11567,1 11633,0 11661,1 11687,0 11745,1 11798,0 11849,1 11929,0 12003,1 12092,0 12172,1 12208,0 12227,1 12294,0 12338,1 12426,0 12473,1 12502,0 12556,1 12649,0 12685,1 12732,0 12817,1 12850,0 12906,1 13001,0 13031,1 13122,0 13180,1 end initlist b120 0,0 42,1 49,0 72,1 170,0 199,1 203,0 218,1 234,0 329,1 348,0 388,1 413,0 441,1 521,0 603,1 675,0 735,1 781,0 876,1 933,0 936,1 1007,0 1097,1 1187,0 1213,1 1224,0 1273,1 1345,0 1394,1 1427,0 1433,1 1467,0 1505,1 1519,0 1614,1 1618,0 1677,1 1715,0 1736,1 1762,0 1814,1 1867,0 1956,1 2020,0 2075,1 2141,0 2146,1 2235,0 2283,1 2361,0 2453,1 2541,0 2598,1 2607,0 2676,1 2744,0 2781,1 2794,0 2805,1 2808,0 2840,1 2880,0 2940,1 2956,0 3009,1 3037,0 3083,1 3177,0 3263,1 3309,0 3318,1 3405,0 3449,1 3456,0 3538,1 3593,0 3671,1 3732,0 3761,1 3849,0 3943,1 3988,0 4027,1 4032,0 4054,1 4068,0 4127,1 4152,0 4163,1 4252,0 4291,1 4344,0 4394,1 4414,0 4481,1 4536,0 4567,1 4587,0 4657,1 4754,0 4832,1 4905,0 4975,1 5045,0 5097,1 5127,0 5224,1 5279,0 5376,1 5429,0 5487,1 5513,0 5527,1 5549,0 5552,1 5598,0 5674,1 5748,0 5833,1 5869,0 5877,1 5880,0 5968,1 5993,0 6089,1 6180,0 6246,1 6281,0 6324,1 6369,0 6446,1 6483,0 6504,1 6550,0 6567,1 6631,0 6707,1 6739,0 6818,1 6859,0 6956,1 6968,0 7049,1 7143,0 7181,1 7274,0 7283,1 7372,0 7408,1 7490,0 7495,1 7542,0 7547,1 7595,0 7668,1 7749,0 7786,1 7883,0 7982,1 8068,0 8116,1 8180,0 8232,1 8279,0 8377,1 8436,0 8465,1 8513,0 8534,1 8601,0 8618,1 8632,0 8729,1 8782,0 8875,1 8923,0 8965,1 9024,0 9108,1 9116,0 9198,1 9250,0 9273,1 9347,0 9385,1 9464,0 9516,1 9522,0 9612,1 9677,0 9710,1 9754,0 9832,1 9862,0 9908,1 9986,0 9994,1 10024,0 10115,1 10136,0 10190,1 10210,0 10303,1 10333,0 10350,1 10436,0 10516,1 10541,0 10581,1 10607,0 10656,1 10726,0 10767,1 10806,0 10831,1 10925,0 10967,1 11025,0 11038,1 11058,0 11089,1 11159,0 11223,1 11255,0 11338,1 11348,0 11373,1 11471,0 11556,1 11561,0 11647,1 11720,0 11813,1 11837,0 11907,1 11924,0 12012,1 12029,0 12034,1 12125,0 12170,1 12231,0 12323,1 12352,0 12448,1 12475,0 12561,1 12651,0 12702,1 12761,0 12776,1 12778,0 12860,1 12938,0 12995,1 13090,0 13177,1 end initlist b121 0,0 75,1 118,0 208,1 270,0 300,1 387,0 401,1 475,0 541,1 592,0 602,1 685,0 727,1 793,0 874,1 961,0 997,1 1095,0 1145,1 1213,0 1219,1 1225,0 1311,1 1401,0 1487,1 1526,0 1588,1 1627,0 1632,1 1712,0 1758,1 1771,0 1789,1 1865,0 1885,1 1911,0 1970,1 2064,0 2095,1 2134,0 2166,1 2243,0 2317,1 2417,0 2502,1 2561,0 2623,1 2634,0 2666,1 2727,0 2763,1 2781,0 2806,1 2822,0 2862,1 2886,0 2945,1 3033,0 3050,1 3128,0 3172,1 3234,0 3306,1 3330,0 3377,1 3459,0 3486,1 3513,0 3563,1 3634,0 3652,1 3659,0 3699,1 3796,0 3843,1 3897,0 3921,1 3929,0 4021,1 4032,0 4064,1 4104,0 4189,1 4202,0 4237,1 4245,0 4263,1 4278,0 4281,1 4374,0 4396,1 4490,0 4501,1 4549,0 4596,1 4619,0 4623,1 4644,0 4716,1 4792,0 4874,1 4909,0 4933,1 5001,0 5011,1 5088,0 5160,1 5190,0 5264,1 5360,0 5368,1 5437,0 5516,1 5529,0 5577,1 5598,0 5599,1 5637,0 5671,1 5688,0 5702,1 5782,0 5786,1 5813,0 5876,1 5962,0 5975,1 6048,0 6109,1 6205,0 6210,1 6304,0 6366,1 6404,0 6484,1 6542,0 6562,1 6640,0 6684,1 6723,0 6771,1 6844,0 6943,1 6956,0 6977,1 7046,0 7068,1 7144,0 7153,1 7214,0 7285,1 7369,0 7391,1 7426,0 7476,1 7493,0 7526,1 7622,0 7682,1 7757,0 7793,1 7853,0 7953,1 8001,0 8059,1 8064,0 8105,1 8160,0 8166,1 8239,0 8290,1 8327,0 8408,1 8465,0 8483,1 8564,0 8575,1 8669,0 8701,1 8757,0 8802,1 8826,0 8885,1 8912,0 8943,1 8970,0 9068,1 9113,0 9148,1 9236,0 9309,1 9376,0 9465,1 9511,0 9516,1 9561,0 9578,1 9641,0 9647,1 9704,0 9746,1 9791,0 9819,1 9870,0 9896,1 9911,0 9980,1 9996,0 10011,1 10108,0 10171,1 10213,0 10275,1 10277,0 10326,1 10399,0 10460,1 10498,0 10577,1 10584,0 10669,1 10717,0 10803,1 10886,0 10928,1 10984,0 11041,1 11050,0 11066,1 11091,0 11148,1 11234,0 11300,1 11302,0 11303,1 11364,0 11381,1 11418,0 11462,1 11516,0 11573,1 11607,0 11680,1 11769,0 11789,1 11879,0 11911,1 11984,0 12045,1 12087,0 12153,1 12222,0 12321,1 12402,0 12500,1 12532,0 12610,1 end initlist b122 0,0 72,1 84,0 100,1 190,0 263,1 332,0 399,1 485,0 576,1 631,0 726,1 734,0 823,1 852,0 900,1 972,0 1039,1 1092,0 1166,1 1192,0 1223,1 1275,0 1293,1 1322,0 1420,1 1500,0 1556,1 1653,0 1674,1 1767,0 1797,1 1854,0 1892,1 1936,0 1950,1 2043,0 2124,1 2173,0 2208,1 2237,0 2262,1 2342,0 2414,1 2479,0 2540,1 2594,0 2678,1 2691,0 2719,1 2796,0 2858,1 2883,0 2894,1 2970,0 3070,1 3168,0 3256,1 3342,0 3370,1 3464,0 3557,1 3587,0 3649,1 3663,0 3714,1 3774,0 3867,1 3912,0 3962,1 4000,0 4022,1 4101,0 4105,1 4153,0 4223,1 4276,0 4367,1 4394,0 4431,1 4478,0 4484,1 4575,0 4615,1 4623,0 4706,1 4760,0 4840,1 4876,0 4946,1 5008,0 5092,1 5183,0 5230,1 5262,0 5358,1 5440,0 5469,1 5548,0 5604,1 5608,0 5688,1 5731,0 5795,1 5839,0 5892,1 5956,0 5990,1 6050,0 6137,1 6236,0 6253,1 6267,0 6318,1 6413,0 6491,1 6563,0 6626,1 6650,0 6658,1 6663,0 6741,1 6792,0 6843,1 6893,0 6938,1 6979,0 6994,1 7083,0 7173,1 7199,0 7225,1 7251,0 7301,1 7340,0 7432,1 7458,0 7509,1 7562,0 7568,1 7592,0 7613,1 7632,0 7679,1 7757,0 7852,1 7920,0 7976,1 8060,0 8104,1 8129,0 8169,1 8204,0 8238,1 8322,0 8329,1 8411,0 8428,1 8510,0 8529,1 8607,0 8608,1 8702,0 8755,1 8806,0 8847,1 8934,0 8980,1 8992,0 9076,1 9094,0 9098,1 9196,0 9227,1 9244,0 9288,1 9319,0 9408,1 9483,0 9495,1 9500,0 9594,1 9637,0 9649,1 9711,0 9717,1 9811,0 9899,1 9901,0 9967,1 10052,0 10085,1 10094,0 10140,1 10165,0 10235,1 10311,0 10368,1 10406,0 10474,1 10540,0 10621,1 10651,0 10669,1 10677,0 10754,1 10832,0 10857,1 10955,0 11021,1 11050,0 11115,1 11138,0 11210,1 11277,0 11293,1 11370,0 11452,1 11546,0 11569,1 11575,0 11628,1 11644,0 11727,1 11805,0 11860,1 11910,0 11952,1 12005,0 12008,1 12050,0 12068,1 12121,0 12199,1 12294,0 12346,1 12411,0 12433,1 12484,0 12497,1 12587,0 12590,1 12622,0 12671,1 12703,0 12718,1 12803,0 12823,1 12863,0 12953,1 13000,0 13063,1 13086,0 13107,1 13183,0 13272,1 13292,0 13353,1 end initlist b123 0,0 50,1 108,0 184,1 235,0 282,1 355,0 407,1 468,0 521,1 611,0 669,1 731,0 766,1 845,0 908,1 935,0 998,1 1029,0 1063,1 1120,0 1199,1 1205,0 1209,1 1239,0 1339,1 1366,0 1435,1 1438,0 1531,1 1551,0 1581,1 1599,0 1682,1 1702,0 1797,1 1861,0 1866,1 1917,0 1921,1 1968,0 2021,1 2025,0 2125,1 2202,0 2209,1 2280,0 2299,1 2307,0 2362,1 2401,0 2483,1 2499,0 2567,1 2607,0 2610,1 2665,0 2679,1 2729,0 2822,1 2892,0 2988,1 3048,0 3111,1 3145,0 3168,1 3252,0 3265,1 3277,0 3336,1 3341,0 3397,1 3427,0 3481,1 3564,0 3629,1 3661,0 3694,1 3780,0 3796,1 3801,0 3814,1 3879,0 3920,1 3922,0 3968,1 4028,0 4084,1 4143,0 4198,1 4247,0 4269,1 4330,0 4406,1 4454,0 4514,1 4594,0 4665,1 4752,0 4765,1 4806,0 4858,1 4912,0 4944,1 5021,0 5031,1 5044,0 5114,1 5117,0 5132,1 5161,0 5182,1 5271,0 5298,1 5387,0 5483,1 5493,0 5565,1 5574,0 5602,1 5628,0 5705,1 5783,0 5869,1 5923,0 5947,1 5969,0 6015,1 6023,0 6101,1 6128,0 6198,1 6240,0 6245,1 6334,0 6335,1 6418,0 6494,1 6561,0 6612,1 6666,0 6684,1 6697,0 6765,1 6789,0 6805,1 6876,0 6954,1 6978,0 7030,1 7100,0 7110,1 7183,0 7257,1 7275,0 7338,1 7355,0 7426,1 7459,0 7519,1 7562,0 7594,1 7628,0 7720,1 7779,0 7794,1 7891,0 7970,1 8043,0 8049,1 8104,0 8187,1 8214,0 8252,1 8302,0 8368,1 8399,0 8475,1 8543,0 8576,1 8578,0 8649,1 8703,0 8761,1 8821,0 8843,1 8892,0 8975,1 8976,0 9065,1 9138,0 9189,1 9277,0 9345,1 9435,0 9478,1 9491,0 9526,1 9601,0 9618,1 9692,0 9752,1 9831,0 9923,1 10022,0 10072,1 10148,0 10154,1 10252,0 10314,1 10333,0 10346,1 10432,0 10454,1 10543,0 10587,1 10679,0 10759,1 10811,0 10875,1 10896,0 10897,1 10964,0 10972,1 11072,0 11109,1 11152,0 11252,1 11309,0 11377,1 11437,0 11468,1 11492,0 11501,1 11549,0 11566,1 11609,0 11701,1 11771,0 11789,1 11871,0 11926,1 11974,0 11981,1 12061,0 12143,1 12209,0 12283,1 12375,0 12470,1 12567,0 12576,1 12638,0 12691,1 12770,0 12830,1 12912,0 13007,1 end initlist b124 0,0 68,1 154,0 196,1 227,0 271,1 289,0 342,1 396,0 399,1 458,0 513,1 549,0 561,1 590,0 644,1 729,0 774,1 870,0 926,1 1009,0 1086,1 1104,0 1166,1 1227,0 1296,1 1318,0 1403,1 1496,0 1577,1 1581,0 1620,1 1679,0 1698,1 1738,0 1767,1 1821,0 1830,1 1839,0 1841,1 1873,0 1970,1 2048,0 2140,1 2231,0 2262,1 2336,0 2371,1 2403,0 2464,1 2511,0 2544,1 2583,0 2596,1 2693,0 2707,1 2785,0 2848,1 2946,0 3009,1 3022,0 3065,1 3072,0 3136,1 3206,0 3243,1 3313,0 3405,1 3439,0 3484,1 3496,0 3513,1 3559,0 3642,1 3729,0 3797,1 3889,0 3977,1 3981,0 4061,1 4136,0 4210,1 4241,0 4321,1 4377,0 4441,1 4534,0 4628,1 4696,0 4725,1 4754,0 4755,1 4851,0 4928,1 4963,0 5035,1 5073,0 5114,1 5143,0 5228,1 5256,0 5349,1 5439,0 5515,1 5595,0 5658,1 5740,0 5806,1 5831,0 5884,1 5928,0 5971,1 5997,0 6081,1 6163,0 6256,1 6258,0 6323,1 6333,0 6404,1 6498,0 6588,1 6669,0 6766,1 6795,0 6801,1 6858,0 6930,1 7018,0 7093,1 7175,0 7267,1 7273,0 7335,1 7364,0 7460,1 7489,0 7537,1 7611,0 7617,1 7650,0 7672,1 7725,0 7824,1 7838,0 7903,1 7978,0 8071,1 8138,0 8188,1 8249,0 8274,1 8302,0 8398,1 8482,0 8569,1 8592,0 8681,1 8750,0 8838,1 8917,0 8961,1 8962,0 8998,1 9028,0 9103,1 9149,0 9213,1 9237,0 9300,1 9362,0 9392,1 9451,0 9471,1 9509,0 9556,1 9605,0 9658,1 9710,0 9714,1 9789,0 9843,1 9849,0 9941,1 9973,0 10032,1 10132,0 10157,1 10244,0 10311,1 10316,0 10332,1 10371,0 10372,1 10410,0 10496,1 10506,0 10601,1 10679,0 10738,1 10815,0 10892,1 10990,0 11036,1 11113,0 11157,1 11216,0 11279,1 11318,0 11407,1 11467,0 11514,1 11602,0 11621,1 11632,0 11644,1 11728,0 11754,1 11760,0 11816,1 11838,0 11906,1 11969,0 12001,1 12066,0 12091,1 12128,0 12134,1 12210,0 12283,1 12298,0 12391,1 12490,0 12571,1 12671,0 12751,1 12803,0 12900,1 12995,0 13036,1 13123,0 13220,1 13262,0 13277,1 13341,0 13393,1 13459,0 13495,1 13502,0 13534,1 13579,0 13594,1 13662,0 13690,1 13700,0 13728,1 13767,0 13811,1 end initlist b125 0,0 23,1 34,0 56,1 132,0 156,1 199,0 260,1 336,0 396,1 490,0 578,1 642,0 742,1 821,0 854,1 876,0 915,1 982,0 986,1 1070,0 1087,1 1124,0 1185,1 1269,0 1365,1 1383,0 1446,1 1531,0 1542,1 1551,0 1559,1 1625,0 1647,1 1715,0 1795,1 1837,0 1932,1 1933,0 1954,1 1976,0 2062,1 2076,0 2087,1 2158,0 2181,1 2237,0 2331,1 2428,0 2471,1 2568,0 2620,1 2701,0 2759,1 2829,0 2857,1 2890,0 2908,1 3001,0 3063,1 3131,0 3169,1 3186,0 3271,1 3304,0 3367,1 3460,0 3518,1 3526,0 3624,1 3639,0 3721,1 3811,0 3867,1 3885,0 3918,1 4004,0 4014,1 4067,0 4099,1 4172,0 4235,1 4264,0 4358,1 4414,0 4457,1 4506,0 4564,1 4641,0 4648,1 4740,0 4800,1 4873,0 4973,1 4984,0 4995,1 5090,0 5106,1 5112,0 5115,1 5186,0 5244,1 5296,0 5333,1 5410,0 5507,1 5545,0 5603,1 5617,0 5692,1 5758,0 5782,1 5858,0 5896,1 5979,0 6078,1 6117,0 6173,1 6241,0 6252,1 6299,0 6322,1 6359,0 6449,1 6485,0 6534,1 6605,0 6642,1 6655,0 6663,1 6735,0 6773,1 6794,0 6822,1 6870,0 6900,1 6930,0 7003,1 7022,0 7089,1 7114,0 7172,1 7235,0 7302,1 7332,0 7405,1 7472,0 7528,1 7564,0 7653,1 7683,0 7745,1 7771,0 7815,1 7874,0 7883,1 7964,0 7974,1 8046,0 8113,1 8178,0 8246,1 8248,0 8267,1 8272,0 8370,1 8450,0 8451,1 8471,0 8477,1 8571,0 8607,1 8682,0 8724,1 8753,0 8829,1 8833,0 8844,1 8885,0 8954,1 9012,0 9108,1 9145,0 9147,1 9196,0 9272,1 9345,0 9411,1 9488,0 9580,1 9648,0 9672,1 9764,0 9823,1 9872,0 9937,1 10002,0 10091,1 10121,0 10187,1 10223,0 10226,1 10242,0 10290,1 10357,0 10419,1 10479,0 10502,1 10532,0 10562,1 10567,0 10604,1 10638,0 10683,1 10759,0 10851,1 10896,0 10991,1 11021,0 11080,1 11140,0 11160,1 11208,0 11283,1 11335,0 11373,1 11420,0 11432,1 11433,0 11526,1 11588,0 11650,1 11676,0 11691,1 11698,0 11725,1 11821,0 11896,1 11940,0 12009,1 12046,0 12129,1 12191,0 12277,1 12366,0 12413,1 12481,0 12511,1 12562,0 12608,1 12626,0 12697,1 12772,0 12811,1 12825,0 12901,1 12903,0 13002,1 end initlist b126 0,0 61,1 95,0 114,1 203,0 300,1 336,0 393,1 489,0 551,1 621,0 665,1 685,0 771,1 802,0 865,1 920,0 926,1 927,0 941,1 1024,0 1039,1 1099,0 1163,1 1239,0 1279,1 1280,0 1352,1 1404,0 1421,1 1504,0 1595,1 1646,0 1721,1 1817,0 1913,1 1919,0 1926,1 2021,0 2040,1 2048,0 2116,1 2119,0 2171,1 2205,0 2237,1 2284,0 2363,1 2433,0 2514,1 2516,0 2615,1 2626,0 2637,1 2727,0 2808,1 2826,0 2859,1 2922,0 2950,1 2979,0 2996,1 3075,0 3168,1 3236,0 3319,1 3385,0 3415,1 3486,0 3576,1 3578,0 3635,1 3654,0 3737,1 3764,0 3803,1 3872,0 3895,1 3972,0 4064,1 4072,0 4133,1 4151,0 4209,1 4276,0 4322,1 4387,0 4448,1 4460,0 4533,1 4622,0 4645,1 4683,0 4694,1 4756,0 4786,1 4868,0 4897,1 4959,0 4971,1 5067,0 5148,1 5188,0 5228,1 5268,0 5298,1 5397,0 5410,1 5464,0 5517,1 5616,0 5680,1 5754,0 5770,1 5779,0 5790,1 5836,0 5912,1 5951,0 6036,1 6116,0 6127,1 6227,0 6267,1 6323,0 6395,1 6454,0 6506,1 6555,0 6601,1 6664,0 6739,1 6786,0 6820,1 6825,0 6877,1 6939,0 6984,1 7078,0 7089,1 7156,0 7220,1 7261,0 7263,1 7345,0 7431,1 7511,0 7578,1 7664,0 7759,1 7765,0 7796,1 7830,0 7834,1 7912,0 7934,1 7939,0 8005,1 8099,0 8103,1 8156,0 8199,1 8245,0 8321,1 8385,0 8430,1 8512,0 8552,1 8589,0 8631,1 8641,0 8681,1 8726,0 8762,1 8772,0 8841,1 8927,0 8967,1 9023,0 9079,1 9097,0 9155,1 9185,0 9236,1 9275,0 9353,1 9355,0 9402,1 9464,0 9541,1 9626,0 9668,1 9755,0 9846,1 9940,0 9987,1 10038,0 10084,1 10129,0 10191,1 10239,0 10278,1 10322,0 10371,1 10377,0 10392,1 10451,0 10521,1 10547,0 10603,1 10639,0 10710,1 10735,0 10748,1 10776,0 10845,1 10853,0 10926,1 11021,0 11089,1 11183,0 11188,1 11281,0 11325,1 11392,0 11449,1 11476,0 11551,1 11572,0 11603,1 11643,0 11648,1 11680,0 11774,1 11792,0 11887,1 11899,0 11940,1 11980,0 12029,1 12055,0 12127,1 12136,0 12188,1 12260,0 12347,1 12410,0 12473,1 12529,0 12563,1 12590,0 12653,1 12722,0 12801,1 12803,0 12873,1 12903,0 12943,1 end initlist b127 0,0 2,1 69,0 88,1 155,0 248,1 347,0 433,1 434,0 512,1 562,0 603,1 614,0 625,1 693,0 790,1 852,0 911,1 990,0 1032,1 1111,0 1193,1 1282,0 1364,1 1442,0 1472,1 1527,0 1623,1 1662,0 1713,1 1721,0 1781,1 1833,0 1877,1 1904,0 1986,1 2015,0 2111,1 2210,0 2234,1 2334,0 2371,1 2458,0 2459,1 2501,0 2519,1 2616,0 2619,1 2710,0 2731,1 2744,0 2780,1 2784,0 2848,1 2923,0 2936,1 2942,0 3016,1 3062,0 3095,1 3130,0 3220,1 3299,0 3395,1 3492,0 3528,1 3551,0 3647,1 3667,0 3693,1 3762,0 3793,1 3840,0 3932,1 3954,0 4006,1 4074,0 4108,1 4191,0 4218,1 4304,0 4337,1 4381,0 4468,1 4514,0 4532,1 4592,0 4660,1 4756,0 4807,1 4817,0 4841,1 4936,0 4938,1 4967,0 5044,1 5052,0 5097,1 5176,0 5258,1 5271,0 5308,1 5339,0 5393,1 5489,0 5578,1 5608,0 5680,1 5718,0 5791,1 5823,0 5921,1 6006,0 6043,1 6124,0 6162,1 6224,0 6310,1 6321,0 6418,1 6452,0 6470,1 6474,0 6490,1 6497,0 6535,1 6601,0 6663,1 6733,0 6742,1 6775,0 6845,1 6933,0 7019,1 7029,0 7119,1 7159,0 7219,1 7231,0 7258,1 7310,0 7369,1 7436,0 7458,1 7468,0 7540,1 7597,0 7630,1 7728,0 7729,1 7801,0 7835,1 7867,0 7919,1 7967,0 8060,1 8133,0 8154,1 8254,0 8338,1 8436,0 8491,1 8529,0 8548,1 8629,0 8659,1 8712,0 8731,1 8799,0 8801,1 8842,0 8933,1 9023,0 9101,1 9108,0 9183,1 9197,0 9219,1 9296,0 9361,1 9413,0 9454,1 9551,0 9570,1 9649,0 9710,1 9718,0 9811,1 9886,0 9946,1 9966,0 10051,1 10071,0 10154,1 10181,0 10200,1 10227,0 10289,1 10333,0 10364,1 10442,0 10484,1 10542,0 10609,1 10690,0 10764,1 10773,0 10863,1 10911,0 10964,1 11032,0 11076,1 11120,0 11171,1 11192,0 11232,1 11317,0 11330,1 11389,0 11433,1 11451,0 11491,1 11567,0 11655,1 11748,0 11822,1 11837,0 11863,1 11889,0 11905,1 11987,0 12084,1 12090,0 12121,1 12170,0 12226,1 12301,0 12333,1 12378,0 12396,1 12402,0 12409,1 12496,0 12522,1 12572,0 12623,1 12628,0 12675,1 12729,0 12741,1 12786,0 12865,1 12945,0 12963,1 13058,0 13098,1 13135,0 13209,1 end initlist cin 0, 0 66, 1 end outvalues s0 1, s1 1, s2 1, s3 1, s4 1, s5 1, s6 1, s7 1, s8 1, s9 1, s10 1, s11 1, s12 1, s13 1, s14 1, s15 1, s16 1, s17 1, s18 1, s19 1, s20 1, s21 1, s22 1, s23 1, s24 1, s25 1, s26 1, s27 1, s28 1, s29 1, s30 1, s31 1, s32 1, s33 1, s34 1, s35 1, s36 1, s37 1, s38 1, s39 1, s40 1, s41 1, s42 1, s43 1, s44 1, s45 1, s46 1, s47 1, s48 1, s49 1, s50 1, s51 1, s52 1, s53 1, s54 1, s55 1, s56 1, s57 1, s58 1, s59 1, s60 1, s61 1, s62 1, s63 1, s64 1, s65 1, s66 1, s67 1, s68 1, s69 1, s70 1, s71 1, s72 1, s73 1, s74 1, s75 1, s76 1, s77 1, s78 1, s79 1, s80 1, s81 1, s82 1, s83 1, s84 1, s85 1, s86 1, s87 1, s88 1, s89 1, s90 1, s91 1, s92 1, s93 1, s94 1, s95 1, s96 1, s97 1, s98 1, s99 1, s100 1, s101 1, s102 1, s103 1, s104 1, s105 1, s106 1, s107 1, s108 1, s109 1, s110 1, s111 1, s112 1, s113 1, s114 1, s115 1, s116 1, s117 1, s118 1, s119 1, s120 1, s121 1, s122 1, s123 1, s124 1, s125 1, s126 1, s127 1, , cout 1, end netlist // PGgen (g0,p0,a0,b0) xor2(p0,a0,b0)#5 and2(g0,a0,b0)#5 end netlist // PGgen (g1,p1,a1,b1) xor2(p1,a1,b1)#5 and2(g1,a1,b1)#5 end netlist // PGgen (g2,p2,a2,b2) xor2(p2,a2,b2)#5 and2(g2,a2,b2)#5 end netlist // PGgen (g3,p3,a3,b3) xor2(p3,a3,b3)#5 and2(g3,a3,b3)#5 end netlist // PGgen (g4,p4,a4,b4) xor2(p4,a4,b4)#5 and2(g4,a4,b4)#5 end netlist // PGgen (g5,p5,a5,b5) xor2(p5,a5,b5)#5 and2(g5,a5,b5)#5 end netlist // PGgen (g6,p6,a6,b6) xor2(p6,a6,b6)#5 and2(g6,a6,b6)#5 end netlist // PGgen (g7,p7,a7,b7) xor2(p7,a7,b7)#5 and2(g7,a7,b7)#5 end netlist // PGgen (g8,p8,a8,b8) xor2(p8,a8,b8)#5 and2(g8,a8,b8)#5 end netlist // PGgen (g9,p9,a9,b9) xor2(p9,a9,b9)#5 and2(g9,a9,b9)#5 end netlist // PGgen (g10,p10,a10,b10) xor2(p10,a10,b10)#5 and2(g10,a10,b10)#5 end netlist // PGgen (g11,p11,a11,b11) xor2(p11,a11,b11)#5 and2(g11,a11,b11)#5 end netlist // PGgen (g12,p12,a12,b12) xor2(p12,a12,b12)#5 and2(g12,a12,b12)#5 end netlist // PGgen (g13,p13,a13,b13) xor2(p13,a13,b13)#5 and2(g13,a13,b13)#5 end netlist // PGgen (g14,p14,a14,b14) xor2(p14,a14,b14)#5 and2(g14,a14,b14)#5 end netlist // PGgen (g15,p15,a15,b15) xor2(p15,a15,b15)#5 and2(g15,a15,b15)#5 end netlist // PGgen (g16,p16,a16,b16) xor2(p16,a16,b16)#5 and2(g16,a16,b16)#5 end netlist // PGgen (g17,p17,a17,b17) xor2(p17,a17,b17)#5 and2(g17,a17,b17)#5 end netlist // PGgen (g18,p18,a18,b18) xor2(p18,a18,b18)#5 and2(g18,a18,b18)#5 end netlist // PGgen (g19,p19,a19,b19) xor2(p19,a19,b19)#5 and2(g19,a19,b19)#5 end netlist // PGgen (g20,p20,a20,b20) xor2(p20,a20,b20)#5 and2(g20,a20,b20)#5 end netlist // PGgen (g21,p21,a21,b21) xor2(p21,a21,b21)#5 and2(g21,a21,b21)#5 end netlist // PGgen (g22,p22,a22,b22) xor2(p22,a22,b22)#5 and2(g22,a22,b22)#5 end netlist // PGgen (g23,p23,a23,b23) xor2(p23,a23,b23)#5 and2(g23,a23,b23)#5 end netlist // PGgen (g24,p24,a24,b24) xor2(p24,a24,b24)#5 and2(g24,a24,b24)#5 end netlist // PGgen (g25,p25,a25,b25) xor2(p25,a25,b25)#5 and2(g25,a25,b25)#5 end netlist // PGgen (g26,p26,a26,b26) xor2(p26,a26,b26)#5 and2(g26,a26,b26)#5 end netlist // PGgen (g27,p27,a27,b27) xor2(p27,a27,b27)#5 and2(g27,a27,b27)#5 end netlist // PGgen (g28,p28,a28,b28) xor2(p28,a28,b28)#5 and2(g28,a28,b28)#5 end netlist // PGgen (g29,p29,a29,b29) xor2(p29,a29,b29)#5 and2(g29,a29,b29)#5 end netlist // PGgen (g30,p30,a30,b30) xor2(p30,a30,b30)#5 and2(g30,a30,b30)#5 end netlist // PGgen (g31,p31,a31,b31) xor2(p31,a31,b31)#5 and2(g31,a31,b31)#5 end netlist // PGgen (g32,p32,a32,b32) xor2(p32,a32,b32)#5 and2(g32,a32,b32)#5 end netlist // PGgen (g33,p33,a33,b33) xor2(p33,a33,b33)#5 and2(g33,a33,b33)#5 end netlist // PGgen (g34,p34,a34,b34) xor2(p34,a34,b34)#5 and2(g34,a34,b34)#5 end netlist // PGgen (g35,p35,a35,b35) xor2(p35,a35,b35)#5 and2(g35,a35,b35)#5 end netlist // PGgen (g36,p36,a36,b36) xor2(p36,a36,b36)#5 and2(g36,a36,b36)#5 end netlist // PGgen (g37,p37,a37,b37) xor2(p37,a37,b37)#5 and2(g37,a37,b37)#5 end netlist // PGgen (g38,p38,a38,b38) xor2(p38,a38,b38)#5 and2(g38,a38,b38)#5 end netlist // PGgen (g39,p39,a39,b39) xor2(p39,a39,b39)#5 and2(g39,a39,b39)#5 end netlist // PGgen (g40,p40,a40,b40) xor2(p40,a40,b40)#5 and2(g40,a40,b40)#5 end netlist // PGgen (g41,p41,a41,b41) xor2(p41,a41,b41)#5 and2(g41,a41,b41)#5 end netlist // PGgen (g42,p42,a42,b42) xor2(p42,a42,b42)#5 and2(g42,a42,b42)#5 end netlist // PGgen (g43,p43,a43,b43) xor2(p43,a43,b43)#5 and2(g43,a43,b43)#5 end netlist // PGgen (g44,p44,a44,b44) xor2(p44,a44,b44)#5 and2(g44,a44,b44)#5 end netlist // PGgen (g45,p45,a45,b45) xor2(p45,a45,b45)#5 and2(g45,a45,b45)#5 end netlist // PGgen (g46,p46,a46,b46) xor2(p46,a46,b46)#5 and2(g46,a46,b46)#5 end netlist // PGgen (g47,p47,a47,b47) xor2(p47,a47,b47)#5 and2(g47,a47,b47)#5 end netlist // PGgen (g48,p48,a48,b48) xor2(p48,a48,b48)#5 and2(g48,a48,b48)#5 end netlist // PGgen (g49,p49,a49,b49) xor2(p49,a49,b49)#5 and2(g49,a49,b49)#5 end netlist // PGgen (g50,p50,a50,b50) xor2(p50,a50,b50)#5 and2(g50,a50,b50)#5 end netlist // PGgen (g51,p51,a51,b51) xor2(p51,a51,b51)#5 and2(g51,a51,b51)#5 end netlist // PGgen (g52,p52,a52,b52) xor2(p52,a52,b52)#5 and2(g52,a52,b52)#5 end netlist // PGgen (g53,p53,a53,b53) xor2(p53,a53,b53)#5 and2(g53,a53,b53)#5 end netlist // PGgen (g54,p54,a54,b54) xor2(p54,a54,b54)#5 and2(g54,a54,b54)#5 end netlist // PGgen (g55,p55,a55,b55) xor2(p55,a55,b55)#5 and2(g55,a55,b55)#5 end netlist // PGgen (g56,p56,a56,b56) xor2(p56,a56,b56)#5 and2(g56,a56,b56)#5 end netlist // PGgen (g57,p57,a57,b57) xor2(p57,a57,b57)#5 and2(g57,a57,b57)#5 end netlist // PGgen (g58,p58,a58,b58) xor2(p58,a58,b58)#5 and2(g58,a58,b58)#5 end netlist // PGgen (g59,p59,a59,b59) xor2(p59,a59,b59)#5 and2(g59,a59,b59)#5 end netlist // PGgen (g60,p60,a60,b60) xor2(p60,a60,b60)#5 and2(g60,a60,b60)#5 end netlist // PGgen (g61,p61,a61,b61) xor2(p61,a61,b61)#5 and2(g61,a61,b61)#5 end netlist // PGgen (g62,p62,a62,b62) xor2(p62,a62,b62)#5 and2(g62,a62,b62)#5 end netlist // PGgen (g63,p63,a63,b63) xor2(p63,a63,b63)#5 and2(g63,a63,b63)#5 end netlist // PGgen (g64,p64,a64,b64) xor2(p64,a64,b64)#5 and2(g64,a64,b64)#5 end netlist // PGgen (g65,p65,a65,b65) xor2(p65,a65,b65)#5 and2(g65,a65,b65)#5 end netlist // PGgen (g66,p66,a66,b66) xor2(p66,a66,b66)#5 and2(g66,a66,b66)#5 end netlist // PGgen (g67,p67,a67,b67) xor2(p67,a67,b67)#5 and2(g67,a67,b67)#5 end netlist // PGgen (g68,p68,a68,b68) xor2(p68,a68,b68)#5 and2(g68,a68,b68)#5 end netlist // PGgen (g69,p69,a69,b69) xor2(p69,a69,b69)#5 and2(g69,a69,b69)#5 end netlist // PGgen (g70,p70,a70,b70) xor2(p70,a70,b70)#5 and2(g70,a70,b70)#5 end netlist // PGgen (g71,p71,a71,b71) xor2(p71,a71,b71)#5 and2(g71,a71,b71)#5 end netlist // PGgen (g72,p72,a72,b72) xor2(p72,a72,b72)#5 and2(g72,a72,b72)#5 end netlist // PGgen (g73,p73,a73,b73) xor2(p73,a73,b73)#5 and2(g73,a73,b73)#5 end netlist // PGgen (g74,p74,a74,b74) xor2(p74,a74,b74)#5 and2(g74,a74,b74)#5 end netlist // PGgen (g75,p75,a75,b75) xor2(p75,a75,b75)#5 and2(g75,a75,b75)#5 end netlist // PGgen (g76,p76,a76,b76) xor2(p76,a76,b76)#5 and2(g76,a76,b76)#5 end netlist // PGgen (g77,p77,a77,b77) xor2(p77,a77,b77)#5 and2(g77,a77,b77)#5 end netlist // PGgen (g78,p78,a78,b78) xor2(p78,a78,b78)#5 and2(g78,a78,b78)#5 end netlist // PGgen (g79,p79,a79,b79) xor2(p79,a79,b79)#5 and2(g79,a79,b79)#5 end netlist // PGgen (g80,p80,a80,b80) xor2(p80,a80,b80)#5 and2(g80,a80,b80)#5 end netlist // PGgen (g81,p81,a81,b81) xor2(p81,a81,b81)#5 and2(g81,a81,b81)#5 end netlist // PGgen (g82,p82,a82,b82) xor2(p82,a82,b82)#5 and2(g82,a82,b82)#5 end netlist // PGgen (g83,p83,a83,b83) xor2(p83,a83,b83)#5 and2(g83,a83,b83)#5 end netlist // PGgen (g84,p84,a84,b84) xor2(p84,a84,b84)#5 and2(g84,a84,b84)#5 end netlist // PGgen (g85,p85,a85,b85) xor2(p85,a85,b85)#5 and2(g85,a85,b85)#5 end netlist // PGgen (g86,p86,a86,b86) xor2(p86,a86,b86)#5 and2(g86,a86,b86)#5 end netlist // PGgen (g87,p87,a87,b87) xor2(p87,a87,b87)#5 and2(g87,a87,b87)#5 end netlist // PGgen (g88,p88,a88,b88) xor2(p88,a88,b88)#5 and2(g88,a88,b88)#5 end netlist // PGgen (g89,p89,a89,b89) xor2(p89,a89,b89)#5 and2(g89,a89,b89)#5 end netlist // PGgen (g90,p90,a90,b90) xor2(p90,a90,b90)#5 and2(g90,a90,b90)#5 end netlist // PGgen (g91,p91,a91,b91) xor2(p91,a91,b91)#5 and2(g91,a91,b91)#5 end netlist // PGgen (g92,p92,a92,b92) xor2(p92,a92,b92)#5 and2(g92,a92,b92)#5 end netlist // PGgen (g93,p93,a93,b93) xor2(p93,a93,b93)#5 and2(g93,a93,b93)#5 end netlist // PGgen (g94,p94,a94,b94) xor2(p94,a94,b94)#5 and2(g94,a94,b94)#5 end netlist // PGgen (g95,p95,a95,b95) xor2(p95,a95,b95)#5 and2(g95,a95,b95)#5 end netlist // PGgen (g96,p96,a96,b96) xor2(p96,a96,b96)#5 and2(g96,a96,b96)#5 end netlist // PGgen (g97,p97,a97,b97) xor2(p97,a97,b97)#5 and2(g97,a97,b97)#5 end netlist // PGgen (g98,p98,a98,b98) xor2(p98,a98,b98)#5 and2(g98,a98,b98)#5 end netlist // PGgen (g99,p99,a99,b99) xor2(p99,a99,b99)#5 and2(g99,a99,b99)#5 end netlist // PGgen (g100,p100,a100,b100) xor2(p100,a100,b100)#5 and2(g100,a100,b100)#5 end netlist // PGgen (g101,p101,a101,b101) xor2(p101,a101,b101)#5 and2(g101,a101,b101)#5 end netlist // PGgen (g102,p102,a102,b102) xor2(p102,a102,b102)#5 and2(g102,a102,b102)#5 end netlist // PGgen (g103,p103,a103,b103) xor2(p103,a103,b103)#5 and2(g103,a103,b103)#5 end netlist // PGgen (g104,p104,a104,b104) xor2(p104,a104,b104)#5 and2(g104,a104,b104)#5 end netlist // PGgen (g105,p105,a105,b105) xor2(p105,a105,b105)#5 and2(g105,a105,b105)#5 end netlist // PGgen (g106,p106,a106,b106) xor2(p106,a106,b106)#5 and2(g106,a106,b106)#5 end netlist // PGgen (g107,p107,a107,b107) xor2(p107,a107,b107)#5 and2(g107,a107,b107)#5 end netlist // PGgen (g108,p108,a108,b108) xor2(p108,a108,b108)#5 and2(g108,a108,b108)#5 end netlist // PGgen (g109,p109,a109,b109) xor2(p109,a109,b109)#5 and2(g109,a109,b109)#5 end netlist // PGgen (g110,p110,a110,b110) xor2(p110,a110,b110)#5 and2(g110,a110,b110)#5 end netlist // PGgen (g111,p111,a111,b111) xor2(p111,a111,b111)#5 and2(g111,a111,b111)#5 end netlist // PGgen (g112,p112,a112,b112) xor2(p112,a112,b112)#5 and2(g112,a112,b112)#5 end netlist // PGgen (g113,p113,a113,b113) xor2(p113,a113,b113)#5 and2(g113,a113,b113)#5 end netlist // PGgen (g114,p114,a114,b114) xor2(p114,a114,b114)#5 and2(g114,a114,b114)#5 end netlist // PGgen (g115,p115,a115,b115) xor2(p115,a115,b115)#5 and2(g115,a115,b115)#5 end netlist // PGgen (g116,p116,a116,b116) xor2(p116,a116,b116)#5 and2(g116,a116,b116)#5 end netlist // PGgen (g117,p117,a117,b117) xor2(p117,a117,b117)#5 and2(g117,a117,b117)#5 end netlist // PGgen (g118,p118,a118,b118) xor2(p118,a118,b118)#5 and2(g118,a118,b118)#5 end netlist // PGgen (g119,p119,a119,b119) xor2(p119,a119,b119)#5 and2(g119,a119,b119)#5 end netlist // PGgen (g120,p120,a120,b120) xor2(p120,a120,b120)#5 and2(g120,a120,b120)#5 end netlist // PGgen (g121,p121,a121,b121) xor2(p121,a121,b121)#5 and2(g121,a121,b121)#5 end netlist // PGgen (g122,p122,a122,b122) xor2(p122,a122,b122)#5 and2(g122,a122,b122)#5 end netlist // PGgen (g123,p123,a123,b123) xor2(p123,a123,b123)#5 and2(g123,a123,b123)#5 end netlist // PGgen (g124,p124,a124,b124) xor2(p124,a124,b124)#5 and2(g124,a124,b124)#5 end netlist // PGgen (g125,p125,a125,b125) xor2(p125,a125,b125)#5 and2(g125,a125,b125)#5 end netlist // PGgen (g126,p126,a126,b126) xor2(p126,a126,b126)#5 and2(g126,a126,b126)#5 end netlist // PGgen (g127,p127,a127,b127) xor2(p127,a127,b127)#5 and2(g127,a127,b127)#5 end netlist // Gcombine (g_0_cin, g0, cin, p0 ) and2(w0g_0_cin, p0, cin )#5 or2( g_0_cin, w0g_0_cin, g0 )#5 end netlist // PGcombine (g_1_0,p_1_0,g1,p1,g0,p0) and2( w0g_1_0, p1, g0 )#5 or2( g_1_0, w0g_1_0, g1 )#5 and2( p_1_0, p1, p0)#5 end netlist // PGcombine (g_2_1,p_2_1,g2,p2,g1,p1) and2( w0g_2_1, p2, g1 )#5 or2( g_2_1, w0g_2_1, g2 )#5 and2( p_2_1, p2, p1)#5 end netlist // PGcombine (g_3_2,p_3_2,g3,p3,g2,p2) and2( w0g_3_2, p3, g2 )#5 or2( g_3_2, w0g_3_2, g3 )#5 and2( p_3_2, p3, p2)#5 end netlist // PGcombine (g_4_3,p_4_3,g4,p4,g3,p3) and2( w0g_4_3, p4, g3 )#5 or2( g_4_3, w0g_4_3, g4 )#5 and2( p_4_3, p4, p3)#5 end netlist // PGcombine (g_5_4,p_5_4,g5,p5,g4,p4) and2( w0g_5_4, p5, g4 )#5 or2( g_5_4, w0g_5_4, g5 )#5 and2( p_5_4, p5, p4)#5 end netlist // PGcombine (g_6_5,p_6_5,g6,p6,g5,p5) and2( w0g_6_5, p6, g5 )#5 or2( g_6_5, w0g_6_5, g6 )#5 and2( p_6_5, p6, p5)#5 end netlist // PGcombine (g_7_6,p_7_6,g7,p7,g6,p6) and2( w0g_7_6, p7, g6 )#5 or2( g_7_6, w0g_7_6, g7 )#5 and2( p_7_6, p7, p6)#5 end netlist // PGcombine (g_8_7,p_8_7,g8,p8,g7,p7) and2( w0g_8_7, p8, g7 )#5 or2( g_8_7, w0g_8_7, g8 )#5 and2( p_8_7, p8, p7)#5 end netlist // PGcombine (g_9_8,p_9_8,g9,p9,g8,p8) and2( w0g_9_8, p9, g8 )#5 or2( g_9_8, w0g_9_8, g9 )#5 and2( p_9_8, p9, p8)#5 end netlist // PGcombine (g_10_9,p_10_9,g10,p10,g9,p9) and2( w0g_10_9, p10, g9 )#5 or2( g_10_9, w0g_10_9, g10 )#5 and2( p_10_9, p10, p9)#5 end netlist // PGcombine (g_11_10,p_11_10,g11,p11,g10,p10) and2( w0g_11_10, p11, g10 )#5 or2( g_11_10, w0g_11_10, g11 )#5 and2( p_11_10, p11, p10)#5 end netlist // PGcombine (g_12_11,p_12_11,g12,p12,g11,p11) and2( w0g_12_11, p12, g11 )#5 or2( g_12_11, w0g_12_11, g12 )#5 and2( p_12_11, p12, p11)#5 end netlist // PGcombine (g_13_12,p_13_12,g13,p13,g12,p12) and2( w0g_13_12, p13, g12 )#5 or2( g_13_12, w0g_13_12, g13 )#5 and2( p_13_12, p13, p12)#5 end netlist // PGcombine (g_14_13,p_14_13,g14,p14,g13,p13) and2( w0g_14_13, p14, g13 )#5 or2( g_14_13, w0g_14_13, g14 )#5 and2( p_14_13, p14, p13)#5 end netlist // PGcombine (g_15_14,p_15_14,g15,p15,g14,p14) and2( w0g_15_14, p15, g14 )#5 or2( g_15_14, w0g_15_14, g15 )#5 and2( p_15_14, p15, p14)#5 end netlist // PGcombine (g_16_15,p_16_15,g16,p16,g15,p15) and2( w0g_16_15, p16, g15 )#5 or2( g_16_15, w0g_16_15, g16 )#5 and2( p_16_15, p16, p15)#5 end netlist // PGcombine (g_17_16,p_17_16,g17,p17,g16,p16) and2( w0g_17_16, p17, g16 )#5 or2( g_17_16, w0g_17_16, g17 )#5 and2( p_17_16, p17, p16)#5 end netlist // PGcombine (g_18_17,p_18_17,g18,p18,g17,p17) and2( w0g_18_17, p18, g17 )#5 or2( g_18_17, w0g_18_17, g18 )#5 and2( p_18_17, p18, p17)#5 end netlist // PGcombine (g_19_18,p_19_18,g19,p19,g18,p18) and2( w0g_19_18, p19, g18 )#5 or2( g_19_18, w0g_19_18, g19 )#5 and2( p_19_18, p19, p18)#5 end netlist // PGcombine (g_20_19,p_20_19,g20,p20,g19,p19) and2( w0g_20_19, p20, g19 )#5 or2( g_20_19, w0g_20_19, g20 )#5 and2( p_20_19, p20, p19)#5 end netlist // PGcombine (g_21_20,p_21_20,g21,p21,g20,p20) and2( w0g_21_20, p21, g20 )#5 or2( g_21_20, w0g_21_20, g21 )#5 and2( p_21_20, p21, p20)#5 end netlist // PGcombine (g_22_21,p_22_21,g22,p22,g21,p21) and2( w0g_22_21, p22, g21 )#5 or2( g_22_21, w0g_22_21, g22 )#5 and2( p_22_21, p22, p21)#5 end netlist // PGcombine (g_23_22,p_23_22,g23,p23,g22,p22) and2( w0g_23_22, p23, g22 )#5 or2( g_23_22, w0g_23_22, g23 )#5 and2( p_23_22, p23, p22)#5 end netlist // PGcombine (g_24_23,p_24_23,g24,p24,g23,p23) and2( w0g_24_23, p24, g23 )#5 or2( g_24_23, w0g_24_23, g24 )#5 and2( p_24_23, p24, p23)#5 end netlist // PGcombine (g_25_24,p_25_24,g25,p25,g24,p24) and2( w0g_25_24, p25, g24 )#5 or2( g_25_24, w0g_25_24, g25 )#5 and2( p_25_24, p25, p24)#5 end netlist // PGcombine (g_26_25,p_26_25,g26,p26,g25,p25) and2( w0g_26_25, p26, g25 )#5 or2( g_26_25, w0g_26_25, g26 )#5 and2( p_26_25, p26, p25)#5 end netlist // PGcombine (g_27_26,p_27_26,g27,p27,g26,p26) and2( w0g_27_26, p27, g26 )#5 or2( g_27_26, w0g_27_26, g27 )#5 and2( p_27_26, p27, p26)#5 end netlist // PGcombine (g_28_27,p_28_27,g28,p28,g27,p27) and2( w0g_28_27, p28, g27 )#5 or2( g_28_27, w0g_28_27, g28 )#5 and2( p_28_27, p28, p27)#5 end netlist // PGcombine (g_29_28,p_29_28,g29,p29,g28,p28) and2( w0g_29_28, p29, g28 )#5 or2( g_29_28, w0g_29_28, g29 )#5 and2( p_29_28, p29, p28)#5 end netlist // PGcombine (g_30_29,p_30_29,g30,p30,g29,p29) and2( w0g_30_29, p30, g29 )#5 or2( g_30_29, w0g_30_29, g30 )#5 and2( p_30_29, p30, p29)#5 end netlist // PGcombine (g_31_30,p_31_30,g31,p31,g30,p30) and2( w0g_31_30, p31, g30 )#5 or2( g_31_30, w0g_31_30, g31 )#5 and2( p_31_30, p31, p30)#5 end netlist // PGcombine (g_32_31,p_32_31,g32,p32,g31,p31) and2( w0g_32_31, p32, g31 )#5 or2( g_32_31, w0g_32_31, g32 )#5 and2( p_32_31, p32, p31)#5 end netlist // PGcombine (g_33_32,p_33_32,g33,p33,g32,p32) and2( w0g_33_32, p33, g32 )#5 or2( g_33_32, w0g_33_32, g33 )#5 and2( p_33_32, p33, p32)#5 end netlist // PGcombine (g_34_33,p_34_33,g34,p34,g33,p33) and2( w0g_34_33, p34, g33 )#5 or2( g_34_33, w0g_34_33, g34 )#5 and2( p_34_33, p34, p33)#5 end netlist // PGcombine (g_35_34,p_35_34,g35,p35,g34,p34) and2( w0g_35_34, p35, g34 )#5 or2( g_35_34, w0g_35_34, g35 )#5 and2( p_35_34, p35, p34)#5 end netlist // PGcombine (g_36_35,p_36_35,g36,p36,g35,p35) and2( w0g_36_35, p36, g35 )#5 or2( g_36_35, w0g_36_35, g36 )#5 and2( p_36_35, p36, p35)#5 end netlist // PGcombine (g_37_36,p_37_36,g37,p37,g36,p36) and2( w0g_37_36, p37, g36 )#5 or2( g_37_36, w0g_37_36, g37 )#5 and2( p_37_36, p37, p36)#5 end netlist // PGcombine (g_38_37,p_38_37,g38,p38,g37,p37) and2( w0g_38_37, p38, g37 )#5 or2( g_38_37, w0g_38_37, g38 )#5 and2( p_38_37, p38, p37)#5 end netlist // PGcombine (g_39_38,p_39_38,g39,p39,g38,p38) and2( w0g_39_38, p39, g38 )#5 or2( g_39_38, w0g_39_38, g39 )#5 and2( p_39_38, p39, p38)#5 end netlist // PGcombine (g_40_39,p_40_39,g40,p40,g39,p39) and2( w0g_40_39, p40, g39 )#5 or2( g_40_39, w0g_40_39, g40 )#5 and2( p_40_39, p40, p39)#5 end netlist // PGcombine (g_41_40,p_41_40,g41,p41,g40,p40) and2( w0g_41_40, p41, g40 )#5 or2( g_41_40, w0g_41_40, g41 )#5 and2( p_41_40, p41, p40)#5 end netlist // PGcombine (g_42_41,p_42_41,g42,p42,g41,p41) and2( w0g_42_41, p42, g41 )#5 or2( g_42_41, w0g_42_41, g42 )#5 and2( p_42_41, p42, p41)#5 end netlist // PGcombine (g_43_42,p_43_42,g43,p43,g42,p42) and2( w0g_43_42, p43, g42 )#5 or2( g_43_42, w0g_43_42, g43 )#5 and2( p_43_42, p43, p42)#5 end netlist // PGcombine (g_44_43,p_44_43,g44,p44,g43,p43) and2( w0g_44_43, p44, g43 )#5 or2( g_44_43, w0g_44_43, g44 )#5 and2( p_44_43, p44, p43)#5 end netlist // PGcombine (g_45_44,p_45_44,g45,p45,g44,p44) and2( w0g_45_44, p45, g44 )#5 or2( g_45_44, w0g_45_44, g45 )#5 and2( p_45_44, p45, p44)#5 end netlist // PGcombine (g_46_45,p_46_45,g46,p46,g45,p45) and2( w0g_46_45, p46, g45 )#5 or2( g_46_45, w0g_46_45, g46 )#5 and2( p_46_45, p46, p45)#5 end netlist // PGcombine (g_47_46,p_47_46,g47,p47,g46,p46) and2( w0g_47_46, p47, g46 )#5 or2( g_47_46, w0g_47_46, g47 )#5 and2( p_47_46, p47, p46)#5 end netlist // PGcombine (g_48_47,p_48_47,g48,p48,g47,p47) and2( w0g_48_47, p48, g47 )#5 or2( g_48_47, w0g_48_47, g48 )#5 and2( p_48_47, p48, p47)#5 end netlist // PGcombine (g_49_48,p_49_48,g49,p49,g48,p48) and2( w0g_49_48, p49, g48 )#5 or2( g_49_48, w0g_49_48, g49 )#5 and2( p_49_48, p49, p48)#5 end netlist // PGcombine (g_50_49,p_50_49,g50,p50,g49,p49) and2( w0g_50_49, p50, g49 )#5 or2( g_50_49, w0g_50_49, g50 )#5 and2( p_50_49, p50, p49)#5 end netlist // PGcombine (g_51_50,p_51_50,g51,p51,g50,p50) and2( w0g_51_50, p51, g50 )#5 or2( g_51_50, w0g_51_50, g51 )#5 and2( p_51_50, p51, p50)#5 end netlist // PGcombine (g_52_51,p_52_51,g52,p52,g51,p51) and2( w0g_52_51, p52, g51 )#5 or2( g_52_51, w0g_52_51, g52 )#5 and2( p_52_51, p52, p51)#5 end netlist // PGcombine (g_53_52,p_53_52,g53,p53,g52,p52) and2( w0g_53_52, p53, g52 )#5 or2( g_53_52, w0g_53_52, g53 )#5 and2( p_53_52, p53, p52)#5 end netlist // PGcombine (g_54_53,p_54_53,g54,p54,g53,p53) and2( w0g_54_53, p54, g53 )#5 or2( g_54_53, w0g_54_53, g54 )#5 and2( p_54_53, p54, p53)#5 end netlist // PGcombine (g_55_54,p_55_54,g55,p55,g54,p54) and2( w0g_55_54, p55, g54 )#5 or2( g_55_54, w0g_55_54, g55 )#5 and2( p_55_54, p55, p54)#5 end netlist // PGcombine (g_56_55,p_56_55,g56,p56,g55,p55) and2( w0g_56_55, p56, g55 )#5 or2( g_56_55, w0g_56_55, g56 )#5 and2( p_56_55, p56, p55)#5 end netlist // PGcombine (g_57_56,p_57_56,g57,p57,g56,p56) and2( w0g_57_56, p57, g56 )#5 or2( g_57_56, w0g_57_56, g57 )#5 and2( p_57_56, p57, p56)#5 end netlist // PGcombine (g_58_57,p_58_57,g58,p58,g57,p57) and2( w0g_58_57, p58, g57 )#5 or2( g_58_57, w0g_58_57, g58 )#5 and2( p_58_57, p58, p57)#5 end netlist // PGcombine (g_59_58,p_59_58,g59,p59,g58,p58) and2( w0g_59_58, p59, g58 )#5 or2( g_59_58, w0g_59_58, g59 )#5 and2( p_59_58, p59, p58)#5 end netlist // PGcombine (g_60_59,p_60_59,g60,p60,g59,p59) and2( w0g_60_59, p60, g59 )#5 or2( g_60_59, w0g_60_59, g60 )#5 and2( p_60_59, p60, p59)#5 end netlist // PGcombine (g_61_60,p_61_60,g61,p61,g60,p60) and2( w0g_61_60, p61, g60 )#5 or2( g_61_60, w0g_61_60, g61 )#5 and2( p_61_60, p61, p60)#5 end netlist // PGcombine (g_62_61,p_62_61,g62,p62,g61,p61) and2( w0g_62_61, p62, g61 )#5 or2( g_62_61, w0g_62_61, g62 )#5 and2( p_62_61, p62, p61)#5 end netlist // PGcombine (g_63_62,p_63_62,g63,p63,g62,p62) and2( w0g_63_62, p63, g62 )#5 or2( g_63_62, w0g_63_62, g63 )#5 and2( p_63_62, p63, p62)#5 end netlist // PGcombine (g_64_63,p_64_63,g64,p64,g63,p63) and2( w0g_64_63, p64, g63 )#5 or2( g_64_63, w0g_64_63, g64 )#5 and2( p_64_63, p64, p63)#5 end netlist // PGcombine (g_65_64,p_65_64,g65,p65,g64,p64) and2( w0g_65_64, p65, g64 )#5 or2( g_65_64, w0g_65_64, g65 )#5 and2( p_65_64, p65, p64)#5 end netlist // PGcombine (g_66_65,p_66_65,g66,p66,g65,p65) and2( w0g_66_65, p66, g65 )#5 or2( g_66_65, w0g_66_65, g66 )#5 and2( p_66_65, p66, p65)#5 end netlist // PGcombine (g_67_66,p_67_66,g67,p67,g66,p66) and2( w0g_67_66, p67, g66 )#5 or2( g_67_66, w0g_67_66, g67 )#5 and2( p_67_66, p67, p66)#5 end netlist // PGcombine (g_68_67,p_68_67,g68,p68,g67,p67) and2( w0g_68_67, p68, g67 )#5 or2( g_68_67, w0g_68_67, g68 )#5 and2( p_68_67, p68, p67)#5 end netlist // PGcombine (g_69_68,p_69_68,g69,p69,g68,p68) and2( w0g_69_68, p69, g68 )#5 or2( g_69_68, w0g_69_68, g69 )#5 and2( p_69_68, p69, p68)#5 end netlist // PGcombine (g_70_69,p_70_69,g70,p70,g69,p69) and2( w0g_70_69, p70, g69 )#5 or2( g_70_69, w0g_70_69, g70 )#5 and2( p_70_69, p70, p69)#5 end netlist // PGcombine (g_71_70,p_71_70,g71,p71,g70,p70) and2( w0g_71_70, p71, g70 )#5 or2( g_71_70, w0g_71_70, g71 )#5 and2( p_71_70, p71, p70)#5 end netlist // PGcombine (g_72_71,p_72_71,g72,p72,g71,p71) and2( w0g_72_71, p72, g71 )#5 or2( g_72_71, w0g_72_71, g72 )#5 and2( p_72_71, p72, p71)#5 end netlist // PGcombine (g_73_72,p_73_72,g73,p73,g72,p72) and2( w0g_73_72, p73, g72 )#5 or2( g_73_72, w0g_73_72, g73 )#5 and2( p_73_72, p73, p72)#5 end netlist // PGcombine (g_74_73,p_74_73,g74,p74,g73,p73) and2( w0g_74_73, p74, g73 )#5 or2( g_74_73, w0g_74_73, g74 )#5 and2( p_74_73, p74, p73)#5 end netlist // PGcombine (g_75_74,p_75_74,g75,p75,g74,p74) and2( w0g_75_74, p75, g74 )#5 or2( g_75_74, w0g_75_74, g75 )#5 and2( p_75_74, p75, p74)#5 end netlist // PGcombine (g_76_75,p_76_75,g76,p76,g75,p75) and2( w0g_76_75, p76, g75 )#5 or2( g_76_75, w0g_76_75, g76 )#5 and2( p_76_75, p76, p75)#5 end netlist // PGcombine (g_77_76,p_77_76,g77,p77,g76,p76) and2( w0g_77_76, p77, g76 )#5 or2( g_77_76, w0g_77_76, g77 )#5 and2( p_77_76, p77, p76)#5 end netlist // PGcombine (g_78_77,p_78_77,g78,p78,g77,p77) and2( w0g_78_77, p78, g77 )#5 or2( g_78_77, w0g_78_77, g78 )#5 and2( p_78_77, p78, p77)#5 end netlist // PGcombine (g_79_78,p_79_78,g79,p79,g78,p78) and2( w0g_79_78, p79, g78 )#5 or2( g_79_78, w0g_79_78, g79 )#5 and2( p_79_78, p79, p78)#5 end netlist // PGcombine (g_80_79,p_80_79,g80,p80,g79,p79) and2( w0g_80_79, p80, g79 )#5 or2( g_80_79, w0g_80_79, g80 )#5 and2( p_80_79, p80, p79)#5 end netlist // PGcombine (g_81_80,p_81_80,g81,p81,g80,p80) and2( w0g_81_80, p81, g80 )#5 or2( g_81_80, w0g_81_80, g81 )#5 and2( p_81_80, p81, p80)#5 end netlist // PGcombine (g_82_81,p_82_81,g82,p82,g81,p81) and2( w0g_82_81, p82, g81 )#5 or2( g_82_81, w0g_82_81, g82 )#5 and2( p_82_81, p82, p81)#5 end netlist // PGcombine (g_83_82,p_83_82,g83,p83,g82,p82) and2( w0g_83_82, p83, g82 )#5 or2( g_83_82, w0g_83_82, g83 )#5 and2( p_83_82, p83, p82)#5 end netlist // PGcombine (g_84_83,p_84_83,g84,p84,g83,p83) and2( w0g_84_83, p84, g83 )#5 or2( g_84_83, w0g_84_83, g84 )#5 and2( p_84_83, p84, p83)#5 end netlist // PGcombine (g_85_84,p_85_84,g85,p85,g84,p84) and2( w0g_85_84, p85, g84 )#5 or2( g_85_84, w0g_85_84, g85 )#5 and2( p_85_84, p85, p84)#5 end netlist // PGcombine (g_86_85,p_86_85,g86,p86,g85,p85) and2( w0g_86_85, p86, g85 )#5 or2( g_86_85, w0g_86_85, g86 )#5 and2( p_86_85, p86, p85)#5 end netlist // PGcombine (g_87_86,p_87_86,g87,p87,g86,p86) and2( w0g_87_86, p87, g86 )#5 or2( g_87_86, w0g_87_86, g87 )#5 and2( p_87_86, p87, p86)#5 end netlist // PGcombine (g_88_87,p_88_87,g88,p88,g87,p87) and2( w0g_88_87, p88, g87 )#5 or2( g_88_87, w0g_88_87, g88 )#5 and2( p_88_87, p88, p87)#5 end netlist // PGcombine (g_89_88,p_89_88,g89,p89,g88,p88) and2( w0g_89_88, p89, g88 )#5 or2( g_89_88, w0g_89_88, g89 )#5 and2( p_89_88, p89, p88)#5 end netlist // PGcombine (g_90_89,p_90_89,g90,p90,g89,p89) and2( w0g_90_89, p90, g89 )#5 or2( g_90_89, w0g_90_89, g90 )#5 and2( p_90_89, p90, p89)#5 end netlist // PGcombine (g_91_90,p_91_90,g91,p91,g90,p90) and2( w0g_91_90, p91, g90 )#5 or2( g_91_90, w0g_91_90, g91 )#5 and2( p_91_90, p91, p90)#5 end netlist // PGcombine (g_92_91,p_92_91,g92,p92,g91,p91) and2( w0g_92_91, p92, g91 )#5 or2( g_92_91, w0g_92_91, g92 )#5 and2( p_92_91, p92, p91)#5 end netlist // PGcombine (g_93_92,p_93_92,g93,p93,g92,p92) and2( w0g_93_92, p93, g92 )#5 or2( g_93_92, w0g_93_92, g93 )#5 and2( p_93_92, p93, p92)#5 end netlist // PGcombine (g_94_93,p_94_93,g94,p94,g93,p93) and2( w0g_94_93, p94, g93 )#5 or2( g_94_93, w0g_94_93, g94 )#5 and2( p_94_93, p94, p93)#5 end netlist // PGcombine (g_95_94,p_95_94,g95,p95,g94,p94) and2( w0g_95_94, p95, g94 )#5 or2( g_95_94, w0g_95_94, g95 )#5 and2( p_95_94, p95, p94)#5 end netlist // PGcombine (g_96_95,p_96_95,g96,p96,g95,p95) and2( w0g_96_95, p96, g95 )#5 or2( g_96_95, w0g_96_95, g96 )#5 and2( p_96_95, p96, p95)#5 end netlist // PGcombine (g_97_96,p_97_96,g97,p97,g96,p96) and2( w0g_97_96, p97, g96 )#5 or2( g_97_96, w0g_97_96, g97 )#5 and2( p_97_96, p97, p96)#5 end netlist // PGcombine (g_98_97,p_98_97,g98,p98,g97,p97) and2( w0g_98_97, p98, g97 )#5 or2( g_98_97, w0g_98_97, g98 )#5 and2( p_98_97, p98, p97)#5 end netlist // PGcombine (g_99_98,p_99_98,g99,p99,g98,p98) and2( w0g_99_98, p99, g98 )#5 or2( g_99_98, w0g_99_98, g99 )#5 and2( p_99_98, p99, p98)#5 end netlist // PGcombine (g_100_99,p_100_99,g100,p100,g99,p99) and2( w0g_100_99, p100, g99 )#5 or2( g_100_99, w0g_100_99, g100 )#5 and2( p_100_99, p100, p99)#5 end netlist // PGcombine (g_101_100,p_101_100,g101,p101,g100,p100) and2( w0g_101_100, p101, g100 )#5 or2( g_101_100, w0g_101_100, g101 )#5 and2( p_101_100, p101, p100)#5 end netlist // PGcombine (g_102_101,p_102_101,g102,p102,g101,p101) and2( w0g_102_101, p102, g101 )#5 or2( g_102_101, w0g_102_101, g102 )#5 and2( p_102_101, p102, p101)#5 end netlist // PGcombine (g_103_102,p_103_102,g103,p103,g102,p102) and2( w0g_103_102, p103, g102 )#5 or2( g_103_102, w0g_103_102, g103 )#5 and2( p_103_102, p103, p102)#5 end netlist // PGcombine (g_104_103,p_104_103,g104,p104,g103,p103) and2( w0g_104_103, p104, g103 )#5 or2( g_104_103, w0g_104_103, g104 )#5 and2( p_104_103, p104, p103)#5 end netlist // PGcombine (g_105_104,p_105_104,g105,p105,g104,p104) and2( w0g_105_104, p105, g104 )#5 or2( g_105_104, w0g_105_104, g105 )#5 and2( p_105_104, p105, p104)#5 end netlist // PGcombine (g_106_105,p_106_105,g106,p106,g105,p105) and2( w0g_106_105, p106, g105 )#5 or2( g_106_105, w0g_106_105, g106 )#5 and2( p_106_105, p106, p105)#5 end netlist // PGcombine (g_107_106,p_107_106,g107,p107,g106,p106) and2( w0g_107_106, p107, g106 )#5 or2( g_107_106, w0g_107_106, g107 )#5 and2( p_107_106, p107, p106)#5 end netlist // PGcombine (g_108_107,p_108_107,g108,p108,g107,p107) and2( w0g_108_107, p108, g107 )#5 or2( g_108_107, w0g_108_107, g108 )#5 and2( p_108_107, p108, p107)#5 end netlist // PGcombine (g_109_108,p_109_108,g109,p109,g108,p108) and2( w0g_109_108, p109, g108 )#5 or2( g_109_108, w0g_109_108, g109 )#5 and2( p_109_108, p109, p108)#5 end netlist // PGcombine (g_110_109,p_110_109,g110,p110,g109,p109) and2( w0g_110_109, p110, g109 )#5 or2( g_110_109, w0g_110_109, g110 )#5 and2( p_110_109, p110, p109)#5 end netlist // PGcombine (g_111_110,p_111_110,g111,p111,g110,p110) and2( w0g_111_110, p111, g110 )#5 or2( g_111_110, w0g_111_110, g111 )#5 and2( p_111_110, p111, p110)#5 end netlist // PGcombine (g_112_111,p_112_111,g112,p112,g111,p111) and2( w0g_112_111, p112, g111 )#5 or2( g_112_111, w0g_112_111, g112 )#5 and2( p_112_111, p112, p111)#5 end netlist // PGcombine (g_113_112,p_113_112,g113,p113,g112,p112) and2( w0g_113_112, p113, g112 )#5 or2( g_113_112, w0g_113_112, g113 )#5 and2( p_113_112, p113, p112)#5 end netlist // PGcombine (g_114_113,p_114_113,g114,p114,g113,p113) and2( w0g_114_113, p114, g113 )#5 or2( g_114_113, w0g_114_113, g114 )#5 and2( p_114_113, p114, p113)#5 end netlist // PGcombine (g_115_114,p_115_114,g115,p115,g114,p114) and2( w0g_115_114, p115, g114 )#5 or2( g_115_114, w0g_115_114, g115 )#5 and2( p_115_114, p115, p114)#5 end netlist // PGcombine (g_116_115,p_116_115,g116,p116,g115,p115) and2( w0g_116_115, p116, g115 )#5 or2( g_116_115, w0g_116_115, g116 )#5 and2( p_116_115, p116, p115)#5 end netlist // PGcombine (g_117_116,p_117_116,g117,p117,g116,p116) and2( w0g_117_116, p117, g116 )#5 or2( g_117_116, w0g_117_116, g117 )#5 and2( p_117_116, p117, p116)#5 end netlist // PGcombine (g_118_117,p_118_117,g118,p118,g117,p117) and2( w0g_118_117, p118, g117 )#5 or2( g_118_117, w0g_118_117, g118 )#5 and2( p_118_117, p118, p117)#5 end netlist // PGcombine (g_119_118,p_119_118,g119,p119,g118,p118) and2( w0g_119_118, p119, g118 )#5 or2( g_119_118, w0g_119_118, g119 )#5 and2( p_119_118, p119, p118)#5 end netlist // PGcombine (g_120_119,p_120_119,g120,p120,g119,p119) and2( w0g_120_119, p120, g119 )#5 or2( g_120_119, w0g_120_119, g120 )#5 and2( p_120_119, p120, p119)#5 end netlist // PGcombine (g_121_120,p_121_120,g121,p121,g120,p120) and2( w0g_121_120, p121, g120 )#5 or2( g_121_120, w0g_121_120, g121 )#5 and2( p_121_120, p121, p120)#5 end netlist // PGcombine (g_122_121,p_122_121,g122,p122,g121,p121) and2( w0g_122_121, p122, g121 )#5 or2( g_122_121, w0g_122_121, g122 )#5 and2( p_122_121, p122, p121)#5 end netlist // PGcombine (g_123_122,p_123_122,g123,p123,g122,p122) and2( w0g_123_122, p123, g122 )#5 or2( g_123_122, w0g_123_122, g123 )#5 and2( p_123_122, p123, p122)#5 end netlist // PGcombine (g_124_123,p_124_123,g124,p124,g123,p123) and2( w0g_124_123, p124, g123 )#5 or2( g_124_123, w0g_124_123, g124 )#5 and2( p_124_123, p124, p123)#5 end netlist // PGcombine (g_125_124,p_125_124,g125,p125,g124,p124) and2( w0g_125_124, p125, g124 )#5 or2( g_125_124, w0g_125_124, g125 )#5 and2( p_125_124, p125, p124)#5 end netlist // PGcombine (g_126_125,p_126_125,g126,p126,g125,p125) and2( w0g_126_125, p126, g125 )#5 or2( g_126_125, w0g_126_125, g126 )#5 and2( p_126_125, p126, p125)#5 end netlist // PGcombine (g_127_126,p_127_126,g127,p127,g126,p126) and2( w0g_127_126, p127, g126 )#5 or2( g_127_126, w0g_127_126, g127 )#5 and2( p_127_126, p127, p126)#5 end netlist // Gcombine (g_1_cin, g_1_0, cin, p_1_0 ) and2(w0g_1_cin, p_1_0, cin )#5 or2( g_1_cin, w0g_1_cin, g_1_0 )#5 end netlist // Gcombine (g_2_cin, g_2_1, g_0_cin, p_2_1 ) and2(w0g_2_cin, p_2_1, g_0_cin )#5 or2( g_2_cin, w0g_2_cin, g_2_1 )#5 end netlist // PGcombine (g_3_0,p_3_0,g_3_2,p_3_2,g_1_0,p_1_0) and2( w0g_3_0, p_3_2, g_1_0 )#5 or2( g_3_0, w0g_3_0, g_3_2 )#5 and2( p_3_0, p_3_2, p_1_0)#5 end netlist // PGcombine (g_4_1,p_4_1,g_4_3,p_4_3,g_2_1,p_2_1) and2( w0g_4_1, p_4_3, g_2_1 )#5 or2( g_4_1, w0g_4_1, g_4_3 )#5 and2( p_4_1, p_4_3, p_2_1)#5 end netlist // PGcombine (g_5_2,p_5_2,g_5_4,p_5_4,g_3_2,p_3_2) and2( w0g_5_2, p_5_4, g_3_2 )#5 or2( g_5_2, w0g_5_2, g_5_4 )#5 and2( p_5_2, p_5_4, p_3_2)#5 end netlist // PGcombine (g_6_3,p_6_3,g_6_5,p_6_5,g_4_3,p_4_3) and2( w0g_6_3, p_6_5, g_4_3 )#5 or2( g_6_3, w0g_6_3, g_6_5 )#5 and2( p_6_3, p_6_5, p_4_3)#5 end netlist // PGcombine (g_7_4,p_7_4,g_7_6,p_7_6,g_5_4,p_5_4) and2( w0g_7_4, p_7_6, g_5_4 )#5 or2( g_7_4, w0g_7_4, g_7_6 )#5 and2( p_7_4, p_7_6, p_5_4)#5 end netlist // PGcombine (g_8_5,p_8_5,g_8_7,p_8_7,g_6_5,p_6_5) and2( w0g_8_5, p_8_7, g_6_5 )#5 or2( g_8_5, w0g_8_5, g_8_7 )#5 and2( p_8_5, p_8_7, p_6_5)#5 end netlist // PGcombine (g_9_6,p_9_6,g_9_8,p_9_8,g_7_6,p_7_6) and2( w0g_9_6, p_9_8, g_7_6 )#5 or2( g_9_6, w0g_9_6, g_9_8 )#5 and2( p_9_6, p_9_8, p_7_6)#5 end netlist // PGcombine (g_10_7,p_10_7,g_10_9,p_10_9,g_8_7,p_8_7) and2( w0g_10_7, p_10_9, g_8_7 )#5 or2( g_10_7, w0g_10_7, g_10_9 )#5 and2( p_10_7, p_10_9, p_8_7)#5 end netlist // PGcombine (g_11_8,p_11_8,g_11_10,p_11_10,g_9_8,p_9_8) and2( w0g_11_8, p_11_10, g_9_8 )#5 or2( g_11_8, w0g_11_8, g_11_10 )#5 and2( p_11_8, p_11_10, p_9_8)#5 end netlist // PGcombine (g_12_9,p_12_9,g_12_11,p_12_11,g_10_9,p_10_9) and2( w0g_12_9, p_12_11, g_10_9 )#5 or2( g_12_9, w0g_12_9, g_12_11 )#5 and2( p_12_9, p_12_11, p_10_9)#5 end netlist // PGcombine (g_13_10,p_13_10,g_13_12,p_13_12,g_11_10,p_11_10) and2( w0g_13_10, p_13_12, g_11_10 )#5 or2( g_13_10, w0g_13_10, g_13_12 )#5 and2( p_13_10, p_13_12, p_11_10)#5 end netlist // PGcombine (g_14_11,p_14_11,g_14_13,p_14_13,g_12_11,p_12_11) and2( w0g_14_11, p_14_13, g_12_11 )#5 or2( g_14_11, w0g_14_11, g_14_13 )#5 and2( p_14_11, p_14_13, p_12_11)#5 end netlist // PGcombine (g_15_12,p_15_12,g_15_14,p_15_14,g_13_12,p_13_12) and2( w0g_15_12, p_15_14, g_13_12 )#5 or2( g_15_12, w0g_15_12, g_15_14 )#5 and2( p_15_12, p_15_14, p_13_12)#5 end netlist // PGcombine (g_16_13,p_16_13,g_16_15,p_16_15,g_14_13,p_14_13) and2( w0g_16_13, p_16_15, g_14_13 )#5 or2( g_16_13, w0g_16_13, g_16_15 )#5 and2( p_16_13, p_16_15, p_14_13)#5 end netlist // PGcombine (g_17_14,p_17_14,g_17_16,p_17_16,g_15_14,p_15_14) and2( w0g_17_14, p_17_16, g_15_14 )#5 or2( g_17_14, w0g_17_14, g_17_16 )#5 and2( p_17_14, p_17_16, p_15_14)#5 end netlist // PGcombine (g_18_15,p_18_15,g_18_17,p_18_17,g_16_15,p_16_15) and2( w0g_18_15, p_18_17, g_16_15 )#5 or2( g_18_15, w0g_18_15, g_18_17 )#5 and2( p_18_15, p_18_17, p_16_15)#5 end netlist // PGcombine (g_19_16,p_19_16,g_19_18,p_19_18,g_17_16,p_17_16) and2( w0g_19_16, p_19_18, g_17_16 )#5 or2( g_19_16, w0g_19_16, g_19_18 )#5 and2( p_19_16, p_19_18, p_17_16)#5 end netlist // PGcombine (g_20_17,p_20_17,g_20_19,p_20_19,g_18_17,p_18_17) and2( w0g_20_17, p_20_19, g_18_17 )#5 or2( g_20_17, w0g_20_17, g_20_19 )#5 and2( p_20_17, p_20_19, p_18_17)#5 end netlist // PGcombine (g_21_18,p_21_18,g_21_20,p_21_20,g_19_18,p_19_18) and2( w0g_21_18, p_21_20, g_19_18 )#5 or2( g_21_18, w0g_21_18, g_21_20 )#5 and2( p_21_18, p_21_20, p_19_18)#5 end netlist // PGcombine (g_22_19,p_22_19,g_22_21,p_22_21,g_20_19,p_20_19) and2( w0g_22_19, p_22_21, g_20_19 )#5 or2( g_22_19, w0g_22_19, g_22_21 )#5 and2( p_22_19, p_22_21, p_20_19)#5 end netlist // PGcombine (g_23_20,p_23_20,g_23_22,p_23_22,g_21_20,p_21_20) and2( w0g_23_20, p_23_22, g_21_20 )#5 or2( g_23_20, w0g_23_20, g_23_22 )#5 and2( p_23_20, p_23_22, p_21_20)#5 end netlist // PGcombine (g_24_21,p_24_21,g_24_23,p_24_23,g_22_21,p_22_21) and2( w0g_24_21, p_24_23, g_22_21 )#5 or2( g_24_21, w0g_24_21, g_24_23 )#5 and2( p_24_21, p_24_23, p_22_21)#5 end netlist // PGcombine (g_25_22,p_25_22,g_25_24,p_25_24,g_23_22,p_23_22) and2( w0g_25_22, p_25_24, g_23_22 )#5 or2( g_25_22, w0g_25_22, g_25_24 )#5 and2( p_25_22, p_25_24, p_23_22)#5 end netlist // PGcombine (g_26_23,p_26_23,g_26_25,p_26_25,g_24_23,p_24_23) and2( w0g_26_23, p_26_25, g_24_23 )#5 or2( g_26_23, w0g_26_23, g_26_25 )#5 and2( p_26_23, p_26_25, p_24_23)#5 end netlist // PGcombine (g_27_24,p_27_24,g_27_26,p_27_26,g_25_24,p_25_24) and2( w0g_27_24, p_27_26, g_25_24 )#5 or2( g_27_24, w0g_27_24, g_27_26 )#5 and2( p_27_24, p_27_26, p_25_24)#5 end netlist // PGcombine (g_28_25,p_28_25,g_28_27,p_28_27,g_26_25,p_26_25) and2( w0g_28_25, p_28_27, g_26_25 )#5 or2( g_28_25, w0g_28_25, g_28_27 )#5 and2( p_28_25, p_28_27, p_26_25)#5 end netlist // PGcombine (g_29_26,p_29_26,g_29_28,p_29_28,g_27_26,p_27_26) and2( w0g_29_26, p_29_28, g_27_26 )#5 or2( g_29_26, w0g_29_26, g_29_28 )#5 and2( p_29_26, p_29_28, p_27_26)#5 end netlist // PGcombine (g_30_27,p_30_27,g_30_29,p_30_29,g_28_27,p_28_27) and2( w0g_30_27, p_30_29, g_28_27 )#5 or2( g_30_27, w0g_30_27, g_30_29 )#5 and2( p_30_27, p_30_29, p_28_27)#5 end netlist // PGcombine (g_31_28,p_31_28,g_31_30,p_31_30,g_29_28,p_29_28) and2( w0g_31_28, p_31_30, g_29_28 )#5 or2( g_31_28, w0g_31_28, g_31_30 )#5 and2( p_31_28, p_31_30, p_29_28)#5 end netlist // PGcombine (g_32_29,p_32_29,g_32_31,p_32_31,g_30_29,p_30_29) and2( w0g_32_29, p_32_31, g_30_29 )#5 or2( g_32_29, w0g_32_29, g_32_31 )#5 and2( p_32_29, p_32_31, p_30_29)#5 end netlist // PGcombine (g_33_30,p_33_30,g_33_32,p_33_32,g_31_30,p_31_30) and2( w0g_33_30, p_33_32, g_31_30 )#5 or2( g_33_30, w0g_33_30, g_33_32 )#5 and2( p_33_30, p_33_32, p_31_30)#5 end netlist // PGcombine (g_34_31,p_34_31,g_34_33,p_34_33,g_32_31,p_32_31) and2( w0g_34_31, p_34_33, g_32_31 )#5 or2( g_34_31, w0g_34_31, g_34_33 )#5 and2( p_34_31, p_34_33, p_32_31)#5 end netlist // PGcombine (g_35_32,p_35_32,g_35_34,p_35_34,g_33_32,p_33_32) and2( w0g_35_32, p_35_34, g_33_32 )#5 or2( g_35_32, w0g_35_32, g_35_34 )#5 and2( p_35_32, p_35_34, p_33_32)#5 end netlist // PGcombine (g_36_33,p_36_33,g_36_35,p_36_35,g_34_33,p_34_33) and2( w0g_36_33, p_36_35, g_34_33 )#5 or2( g_36_33, w0g_36_33, g_36_35 )#5 and2( p_36_33, p_36_35, p_34_33)#5 end netlist // PGcombine (g_37_34,p_37_34,g_37_36,p_37_36,g_35_34,p_35_34) and2( w0g_37_34, p_37_36, g_35_34 )#5 or2( g_37_34, w0g_37_34, g_37_36 )#5 and2( p_37_34, p_37_36, p_35_34)#5 end netlist // PGcombine (g_38_35,p_38_35,g_38_37,p_38_37,g_36_35,p_36_35) and2( w0g_38_35, p_38_37, g_36_35 )#5 or2( g_38_35, w0g_38_35, g_38_37 )#5 and2( p_38_35, p_38_37, p_36_35)#5 end netlist // PGcombine (g_39_36,p_39_36,g_39_38,p_39_38,g_37_36,p_37_36) and2( w0g_39_36, p_39_38, g_37_36 )#5 or2( g_39_36, w0g_39_36, g_39_38 )#5 and2( p_39_36, p_39_38, p_37_36)#5 end netlist // PGcombine (g_40_37,p_40_37,g_40_39,p_40_39,g_38_37,p_38_37) and2( w0g_40_37, p_40_39, g_38_37 )#5 or2( g_40_37, w0g_40_37, g_40_39 )#5 and2( p_40_37, p_40_39, p_38_37)#5 end netlist // PGcombine (g_41_38,p_41_38,g_41_40,p_41_40,g_39_38,p_39_38) and2( w0g_41_38, p_41_40, g_39_38 )#5 or2( g_41_38, w0g_41_38, g_41_40 )#5 and2( p_41_38, p_41_40, p_39_38)#5 end netlist // PGcombine (g_42_39,p_42_39,g_42_41,p_42_41,g_40_39,p_40_39) and2( w0g_42_39, p_42_41, g_40_39 )#5 or2( g_42_39, w0g_42_39, g_42_41 )#5 and2( p_42_39, p_42_41, p_40_39)#5 end netlist // PGcombine (g_43_40,p_43_40,g_43_42,p_43_42,g_41_40,p_41_40) and2( w0g_43_40, p_43_42, g_41_40 )#5 or2( g_43_40, w0g_43_40, g_43_42 )#5 and2( p_43_40, p_43_42, p_41_40)#5 end netlist // PGcombine (g_44_41,p_44_41,g_44_43,p_44_43,g_42_41,p_42_41) and2( w0g_44_41, p_44_43, g_42_41 )#5 or2( g_44_41, w0g_44_41, g_44_43 )#5 and2( p_44_41, p_44_43, p_42_41)#5 end netlist // PGcombine (g_45_42,p_45_42,g_45_44,p_45_44,g_43_42,p_43_42) and2( w0g_45_42, p_45_44, g_43_42 )#5 or2( g_45_42, w0g_45_42, g_45_44 )#5 and2( p_45_42, p_45_44, p_43_42)#5 end netlist // PGcombine (g_46_43,p_46_43,g_46_45,p_46_45,g_44_43,p_44_43) and2( w0g_46_43, p_46_45, g_44_43 )#5 or2( g_46_43, w0g_46_43, g_46_45 )#5 and2( p_46_43, p_46_45, p_44_43)#5 end netlist // PGcombine (g_47_44,p_47_44,g_47_46,p_47_46,g_45_44,p_45_44) and2( w0g_47_44, p_47_46, g_45_44 )#5 or2( g_47_44, w0g_47_44, g_47_46 )#5 and2( p_47_44, p_47_46, p_45_44)#5 end netlist // PGcombine (g_48_45,p_48_45,g_48_47,p_48_47,g_46_45,p_46_45) and2( w0g_48_45, p_48_47, g_46_45 )#5 or2( g_48_45, w0g_48_45, g_48_47 )#5 and2( p_48_45, p_48_47, p_46_45)#5 end netlist // PGcombine (g_49_46,p_49_46,g_49_48,p_49_48,g_47_46,p_47_46) and2( w0g_49_46, p_49_48, g_47_46 )#5 or2( g_49_46, w0g_49_46, g_49_48 )#5 and2( p_49_46, p_49_48, p_47_46)#5 end netlist // PGcombine (g_50_47,p_50_47,g_50_49,p_50_49,g_48_47,p_48_47) and2( w0g_50_47, p_50_49, g_48_47 )#5 or2( g_50_47, w0g_50_47, g_50_49 )#5 and2( p_50_47, p_50_49, p_48_47)#5 end netlist // PGcombine (g_51_48,p_51_48,g_51_50,p_51_50,g_49_48,p_49_48) and2( w0g_51_48, p_51_50, g_49_48 )#5 or2( g_51_48, w0g_51_48, g_51_50 )#5 and2( p_51_48, p_51_50, p_49_48)#5 end netlist // PGcombine (g_52_49,p_52_49,g_52_51,p_52_51,g_50_49,p_50_49) and2( w0g_52_49, p_52_51, g_50_49 )#5 or2( g_52_49, w0g_52_49, g_52_51 )#5 and2( p_52_49, p_52_51, p_50_49)#5 end netlist // PGcombine (g_53_50,p_53_50,g_53_52,p_53_52,g_51_50,p_51_50) and2( w0g_53_50, p_53_52, g_51_50 )#5 or2( g_53_50, w0g_53_50, g_53_52 )#5 and2( p_53_50, p_53_52, p_51_50)#5 end netlist // PGcombine (g_54_51,p_54_51,g_54_53,p_54_53,g_52_51,p_52_51) and2( w0g_54_51, p_54_53, g_52_51 )#5 or2( g_54_51, w0g_54_51, g_54_53 )#5 and2( p_54_51, p_54_53, p_52_51)#5 end netlist // PGcombine (g_55_52,p_55_52,g_55_54,p_55_54,g_53_52,p_53_52) and2( w0g_55_52, p_55_54, g_53_52 )#5 or2( g_55_52, w0g_55_52, g_55_54 )#5 and2( p_55_52, p_55_54, p_53_52)#5 end netlist // PGcombine (g_56_53,p_56_53,g_56_55,p_56_55,g_54_53,p_54_53) and2( w0g_56_53, p_56_55, g_54_53 )#5 or2( g_56_53, w0g_56_53, g_56_55 )#5 and2( p_56_53, p_56_55, p_54_53)#5 end netlist // PGcombine (g_57_54,p_57_54,g_57_56,p_57_56,g_55_54,p_55_54) and2( w0g_57_54, p_57_56, g_55_54 )#5 or2( g_57_54, w0g_57_54, g_57_56 )#5 and2( p_57_54, p_57_56, p_55_54)#5 end netlist // PGcombine (g_58_55,p_58_55,g_58_57,p_58_57,g_56_55,p_56_55) and2( w0g_58_55, p_58_57, g_56_55 )#5 or2( g_58_55, w0g_58_55, g_58_57 )#5 and2( p_58_55, p_58_57, p_56_55)#5 end netlist // PGcombine (g_59_56,p_59_56,g_59_58,p_59_58,g_57_56,p_57_56) and2( w0g_59_56, p_59_58, g_57_56 )#5 or2( g_59_56, w0g_59_56, g_59_58 )#5 and2( p_59_56, p_59_58, p_57_56)#5 end netlist // PGcombine (g_60_57,p_60_57,g_60_59,p_60_59,g_58_57,p_58_57) and2( w0g_60_57, p_60_59, g_58_57 )#5 or2( g_60_57, w0g_60_57, g_60_59 )#5 and2( p_60_57, p_60_59, p_58_57)#5 end netlist // PGcombine (g_61_58,p_61_58,g_61_60,p_61_60,g_59_58,p_59_58) and2( w0g_61_58, p_61_60, g_59_58 )#5 or2( g_61_58, w0g_61_58, g_61_60 )#5 and2( p_61_58, p_61_60, p_59_58)#5 end netlist // PGcombine (g_62_59,p_62_59,g_62_61,p_62_61,g_60_59,p_60_59) and2( w0g_62_59, p_62_61, g_60_59 )#5 or2( g_62_59, w0g_62_59, g_62_61 )#5 and2( p_62_59, p_62_61, p_60_59)#5 end netlist // PGcombine (g_63_60,p_63_60,g_63_62,p_63_62,g_61_60,p_61_60) and2( w0g_63_60, p_63_62, g_61_60 )#5 or2( g_63_60, w0g_63_60, g_63_62 )#5 and2( p_63_60, p_63_62, p_61_60)#5 end netlist // PGcombine (g_64_61,p_64_61,g_64_63,p_64_63,g_62_61,p_62_61) and2( w0g_64_61, p_64_63, g_62_61 )#5 or2( g_64_61, w0g_64_61, g_64_63 )#5 and2( p_64_61, p_64_63, p_62_61)#5 end netlist // PGcombine (g_65_62,p_65_62,g_65_64,p_65_64,g_63_62,p_63_62) and2( w0g_65_62, p_65_64, g_63_62 )#5 or2( g_65_62, w0g_65_62, g_65_64 )#5 and2( p_65_62, p_65_64, p_63_62)#5 end netlist // PGcombine (g_66_63,p_66_63,g_66_65,p_66_65,g_64_63,p_64_63) and2( w0g_66_63, p_66_65, g_64_63 )#5 or2( g_66_63, w0g_66_63, g_66_65 )#5 and2( p_66_63, p_66_65, p_64_63)#5 end netlist // PGcombine (g_67_64,p_67_64,g_67_66,p_67_66,g_65_64,p_65_64) and2( w0g_67_64, p_67_66, g_65_64 )#5 or2( g_67_64, w0g_67_64, g_67_66 )#5 and2( p_67_64, p_67_66, p_65_64)#5 end netlist // PGcombine (g_68_65,p_68_65,g_68_67,p_68_67,g_66_65,p_66_65) and2( w0g_68_65, p_68_67, g_66_65 )#5 or2( g_68_65, w0g_68_65, g_68_67 )#5 and2( p_68_65, p_68_67, p_66_65)#5 end netlist // PGcombine (g_69_66,p_69_66,g_69_68,p_69_68,g_67_66,p_67_66) and2( w0g_69_66, p_69_68, g_67_66 )#5 or2( g_69_66, w0g_69_66, g_69_68 )#5 and2( p_69_66, p_69_68, p_67_66)#5 end netlist // PGcombine (g_70_67,p_70_67,g_70_69,p_70_69,g_68_67,p_68_67) and2( w0g_70_67, p_70_69, g_68_67 )#5 or2( g_70_67, w0g_70_67, g_70_69 )#5 and2( p_70_67, p_70_69, p_68_67)#5 end netlist // PGcombine (g_71_68,p_71_68,g_71_70,p_71_70,g_69_68,p_69_68) and2( w0g_71_68, p_71_70, g_69_68 )#5 or2( g_71_68, w0g_71_68, g_71_70 )#5 and2( p_71_68, p_71_70, p_69_68)#5 end netlist // PGcombine (g_72_69,p_72_69,g_72_71,p_72_71,g_70_69,p_70_69) and2( w0g_72_69, p_72_71, g_70_69 )#5 or2( g_72_69, w0g_72_69, g_72_71 )#5 and2( p_72_69, p_72_71, p_70_69)#5 end netlist // PGcombine (g_73_70,p_73_70,g_73_72,p_73_72,g_71_70,p_71_70) and2( w0g_73_70, p_73_72, g_71_70 )#5 or2( g_73_70, w0g_73_70, g_73_72 )#5 and2( p_73_70, p_73_72, p_71_70)#5 end netlist // PGcombine (g_74_71,p_74_71,g_74_73,p_74_73,g_72_71,p_72_71) and2( w0g_74_71, p_74_73, g_72_71 )#5 or2( g_74_71, w0g_74_71, g_74_73 )#5 and2( p_74_71, p_74_73, p_72_71)#5 end netlist // PGcombine (g_75_72,p_75_72,g_75_74,p_75_74,g_73_72,p_73_72) and2( w0g_75_72, p_75_74, g_73_72 )#5 or2( g_75_72, w0g_75_72, g_75_74 )#5 and2( p_75_72, p_75_74, p_73_72)#5 end netlist // PGcombine (g_76_73,p_76_73,g_76_75,p_76_75,g_74_73,p_74_73) and2( w0g_76_73, p_76_75, g_74_73 )#5 or2( g_76_73, w0g_76_73, g_76_75 )#5 and2( p_76_73, p_76_75, p_74_73)#5 end netlist // PGcombine (g_77_74,p_77_74,g_77_76,p_77_76,g_75_74,p_75_74) and2( w0g_77_74, p_77_76, g_75_74 )#5 or2( g_77_74, w0g_77_74, g_77_76 )#5 and2( p_77_74, p_77_76, p_75_74)#5 end netlist // PGcombine (g_78_75,p_78_75,g_78_77,p_78_77,g_76_75,p_76_75) and2( w0g_78_75, p_78_77, g_76_75 )#5 or2( g_78_75, w0g_78_75, g_78_77 )#5 and2( p_78_75, p_78_77, p_76_75)#5 end netlist // PGcombine (g_79_76,p_79_76,g_79_78,p_79_78,g_77_76,p_77_76) and2( w0g_79_76, p_79_78, g_77_76 )#5 or2( g_79_76, w0g_79_76, g_79_78 )#5 and2( p_79_76, p_79_78, p_77_76)#5 end netlist // PGcombine (g_80_77,p_80_77,g_80_79,p_80_79,g_78_77,p_78_77) and2( w0g_80_77, p_80_79, g_78_77 )#5 or2( g_80_77, w0g_80_77, g_80_79 )#5 and2( p_80_77, p_80_79, p_78_77)#5 end netlist // PGcombine (g_81_78,p_81_78,g_81_80,p_81_80,g_79_78,p_79_78) and2( w0g_81_78, p_81_80, g_79_78 )#5 or2( g_81_78, w0g_81_78, g_81_80 )#5 and2( p_81_78, p_81_80, p_79_78)#5 end netlist // PGcombine (g_82_79,p_82_79,g_82_81,p_82_81,g_80_79,p_80_79) and2( w0g_82_79, p_82_81, g_80_79 )#5 or2( g_82_79, w0g_82_79, g_82_81 )#5 and2( p_82_79, p_82_81, p_80_79)#5 end netlist // PGcombine (g_83_80,p_83_80,g_83_82,p_83_82,g_81_80,p_81_80) and2( w0g_83_80, p_83_82, g_81_80 )#5 or2( g_83_80, w0g_83_80, g_83_82 )#5 and2( p_83_80, p_83_82, p_81_80)#5 end netlist // PGcombine (g_84_81,p_84_81,g_84_83,p_84_83,g_82_81,p_82_81) and2( w0g_84_81, p_84_83, g_82_81 )#5 or2( g_84_81, w0g_84_81, g_84_83 )#5 and2( p_84_81, p_84_83, p_82_81)#5 end netlist // PGcombine (g_85_82,p_85_82,g_85_84,p_85_84,g_83_82,p_83_82) and2( w0g_85_82, p_85_84, g_83_82 )#5 or2( g_85_82, w0g_85_82, g_85_84 )#5 and2( p_85_82, p_85_84, p_83_82)#5 end netlist // PGcombine (g_86_83,p_86_83,g_86_85,p_86_85,g_84_83,p_84_83) and2( w0g_86_83, p_86_85, g_84_83 )#5 or2( g_86_83, w0g_86_83, g_86_85 )#5 and2( p_86_83, p_86_85, p_84_83)#5 end netlist // PGcombine (g_87_84,p_87_84,g_87_86,p_87_86,g_85_84,p_85_84) and2( w0g_87_84, p_87_86, g_85_84 )#5 or2( g_87_84, w0g_87_84, g_87_86 )#5 and2( p_87_84, p_87_86, p_85_84)#5 end netlist // PGcombine (g_88_85,p_88_85,g_88_87,p_88_87,g_86_85,p_86_85) and2( w0g_88_85, p_88_87, g_86_85 )#5 or2( g_88_85, w0g_88_85, g_88_87 )#5 and2( p_88_85, p_88_87, p_86_85)#5 end netlist // PGcombine (g_89_86,p_89_86,g_89_88,p_89_88,g_87_86,p_87_86) and2( w0g_89_86, p_89_88, g_87_86 )#5 or2( g_89_86, w0g_89_86, g_89_88 )#5 and2( p_89_86, p_89_88, p_87_86)#5 end netlist // PGcombine (g_90_87,p_90_87,g_90_89,p_90_89,g_88_87,p_88_87) and2( w0g_90_87, p_90_89, g_88_87 )#5 or2( g_90_87, w0g_90_87, g_90_89 )#5 and2( p_90_87, p_90_89, p_88_87)#5 end netlist // PGcombine (g_91_88,p_91_88,g_91_90,p_91_90,g_89_88,p_89_88) and2( w0g_91_88, p_91_90, g_89_88 )#5 or2( g_91_88, w0g_91_88, g_91_90 )#5 and2( p_91_88, p_91_90, p_89_88)#5 end netlist // PGcombine (g_92_89,p_92_89,g_92_91,p_92_91,g_90_89,p_90_89) and2( w0g_92_89, p_92_91, g_90_89 )#5 or2( g_92_89, w0g_92_89, g_92_91 )#5 and2( p_92_89, p_92_91, p_90_89)#5 end netlist // PGcombine (g_93_90,p_93_90,g_93_92,p_93_92,g_91_90,p_91_90) and2( w0g_93_90, p_93_92, g_91_90 )#5 or2( g_93_90, w0g_93_90, g_93_92 )#5 and2( p_93_90, p_93_92, p_91_90)#5 end netlist // PGcombine (g_94_91,p_94_91,g_94_93,p_94_93,g_92_91,p_92_91) and2( w0g_94_91, p_94_93, g_92_91 )#5 or2( g_94_91, w0g_94_91, g_94_93 )#5 and2( p_94_91, p_94_93, p_92_91)#5 end netlist // PGcombine (g_95_92,p_95_92,g_95_94,p_95_94,g_93_92,p_93_92) and2( w0g_95_92, p_95_94, g_93_92 )#5 or2( g_95_92, w0g_95_92, g_95_94 )#5 and2( p_95_92, p_95_94, p_93_92)#5 end netlist // PGcombine (g_96_93,p_96_93,g_96_95,p_96_95,g_94_93,p_94_93) and2( w0g_96_93, p_96_95, g_94_93 )#5 or2( g_96_93, w0g_96_93, g_96_95 )#5 and2( p_96_93, p_96_95, p_94_93)#5 end netlist // PGcombine (g_97_94,p_97_94,g_97_96,p_97_96,g_95_94,p_95_94) and2( w0g_97_94, p_97_96, g_95_94 )#5 or2( g_97_94, w0g_97_94, g_97_96 )#5 and2( p_97_94, p_97_96, p_95_94)#5 end netlist // PGcombine (g_98_95,p_98_95,g_98_97,p_98_97,g_96_95,p_96_95) and2( w0g_98_95, p_98_97, g_96_95 )#5 or2( g_98_95, w0g_98_95, g_98_97 )#5 and2( p_98_95, p_98_97, p_96_95)#5 end netlist // PGcombine (g_99_96,p_99_96,g_99_98,p_99_98,g_97_96,p_97_96) and2( w0g_99_96, p_99_98, g_97_96 )#5 or2( g_99_96, w0g_99_96, g_99_98 )#5 and2( p_99_96, p_99_98, p_97_96)#5 end netlist // PGcombine (g_100_97,p_100_97,g_100_99,p_100_99,g_98_97,p_98_97) and2( w0g_100_97, p_100_99, g_98_97 )#5 or2( g_100_97, w0g_100_97, g_100_99 )#5 and2( p_100_97, p_100_99, p_98_97)#5 end netlist // PGcombine (g_101_98,p_101_98,g_101_100,p_101_100,g_99_98,p_99_98) and2( w0g_101_98, p_101_100, g_99_98 )#5 or2( g_101_98, w0g_101_98, g_101_100 )#5 and2( p_101_98, p_101_100, p_99_98)#5 end netlist // PGcombine (g_102_99,p_102_99,g_102_101,p_102_101,g_100_99,p_100_99) and2( w0g_102_99, p_102_101, g_100_99 )#5 or2( g_102_99, w0g_102_99, g_102_101 )#5 and2( p_102_99, p_102_101, p_100_99)#5 end netlist // PGcombine (g_103_100,p_103_100,g_103_102,p_103_102,g_101_100,p_101_100) and2( w0g_103_100, p_103_102, g_101_100 )#5 or2( g_103_100, w0g_103_100, g_103_102 )#5 and2( p_103_100, p_103_102, p_101_100)#5 end netlist // PGcombine (g_104_101,p_104_101,g_104_103,p_104_103,g_102_101,p_102_101) and2( w0g_104_101, p_104_103, g_102_101 )#5 or2( g_104_101, w0g_104_101, g_104_103 )#5 and2( p_104_101, p_104_103, p_102_101)#5 end netlist // PGcombine (g_105_102,p_105_102,g_105_104,p_105_104,g_103_102,p_103_102) and2( w0g_105_102, p_105_104, g_103_102 )#5 or2( g_105_102, w0g_105_102, g_105_104 )#5 and2( p_105_102, p_105_104, p_103_102)#5 end netlist // PGcombine (g_106_103,p_106_103,g_106_105,p_106_105,g_104_103,p_104_103) and2( w0g_106_103, p_106_105, g_104_103 )#5 or2( g_106_103, w0g_106_103, g_106_105 )#5 and2( p_106_103, p_106_105, p_104_103)#5 end netlist // PGcombine (g_107_104,p_107_104,g_107_106,p_107_106,g_105_104,p_105_104) and2( w0g_107_104, p_107_106, g_105_104 )#5 or2( g_107_104, w0g_107_104, g_107_106 )#5 and2( p_107_104, p_107_106, p_105_104)#5 end netlist // PGcombine (g_108_105,p_108_105,g_108_107,p_108_107,g_106_105,p_106_105) and2( w0g_108_105, p_108_107, g_106_105 )#5 or2( g_108_105, w0g_108_105, g_108_107 )#5 and2( p_108_105, p_108_107, p_106_105)#5 end netlist // PGcombine (g_109_106,p_109_106,g_109_108,p_109_108,g_107_106,p_107_106) and2( w0g_109_106, p_109_108, g_107_106 )#5 or2( g_109_106, w0g_109_106, g_109_108 )#5 and2( p_109_106, p_109_108, p_107_106)#5 end netlist // PGcombine (g_110_107,p_110_107,g_110_109,p_110_109,g_108_107,p_108_107) and2( w0g_110_107, p_110_109, g_108_107 )#5 or2( g_110_107, w0g_110_107, g_110_109 )#5 and2( p_110_107, p_110_109, p_108_107)#5 end netlist // PGcombine (g_111_108,p_111_108,g_111_110,p_111_110,g_109_108,p_109_108) and2( w0g_111_108, p_111_110, g_109_108 )#5 or2( g_111_108, w0g_111_108, g_111_110 )#5 and2( p_111_108, p_111_110, p_109_108)#5 end netlist // PGcombine (g_112_109,p_112_109,g_112_111,p_112_111,g_110_109,p_110_109) and2( w0g_112_109, p_112_111, g_110_109 )#5 or2( g_112_109, w0g_112_109, g_112_111 )#5 and2( p_112_109, p_112_111, p_110_109)#5 end netlist // PGcombine (g_113_110,p_113_110,g_113_112,p_113_112,g_111_110,p_111_110) and2( w0g_113_110, p_113_112, g_111_110 )#5 or2( g_113_110, w0g_113_110, g_113_112 )#5 and2( p_113_110, p_113_112, p_111_110)#5 end netlist // PGcombine (g_114_111,p_114_111,g_114_113,p_114_113,g_112_111,p_112_111) and2( w0g_114_111, p_114_113, g_112_111 )#5 or2( g_114_111, w0g_114_111, g_114_113 )#5 and2( p_114_111, p_114_113, p_112_111)#5 end netlist // PGcombine (g_115_112,p_115_112,g_115_114,p_115_114,g_113_112,p_113_112) and2( w0g_115_112, p_115_114, g_113_112 )#5 or2( g_115_112, w0g_115_112, g_115_114 )#5 and2( p_115_112, p_115_114, p_113_112)#5 end netlist // PGcombine (g_116_113,p_116_113,g_116_115,p_116_115,g_114_113,p_114_113) and2( w0g_116_113, p_116_115, g_114_113 )#5 or2( g_116_113, w0g_116_113, g_116_115 )#5 and2( p_116_113, p_116_115, p_114_113)#5 end netlist // PGcombine (g_117_114,p_117_114,g_117_116,p_117_116,g_115_114,p_115_114) and2( w0g_117_114, p_117_116, g_115_114 )#5 or2( g_117_114, w0g_117_114, g_117_116 )#5 and2( p_117_114, p_117_116, p_115_114)#5 end netlist // PGcombine (g_118_115,p_118_115,g_118_117,p_118_117,g_116_115,p_116_115) and2( w0g_118_115, p_118_117, g_116_115 )#5 or2( g_118_115, w0g_118_115, g_118_117 )#5 and2( p_118_115, p_118_117, p_116_115)#5 end netlist // PGcombine (g_119_116,p_119_116,g_119_118,p_119_118,g_117_116,p_117_116) and2( w0g_119_116, p_119_118, g_117_116 )#5 or2( g_119_116, w0g_119_116, g_119_118 )#5 and2( p_119_116, p_119_118, p_117_116)#5 end netlist // PGcombine (g_120_117,p_120_117,g_120_119,p_120_119,g_118_117,p_118_117) and2( w0g_120_117, p_120_119, g_118_117 )#5 or2( g_120_117, w0g_120_117, g_120_119 )#5 and2( p_120_117, p_120_119, p_118_117)#5 end netlist // PGcombine (g_121_118,p_121_118,g_121_120,p_121_120,g_119_118,p_119_118) and2( w0g_121_118, p_121_120, g_119_118 )#5 or2( g_121_118, w0g_121_118, g_121_120 )#5 and2( p_121_118, p_121_120, p_119_118)#5 end netlist // PGcombine (g_122_119,p_122_119,g_122_121,p_122_121,g_120_119,p_120_119) and2( w0g_122_119, p_122_121, g_120_119 )#5 or2( g_122_119, w0g_122_119, g_122_121 )#5 and2( p_122_119, p_122_121, p_120_119)#5 end netlist // PGcombine (g_123_120,p_123_120,g_123_122,p_123_122,g_121_120,p_121_120) and2( w0g_123_120, p_123_122, g_121_120 )#5 or2( g_123_120, w0g_123_120, g_123_122 )#5 and2( p_123_120, p_123_122, p_121_120)#5 end netlist // PGcombine (g_124_121,p_124_121,g_124_123,p_124_123,g_122_121,p_122_121) and2( w0g_124_121, p_124_123, g_122_121 )#5 or2( g_124_121, w0g_124_121, g_124_123 )#5 and2( p_124_121, p_124_123, p_122_121)#5 end netlist // PGcombine (g_125_122,p_125_122,g_125_124,p_125_124,g_123_122,p_123_122) and2( w0g_125_122, p_125_124, g_123_122 )#5 or2( g_125_122, w0g_125_122, g_125_124 )#5 and2( p_125_122, p_125_124, p_123_122)#5 end netlist // PGcombine (g_126_123,p_126_123,g_126_125,p_126_125,g_124_123,p_124_123) and2( w0g_126_123, p_126_125, g_124_123 )#5 or2( g_126_123, w0g_126_123, g_126_125 )#5 and2( p_126_123, p_126_125, p_124_123)#5 end netlist // PGcombine (g_127_124,p_127_124,g_127_126,p_127_126,g_125_124,p_125_124) and2( w0g_127_124, p_127_126, g_125_124 )#5 or2( g_127_124, w0g_127_124, g_127_126 )#5 and2( p_127_124, p_127_126, p_125_124)#5 end netlist // Gcombine (g_3_cin, g_3_0, cin, p_3_0 ) and2(w0g_3_cin, p_3_0, cin )#5 or2( g_3_cin, w0g_3_cin, g_3_0 )#5 end netlist // Gcombine (g_4_cin, g_4_1, g_0_cin, p_4_1 ) and2(w0g_4_cin, p_4_1, g_0_cin )#5 or2( g_4_cin, w0g_4_cin, g_4_1 )#5 end netlist // Gcombine (g_5_cin, g_5_2, g_1_cin, p_5_2 ) and2(w0g_5_cin, p_5_2, g_1_cin )#5 or2( g_5_cin, w0g_5_cin, g_5_2 )#5 end netlist // Gcombine (g_6_cin, g_6_3, g_2_cin, p_6_3 ) and2(w0g_6_cin, p_6_3, g_2_cin )#5 or2( g_6_cin, w0g_6_cin, g_6_3 )#5 end netlist // PGcombine (g_7_0,p_7_0,g_7_4,p_7_4,g_3_0,p_3_0) and2( w0g_7_0, p_7_4, g_3_0 )#5 or2( g_7_0, w0g_7_0, g_7_4 )#5 and2( p_7_0, p_7_4, p_3_0)#5 end netlist // PGcombine (g_8_1,p_8_1,g_8_5,p_8_5,g_4_1,p_4_1) and2( w0g_8_1, p_8_5, g_4_1 )#5 or2( g_8_1, w0g_8_1, g_8_5 )#5 and2( p_8_1, p_8_5, p_4_1)#5 end netlist // PGcombine (g_9_2,p_9_2,g_9_6,p_9_6,g_5_2,p_5_2) and2( w0g_9_2, p_9_6, g_5_2 )#5 or2( g_9_2, w0g_9_2, g_9_6 )#5 and2( p_9_2, p_9_6, p_5_2)#5 end netlist // PGcombine (g_10_3,p_10_3,g_10_7,p_10_7,g_6_3,p_6_3) and2( w0g_10_3, p_10_7, g_6_3 )#5 or2( g_10_3, w0g_10_3, g_10_7 )#5 and2( p_10_3, p_10_7, p_6_3)#5 end netlist // PGcombine (g_11_4,p_11_4,g_11_8,p_11_8,g_7_4,p_7_4) and2( w0g_11_4, p_11_8, g_7_4 )#5 or2( g_11_4, w0g_11_4, g_11_8 )#5 and2( p_11_4, p_11_8, p_7_4)#5 end netlist // PGcombine (g_12_5,p_12_5,g_12_9,p_12_9,g_8_5,p_8_5) and2( w0g_12_5, p_12_9, g_8_5 )#5 or2( g_12_5, w0g_12_5, g_12_9 )#5 and2( p_12_5, p_12_9, p_8_5)#5 end netlist // PGcombine (g_13_6,p_13_6,g_13_10,p_13_10,g_9_6,p_9_6) and2( w0g_13_6, p_13_10, g_9_6 )#5 or2( g_13_6, w0g_13_6, g_13_10 )#5 and2( p_13_6, p_13_10, p_9_6)#5 end netlist // PGcombine (g_14_7,p_14_7,g_14_11,p_14_11,g_10_7,p_10_7) and2( w0g_14_7, p_14_11, g_10_7 )#5 or2( g_14_7, w0g_14_7, g_14_11 )#5 and2( p_14_7, p_14_11, p_10_7)#5 end netlist // PGcombine (g_15_8,p_15_8,g_15_12,p_15_12,g_11_8,p_11_8) and2( w0g_15_8, p_15_12, g_11_8 )#5 or2( g_15_8, w0g_15_8, g_15_12 )#5 and2( p_15_8, p_15_12, p_11_8)#5 end netlist // PGcombine (g_16_9,p_16_9,g_16_13,p_16_13,g_12_9,p_12_9) and2( w0g_16_9, p_16_13, g_12_9 )#5 or2( g_16_9, w0g_16_9, g_16_13 )#5 and2( p_16_9, p_16_13, p_12_9)#5 end netlist // PGcombine (g_17_10,p_17_10,g_17_14,p_17_14,g_13_10,p_13_10) and2( w0g_17_10, p_17_14, g_13_10 )#5 or2( g_17_10, w0g_17_10, g_17_14 )#5 and2( p_17_10, p_17_14, p_13_10)#5 end netlist // PGcombine (g_18_11,p_18_11,g_18_15,p_18_15,g_14_11,p_14_11) and2( w0g_18_11, p_18_15, g_14_11 )#5 or2( g_18_11, w0g_18_11, g_18_15 )#5 and2( p_18_11, p_18_15, p_14_11)#5 end netlist // PGcombine (g_19_12,p_19_12,g_19_16,p_19_16,g_15_12,p_15_12) and2( w0g_19_12, p_19_16, g_15_12 )#5 or2( g_19_12, w0g_19_12, g_19_16 )#5 and2( p_19_12, p_19_16, p_15_12)#5 end netlist // PGcombine (g_20_13,p_20_13,g_20_17,p_20_17,g_16_13,p_16_13) and2( w0g_20_13, p_20_17, g_16_13 )#5 or2( g_20_13, w0g_20_13, g_20_17 )#5 and2( p_20_13, p_20_17, p_16_13)#5 end netlist // PGcombine (g_21_14,p_21_14,g_21_18,p_21_18,g_17_14,p_17_14) and2( w0g_21_14, p_21_18, g_17_14 )#5 or2( g_21_14, w0g_21_14, g_21_18 )#5 and2( p_21_14, p_21_18, p_17_14)#5 end netlist // PGcombine (g_22_15,p_22_15,g_22_19,p_22_19,g_18_15,p_18_15) and2( w0g_22_15, p_22_19, g_18_15 )#5 or2( g_22_15, w0g_22_15, g_22_19 )#5 and2( p_22_15, p_22_19, p_18_15)#5 end netlist // PGcombine (g_23_16,p_23_16,g_23_20,p_23_20,g_19_16,p_19_16) and2( w0g_23_16, p_23_20, g_19_16 )#5 or2( g_23_16, w0g_23_16, g_23_20 )#5 and2( p_23_16, p_23_20, p_19_16)#5 end netlist // PGcombine (g_24_17,p_24_17,g_24_21,p_24_21,g_20_17,p_20_17) and2( w0g_24_17, p_24_21, g_20_17 )#5 or2( g_24_17, w0g_24_17, g_24_21 )#5 and2( p_24_17, p_24_21, p_20_17)#5 end netlist // PGcombine (g_25_18,p_25_18,g_25_22,p_25_22,g_21_18,p_21_18) and2( w0g_25_18, p_25_22, g_21_18 )#5 or2( g_25_18, w0g_25_18, g_25_22 )#5 and2( p_25_18, p_25_22, p_21_18)#5 end netlist // PGcombine (g_26_19,p_26_19,g_26_23,p_26_23,g_22_19,p_22_19) and2( w0g_26_19, p_26_23, g_22_19 )#5 or2( g_26_19, w0g_26_19, g_26_23 )#5 and2( p_26_19, p_26_23, p_22_19)#5 end netlist // PGcombine (g_27_20,p_27_20,g_27_24,p_27_24,g_23_20,p_23_20) and2( w0g_27_20, p_27_24, g_23_20 )#5 or2( g_27_20, w0g_27_20, g_27_24 )#5 and2( p_27_20, p_27_24, p_23_20)#5 end netlist // PGcombine (g_28_21,p_28_21,g_28_25,p_28_25,g_24_21,p_24_21) and2( w0g_28_21, p_28_25, g_24_21 )#5 or2( g_28_21, w0g_28_21, g_28_25 )#5 and2( p_28_21, p_28_25, p_24_21)#5 end netlist // PGcombine (g_29_22,p_29_22,g_29_26,p_29_26,g_25_22,p_25_22) and2( w0g_29_22, p_29_26, g_25_22 )#5 or2( g_29_22, w0g_29_22, g_29_26 )#5 and2( p_29_22, p_29_26, p_25_22)#5 end netlist // PGcombine (g_30_23,p_30_23,g_30_27,p_30_27,g_26_23,p_26_23) and2( w0g_30_23, p_30_27, g_26_23 )#5 or2( g_30_23, w0g_30_23, g_30_27 )#5 and2( p_30_23, p_30_27, p_26_23)#5 end netlist // PGcombine (g_31_24,p_31_24,g_31_28,p_31_28,g_27_24,p_27_24) and2( w0g_31_24, p_31_28, g_27_24 )#5 or2( g_31_24, w0g_31_24, g_31_28 )#5 and2( p_31_24, p_31_28, p_27_24)#5 end netlist // PGcombine (g_32_25,p_32_25,g_32_29,p_32_29,g_28_25,p_28_25) and2( w0g_32_25, p_32_29, g_28_25 )#5 or2( g_32_25, w0g_32_25, g_32_29 )#5 and2( p_32_25, p_32_29, p_28_25)#5 end netlist // PGcombine (g_33_26,p_33_26,g_33_30,p_33_30,g_29_26,p_29_26) and2( w0g_33_26, p_33_30, g_29_26 )#5 or2( g_33_26, w0g_33_26, g_33_30 )#5 and2( p_33_26, p_33_30, p_29_26)#5 end netlist // PGcombine (g_34_27,p_34_27,g_34_31,p_34_31,g_30_27,p_30_27) and2( w0g_34_27, p_34_31, g_30_27 )#5 or2( g_34_27, w0g_34_27, g_34_31 )#5 and2( p_34_27, p_34_31, p_30_27)#5 end netlist // PGcombine (g_35_28,p_35_28,g_35_32,p_35_32,g_31_28,p_31_28) and2( w0g_35_28, p_35_32, g_31_28 )#5 or2( g_35_28, w0g_35_28, g_35_32 )#5 and2( p_35_28, p_35_32, p_31_28)#5 end netlist // PGcombine (g_36_29,p_36_29,g_36_33,p_36_33,g_32_29,p_32_29) and2( w0g_36_29, p_36_33, g_32_29 )#5 or2( g_36_29, w0g_36_29, g_36_33 )#5 and2( p_36_29, p_36_33, p_32_29)#5 end netlist // PGcombine (g_37_30,p_37_30,g_37_34,p_37_34,g_33_30,p_33_30) and2( w0g_37_30, p_37_34, g_33_30 )#5 or2( g_37_30, w0g_37_30, g_37_34 )#5 and2( p_37_30, p_37_34, p_33_30)#5 end netlist // PGcombine (g_38_31,p_38_31,g_38_35,p_38_35,g_34_31,p_34_31) and2( w0g_38_31, p_38_35, g_34_31 )#5 or2( g_38_31, w0g_38_31, g_38_35 )#5 and2( p_38_31, p_38_35, p_34_31)#5 end netlist // PGcombine (g_39_32,p_39_32,g_39_36,p_39_36,g_35_32,p_35_32) and2( w0g_39_32, p_39_36, g_35_32 )#5 or2( g_39_32, w0g_39_32, g_39_36 )#5 and2( p_39_32, p_39_36, p_35_32)#5 end netlist // PGcombine (g_40_33,p_40_33,g_40_37,p_40_37,g_36_33,p_36_33) and2( w0g_40_33, p_40_37, g_36_33 )#5 or2( g_40_33, w0g_40_33, g_40_37 )#5 and2( p_40_33, p_40_37, p_36_33)#5 end netlist // PGcombine (g_41_34,p_41_34,g_41_38,p_41_38,g_37_34,p_37_34) and2( w0g_41_34, p_41_38, g_37_34 )#5 or2( g_41_34, w0g_41_34, g_41_38 )#5 and2( p_41_34, p_41_38, p_37_34)#5 end netlist // PGcombine (g_42_35,p_42_35,g_42_39,p_42_39,g_38_35,p_38_35) and2( w0g_42_35, p_42_39, g_38_35 )#5 or2( g_42_35, w0g_42_35, g_42_39 )#5 and2( p_42_35, p_42_39, p_38_35)#5 end netlist // PGcombine (g_43_36,p_43_36,g_43_40,p_43_40,g_39_36,p_39_36) and2( w0g_43_36, p_43_40, g_39_36 )#5 or2( g_43_36, w0g_43_36, g_43_40 )#5 and2( p_43_36, p_43_40, p_39_36)#5 end netlist // PGcombine (g_44_37,p_44_37,g_44_41,p_44_41,g_40_37,p_40_37) and2( w0g_44_37, p_44_41, g_40_37 )#5 or2( g_44_37, w0g_44_37, g_44_41 )#5 and2( p_44_37, p_44_41, p_40_37)#5 end netlist // PGcombine (g_45_38,p_45_38,g_45_42,p_45_42,g_41_38,p_41_38) and2( w0g_45_38, p_45_42, g_41_38 )#5 or2( g_45_38, w0g_45_38, g_45_42 )#5 and2( p_45_38, p_45_42, p_41_38)#5 end netlist // PGcombine (g_46_39,p_46_39,g_46_43,p_46_43,g_42_39,p_42_39) and2( w0g_46_39, p_46_43, g_42_39 )#5 or2( g_46_39, w0g_46_39, g_46_43 )#5 and2( p_46_39, p_46_43, p_42_39)#5 end netlist // PGcombine (g_47_40,p_47_40,g_47_44,p_47_44,g_43_40,p_43_40) and2( w0g_47_40, p_47_44, g_43_40 )#5 or2( g_47_40, w0g_47_40, g_47_44 )#5 and2( p_47_40, p_47_44, p_43_40)#5 end netlist // PGcombine (g_48_41,p_48_41,g_48_45,p_48_45,g_44_41,p_44_41) and2( w0g_48_41, p_48_45, g_44_41 )#5 or2( g_48_41, w0g_48_41, g_48_45 )#5 and2( p_48_41, p_48_45, p_44_41)#5 end netlist // PGcombine (g_49_42,p_49_42,g_49_46,p_49_46,g_45_42,p_45_42) and2( w0g_49_42, p_49_46, g_45_42 )#5 or2( g_49_42, w0g_49_42, g_49_46 )#5 and2( p_49_42, p_49_46, p_45_42)#5 end netlist // PGcombine (g_50_43,p_50_43,g_50_47,p_50_47,g_46_43,p_46_43) and2( w0g_50_43, p_50_47, g_46_43 )#5 or2( g_50_43, w0g_50_43, g_50_47 )#5 and2( p_50_43, p_50_47, p_46_43)#5 end netlist // PGcombine (g_51_44,p_51_44,g_51_48,p_51_48,g_47_44,p_47_44) and2( w0g_51_44, p_51_48, g_47_44 )#5 or2( g_51_44, w0g_51_44, g_51_48 )#5 and2( p_51_44, p_51_48, p_47_44)#5 end netlist // PGcombine (g_52_45,p_52_45,g_52_49,p_52_49,g_48_45,p_48_45) and2( w0g_52_45, p_52_49, g_48_45 )#5 or2( g_52_45, w0g_52_45, g_52_49 )#5 and2( p_52_45, p_52_49, p_48_45)#5 end netlist // PGcombine (g_53_46,p_53_46,g_53_50,p_53_50,g_49_46,p_49_46) and2( w0g_53_46, p_53_50, g_49_46 )#5 or2( g_53_46, w0g_53_46, g_53_50 )#5 and2( p_53_46, p_53_50, p_49_46)#5 end netlist // PGcombine (g_54_47,p_54_47,g_54_51,p_54_51,g_50_47,p_50_47) and2( w0g_54_47, p_54_51, g_50_47 )#5 or2( g_54_47, w0g_54_47, g_54_51 )#5 and2( p_54_47, p_54_51, p_50_47)#5 end netlist // PGcombine (g_55_48,p_55_48,g_55_52,p_55_52,g_51_48,p_51_48) and2( w0g_55_48, p_55_52, g_51_48 )#5 or2( g_55_48, w0g_55_48, g_55_52 )#5 and2( p_55_48, p_55_52, p_51_48)#5 end netlist // PGcombine (g_56_49,p_56_49,g_56_53,p_56_53,g_52_49,p_52_49) and2( w0g_56_49, p_56_53, g_52_49 )#5 or2( g_56_49, w0g_56_49, g_56_53 )#5 and2( p_56_49, p_56_53, p_52_49)#5 end netlist // PGcombine (g_57_50,p_57_50,g_57_54,p_57_54,g_53_50,p_53_50) and2( w0g_57_50, p_57_54, g_53_50 )#5 or2( g_57_50, w0g_57_50, g_57_54 )#5 and2( p_57_50, p_57_54, p_53_50)#5 end netlist // PGcombine (g_58_51,p_58_51,g_58_55,p_58_55,g_54_51,p_54_51) and2( w0g_58_51, p_58_55, g_54_51 )#5 or2( g_58_51, w0g_58_51, g_58_55 )#5 and2( p_58_51, p_58_55, p_54_51)#5 end netlist // PGcombine (g_59_52,p_59_52,g_59_56,p_59_56,g_55_52,p_55_52) and2( w0g_59_52, p_59_56, g_55_52 )#5 or2( g_59_52, w0g_59_52, g_59_56 )#5 and2( p_59_52, p_59_56, p_55_52)#5 end netlist // PGcombine (g_60_53,p_60_53,g_60_57,p_60_57,g_56_53,p_56_53) and2( w0g_60_53, p_60_57, g_56_53 )#5 or2( g_60_53, w0g_60_53, g_60_57 )#5 and2( p_60_53, p_60_57, p_56_53)#5 end netlist // PGcombine (g_61_54,p_61_54,g_61_58,p_61_58,g_57_54,p_57_54) and2( w0g_61_54, p_61_58, g_57_54 )#5 or2( g_61_54, w0g_61_54, g_61_58 )#5 and2( p_61_54, p_61_58, p_57_54)#5 end netlist // PGcombine (g_62_55,p_62_55,g_62_59,p_62_59,g_58_55,p_58_55) and2( w0g_62_55, p_62_59, g_58_55 )#5 or2( g_62_55, w0g_62_55, g_62_59 )#5 and2( p_62_55, p_62_59, p_58_55)#5 end netlist // PGcombine (g_63_56,p_63_56,g_63_60,p_63_60,g_59_56,p_59_56) and2( w0g_63_56, p_63_60, g_59_56 )#5 or2( g_63_56, w0g_63_56, g_63_60 )#5 and2( p_63_56, p_63_60, p_59_56)#5 end netlist // PGcombine (g_64_57,p_64_57,g_64_61,p_64_61,g_60_57,p_60_57) and2( w0g_64_57, p_64_61, g_60_57 )#5 or2( g_64_57, w0g_64_57, g_64_61 )#5 and2( p_64_57, p_64_61, p_60_57)#5 end netlist // PGcombine (g_65_58,p_65_58,g_65_62,p_65_62,g_61_58,p_61_58) and2( w0g_65_58, p_65_62, g_61_58 )#5 or2( g_65_58, w0g_65_58, g_65_62 )#5 and2( p_65_58, p_65_62, p_61_58)#5 end netlist // PGcombine (g_66_59,p_66_59,g_66_63,p_66_63,g_62_59,p_62_59) and2( w0g_66_59, p_66_63, g_62_59 )#5 or2( g_66_59, w0g_66_59, g_66_63 )#5 and2( p_66_59, p_66_63, p_62_59)#5 end netlist // PGcombine (g_67_60,p_67_60,g_67_64,p_67_64,g_63_60,p_63_60) and2( w0g_67_60, p_67_64, g_63_60 )#5 or2( g_67_60, w0g_67_60, g_67_64 )#5 and2( p_67_60, p_67_64, p_63_60)#5 end netlist // PGcombine (g_68_61,p_68_61,g_68_65,p_68_65,g_64_61,p_64_61) and2( w0g_68_61, p_68_65, g_64_61 )#5 or2( g_68_61, w0g_68_61, g_68_65 )#5 and2( p_68_61, p_68_65, p_64_61)#5 end netlist // PGcombine (g_69_62,p_69_62,g_69_66,p_69_66,g_65_62,p_65_62) and2( w0g_69_62, p_69_66, g_65_62 )#5 or2( g_69_62, w0g_69_62, g_69_66 )#5 and2( p_69_62, p_69_66, p_65_62)#5 end netlist // PGcombine (g_70_63,p_70_63,g_70_67,p_70_67,g_66_63,p_66_63) and2( w0g_70_63, p_70_67, g_66_63 )#5 or2( g_70_63, w0g_70_63, g_70_67 )#5 and2( p_70_63, p_70_67, p_66_63)#5 end netlist // PGcombine (g_71_64,p_71_64,g_71_68,p_71_68,g_67_64,p_67_64) and2( w0g_71_64, p_71_68, g_67_64 )#5 or2( g_71_64, w0g_71_64, g_71_68 )#5 and2( p_71_64, p_71_68, p_67_64)#5 end netlist // PGcombine (g_72_65,p_72_65,g_72_69,p_72_69,g_68_65,p_68_65) and2( w0g_72_65, p_72_69, g_68_65 )#5 or2( g_72_65, w0g_72_65, g_72_69 )#5 and2( p_72_65, p_72_69, p_68_65)#5 end netlist // PGcombine (g_73_66,p_73_66,g_73_70,p_73_70,g_69_66,p_69_66) and2( w0g_73_66, p_73_70, g_69_66 )#5 or2( g_73_66, w0g_73_66, g_73_70 )#5 and2( p_73_66, p_73_70, p_69_66)#5 end netlist // PGcombine (g_74_67,p_74_67,g_74_71,p_74_71,g_70_67,p_70_67) and2( w0g_74_67, p_74_71, g_70_67 )#5 or2( g_74_67, w0g_74_67, g_74_71 )#5 and2( p_74_67, p_74_71, p_70_67)#5 end netlist // PGcombine (g_75_68,p_75_68,g_75_72,p_75_72,g_71_68,p_71_68) and2( w0g_75_68, p_75_72, g_71_68 )#5 or2( g_75_68, w0g_75_68, g_75_72 )#5 and2( p_75_68, p_75_72, p_71_68)#5 end netlist // PGcombine (g_76_69,p_76_69,g_76_73,p_76_73,g_72_69,p_72_69) and2( w0g_76_69, p_76_73, g_72_69 )#5 or2( g_76_69, w0g_76_69, g_76_73 )#5 and2( p_76_69, p_76_73, p_72_69)#5 end netlist // PGcombine (g_77_70,p_77_70,g_77_74,p_77_74,g_73_70,p_73_70) and2( w0g_77_70, p_77_74, g_73_70 )#5 or2( g_77_70, w0g_77_70, g_77_74 )#5 and2( p_77_70, p_77_74, p_73_70)#5 end netlist // PGcombine (g_78_71,p_78_71,g_78_75,p_78_75,g_74_71,p_74_71) and2( w0g_78_71, p_78_75, g_74_71 )#5 or2( g_78_71, w0g_78_71, g_78_75 )#5 and2( p_78_71, p_78_75, p_74_71)#5 end netlist // PGcombine (g_79_72,p_79_72,g_79_76,p_79_76,g_75_72,p_75_72) and2( w0g_79_72, p_79_76, g_75_72 )#5 or2( g_79_72, w0g_79_72, g_79_76 )#5 and2( p_79_72, p_79_76, p_75_72)#5 end netlist // PGcombine (g_80_73,p_80_73,g_80_77,p_80_77,g_76_73,p_76_73) and2( w0g_80_73, p_80_77, g_76_73 )#5 or2( g_80_73, w0g_80_73, g_80_77 )#5 and2( p_80_73, p_80_77, p_76_73)#5 end netlist // PGcombine (g_81_74,p_81_74,g_81_78,p_81_78,g_77_74,p_77_74) and2( w0g_81_74, p_81_78, g_77_74 )#5 or2( g_81_74, w0g_81_74, g_81_78 )#5 and2( p_81_74, p_81_78, p_77_74)#5 end netlist // PGcombine (g_82_75,p_82_75,g_82_79,p_82_79,g_78_75,p_78_75) and2( w0g_82_75, p_82_79, g_78_75 )#5 or2( g_82_75, w0g_82_75, g_82_79 )#5 and2( p_82_75, p_82_79, p_78_75)#5 end netlist // PGcombine (g_83_76,p_83_76,g_83_80,p_83_80,g_79_76,p_79_76) and2( w0g_83_76, p_83_80, g_79_76 )#5 or2( g_83_76, w0g_83_76, g_83_80 )#5 and2( p_83_76, p_83_80, p_79_76)#5 end netlist // PGcombine (g_84_77,p_84_77,g_84_81,p_84_81,g_80_77,p_80_77) and2( w0g_84_77, p_84_81, g_80_77 )#5 or2( g_84_77, w0g_84_77, g_84_81 )#5 and2( p_84_77, p_84_81, p_80_77)#5 end netlist // PGcombine (g_85_78,p_85_78,g_85_82,p_85_82,g_81_78,p_81_78) and2( w0g_85_78, p_85_82, g_81_78 )#5 or2( g_85_78, w0g_85_78, g_85_82 )#5 and2( p_85_78, p_85_82, p_81_78)#5 end netlist // PGcombine (g_86_79,p_86_79,g_86_83,p_86_83,g_82_79,p_82_79) and2( w0g_86_79, p_86_83, g_82_79 )#5 or2( g_86_79, w0g_86_79, g_86_83 )#5 and2( p_86_79, p_86_83, p_82_79)#5 end netlist // PGcombine (g_87_80,p_87_80,g_87_84,p_87_84,g_83_80,p_83_80) and2( w0g_87_80, p_87_84, g_83_80 )#5 or2( g_87_80, w0g_87_80, g_87_84 )#5 and2( p_87_80, p_87_84, p_83_80)#5 end netlist // PGcombine (g_88_81,p_88_81,g_88_85,p_88_85,g_84_81,p_84_81) and2( w0g_88_81, p_88_85, g_84_81 )#5 or2( g_88_81, w0g_88_81, g_88_85 )#5 and2( p_88_81, p_88_85, p_84_81)#5 end netlist // PGcombine (g_89_82,p_89_82,g_89_86,p_89_86,g_85_82,p_85_82) and2( w0g_89_82, p_89_86, g_85_82 )#5 or2( g_89_82, w0g_89_82, g_89_86 )#5 and2( p_89_82, p_89_86, p_85_82)#5 end netlist // PGcombine (g_90_83,p_90_83,g_90_87,p_90_87,g_86_83,p_86_83) and2( w0g_90_83, p_90_87, g_86_83 )#5 or2( g_90_83, w0g_90_83, g_90_87 )#5 and2( p_90_83, p_90_87, p_86_83)#5 end netlist // PGcombine (g_91_84,p_91_84,g_91_88,p_91_88,g_87_84,p_87_84) and2( w0g_91_84, p_91_88, g_87_84 )#5 or2( g_91_84, w0g_91_84, g_91_88 )#5 and2( p_91_84, p_91_88, p_87_84)#5 end netlist // PGcombine (g_92_85,p_92_85,g_92_89,p_92_89,g_88_85,p_88_85) and2( w0g_92_85, p_92_89, g_88_85 )#5 or2( g_92_85, w0g_92_85, g_92_89 )#5 and2( p_92_85, p_92_89, p_88_85)#5 end netlist // PGcombine (g_93_86,p_93_86,g_93_90,p_93_90,g_89_86,p_89_86) and2( w0g_93_86, p_93_90, g_89_86 )#5 or2( g_93_86, w0g_93_86, g_93_90 )#5 and2( p_93_86, p_93_90, p_89_86)#5 end netlist // PGcombine (g_94_87,p_94_87,g_94_91,p_94_91,g_90_87,p_90_87) and2( w0g_94_87, p_94_91, g_90_87 )#5 or2( g_94_87, w0g_94_87, g_94_91 )#5 and2( p_94_87, p_94_91, p_90_87)#5 end netlist // PGcombine (g_95_88,p_95_88,g_95_92,p_95_92,g_91_88,p_91_88) and2( w0g_95_88, p_95_92, g_91_88 )#5 or2( g_95_88, w0g_95_88, g_95_92 )#5 and2( p_95_88, p_95_92, p_91_88)#5 end netlist // PGcombine (g_96_89,p_96_89,g_96_93,p_96_93,g_92_89,p_92_89) and2( w0g_96_89, p_96_93, g_92_89 )#5 or2( g_96_89, w0g_96_89, g_96_93 )#5 and2( p_96_89, p_96_93, p_92_89)#5 end netlist // PGcombine (g_97_90,p_97_90,g_97_94,p_97_94,g_93_90,p_93_90) and2( w0g_97_90, p_97_94, g_93_90 )#5 or2( g_97_90, w0g_97_90, g_97_94 )#5 and2( p_97_90, p_97_94, p_93_90)#5 end netlist // PGcombine (g_98_91,p_98_91,g_98_95,p_98_95,g_94_91,p_94_91) and2( w0g_98_91, p_98_95, g_94_91 )#5 or2( g_98_91, w0g_98_91, g_98_95 )#5 and2( p_98_91, p_98_95, p_94_91)#5 end netlist // PGcombine (g_99_92,p_99_92,g_99_96,p_99_96,g_95_92,p_95_92) and2( w0g_99_92, p_99_96, g_95_92 )#5 or2( g_99_92, w0g_99_92, g_99_96 )#5 and2( p_99_92, p_99_96, p_95_92)#5 end netlist // PGcombine (g_100_93,p_100_93,g_100_97,p_100_97,g_96_93,p_96_93) and2( w0g_100_93, p_100_97, g_96_93 )#5 or2( g_100_93, w0g_100_93, g_100_97 )#5 and2( p_100_93, p_100_97, p_96_93)#5 end netlist // PGcombine (g_101_94,p_101_94,g_101_98,p_101_98,g_97_94,p_97_94) and2( w0g_101_94, p_101_98, g_97_94 )#5 or2( g_101_94, w0g_101_94, g_101_98 )#5 and2( p_101_94, p_101_98, p_97_94)#5 end netlist // PGcombine (g_102_95,p_102_95,g_102_99,p_102_99,g_98_95,p_98_95) and2( w0g_102_95, p_102_99, g_98_95 )#5 or2( g_102_95, w0g_102_95, g_102_99 )#5 and2( p_102_95, p_102_99, p_98_95)#5 end netlist // PGcombine (g_103_96,p_103_96,g_103_100,p_103_100,g_99_96,p_99_96) and2( w0g_103_96, p_103_100, g_99_96 )#5 or2( g_103_96, w0g_103_96, g_103_100 )#5 and2( p_103_96, p_103_100, p_99_96)#5 end netlist // PGcombine (g_104_97,p_104_97,g_104_101,p_104_101,g_100_97,p_100_97) and2( w0g_104_97, p_104_101, g_100_97 )#5 or2( g_104_97, w0g_104_97, g_104_101 )#5 and2( p_104_97, p_104_101, p_100_97)#5 end netlist // PGcombine (g_105_98,p_105_98,g_105_102,p_105_102,g_101_98,p_101_98) and2( w0g_105_98, p_105_102, g_101_98 )#5 or2( g_105_98, w0g_105_98, g_105_102 )#5 and2( p_105_98, p_105_102, p_101_98)#5 end netlist // PGcombine (g_106_99,p_106_99,g_106_103,p_106_103,g_102_99,p_102_99) and2( w0g_106_99, p_106_103, g_102_99 )#5 or2( g_106_99, w0g_106_99, g_106_103 )#5 and2( p_106_99, p_106_103, p_102_99)#5 end netlist // PGcombine (g_107_100,p_107_100,g_107_104,p_107_104,g_103_100,p_103_100) and2( w0g_107_100, p_107_104, g_103_100 )#5 or2( g_107_100, w0g_107_100, g_107_104 )#5 and2( p_107_100, p_107_104, p_103_100)#5 end netlist // PGcombine (g_108_101,p_108_101,g_108_105,p_108_105,g_104_101,p_104_101) and2( w0g_108_101, p_108_105, g_104_101 )#5 or2( g_108_101, w0g_108_101, g_108_105 )#5 and2( p_108_101, p_108_105, p_104_101)#5 end netlist // PGcombine (g_109_102,p_109_102,g_109_106,p_109_106,g_105_102,p_105_102) and2( w0g_109_102, p_109_106, g_105_102 )#5 or2( g_109_102, w0g_109_102, g_109_106 )#5 and2( p_109_102, p_109_106, p_105_102)#5 end netlist // PGcombine (g_110_103,p_110_103,g_110_107,p_110_107,g_106_103,p_106_103) and2( w0g_110_103, p_110_107, g_106_103 )#5 or2( g_110_103, w0g_110_103, g_110_107 )#5 and2( p_110_103, p_110_107, p_106_103)#5 end netlist // PGcombine (g_111_104,p_111_104,g_111_108,p_111_108,g_107_104,p_107_104) and2( w0g_111_104, p_111_108, g_107_104 )#5 or2( g_111_104, w0g_111_104, g_111_108 )#5 and2( p_111_104, p_111_108, p_107_104)#5 end netlist // PGcombine (g_112_105,p_112_105,g_112_109,p_112_109,g_108_105,p_108_105) and2( w0g_112_105, p_112_109, g_108_105 )#5 or2( g_112_105, w0g_112_105, g_112_109 )#5 and2( p_112_105, p_112_109, p_108_105)#5 end netlist // PGcombine (g_113_106,p_113_106,g_113_110,p_113_110,g_109_106,p_109_106) and2( w0g_113_106, p_113_110, g_109_106 )#5 or2( g_113_106, w0g_113_106, g_113_110 )#5 and2( p_113_106, p_113_110, p_109_106)#5 end netlist // PGcombine (g_114_107,p_114_107,g_114_111,p_114_111,g_110_107,p_110_107) and2( w0g_114_107, p_114_111, g_110_107 )#5 or2( g_114_107, w0g_114_107, g_114_111 )#5 and2( p_114_107, p_114_111, p_110_107)#5 end netlist // PGcombine (g_115_108,p_115_108,g_115_112,p_115_112,g_111_108,p_111_108) and2( w0g_115_108, p_115_112, g_111_108 )#5 or2( g_115_108, w0g_115_108, g_115_112 )#5 and2( p_115_108, p_115_112, p_111_108)#5 end netlist // PGcombine (g_116_109,p_116_109,g_116_113,p_116_113,g_112_109,p_112_109) and2( w0g_116_109, p_116_113, g_112_109 )#5 or2( g_116_109, w0g_116_109, g_116_113 )#5 and2( p_116_109, p_116_113, p_112_109)#5 end netlist // PGcombine (g_117_110,p_117_110,g_117_114,p_117_114,g_113_110,p_113_110) and2( w0g_117_110, p_117_114, g_113_110 )#5 or2( g_117_110, w0g_117_110, g_117_114 )#5 and2( p_117_110, p_117_114, p_113_110)#5 end netlist // PGcombine (g_118_111,p_118_111,g_118_115,p_118_115,g_114_111,p_114_111) and2( w0g_118_111, p_118_115, g_114_111 )#5 or2( g_118_111, w0g_118_111, g_118_115 )#5 and2( p_118_111, p_118_115, p_114_111)#5 end netlist // PGcombine (g_119_112,p_119_112,g_119_116,p_119_116,g_115_112,p_115_112) and2( w0g_119_112, p_119_116, g_115_112 )#5 or2( g_119_112, w0g_119_112, g_119_116 )#5 and2( p_119_112, p_119_116, p_115_112)#5 end netlist // PGcombine (g_120_113,p_120_113,g_120_117,p_120_117,g_116_113,p_116_113) and2( w0g_120_113, p_120_117, g_116_113 )#5 or2( g_120_113, w0g_120_113, g_120_117 )#5 and2( p_120_113, p_120_117, p_116_113)#5 end netlist // PGcombine (g_121_114,p_121_114,g_121_118,p_121_118,g_117_114,p_117_114) and2( w0g_121_114, p_121_118, g_117_114 )#5 or2( g_121_114, w0g_121_114, g_121_118 )#5 and2( p_121_114, p_121_118, p_117_114)#5 end netlist // PGcombine (g_122_115,p_122_115,g_122_119,p_122_119,g_118_115,p_118_115) and2( w0g_122_115, p_122_119, g_118_115 )#5 or2( g_122_115, w0g_122_115, g_122_119 )#5 and2( p_122_115, p_122_119, p_118_115)#5 end netlist // PGcombine (g_123_116,p_123_116,g_123_120,p_123_120,g_119_116,p_119_116) and2( w0g_123_116, p_123_120, g_119_116 )#5 or2( g_123_116, w0g_123_116, g_123_120 )#5 and2( p_123_116, p_123_120, p_119_116)#5 end netlist // PGcombine (g_124_117,p_124_117,g_124_121,p_124_121,g_120_117,p_120_117) and2( w0g_124_117, p_124_121, g_120_117 )#5 or2( g_124_117, w0g_124_117, g_124_121 )#5 and2( p_124_117, p_124_121, p_120_117)#5 end netlist // PGcombine (g_125_118,p_125_118,g_125_122,p_125_122,g_121_118,p_121_118) and2( w0g_125_118, p_125_122, g_121_118 )#5 or2( g_125_118, w0g_125_118, g_125_122 )#5 and2( p_125_118, p_125_122, p_121_118)#5 end netlist // PGcombine (g_126_119,p_126_119,g_126_123,p_126_123,g_122_119,p_122_119) and2( w0g_126_119, p_126_123, g_122_119 )#5 or2( g_126_119, w0g_126_119, g_126_123 )#5 and2( p_126_119, p_126_123, p_122_119)#5 end netlist // PGcombine (g_127_120,p_127_120,g_127_124,p_127_124,g_123_120,p_123_120) and2( w0g_127_120, p_127_124, g_123_120 )#5 or2( g_127_120, w0g_127_120, g_127_124 )#5 and2( p_127_120, p_127_124, p_123_120)#5 end netlist // Gcombine (g_7_cin, g_7_0, cin, p_7_0 ) and2(w0g_7_cin, p_7_0, cin )#5 or2( g_7_cin, w0g_7_cin, g_7_0 )#5 end netlist // Gcombine (g_8_cin, g_8_1, g_0_cin, p_8_1 ) and2(w0g_8_cin, p_8_1, g_0_cin )#5 or2( g_8_cin, w0g_8_cin, g_8_1 )#5 end netlist // Gcombine (g_9_cin, g_9_2, g_1_cin, p_9_2 ) and2(w0g_9_cin, p_9_2, g_1_cin )#5 or2( g_9_cin, w0g_9_cin, g_9_2 )#5 end netlist // Gcombine (g_10_cin, g_10_3, g_2_cin, p_10_3 ) and2(w0g_10_cin, p_10_3, g_2_cin )#5 or2( g_10_cin, w0g_10_cin, g_10_3 )#5 end netlist // Gcombine (g_11_cin, g_11_4, g_3_cin, p_11_4 ) and2(w0g_11_cin, p_11_4, g_3_cin )#5 or2( g_11_cin, w0g_11_cin, g_11_4 )#5 end netlist // Gcombine (g_12_cin, g_12_5, g_4_cin, p_12_5 ) and2(w0g_12_cin, p_12_5, g_4_cin )#5 or2( g_12_cin, w0g_12_cin, g_12_5 )#5 end netlist // Gcombine (g_13_cin, g_13_6, g_5_cin, p_13_6 ) and2(w0g_13_cin, p_13_6, g_5_cin )#5 or2( g_13_cin, w0g_13_cin, g_13_6 )#5 end netlist // Gcombine (g_14_cin, g_14_7, g_6_cin, p_14_7 ) and2(w0g_14_cin, p_14_7, g_6_cin )#5 or2( g_14_cin, w0g_14_cin, g_14_7 )#5 end netlist // PGcombine (g_15_0,p_15_0,g_15_8,p_15_8,g_7_0,p_7_0) and2( w0g_15_0, p_15_8, g_7_0 )#5 or2( g_15_0, w0g_15_0, g_15_8 )#5 and2( p_15_0, p_15_8, p_7_0)#5 end netlist // PGcombine (g_16_1,p_16_1,g_16_9,p_16_9,g_8_1,p_8_1) and2( w0g_16_1, p_16_9, g_8_1 )#5 or2( g_16_1, w0g_16_1, g_16_9 )#5 and2( p_16_1, p_16_9, p_8_1)#5 end netlist // PGcombine (g_17_2,p_17_2,g_17_10,p_17_10,g_9_2,p_9_2) and2( w0g_17_2, p_17_10, g_9_2 )#5 or2( g_17_2, w0g_17_2, g_17_10 )#5 and2( p_17_2, p_17_10, p_9_2)#5 end netlist // PGcombine (g_18_3,p_18_3,g_18_11,p_18_11,g_10_3,p_10_3) and2( w0g_18_3, p_18_11, g_10_3 )#5 or2( g_18_3, w0g_18_3, g_18_11 )#5 and2( p_18_3, p_18_11, p_10_3)#5 end netlist // PGcombine (g_19_4,p_19_4,g_19_12,p_19_12,g_11_4,p_11_4) and2( w0g_19_4, p_19_12, g_11_4 )#5 or2( g_19_4, w0g_19_4, g_19_12 )#5 and2( p_19_4, p_19_12, p_11_4)#5 end netlist // PGcombine (g_20_5,p_20_5,g_20_13,p_20_13,g_12_5,p_12_5) and2( w0g_20_5, p_20_13, g_12_5 )#5 or2( g_20_5, w0g_20_5, g_20_13 )#5 and2( p_20_5, p_20_13, p_12_5)#5 end netlist // PGcombine (g_21_6,p_21_6,g_21_14,p_21_14,g_13_6,p_13_6) and2( w0g_21_6, p_21_14, g_13_6 )#5 or2( g_21_6, w0g_21_6, g_21_14 )#5 and2( p_21_6, p_21_14, p_13_6)#5 end netlist // PGcombine (g_22_7,p_22_7,g_22_15,p_22_15,g_14_7,p_14_7) and2( w0g_22_7, p_22_15, g_14_7 )#5 or2( g_22_7, w0g_22_7, g_22_15 )#5 and2( p_22_7, p_22_15, p_14_7)#5 end netlist // PGcombine (g_23_8,p_23_8,g_23_16,p_23_16,g_15_8,p_15_8) and2( w0g_23_8, p_23_16, g_15_8 )#5 or2( g_23_8, w0g_23_8, g_23_16 )#5 and2( p_23_8, p_23_16, p_15_8)#5 end netlist // PGcombine (g_24_9,p_24_9,g_24_17,p_24_17,g_16_9,p_16_9) and2( w0g_24_9, p_24_17, g_16_9 )#5 or2( g_24_9, w0g_24_9, g_24_17 )#5 and2( p_24_9, p_24_17, p_16_9)#5 end netlist // PGcombine (g_25_10,p_25_10,g_25_18,p_25_18,g_17_10,p_17_10) and2( w0g_25_10, p_25_18, g_17_10 )#5 or2( g_25_10, w0g_25_10, g_25_18 )#5 and2( p_25_10, p_25_18, p_17_10)#5 end netlist // PGcombine (g_26_11,p_26_11,g_26_19,p_26_19,g_18_11,p_18_11) and2( w0g_26_11, p_26_19, g_18_11 )#5 or2( g_26_11, w0g_26_11, g_26_19 )#5 and2( p_26_11, p_26_19, p_18_11)#5 end netlist // PGcombine (g_27_12,p_27_12,g_27_20,p_27_20,g_19_12,p_19_12) and2( w0g_27_12, p_27_20, g_19_12 )#5 or2( g_27_12, w0g_27_12, g_27_20 )#5 and2( p_27_12, p_27_20, p_19_12)#5 end netlist // PGcombine (g_28_13,p_28_13,g_28_21,p_28_21,g_20_13,p_20_13) and2( w0g_28_13, p_28_21, g_20_13 )#5 or2( g_28_13, w0g_28_13, g_28_21 )#5 and2( p_28_13, p_28_21, p_20_13)#5 end netlist // PGcombine (g_29_14,p_29_14,g_29_22,p_29_22,g_21_14,p_21_14) and2( w0g_29_14, p_29_22, g_21_14 )#5 or2( g_29_14, w0g_29_14, g_29_22 )#5 and2( p_29_14, p_29_22, p_21_14)#5 end netlist // PGcombine (g_30_15,p_30_15,g_30_23,p_30_23,g_22_15,p_22_15) and2( w0g_30_15, p_30_23, g_22_15 )#5 or2( g_30_15, w0g_30_15, g_30_23 )#5 and2( p_30_15, p_30_23, p_22_15)#5 end netlist // PGcombine (g_31_16,p_31_16,g_31_24,p_31_24,g_23_16,p_23_16) and2( w0g_31_16, p_31_24, g_23_16 )#5 or2( g_31_16, w0g_31_16, g_31_24 )#5 and2( p_31_16, p_31_24, p_23_16)#5 end netlist // PGcombine (g_32_17,p_32_17,g_32_25,p_32_25,g_24_17,p_24_17) and2( w0g_32_17, p_32_25, g_24_17 )#5 or2( g_32_17, w0g_32_17, g_32_25 )#5 and2( p_32_17, p_32_25, p_24_17)#5 end netlist // PGcombine (g_33_18,p_33_18,g_33_26,p_33_26,g_25_18,p_25_18) and2( w0g_33_18, p_33_26, g_25_18 )#5 or2( g_33_18, w0g_33_18, g_33_26 )#5 and2( p_33_18, p_33_26, p_25_18)#5 end netlist // PGcombine (g_34_19,p_34_19,g_34_27,p_34_27,g_26_19,p_26_19) and2( w0g_34_19, p_34_27, g_26_19 )#5 or2( g_34_19, w0g_34_19, g_34_27 )#5 and2( p_34_19, p_34_27, p_26_19)#5 end netlist // PGcombine (g_35_20,p_35_20,g_35_28,p_35_28,g_27_20,p_27_20) and2( w0g_35_20, p_35_28, g_27_20 )#5 or2( g_35_20, w0g_35_20, g_35_28 )#5 and2( p_35_20, p_35_28, p_27_20)#5 end netlist // PGcombine (g_36_21,p_36_21,g_36_29,p_36_29,g_28_21,p_28_21) and2( w0g_36_21, p_36_29, g_28_21 )#5 or2( g_36_21, w0g_36_21, g_36_29 )#5 and2( p_36_21, p_36_29, p_28_21)#5 end netlist // PGcombine (g_37_22,p_37_22,g_37_30,p_37_30,g_29_22,p_29_22) and2( w0g_37_22, p_37_30, g_29_22 )#5 or2( g_37_22, w0g_37_22, g_37_30 )#5 and2( p_37_22, p_37_30, p_29_22)#5 end netlist // PGcombine (g_38_23,p_38_23,g_38_31,p_38_31,g_30_23,p_30_23) and2( w0g_38_23, p_38_31, g_30_23 )#5 or2( g_38_23, w0g_38_23, g_38_31 )#5 and2( p_38_23, p_38_31, p_30_23)#5 end netlist // PGcombine (g_39_24,p_39_24,g_39_32,p_39_32,g_31_24,p_31_24) and2( w0g_39_24, p_39_32, g_31_24 )#5 or2( g_39_24, w0g_39_24, g_39_32 )#5 and2( p_39_24, p_39_32, p_31_24)#5 end netlist // PGcombine (g_40_25,p_40_25,g_40_33,p_40_33,g_32_25,p_32_25) and2( w0g_40_25, p_40_33, g_32_25 )#5 or2( g_40_25, w0g_40_25, g_40_33 )#5 and2( p_40_25, p_40_33, p_32_25)#5 end netlist // PGcombine (g_41_26,p_41_26,g_41_34,p_41_34,g_33_26,p_33_26) and2( w0g_41_26, p_41_34, g_33_26 )#5 or2( g_41_26, w0g_41_26, g_41_34 )#5 and2( p_41_26, p_41_34, p_33_26)#5 end netlist // PGcombine (g_42_27,p_42_27,g_42_35,p_42_35,g_34_27,p_34_27) and2( w0g_42_27, p_42_35, g_34_27 )#5 or2( g_42_27, w0g_42_27, g_42_35 )#5 and2( p_42_27, p_42_35, p_34_27)#5 end netlist // PGcombine (g_43_28,p_43_28,g_43_36,p_43_36,g_35_28,p_35_28) and2( w0g_43_28, p_43_36, g_35_28 )#5 or2( g_43_28, w0g_43_28, g_43_36 )#5 and2( p_43_28, p_43_36, p_35_28)#5 end netlist // PGcombine (g_44_29,p_44_29,g_44_37,p_44_37,g_36_29,p_36_29) and2( w0g_44_29, p_44_37, g_36_29 )#5 or2( g_44_29, w0g_44_29, g_44_37 )#5 and2( p_44_29, p_44_37, p_36_29)#5 end netlist // PGcombine (g_45_30,p_45_30,g_45_38,p_45_38,g_37_30,p_37_30) and2( w0g_45_30, p_45_38, g_37_30 )#5 or2( g_45_30, w0g_45_30, g_45_38 )#5 and2( p_45_30, p_45_38, p_37_30)#5 end netlist // PGcombine (g_46_31,p_46_31,g_46_39,p_46_39,g_38_31,p_38_31) and2( w0g_46_31, p_46_39, g_38_31 )#5 or2( g_46_31, w0g_46_31, g_46_39 )#5 and2( p_46_31, p_46_39, p_38_31)#5 end netlist // PGcombine (g_47_32,p_47_32,g_47_40,p_47_40,g_39_32,p_39_32) and2( w0g_47_32, p_47_40, g_39_32 )#5 or2( g_47_32, w0g_47_32, g_47_40 )#5 and2( p_47_32, p_47_40, p_39_32)#5 end netlist // PGcombine (g_48_33,p_48_33,g_48_41,p_48_41,g_40_33,p_40_33) and2( w0g_48_33, p_48_41, g_40_33 )#5 or2( g_48_33, w0g_48_33, g_48_41 )#5 and2( p_48_33, p_48_41, p_40_33)#5 end netlist // PGcombine (g_49_34,p_49_34,g_49_42,p_49_42,g_41_34,p_41_34) and2( w0g_49_34, p_49_42, g_41_34 )#5 or2( g_49_34, w0g_49_34, g_49_42 )#5 and2( p_49_34, p_49_42, p_41_34)#5 end netlist // PGcombine (g_50_35,p_50_35,g_50_43,p_50_43,g_42_35,p_42_35) and2( w0g_50_35, p_50_43, g_42_35 )#5 or2( g_50_35, w0g_50_35, g_50_43 )#5 and2( p_50_35, p_50_43, p_42_35)#5 end netlist // PGcombine (g_51_36,p_51_36,g_51_44,p_51_44,g_43_36,p_43_36) and2( w0g_51_36, p_51_44, g_43_36 )#5 or2( g_51_36, w0g_51_36, g_51_44 )#5 and2( p_51_36, p_51_44, p_43_36)#5 end netlist // PGcombine (g_52_37,p_52_37,g_52_45,p_52_45,g_44_37,p_44_37) and2( w0g_52_37, p_52_45, g_44_37 )#5 or2( g_52_37, w0g_52_37, g_52_45 )#5 and2( p_52_37, p_52_45, p_44_37)#5 end netlist // PGcombine (g_53_38,p_53_38,g_53_46,p_53_46,g_45_38,p_45_38) and2( w0g_53_38, p_53_46, g_45_38 )#5 or2( g_53_38, w0g_53_38, g_53_46 )#5 and2( p_53_38, p_53_46, p_45_38)#5 end netlist // PGcombine (g_54_39,p_54_39,g_54_47,p_54_47,g_46_39,p_46_39) and2( w0g_54_39, p_54_47, g_46_39 )#5 or2( g_54_39, w0g_54_39, g_54_47 )#5 and2( p_54_39, p_54_47, p_46_39)#5 end netlist // PGcombine (g_55_40,p_55_40,g_55_48,p_55_48,g_47_40,p_47_40) and2( w0g_55_40, p_55_48, g_47_40 )#5 or2( g_55_40, w0g_55_40, g_55_48 )#5 and2( p_55_40, p_55_48, p_47_40)#5 end netlist // PGcombine (g_56_41,p_56_41,g_56_49,p_56_49,g_48_41,p_48_41) and2( w0g_56_41, p_56_49, g_48_41 )#5 or2( g_56_41, w0g_56_41, g_56_49 )#5 and2( p_56_41, p_56_49, p_48_41)#5 end netlist // PGcombine (g_57_42,p_57_42,g_57_50,p_57_50,g_49_42,p_49_42) and2( w0g_57_42, p_57_50, g_49_42 )#5 or2( g_57_42, w0g_57_42, g_57_50 )#5 and2( p_57_42, p_57_50, p_49_42)#5 end netlist // PGcombine (g_58_43,p_58_43,g_58_51,p_58_51,g_50_43,p_50_43) and2( w0g_58_43, p_58_51, g_50_43 )#5 or2( g_58_43, w0g_58_43, g_58_51 )#5 and2( p_58_43, p_58_51, p_50_43)#5 end netlist // PGcombine (g_59_44,p_59_44,g_59_52,p_59_52,g_51_44,p_51_44) and2( w0g_59_44, p_59_52, g_51_44 )#5 or2( g_59_44, w0g_59_44, g_59_52 )#5 and2( p_59_44, p_59_52, p_51_44)#5 end netlist // PGcombine (g_60_45,p_60_45,g_60_53,p_60_53,g_52_45,p_52_45) and2( w0g_60_45, p_60_53, g_52_45 )#5 or2( g_60_45, w0g_60_45, g_60_53 )#5 and2( p_60_45, p_60_53, p_52_45)#5 end netlist // PGcombine (g_61_46,p_61_46,g_61_54,p_61_54,g_53_46,p_53_46) and2( w0g_61_46, p_61_54, g_53_46 )#5 or2( g_61_46, w0g_61_46, g_61_54 )#5 and2( p_61_46, p_61_54, p_53_46)#5 end netlist // PGcombine (g_62_47,p_62_47,g_62_55,p_62_55,g_54_47,p_54_47) and2( w0g_62_47, p_62_55, g_54_47 )#5 or2( g_62_47, w0g_62_47, g_62_55 )#5 and2( p_62_47, p_62_55, p_54_47)#5 end netlist // PGcombine (g_63_48,p_63_48,g_63_56,p_63_56,g_55_48,p_55_48) and2( w0g_63_48, p_63_56, g_55_48 )#5 or2( g_63_48, w0g_63_48, g_63_56 )#5 and2( p_63_48, p_63_56, p_55_48)#5 end netlist // PGcombine (g_64_49,p_64_49,g_64_57,p_64_57,g_56_49,p_56_49) and2( w0g_64_49, p_64_57, g_56_49 )#5 or2( g_64_49, w0g_64_49, g_64_57 )#5 and2( p_64_49, p_64_57, p_56_49)#5 end netlist // PGcombine (g_65_50,p_65_50,g_65_58,p_65_58,g_57_50,p_57_50) and2( w0g_65_50, p_65_58, g_57_50 )#5 or2( g_65_50, w0g_65_50, g_65_58 )#5 and2( p_65_50, p_65_58, p_57_50)#5 end netlist // PGcombine (g_66_51,p_66_51,g_66_59,p_66_59,g_58_51,p_58_51) and2( w0g_66_51, p_66_59, g_58_51 )#5 or2( g_66_51, w0g_66_51, g_66_59 )#5 and2( p_66_51, p_66_59, p_58_51)#5 end netlist // PGcombine (g_67_52,p_67_52,g_67_60,p_67_60,g_59_52,p_59_52) and2( w0g_67_52, p_67_60, g_59_52 )#5 or2( g_67_52, w0g_67_52, g_67_60 )#5 and2( p_67_52, p_67_60, p_59_52)#5 end netlist // PGcombine (g_68_53,p_68_53,g_68_61,p_68_61,g_60_53,p_60_53) and2( w0g_68_53, p_68_61, g_60_53 )#5 or2( g_68_53, w0g_68_53, g_68_61 )#5 and2( p_68_53, p_68_61, p_60_53)#5 end netlist // PGcombine (g_69_54,p_69_54,g_69_62,p_69_62,g_61_54,p_61_54) and2( w0g_69_54, p_69_62, g_61_54 )#5 or2( g_69_54, w0g_69_54, g_69_62 )#5 and2( p_69_54, p_69_62, p_61_54)#5 end netlist // PGcombine (g_70_55,p_70_55,g_70_63,p_70_63,g_62_55,p_62_55) and2( w0g_70_55, p_70_63, g_62_55 )#5 or2( g_70_55, w0g_70_55, g_70_63 )#5 and2( p_70_55, p_70_63, p_62_55)#5 end netlist // PGcombine (g_71_56,p_71_56,g_71_64,p_71_64,g_63_56,p_63_56) and2( w0g_71_56, p_71_64, g_63_56 )#5 or2( g_71_56, w0g_71_56, g_71_64 )#5 and2( p_71_56, p_71_64, p_63_56)#5 end netlist // PGcombine (g_72_57,p_72_57,g_72_65,p_72_65,g_64_57,p_64_57) and2( w0g_72_57, p_72_65, g_64_57 )#5 or2( g_72_57, w0g_72_57, g_72_65 )#5 and2( p_72_57, p_72_65, p_64_57)#5 end netlist // PGcombine (g_73_58,p_73_58,g_73_66,p_73_66,g_65_58,p_65_58) and2( w0g_73_58, p_73_66, g_65_58 )#5 or2( g_73_58, w0g_73_58, g_73_66 )#5 and2( p_73_58, p_73_66, p_65_58)#5 end netlist // PGcombine (g_74_59,p_74_59,g_74_67,p_74_67,g_66_59,p_66_59) and2( w0g_74_59, p_74_67, g_66_59 )#5 or2( g_74_59, w0g_74_59, g_74_67 )#5 and2( p_74_59, p_74_67, p_66_59)#5 end netlist // PGcombine (g_75_60,p_75_60,g_75_68,p_75_68,g_67_60,p_67_60) and2( w0g_75_60, p_75_68, g_67_60 )#5 or2( g_75_60, w0g_75_60, g_75_68 )#5 and2( p_75_60, p_75_68, p_67_60)#5 end netlist // PGcombine (g_76_61,p_76_61,g_76_69,p_76_69,g_68_61,p_68_61) and2( w0g_76_61, p_76_69, g_68_61 )#5 or2( g_76_61, w0g_76_61, g_76_69 )#5 and2( p_76_61, p_76_69, p_68_61)#5 end netlist // PGcombine (g_77_62,p_77_62,g_77_70,p_77_70,g_69_62,p_69_62) and2( w0g_77_62, p_77_70, g_69_62 )#5 or2( g_77_62, w0g_77_62, g_77_70 )#5 and2( p_77_62, p_77_70, p_69_62)#5 end netlist // PGcombine (g_78_63,p_78_63,g_78_71,p_78_71,g_70_63,p_70_63) and2( w0g_78_63, p_78_71, g_70_63 )#5 or2( g_78_63, w0g_78_63, g_78_71 )#5 and2( p_78_63, p_78_71, p_70_63)#5 end netlist // PGcombine (g_79_64,p_79_64,g_79_72,p_79_72,g_71_64,p_71_64) and2( w0g_79_64, p_79_72, g_71_64 )#5 or2( g_79_64, w0g_79_64, g_79_72 )#5 and2( p_79_64, p_79_72, p_71_64)#5 end netlist // PGcombine (g_80_65,p_80_65,g_80_73,p_80_73,g_72_65,p_72_65) and2( w0g_80_65, p_80_73, g_72_65 )#5 or2( g_80_65, w0g_80_65, g_80_73 )#5 and2( p_80_65, p_80_73, p_72_65)#5 end netlist // PGcombine (g_81_66,p_81_66,g_81_74,p_81_74,g_73_66,p_73_66) and2( w0g_81_66, p_81_74, g_73_66 )#5 or2( g_81_66, w0g_81_66, g_81_74 )#5 and2( p_81_66, p_81_74, p_73_66)#5 end netlist // PGcombine (g_82_67,p_82_67,g_82_75,p_82_75,g_74_67,p_74_67) and2( w0g_82_67, p_82_75, g_74_67 )#5 or2( g_82_67, w0g_82_67, g_82_75 )#5 and2( p_82_67, p_82_75, p_74_67)#5 end netlist // PGcombine (g_83_68,p_83_68,g_83_76,p_83_76,g_75_68,p_75_68) and2( w0g_83_68, p_83_76, g_75_68 )#5 or2( g_83_68, w0g_83_68, g_83_76 )#5 and2( p_83_68, p_83_76, p_75_68)#5 end netlist // PGcombine (g_84_69,p_84_69,g_84_77,p_84_77,g_76_69,p_76_69) and2( w0g_84_69, p_84_77, g_76_69 )#5 or2( g_84_69, w0g_84_69, g_84_77 )#5 and2( p_84_69, p_84_77, p_76_69)#5 end netlist // PGcombine (g_85_70,p_85_70,g_85_78,p_85_78,g_77_70,p_77_70) and2( w0g_85_70, p_85_78, g_77_70 )#5 or2( g_85_70, w0g_85_70, g_85_78 )#5 and2( p_85_70, p_85_78, p_77_70)#5 end netlist // PGcombine (g_86_71,p_86_71,g_86_79,p_86_79,g_78_71,p_78_71) and2( w0g_86_71, p_86_79, g_78_71 )#5 or2( g_86_71, w0g_86_71, g_86_79 )#5 and2( p_86_71, p_86_79, p_78_71)#5 end netlist // PGcombine (g_87_72,p_87_72,g_87_80,p_87_80,g_79_72,p_79_72) and2( w0g_87_72, p_87_80, g_79_72 )#5 or2( g_87_72, w0g_87_72, g_87_80 )#5 and2( p_87_72, p_87_80, p_79_72)#5 end netlist // PGcombine (g_88_73,p_88_73,g_88_81,p_88_81,g_80_73,p_80_73) and2( w0g_88_73, p_88_81, g_80_73 )#5 or2( g_88_73, w0g_88_73, g_88_81 )#5 and2( p_88_73, p_88_81, p_80_73)#5 end netlist // PGcombine (g_89_74,p_89_74,g_89_82,p_89_82,g_81_74,p_81_74) and2( w0g_89_74, p_89_82, g_81_74 )#5 or2( g_89_74, w0g_89_74, g_89_82 )#5 and2( p_89_74, p_89_82, p_81_74)#5 end netlist // PGcombine (g_90_75,p_90_75,g_90_83,p_90_83,g_82_75,p_82_75) and2( w0g_90_75, p_90_83, g_82_75 )#5 or2( g_90_75, w0g_90_75, g_90_83 )#5 and2( p_90_75, p_90_83, p_82_75)#5 end netlist // PGcombine (g_91_76,p_91_76,g_91_84,p_91_84,g_83_76,p_83_76) and2( w0g_91_76, p_91_84, g_83_76 )#5 or2( g_91_76, w0g_91_76, g_91_84 )#5 and2( p_91_76, p_91_84, p_83_76)#5 end netlist // PGcombine (g_92_77,p_92_77,g_92_85,p_92_85,g_84_77,p_84_77) and2( w0g_92_77, p_92_85, g_84_77 )#5 or2( g_92_77, w0g_92_77, g_92_85 )#5 and2( p_92_77, p_92_85, p_84_77)#5 end netlist // PGcombine (g_93_78,p_93_78,g_93_86,p_93_86,g_85_78,p_85_78) and2( w0g_93_78, p_93_86, g_85_78 )#5 or2( g_93_78, w0g_93_78, g_93_86 )#5 and2( p_93_78, p_93_86, p_85_78)#5 end netlist // PGcombine (g_94_79,p_94_79,g_94_87,p_94_87,g_86_79,p_86_79) and2( w0g_94_79, p_94_87, g_86_79 )#5 or2( g_94_79, w0g_94_79, g_94_87 )#5 and2( p_94_79, p_94_87, p_86_79)#5 end netlist // PGcombine (g_95_80,p_95_80,g_95_88,p_95_88,g_87_80,p_87_80) and2( w0g_95_80, p_95_88, g_87_80 )#5 or2( g_95_80, w0g_95_80, g_95_88 )#5 and2( p_95_80, p_95_88, p_87_80)#5 end netlist // PGcombine (g_96_81,p_96_81,g_96_89,p_96_89,g_88_81,p_88_81) and2( w0g_96_81, p_96_89, g_88_81 )#5 or2( g_96_81, w0g_96_81, g_96_89 )#5 and2( p_96_81, p_96_89, p_88_81)#5 end netlist // PGcombine (g_97_82,p_97_82,g_97_90,p_97_90,g_89_82,p_89_82) and2( w0g_97_82, p_97_90, g_89_82 )#5 or2( g_97_82, w0g_97_82, g_97_90 )#5 and2( p_97_82, p_97_90, p_89_82)#5 end netlist // PGcombine (g_98_83,p_98_83,g_98_91,p_98_91,g_90_83,p_90_83) and2( w0g_98_83, p_98_91, g_90_83 )#5 or2( g_98_83, w0g_98_83, g_98_91 )#5 and2( p_98_83, p_98_91, p_90_83)#5 end netlist // PGcombine (g_99_84,p_99_84,g_99_92,p_99_92,g_91_84,p_91_84) and2( w0g_99_84, p_99_92, g_91_84 )#5 or2( g_99_84, w0g_99_84, g_99_92 )#5 and2( p_99_84, p_99_92, p_91_84)#5 end netlist // PGcombine (g_100_85,p_100_85,g_100_93,p_100_93,g_92_85,p_92_85) and2( w0g_100_85, p_100_93, g_92_85 )#5 or2( g_100_85, w0g_100_85, g_100_93 )#5 and2( p_100_85, p_100_93, p_92_85)#5 end netlist // PGcombine (g_101_86,p_101_86,g_101_94,p_101_94,g_93_86,p_93_86) and2( w0g_101_86, p_101_94, g_93_86 )#5 or2( g_101_86, w0g_101_86, g_101_94 )#5 and2( p_101_86, p_101_94, p_93_86)#5 end netlist // PGcombine (g_102_87,p_102_87,g_102_95,p_102_95,g_94_87,p_94_87) and2( w0g_102_87, p_102_95, g_94_87 )#5 or2( g_102_87, w0g_102_87, g_102_95 )#5 and2( p_102_87, p_102_95, p_94_87)#5 end netlist // PGcombine (g_103_88,p_103_88,g_103_96,p_103_96,g_95_88,p_95_88) and2( w0g_103_88, p_103_96, g_95_88 )#5 or2( g_103_88, w0g_103_88, g_103_96 )#5 and2( p_103_88, p_103_96, p_95_88)#5 end netlist // PGcombine (g_104_89,p_104_89,g_104_97,p_104_97,g_96_89,p_96_89) and2( w0g_104_89, p_104_97, g_96_89 )#5 or2( g_104_89, w0g_104_89, g_104_97 )#5 and2( p_104_89, p_104_97, p_96_89)#5 end netlist // PGcombine (g_105_90,p_105_90,g_105_98,p_105_98,g_97_90,p_97_90) and2( w0g_105_90, p_105_98, g_97_90 )#5 or2( g_105_90, w0g_105_90, g_105_98 )#5 and2( p_105_90, p_105_98, p_97_90)#5 end netlist // PGcombine (g_106_91,p_106_91,g_106_99,p_106_99,g_98_91,p_98_91) and2( w0g_106_91, p_106_99, g_98_91 )#5 or2( g_106_91, w0g_106_91, g_106_99 )#5 and2( p_106_91, p_106_99, p_98_91)#5 end netlist // PGcombine (g_107_92,p_107_92,g_107_100,p_107_100,g_99_92,p_99_92) and2( w0g_107_92, p_107_100, g_99_92 )#5 or2( g_107_92, w0g_107_92, g_107_100 )#5 and2( p_107_92, p_107_100, p_99_92)#5 end netlist // PGcombine (g_108_93,p_108_93,g_108_101,p_108_101,g_100_93,p_100_93) and2( w0g_108_93, p_108_101, g_100_93 )#5 or2( g_108_93, w0g_108_93, g_108_101 )#5 and2( p_108_93, p_108_101, p_100_93)#5 end netlist // PGcombine (g_109_94,p_109_94,g_109_102,p_109_102,g_101_94,p_101_94) and2( w0g_109_94, p_109_102, g_101_94 )#5 or2( g_109_94, w0g_109_94, g_109_102 )#5 and2( p_109_94, p_109_102, p_101_94)#5 end netlist // PGcombine (g_110_95,p_110_95,g_110_103,p_110_103,g_102_95,p_102_95) and2( w0g_110_95, p_110_103, g_102_95 )#5 or2( g_110_95, w0g_110_95, g_110_103 )#5 and2( p_110_95, p_110_103, p_102_95)#5 end netlist // PGcombine (g_111_96,p_111_96,g_111_104,p_111_104,g_103_96,p_103_96) and2( w0g_111_96, p_111_104, g_103_96 )#5 or2( g_111_96, w0g_111_96, g_111_104 )#5 and2( p_111_96, p_111_104, p_103_96)#5 end netlist // PGcombine (g_112_97,p_112_97,g_112_105,p_112_105,g_104_97,p_104_97) and2( w0g_112_97, p_112_105, g_104_97 )#5 or2( g_112_97, w0g_112_97, g_112_105 )#5 and2( p_112_97, p_112_105, p_104_97)#5 end netlist // PGcombine (g_113_98,p_113_98,g_113_106,p_113_106,g_105_98,p_105_98) and2( w0g_113_98, p_113_106, g_105_98 )#5 or2( g_113_98, w0g_113_98, g_113_106 )#5 and2( p_113_98, p_113_106, p_105_98)#5 end netlist // PGcombine (g_114_99,p_114_99,g_114_107,p_114_107,g_106_99,p_106_99) and2( w0g_114_99, p_114_107, g_106_99 )#5 or2( g_114_99, w0g_114_99, g_114_107 )#5 and2( p_114_99, p_114_107, p_106_99)#5 end netlist // PGcombine (g_115_100,p_115_100,g_115_108,p_115_108,g_107_100,p_107_100) and2( w0g_115_100, p_115_108, g_107_100 )#5 or2( g_115_100, w0g_115_100, g_115_108 )#5 and2( p_115_100, p_115_108, p_107_100)#5 end netlist // PGcombine (g_116_101,p_116_101,g_116_109,p_116_109,g_108_101,p_108_101) and2( w0g_116_101, p_116_109, g_108_101 )#5 or2( g_116_101, w0g_116_101, g_116_109 )#5 and2( p_116_101, p_116_109, p_108_101)#5 end netlist // PGcombine (g_117_102,p_117_102,g_117_110,p_117_110,g_109_102,p_109_102) and2( w0g_117_102, p_117_110, g_109_102 )#5 or2( g_117_102, w0g_117_102, g_117_110 )#5 and2( p_117_102, p_117_110, p_109_102)#5 end netlist // PGcombine (g_118_103,p_118_103,g_118_111,p_118_111,g_110_103,p_110_103) and2( w0g_118_103, p_118_111, g_110_103 )#5 or2( g_118_103, w0g_118_103, g_118_111 )#5 and2( p_118_103, p_118_111, p_110_103)#5 end netlist // PGcombine (g_119_104,p_119_104,g_119_112,p_119_112,g_111_104,p_111_104) and2( w0g_119_104, p_119_112, g_111_104 )#5 or2( g_119_104, w0g_119_104, g_119_112 )#5 and2( p_119_104, p_119_112, p_111_104)#5 end netlist // PGcombine (g_120_105,p_120_105,g_120_113,p_120_113,g_112_105,p_112_105) and2( w0g_120_105, p_120_113, g_112_105 )#5 or2( g_120_105, w0g_120_105, g_120_113 )#5 and2( p_120_105, p_120_113, p_112_105)#5 end netlist // PGcombine (g_121_106,p_121_106,g_121_114,p_121_114,g_113_106,p_113_106) and2( w0g_121_106, p_121_114, g_113_106 )#5 or2( g_121_106, w0g_121_106, g_121_114 )#5 and2( p_121_106, p_121_114, p_113_106)#5 end netlist // PGcombine (g_122_107,p_122_107,g_122_115,p_122_115,g_114_107,p_114_107) and2( w0g_122_107, p_122_115, g_114_107 )#5 or2( g_122_107, w0g_122_107, g_122_115 )#5 and2( p_122_107, p_122_115, p_114_107)#5 end netlist // PGcombine (g_123_108,p_123_108,g_123_116,p_123_116,g_115_108,p_115_108) and2( w0g_123_108, p_123_116, g_115_108 )#5 or2( g_123_108, w0g_123_108, g_123_116 )#5 and2( p_123_108, p_123_116, p_115_108)#5 end netlist // PGcombine (g_124_109,p_124_109,g_124_117,p_124_117,g_116_109,p_116_109) and2( w0g_124_109, p_124_117, g_116_109 )#5 or2( g_124_109, w0g_124_109, g_124_117 )#5 and2( p_124_109, p_124_117, p_116_109)#5 end netlist // PGcombine (g_125_110,p_125_110,g_125_118,p_125_118,g_117_110,p_117_110) and2( w0g_125_110, p_125_118, g_117_110 )#5 or2( g_125_110, w0g_125_110, g_125_118 )#5 and2( p_125_110, p_125_118, p_117_110)#5 end netlist // PGcombine (g_126_111,p_126_111,g_126_119,p_126_119,g_118_111,p_118_111) and2( w0g_126_111, p_126_119, g_118_111 )#5 or2( g_126_111, w0g_126_111, g_126_119 )#5 and2( p_126_111, p_126_119, p_118_111)#5 end netlist // PGcombine (g_127_112,p_127_112,g_127_120,p_127_120,g_119_112,p_119_112) and2( w0g_127_112, p_127_120, g_119_112 )#5 or2( g_127_112, w0g_127_112, g_127_120 )#5 and2( p_127_112, p_127_120, p_119_112)#5 end netlist // Gcombine (g_15_cin, g_15_0, cin, p_15_0 ) and2(w0g_15_cin, p_15_0, cin )#5 or2( g_15_cin, w0g_15_cin, g_15_0 )#5 end netlist // Gcombine (g_16_cin, g_16_1, g_0_cin, p_16_1 ) and2(w0g_16_cin, p_16_1, g_0_cin )#5 or2( g_16_cin, w0g_16_cin, g_16_1 )#5 end netlist // Gcombine (g_17_cin, g_17_2, g_1_cin, p_17_2 ) and2(w0g_17_cin, p_17_2, g_1_cin )#5 or2( g_17_cin, w0g_17_cin, g_17_2 )#5 end netlist // Gcombine (g_18_cin, g_18_3, g_2_cin, p_18_3 ) and2(w0g_18_cin, p_18_3, g_2_cin )#5 or2( g_18_cin, w0g_18_cin, g_18_3 )#5 end netlist // Gcombine (g_19_cin, g_19_4, g_3_cin, p_19_4 ) and2(w0g_19_cin, p_19_4, g_3_cin )#5 or2( g_19_cin, w0g_19_cin, g_19_4 )#5 end netlist // Gcombine (g_20_cin, g_20_5, g_4_cin, p_20_5 ) and2(w0g_20_cin, p_20_5, g_4_cin )#5 or2( g_20_cin, w0g_20_cin, g_20_5 )#5 end netlist // Gcombine (g_21_cin, g_21_6, g_5_cin, p_21_6 ) and2(w0g_21_cin, p_21_6, g_5_cin )#5 or2( g_21_cin, w0g_21_cin, g_21_6 )#5 end netlist // Gcombine (g_22_cin, g_22_7, g_6_cin, p_22_7 ) and2(w0g_22_cin, p_22_7, g_6_cin )#5 or2( g_22_cin, w0g_22_cin, g_22_7 )#5 end netlist // Gcombine (g_23_cin, g_23_8, g_7_cin, p_23_8 ) and2(w0g_23_cin, p_23_8, g_7_cin )#5 or2( g_23_cin, w0g_23_cin, g_23_8 )#5 end netlist // Gcombine (g_24_cin, g_24_9, g_8_cin, p_24_9 ) and2(w0g_24_cin, p_24_9, g_8_cin )#5 or2( g_24_cin, w0g_24_cin, g_24_9 )#5 end netlist // Gcombine (g_25_cin, g_25_10, g_9_cin, p_25_10 ) and2(w0g_25_cin, p_25_10, g_9_cin )#5 or2( g_25_cin, w0g_25_cin, g_25_10 )#5 end netlist // Gcombine (g_26_cin, g_26_11, g_10_cin, p_26_11 ) and2(w0g_26_cin, p_26_11, g_10_cin )#5 or2( g_26_cin, w0g_26_cin, g_26_11 )#5 end netlist // Gcombine (g_27_cin, g_27_12, g_11_cin, p_27_12 ) and2(w0g_27_cin, p_27_12, g_11_cin )#5 or2( g_27_cin, w0g_27_cin, g_27_12 )#5 end netlist // Gcombine (g_28_cin, g_28_13, g_12_cin, p_28_13 ) and2(w0g_28_cin, p_28_13, g_12_cin )#5 or2( g_28_cin, w0g_28_cin, g_28_13 )#5 end netlist // Gcombine (g_29_cin, g_29_14, g_13_cin, p_29_14 ) and2(w0g_29_cin, p_29_14, g_13_cin )#5 or2( g_29_cin, w0g_29_cin, g_29_14 )#5 end netlist // Gcombine (g_30_cin, g_30_15, g_14_cin, p_30_15 ) and2(w0g_30_cin, p_30_15, g_14_cin )#5 or2( g_30_cin, w0g_30_cin, g_30_15 )#5 end netlist // PGcombine (g_31_0,p_31_0,g_31_16,p_31_16,g_15_0,p_15_0) and2( w0g_31_0, p_31_16, g_15_0 )#5 or2( g_31_0, w0g_31_0, g_31_16 )#5 and2( p_31_0, p_31_16, p_15_0)#5 end netlist // PGcombine (g_32_1,p_32_1,g_32_17,p_32_17,g_16_1,p_16_1) and2( w0g_32_1, p_32_17, g_16_1 )#5 or2( g_32_1, w0g_32_1, g_32_17 )#5 and2( p_32_1, p_32_17, p_16_1)#5 end netlist // PGcombine (g_33_2,p_33_2,g_33_18,p_33_18,g_17_2,p_17_2) and2( w0g_33_2, p_33_18, g_17_2 )#5 or2( g_33_2, w0g_33_2, g_33_18 )#5 and2( p_33_2, p_33_18, p_17_2)#5 end netlist // PGcombine (g_34_3,p_34_3,g_34_19,p_34_19,g_18_3,p_18_3) and2( w0g_34_3, p_34_19, g_18_3 )#5 or2( g_34_3, w0g_34_3, g_34_19 )#5 and2( p_34_3, p_34_19, p_18_3)#5 end netlist // PGcombine (g_35_4,p_35_4,g_35_20,p_35_20,g_19_4,p_19_4) and2( w0g_35_4, p_35_20, g_19_4 )#5 or2( g_35_4, w0g_35_4, g_35_20 )#5 and2( p_35_4, p_35_20, p_19_4)#5 end netlist // PGcombine (g_36_5,p_36_5,g_36_21,p_36_21,g_20_5,p_20_5) and2( w0g_36_5, p_36_21, g_20_5 )#5 or2( g_36_5, w0g_36_5, g_36_21 )#5 and2( p_36_5, p_36_21, p_20_5)#5 end netlist // PGcombine (g_37_6,p_37_6,g_37_22,p_37_22,g_21_6,p_21_6) and2( w0g_37_6, p_37_22, g_21_6 )#5 or2( g_37_6, w0g_37_6, g_37_22 )#5 and2( p_37_6, p_37_22, p_21_6)#5 end netlist // PGcombine (g_38_7,p_38_7,g_38_23,p_38_23,g_22_7,p_22_7) and2( w0g_38_7, p_38_23, g_22_7 )#5 or2( g_38_7, w0g_38_7, g_38_23 )#5 and2( p_38_7, p_38_23, p_22_7)#5 end netlist // PGcombine (g_39_8,p_39_8,g_39_24,p_39_24,g_23_8,p_23_8) and2( w0g_39_8, p_39_24, g_23_8 )#5 or2( g_39_8, w0g_39_8, g_39_24 )#5 and2( p_39_8, p_39_24, p_23_8)#5 end netlist // PGcombine (g_40_9,p_40_9,g_40_25,p_40_25,g_24_9,p_24_9) and2( w0g_40_9, p_40_25, g_24_9 )#5 or2( g_40_9, w0g_40_9, g_40_25 )#5 and2( p_40_9, p_40_25, p_24_9)#5 end netlist // PGcombine (g_41_10,p_41_10,g_41_26,p_41_26,g_25_10,p_25_10) and2( w0g_41_10, p_41_26, g_25_10 )#5 or2( g_41_10, w0g_41_10, g_41_26 )#5 and2( p_41_10, p_41_26, p_25_10)#5 end netlist // PGcombine (g_42_11,p_42_11,g_42_27,p_42_27,g_26_11,p_26_11) and2( w0g_42_11, p_42_27, g_26_11 )#5 or2( g_42_11, w0g_42_11, g_42_27 )#5 and2( p_42_11, p_42_27, p_26_11)#5 end netlist // PGcombine (g_43_12,p_43_12,g_43_28,p_43_28,g_27_12,p_27_12) and2( w0g_43_12, p_43_28, g_27_12 )#5 or2( g_43_12, w0g_43_12, g_43_28 )#5 and2( p_43_12, p_43_28, p_27_12)#5 end netlist // PGcombine (g_44_13,p_44_13,g_44_29,p_44_29,g_28_13,p_28_13) and2( w0g_44_13, p_44_29, g_28_13 )#5 or2( g_44_13, w0g_44_13, g_44_29 )#5 and2( p_44_13, p_44_29, p_28_13)#5 end netlist // PGcombine (g_45_14,p_45_14,g_45_30,p_45_30,g_29_14,p_29_14) and2( w0g_45_14, p_45_30, g_29_14 )#5 or2( g_45_14, w0g_45_14, g_45_30 )#5 and2( p_45_14, p_45_30, p_29_14)#5 end netlist // PGcombine (g_46_15,p_46_15,g_46_31,p_46_31,g_30_15,p_30_15) and2( w0g_46_15, p_46_31, g_30_15 )#5 or2( g_46_15, w0g_46_15, g_46_31 )#5 and2( p_46_15, p_46_31, p_30_15)#5 end netlist // PGcombine (g_47_16,p_47_16,g_47_32,p_47_32,g_31_16,p_31_16) and2( w0g_47_16, p_47_32, g_31_16 )#5 or2( g_47_16, w0g_47_16, g_47_32 )#5 and2( p_47_16, p_47_32, p_31_16)#5 end netlist // PGcombine (g_48_17,p_48_17,g_48_33,p_48_33,g_32_17,p_32_17) and2( w0g_48_17, p_48_33, g_32_17 )#5 or2( g_48_17, w0g_48_17, g_48_33 )#5 and2( p_48_17, p_48_33, p_32_17)#5 end netlist // PGcombine (g_49_18,p_49_18,g_49_34,p_49_34,g_33_18,p_33_18) and2( w0g_49_18, p_49_34, g_33_18 )#5 or2( g_49_18, w0g_49_18, g_49_34 )#5 and2( p_49_18, p_49_34, p_33_18)#5 end netlist // PGcombine (g_50_19,p_50_19,g_50_35,p_50_35,g_34_19,p_34_19) and2( w0g_50_19, p_50_35, g_34_19 )#5 or2( g_50_19, w0g_50_19, g_50_35 )#5 and2( p_50_19, p_50_35, p_34_19)#5 end netlist // PGcombine (g_51_20,p_51_20,g_51_36,p_51_36,g_35_20,p_35_20) and2( w0g_51_20, p_51_36, g_35_20 )#5 or2( g_51_20, w0g_51_20, g_51_36 )#5 and2( p_51_20, p_51_36, p_35_20)#5 end netlist // PGcombine (g_52_21,p_52_21,g_52_37,p_52_37,g_36_21,p_36_21) and2( w0g_52_21, p_52_37, g_36_21 )#5 or2( g_52_21, w0g_52_21, g_52_37 )#5 and2( p_52_21, p_52_37, p_36_21)#5 end netlist // PGcombine (g_53_22,p_53_22,g_53_38,p_53_38,g_37_22,p_37_22) and2( w0g_53_22, p_53_38, g_37_22 )#5 or2( g_53_22, w0g_53_22, g_53_38 )#5 and2( p_53_22, p_53_38, p_37_22)#5 end netlist // PGcombine (g_54_23,p_54_23,g_54_39,p_54_39,g_38_23,p_38_23) and2( w0g_54_23, p_54_39, g_38_23 )#5 or2( g_54_23, w0g_54_23, g_54_39 )#5 and2( p_54_23, p_54_39, p_38_23)#5 end netlist // PGcombine (g_55_24,p_55_24,g_55_40,p_55_40,g_39_24,p_39_24) and2( w0g_55_24, p_55_40, g_39_24 )#5 or2( g_55_24, w0g_55_24, g_55_40 )#5 and2( p_55_24, p_55_40, p_39_24)#5 end netlist // PGcombine (g_56_25,p_56_25,g_56_41,p_56_41,g_40_25,p_40_25) and2( w0g_56_25, p_56_41, g_40_25 )#5 or2( g_56_25, w0g_56_25, g_56_41 )#5 and2( p_56_25, p_56_41, p_40_25)#5 end netlist // PGcombine (g_57_26,p_57_26,g_57_42,p_57_42,g_41_26,p_41_26) and2( w0g_57_26, p_57_42, g_41_26 )#5 or2( g_57_26, w0g_57_26, g_57_42 )#5 and2( p_57_26, p_57_42, p_41_26)#5 end netlist // PGcombine (g_58_27,p_58_27,g_58_43,p_58_43,g_42_27,p_42_27) and2( w0g_58_27, p_58_43, g_42_27 )#5 or2( g_58_27, w0g_58_27, g_58_43 )#5 and2( p_58_27, p_58_43, p_42_27)#5 end netlist // PGcombine (g_59_28,p_59_28,g_59_44,p_59_44,g_43_28,p_43_28) and2( w0g_59_28, p_59_44, g_43_28 )#5 or2( g_59_28, w0g_59_28, g_59_44 )#5 and2( p_59_28, p_59_44, p_43_28)#5 end netlist // PGcombine (g_60_29,p_60_29,g_60_45,p_60_45,g_44_29,p_44_29) and2( w0g_60_29, p_60_45, g_44_29 )#5 or2( g_60_29, w0g_60_29, g_60_45 )#5 and2( p_60_29, p_60_45, p_44_29)#5 end netlist // PGcombine (g_61_30,p_61_30,g_61_46,p_61_46,g_45_30,p_45_30) and2( w0g_61_30, p_61_46, g_45_30 )#5 or2( g_61_30, w0g_61_30, g_61_46 )#5 and2( p_61_30, p_61_46, p_45_30)#5 end netlist // PGcombine (g_62_31,p_62_31,g_62_47,p_62_47,g_46_31,p_46_31) and2( w0g_62_31, p_62_47, g_46_31 )#5 or2( g_62_31, w0g_62_31, g_62_47 )#5 and2( p_62_31, p_62_47, p_46_31)#5 end netlist // PGcombine (g_63_32,p_63_32,g_63_48,p_63_48,g_47_32,p_47_32) and2( w0g_63_32, p_63_48, g_47_32 )#5 or2( g_63_32, w0g_63_32, g_63_48 )#5 and2( p_63_32, p_63_48, p_47_32)#5 end netlist // PGcombine (g_64_33,p_64_33,g_64_49,p_64_49,g_48_33,p_48_33) and2( w0g_64_33, p_64_49, g_48_33 )#5 or2( g_64_33, w0g_64_33, g_64_49 )#5 and2( p_64_33, p_64_49, p_48_33)#5 end netlist // PGcombine (g_65_34,p_65_34,g_65_50,p_65_50,g_49_34,p_49_34) and2( w0g_65_34, p_65_50, g_49_34 )#5 or2( g_65_34, w0g_65_34, g_65_50 )#5 and2( p_65_34, p_65_50, p_49_34)#5 end netlist // PGcombine (g_66_35,p_66_35,g_66_51,p_66_51,g_50_35,p_50_35) and2( w0g_66_35, p_66_51, g_50_35 )#5 or2( g_66_35, w0g_66_35, g_66_51 )#5 and2( p_66_35, p_66_51, p_50_35)#5 end netlist // PGcombine (g_67_36,p_67_36,g_67_52,p_67_52,g_51_36,p_51_36) and2( w0g_67_36, p_67_52, g_51_36 )#5 or2( g_67_36, w0g_67_36, g_67_52 )#5 and2( p_67_36, p_67_52, p_51_36)#5 end netlist // PGcombine (g_68_37,p_68_37,g_68_53,p_68_53,g_52_37,p_52_37) and2( w0g_68_37, p_68_53, g_52_37 )#5 or2( g_68_37, w0g_68_37, g_68_53 )#5 and2( p_68_37, p_68_53, p_52_37)#5 end netlist // PGcombine (g_69_38,p_69_38,g_69_54,p_69_54,g_53_38,p_53_38) and2( w0g_69_38, p_69_54, g_53_38 )#5 or2( g_69_38, w0g_69_38, g_69_54 )#5 and2( p_69_38, p_69_54, p_53_38)#5 end netlist // PGcombine (g_70_39,p_70_39,g_70_55,p_70_55,g_54_39,p_54_39) and2( w0g_70_39, p_70_55, g_54_39 )#5 or2( g_70_39, w0g_70_39, g_70_55 )#5 and2( p_70_39, p_70_55, p_54_39)#5 end netlist // PGcombine (g_71_40,p_71_40,g_71_56,p_71_56,g_55_40,p_55_40) and2( w0g_71_40, p_71_56, g_55_40 )#5 or2( g_71_40, w0g_71_40, g_71_56 )#5 and2( p_71_40, p_71_56, p_55_40)#5 end netlist // PGcombine (g_72_41,p_72_41,g_72_57,p_72_57,g_56_41,p_56_41) and2( w0g_72_41, p_72_57, g_56_41 )#5 or2( g_72_41, w0g_72_41, g_72_57 )#5 and2( p_72_41, p_72_57, p_56_41)#5 end netlist // PGcombine (g_73_42,p_73_42,g_73_58,p_73_58,g_57_42,p_57_42) and2( w0g_73_42, p_73_58, g_57_42 )#5 or2( g_73_42, w0g_73_42, g_73_58 )#5 and2( p_73_42, p_73_58, p_57_42)#5 end netlist // PGcombine (g_74_43,p_74_43,g_74_59,p_74_59,g_58_43,p_58_43) and2( w0g_74_43, p_74_59, g_58_43 )#5 or2( g_74_43, w0g_74_43, g_74_59 )#5 and2( p_74_43, p_74_59, p_58_43)#5 end netlist // PGcombine (g_75_44,p_75_44,g_75_60,p_75_60,g_59_44,p_59_44) and2( w0g_75_44, p_75_60, g_59_44 )#5 or2( g_75_44, w0g_75_44, g_75_60 )#5 and2( p_75_44, p_75_60, p_59_44)#5 end netlist // PGcombine (g_76_45,p_76_45,g_76_61,p_76_61,g_60_45,p_60_45) and2( w0g_76_45, p_76_61, g_60_45 )#5 or2( g_76_45, w0g_76_45, g_76_61 )#5 and2( p_76_45, p_76_61, p_60_45)#5 end netlist // PGcombine (g_77_46,p_77_46,g_77_62,p_77_62,g_61_46,p_61_46) and2( w0g_77_46, p_77_62, g_61_46 )#5 or2( g_77_46, w0g_77_46, g_77_62 )#5 and2( p_77_46, p_77_62, p_61_46)#5 end netlist // PGcombine (g_78_47,p_78_47,g_78_63,p_78_63,g_62_47,p_62_47) and2( w0g_78_47, p_78_63, g_62_47 )#5 or2( g_78_47, w0g_78_47, g_78_63 )#5 and2( p_78_47, p_78_63, p_62_47)#5 end netlist // PGcombine (g_79_48,p_79_48,g_79_64,p_79_64,g_63_48,p_63_48) and2( w0g_79_48, p_79_64, g_63_48 )#5 or2( g_79_48, w0g_79_48, g_79_64 )#5 and2( p_79_48, p_79_64, p_63_48)#5 end netlist // PGcombine (g_80_49,p_80_49,g_80_65,p_80_65,g_64_49,p_64_49) and2( w0g_80_49, p_80_65, g_64_49 )#5 or2( g_80_49, w0g_80_49, g_80_65 )#5 and2( p_80_49, p_80_65, p_64_49)#5 end netlist // PGcombine (g_81_50,p_81_50,g_81_66,p_81_66,g_65_50,p_65_50) and2( w0g_81_50, p_81_66, g_65_50 )#5 or2( g_81_50, w0g_81_50, g_81_66 )#5 and2( p_81_50, p_81_66, p_65_50)#5 end netlist // PGcombine (g_82_51,p_82_51,g_82_67,p_82_67,g_66_51,p_66_51) and2( w0g_82_51, p_82_67, g_66_51 )#5 or2( g_82_51, w0g_82_51, g_82_67 )#5 and2( p_82_51, p_82_67, p_66_51)#5 end netlist // PGcombine (g_83_52,p_83_52,g_83_68,p_83_68,g_67_52,p_67_52) and2( w0g_83_52, p_83_68, g_67_52 )#5 or2( g_83_52, w0g_83_52, g_83_68 )#5 and2( p_83_52, p_83_68, p_67_52)#5 end netlist // PGcombine (g_84_53,p_84_53,g_84_69,p_84_69,g_68_53,p_68_53) and2( w0g_84_53, p_84_69, g_68_53 )#5 or2( g_84_53, w0g_84_53, g_84_69 )#5 and2( p_84_53, p_84_69, p_68_53)#5 end netlist // PGcombine (g_85_54,p_85_54,g_85_70,p_85_70,g_69_54,p_69_54) and2( w0g_85_54, p_85_70, g_69_54 )#5 or2( g_85_54, w0g_85_54, g_85_70 )#5 and2( p_85_54, p_85_70, p_69_54)#5 end netlist // PGcombine (g_86_55,p_86_55,g_86_71,p_86_71,g_70_55,p_70_55) and2( w0g_86_55, p_86_71, g_70_55 )#5 or2( g_86_55, w0g_86_55, g_86_71 )#5 and2( p_86_55, p_86_71, p_70_55)#5 end netlist // PGcombine (g_87_56,p_87_56,g_87_72,p_87_72,g_71_56,p_71_56) and2( w0g_87_56, p_87_72, g_71_56 )#5 or2( g_87_56, w0g_87_56, g_87_72 )#5 and2( p_87_56, p_87_72, p_71_56)#5 end netlist // PGcombine (g_88_57,p_88_57,g_88_73,p_88_73,g_72_57,p_72_57) and2( w0g_88_57, p_88_73, g_72_57 )#5 or2( g_88_57, w0g_88_57, g_88_73 )#5 and2( p_88_57, p_88_73, p_72_57)#5 end netlist // PGcombine (g_89_58,p_89_58,g_89_74,p_89_74,g_73_58,p_73_58) and2( w0g_89_58, p_89_74, g_73_58 )#5 or2( g_89_58, w0g_89_58, g_89_74 )#5 and2( p_89_58, p_89_74, p_73_58)#5 end netlist // PGcombine (g_90_59,p_90_59,g_90_75,p_90_75,g_74_59,p_74_59) and2( w0g_90_59, p_90_75, g_74_59 )#5 or2( g_90_59, w0g_90_59, g_90_75 )#5 and2( p_90_59, p_90_75, p_74_59)#5 end netlist // PGcombine (g_91_60,p_91_60,g_91_76,p_91_76,g_75_60,p_75_60) and2( w0g_91_60, p_91_76, g_75_60 )#5 or2( g_91_60, w0g_91_60, g_91_76 )#5 and2( p_91_60, p_91_76, p_75_60)#5 end netlist // PGcombine (g_92_61,p_92_61,g_92_77,p_92_77,g_76_61,p_76_61) and2( w0g_92_61, p_92_77, g_76_61 )#5 or2( g_92_61, w0g_92_61, g_92_77 )#5 and2( p_92_61, p_92_77, p_76_61)#5 end netlist // PGcombine (g_93_62,p_93_62,g_93_78,p_93_78,g_77_62,p_77_62) and2( w0g_93_62, p_93_78, g_77_62 )#5 or2( g_93_62, w0g_93_62, g_93_78 )#5 and2( p_93_62, p_93_78, p_77_62)#5 end netlist // PGcombine (g_94_63,p_94_63,g_94_79,p_94_79,g_78_63,p_78_63) and2( w0g_94_63, p_94_79, g_78_63 )#5 or2( g_94_63, w0g_94_63, g_94_79 )#5 and2( p_94_63, p_94_79, p_78_63)#5 end netlist // PGcombine (g_95_64,p_95_64,g_95_80,p_95_80,g_79_64,p_79_64) and2( w0g_95_64, p_95_80, g_79_64 )#5 or2( g_95_64, w0g_95_64, g_95_80 )#5 and2( p_95_64, p_95_80, p_79_64)#5 end netlist // PGcombine (g_96_65,p_96_65,g_96_81,p_96_81,g_80_65,p_80_65) and2( w0g_96_65, p_96_81, g_80_65 )#5 or2( g_96_65, w0g_96_65, g_96_81 )#5 and2( p_96_65, p_96_81, p_80_65)#5 end netlist // PGcombine (g_97_66,p_97_66,g_97_82,p_97_82,g_81_66,p_81_66) and2( w0g_97_66, p_97_82, g_81_66 )#5 or2( g_97_66, w0g_97_66, g_97_82 )#5 and2( p_97_66, p_97_82, p_81_66)#5 end netlist // PGcombine (g_98_67,p_98_67,g_98_83,p_98_83,g_82_67,p_82_67) and2( w0g_98_67, p_98_83, g_82_67 )#5 or2( g_98_67, w0g_98_67, g_98_83 )#5 and2( p_98_67, p_98_83, p_82_67)#5 end netlist // PGcombine (g_99_68,p_99_68,g_99_84,p_99_84,g_83_68,p_83_68) and2( w0g_99_68, p_99_84, g_83_68 )#5 or2( g_99_68, w0g_99_68, g_99_84 )#5 and2( p_99_68, p_99_84, p_83_68)#5 end netlist // PGcombine (g_100_69,p_100_69,g_100_85,p_100_85,g_84_69,p_84_69) and2( w0g_100_69, p_100_85, g_84_69 )#5 or2( g_100_69, w0g_100_69, g_100_85 )#5 and2( p_100_69, p_100_85, p_84_69)#5 end netlist // PGcombine (g_101_70,p_101_70,g_101_86,p_101_86,g_85_70,p_85_70) and2( w0g_101_70, p_101_86, g_85_70 )#5 or2( g_101_70, w0g_101_70, g_101_86 )#5 and2( p_101_70, p_101_86, p_85_70)#5 end netlist // PGcombine (g_102_71,p_102_71,g_102_87,p_102_87,g_86_71,p_86_71) and2( w0g_102_71, p_102_87, g_86_71 )#5 or2( g_102_71, w0g_102_71, g_102_87 )#5 and2( p_102_71, p_102_87, p_86_71)#5 end netlist // PGcombine (g_103_72,p_103_72,g_103_88,p_103_88,g_87_72,p_87_72) and2( w0g_103_72, p_103_88, g_87_72 )#5 or2( g_103_72, w0g_103_72, g_103_88 )#5 and2( p_103_72, p_103_88, p_87_72)#5 end netlist // PGcombine (g_104_73,p_104_73,g_104_89,p_104_89,g_88_73,p_88_73) and2( w0g_104_73, p_104_89, g_88_73 )#5 or2( g_104_73, w0g_104_73, g_104_89 )#5 and2( p_104_73, p_104_89, p_88_73)#5 end netlist // PGcombine (g_105_74,p_105_74,g_105_90,p_105_90,g_89_74,p_89_74) and2( w0g_105_74, p_105_90, g_89_74 )#5 or2( g_105_74, w0g_105_74, g_105_90 )#5 and2( p_105_74, p_105_90, p_89_74)#5 end netlist // PGcombine (g_106_75,p_106_75,g_106_91,p_106_91,g_90_75,p_90_75) and2( w0g_106_75, p_106_91, g_90_75 )#5 or2( g_106_75, w0g_106_75, g_106_91 )#5 and2( p_106_75, p_106_91, p_90_75)#5 end netlist // PGcombine (g_107_76,p_107_76,g_107_92,p_107_92,g_91_76,p_91_76) and2( w0g_107_76, p_107_92, g_91_76 )#5 or2( g_107_76, w0g_107_76, g_107_92 )#5 and2( p_107_76, p_107_92, p_91_76)#5 end netlist // PGcombine (g_108_77,p_108_77,g_108_93,p_108_93,g_92_77,p_92_77) and2( w0g_108_77, p_108_93, g_92_77 )#5 or2( g_108_77, w0g_108_77, g_108_93 )#5 and2( p_108_77, p_108_93, p_92_77)#5 end netlist // PGcombine (g_109_78,p_109_78,g_109_94,p_109_94,g_93_78,p_93_78) and2( w0g_109_78, p_109_94, g_93_78 )#5 or2( g_109_78, w0g_109_78, g_109_94 )#5 and2( p_109_78, p_109_94, p_93_78)#5 end netlist // PGcombine (g_110_79,p_110_79,g_110_95,p_110_95,g_94_79,p_94_79) and2( w0g_110_79, p_110_95, g_94_79 )#5 or2( g_110_79, w0g_110_79, g_110_95 )#5 and2( p_110_79, p_110_95, p_94_79)#5 end netlist // PGcombine (g_111_80,p_111_80,g_111_96,p_111_96,g_95_80,p_95_80) and2( w0g_111_80, p_111_96, g_95_80 )#5 or2( g_111_80, w0g_111_80, g_111_96 )#5 and2( p_111_80, p_111_96, p_95_80)#5 end netlist // PGcombine (g_112_81,p_112_81,g_112_97,p_112_97,g_96_81,p_96_81) and2( w0g_112_81, p_112_97, g_96_81 )#5 or2( g_112_81, w0g_112_81, g_112_97 )#5 and2( p_112_81, p_112_97, p_96_81)#5 end netlist // PGcombine (g_113_82,p_113_82,g_113_98,p_113_98,g_97_82,p_97_82) and2( w0g_113_82, p_113_98, g_97_82 )#5 or2( g_113_82, w0g_113_82, g_113_98 )#5 and2( p_113_82, p_113_98, p_97_82)#5 end netlist // PGcombine (g_114_83,p_114_83,g_114_99,p_114_99,g_98_83,p_98_83) and2( w0g_114_83, p_114_99, g_98_83 )#5 or2( g_114_83, w0g_114_83, g_114_99 )#5 and2( p_114_83, p_114_99, p_98_83)#5 end netlist // PGcombine (g_115_84,p_115_84,g_115_100,p_115_100,g_99_84,p_99_84) and2( w0g_115_84, p_115_100, g_99_84 )#5 or2( g_115_84, w0g_115_84, g_115_100 )#5 and2( p_115_84, p_115_100, p_99_84)#5 end netlist // PGcombine (g_116_85,p_116_85,g_116_101,p_116_101,g_100_85,p_100_85) and2( w0g_116_85, p_116_101, g_100_85 )#5 or2( g_116_85, w0g_116_85, g_116_101 )#5 and2( p_116_85, p_116_101, p_100_85)#5 end netlist // PGcombine (g_117_86,p_117_86,g_117_102,p_117_102,g_101_86,p_101_86) and2( w0g_117_86, p_117_102, g_101_86 )#5 or2( g_117_86, w0g_117_86, g_117_102 )#5 and2( p_117_86, p_117_102, p_101_86)#5 end netlist // PGcombine (g_118_87,p_118_87,g_118_103,p_118_103,g_102_87,p_102_87) and2( w0g_118_87, p_118_103, g_102_87 )#5 or2( g_118_87, w0g_118_87, g_118_103 )#5 and2( p_118_87, p_118_103, p_102_87)#5 end netlist // PGcombine (g_119_88,p_119_88,g_119_104,p_119_104,g_103_88,p_103_88) and2( w0g_119_88, p_119_104, g_103_88 )#5 or2( g_119_88, w0g_119_88, g_119_104 )#5 and2( p_119_88, p_119_104, p_103_88)#5 end netlist // PGcombine (g_120_89,p_120_89,g_120_105,p_120_105,g_104_89,p_104_89) and2( w0g_120_89, p_120_105, g_104_89 )#5 or2( g_120_89, w0g_120_89, g_120_105 )#5 and2( p_120_89, p_120_105, p_104_89)#5 end netlist // PGcombine (g_121_90,p_121_90,g_121_106,p_121_106,g_105_90,p_105_90) and2( w0g_121_90, p_121_106, g_105_90 )#5 or2( g_121_90, w0g_121_90, g_121_106 )#5 and2( p_121_90, p_121_106, p_105_90)#5 end netlist // PGcombine (g_122_91,p_122_91,g_122_107,p_122_107,g_106_91,p_106_91) and2( w0g_122_91, p_122_107, g_106_91 )#5 or2( g_122_91, w0g_122_91, g_122_107 )#5 and2( p_122_91, p_122_107, p_106_91)#5 end netlist // PGcombine (g_123_92,p_123_92,g_123_108,p_123_108,g_107_92,p_107_92) and2( w0g_123_92, p_123_108, g_107_92 )#5 or2( g_123_92, w0g_123_92, g_123_108 )#5 and2( p_123_92, p_123_108, p_107_92)#5 end netlist // PGcombine (g_124_93,p_124_93,g_124_109,p_124_109,g_108_93,p_108_93) and2( w0g_124_93, p_124_109, g_108_93 )#5 or2( g_124_93, w0g_124_93, g_124_109 )#5 and2( p_124_93, p_124_109, p_108_93)#5 end netlist // PGcombine (g_125_94,p_125_94,g_125_110,p_125_110,g_109_94,p_109_94) and2( w0g_125_94, p_125_110, g_109_94 )#5 or2( g_125_94, w0g_125_94, g_125_110 )#5 and2( p_125_94, p_125_110, p_109_94)#5 end netlist // PGcombine (g_126_95,p_126_95,g_126_111,p_126_111,g_110_95,p_110_95) and2( w0g_126_95, p_126_111, g_110_95 )#5 or2( g_126_95, w0g_126_95, g_126_111 )#5 and2( p_126_95, p_126_111, p_110_95)#5 end netlist // PGcombine (g_127_96,p_127_96,g_127_112,p_127_112,g_111_96,p_111_96) and2( w0g_127_96, p_127_112, g_111_96 )#5 or2( g_127_96, w0g_127_96, g_127_112 )#5 and2( p_127_96, p_127_112, p_111_96)#5 end netlist // Gcombine (g_31_cin, g_31_0, cin, p_31_0 ) and2(w0g_31_cin, p_31_0, cin )#5 or2( g_31_cin, w0g_31_cin, g_31_0 )#5 end netlist // Gcombine (g_32_cin, g_32_1, g_0_cin, p_32_1 ) and2(w0g_32_cin, p_32_1, g_0_cin )#5 or2( g_32_cin, w0g_32_cin, g_32_1 )#5 end netlist // Gcombine (g_33_cin, g_33_2, g_1_cin, p_33_2 ) and2(w0g_33_cin, p_33_2, g_1_cin )#5 or2( g_33_cin, w0g_33_cin, g_33_2 )#5 end netlist // Gcombine (g_34_cin, g_34_3, g_2_cin, p_34_3 ) and2(w0g_34_cin, p_34_3, g_2_cin )#5 or2( g_34_cin, w0g_34_cin, g_34_3 )#5 end netlist // Gcombine (g_35_cin, g_35_4, g_3_cin, p_35_4 ) and2(w0g_35_cin, p_35_4, g_3_cin )#5 or2( g_35_cin, w0g_35_cin, g_35_4 )#5 end netlist // Gcombine (g_36_cin, g_36_5, g_4_cin, p_36_5 ) and2(w0g_36_cin, p_36_5, g_4_cin )#5 or2( g_36_cin, w0g_36_cin, g_36_5 )#5 end netlist // Gcombine (g_37_cin, g_37_6, g_5_cin, p_37_6 ) and2(w0g_37_cin, p_37_6, g_5_cin )#5 or2( g_37_cin, w0g_37_cin, g_37_6 )#5 end netlist // Gcombine (g_38_cin, g_38_7, g_6_cin, p_38_7 ) and2(w0g_38_cin, p_38_7, g_6_cin )#5 or2( g_38_cin, w0g_38_cin, g_38_7 )#5 end netlist // Gcombine (g_39_cin, g_39_8, g_7_cin, p_39_8 ) and2(w0g_39_cin, p_39_8, g_7_cin )#5 or2( g_39_cin, w0g_39_cin, g_39_8 )#5 end netlist // Gcombine (g_40_cin, g_40_9, g_8_cin, p_40_9 ) and2(w0g_40_cin, p_40_9, g_8_cin )#5 or2( g_40_cin, w0g_40_cin, g_40_9 )#5 end netlist // Gcombine (g_41_cin, g_41_10, g_9_cin, p_41_10 ) and2(w0g_41_cin, p_41_10, g_9_cin )#5 or2( g_41_cin, w0g_41_cin, g_41_10 )#5 end netlist // Gcombine (g_42_cin, g_42_11, g_10_cin, p_42_11 ) and2(w0g_42_cin, p_42_11, g_10_cin )#5 or2( g_42_cin, w0g_42_cin, g_42_11 )#5 end netlist // Gcombine (g_43_cin, g_43_12, g_11_cin, p_43_12 ) and2(w0g_43_cin, p_43_12, g_11_cin )#5 or2( g_43_cin, w0g_43_cin, g_43_12 )#5 end netlist // Gcombine (g_44_cin, g_44_13, g_12_cin, p_44_13 ) and2(w0g_44_cin, p_44_13, g_12_cin )#5 or2( g_44_cin, w0g_44_cin, g_44_13 )#5 end netlist // Gcombine (g_45_cin, g_45_14, g_13_cin, p_45_14 ) and2(w0g_45_cin, p_45_14, g_13_cin )#5 or2( g_45_cin, w0g_45_cin, g_45_14 )#5 end netlist // Gcombine (g_46_cin, g_46_15, g_14_cin, p_46_15 ) and2(w0g_46_cin, p_46_15, g_14_cin )#5 or2( g_46_cin, w0g_46_cin, g_46_15 )#5 end netlist // Gcombine (g_47_cin, g_47_16, g_15_cin, p_47_16 ) and2(w0g_47_cin, p_47_16, g_15_cin )#5 or2( g_47_cin, w0g_47_cin, g_47_16 )#5 end netlist // Gcombine (g_48_cin, g_48_17, g_16_cin, p_48_17 ) and2(w0g_48_cin, p_48_17, g_16_cin )#5 or2( g_48_cin, w0g_48_cin, g_48_17 )#5 end netlist // Gcombine (g_49_cin, g_49_18, g_17_cin, p_49_18 ) and2(w0g_49_cin, p_49_18, g_17_cin )#5 or2( g_49_cin, w0g_49_cin, g_49_18 )#5 end netlist // Gcombine (g_50_cin, g_50_19, g_18_cin, p_50_19 ) and2(w0g_50_cin, p_50_19, g_18_cin )#5 or2( g_50_cin, w0g_50_cin, g_50_19 )#5 end netlist // Gcombine (g_51_cin, g_51_20, g_19_cin, p_51_20 ) and2(w0g_51_cin, p_51_20, g_19_cin )#5 or2( g_51_cin, w0g_51_cin, g_51_20 )#5 end netlist // Gcombine (g_52_cin, g_52_21, g_20_cin, p_52_21 ) and2(w0g_52_cin, p_52_21, g_20_cin )#5 or2( g_52_cin, w0g_52_cin, g_52_21 )#5 end netlist // Gcombine (g_53_cin, g_53_22, g_21_cin, p_53_22 ) and2(w0g_53_cin, p_53_22, g_21_cin )#5 or2( g_53_cin, w0g_53_cin, g_53_22 )#5 end netlist // Gcombine (g_54_cin, g_54_23, g_22_cin, p_54_23 ) and2(w0g_54_cin, p_54_23, g_22_cin )#5 or2( g_54_cin, w0g_54_cin, g_54_23 )#5 end netlist // Gcombine (g_55_cin, g_55_24, g_23_cin, p_55_24 ) and2(w0g_55_cin, p_55_24, g_23_cin )#5 or2( g_55_cin, w0g_55_cin, g_55_24 )#5 end netlist // Gcombine (g_56_cin, g_56_25, g_24_cin, p_56_25 ) and2(w0g_56_cin, p_56_25, g_24_cin )#5 or2( g_56_cin, w0g_56_cin, g_56_25 )#5 end netlist // Gcombine (g_57_cin, g_57_26, g_25_cin, p_57_26 ) and2(w0g_57_cin, p_57_26, g_25_cin )#5 or2( g_57_cin, w0g_57_cin, g_57_26 )#5 end netlist // Gcombine (g_58_cin, g_58_27, g_26_cin, p_58_27 ) and2(w0g_58_cin, p_58_27, g_26_cin )#5 or2( g_58_cin, w0g_58_cin, g_58_27 )#5 end netlist // Gcombine (g_59_cin, g_59_28, g_27_cin, p_59_28 ) and2(w0g_59_cin, p_59_28, g_27_cin )#5 or2( g_59_cin, w0g_59_cin, g_59_28 )#5 end netlist // Gcombine (g_60_cin, g_60_29, g_28_cin, p_60_29 ) and2(w0g_60_cin, p_60_29, g_28_cin )#5 or2( g_60_cin, w0g_60_cin, g_60_29 )#5 end netlist // Gcombine (g_61_cin, g_61_30, g_29_cin, p_61_30 ) and2(w0g_61_cin, p_61_30, g_29_cin )#5 or2( g_61_cin, w0g_61_cin, g_61_30 )#5 end netlist // Gcombine (g_62_cin, g_62_31, g_30_cin, p_62_31 ) and2(w0g_62_cin, p_62_31, g_30_cin )#5 or2( g_62_cin, w0g_62_cin, g_62_31 )#5 end netlist // PGcombine (g_63_0,p_63_0,g_63_32,p_63_32,g_31_0,p_31_0) and2( w0g_63_0, p_63_32, g_31_0 )#5 or2( g_63_0, w0g_63_0, g_63_32 )#5 and2( p_63_0, p_63_32, p_31_0)#5 end netlist // PGcombine (g_64_1,p_64_1,g_64_33,p_64_33,g_32_1,p_32_1) and2( w0g_64_1, p_64_33, g_32_1 )#5 or2( g_64_1, w0g_64_1, g_64_33 )#5 and2( p_64_1, p_64_33, p_32_1)#5 end netlist // PGcombine (g_65_2,p_65_2,g_65_34,p_65_34,g_33_2,p_33_2) and2( w0g_65_2, p_65_34, g_33_2 )#5 or2( g_65_2, w0g_65_2, g_65_34 )#5 and2( p_65_2, p_65_34, p_33_2)#5 end netlist // PGcombine (g_66_3,p_66_3,g_66_35,p_66_35,g_34_3,p_34_3) and2( w0g_66_3, p_66_35, g_34_3 )#5 or2( g_66_3, w0g_66_3, g_66_35 )#5 and2( p_66_3, p_66_35, p_34_3)#5 end netlist // PGcombine (g_67_4,p_67_4,g_67_36,p_67_36,g_35_4,p_35_4) and2( w0g_67_4, p_67_36, g_35_4 )#5 or2( g_67_4, w0g_67_4, g_67_36 )#5 and2( p_67_4, p_67_36, p_35_4)#5 end netlist // PGcombine (g_68_5,p_68_5,g_68_37,p_68_37,g_36_5,p_36_5) and2( w0g_68_5, p_68_37, g_36_5 )#5 or2( g_68_5, w0g_68_5, g_68_37 )#5 and2( p_68_5, p_68_37, p_36_5)#5 end netlist // PGcombine (g_69_6,p_69_6,g_69_38,p_69_38,g_37_6,p_37_6) and2( w0g_69_6, p_69_38, g_37_6 )#5 or2( g_69_6, w0g_69_6, g_69_38 )#5 and2( p_69_6, p_69_38, p_37_6)#5 end netlist // PGcombine (g_70_7,p_70_7,g_70_39,p_70_39,g_38_7,p_38_7) and2( w0g_70_7, p_70_39, g_38_7 )#5 or2( g_70_7, w0g_70_7, g_70_39 )#5 and2( p_70_7, p_70_39, p_38_7)#5 end netlist // PGcombine (g_71_8,p_71_8,g_71_40,p_71_40,g_39_8,p_39_8) and2( w0g_71_8, p_71_40, g_39_8 )#5 or2( g_71_8, w0g_71_8, g_71_40 )#5 and2( p_71_8, p_71_40, p_39_8)#5 end netlist // PGcombine (g_72_9,p_72_9,g_72_41,p_72_41,g_40_9,p_40_9) and2( w0g_72_9, p_72_41, g_40_9 )#5 or2( g_72_9, w0g_72_9, g_72_41 )#5 and2( p_72_9, p_72_41, p_40_9)#5 end netlist // PGcombine (g_73_10,p_73_10,g_73_42,p_73_42,g_41_10,p_41_10) and2( w0g_73_10, p_73_42, g_41_10 )#5 or2( g_73_10, w0g_73_10, g_73_42 )#5 and2( p_73_10, p_73_42, p_41_10)#5 end netlist // PGcombine (g_74_11,p_74_11,g_74_43,p_74_43,g_42_11,p_42_11) and2( w0g_74_11, p_74_43, g_42_11 )#5 or2( g_74_11, w0g_74_11, g_74_43 )#5 and2( p_74_11, p_74_43, p_42_11)#5 end netlist // PGcombine (g_75_12,p_75_12,g_75_44,p_75_44,g_43_12,p_43_12) and2( w0g_75_12, p_75_44, g_43_12 )#5 or2( g_75_12, w0g_75_12, g_75_44 )#5 and2( p_75_12, p_75_44, p_43_12)#5 end netlist // PGcombine (g_76_13,p_76_13,g_76_45,p_76_45,g_44_13,p_44_13) and2( w0g_76_13, p_76_45, g_44_13 )#5 or2( g_76_13, w0g_76_13, g_76_45 )#5 and2( p_76_13, p_76_45, p_44_13)#5 end netlist // PGcombine (g_77_14,p_77_14,g_77_46,p_77_46,g_45_14,p_45_14) and2( w0g_77_14, p_77_46, g_45_14 )#5 or2( g_77_14, w0g_77_14, g_77_46 )#5 and2( p_77_14, p_77_46, p_45_14)#5 end netlist // PGcombine (g_78_15,p_78_15,g_78_47,p_78_47,g_46_15,p_46_15) and2( w0g_78_15, p_78_47, g_46_15 )#5 or2( g_78_15, w0g_78_15, g_78_47 )#5 and2( p_78_15, p_78_47, p_46_15)#5 end netlist // PGcombine (g_79_16,p_79_16,g_79_48,p_79_48,g_47_16,p_47_16) and2( w0g_79_16, p_79_48, g_47_16 )#5 or2( g_79_16, w0g_79_16, g_79_48 )#5 and2( p_79_16, p_79_48, p_47_16)#5 end netlist // PGcombine (g_80_17,p_80_17,g_80_49,p_80_49,g_48_17,p_48_17) and2( w0g_80_17, p_80_49, g_48_17 )#5 or2( g_80_17, w0g_80_17, g_80_49 )#5 and2( p_80_17, p_80_49, p_48_17)#5 end netlist // PGcombine (g_81_18,p_81_18,g_81_50,p_81_50,g_49_18,p_49_18) and2( w0g_81_18, p_81_50, g_49_18 )#5 or2( g_81_18, w0g_81_18, g_81_50 )#5 and2( p_81_18, p_81_50, p_49_18)#5 end netlist // PGcombine (g_82_19,p_82_19,g_82_51,p_82_51,g_50_19,p_50_19) and2( w0g_82_19, p_82_51, g_50_19 )#5 or2( g_82_19, w0g_82_19, g_82_51 )#5 and2( p_82_19, p_82_51, p_50_19)#5 end netlist // PGcombine (g_83_20,p_83_20,g_83_52,p_83_52,g_51_20,p_51_20) and2( w0g_83_20, p_83_52, g_51_20 )#5 or2( g_83_20, w0g_83_20, g_83_52 )#5 and2( p_83_20, p_83_52, p_51_20)#5 end netlist // PGcombine (g_84_21,p_84_21,g_84_53,p_84_53,g_52_21,p_52_21) and2( w0g_84_21, p_84_53, g_52_21 )#5 or2( g_84_21, w0g_84_21, g_84_53 )#5 and2( p_84_21, p_84_53, p_52_21)#5 end netlist // PGcombine (g_85_22,p_85_22,g_85_54,p_85_54,g_53_22,p_53_22) and2( w0g_85_22, p_85_54, g_53_22 )#5 or2( g_85_22, w0g_85_22, g_85_54 )#5 and2( p_85_22, p_85_54, p_53_22)#5 end netlist // PGcombine (g_86_23,p_86_23,g_86_55,p_86_55,g_54_23,p_54_23) and2( w0g_86_23, p_86_55, g_54_23 )#5 or2( g_86_23, w0g_86_23, g_86_55 )#5 and2( p_86_23, p_86_55, p_54_23)#5 end netlist // PGcombine (g_87_24,p_87_24,g_87_56,p_87_56,g_55_24,p_55_24) and2( w0g_87_24, p_87_56, g_55_24 )#5 or2( g_87_24, w0g_87_24, g_87_56 )#5 and2( p_87_24, p_87_56, p_55_24)#5 end netlist // PGcombine (g_88_25,p_88_25,g_88_57,p_88_57,g_56_25,p_56_25) and2( w0g_88_25, p_88_57, g_56_25 )#5 or2( g_88_25, w0g_88_25, g_88_57 )#5 and2( p_88_25, p_88_57, p_56_25)#5 end netlist // PGcombine (g_89_26,p_89_26,g_89_58,p_89_58,g_57_26,p_57_26) and2( w0g_89_26, p_89_58, g_57_26 )#5 or2( g_89_26, w0g_89_26, g_89_58 )#5 and2( p_89_26, p_89_58, p_57_26)#5 end netlist // PGcombine (g_90_27,p_90_27,g_90_59,p_90_59,g_58_27,p_58_27) and2( w0g_90_27, p_90_59, g_58_27 )#5 or2( g_90_27, w0g_90_27, g_90_59 )#5 and2( p_90_27, p_90_59, p_58_27)#5 end netlist // PGcombine (g_91_28,p_91_28,g_91_60,p_91_60,g_59_28,p_59_28) and2( w0g_91_28, p_91_60, g_59_28 )#5 or2( g_91_28, w0g_91_28, g_91_60 )#5 and2( p_91_28, p_91_60, p_59_28)#5 end netlist // PGcombine (g_92_29,p_92_29,g_92_61,p_92_61,g_60_29,p_60_29) and2( w0g_92_29, p_92_61, g_60_29 )#5 or2( g_92_29, w0g_92_29, g_92_61 )#5 and2( p_92_29, p_92_61, p_60_29)#5 end netlist // PGcombine (g_93_30,p_93_30,g_93_62,p_93_62,g_61_30,p_61_30) and2( w0g_93_30, p_93_62, g_61_30 )#5 or2( g_93_30, w0g_93_30, g_93_62 )#5 and2( p_93_30, p_93_62, p_61_30)#5 end netlist // PGcombine (g_94_31,p_94_31,g_94_63,p_94_63,g_62_31,p_62_31) and2( w0g_94_31, p_94_63, g_62_31 )#5 or2( g_94_31, w0g_94_31, g_94_63 )#5 and2( p_94_31, p_94_63, p_62_31)#5 end netlist // PGcombine (g_95_32,p_95_32,g_95_64,p_95_64,g_63_32,p_63_32) and2( w0g_95_32, p_95_64, g_63_32 )#5 or2( g_95_32, w0g_95_32, g_95_64 )#5 and2( p_95_32, p_95_64, p_63_32)#5 end netlist // PGcombine (g_96_33,p_96_33,g_96_65,p_96_65,g_64_33,p_64_33) and2( w0g_96_33, p_96_65, g_64_33 )#5 or2( g_96_33, w0g_96_33, g_96_65 )#5 and2( p_96_33, p_96_65, p_64_33)#5 end netlist // PGcombine (g_97_34,p_97_34,g_97_66,p_97_66,g_65_34,p_65_34) and2( w0g_97_34, p_97_66, g_65_34 )#5 or2( g_97_34, w0g_97_34, g_97_66 )#5 and2( p_97_34, p_97_66, p_65_34)#5 end netlist // PGcombine (g_98_35,p_98_35,g_98_67,p_98_67,g_66_35,p_66_35) and2( w0g_98_35, p_98_67, g_66_35 )#5 or2( g_98_35, w0g_98_35, g_98_67 )#5 and2( p_98_35, p_98_67, p_66_35)#5 end netlist // PGcombine (g_99_36,p_99_36,g_99_68,p_99_68,g_67_36,p_67_36) and2( w0g_99_36, p_99_68, g_67_36 )#5 or2( g_99_36, w0g_99_36, g_99_68 )#5 and2( p_99_36, p_99_68, p_67_36)#5 end netlist // PGcombine (g_100_37,p_100_37,g_100_69,p_100_69,g_68_37,p_68_37) and2( w0g_100_37, p_100_69, g_68_37 )#5 or2( g_100_37, w0g_100_37, g_100_69 )#5 and2( p_100_37, p_100_69, p_68_37)#5 end netlist // PGcombine (g_101_38,p_101_38,g_101_70,p_101_70,g_69_38,p_69_38) and2( w0g_101_38, p_101_70, g_69_38 )#5 or2( g_101_38, w0g_101_38, g_101_70 )#5 and2( p_101_38, p_101_70, p_69_38)#5 end netlist // PGcombine (g_102_39,p_102_39,g_102_71,p_102_71,g_70_39,p_70_39) and2( w0g_102_39, p_102_71, g_70_39 )#5 or2( g_102_39, w0g_102_39, g_102_71 )#5 and2( p_102_39, p_102_71, p_70_39)#5 end netlist // PGcombine (g_103_40,p_103_40,g_103_72,p_103_72,g_71_40,p_71_40) and2( w0g_103_40, p_103_72, g_71_40 )#5 or2( g_103_40, w0g_103_40, g_103_72 )#5 and2( p_103_40, p_103_72, p_71_40)#5 end netlist // PGcombine (g_104_41,p_104_41,g_104_73,p_104_73,g_72_41,p_72_41) and2( w0g_104_41, p_104_73, g_72_41 )#5 or2( g_104_41, w0g_104_41, g_104_73 )#5 and2( p_104_41, p_104_73, p_72_41)#5 end netlist // PGcombine (g_105_42,p_105_42,g_105_74,p_105_74,g_73_42,p_73_42) and2( w0g_105_42, p_105_74, g_73_42 )#5 or2( g_105_42, w0g_105_42, g_105_74 )#5 and2( p_105_42, p_105_74, p_73_42)#5 end netlist // PGcombine (g_106_43,p_106_43,g_106_75,p_106_75,g_74_43,p_74_43) and2( w0g_106_43, p_106_75, g_74_43 )#5 or2( g_106_43, w0g_106_43, g_106_75 )#5 and2( p_106_43, p_106_75, p_74_43)#5 end netlist // PGcombine (g_107_44,p_107_44,g_107_76,p_107_76,g_75_44,p_75_44) and2( w0g_107_44, p_107_76, g_75_44 )#5 or2( g_107_44, w0g_107_44, g_107_76 )#5 and2( p_107_44, p_107_76, p_75_44)#5 end netlist // PGcombine (g_108_45,p_108_45,g_108_77,p_108_77,g_76_45,p_76_45) and2( w0g_108_45, p_108_77, g_76_45 )#5 or2( g_108_45, w0g_108_45, g_108_77 )#5 and2( p_108_45, p_108_77, p_76_45)#5 end netlist // PGcombine (g_109_46,p_109_46,g_109_78,p_109_78,g_77_46,p_77_46) and2( w0g_109_46, p_109_78, g_77_46 )#5 or2( g_109_46, w0g_109_46, g_109_78 )#5 and2( p_109_46, p_109_78, p_77_46)#5 end netlist // PGcombine (g_110_47,p_110_47,g_110_79,p_110_79,g_78_47,p_78_47) and2( w0g_110_47, p_110_79, g_78_47 )#5 or2( g_110_47, w0g_110_47, g_110_79 )#5 and2( p_110_47, p_110_79, p_78_47)#5 end netlist // PGcombine (g_111_48,p_111_48,g_111_80,p_111_80,g_79_48,p_79_48) and2( w0g_111_48, p_111_80, g_79_48 )#5 or2( g_111_48, w0g_111_48, g_111_80 )#5 and2( p_111_48, p_111_80, p_79_48)#5 end netlist // PGcombine (g_112_49,p_112_49,g_112_81,p_112_81,g_80_49,p_80_49) and2( w0g_112_49, p_112_81, g_80_49 )#5 or2( g_112_49, w0g_112_49, g_112_81 )#5 and2( p_112_49, p_112_81, p_80_49)#5 end netlist // PGcombine (g_113_50,p_113_50,g_113_82,p_113_82,g_81_50,p_81_50) and2( w0g_113_50, p_113_82, g_81_50 )#5 or2( g_113_50, w0g_113_50, g_113_82 )#5 and2( p_113_50, p_113_82, p_81_50)#5 end netlist // PGcombine (g_114_51,p_114_51,g_114_83,p_114_83,g_82_51,p_82_51) and2( w0g_114_51, p_114_83, g_82_51 )#5 or2( g_114_51, w0g_114_51, g_114_83 )#5 and2( p_114_51, p_114_83, p_82_51)#5 end netlist // PGcombine (g_115_52,p_115_52,g_115_84,p_115_84,g_83_52,p_83_52) and2( w0g_115_52, p_115_84, g_83_52 )#5 or2( g_115_52, w0g_115_52, g_115_84 )#5 and2( p_115_52, p_115_84, p_83_52)#5 end netlist // PGcombine (g_116_53,p_116_53,g_116_85,p_116_85,g_84_53,p_84_53) and2( w0g_116_53, p_116_85, g_84_53 )#5 or2( g_116_53, w0g_116_53, g_116_85 )#5 and2( p_116_53, p_116_85, p_84_53)#5 end netlist // PGcombine (g_117_54,p_117_54,g_117_86,p_117_86,g_85_54,p_85_54) and2( w0g_117_54, p_117_86, g_85_54 )#5 or2( g_117_54, w0g_117_54, g_117_86 )#5 and2( p_117_54, p_117_86, p_85_54)#5 end netlist // PGcombine (g_118_55,p_118_55,g_118_87,p_118_87,g_86_55,p_86_55) and2( w0g_118_55, p_118_87, g_86_55 )#5 or2( g_118_55, w0g_118_55, g_118_87 )#5 and2( p_118_55, p_118_87, p_86_55)#5 end netlist // PGcombine (g_119_56,p_119_56,g_119_88,p_119_88,g_87_56,p_87_56) and2( w0g_119_56, p_119_88, g_87_56 )#5 or2( g_119_56, w0g_119_56, g_119_88 )#5 and2( p_119_56, p_119_88, p_87_56)#5 end netlist // PGcombine (g_120_57,p_120_57,g_120_89,p_120_89,g_88_57,p_88_57) and2( w0g_120_57, p_120_89, g_88_57 )#5 or2( g_120_57, w0g_120_57, g_120_89 )#5 and2( p_120_57, p_120_89, p_88_57)#5 end netlist // PGcombine (g_121_58,p_121_58,g_121_90,p_121_90,g_89_58,p_89_58) and2( w0g_121_58, p_121_90, g_89_58 )#5 or2( g_121_58, w0g_121_58, g_121_90 )#5 and2( p_121_58, p_121_90, p_89_58)#5 end netlist // PGcombine (g_122_59,p_122_59,g_122_91,p_122_91,g_90_59,p_90_59) and2( w0g_122_59, p_122_91, g_90_59 )#5 or2( g_122_59, w0g_122_59, g_122_91 )#5 and2( p_122_59, p_122_91, p_90_59)#5 end netlist // PGcombine (g_123_60,p_123_60,g_123_92,p_123_92,g_91_60,p_91_60) and2( w0g_123_60, p_123_92, g_91_60 )#5 or2( g_123_60, w0g_123_60, g_123_92 )#5 and2( p_123_60, p_123_92, p_91_60)#5 end netlist // PGcombine (g_124_61,p_124_61,g_124_93,p_124_93,g_92_61,p_92_61) and2( w0g_124_61, p_124_93, g_92_61 )#5 or2( g_124_61, w0g_124_61, g_124_93 )#5 and2( p_124_61, p_124_93, p_92_61)#5 end netlist // PGcombine (g_125_62,p_125_62,g_125_94,p_125_94,g_93_62,p_93_62) and2( w0g_125_62, p_125_94, g_93_62 )#5 or2( g_125_62, w0g_125_62, g_125_94 )#5 and2( p_125_62, p_125_94, p_93_62)#5 end netlist // PGcombine (g_126_63,p_126_63,g_126_95,p_126_95,g_94_63,p_94_63) and2( w0g_126_63, p_126_95, g_94_63 )#5 or2( g_126_63, w0g_126_63, g_126_95 )#5 and2( p_126_63, p_126_95, p_94_63)#5 end netlist // PGcombine (g_127_64,p_127_64,g_127_96,p_127_96,g_95_64,p_95_64) and2( w0g_127_64, p_127_96, g_95_64 )#5 or2( g_127_64, w0g_127_64, g_127_96 )#5 and2( p_127_64, p_127_96, p_95_64)#5 end netlist // Gcombine (g_63_cin, g_63_0, cin, p_63_0 ) and2(w0g_63_cin, p_63_0, cin )#5 or2( g_63_cin, w0g_63_cin, g_63_0 )#5 end netlist // Gcombine (g_64_cin, g_64_1, g_0_cin, p_64_1 ) and2(w0g_64_cin, p_64_1, g_0_cin )#5 or2( g_64_cin, w0g_64_cin, g_64_1 )#5 end netlist // Gcombine (g_65_cin, g_65_2, g_1_cin, p_65_2 ) and2(w0g_65_cin, p_65_2, g_1_cin )#5 or2( g_65_cin, w0g_65_cin, g_65_2 )#5 end netlist // Gcombine (g_66_cin, g_66_3, g_2_cin, p_66_3 ) and2(w0g_66_cin, p_66_3, g_2_cin )#5 or2( g_66_cin, w0g_66_cin, g_66_3 )#5 end netlist // Gcombine (g_67_cin, g_67_4, g_3_cin, p_67_4 ) and2(w0g_67_cin, p_67_4, g_3_cin )#5 or2( g_67_cin, w0g_67_cin, g_67_4 )#5 end netlist // Gcombine (g_68_cin, g_68_5, g_4_cin, p_68_5 ) and2(w0g_68_cin, p_68_5, g_4_cin )#5 or2( g_68_cin, w0g_68_cin, g_68_5 )#5 end netlist // Gcombine (g_69_cin, g_69_6, g_5_cin, p_69_6 ) and2(w0g_69_cin, p_69_6, g_5_cin )#5 or2( g_69_cin, w0g_69_cin, g_69_6 )#5 end netlist // Gcombine (g_70_cin, g_70_7, g_6_cin, p_70_7 ) and2(w0g_70_cin, p_70_7, g_6_cin )#5 or2( g_70_cin, w0g_70_cin, g_70_7 )#5 end netlist // Gcombine (g_71_cin, g_71_8, g_7_cin, p_71_8 ) and2(w0g_71_cin, p_71_8, g_7_cin )#5 or2( g_71_cin, w0g_71_cin, g_71_8 )#5 end netlist // Gcombine (g_72_cin, g_72_9, g_8_cin, p_72_9 ) and2(w0g_72_cin, p_72_9, g_8_cin )#5 or2( g_72_cin, w0g_72_cin, g_72_9 )#5 end netlist // Gcombine (g_73_cin, g_73_10, g_9_cin, p_73_10 ) and2(w0g_73_cin, p_73_10, g_9_cin )#5 or2( g_73_cin, w0g_73_cin, g_73_10 )#5 end netlist // Gcombine (g_74_cin, g_74_11, g_10_cin, p_74_11 ) and2(w0g_74_cin, p_74_11, g_10_cin )#5 or2( g_74_cin, w0g_74_cin, g_74_11 )#5 end netlist // Gcombine (g_75_cin, g_75_12, g_11_cin, p_75_12 ) and2(w0g_75_cin, p_75_12, g_11_cin )#5 or2( g_75_cin, w0g_75_cin, g_75_12 )#5 end netlist // Gcombine (g_76_cin, g_76_13, g_12_cin, p_76_13 ) and2(w0g_76_cin, p_76_13, g_12_cin )#5 or2( g_76_cin, w0g_76_cin, g_76_13 )#5 end netlist // Gcombine (g_77_cin, g_77_14, g_13_cin, p_77_14 ) and2(w0g_77_cin, p_77_14, g_13_cin )#5 or2( g_77_cin, w0g_77_cin, g_77_14 )#5 end netlist // Gcombine (g_78_cin, g_78_15, g_14_cin, p_78_15 ) and2(w0g_78_cin, p_78_15, g_14_cin )#5 or2( g_78_cin, w0g_78_cin, g_78_15 )#5 end netlist // Gcombine (g_79_cin, g_79_16, g_15_cin, p_79_16 ) and2(w0g_79_cin, p_79_16, g_15_cin )#5 or2( g_79_cin, w0g_79_cin, g_79_16 )#5 end netlist // Gcombine (g_80_cin, g_80_17, g_16_cin, p_80_17 ) and2(w0g_80_cin, p_80_17, g_16_cin )#5 or2( g_80_cin, w0g_80_cin, g_80_17 )#5 end netlist // Gcombine (g_81_cin, g_81_18, g_17_cin, p_81_18 ) and2(w0g_81_cin, p_81_18, g_17_cin )#5 or2( g_81_cin, w0g_81_cin, g_81_18 )#5 end netlist // Gcombine (g_82_cin, g_82_19, g_18_cin, p_82_19 ) and2(w0g_82_cin, p_82_19, g_18_cin )#5 or2( g_82_cin, w0g_82_cin, g_82_19 )#5 end netlist // Gcombine (g_83_cin, g_83_20, g_19_cin, p_83_20 ) and2(w0g_83_cin, p_83_20, g_19_cin )#5 or2( g_83_cin, w0g_83_cin, g_83_20 )#5 end netlist // Gcombine (g_84_cin, g_84_21, g_20_cin, p_84_21 ) and2(w0g_84_cin, p_84_21, g_20_cin )#5 or2( g_84_cin, w0g_84_cin, g_84_21 )#5 end netlist // Gcombine (g_85_cin, g_85_22, g_21_cin, p_85_22 ) and2(w0g_85_cin, p_85_22, g_21_cin )#5 or2( g_85_cin, w0g_85_cin, g_85_22 )#5 end netlist // Gcombine (g_86_cin, g_86_23, g_22_cin, p_86_23 ) and2(w0g_86_cin, p_86_23, g_22_cin )#5 or2( g_86_cin, w0g_86_cin, g_86_23 )#5 end netlist // Gcombine (g_87_cin, g_87_24, g_23_cin, p_87_24 ) and2(w0g_87_cin, p_87_24, g_23_cin )#5 or2( g_87_cin, w0g_87_cin, g_87_24 )#5 end netlist // Gcombine (g_88_cin, g_88_25, g_24_cin, p_88_25 ) and2(w0g_88_cin, p_88_25, g_24_cin )#5 or2( g_88_cin, w0g_88_cin, g_88_25 )#5 end netlist // Gcombine (g_89_cin, g_89_26, g_25_cin, p_89_26 ) and2(w0g_89_cin, p_89_26, g_25_cin )#5 or2( g_89_cin, w0g_89_cin, g_89_26 )#5 end netlist // Gcombine (g_90_cin, g_90_27, g_26_cin, p_90_27 ) and2(w0g_90_cin, p_90_27, g_26_cin )#5 or2( g_90_cin, w0g_90_cin, g_90_27 )#5 end netlist // Gcombine (g_91_cin, g_91_28, g_27_cin, p_91_28 ) and2(w0g_91_cin, p_91_28, g_27_cin )#5 or2( g_91_cin, w0g_91_cin, g_91_28 )#5 end netlist // Gcombine (g_92_cin, g_92_29, g_28_cin, p_92_29 ) and2(w0g_92_cin, p_92_29, g_28_cin )#5 or2( g_92_cin, w0g_92_cin, g_92_29 )#5 end netlist // Gcombine (g_93_cin, g_93_30, g_29_cin, p_93_30 ) and2(w0g_93_cin, p_93_30, g_29_cin )#5 or2( g_93_cin, w0g_93_cin, g_93_30 )#5 end netlist // Gcombine (g_94_cin, g_94_31, g_30_cin, p_94_31 ) and2(w0g_94_cin, p_94_31, g_30_cin )#5 or2( g_94_cin, w0g_94_cin, g_94_31 )#5 end netlist // Gcombine (g_95_cin, g_95_32, g_31_cin, p_95_32 ) and2(w0g_95_cin, p_95_32, g_31_cin )#5 or2( g_95_cin, w0g_95_cin, g_95_32 )#5 end netlist // Gcombine (g_96_cin, g_96_33, g_32_cin, p_96_33 ) and2(w0g_96_cin, p_96_33, g_32_cin )#5 or2( g_96_cin, w0g_96_cin, g_96_33 )#5 end netlist // Gcombine (g_97_cin, g_97_34, g_33_cin, p_97_34 ) and2(w0g_97_cin, p_97_34, g_33_cin )#5 or2( g_97_cin, w0g_97_cin, g_97_34 )#5 end netlist // Gcombine (g_98_cin, g_98_35, g_34_cin, p_98_35 ) and2(w0g_98_cin, p_98_35, g_34_cin )#5 or2( g_98_cin, w0g_98_cin, g_98_35 )#5 end netlist // Gcombine (g_99_cin, g_99_36, g_35_cin, p_99_36 ) and2(w0g_99_cin, p_99_36, g_35_cin )#5 or2( g_99_cin, w0g_99_cin, g_99_36 )#5 end netlist // Gcombine (g_100_cin, g_100_37, g_36_cin, p_100_37 ) and2(w0g_100_cin, p_100_37, g_36_cin )#5 or2( g_100_cin, w0g_100_cin, g_100_37 )#5 end netlist // Gcombine (g_101_cin, g_101_38, g_37_cin, p_101_38 ) and2(w0g_101_cin, p_101_38, g_37_cin )#5 or2( g_101_cin, w0g_101_cin, g_101_38 )#5 end netlist // Gcombine (g_102_cin, g_102_39, g_38_cin, p_102_39 ) and2(w0g_102_cin, p_102_39, g_38_cin )#5 or2( g_102_cin, w0g_102_cin, g_102_39 )#5 end netlist // Gcombine (g_103_cin, g_103_40, g_39_cin, p_103_40 ) and2(w0g_103_cin, p_103_40, g_39_cin )#5 or2( g_103_cin, w0g_103_cin, g_103_40 )#5 end netlist // Gcombine (g_104_cin, g_104_41, g_40_cin, p_104_41 ) and2(w0g_104_cin, p_104_41, g_40_cin )#5 or2( g_104_cin, w0g_104_cin, g_104_41 )#5 end netlist // Gcombine (g_105_cin, g_105_42, g_41_cin, p_105_42 ) and2(w0g_105_cin, p_105_42, g_41_cin )#5 or2( g_105_cin, w0g_105_cin, g_105_42 )#5 end netlist // Gcombine (g_106_cin, g_106_43, g_42_cin, p_106_43 ) and2(w0g_106_cin, p_106_43, g_42_cin )#5 or2( g_106_cin, w0g_106_cin, g_106_43 )#5 end netlist // Gcombine (g_107_cin, g_107_44, g_43_cin, p_107_44 ) and2(w0g_107_cin, p_107_44, g_43_cin )#5 or2( g_107_cin, w0g_107_cin, g_107_44 )#5 end netlist // Gcombine (g_108_cin, g_108_45, g_44_cin, p_108_45 ) and2(w0g_108_cin, p_108_45, g_44_cin )#5 or2( g_108_cin, w0g_108_cin, g_108_45 )#5 end netlist // Gcombine (g_109_cin, g_109_46, g_45_cin, p_109_46 ) and2(w0g_109_cin, p_109_46, g_45_cin )#5 or2( g_109_cin, w0g_109_cin, g_109_46 )#5 end netlist // Gcombine (g_110_cin, g_110_47, g_46_cin, p_110_47 ) and2(w0g_110_cin, p_110_47, g_46_cin )#5 or2( g_110_cin, w0g_110_cin, g_110_47 )#5 end netlist // Gcombine (g_111_cin, g_111_48, g_47_cin, p_111_48 ) and2(w0g_111_cin, p_111_48, g_47_cin )#5 or2( g_111_cin, w0g_111_cin, g_111_48 )#5 end netlist // Gcombine (g_112_cin, g_112_49, g_48_cin, p_112_49 ) and2(w0g_112_cin, p_112_49, g_48_cin )#5 or2( g_112_cin, w0g_112_cin, g_112_49 )#5 end netlist // Gcombine (g_113_cin, g_113_50, g_49_cin, p_113_50 ) and2(w0g_113_cin, p_113_50, g_49_cin )#5 or2( g_113_cin, w0g_113_cin, g_113_50 )#5 end netlist // Gcombine (g_114_cin, g_114_51, g_50_cin, p_114_51 ) and2(w0g_114_cin, p_114_51, g_50_cin )#5 or2( g_114_cin, w0g_114_cin, g_114_51 )#5 end netlist // Gcombine (g_115_cin, g_115_52, g_51_cin, p_115_52 ) and2(w0g_115_cin, p_115_52, g_51_cin )#5 or2( g_115_cin, w0g_115_cin, g_115_52 )#5 end netlist // Gcombine (g_116_cin, g_116_53, g_52_cin, p_116_53 ) and2(w0g_116_cin, p_116_53, g_52_cin )#5 or2( g_116_cin, w0g_116_cin, g_116_53 )#5 end netlist // Gcombine (g_117_cin, g_117_54, g_53_cin, p_117_54 ) and2(w0g_117_cin, p_117_54, g_53_cin )#5 or2( g_117_cin, w0g_117_cin, g_117_54 )#5 end netlist // Gcombine (g_118_cin, g_118_55, g_54_cin, p_118_55 ) and2(w0g_118_cin, p_118_55, g_54_cin )#5 or2( g_118_cin, w0g_118_cin, g_118_55 )#5 end netlist // Gcombine (g_119_cin, g_119_56, g_55_cin, p_119_56 ) and2(w0g_119_cin, p_119_56, g_55_cin )#5 or2( g_119_cin, w0g_119_cin, g_119_56 )#5 end netlist // Gcombine (g_120_cin, g_120_57, g_56_cin, p_120_57 ) and2(w0g_120_cin, p_120_57, g_56_cin )#5 or2( g_120_cin, w0g_120_cin, g_120_57 )#5 end netlist // Gcombine (g_121_cin, g_121_58, g_57_cin, p_121_58 ) and2(w0g_121_cin, p_121_58, g_57_cin )#5 or2( g_121_cin, w0g_121_cin, g_121_58 )#5 end netlist // Gcombine (g_122_cin, g_122_59, g_58_cin, p_122_59 ) and2(w0g_122_cin, p_122_59, g_58_cin )#5 or2( g_122_cin, w0g_122_cin, g_122_59 )#5 end netlist // Gcombine (g_123_cin, g_123_60, g_59_cin, p_123_60 ) and2(w0g_123_cin, p_123_60, g_59_cin )#5 or2( g_123_cin, w0g_123_cin, g_123_60 )#5 end netlist // Gcombine (g_124_cin, g_124_61, g_60_cin, p_124_61 ) and2(w0g_124_cin, p_124_61, g_60_cin )#5 or2( g_124_cin, w0g_124_cin, g_124_61 )#5 end netlist // Gcombine (g_125_cin, g_125_62, g_61_cin, p_125_62 ) and2(w0g_125_cin, p_125_62, g_61_cin )#5 or2( g_125_cin, w0g_125_cin, g_125_62 )#5 end netlist // Gcombine (g_126_cin, g_126_63, g_62_cin, p_126_63 ) and2(w0g_126_cin, p_126_63, g_62_cin )#5 or2( g_126_cin, w0g_126_cin, g_126_63 )#5 end netlist // PGcombine (g_127_0,p_127_0,g_127_64,p_127_64,g_63_0,p_63_0) and2( w0g_127_0, p_127_64, g_63_0 )#5 or2( g_127_0, w0g_127_0, g_127_64 )#5 and2( p_127_0, p_127_64, p_63_0)#5 end netlist // Gcombine (cout, g_127_0, cin, p_127_0 ) and2(w0cout, p_127_0, cin )#5 or2( cout, w0cout, g_127_0 )#5 end netlist xor2( s0, p0,cin )#5 xor2( s1, p1,g_0_cin )#5 xor2( s2, p2,g_1_cin )#5 xor2( s3, p3,g_2_cin )#5 xor2( s4, p4,g_3_cin )#5 xor2( s5, p5,g_4_cin )#5 xor2( s6, p6,g_5_cin )#5 xor2( s7, p7,g_6_cin )#5 xor2( s8, p8,g_7_cin )#5 xor2( s9, p9,g_8_cin )#5 xor2( s10, p10,g_9_cin )#5 xor2( s11, p11,g_10_cin )#5 xor2( s12, p12,g_11_cin )#5 xor2( s13, p13,g_12_cin )#5 xor2( s14, p14,g_13_cin )#5 xor2( s15, p15,g_14_cin )#5 xor2( s16, p16,g_15_cin )#5 xor2( s17, p17,g_16_cin )#5 xor2( s18, p18,g_17_cin )#5 xor2( s19, p19,g_18_cin )#5 xor2( s20, p20,g_19_cin )#5 xor2( s21, p21,g_20_cin )#5 xor2( s22, p22,g_21_cin )#5 xor2( s23, p23,g_22_cin )#5 xor2( s24, p24,g_23_cin )#5 xor2( s25, p25,g_24_cin )#5 xor2( s26, p26,g_25_cin )#5 xor2( s27, p27,g_26_cin )#5 xor2( s28, p28,g_27_cin )#5 xor2( s29, p29,g_28_cin )#5 xor2( s30, p30,g_29_cin )#5 xor2( s31, p31,g_30_cin )#5 xor2( s32, p32,g_31_cin )#5 xor2( s33, p33,g_32_cin )#5 xor2( s34, p34,g_33_cin )#5 xor2( s35, p35,g_34_cin )#5 xor2( s36, p36,g_35_cin )#5 xor2( s37, p37,g_36_cin )#5 xor2( s38, p38,g_37_cin )#5 xor2( s39, p39,g_38_cin )#5 xor2( s40, p40,g_39_cin )#5 xor2( s41, p41,g_40_cin )#5 xor2( s42, p42,g_41_cin )#5 xor2( s43, p43,g_42_cin )#5 xor2( s44, p44,g_43_cin )#5 xor2( s45, p45,g_44_cin )#5 xor2( s46, p46,g_45_cin )#5 xor2( s47, p47,g_46_cin )#5 xor2( s48, p48,g_47_cin )#5 xor2( s49, p49,g_48_cin )#5 xor2( s50, p50,g_49_cin )#5 xor2( s51, p51,g_50_cin )#5 xor2( s52, p52,g_51_cin )#5 xor2( s53, p53,g_52_cin )#5 xor2( s54, p54,g_53_cin )#5 xor2( s55, p55,g_54_cin )#5 xor2( s56, p56,g_55_cin )#5 xor2( s57, p57,g_56_cin )#5 xor2( s58, p58,g_57_cin )#5 xor2( s59, p59,g_58_cin )#5 xor2( s60, p60,g_59_cin )#5 xor2( s61, p61,g_60_cin )#5 xor2( s62, p62,g_61_cin )#5 xor2( s63, p63,g_62_cin )#5 xor2( s64, p64,g_63_cin )#5 xor2( s65, p65,g_64_cin )#5 xor2( s66, p66,g_65_cin )#5 xor2( s67, p67,g_66_cin )#5 xor2( s68, p68,g_67_cin )#5 xor2( s69, p69,g_68_cin )#5 xor2( s70, p70,g_69_cin )#5 xor2( s71, p71,g_70_cin )#5 xor2( s72, p72,g_71_cin )#5 xor2( s73, p73,g_72_cin )#5 xor2( s74, p74,g_73_cin )#5 xor2( s75, p75,g_74_cin )#5 xor2( s76, p76,g_75_cin )#5 xor2( s77, p77,g_76_cin )#5 xor2( s78, p78,g_77_cin )#5 xor2( s79, p79,g_78_cin )#5 xor2( s80, p80,g_79_cin )#5 xor2( s81, p81,g_80_cin )#5 xor2( s82, p82,g_81_cin )#5 xor2( s83, p83,g_82_cin )#5 xor2( s84, p84,g_83_cin )#5 xor2( s85, p85,g_84_cin )#5 xor2( s86, p86,g_85_cin )#5 xor2( s87, p87,g_86_cin )#5 xor2( s88, p88,g_87_cin )#5 xor2( s89, p89,g_88_cin )#5 xor2( s90, p90,g_89_cin )#5 xor2( s91, p91,g_90_cin )#5 xor2( s92, p92,g_91_cin )#5 xor2( s93, p93,g_92_cin )#5 xor2( s94, p94,g_93_cin )#5 xor2( s95, p95,g_94_cin )#5 xor2( s96, p96,g_95_cin )#5 xor2( s97, p97,g_96_cin )#5 xor2( s98, p98,g_97_cin )#5 xor2( s99, p99,g_98_cin )#5 xor2( s100, p100,g_99_cin )#5 xor2( s101, p101,g_100_cin )#5 xor2( s102, p102,g_101_cin )#5 xor2( s103, p103,g_102_cin )#5 xor2( s104, p104,g_103_cin )#5 xor2( s105, p105,g_104_cin )#5 xor2( s106, p106,g_105_cin )#5 xor2( s107, p107,g_106_cin )#5 xor2( s108, p108,g_107_cin )#5 xor2( s109, p109,g_108_cin )#5 xor2( s110, p110,g_109_cin )#5 xor2( s111, p111,g_110_cin )#5 xor2( s112, p112,g_111_cin )#5 xor2( s113, p113,g_112_cin )#5 xor2( s114, p114,g_113_cin )#5 xor2( s115, p115,g_114_cin )#5 xor2( s116, p116,g_115_cin )#5 xor2( s117, p117,g_116_cin )#5 xor2( s118, p118,g_117_cin )#5 xor2( s119, p119,g_118_cin )#5 xor2( s120, p120,g_119_cin )#5 xor2( s121, p121,g_120_cin )#5 xor2( s122, p122,g_121_cin )#5 xor2( s123, p123,g_122_cin )#5 xor2( s124, p124,g_123_cin )#5 xor2( s125, p125,g_124_cin )#5 xor2( s126, p126,g_125_cin )#5 xor2( s127, p127,g_126_cin )#5 end
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/avi/CMakeLists.txt
find_program(WGET wget) find_program(GUNZIP gunzip) function(dlinput base url) add_custom_command(OUTPUT ${base}.gz COMMAND ${WGET} -O ${base}.gz ${url}) endfunction(dlinput) dlinput(10x10_42k.NEU.gz http://iss.ices.utexas.edu/projects/galois/downloads/inputs/avi/10x10_42k.NEU.gz) add_custom_target(more-avi-inputs DEPENDS 10x10_42k.NEU.gz) add_dependencies(more-inputs more-avi-inputs)
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/pta/ex_constraints.txt
11078 13216 0,1,2,0,0 1,3,2264,0,0 2,4,3,0,0 3,5,2275,0,0 4,7,2277,0,0 5,9,2278,0,0 6,11,2279,0,0 7,13,2286,0,0 8,14,2287,0,0 9,15,2289,0,0 10,17,2291,0,0 11,19,2296,0,0 12,21,2297,0,0 13,23,2298,0,0 14,25,2299,0,0 15,27,2300,0,0 16,29,2301,0,0 17,31,2302,0,0 18,33,2308,0,0 19,35,2317,0,0 20,39,2318,0,0 21,43,2329,0,0 22,45,2337,0,0 23,47,2338,0,0 24,49,2339,0,0 25,51,2350,0,0 26,53,2351,0,0 27,55,2352,0,0 28,57,2355,0,0 29,59,2362,0,0 30,61,2363,0,0 31,63,2368,0,0 32,65,2371,0,0 33,67,2377,0,0 34,69,2378,0,0 35,71,2379,0,0 36,73,2380,0,0 37,75,2381,0,0 38,77,2382,0,0 39,79,2388,0,0 40,81,2390,0,0 41,84,2406,0,0 42,86,2407,0,0 43,88,2408,0,0 44,90,2482,0,0 45,91,2483,0,0 46,92,2485,0,0 47,93,2487,0,0 48,94,2489,0,0 49,95,2491,0,0 50,96,2493,0,0 51,97,2495,0,0 52,98,2497,0,0 53,99,2499,0,0 54,100,2501,0,0 55,101,2503,0,0 56,102,2505,0,0 57,103,2507,0,0 58,104,2509,0,0 59,105,2511,0,0 60,106,2513,0,0 61,107,2515,0,0 62,108,2517,0,0 63,109,2519,0,0 64,110,2521,0,0 65,111,2523,0,0 66,112,2525,0,0 67,113,2527,0,0 68,114,2529,0,0 69,115,2531,0,0 70,116,2532,0,0 71,117,2534,0,0 72,118,2536,0,0 73,119,2538,0,0 74,120,2540,0,0 75,121,2542,0,0 76,122,2544,0,0 77,123,2546,0,0 78,124,2548,0,0 79,125,2550,0,0 80,126,2552,0,0 81,127,2554,0,0 82,128,2555,0,0 83,129,2556,0,0 84,130,2558,0,0 85,131,2560,0,0 86,132,2562,0,0 87,133,2564,0,0 88,134,2566,0,0 89,135,2568,0,0 90,136,2570,0,0 91,137,2572,0,0 92,138,2574,0,0 93,139,2576,0,0 94,140,2578,0,0 95,141,2580,0,0 96,142,2582,0,0 97,143,2584,0,0 98,144,2586,0,0 99,145,2588,0,0 100,146,2590,0,0 101,147,2592,0,0 102,148,2594,0,0 103,149,2596,0,0 104,150,2598,0,0 105,151,2600,0,0 106,152,2602,0,0 107,153,2604,0,0 108,154,2606,0,0 109,155,2608,0,0 110,156,2610,0,0 111,157,2612,0,0 112,158,2614,0,0 113,159,2616,0,0 114,160,2618,0,0 115,161,2620,0,0 116,162,2622,0,0 117,163,2624,0,0 118,164,2626,0,0 119,165,2628,0,0 120,166,2630,0,0 121,167,2632,0,0 122,168,2634,0,0 123,169,2636,0,0 124,170,2638,0,0 125,171,2640,0,0 126,172,2642,0,0 127,173,2644,0,0 128,174,2646,0,0 129,175,2648,0,0 130,176,2650,0,0 131,177,2652,0,0 132,178,2654,0,0 133,179,2656,0,0 134,180,2658,0,0 135,181,2660,0,0 136,182,2662,0,0 137,183,2664,0,0 138,184,2666,0,0 139,185,2668,0,0 140,186,2670,0,0 141,187,2672,0,0 142,188,2673,0,0 143,189,2675,0,0 144,190,2677,0,0 145,191,2679,0,0 146,192,2681,0,0 147,193,2683,0,0 148,194,2685,0,0 149,195,2687,0,0 150,196,2689,0,0 151,197,2691,0,0 152,198,2693,0,0 153,199,2696,0,0 154,200,2698,0,0 155,201,2700,0,0 156,202,2702,0,0 157,203,2704,0,0 158,204,2706,0,0 159,205,2707,0,0 160,206,2709,0,0 161,207,2711,0,0 162,208,2713,0,0 163,209,2714,0,0 164,210,2715,0,0 165,211,2717,0,0 166,212,2719,0,0 167,213,2721,0,0 168,214,2723,0,0 169,215,2725,0,0 170,216,2727,0,0 171,217,2729,0,0 172,218,2731,0,0 173,219,2733,0,0 174,220,2735,0,0 175,221,2737,0,0 176,222,2739,0,0 177,223,2741,0,0 178,224,2743,0,0 179,225,2745,0,0 180,226,2746,0,0 181,227,2747,0,0 182,228,2748,0,0 183,229,2750,0,0 184,230,2752,0,0 185,231,2754,0,0 186,232,2756,0,0 187,233,2758,0,0 188,234,2760,0,0 189,235,2762,0,0 190,236,2764,0,0 191,237,2766,0,0 192,238,2768,0,0 193,239,2770,0,0 194,240,2772,0,0 195,241,2774,0,0 196,242,2776,0,0 197,243,2778,0,0 198,244,2780,0,0 199,245,2782,0,0 200,246,2784,0,0 201,247,2786,0,0 202,248,2788,0,0 203,249,2790,0,0 204,250,2792,0,0 205,251,2793,0,0 206,252,2794,0,0 207,258,2845,0,0 208,259,2847,0,0 209,260,2849,0,0 210,261,2851,0,0 211,262,2853,0,0 212,263,2855,0,0 213,264,2857,0,0 214,265,2859,0,0 215,266,2861,0,0 216,267,2863,0,0 217,268,2865,0,0 218,269,2867,0,0 219,270,2869,0,0 220,271,2871,0,0 221,272,2873,0,0 222,273,2875,0,0 223,274,2877,0,0 224,275,2879,0,0 225,276,2881,0,0 226,277,2883,0,0 227,278,2885,0,0 228,279,2887,0,0 229,280,2889,0,0 230,281,2891,0,0 231,282,2893,0,0 232,283,2895,0,0 233,284,2897,0,0 234,285,2899,0,0 235,286,2901,0,0 236,287,2903,0,0 237,288,2905,0,0 238,289,2907,0,0 239,290,2909,0,0 240,291,2911,0,0 241,292,2913,0,0 242,293,2915,0,0 243,294,2917,0,0 244,295,2919,0,0 245,296,2921,0,0 246,297,2923,0,0 247,298,2925,0,0 248,299,2927,0,0 249,300,2929,0,0 250,301,2931,0,0 251,302,2933,0,0 252,303,2935,0,0 253,304,2937,0,0 254,305,2939,0,0 255,306,2941,0,0 256,307,2943,0,0 257,308,2945,0,0 258,309,2947,0,0 259,310,2949,0,0 260,311,2951,0,0 261,312,2953,0,0 262,313,2955,0,0 263,314,2957,0,0 264,315,2959,0,0 265,316,2961,0,0 266,317,2963,0,0 267,318,2965,0,0 268,319,2967,0,0 269,320,2969,0,0 270,321,2971,0,0 271,322,2973,0,0 272,323,2975,0,0 273,324,2977,0,0 274,325,2979,0,0 275,326,2981,0,0 276,327,2983,0,0 277,328,2985,0,0 278,329,2987,0,0 279,330,2988,0,0 280,331,2989,0,0 281,332,2990,0,0 282,333,2991,0,0 283,334,2992,0,0 284,335,2993,0,0 285,336,2994,0,0 286,337,2995,0,0 287,338,2996,0,0 288,339,2997,0,0 289,340,2998,0,0 290,341,2999,0,0 291,342,3000,0,0 292,343,3002,0,0 293,344,3003,0,0 294,345,3009,0,0 295,346,3010,0,0 296,347,3011,0,0 297,348,3012,0,0 298,349,3013,0,0 299,350,3014,0,0 300,351,3015,0,0 301,352,3016,0,0 302,353,3017,0,0 303,354,3018,0,0 304,355,3019,0,0 305,356,3020,0,0 306,357,3023,0,0 307,358,3024,0,0 308,359,3031,0,0 309,360,3032,0,0 310,361,3036,0,0 311,362,3037,0,0 312,363,3040,0,0 313,364,3041,0,0 314,365,3042,0,0 315,366,3043,0,0 316,367,3044,0,0 317,368,3045,0,0 318,369,3046,0,0 319,370,3047,0,0 320,371,3048,0,0 321,372,3049,0,0 322,373,3050,0,0 323,376,3052,0,0 324,377,3053,0,0 325,378,3054,0,0 326,379,3055,0,0 327,380,3056,0,0 328,381,3057,0,0 329,382,3058,0,0 330,383,3059,0,0 331,384,3060,0,0 332,385,3061,0,0 333,388,3063,0,0 334,389,3064,0,0 335,390,3065,0,0 336,391,3066,0,0 337,392,3067,0,0 338,393,3069,0,0 339,394,3072,0,0 340,395,3073,0,0 341,396,3074,0,0 342,397,3075,0,0 343,398,3076,0,0 344,399,3077,0,0 345,400,3078,0,0 346,401,3079,0,0 347,402,3080,0,0 348,403,3081,0,0 349,404,3082,0,0 350,405,3083,0,0 351,406,3084,0,0 352,407,3085,0,0 353,408,3086,0,0 354,409,3087,0,0 355,410,3088,0,0 356,411,3089,0,0 357,412,3090,0,0 358,413,3091,0,0 359,414,3092,0,0 360,415,3093,0,0 361,416,3094,0,0 362,417,3095,0,0 363,421,3098,0,0 364,428,3110,0,0 365,435,3112,0,0 366,442,3115,0,0 367,443,3119,0,0 368,444,3121,0,0 369,445,3122,0,0 370,446,3123,0,0 371,447,3124,0,0 372,448,3125,0,0 373,449,3126,0,0 374,450,3127,0,0 375,451,3128,0,0 376,452,3129,0,0 377,453,3130,0,0 378,454,3132,0,0 379,455,3134,0,0 380,456,3136,0,0 381,461,3145,0,0 382,462,3147,0,0 383,463,3148,0,0 384,464,3149,0,0 385,465,3150,0,0 386,466,3151,0,0 387,467,3152,0,0 388,468,3153,0,0 389,469,3154,0,0 390,470,3155,0,0 391,471,3156,0,0 392,472,3157,0,0 393,473,3158,0,0 394,474,3159,0,0 395,475,3160,0,0 396,476,3161,0,0 397,477,3162,0,0 398,478,3163,0,0 399,479,3164,0,0 400,480,3165,0,0 401,481,3166,0,0 402,482,3167,0,0 403,483,3168,0,0 404,484,3169,0,0 405,485,3170,0,0 406,486,3171,0,0 407,487,3172,0,0 408,488,3173,0,0 409,489,3174,0,0 410,490,3175,0,0 411,491,3176,0,0 412,492,3177,0,0 413,493,3178,0,0 414,494,3179,0,0 415,495,3180,0,0 416,496,3181,0,0 417,497,3182,0,0 418,498,3183,0,0 419,499,3184,0,0 420,500,3185,0,0 421,501,3186,0,0 422,502,3187,0,0 423,503,3188,0,0 424,504,3189,0,0 425,505,3190,0,0 426,506,3191,0,0 427,507,3192,0,0 428,508,3193,0,0 429,509,3194,0,0 430,510,3195,0,0 431,511,3196,0,0 432,512,3197,0,0 433,513,3198,0,0 434,514,3199,0,0 435,515,3200,0,0 436,516,3201,0,0 437,517,3202,0,0 438,518,3203,0,0 439,519,3204,0,0 440,520,3205,0,0 441,521,3206,0,0 442,522,3207,0,0 443,523,3208,0,0 444,524,3209,0,0 445,525,3210,0,0 446,526,3211,0,0 447,527,3212,0,0 448,528,3213,0,0 449,529,3214,0,0 450,530,3215,0,0 451,531,3216,0,0 452,532,3217,0,0 453,533,3218,0,0 454,534,3219,0,0 455,535,3220,0,0 456,536,3221,0,0 457,537,3222,0,0 458,538,3223,0,0 459,539,3224,0,0 460,540,3225,0,0 461,541,3226,0,0 462,542,3227,0,0 463,543,3228,0,0 464,544,3229,0,0 465,545,3230,0,0 466,546,3231,0,0 467,554,3247,0,0 468,562,3248,0,0 469,563,3249,0,0 470,564,3250,0,0 471,565,3251,0,0 472,566,3252,0,0 473,567,3253,0,0 474,568,3254,0,0 475,569,3255,0,0 476,574,3257,0,0 477,579,3259,0,0 478,584,3261,0,0 479,585,3262,0,0 480,586,3264,0,0 481,587,3266,0,0 482,588,3267,0,0 483,589,3268,0,0 484,590,3269,0,0 485,591,3270,0,0 486,592,3272,0,0 487,593,3273,0,0 488,594,3274,0,0 489,595,3275,0,0 490,596,3276,0,0 491,597,3277,0,0 492,598,3278,0,0 493,599,3279,0,0 494,600,3280,0,0 495,601,3281,0,0 496,602,3282,0,0 497,603,3283,0,0 498,606,3288,0,0 499,607,3289,0,0 500,608,3290,0,0 501,609,3292,0,0 502,610,3293,0,0 503,611,3294,0,0 504,612,3295,0,0 505,613,3296,0,0 506,614,3297,0,0 507,615,3298,0,0 508,616,3299,0,0 509,617,3300,0,0 510,618,3301,0,0 511,619,3302,0,0 512,620,3303,0,0 513,621,3304,0,0 514,622,3305,0,0 515,623,3307,0,0 516,624,3308,0,0 517,625,3309,0,0 518,626,3311,0,0 519,627,3312,0,0 520,628,3313,0,0 521,629,3314,0,0 522,630,3315,0,0 523,631,3316,0,0 524,632,3317,0,0 525,633,3318,0,0 526,634,3319,0,0 527,635,3320,0,0 528,636,3321,0,0 529,637,3323,0,0 530,638,3324,0,0 531,639,3325,0,0 532,640,3326,0,0 533,641,3327,0,0 534,642,3328,0,0 535,643,3331,0,0 536,644,3332,0,0 537,645,3333,0,0 538,646,3334,0,0 539,647,3335,0,0 540,648,3336,0,0 541,649,3337,0,0 542,650,3338,0,0 543,651,3340,0,0 544,652,3341,0,0 545,653,3342,0,0 546,654,3343,0,0 547,655,3344,0,0 548,656,3345,0,0 549,657,3346,0,0 550,658,3349,0,0 551,659,3350,0,0 552,660,3351,0,0 553,661,3353,0,0 554,662,3354,0,0 555,663,3356,0,0 556,664,3357,0,0 557,665,3359,0,0 558,666,3361,0,0 559,667,3362,0,0 560,668,3363,0,0 561,669,3364,0,0 562,670,3365,0,0 563,671,3367,0,0 564,672,3369,0,0 565,673,3371,0,0 566,674,3373,0,0 567,675,3375,0,0 568,676,3377,0,0 569,677,3381,0,0 570,678,3383,0,0 571,679,3385,0,0 572,680,3387,0,0 573,681,3389,0,0 574,682,3391,0,0 575,683,3393,0,0 576,684,3395,0,0 577,685,3397,0,0 578,686,3399,0,0 579,687,3401,0,0 580,688,3403,0,0 581,689,3405,0,0 582,690,3407,0,0 583,694,3409,0,0 584,695,3411,0,0 585,696,3413,0,0 586,697,3415,0,0 587,698,3417,0,0 588,699,3419,0,0 589,700,3421,0,0 590,701,3423,0,0 591,702,3425,0,0 592,703,3427,0,0 593,704,3429,0,0 594,705,3431,0,0 595,706,3432,0,0 596,707,3433,0,0 597,708,3434,0,0 598,709,3435,0,0 599,710,3437,0,0 600,711,3439,0,0 601,712,3440,0,0 602,713,3442,0,0 603,714,3444,0,0 604,715,3446,0,0 605,716,3448,0,0 606,717,3450,0,0 607,718,3452,0,0 608,719,3454,0,0 609,720,3456,0,0 610,721,3458,0,0 611,722,3459,0,0 612,723,3461,0,0 613,724,3463,0,0 614,725,3465,0,0 615,726,3466,0,0 616,727,3467,0,0 617,728,3469,0,0 618,729,3470,0,0 619,730,3471,0,0 620,731,3472,0,0 621,732,3474,0,0 622,733,3476,0,0 623,734,3477,0,0 624,735,3480,0,0 625,736,3481,0,0 626,737,3482,0,0 627,738,3483,0,0 628,739,3484,0,0 629,740,3486,0,0 630,741,3488,0,0 631,742,3490,0,0 632,743,3492,0,0 633,744,3494,0,0 634,745,3495,0,0 635,746,3496,0,0 636,747,3497,0,0 637,748,3499,0,0 638,749,3500,0,0 639,750,3501,0,0 640,751,3503,0,0 641,752,3504,0,0 642,753,3506,0,0 643,754,3508,0,0 644,755,3510,0,0 645,756,3512,0,0 646,757,3514,0,0 647,758,3515,0,0 648,759,3516,0,0 649,760,3517,0,0 650,761,3518,0,0 651,762,3519,0,0 652,763,3521,0,0 653,764,3523,0,0 654,765,3525,0,0 655,766,3527,0,0 656,767,3529,0,0 657,768,3531,0,0 658,769,3533,0,0 659,770,3535,0,0 660,771,3537,0,0 661,772,3539,0,0 662,773,3541,0,0 663,774,3543,0,0 664,775,3545,0,0 665,776,3551,0,0 666,777,3553,0,0 667,778,3555,0,0 668,779,3557,0,0 669,780,3559,0,0 670,781,3561,0,0 671,782,3563,0,0 672,783,3565,0,0 673,784,3567,0,0 674,785,3569,0,0 675,786,3571,0,0 676,787,3573,0,0 677,788,3575,0,0 678,789,3577,0,0 679,790,3579,0,0 680,791,3580,0,0 681,792,3582,0,0 682,793,3584,0,0 683,794,3585,0,0 684,795,3587,0,0 685,796,3589,0,0 686,797,3591,0,0 687,798,3593,0,0 688,799,3595,0,0 689,800,3596,0,0 690,801,3598,0,0 691,802,3599,0,0 692,803,3601,0,0 693,804,3602,0,0 694,805,3604,0,0 695,806,3606,0,0 696,807,3607,0,0 697,808,3608,0,0 698,809,3609,0,0 699,810,3610,0,0 700,811,3611,0,0 701,812,3612,0,0 702,813,3613,0,0 703,814,3614,0,0 704,815,3616,0,0 705,816,3617,0,0 706,817,3618,0,0 707,818,3619,0,0 708,819,3621,0,0 709,820,3623,0,0 710,821,3624,0,0 711,822,3625,0,0 712,823,3627,0,0 713,824,3629,0,0 714,828,3630,0,0 715,831,3631,0,0 716,834,3632,0,0 717,835,3633,0,0 718,836,3634,0,0 719,837,3636,0,0 720,838,3638,0,0 721,839,3639,0,0 722,840,3640,0,0 723,843,3641,0,0 724,846,3642,0,0 725,847,3644,0,0 726,848,3645,0,0 727,849,3647,0,0 728,850,3648,0,0 729,851,3650,0,0 730,852,3651,0,0 731,853,3653,0,0 732,854,3655,0,0 733,855,3657,0,0 734,856,3659,0,0 735,857,3661,0,0 736,858,3663,0,0 737,859,3665,0,0 738,860,3667,0,0 739,861,3669,0,0 740,862,3671,0,0 741,863,3673,0,0 742,864,3675,0,0 743,865,3678,0,0 744,866,3680,0,0 745,867,3682,0,0 746,868,3684,0,0 747,869,3686,0,0 748,870,3688,0,0 749,871,3690,0,0 750,872,3692,0,0 751,873,3694,0,0 752,874,3696,0,0 753,875,3698,0,0 754,876,3699,0,0 755,877,3701,0,0 756,878,3703,0,0 757,879,3705,0,0 758,880,3707,0,0 759,881,3709,0,0 760,882,3711,0,0 761,883,3713,0,0 762,884,3715,0,0 763,885,3717,0,0 764,886,3719,0,0 765,887,3721,0,0 766,888,3723,0,0 767,889,3726,0,0 768,890,3728,0,0 769,891,3731,0,0 770,892,3733,0,0 771,893,3735,0,0 772,894,3737,0,0 773,897,3739,0,0 774,898,3741,0,0 775,899,3743,0,0 776,900,3745,0,0 777,901,3747,0,0 778,902,3749,0,0 779,903,3751,0,0 780,904,3753,0,0 781,905,3755,0,0 782,906,3757,0,0 783,907,3759,0,0 784,908,3761,0,0 785,909,3763,0,0 786,910,3765,0,0 787,911,3767,0,0 788,912,3769,0,0 789,913,3771,0,0 790,914,3773,0,0 791,915,3774,0,0 792,916,3775,0,0 793,917,3776,0,0 794,918,3777,0,0 795,919,3778,0,0 796,921,3779,0,0 797,924,3781,0,0 798,925,3783,0,0 799,926,3784,0,0 800,927,3786,0,0 801,928,3788,0,0 802,929,3790,0,0 803,930,3792,0,0 804,931,3794,0,0 805,932,3796,0,0 806,933,3798,0,0 807,934,3800,0,0 808,935,3802,0,0 809,936,3805,0,0 810,937,3806,0,0 811,938,3807,0,0 812,939,3809,0,0 813,940,3810,0,0 814,941,3811,0,0 815,942,3812,0,0 816,943,3813,0,0 817,944,3815,0,0 818,945,3817,0,0 819,946,3819,0,0 820,947,3821,0,0 821,948,3823,0,0 822,949,3825,0,0 823,950,3827,0,0 824,951,3829,0,0 825,952,3830,0,0 826,953,3831,0,0 827,954,3832,0,0 828,955,3834,0,0 829,956,3835,0,0 830,957,3836,0,0 831,958,3837,0,0 832,959,3839,0,0 833,960,3841,0,0 834,961,3843,0,0 835,962,3845,0,0 836,963,3847,0,0 837,964,3849,0,0 838,965,3851,0,0 839,966,3853,0,0 840,967,3855,0,0 841,968,3856,0,0 842,969,3857,0,0 843,970,3858,0,0 844,971,3859,0,0 845,972,3860,0,0 846,973,3861,0,0 847,974,3862,0,0 848,975,3863,0,0 849,976,3864,0,0 850,977,3865,0,0 851,978,3866,0,0 852,979,3867,0,0 853,980,3868,0,0 854,981,3869,0,0 855,982,3871,0,0 856,983,3873,0,0 857,984,3875,0,0 858,985,3876,0,0 859,986,3877,0,0 860,987,3879,0,0 861,988,3881,0,0 862,989,3883,0,0 863,990,3884,0,0 864,991,3885,0,0 865,992,3887,0,0 866,993,3888,0,0 867,994,3889,0,0 868,995,3890,0,0 869,996,3891,0,0 870,997,3893,0,0 871,998,3894,0,0 872,999,3896,0,0 873,1000,3898,0,0 874,1001,3900,0,0 875,1002,3902,0,0 876,1003,3904,0,0 877,1004,3906,0,0 878,1006,3907,0,0 879,1007,3909,0,0 880,1008,3911,0,0 881,1009,3913,0,0 882,1010,3915,0,0 883,1011,3917,0,0 884,1012,3919,0,0 885,1013,3921,0,0 886,1014,3923,0,0 887,1015,3925,0,0 888,1016,3927,0,0 889,1017,3929,0,0 890,1018,3931,0,0 891,1019,3933,0,0 892,1020,3935,0,0 893,1021,3937,0,0 894,1022,3939,0,0 895,1023,3941,0,0 896,1024,3943,0,0 897,1025,3945,0,0 898,1026,3947,0,0 899,1027,3949,0,0 900,1040,3952,0,0 901,2845,2846,1,0 902,2846,252,1,0 903,2847,2848,1,0 904,2848,253,1,0 905,2849,2850,1,0 906,2850,252,1,0 907,2851,2852,1,0 908,2852,253,1,0 909,2853,2854,1,0 910,2854,252,1,0 911,2855,2856,1,0 912,2856,253,1,0 913,2857,2858,1,0 914,2858,252,1,0 915,2859,2860,1,0 916,2860,253,1,0 917,2861,2862,1,0 918,2862,252,1,0 919,2863,2864,1,0 920,2864,253,1,0 921,2780,2781,1,0 922,2781,257,1,0 923,2865,2866,1,0 924,2866,252,1,0 925,2867,2868,1,0 926,2868,253,1,0 927,2869,2870,1,0 928,2870,252,1,0 929,2871,2872,1,0 930,2872,253,1,0 931,2873,2874,1,0 932,2874,252,1,0 933,2578,2579,1,0 934,2579,253,1,0 935,2875,2876,1,0 936,2876,252,1,0 937,2877,2878,1,0 938,2878,253,1,0 939,2879,2880,1,0 940,2880,252,1,0 941,2881,2882,1,0 942,2882,253,1,0 943,2883,2884,1,0 944,2884,252,1,0 945,2885,2886,1,0 946,2886,253,1,0 947,2887,2888,1,0 948,2888,252,1,0 949,2594,2595,1,0 950,2595,252,1,0 951,2889,2890,1,0 952,2890,252,1,0 953,2891,2892,1,0 954,2892,252,1,0 955,2893,2894,1,0 956,2894,252,1,0 957,2895,2896,1,0 958,2896,253,1,0 959,2602,2603,1,0 960,2603,252,1,0 961,2897,2898,1,0 962,2898,253,1,0 963,2604,2605,1,0 964,2605,252,1,0 965,2899,2900,1,0 966,2900,252,1,0 967,2901,2902,1,0 968,2902,253,1,0 969,2903,2904,1,0 970,2904,252,1,0 971,2905,2906,1,0 972,2906,253,1,0 973,2782,2783,1,0 974,2783,257,1,0 975,2907,2908,1,0 976,2908,252,1,0 977,2909,2910,1,0 978,2910,252,1,0 979,2911,2912,1,0 980,2912,253,1,0 981,2913,2914,1,0 982,2914,252,1,0 983,2915,2916,1,0 984,2916,252,1,0 985,2917,2918,1,0 986,2918,252,1,0 987,2919,2920,1,0 988,2920,252,1,0 989,2921,2922,1,0 990,2922,253,1,0 991,2923,2924,1,0 992,2924,252,1,0 993,2925,2926,1,0 994,2926,253,1,0 995,2784,2785,1,0 996,2785,257,1,0 997,2626,2627,1,0 998,2627,252,1,0 999,2927,2928,1,0 1000,2928,253,1,0 1001,2786,2787,1,0 1002,2787,257,1,0 1003,2929,2930,1,0 1004,2930,252,1,0 1005,2931,2932,1,0 1006,2932,253,1,0 1007,2933,2934,1,0 1008,2934,252,1,0 1009,2935,2936,1,0 1010,2936,253,1,0 1011,2937,2938,1,0 1012,2938,252,1,0 1013,2939,2940,1,0 1014,2940,253,1,0 1015,2941,2942,1,0 1016,2942,252,1,0 1017,2943,2944,1,0 1018,2944,253,1,0 1019,2945,2946,1,0 1020,2946,252,1,0 1021,2947,2948,1,0 1022,2948,252,1,0 1023,2949,2950,1,0 1024,2950,253,1,0 1025,2951,2952,1,0 1026,2952,252,1,0 1027,2953,2954,1,0 1028,2954,253,1,0 1029,2955,2956,1,0 1030,2956,252,1,0 1031,2523,2524,1,0 1032,2524,253,1,0 1033,2788,2789,1,0 1034,2789,257,1,0 1035,2957,2958,1,0 1036,2958,252,1,0 1037,2790,2791,1,0 1038,2791,257,1,0 1039,2959,2960,1,0 1040,2960,252,1,0 1041,2961,2962,1,0 1042,2962,252,1,0 1043,2963,2964,1,0 1044,2964,253,1,0 1045,2965,2966,1,0 1046,2966,252,1,0 1047,2967,2968,1,0 1048,2968,253,1,0 1049,2791,257,1,0 1050,2969,2970,1,0 1051,2970,252,1,0 1052,2971,2972,1,0 1053,2972,252,1,0 1054,2973,2974,1,0 1055,2974,253,1,0 1056,2975,2976,1,0 1057,2976,252,1,0 1058,2977,2978,1,0 1059,2978,253,1,0 1060,2979,2980,1,0 1061,2980,252,1,0 1062,2981,2982,1,0 1063,2982,253,1,0 1064,2983,2984,1,0 1065,2984,252,1,0 1066,2985,2986,1,0 1067,2986,253,1,0 1068,27,728,0,0 1069,21,729,0,0 1070,25,730,0,0 1071,3477,3478,1,0 1072,3478,733,1,0 1073,3037,3038,1,0 1074,3038,738,1,0 1075,462,848,0,0 1076,990,848,0,0 1077,464,848,0,0 1078,465,848,0,0 1079,466,848,0,0 1080,467,848,0,0 1081,468,848,0,0 1082,470,848,0,0 1083,469,848,0,0 1084,471,848,0,0 1085,472,848,0,0 1086,474,848,0,0 1087,475,848,0,0 1088,477,848,0,0 1089,478,848,0,0 1090,479,848,0,0 1091,480,848,0,0 1092,481,848,0,0 1093,482,848,0,0 1094,483,848,0,0 1095,484,848,0,0 1096,485,848,0,0 1097,486,848,0,0 1098,487,848,0,0 1099,488,848,0,0 1100,489,848,0,0 1101,490,848,0,0 1102,491,848,0,0 1103,492,848,0,0 1104,493,848,0,0 1105,494,848,0,0 1106,495,848,0,0 1107,496,848,0,0 1108,497,848,0,0 1109,498,848,0,0 1110,499,848,0,0 1111,501,848,0,0 1112,502,848,0,0 1113,504,848,0,0 1114,849,848,0,0 1115,505,848,0,0 1116,506,848,0,0 1117,507,848,0,0 1118,508,848,0,0 1119,509,848,0,0 1120,510,848,0,0 1121,511,848,0,0 1122,512,848,0,0 1123,513,848,0,0 1124,989,848,0,0 1125,515,848,0,0 1126,517,848,0,0 1127,516,848,0,0 1128,463,848,0,0 1129,473,848,0,0 1130,514,848,0,0 1131,476,848,0,0 1132,500,848,0,0 1133,503,848,0,0 1134,518,850,0,0 1135,519,850,0,0 1136,521,850,0,0 1137,522,850,0,0 1138,523,850,0,0 1139,525,850,0,0 1140,526,850,0,0 1141,527,850,0,0 1142,528,850,0,0 1143,529,850,0,0 1144,530,850,0,0 1145,531,850,0,0 1146,532,850,0,0 1147,533,850,0,0 1148,534,850,0,0 1149,535,850,0,0 1150,536,850,0,0 1151,479,851,0,0 1152,480,851,0,0 1153,481,851,0,0 1154,482,851,0,0 1155,483,851,0,0 1156,484,851,0,0 1157,485,851,0,0 1158,486,851,0,0 1159,487,851,0,0 1160,488,851,0,0 1161,3907,3908,1,0 1162,3908,1005,1,0 1163,2489,2490,1,0 1164,2490,1005,1,0 1165,3909,3910,1,0 1166,3910,1005,1,0 1167,3911,3912,1,0 1168,3912,1005,1,0 1169,3913,3914,1,0 1170,3914,1005,1,0 1171,3915,3916,1,0 1172,3916,1005,1,0 1173,3917,3918,1,0 1174,3918,1005,1,0 1175,3919,3920,1,0 1176,3920,1005,1,0 1177,3921,3922,1,0 1178,3922,1005,1,0 1179,3923,3924,1,0 1180,3924,1005,1,0 1181,3925,3926,1,0 1182,3926,1005,1,0 1183,3927,3928,1,0 1184,3928,1005,1,0 1185,3929,3930,1,0 1186,3930,1005,1,0 1187,3931,3932,1,0 1188,3932,1005,1,0 1189,3933,3934,1,0 1190,3934,1005,1,0 1191,3935,3936,1,0 1192,3936,1005,1,0 1193,3937,3938,1,0 1194,3938,1005,1,0 1195,3939,3940,1,0 1196,3940,1005,1,0 1197,3941,3942,1,0 1198,3942,1005,1,0 1199,3943,3944,1,0 1200,3944,1005,1,0 1201,3945,3946,1,0 1202,3946,1005,1,0 1203,3947,3948,1,0 1204,3948,1005,1,0 1205,2483,2484,1,0 1206,2485,2486,1,0 1207,2487,2488,1,0 1208,2491,2492,1,0 1209,2493,2494,1,0 1210,2495,2496,1,0 1211,2497,2498,1,0 1212,2499,2500,1,0 1213,2501,2502,1,0 1214,2503,2504,1,0 1215,2505,2506,1,0 1216,2507,2508,1,0 1217,2509,2510,1,0 1218,2511,2512,1,0 1219,2513,2514,1,0 1220,2515,2516,1,0 1221,2517,2518,1,0 1222,2519,2520,1,0 1223,2521,2522,1,0 1224,2525,2526,1,0 1225,2527,2528,1,0 1226,2529,2530,1,0 1227,2532,2533,1,0 1228,2534,2535,1,0 1229,2536,2537,1,0 1230,2538,2539,1,0 1231,2540,2541,1,0 1232,2542,2543,1,0 1233,2544,2545,1,0 1234,2546,2547,1,0 1235,2548,2549,1,0 1236,2550,2551,1,0 1237,2552,2553,1,0 1238,2556,2557,1,0 1239,2558,2559,1,0 1240,2560,2561,1,0 1241,2562,2563,1,0 1242,2564,2565,1,0 1243,2566,2567,1,0 1244,2568,2569,1,0 1245,2570,2571,1,0 1246,2572,2573,1,0 1247,2574,2575,1,0 1248,2576,2577,1,0 1249,2580,2581,1,0 1250,2582,2583,1,0 1251,2584,2585,1,0 1252,2586,2587,1,0 1253,2588,2589,1,0 1254,2590,2591,1,0 1255,2592,2593,1,0 1256,2596,2597,1,0 1257,2598,2599,1,0 1258,2600,2601,1,0 1259,2606,2607,1,0 1260,2608,2609,1,0 1261,2610,2611,1,0 1262,2612,2613,1,0 1263,2614,2615,1,0 1264,2616,2617,1,0 1265,2618,2619,1,0 1266,2620,2621,1,0 1267,2622,2623,1,0 1268,2624,2625,1,0 1269,2628,2629,1,0 1270,2630,2631,1,0 1271,2632,2633,1,0 1272,2634,2635,1,0 1273,2636,2637,1,0 1274,2638,2639,1,0 1275,2640,2641,1,0 1276,2642,2643,1,0 1277,2644,2645,1,0 1278,2646,2647,1,0 1279,2648,2649,1,0 1280,2650,2651,1,0 1281,2652,2653,1,0 1282,2654,2655,1,0 1283,2656,2657,1,0 1284,2658,2659,1,0 1285,2660,2661,1,0 1286,2662,2663,1,0 1287,2664,2665,1,0 1288,2666,2667,1,0 1289,2668,2669,1,0 1290,2670,2671,1,0 1291,2673,2674,1,0 1292,2675,2676,1,0 1293,2677,2678,1,0 1294,2679,2680,1,0 1295,2681,2682,1,0 1296,2683,2684,1,0 1297,2685,2686,1,0 1298,2687,2688,1,0 1299,2689,2690,1,0 1300,2691,2692,1,0 1301,2693,2694,1,0 1302,2693,2695,1,0 1303,2696,2697,1,0 1304,2698,2699,1,0 1305,2700,2701,1,0 1306,2702,2703,1,0 1307,2704,2705,1,0 1308,2707,2708,1,0 1309,2709,2710,1,0 1310,2711,2712,1,0 1311,2715,2716,1,0 1312,2717,2718,1,0 1313,2719,2720,1,0 1314,2721,2722,1,0 1315,2723,2724,1,0 1316,2725,2726,1,0 1317,2727,2728,1,0 1318,2729,2730,1,0 1319,2731,2732,1,0 1320,2733,2734,1,0 1321,2735,2736,1,0 1322,2737,2738,1,0 1323,2739,2740,1,0 1324,2741,2742,1,0 1325,2743,2744,1,0 1326,2748,2749,1,0 1327,2750,2751,1,0 1328,2752,2753,1,0 1329,2754,2755,1,0 1330,2756,2757,1,0 1331,2758,2759,1,0 1332,2760,2761,1,0 1333,2762,2763,1,0 1334,2764,2765,1,0 1335,2766,2767,1,0 1336,2768,2769,1,0 1337,2770,2771,1,0 1338,2772,2773,1,0 1339,2774,2775,1,0 1340,2776,2777,1,0 1341,2778,2779,1,0 1342,2794,2795,4,4 1343,2794,2796,1,0 1344,2794,2797,4,4 1345,2794,2798,4,4 1346,2794,2799,4,4 1347,2794,2800,4,4 1348,2794,2801,4,4 1349,2794,2802,4,4 1350,2794,2803,4,4 1351,2794,2804,4,4 1352,2794,2805,4,4 1353,2794,2806,4,4 1354,2794,2807,4,5 1355,2794,2808,4,4 1356,2794,2809,4,4 1357,2794,2810,1,0 1358,2794,2811,4,4 1359,2794,2812,4,4 1360,2794,2813,4,4 1361,2794,2814,4,4 1362,2794,2815,4,3 1363,2794,2816,4,4 1364,2794,2817,4,5 1365,2794,2818,4,5 1366,2794,2819,4,4 1367,2794,2820,4,4 1368,2794,2821,4,4 1369,2794,2822,4,4 1370,2794,2823,4,4 1371,2794,2824,4,4 1372,2794,2825,4,4 1373,2794,2826,4,4 1374,2794,2827,4,5 1375,2794,2828,4,4 1376,2794,2829,4,4 1377,2794,2830,1,0 1378,2794,2831,4,5 1379,2794,2832,4,4 1380,2794,2833,4,3 1381,2794,2834,4,4 1382,2794,2835,1,0 1383,2794,2836,4,4 1384,2794,2837,4,4 1385,2794,2838,4,4 1386,2794,2839,1,0 1387,2794,2840,4,4 1388,2794,2841,4,4 1389,2794,2842,4,4 1390,2794,2843,4,4 1391,2794,2844,4,4 1392,3000,3001,1,0 1393,3003,3004,1,0 1394,3003,3005,1,0 1395,3003,3006,1,0 1396,3003,3007,1,0 1397,3003,3008,1,0 1398,3020,3021,1,0 1399,3020,3022,1,0 1400,3024,3025,1,0 1401,3024,3026,1,0 1402,3024,3027,1,0 1403,3024,3028,1,0 1404,3024,3029,1,0 1405,3024,3030,1,0 1406,3032,3033,1,0 1407,3032,3034,1,0 1408,3032,3035,1,0 1409,3037,3039,1,0 1410,3050,3051,1,0 1411,3061,3062,1,0 1412,3067,3068,1,0 1413,3069,3070,1,0 1414,3069,3071,1,0 1415,3095,3096,4,1 1416,3095,3097,4,2 1417,3098,3099,1,0 1418,3098,3100,1,0 1419,3098,3101,1,0 1420,3098,3102,1,0 1421,3098,3103,1,0 1422,3098,3104,4,1 1423,3098,3105,4,2 1424,3098,3106,4,3 1425,3098,3107,4,4 1426,3098,3108,4,5 1427,3098,3109,4,6 1428,3110,3111,1,0 1429,3112,3113,1,0 1430,3112,3114,4,1 1431,3115,3116,1,0 1432,3115,3117,1,0 1433,3115,3118,1,0 1434,3119,3120,1,0 1435,3130,3131,1,0 1436,3132,3133,1,0 1437,3134,3135,1,0 1438,3136,3137,1,0 1439,3136,3138,4,1 1440,3136,3139,4,2 1441,3136,3140,4,3 1442,3136,3141,4,4 1443,3136,3142,4,4 1444,3136,3143,4,4 1445,3136,3144,4,4 1446,3145,3146,1,0 1447,3231,3232,1,0 1448,3231,3233,4,1 1449,3231,3234,4,3 1450,3231,3235,4,5 1451,3231,3236,4,5 1452,3231,3237,4,5 1453,3231,3238,4,5 1454,3231,3239,4,5 1455,3231,3240,4,5 1456,3231,3241,4,5 1457,3231,3242,4,5 1458,3231,3243,4,5 1459,3231,3244,4,5 1460,3231,3245,4,5 1461,3231,3246,4,5 1462,3255,3256,1,0 1463,3257,3258,1,0 1464,3259,3260,1,0 1465,3262,3263,1,0 1466,3264,3265,1,0 1467,3270,3271,1,0 1468,3283,3284,1,0 1469,3283,3285,4,2 1470,3283,3286,1,0 1471,3283,3287,1,0 1472,3290,3291,1,0 1473,3305,3306,1,0 1474,3309,3310,1,0 1475,3321,3322,1,0 1476,3328,3329,1,0 1477,3328,3330,1,0 1478,3338,3339,1,0 1479,3346,3347,1,0 1480,3346,3348,1,0 1481,3351,3352,1,0 1482,3354,3355,1,0 1483,3357,3358,1,0 1484,3359,3360,1,0 1485,3365,3366,1,0 1486,3367,3368,1,0 1487,3369,3370,1,0 1488,3371,3372,1,0 1489,3373,3374,1,0 1490,3375,3376,1,0 1491,3377,3378,1,0 1492,3377,3379,1,0 1493,3377,3380,1,0 1494,3381,3382,1,0 1495,3383,3384,1,0 1496,3385,3386,1,0 1497,3387,3388,1,0 1498,3389,3390,1,0 1499,3391,3392,1,0 1500,3393,3394,1,0 1501,3395,3396,1,0 1502,3397,3398,1,0 1503,3399,3400,1,0 1504,3401,3402,1,0 1505,3403,3404,1,0 1506,3405,3406,1,0 1507,3407,3408,4,1 1508,3409,3410,1,0 1509,3411,3412,1,0 1510,3413,3414,1,0 1511,3415,3416,1,0 1512,3417,3418,1,0 1513,3419,3420,1,0 1514,3421,3422,1,0 1515,3423,3424,1,0 1516,3425,3426,1,0 1517,3427,3428,1,0 1518,3429,3430,1,0 1519,3435,3436,1,0 1520,3437,3438,1,0 1521,3440,3441,1,0 1522,3442,3443,1,0 1523,3444,3445,1,0 1524,3446,3447,1,0 1525,3448,3449,1,0 1526,3450,3451,1,0 1527,3452,3453,1,0 1528,3454,3455,1,0 1529,3456,3457,1,0 1530,3459,3460,1,0 1531,3461,3462,1,0 1532,3463,3464,1,0 1533,3467,3468,1,0 1534,3472,3473,1,0 1535,3474,3475,1,0 1536,3477,3479,1,0 1537,3484,3485,1,0 1538,3486,3487,1,0 1539,3488,3489,1,0 1540,3490,3491,1,0 1541,3492,3493,1,0 1542,3497,3498,1,0 1543,3501,3502,1,0 1544,3504,3505,1,0 1545,3506,3507,1,0 1546,3508,3509,1,0 1547,3510,3511,1,0 1548,3512,3513,1,0 1549,3519,3520,1,0 1550,3521,3522,1,0 1551,3523,3524,1,0 1552,3525,3526,1,0 1553,3527,3528,1,0 1554,3529,3530,1,0 1555,3531,3532,1,0 1556,3533,3534,1,0 1557,3535,3536,1,0 1558,3537,3538,1,0 1559,3539,3540,1,0 1560,3541,3542,1,0 1561,3543,3544,1,0 1562,3545,3546,1,0 1563,3545,3547,1,0 1564,3545,3548,1,0 1565,3545,3549,1,0 1566,3545,3550,1,0 1567,3551,3552,1,0 1568,3553,3554,1,0 1569,3555,3556,1,0 1570,3557,3558,1,0 1571,3559,3560,1,0 1572,3561,3562,1,0 1573,3563,3564,1,0 1574,3565,3566,1,0 1575,3567,3568,1,0 1576,3569,3570,1,0 1577,3571,3572,1,0 1578,3573,3574,1,0 1579,3575,3576,1,0 1580,3577,3578,1,0 1581,3580,3581,1,0 1582,3582,3583,1,0 1583,3585,3586,1,0 1584,3587,3588,1,0 1585,3589,3590,1,0 1586,3591,3592,1,0 1587,3593,3594,1,0 1588,3596,3597,1,0 1589,3599,3600,1,0 1590,3602,3603,1,0 1591,3604,3605,1,0 1592,3614,3615,1,0 1593,3619,3620,1,0 1594,3621,3622,1,0 1595,3625,3626,1,0 1596,3627,3628,1,0 1597,3634,3635,1,0 1598,3636,3637,1,0 1599,3642,3643,1,0 1600,3645,3646,1,0 1601,3648,3649,1,0 1602,3651,3652,1,0 1603,3653,3654,1,0 1604,3655,3656,1,0 1605,3657,3658,1,0 1606,3659,3660,1,0 1607,3661,3662,1,0 1608,3663,3664,1,0 1609,3665,3666,1,0 1610,3667,3668,1,0 1611,3669,3670,1,0 1612,3671,3672,1,0 1613,3673,3674,1,0 1614,3675,3676,1,0 1615,3675,3677,1,0 1616,3678,3679,1,0 1617,3680,3681,1,0 1618,3682,3683,1,0 1619,3684,3685,1,0 1620,3686,3687,1,0 1621,3688,3689,1,0 1622,3690,3691,1,0 1623,3692,3693,1,0 1624,3694,3695,1,0 1625,3696,3697,1,0 1626,3699,3700,1,0 1627,3701,3702,1,0 1628,3703,3704,1,0 1629,3705,3706,1,0 1630,3707,3708,1,0 1631,3709,3710,1,0 1632,3711,3712,1,0 1633,3713,3714,1,0 1634,3715,3716,1,0 1635,3717,3718,1,0 1636,3719,3720,1,0 1637,3721,3722,1,0 1638,3723,3724,1,0 1639,3723,3725,1,0 1640,3726,3727,1,0 1641,3728,3729,1,0 1642,3728,3730,1,0 1643,3731,3732,1,0 1644,3733,3734,1,0 1645,3735,3736,1,0 1646,3737,3738,1,0 1647,3739,3740,1,0 1648,3741,3742,1,0 1649,3743,3744,1,0 1650,3745,3746,1,0 1651,3747,3748,1,0 1652,3749,3750,1,0 1653,3751,3752,1,0 1654,3753,3754,1,0 1655,3755,3756,1,0 1656,3757,3758,1,0 1657,3759,3760,1,0 1658,3761,3762,1,0 1659,3763,3764,1,0 1660,3765,3766,1,0 1661,3767,3768,1,0 1662,3769,3770,1,0 1663,3771,3772,1,0 1664,3779,3780,1,0 1665,3781,3782,1,0 1666,3784,3785,1,0 1667,3786,3787,1,0 1668,3788,3789,1,0 1669,3790,3791,1,0 1670,3792,3793,1,0 1671,3794,3795,1,0 1672,3796,3797,1,0 1673,3798,3799,1,0 1674,3800,3801,1,0 1675,3802,3803,1,0 1676,3802,3804,1,0 1677,3807,3808,1,0 1678,3813,3814,1,0 1679,3815,3816,1,0 1680,3817,3818,1,0 1681,3819,3820,1,0 1682,3821,3822,1,0 1683,3823,3824,1,0 1684,3825,3826,1,0 1685,3827,3828,1,0 1686,3832,3833,1,0 1687,3837,3838,1,0 1688,3839,3840,1,0 1689,3841,3842,1,0 1690,3843,3844,1,0 1691,3845,3846,1,0 1692,3847,3848,1,0 1693,3849,3850,1,0 1694,3851,3852,1,0 1695,3853,3854,1,0 1696,3869,3870,1,0 1697,3871,3872,1,0 1698,3873,3874,1,0 1699,3877,3878,1,0 1700,3879,3880,1,0 1701,3881,3882,1,0 1702,3885,3886,1,0 1703,3891,3892,1,0 1704,3894,3895,1,0 1705,3896,3897,1,0 1706,3898,3899,1,0 1707,3900,3901,1,0 1708,3902,3903,1,0 1709,3904,3905,1,0 1710,3949,3950,4,2 1711,3949,3951,4,9 1712,2482,3953,2,0 1713,3483,3954,2,0 1714,3038,3483,3,0 1715,1052,3955,0,0 1716,3955,3956,4,5 1717,3955,3957,4,3 1718,1072,3958,0,0 1719,2999,3979,2,0 1720,3979,3074,3,0 1721,3979,3078,3,0 1722,3979,3077,3,0 1723,3979,3079,3,0 1724,3979,3075,3,0 1725,3979,3980,1,0 1726,3980,3076,3,0 1727,3032,3981,1,0 1728,2831,3959,2,0 1729,3613,3960,2,0 1730,3960,3961,1,0 1731,3961,3613,3,0 1732,2831,3962,2,0 1733,3962,3963,1,0 1734,3966,3963,1,0 1735,3961,3964,1,0 1736,3965,3964,1,0 1737,3964,3965,1,0 1738,3963,3966,1,0 1739,3958,3968,4,3 1740,3613,3970,2,0 1741,3970,3971,1,0 1742,3615,3982,2,0 1743,3982,3971,3,0 1744,3613,3972,2,0 1745,3973,3974,1,0 1746,3972,3974,1,0 1747,3974,3975,1,0 1748,3975,3976,1,0 1749,3977,3976,1,0 1750,3976,3977,1,0 1751,3613,3978,2,0 1752,3613,3967,2,0 1753,3967,2319,1,0 1754,3974,3973,1,0 1755,1092,3969,0,0 1756,1093,3983,0,0 1757,1097,3984,0,0 1758,1101,3985,0,0 1759,1105,3986,0,0 1760,1109,3987,0,0 1761,1113,3988,0,0 1762,1117,3989,0,0 1763,1121,3990,0,0 1764,1125,3991,0,0 1765,1129,3992,0,0 1766,1133,3993,0,0 1767,1137,3994,0,0 1768,1141,3995,0,0 1769,1145,3996,0,0 1770,1149,3997,0,0 1771,1153,3998,0,0 1772,1157,3999,0,0 1773,1161,4000,0,0 1774,3231,4135,2,0 1775,4135,3247,3,0 1776,3231,4136,2,1 1777,4136,3247,3,1 1778,3231,4137,2,2 1779,4137,3247,3,2 1780,3231,4138,2,3 1781,4138,3247,3,3 1782,3231,4139,2,4 1783,4139,3247,3,4 1784,3231,4140,2,5 1785,4140,3247,3,5 1786,3231,4141,2,6 1787,4141,3247,3,6 1788,3231,4142,2,7 1789,4142,3247,3,7 1790,2264,4001,2,0 1791,4001,4003,1,0 1792,4005,4003,1,0 1793,4002,4003,1,0 1794,4001,4004,1,0 1795,4002,4004,1,0 1796,4003,4005,1,0 1797,4004,4006,1,0 1798,4006,2264,3,0 1799,4006,4007,1,0 1800,4008,4007,1,0 1801,4007,4008,1,0 1802,4006,4009,1,0 1803,4006,4009,1,0 1804,4010,4009,1,0 1805,4009,4010,1,0 1806,2264,4011,2,0 1807,4011,4012,1,0 1808,4013,4012,1,0 1809,4012,4013,1,0 1810,2264,4014,2,0 1811,4014,2482,3,0 1812,3038,3483,3,0 1813,4000,4015,1,0 1814,1,4143,0,0 1815,4143,4015,3,0 1816,4000,4016,4,1 1817,4000,4017,4,2 1818,3999,4018,1,0 1819,4018,4019,2,0 1820,4019,4020,1,0 1821,1,4144,0,0 1822,4144,4020,1,0 1823,4020,3040,3,0 1824,3998,4021,1,0 1825,2337,4021,3,0 1826,3998,4022,4,1 1827,3998,4023,4,2 1828,3996,4024,1,0 1829,4143,4024,3,0 1830,3996,4025,4,1 1831,3996,4026,4,2 1832,3995,4027,1,0 1833,4027,4028,2,0 1834,4028,4029,1,0 1835,4144,4029,1,0 1836,4029,3041,3,0 1837,3994,4030,1,0 1838,4143,4030,3,0 1839,3994,4031,4,1 1840,3994,4032,4,2 1841,3993,4033,1,0 1842,4033,4034,2,0 1843,4034,4035,1,0 1844,4144,4035,1,0 1845,4035,3042,3,0 1846,3992,4036,1,0 1847,4143,4036,3,0 1848,3992,4037,4,1 1849,3992,4038,4,2 1850,3991,4039,1,0 1851,4039,4040,2,0 1852,3990,4041,1,0 1853,4143,4041,3,0 1854,3990,4042,4,1 1855,3990,4043,4,2 1856,3989,4044,1,0 1857,4044,4045,2,0 1858,3988,4046,1,0 1859,2337,4046,3,0 1860,3988,4047,4,1 1861,3988,4048,4,2 1862,1165,4049,0,0 1863,4095,4103,1,0 1864,4090,4103,1,0 1865,4085,4103,1,0 1866,4084,4103,1,0 1867,4084,4103,1,0 1868,2264,4104,1,0 1869,4105,4104,1,0 1870,4105,4104,1,0 1871,4096,4104,1,0 1872,4091,4104,1,0 1873,4086,4104,1,0 1874,4083,4104,1,0 1875,4083,4104,1,0 1876,4104,4105,1,0 1877,4063,4106,1,0 1878,4105,4106,1,0 1879,4105,4106,1,0 1880,4059,4107,1,0 1881,4103,4107,1,0 1882,4103,4107,1,0 1883,1166,4108,0,0 1884,4108,4109,1,0 1885,4109,2999,3,0 1886,4109,4110,1,0 1887,4110,2998,3,0 1888,4120,4121,1,0 1889,4106,4121,1,0 1890,4121,3088,3,0 1891,4121,4122,2,0 1892,4122,3090,3,0 1893,1167,4123,0,0 1894,2508,2354,1,0 1895,4123,4125,1,0 1896,4124,4125,1,0 1897,4107,4125,1,0 1898,4124,4125,1,0 1899,4124,4125,1,0 1900,1168,4126,0,0 1901,4126,3010,3,0 1902,1169,4127,0,0 1903,4125,4128,1,0 1904,4127,4128,1,0 1905,4127,4128,1,0 1906,4127,4128,1,0 1907,4127,4128,1,0 1908,2520,2263,1,0 1909,3010,4131,2,0 1910,3074,4132,2,0 1911,3079,4133,2,0 1912,3076,4134,2,0 1913,4134,3075,3,0 1914,2530,3010,3,0 1915,4131,3013,3,0 1916,2528,3010,3,0 1917,2526,4130,1,0 1918,2524,4130,1,0 1919,4130,3010,3,0 1920,2522,3010,3,0 1921,2520,2292,1,0 1922,3004,4129,1,0 1923,3004,2340,1,0 1924,4127,2341,1,0 1925,2516,2342,1,0 1926,3004,2263,1,0 1927,3004,2292,1,0 1928,1170,4124,0,0 1929,4124,2354,1,0 1930,2787,2340,1,0 1931,4123,2341,1,0 1932,2506,2342,1,0 1933,2496,2319,1,0 1934,4106,4119,2,0 1935,4106,4120,1,0 1936,3140,2340,1,0 1937,4119,2341,1,0 1938,2502,2342,1,0 1939,3986,4111,1,0 1940,4143,4111,3,0 1941,3986,4112,4,1 1942,3986,4113,4,2 1943,3985,4114,1,0 1944,4114,4115,2,0 1945,3984,4116,1,0 1946,2339,4116,3,0 1947,3984,4117,4,1 1948,3984,4118,4,2 1949,4105,4050,2,0 1950,4050,4051,1,0 1951,4051,3094,3,0 1952,2482,4052,2,0 1953,4083,4053,1,0 1954,4105,4053,1,0 1955,4084,4054,1,0 1956,4103,4054,1,0 1957,4053,4055,2,0 1958,4055,4056,1,0 1959,2482,4082,2,0 1960,4080,4083,1,0 1961,4053,4083,1,0 1962,4053,4083,1,0 1963,4053,4083,1,0 1964,4053,4083,1,0 1965,4053,4083,1,0 1966,4053,4083,1,0 1967,4053,4083,1,0 1968,4053,4083,1,0 1969,4070,4083,1,0 1970,4053,4083,1,0 1971,4053,4083,1,0 1972,4073,4083,1,0 1973,4053,4083,1,0 1974,4081,4084,1,0 1975,4054,4084,1,0 1976,4054,4084,1,0 1977,4054,4084,1,0 1978,4054,4084,1,0 1979,4054,4084,1,0 1980,4054,4084,1,0 1981,4054,4084,1,0 1982,4054,4084,1,0 1983,4054,4084,1,0 1984,4054,4084,1,0 1985,4054,4084,1,0 1986,4054,4084,1,0 1987,4054,4084,1,0 1988,4083,4100,2,0 1989,4100,4101,1,0 1990,4100,4102,1,0 1991,4102,4083,3,0 1992,4084,4095,1,0 1993,4083,4096,1,0 1994,4055,4097,1,0 1995,4054,4098,1,0 1996,4053,4099,1,0 1997,4084,4090,1,0 1998,4083,4091,1,0 1999,4055,4092,1,0 2000,4054,4093,1,0 2001,4053,4094,1,0 2002,4084,4085,1,0 2003,4083,4086,1,0 2004,4055,4087,1,0 2005,4054,4088,1,0 2006,4053,4089,1,0 2007,4103,4057,1,0 2008,4055,4058,1,0 2009,4054,4059,1,0 2010,4053,4060,1,0 2011,4058,4061,1,0 2012,4060,4063,1,0 2013,2482,4062,2,0 2014,4055,4064,1,0 2015,4053,4065,1,0 2016,4065,4066,2,0 2017,2482,4067,2,0 2018,4053,4068,2,0 2019,4068,4069,1,0 2020,4053,4070,1,0 2021,4070,4071,2,0 2022,4071,3094,3,0 2023,4069,3094,3,0 2024,4055,4072,1,0 2025,4053,4073,1,0 2026,4073,4074,2,0 2027,3021,2340,1,0 2028,4074,2341,1,0 2029,2492,2342,1,0 2030,2482,4075,2,0 2031,3021,2340,1,0 2032,4055,2341,1,0 2033,2492,2342,1,0 2034,4055,4076,1,0 2035,4053,4077,1,0 2036,4077,4078,2,0 2037,4053,4080,1,0 2038,4077,4080,1,0 2039,4053,4080,1,0 2040,4054,4081,1,0 2041,4078,4081,1,0 2042,4076,4081,1,0 2043,2482,4079,2,0 2044,4003,4002,1,0 2045,3073,4145,2,0 2046,3075,4146,2,0 2047,4146,3073,3,0 2048,4146,3072,3,0 2049,4146,4147,1,0 2050,4145,4147,1,0 2051,3072,4148,2,0 2052,3074,4149,2,0 2053,3079,4150,2,0 2054,3588,2268,1,0 2055,2533,2268,1,0 2056,3075,4151,2,0 2057,2998,4152,2,0 2058,3293,4153,2,0 2059,4153,3330,3,0 2060,1172,1171,0,0 2061,1171,4154,0,0 2062,4154,4155,2,0 2063,3010,4156,2,0 2064,4155,4157,1,0 2065,3073,4158,2,0 2066,4158,3072,3,0 2067,3073,4159,2,0 2068,4159,4160,1,0 2069,4160,3073,3,0 2070,3074,4161,2,0 2071,4161,3073,3,0 2072,3072,4162,2,0 2073,3079,4163,2,0 2074,3588,2268,1,0 2075,3586,2268,1,0 2076,2535,2268,1,0 2077,1171,4164,0,0 2078,4164,4166,2,0 2079,4166,4167,1,0 2080,3010,4165,2,0 2081,3073,4168,2,0 2082,3076,4169,2,0 2083,4169,3072,3,0 2084,3074,4170,2,0 2085,4170,3073,3,0 2086,3079,4171,2,0 2087,4170,3075,3,0 2088,4168,4172,1,0 2089,4170,4172,1,0 2090,3075,4173,2,0 2091,4173,3073,3,0 2092,4173,3072,3,0 2093,4173,4174,1,0 2094,4172,4174,1,0 2095,3072,4175,2,0 2096,3074,4176,2,0 2097,3079,4177,2,0 2098,3588,2268,1,0 2099,2533,2268,1,0 2100,1171,4178,0,0 2101,2265,4179,1,0 2102,4203,4179,1,0 2103,4191,4180,1,0 2104,4204,4180,1,0 2105,4221,4180,1,0 2106,4189,4180,1,0 2107,4220,4180,1,0 2108,4187,4180,1,0 2109,4187,4180,1,0 2110,4198,4180,1,0 2111,4218,4180,1,0 2112,4227,4180,1,0 2113,4178,4181,2,0 2114,4181,4182,1,0 2115,4185,4187,1,0 2116,4186,4187,1,0 2117,4180,4187,1,0 2118,4187,4228,1,0 2119,4231,4232,1,0 2120,4228,4232,1,0 2121,4232,4237,1,0 2122,4232,4237,1,0 2123,4237,2266,1,0 2124,3079,4233,2,0 2125,3079,4235,2,0 2126,2551,2268,1,0 2127,3074,4236,2,0 2128,2553,2268,1,0 2129,3074,4234,2,0 2130,3588,2268,1,0 2131,3075,4229,2,0 2132,4229,4230,1,0 2133,4228,4230,1,0 2134,4230,4231,1,0 2135,3074,4220,2,0 2136,3010,4222,2,0 2137,2547,2268,1,0 2138,3076,4223,2,0 2139,3074,4224,2,0 2140,3032,4225,1,0 2141,4226,4227,1,0 2142,4223,4227,1,0 2143,2549,2268,1,0 2144,4227,4226,1,0 2145,3075,4188,2,0 2146,4188,4189,1,0 2147,4187,4189,1,0 2148,3075,4190,2,0 2149,4190,4191,1,0 2150,4187,4191,1,0 2151,3075,4221,2,0 2152,3074,4192,2,0 2153,3079,4193,2,0 2154,3588,2268,1,0 2155,3110,2314,1,0 2156,3099,4194,1,0 2157,4197,4194,1,0 2158,3111,4195,1,0 2159,4196,4195,1,0 2160,4195,4196,1,0 2161,4194,4197,1,0 2162,3075,4198,2,0 2163,4198,4210,1,0 2164,4217,4210,1,0 2165,4217,4210,1,0 2166,4210,4211,1,0 2167,3074,4212,2,0 2168,2541,2268,1,0 2169,3079,4213,2,0 2170,4216,4217,1,0 2171,4213,4217,1,0 2172,4211,4217,1,0 2173,4214,4217,1,0 2174,4217,2315,1,0 2175,3075,4219,2,0 2176,2545,2268,1,0 2177,4217,4218,1,0 2178,4179,4203,1,0 2179,3030,4203,1,0 2180,4198,4204,1,0 2181,4218,4204,1,0 2182,3514,4205,2,0 2183,3499,4206,2,0 2184,4205,4207,1,0 2185,4207,3499,3,0 2186,4205,4209,1,0 2187,4205,4209,1,0 2188,4209,3514,3,0 2189,3514,4208,2,0 2190,4210,4214,1,0 2191,3079,4215,2,0 2192,2543,2268,1,0 2193,3074,4216,2,0 2194,4198,2315,1,0 2195,3514,4201,2,0 2196,3499,4199,2,0 2197,4201,4200,1,0 2198,4200,3499,3,0 2199,3514,4202,2,0 2200,2539,2268,1,0 2201,3079,4183,2,0 2202,4183,4184,1,0 2203,4180,4184,1,0 2204,4184,4186,1,0 2205,4184,4185,1,0 2206,1173,4238,0,0 2207,1193,4239,0,0 2208,1194,4240,0,0 2209,1195,4241,0,0 2210,1215,4242,0,0 2211,1216,4243,0,0 2212,1217,4244,0,0 2213,1218,4245,0,0 2214,1222,4246,0,0 2215,1226,4247,0,0 2216,1230,4248,0,0 2217,1234,4249,0,0 2218,1242,4250,0,0 2219,1243,4251,0,0 2220,1244,4252,0,0 2221,1245,4253,0,0 2222,1246,4254,0,0 2223,1247,4255,0,0 2224,1248,4256,0,0 2225,1256,4257,0,0 2226,1264,4258,0,0 2227,1272,4259,0,0 2228,1280,4260,0,0 2229,1281,4261,0,0 2230,4260,4262,1,0 2231,4255,4263,1,0 2232,4253,4264,1,0 2233,4252,4265,1,0 2234,4254,4266,1,0 2235,4251,4267,1,0 2236,4240,4268,1,0 2237,4242,4269,1,0 2238,4242,4270,1,0 2239,4238,4271,4,10 2240,4241,4272,4,9 2241,4243,4273,1,0 2242,4243,4274,1,0 2243,4244,4275,1,0 2244,4239,4276,1,0 2245,4239,4277,1,0 2246,4250,4278,1,0 2247,4248,4279,1,0 2248,4248,4280,4,1 2249,4248,4281,4,2 2250,4246,4282,1,0 2251,4246,4283,4,1 2252,4246,4284,4,2 2253,3075,4285,2,0 2254,3079,4286,2,0 2255,4288,4289,1,0 2256,4285,4289,1,0 2257,4286,4289,1,0 2258,3483,4299,2,0 2259,4308,4302,1,0 2260,4307,4302,1,0 2261,4302,3072,3,0 2262,2266,4303,1,0 2263,3075,4304,2,0 2264,4304,4307,1,0 2265,4303,4307,1,0 2266,4307,3073,3,0 2267,3076,4309,2,0 2268,4309,3072,3,0 2269,3074,4310,2,0 2270,4310,3073,3,0 2271,3010,4311,2,0 2272,3072,4312,2,0 2273,3073,4313,2,0 2274,4313,3072,3,0 2275,3010,4314,2,0 2276,2692,2993,3,0 2277,1171,4731,0,0 2278,4731,4732,2,0 2279,4732,4733,1,0 2280,2671,2268,1,0 2281,1,2269,0,0 2282,2490,2272,1,0 2283,3073,4723,2,0 2284,3074,4725,2,0 2285,3079,4726,2,0 2286,3073,4727,2,0 2287,3470,4728,2,0 2288,2,4728,3,2 2289,3074,4729,2,0 2290,3079,4730,2,0 2291,3588,2268,1,0 2292,3470,4724,2,0 2293,2,4724,3,2 2294,3073,4722,2,0 2295,4722,3075,3,0 2296,3074,4695,2,0 2297,3079,4696,2,0 2298,3588,2268,1,0 2299,3073,4697,2,0 2300,3883,4698,2,0 2301,3075,4699,2,0 2302,3074,4700,2,0 2303,2665,2268,1,0 2304,3075,4701,2,0 2305,4701,4702,1,0 2306,4702,3073,3,0 2307,4702,3072,3,0 2308,3072,4703,2,0 2309,3079,4704,2,0 2310,3074,4705,2,0 2311,3588,2268,1,0 2312,3586,2268,1,0 2313,3072,4707,2,0 2314,3073,4708,2,0 2315,3072,4709,2,0 2316,4709,2280,1,0 2317,4708,2281,1,0 2318,3073,4706,2,0 2319,4706,3072,3,0 2320,4699,3073,3,0 2321,4699,3072,3,0 2322,3073,4716,2,0 2323,3197,4718,2,0 2324,4718,2303,1,0 2325,3483,4719,2,0 2326,4258,2356,1,0 2327,2669,2357,1,0 2328,3070,2358,1,0 2329,4258,2359,1,0 2330,3038,3483,3,0 2331,3469,4717,2,0 2332,2300,3469,3,0 2333,3010,4710,2,0 2334,2298,3471,3,0 2335,3072,4405,2,0 2336,3079,4406,2,0 2337,3074,4407,2,0 2338,3588,2268,1,0 2339,3586,2268,1,0 2340,3152,4408,2,0 2341,3073,4411,2,0 2342,3072,4412,2,0 2343,4412,2280,1,0 2344,4411,2281,1,0 2345,3073,4409,2,0 2346,3072,4410,2,0 2347,2635,2993,3,0 2348,2635,2272,1,0 2349,3010,4555,2,0 2350,3098,2314,1,0 2351,3099,4560,1,0 2352,4562,4560,1,0 2353,3113,4561,1,0 2354,4563,4561,1,0 2355,4560,4562,1,0 2356,4561,4563,1,0 2357,3072,4566,2,0 2358,4572,4573,1,0 2359,4566,4573,1,0 2360,3073,4574,2,0 2361,3502,2268,1,0 2362,2321,4575,1,0 2363,3522,2320,1,0 2364,3469,4576,2,0 2365,3470,4577,2,0 2366,2,4577,3,2 2367,3483,4578,2,0 2368,3038,3483,3,0 2369,4573,2309,1,0 2370,4568,4571,1,0 2371,4573,4571,1,0 2372,4573,4571,1,0 2373,4571,4572,1,0 2374,4573,2326,1,0 2375,2308,2273,1,0 2376,4573,2274,1,0 2377,4573,4568,1,0 2378,3073,4569,2,0 2379,4569,4570,1,0 2380,4570,3073,3,0 2381,3499,4567,2,0 2382,3498,2268,1,0 2383,4573,2309,1,0 2384,3073,4564,2,0 2385,3072,4565,2,0 2386,4565,2330,1,0 2387,4564,2331,1,0 2388,3112,2314,1,0 2389,3113,4556,1,0 2390,4558,4556,1,0 2391,3099,4557,1,0 2392,4559,4557,1,0 2393,4556,4558,1,0 2394,4557,4559,1,0 2395,3507,2268,1,0 2396,3509,2268,1,0 2397,4263,2295,1,0 2398,2699,4517,1,0 2399,4518,4517,1,0 2400,4517,4518,1,0 2401,4264,4522,1,0 2402,4524,4522,1,0 2403,3116,4523,1,0 2404,4525,4523,1,0 2405,4522,4524,1,0 2406,4523,4525,1,0 2407,4265,4526,1,0 2408,4528,4526,1,0 2409,3120,4527,1,0 2410,4529,4527,1,0 2411,4526,4528,1,0 2412,4527,4529,1,0 2413,3120,4530,1,0 2414,3120,4530,1,0 2415,4541,4530,1,0 2416,4549,4530,1,0 2417,3116,4531,1,0 2418,3116,4531,1,0 2419,4540,4531,1,0 2420,4550,4531,1,0 2421,4266,2295,1,0 2422,4530,4552,1,0 2423,4530,4552,1,0 2424,4541,4552,1,0 2425,4531,4553,1,0 2426,4531,4553,1,0 2427,4540,4553,1,0 2428,4533,4536,1,0 2429,4265,4536,1,0 2430,4265,4536,1,0 2431,4532,4537,1,0 2432,4530,4537,1,0 2433,4552,4537,1,0 2434,4535,4538,1,0 2435,4264,4538,1,0 2436,4264,4538,1,0 2437,4534,4539,1,0 2438,4531,4539,1,0 2439,3116,4539,1,0 2440,4539,4540,1,0 2441,4537,4541,1,0 2442,4537,4532,1,0 2443,4536,4533,1,0 2444,4539,4534,1,0 2445,4538,4535,1,0 2446,4532,4543,1,0 2447,4530,4543,1,0 2448,4539,4544,1,0 2449,4531,4544,1,0 2450,3511,2268,1,0 2451,4543,4545,1,0 2452,4530,4545,1,0 2453,4544,4546,1,0 2454,4531,4546,1,0 2455,4545,4549,1,0 2456,4548,4549,1,0 2457,4546,4550,1,0 2458,4547,4550,1,0 2459,4254,4551,1,0 2460,4550,4547,1,0 2461,4549,4548,1,0 2462,4553,4554,1,0 2463,4553,4554,1,0 2464,3010,4542,2,0 2465,4266,2295,1,0 2466,3505,2268,1,0 2467,1171,4519,0,0 2468,4519,4520,2,0 2469,4520,4521,1,0 2470,3010,4683,2,0 2471,2661,4684,1,0 2472,2661,4684,1,0 2473,4685,4684,1,0 2474,4684,4685,1,0 2475,1171,4686,0,0 2476,4686,4687,2,0 2477,4687,4688,1,0 2478,4687,4689,1,0 2479,2663,2268,1,0 2480,3010,4690,2,0 2481,4267,2353,1,0 2482,3072,4691,2,0 2483,3073,4692,2,0 2484,4693,4694,1,0 2485,4691,4694,1,0 2486,4690,3010,3,0 2487,4267,3010,3,0 2488,4694,3075,3,0 2489,4694,4693,1,0 2490,3010,4721,2,0 2491,3010,4720,2,0 2492,3073,4712,2,0 2493,3079,4713,2,0 2494,3469,4714,2,0 2495,3470,4715,2,0 2496,2,4715,3,2 2497,3469,4711,2,0 2498,2300,3469,3,0 2499,3010,4402,2,0 2500,2615,2272,1,0 2501,3010,4403,2,0 2502,3010,4404,2,0 2503,2609,2272,1,0 2504,2611,2268,1,0 2505,2615,2272,1,0 2506,2613,2268,1,0 2507,2607,2272,1,0 2508,3010,4319,2,0 2509,2565,2272,1,0 2510,3073,4338,2,0 2511,3079,4339,2,0 2512,3073,4340,2,0 2513,2289,2273,1,0 2514,4340,2274,1,0 2515,3026,2288,1,0 2516,3072,4337,2,0 2517,4337,3081,3,0 2518,2993,4318,2,0 2519,4318,2272,1,0 2520,2561,2272,1,0 2521,3073,4320,2,0 2522,2537,2268,1,0 2523,2563,2272,1,0 2524,3073,4321,2,0 2525,3088,4322,2,0 2526,3090,4323,2,0 2527,4323,4333,1,0 2528,4332,4333,1,0 2529,4322,4334,1,0 2530,4331,4334,1,0 2531,3470,4325,2,0 2532,2,4325,3,2 2533,2710,2304,1,0 2534,4333,2305,1,0 2535,3470,4326,2,0 2536,2,4326,3,2 2537,4333,4329,1,0 2538,4330,4329,1,0 2539,4329,4330,1,0 2540,4327,4331,1,0 2541,4334,4331,1,0 2542,4328,4332,1,0 2543,4330,4332,1,0 2544,4334,4327,1,0 2545,4327,4328,2,0 2546,3470,4324,2,0 2547,2,4324,3,2 2548,3469,4335,2,0 2549,3470,4336,2,0 2550,2,4336,3,2 2551,2537,2268,1,0 2552,3010,4341,2,0 2553,2575,2272,1,0 2554,3072,4349,2,0 2555,3079,4350,2,0 2556,3072,4351,2,0 2557,4351,4352,1,0 2558,2289,2273,1,0 2559,4352,2274,1,0 2560,3026,2288,1,0 2561,2569,2272,1,0 2562,3001,4348,1,0 2563,4347,4348,1,0 2564,4347,4348,1,0 2565,4348,2319,1,0 2566,1289,4347,0,0 2567,2573,2268,1,0 2568,3074,4344,2,0 2569,3079,4345,2,0 2570,2993,4346,2,0 2571,2690,2268,1,0 2572,4346,2269,1,0 2573,3010,4342,2,0 2574,3010,4343,2,0 2575,2571,2272,1,0 2576,2575,2272,1,0 2577,2575,2272,1,0 2578,2567,2272,1,0 2579,2577,2272,1,0 2580,3072,4353,2,0 2581,4353,3083,3,0 2582,4353,3082,3,0 2583,3010,4354,2,0 2584,2579,4355,1,0 2585,2581,4355,1,0 2586,4355,2272,1,0 2587,3073,4359,2,0 2588,3079,4360,2,0 2589,4360,3073,3,0 2590,2537,2268,1,0 2591,3074,4356,2,0 2592,3079,4357,2,0 2593,2993,4358,2,0 2594,2690,2268,1,0 2595,4358,2269,1,0 2596,2583,2272,1,0 2597,3073,4361,2,0 2598,3469,4362,2,0 2599,3470,4363,2,0 2600,2,4363,3,2 2601,2537,2268,1,0 2602,2585,2272,1,0 2603,2587,2272,1,0 2604,3072,4364,2,0 2605,3079,4365,2,0 2606,3074,4366,2,0 2607,3588,2268,1,0 2608,3586,2268,1,0 2609,3073,4368,2,0 2610,3079,4369,2,0 2611,3073,4370,2,0 2612,4370,4371,1,0 2613,2289,2273,1,0 2614,4371,2274,1,0 2615,3075,4372,2,0 2616,3079,4373,2,0 2617,3074,4374,2,0 2618,3076,4375,2,0 2619,4375,3075,3,0 2620,3026,2288,1,0 2621,3072,4367,2,0 2622,4367,3081,3,0 2623,2589,2272,1,0 2624,3072,4376,2,0 2625,3079,4377,2,0 2626,3074,4378,2,0 2627,3588,2268,1,0 2628,3586,2268,1,0 2629,3073,4379,2,0 2630,3074,4380,2,0 2631,4379,4381,1,0 2632,4381,3073,3,0 2633,3010,4382,2,0 2634,1171,4384,0,0 2635,4384,4385,2,0 2636,4385,4386,1,0 2637,2593,2268,1,0 2638,3072,4387,2,0 2639,3079,4388,2,0 2640,3074,4389,2,0 2641,3588,2268,1,0 2642,3586,2268,1,0 2643,3073,4390,2,0 2644,3032,4391,1,0 2645,2993,4383,2,0 2646,2591,2270,1,0 2647,4383,2271,1,0 2648,2595,2272,1,0 2649,2296,3470,3,0 2650,3010,4392,2,0 2651,3010,4393,2,0 2652,3010,4394,2,0 2653,2597,2272,1,0 2654,3073,4395,2,0 2655,2537,2268,1,0 2656,2599,2272,1,0 2657,2601,2272,1,0 2658,3010,4396,2,0 2659,2603,2272,1,0 2660,2528,2272,1,0 2661,3073,4397,2,0 2662,3079,4433,2,0 2663,4433,3073,3,0 2664,3732,2268,1,0 2665,3734,2268,1,0 2666,2831,4434,2,0 2667,3736,2268,1,0 2668,3074,4435,2,0 2669,3079,4436,2,0 2670,3095,2290,1,0 2671,3097,3088,3,0 2672,3097,4401,2,0 2673,4401,3090,3,0 2674,3074,4398,2,0 2675,3079,4399,2,0 2676,2993,4400,2,0 2677,2690,2268,1,0 2678,4400,2269,1,0 2679,2537,2268,1,0 2680,2605,2272,1,0 2681,2617,2272,1,0 2682,3073,4413,2,0 2683,3483,4418,2,0 2684,4257,4419,1,0 2685,3247,4734,2,0 2686,4734,4419,3,0 2687,3247,4735,2,1 2688,4735,4419,3,1 2689,3247,4736,2,2 2690,4736,4419,3,2 2691,3247,4737,2,3 2692,4737,4419,3,3 2693,3247,4738,2,4 2694,4738,4419,3,4 2695,3247,4739,2,5 2696,4739,4419,3,5 2697,3247,4740,2,6 2698,4740,4419,3,6 2699,3247,4741,2,7 2700,4741,4419,3,7 2701,4256,4420,1,0 2702,3231,4742,2,0 2703,4742,4420,3,0 2704,3231,4743,2,1 2705,4743,4420,3,1 2706,3231,4744,2,2 2707,4744,4420,3,2 2708,3231,4745,2,3 2709,4745,4420,3,3 2710,3231,4746,2,4 2711,4746,4420,3,4 2712,3231,4747,2,5 2713,4747,4420,3,5 2714,3231,4748,2,6 2715,4748,4420,3,6 2716,3231,4749,2,7 2717,4749,4420,3,7 2718,4419,4750,2,0 2719,4750,3231,3,0 2720,4419,4751,2,1 2721,4751,3231,3,1 2722,4419,4752,2,2 2723,4752,3231,3,2 2724,4419,4753,2,3 2725,4753,3231,3,3 2726,4419,4754,2,4 2727,4754,3231,3,4 2728,4419,4755,2,5 2729,4755,3231,3,5 2730,4419,4756,2,6 2731,4756,3231,3,6 2732,4419,4757,2,7 2733,4757,3231,3,7 2734,4261,4421,1,0 2735,4420,4758,2,0 2736,4758,4421,3,0 2737,4420,4759,2,1 2738,4759,4421,3,1 2739,4420,4760,2,2 2740,4760,4421,3,2 2741,4420,4761,2,3 2742,4761,4421,3,3 2743,4420,4762,2,4 2744,4762,4421,3,4 2745,4420,4763,2,5 2746,4763,4421,3,5 2747,4420,4764,2,6 2748,4764,4421,3,6 2749,4420,4765,2,7 2750,4765,4421,3,7 2751,4261,4422,4,5 2752,4422,4766,2,0 2753,4766,4262,3,0 2754,3038,3483,3,0 2755,2686,2324,1,0 2756,1,2325,0,0 2757,2490,4417,1,0 2758,3597,4417,1,0 2759,2688,2270,1,0 2760,4417,2271,1,0 2761,3074,4414,2,0 2762,3079,4415,2,0 2763,2993,4416,2,0 2764,2690,2268,1,0 2765,4416,2269,1,0 2766,2537,2268,1,0 2767,3010,4423,2,0 2768,3010,4424,2,0 2769,3010,4425,2,0 2770,2623,2272,1,0 2771,3074,4437,2,0 2772,3079,4438,2,0 2773,3010,4439,2,0 2774,3010,4440,2,0 2775,3072,4441,2,0 2776,3079,4442,2,0 2777,3074,4443,2,0 2778,4441,4444,1,0 2779,4444,3075,3,0 2780,2522,2272,1,0 2781,3073,4429,2,0 2782,3074,4430,2,0 2783,3079,4431,2,0 2784,2993,4432,2,0 2785,2690,2268,1,0 2786,4432,2269,1,0 2787,2537,2268,1,0 2788,2619,2272,1,0 2789,3073,4426,2,0 2790,3074,4427,2,0 2791,3079,4428,2,0 2792,2621,2268,1,0 2793,2537,2268,1,0 2794,2623,2272,1,0 2795,3010,4445,2,0 2796,2625,2272,1,0 2797,3073,4446,2,0 2798,3073,4447,2,0 2799,1171,4448,0,0 2800,3546,4463,1,0 2801,4465,4463,1,0 2802,3546,4463,1,0 2803,3010,4464,2,0 2804,4463,4465,1,0 2805,4448,4466,2,0 2806,3010,4467,2,0 2807,4466,4468,1,0 2808,4473,4470,1,0 2809,2796,4470,1,0 2810,2796,4470,1,0 2811,2796,4470,1,0 2812,4470,2316,1,0 2813,4470,4471,1,0 2814,4471,2316,1,0 2815,4470,4472,1,0 2816,4472,2316,1,0 2817,4470,4473,1,0 2818,3483,4512,2,0 2819,3038,3483,3,0 2820,3469,4469,2,0 2821,2300,3469,3,0 2822,3548,4474,1,0 2823,3546,4474,1,0 2824,3546,4474,1,0 2825,3010,4475,2,0 2826,2972,4476,1,0 2827,2972,4476,1,0 2828,4474,4476,1,0 2829,2972,4476,1,0 2830,2796,4477,1,0 2831,4482,4477,1,0 2832,4477,4478,1,0 2833,4478,4479,2,0 2834,4477,4480,4,1 2835,4480,4481,2,0 2836,4477,4482,1,0 2837,4477,4483,1,0 2838,4477,4483,1,0 2839,4482,4483,1,0 2840,4483,4484,1,0 2841,4484,4485,2,0 2842,3560,2270,1,0 2843,4476,2271,1,0 2844,3010,4486,2,0 2845,3010,4487,2,0 2846,4483,2316,1,0 2847,3469,4488,2,0 2848,3470,4489,2,0 2849,2,4489,3,2 2850,4483,4490,4,2 2851,4483,4491,4,4 2852,3010,4493,2,0 2853,4448,4495,2,0 2854,3010,4496,2,0 2855,4495,4497,1,0 2856,3566,2268,1,0 2857,4483,4498,4,4 2858,4502,4503,1,0 2859,3546,4503,1,0 2860,3546,4503,1,0 2861,3010,4499,2,0 2862,3010,4500,2,0 2863,4503,4502,1,0 2864,3010,4501,2,0 2865,3568,2268,1,0 2866,4503,4504,1,0 2867,3546,2354,1,0 2868,3570,2268,1,0 2869,4483,4505,4,5 2870,4505,4506,2,0 2871,4506,4507,1,0 2872,4509,4507,1,0 2873,3546,4508,1,0 2874,4510,4508,1,0 2875,4507,4509,1,0 2876,4508,4510,1,0 2877,4483,4511,4,3 2878,4484,4494,2,0 2879,3564,2270,1,0 2880,4494,2271,1,0 2881,4484,4492,2,0 2882,3562,2270,1,0 2883,4492,2271,1,0 2884,3010,4449,2,0 2885,2796,4451,1,0 2886,2796,4451,1,0 2887,4458,4451,1,0 2888,4451,4452,4,2 2889,4451,2316,1,0 2890,3470,4456,2,0 2891,2,4456,3,2 2892,4458,4457,1,0 2893,4451,4457,1,0 2894,4451,4457,1,0 2895,4451,4457,1,0 2896,4457,4458,1,0 2897,4458,4459,1,0 2898,3469,4460,2,0 2899,3470,4461,2,0 2900,2,4461,3,2 2901,3483,4462,2,0 2902,3038,3483,3,0 2903,4451,4453,4,4 2904,4451,4454,4,3 2905,4451,4455,4,3 2906,3010,4450,2,0 2907,2537,2268,1,0 2908,2537,2268,1,0 2909,2627,2272,1,0 2910,3073,4513,2,0 2911,3197,4514,2,0 2912,4514,2303,1,0 2913,4259,2356,1,0 2914,2629,2357,1,0 2915,4259,2359,1,0 2916,2537,2268,1,0 2917,2631,2272,1,0 2918,3073,4515,2,0 2919,3001,2292,1,0 2920,2537,2268,1,0 2921,2633,2272,1,0 2922,2639,2268,1,0 2923,3010,4516,2,0 2924,2635,2272,1,0 2925,2637,2272,1,0 2926,2524,2272,1,0 2927,1171,4579,0,0 2928,3021,4580,1,0 2929,4582,4580,1,0 2930,3010,4584,2,0 2931,4579,4585,2,0 2932,4585,4586,1,0 2933,3010,4587,2,0 2934,3010,4581,2,0 2935,4580,4582,1,0 2936,3010,4583,2,0 2937,4580,4589,1,0 2938,4589,4590,1,0 2939,4580,4590,1,0 2940,4591,4592,1,0 2941,4590,4592,1,0 2942,4580,4592,1,0 2943,3010,4593,2,0 2944,2728,2268,1,0 2945,3010,4594,2,0 2946,2827,4595,2,0 2947,4269,2340,1,0 2948,4595,2341,1,0 2949,2732,2342,1,0 2950,4600,4644,1,0 2951,4600,4644,1,0 2952,4270,4644,1,0 2953,4601,4644,1,0 2954,2742,2270,1,0 2955,3021,2271,1,0 2956,2740,2268,1,0 2957,4644,4596,1,0 2958,4596,4598,1,0 2959,4597,4598,1,0 2960,4598,4597,1,0 2961,4599,4600,1,0 2962,4600,4601,1,0 2963,4268,3610,3,0 2964,4603,4605,1,0 2965,3026,4605,1,0 2966,4604,4606,1,0 2967,3021,4606,1,0 2968,4606,4607,1,0 2969,4606,4607,1,0 2970,4605,4608,1,0 2971,4605,4608,1,0 2972,1171,4609,0,0 2973,4609,4610,2,0 2974,4610,4611,1,0 2975,4608,4612,1,0 2976,4608,4612,1,0 2977,1171,4613,0,0 2978,4613,4614,2,0 2979,4612,4615,1,0 2980,4617,4615,1,0 2981,4614,4616,1,0 2982,4615,4617,1,0 2983,4620,4618,1,0 2984,4615,4618,1,0 2985,4618,4621,1,0 2986,4628,4621,1,0 2987,2734,2270,1,0 2988,3021,2271,1,0 2989,4624,4625,1,0 2990,4621,4625,1,0 2991,4618,4625,1,0 2992,4623,4626,1,0 2993,4273,4626,1,0 2994,4273,4626,1,0 2995,4626,4622,1,0 2996,4622,4623,1,0 2997,4626,4623,1,0 2998,4625,4624,1,0 2999,4626,4627,1,0 3000,4626,4627,1,0 3001,4626,4627,1,0 3002,4625,4628,1,0 3003,4625,4628,1,0 3004,4625,4628,1,0 3005,3074,4629,2,0 3006,3079,4630,2,0 3007,4275,2340,1,0 3008,4628,2341,1,0 3009,2736,2342,1,0 3010,3094,4633,2,0 3011,3010,4636,2,0 3012,4277,4637,1,0 3013,4277,3010,3,0 3014,4636,3010,3,0 3015,4633,3094,3,0 3016,4275,3010,3,0 3017,4633,4642,1,0 3018,4636,4643,1,0 3019,4638,4643,1,0 3020,4638,4643,1,0 3021,4638,4643,1,0 3022,4638,4643,1,0 3023,4643,3010,3,0 3024,4642,3010,3,0 3025,3074,4634,2,0 3026,3079,4635,2,0 3027,2738,2268,1,0 3028,3010,4638,2,0 3029,4275,3010,3,0 3030,3075,4639,2,0 3031,2998,4640,2,0 3032,3293,4641,2,0 3033,4641,3330,3,0 3034,3075,4631,2,0 3035,3293,4632,2,0 3036,4632,3329,3,0 3037,4614,4619,1,0 3038,4618,4620,1,0 3039,4605,4603,1,0 3040,4606,4604,1,0 3041,3610,4602,2,0 3042,4598,4599,1,0 3043,4580,4588,1,0 3044,4588,4591,1,0 3045,4580,4591,1,0 3046,2730,2268,1,0 3047,2641,2272,1,0 3048,3010,4645,2,0 3049,2647,2272,1,0 3050,3073,4648,2,0 3051,3075,4649,2,0 3052,2998,4650,2,0 3053,3293,4651,2,0 3054,4651,3330,3,0 3055,2537,2268,1,0 3056,2645,2272,1,0 3057,3073,4647,2,0 3058,2537,2268,1,0 3059,2643,2272,1,0 3060,3073,4646,2,0 3061,2537,2268,1,0 3062,2647,2272,1,0 3063,2651,2272,1,0 3064,2649,2272,1,0 3065,3073,4652,2,0 3066,3469,4653,2,0 3067,3470,4654,2,0 3068,2,4654,3,2 3069,2537,2268,1,0 3070,2530,2272,1,0 3071,3152,4658,2,0 3072,3013,4659,2,0 3073,3752,2268,1,0 3074,2363,4279,3,0 3075,3010,4663,2,0 3076,3756,4664,1,0 3077,3756,4664,1,0 3078,4665,4664,1,0 3079,4664,4665,1,0 3080,1171,4667,0,0 3081,4667,4668,2,0 3082,3010,4669,2,0 3083,4668,4670,1,0 3084,4278,2361,1,0 3085,3078,4671,2,0 3086,4671,3077,3,0 3087,3074,4672,2,0 3088,3076,4673,2,0 3089,4673,2330,1,0 3090,4672,2331,1,0 3091,3074,4674,2,0 3092,4674,3078,3,0 3093,2407,3469,3,0 3094,4249,2306,1,0 3095,3013,4675,2,0 3096,3075,4676,2,0 3097,4676,2412,1,0 3098,2333,4678,1,0 3099,4678,4679,1,0 3100,4677,4679,1,0 3101,4679,3294,3,0 3102,3026,3293,3,0 3103,2530,2993,3,0 3104,4249,2360,1,0 3105,2332,4677,1,0 3106,3010,4666,2,0 3107,3075,4662,2,0 3108,4662,3073,3,0 3109,4662,3072,3,0 3110,3193,4660,2,0 3111,3013,4661,2,0 3112,3754,2268,1,0 3113,3746,2324,1,0 3114,3013,4657,2,0 3115,3750,2268,1,0 3116,3883,4655,2,0 3117,3013,4656,2,0 3118,3748,2268,1,0 3119,2653,4680,1,0 3120,2655,4680,1,0 3121,4680,2272,1,0 3122,3010,4682,2,0 3123,3469,4681,2,0 3124,2300,3469,3,0 3125,2657,2272,1,0 3126,2659,2272,1,0 3127,2559,4316,1,0 3128,4317,4316,1,0 3129,4316,4317,1,0 3130,3073,4315,2,0 3131,4315,3075,3,0 3132,4307,4308,1,0 3133,4308,3075,3,0 3134,3072,4305,2,0 3135,3075,4306,2,0 3136,4306,3073,3,0 3137,3010,4300,2,0 3138,3470,4301,2,0 3139,2,4301,3,2 3140,3038,3483,3,0 3141,3074,4290,2,0 3142,4289,4291,1,0 3143,4291,3073,3,0 3144,4291,3072,3,0 3145,3076,4292,2,0 3146,2557,2268,1,0 3147,3073,4293,2,0 3148,3075,4294,2,0 3149,4294,3073,3,0 3150,4294,3072,3,0 3151,4294,4295,1,0 3152,4293,4295,1,0 3153,3072,4296,2,0 3154,3074,4297,2,0 3155,3079,4298,2,0 3156,3588,2268,1,0 3157,2533,2268,1,0 3158,4286,3075,3,0 3159,3074,4287,2,0 3160,3076,4288,2,0 3161,4288,3075,3,0 3162,1171,4767,0,0 3163,4767,4768,2,0 3164,3010,4769,2,0 3165,4768,4770,1,0 3166,3010,4771,2,0 3167,2674,2268,1,0 3168,3010,4772,2,0 3169,3010,4773,2,0 3170,3194,4774,2,0 3171,3192,4775,2,0 3172,3015,4776,2,0 3173,2300,3469,3,0 3174,3483,4781,2,0 3175,3194,4782,2,0 3176,3247,2307,1,0 3177,3470,4784,2,0 3178,2,4784,3,2 3179,3192,4783,2,0 3180,3038,3483,3,0 3181,4777,4778,1,0 3182,4776,4778,1,0 3183,4778,4779,1,0 3184,4779,4780,1,0 3185,4780,3015,3,0 3186,4778,4777,1,0 3187,3010,4787,2,0 3188,3469,4785,2,0 3189,3470,4786,2,0 3190,2,4786,3,2 3191,1290,4788,0,0 3192,4788,4789,1,0 3193,4788,4790,2,0 3194,2268,2322,1,0 3195,4790,2323,1,0 3196,2676,2270,1,0 3197,3001,2271,1,0 3198,2268,2267,1,0 3199,3088,4791,2,0 3200,4791,3087,3,0 3201,3090,4792,2,0 3202,4792,3089,3,0 3203,2321,4793,1,0 3204,2678,2320,1,0 3205,3470,4794,2,0 3206,2,4794,3,2 3207,3469,4795,2,0 3208,3483,4796,2,0 3209,2407,3469,3,0 3210,3038,3483,3,0 3211,3010,4797,2,0 3212,3010,4798,2,0 3213,2680,2268,1,0 3214,3089,4799,2,0 3215,3089,4801,2,0 3216,3140,2340,1,0 3217,4801,2341,1,0 3218,2682,2342,1,0 3219,3087,4802,2,0 3220,3089,4805,2,0 3221,4805,4806,1,0 3222,4807,4806,1,0 3223,4806,4807,1,0 3224,4804,4808,1,0 3225,4807,4808,1,0 3226,4808,3089,3,0 3227,4802,4803,1,0 3228,4803,3087,3,0 3229,4803,4804,2,0 3230,3068,4800,1,0 3231,3010,4809,2,0 3232,2993,4811,2,0 3233,2684,2270,1,0 3234,4811,2271,1,0 3235,3010,4810,2,0 3236,1291,4812,0,0 3237,4812,4813,1,0 3238,4812,4814,2,0 3239,3026,4815,1,0 3240,3194,4817,2,0 3241,2321,4820,1,0 3242,3026,2320,1,0 3243,3470,4821,2,0 3244,2296,3470,3,0 3245,4821,3470,3,0 3246,3194,4822,2,0 3247,2270,2267,1,0 3248,3192,4823,2,0 3249,3483,4824,2,0 3250,3038,3483,3,0 3251,3192,4818,2,0 3252,3483,4819,2,0 3253,3038,3483,3,0 3254,3151,4816,2,0 3255,2299,4825,1,0 3256,2298,4825,1,0 3257,2298,4825,1,0 3258,4825,3471,3,0 3259,2297,4826,1,0 3260,2296,4826,1,0 3261,2296,4826,1,0 3262,4826,3470,3,0 3263,2300,3469,3,0 3264,3010,4827,2,0 3265,3010,4828,2,0 3266,2272,2993,3,0 3267,2272,4831,1,0 3268,4830,4831,1,0 3269,2694,4832,1,0 3270,4829,4832,1,0 3271,4832,4829,1,0 3272,4831,4830,1,0 3273,4835,4836,1,0 3274,4831,4836,1,0 3275,4834,4837,1,0 3276,4832,4837,1,0 3277,4837,4839,1,0 3278,4837,4839,1,0 3279,3010,4840,2,0 3280,1171,4841,0,0 3281,4841,4842,2,0 3282,4842,4843,1,0 3283,4839,4850,1,0 3284,4849,4850,1,0 3285,3010,4851,2,0 3286,1171,4852,0,0 3287,4852,4853,2,0 3288,4853,4854,1,0 3289,3010,4848,2,0 3290,4850,4849,1,0 3291,4850,4855,1,0 3292,4850,4855,1,0 3293,4850,4855,1,0 3294,2703,2270,1,0 3295,2694,2271,1,0 3296,4855,4856,1,0 3297,4855,4856,1,0 3298,4839,4856,1,0 3299,4839,4856,1,0 3300,4839,4856,1,0 3301,4839,4856,1,0 3302,2701,2270,1,0 3303,2694,2271,1,0 3304,2697,4844,1,0 3305,4845,4844,1,0 3306,4844,4845,1,0 3307,2699,4846,1,0 3308,4847,4846,1,0 3309,4846,4847,1,0 3310,3010,4838,2,0 3311,3010,4833,2,0 3312,4837,4834,1,0 3313,4836,4835,1,0 3314,3198,4858,2,0 3315,3483,4859,2,0 3316,3038,3483,3,0 3317,2705,2324,1,0 3318,3483,4857,2,0 3319,3038,3483,3,0 3320,3483,4864,2,0 3321,3038,3483,3,0 3322,3290,4860,1,0 3323,4860,4861,2,0 3324,4861,4862,1,0 3325,4863,4862,1,0 3326,4862,4863,1,0 3327,2274,3075,3,0 3328,3077,4866,2,0 3329,2998,4867,2,0 3330,3077,4871,2,0 3331,4871,4872,1,0 3332,4871,4873,1,0 3333,3075,4874,2,0 3334,4874,4875,1,0 3335,4875,3075,3,0 3336,3083,4876,2,0 3337,4876,4877,1,0 3338,4877,3083,3,0 3339,3074,4878,2,0 3340,4878,4879,1,0 3341,4879,3074,3,0 3342,3078,4880,2,0 3343,4880,4881,1,0 3344,4881,3078,3,0 3345,4872,3077,3,0 3346,4873,4884,1,0 3347,4882,4884,1,0 3348,4872,4885,1,0 3349,4883,4885,1,0 3350,4884,4882,1,0 3351,4885,4883,1,0 3352,4875,2326,1,0 3353,2708,2268,1,0 3354,3072,4868,2,0 3355,4868,3082,3,0 3356,3073,4869,2,0 3357,4869,4870,1,0 3358,4870,3083,3,0 3359,2274,4865,1,0 3360,4865,3083,3,0 3361,4865,3082,3,0 3362,1292,4886,0,0 3363,1296,4887,0,0 3364,1300,4888,0,0 3365,1304,4889,0,0 3366,3072,4890,2,0 3367,3079,4891,2,0 3368,3074,4892,2,0 3369,3588,2268,1,0 3370,3586,2268,1,0 3371,3072,4926,2,0 3372,3073,4927,2,0 3373,4927,4928,1,0 3374,3077,4929,2,0 3375,3078,4930,2,0 3376,4930,4931,1,0 3377,4931,3078,3,0 3378,3083,4932,2,0 3379,4932,4933,1,0 3380,4933,3083,3,0 3381,3074,4934,2,0 3382,4934,4935,1,0 3383,4935,3074,3,0 3384,4929,4936,1,0 3385,4936,3077,3,0 3386,4928,4937,1,0 3387,4940,4937,1,0 3388,4926,4938,1,0 3389,4939,4938,1,0 3390,4938,4939,1,0 3391,4937,4940,1,0 3392,3074,4941,2,0 3393,4941,4942,1,0 3394,4926,4942,1,0 3395,4942,3075,3,0 3396,3073,4943,2,0 3397,3072,4944,2,0 3398,4887,4893,1,0 3399,4143,4893,3,0 3400,4887,4894,4,1 3401,4887,4895,4,2 3402,4886,4896,1,0 3403,4896,4897,2,0 3404,4897,4898,1,0 3405,4144,4898,1,0 3406,3072,4899,2,0 3407,3073,4900,2,0 3408,3074,4901,2,0 3409,4900,4902,1,0 3410,3074,4919,2,0 3411,4919,4920,1,0 3412,4920,3074,3,0 3413,4899,4921,1,0 3414,4921,3081,3,0 3415,4920,4922,1,0 3416,4899,4922,1,0 3417,4922,3075,3,0 3418,4889,4923,1,0 3419,4898,4923,3,0 3420,4889,4924,4,1 3421,4889,4925,4,2 3422,4905,4903,1,0 3423,4902,4903,1,0 3424,4906,4904,1,0 3425,4899,4904,1,0 3426,4903,4905,1,0 3427,4904,4906,1,0 3428,3074,4907,2,0 3429,4907,4908,1,0 3430,4908,4909,1,0 3431,4911,4909,1,0 3432,4902,4910,1,0 3433,4912,4910,1,0 3434,4909,4911,1,0 3435,4910,4912,1,0 3436,3074,4913,2,0 3437,4913,4914,1,0 3438,4899,4915,1,0 3439,4918,4915,1,0 3440,4914,4916,1,0 3441,4917,4916,1,0 3442,4916,4917,1,0 3443,4915,4918,1,0 3444,3074,4945,2,0 3445,3078,4946,2,0 3446,3077,4947,2,0 3447,4946,4948,1,0 3448,4950,4948,1,0 3449,4945,4949,1,0 3450,4951,4949,1,0 3451,4948,4950,1,0 3452,4949,4951,1,0 3453,3074,4952,2,0 3454,4947,4953,1,0 3455,4953,3077,3,0 3456,4952,3078,3,0 3457,3072,4954,2,0 3458,3004,4968,1,0 3459,4966,4968,1,0 3460,4967,4969,1,0 3461,4954,4969,1,0 3462,3073,4970,2,0 3463,3004,4971,1,0 3464,4974,4971,1,0 3465,3026,4972,1,0 3466,4973,4972,1,0 3467,4972,4973,1,0 3468,4971,4974,1,0 3469,3072,4976,2,0 3470,4976,4977,1,0 3471,4977,3072,3,0 3472,2275,2273,1,0 3473,4977,2274,1,0 3474,3072,4975,2,0 3475,4975,3083,3,0 3476,4975,3082,3,0 3477,3072,4955,2,0 3478,4958,4962,1,0 3479,3026,4962,1,0 3480,4957,4962,1,0 3481,4958,4962,1,0 3482,4958,4962,1,0 3483,4958,4962,1,0 3484,4958,4962,1,0 3485,4958,4962,1,0 3486,4965,4962,1,0 3487,4965,4962,1,0 3488,4961,4963,1,0 3489,4968,4963,1,0 3490,4968,4963,1,0 3491,4968,4963,1,0 3492,4968,4963,1,0 3493,4968,4963,1,0 3494,4968,4963,1,0 3495,4960,4963,1,0 3496,4964,4963,1,0 3497,4964,4963,1,0 3498,4963,4964,1,0 3499,4962,4965,1,0 3500,4963,4966,1,0 3501,4969,4967,1,0 3502,2712,2268,1,0 3503,4956,4957,1,0 3504,3026,4957,1,0 3505,4957,4958,1,0 3506,4968,4959,1,0 3507,4968,4960,1,0 3508,4968,4961,1,0 3509,4957,4956,1,0 3510,3073,4978,2,0 3511,3072,4979,2,0 3512,4983,4984,1,0 3513,4979,4984,1,0 3514,4982,4985,1,0 3515,4978,4985,1,0 3516,4981,4986,1,0 3517,4979,4986,1,0 3518,4985,4987,1,0 3519,2276,4988,1,0 3520,2716,2268,1,0 3521,2276,4989,1,0 3522,4989,3075,3,0 3523,3072,5018,2,0 3524,5018,3082,3,0 3525,3073,5019,2,0 3526,5019,3083,3,0 3527,2276,3081,3,0 3528,2276,5015,1,0 3529,5015,3082,3,0 3530,2276,5016,1,0 3531,5016,3083,3,0 3532,3072,5017,2,0 3533,5017,3081,3,0 3534,4993,4990,1,0 3535,4988,4990,1,0 3536,4992,4991,1,0 3537,4986,4991,1,0 3538,4991,4992,1,0 3539,4990,4993,1,0 3540,4996,4994,1,0 3541,4987,4994,1,0 3542,4997,4995,1,0 3543,4986,4995,1,0 3544,4994,4996,1,0 3545,4995,4997,1,0 3546,5000,4998,1,0 3547,4987,4998,1,0 3548,5001,4999,1,0 3549,4988,4999,1,0 3550,4998,5000,1,0 3551,4999,5001,1,0 3552,2718,2268,1,0 3553,2276,3075,3,0 3554,2276,5002,1,0 3555,4987,5003,1,0 3556,5005,5003,1,0 3557,4986,5004,1,0 3558,5006,5004,1,0 3559,5003,5005,1,0 3560,5004,5006,1,0 3561,5009,5007,1,0 3562,5002,5007,1,0 3563,5010,5008,1,0 3564,4987,5008,1,0 3565,5007,5009,1,0 3566,5008,5010,1,0 3567,5013,5011,1,0 3568,5002,5011,1,0 3569,5014,5012,1,0 3570,4986,5012,1,0 3571,5011,5013,1,0 3572,5012,5014,1,0 3573,4984,4983,1,0 3574,4979,2714,3,0 3575,3074,4980,2,0 3576,4980,4981,1,0 3577,2277,2273,1,0 3578,4980,2274,1,0 3579,3074,4982,2,0 3580,2993,5020,2,0 3581,3073,5021,2,0 3582,3075,5022,2,0 3583,5022,3073,3,0 3584,5022,3072,3,0 3585,5022,5023,1,0 3586,5021,5023,1,0 3587,3072,5024,2,0 3588,3074,5025,2,0 3589,3079,5026,2,0 3590,3588,2268,1,0 3591,2533,2268,1,0 3592,3073,5027,2,0 3593,3075,5028,2,0 3594,3072,5029,2,0 3595,5029,5030,1,0 3596,5030,5032,1,0 3597,5031,5032,1,0 3598,2998,5033,2,0 3599,3072,5035,2,0 3600,3079,5036,2,0 3601,3074,5037,2,0 3602,3588,2268,1,0 3603,3586,2268,1,0 3604,2266,5038,1,0 3605,2993,5039,2,0 3606,2720,2270,1,0 3607,5039,2271,1,0 3608,5038,2276,1,0 3609,3073,5040,2,0 3610,3072,5041,2,0 3611,3293,5034,2,0 3612,5034,3330,3,0 3613,5027,5031,1,0 3614,2714,5042,2,0 3615,3073,5043,2,0 3616,5042,5044,1,0 3617,5044,2714,3,0 3618,2714,5045,2,0 3619,3078,5046,2,0 3620,5045,5047,1,0 3621,5047,2714,3,0 3622,2714,5048,2,0 3623,5048,5049,1,0 3624,5049,2714,3,0 3625,2722,2268,1,0 3626,3078,5050,2,0 3627,3074,5051,2,0 3628,5051,5054,1,0 3629,5054,2714,3,0 3630,3073,5055,2,0 3631,2278,2273,1,0 3632,5055,2274,1,0 3633,3045,5052,2,0 3634,3046,5053,2,0 3635,3293,5056,2,0 3636,3003,5057,1,0 3637,3075,5058,2,0 3638,3004,5059,1,0 3639,3078,5060,2,0 3640,3026,5061,1,0 3641,3078,5062,2,0 3642,5062,2326,1,0 3643,3074,5063,2,0 3644,5063,5064,1,0 3645,5057,2340,1,0 3646,3026,2341,1,0 3647,2724,2342,1,0 3648,3004,5077,1,0 3649,5080,5077,1,0 3650,3026,5078,1,0 3651,5079,5078,1,0 3652,5078,5079,1,0 3653,5077,5080,1,0 3654,3074,5081,2,0 3655,5081,5082,1,0 3656,5082,2326,1,0 3657,3075,5083,2,0 3658,5083,3082,3,0 3659,5083,5084,1,0 3660,5084,3083,3,0 3661,5083,5085,1,0 3662,5085,3081,3,0 3663,3004,5065,1,0 3664,3078,5066,2,0 3665,3046,5067,2,0 3666,3026,5068,1,0 3667,3078,5069,2,0 3668,5069,2326,1,0 3669,3074,5070,2,0 3670,5070,5071,1,0 3671,3045,5072,2,0 3672,5072,5073,1,0 3673,5076,5073,1,0 3674,3026,5074,1,0 3675,5075,5074,1,0 3676,5074,5075,1,0 3677,5073,5076,1,0 3678,3072,5088,2,0 3679,5116,5117,1,0 3680,5088,5117,1,0 3681,3073,5118,2,0 3682,5118,5119,1,0 3683,3072,5120,2,0 3684,5117,3075,3,0 3685,3072,5089,2,0 3686,3026,5090,1,0 3687,5091,5090,1,0 3688,5090,5091,1,0 3689,5117,83,1,0 3690,3075,5100,2,0 3691,3004,5102,1,0 3692,5101,5102,1,0 3693,5103,5104,1,0 3694,5102,5104,1,0 3695,5104,5103,1,0 3696,5095,5105,1,0 3697,3004,5105,1,0 3698,5099,5105,1,0 3699,5104,5105,1,0 3700,2335,5106,1,0 3701,3026,2334,1,0 3702,5105,5107,1,0 3703,5106,5108,1,0 3704,5106,5108,1,0 3705,5111,5108,1,0 3706,5105,5109,1,0 3707,5105,5109,1,0 3708,5110,5109,1,0 3709,5109,5110,1,0 3710,5108,5111,1,0 3711,3004,5112,1,0 3712,5115,5112,1,0 3713,3026,5113,1,0 3714,5114,5113,1,0 3715,5113,5114,1,0 3716,5112,5115,1,0 3717,5117,2326,1,0 3718,5117,5116,1,0 3719,2726,2268,1,0 3720,5102,5101,1,0 3721,5096,5097,1,0 3722,3004,5097,1,0 3723,5098,5099,1,0 3724,5097,5099,1,0 3725,5099,5098,1,0 3726,5097,5096,1,0 3727,3004,5093,1,0 3728,5092,5093,1,0 3729,5094,5095,1,0 3730,5093,5095,1,0 3731,5095,5094,1,0 3732,5093,5092,1,0 3733,3073,5086,2,0 3734,3072,5087,2,0 3735,5087,2330,1,0 3736,5086,2331,1,0 3737,2744,2268,1,0 3738,3073,5121,2,0 3739,3072,5122,2,0 3740,5122,2330,1,0 3741,5121,2331,1,0 3742,3073,5123,2,0 3743,3072,5124,2,0 3744,3074,5125,2,0 3745,3079,5126,2,0 3746,3588,2268,1,0 3747,3010,5127,2,0 3748,1171,5131,0,0 3749,5131,5132,2,0 3750,5132,5133,1,0 3751,3073,5137,2,0 3752,5137,3072,3,0 3753,3075,5138,2,0 3754,3074,5139,2,0 3755,5138,5140,1,0 3756,5140,3073,3,0 3757,5140,3072,3,0 3758,3010,5134,2,0 3759,5131,5135,2,0 3760,5135,5136,1,0 3761,3010,5129,2,0 3762,3010,5128,2,0 3763,3010,5130,2,0 3764,3073,5150,2,0 3765,5150,3072,3,0 3766,5150,5151,1,0 3767,5151,3073,3,0 3768,5151,3075,3,0 3769,5162,5164,1,0 3770,5151,5164,1,0 3771,5155,5164,1,0 3772,5155,5164,1,0 3773,5163,5165,1,0 3774,5150,5165,1,0 3775,5153,5165,1,0 3776,5153,5165,1,0 3777,5154,5166,1,0 3778,5154,5166,1,0 3779,3079,5167,2,0 3780,5168,5169,1,0 3781,5165,5169,1,0 3782,3074,5170,2,0 3783,5170,3073,3,0 3784,5170,5171,1,0 3785,5164,5171,1,0 3786,3075,5172,2,0 3787,5170,3075,3,0 3788,3152,5174,2,0 3789,3073,5175,2,0 3790,3072,5176,2,0 3791,3073,5184,2,0 3792,3072,5185,2,0 3793,5185,2280,1,0 3794,5184,2281,1,0 3795,5166,5177,1,0 3796,3072,5178,2,0 3797,5178,2280,1,0 3798,5177,2281,1,0 3799,3470,5179,2,0 3800,2,5179,3,2 3801,5179,5180,1,0 3802,2,5180,3,2 3803,5166,2280,1,0 3804,5166,2281,1,0 3805,3470,5181,2,0 3806,2,5181,3,2 3807,5181,5182,1,0 3808,2,5182,3,2 3809,5166,5183,1,0 3810,5183,3072,3,0 3811,3470,5173,2,0 3812,2,5173,3,2 3813,3076,5168,2,0 3814,5168,3072,3,0 3815,3073,5141,2,0 3816,3074,5142,2,0 3817,2749,2268,1,0 3818,3073,5143,2,0 3819,3074,5144,2,0 3820,2751,2268,1,0 3821,3073,5145,2,0 3822,5145,5146,1,0 3823,5146,3073,3,0 3824,3074,5147,2,0 3825,2753,2268,1,0 3826,3073,5148,2,0 3827,5148,5149,1,0 3828,5149,3073,3,0 3829,3073,5159,2,0 3830,5159,5160,1,0 3831,5160,3073,3,0 3832,3076,5161,2,0 3833,2755,2268,1,0 3834,3073,5162,2,0 3835,5162,5163,1,0 3836,5163,3072,3,0 3837,5162,3075,3,0 3838,3073,5152,2,0 3839,5152,5153,1,0 3840,5153,3072,3,0 3841,5152,3075,3,0 3842,5152,5154,1,0 3843,5152,5155,1,0 3844,5155,3073,3,0 3845,3075,5156,2,0 3846,2998,5157,2,0 3847,5155,3075,3,0 3848,3293,5158,2,0 3849,5158,3330,3,0 3850,5190,5191,1,0 3851,2280,5191,1,0 3852,3471,5187,2,0 3853,3079,5188,2,0 3854,2,5187,3,2 3855,5191,5190,1,0 3856,5191,3075,3,0 3857,3470,5189,2,0 3858,2,5189,3,2 3859,3469,5186,2,0 3860,2300,3469,3,0 3861,2759,2268,1,0 3862,3081,5206,2,0 3863,3083,5207,2,0 3864,5206,3073,3,0 3865,3082,5208,2,0 3866,5208,5209,1,0 3867,5209,3072,3,0 3868,5208,5210,1,0 3869,5210,3081,3,0 3870,5207,5214,1,0 3871,5210,5214,1,0 3872,5212,5215,1,0 3873,5208,5215,1,0 3874,5214,2276,1,0 3875,5215,3075,3,0 3876,2601,2993,3,0 3877,3073,5216,2,0 3878,3072,5217,2,0 3879,3075,5272,2,0 3880,3079,5273,2,0 3881,3074,5274,2,0 3882,3074,5275,2,0 3883,3076,5276,2,0 3884,5276,3075,3,0 3885,5206,5211,1,0 3886,5211,3072,3,0 3887,5207,3081,3,0 3888,3082,5212,2,0 3889,5206,5213,1,0 3890,5213,3073,3,0 3891,3075,5218,2,0 3892,3074,5219,2,0 3893,3079,5220,2,0 3894,5219,5221,1,0 3895,3082,5224,2,0 3896,5224,5225,1,0 3897,3083,5226,2,0 3898,5219,5222,1,0 3899,3032,5223,1,0 3900,3083,5227,2,0 3901,3082,5228,2,0 3902,3081,5241,2,0 3903,5219,5243,1,0 3904,5228,5244,1,0 3905,5244,3075,3,0 3906,5243,5245,1,0 3907,5219,5245,1,0 3908,5228,5246,1,0 3909,5246,3081,3,0 3910,3081,5247,2,0 3911,5247,5248,1,0 3912,3078,5249,2,0 3913,3074,5250,2,0 3914,5264,5265,1,0 3915,5228,5265,1,0 3916,5248,3075,3,0 3917,5245,5266,1,0 3918,5265,5267,1,0 3919,5228,5267,1,0 3920,5266,5268,1,0 3921,5245,5268,1,0 3922,5267,5269,1,0 3923,5269,3081,3,0 3924,5248,3082,3,0 3925,5247,5270,1,0 3926,5270,3083,3,0 3927,5268,3074,3,0 3928,3084,5271,2,0 3929,5271,3075,3,0 3930,5218,3084,3,0 3931,5228,5264,1,0 3932,5264,3082,3,0 3933,5253,5251,1,0 3934,5221,5251,1,0 3935,5254,5252,1,0 3936,5248,5252,1,0 3937,5251,5253,1,0 3938,5252,5254,1,0 3939,5249,5255,1,0 3940,5255,5256,1,0 3941,5258,5256,1,0 3942,5221,5257,1,0 3943,5259,5257,1,0 3944,5256,5258,1,0 3945,5257,5259,1,0 3946,5262,5260,1,0 3947,5255,5260,1,0 3948,5263,5261,1,0 3949,5248,5261,1,0 3950,5260,5262,1,0 3951,5261,5263,1,0 3952,5241,5242,1,0 3953,5242,3081,3,0 3954,5231,5229,1,0 3955,5227,5229,1,0 3956,5232,5230,1,0 3957,5228,5230,1,0 3958,5229,5231,1,0 3959,5230,5232,1,0 3960,5235,5233,1,0 3961,5221,5233,1,0 3962,5236,5234,1,0 3963,5227,5234,1,0 3964,5233,5235,1,0 3965,5234,5236,1,0 3966,5239,5237,1,0 3967,5221,5237,1,0 3968,5240,5238,1,0 3969,5228,5238,1,0 3970,5237,5239,1,0 3971,5238,5240,1,0 3972,3082,5192,2,0 3973,3083,5193,2,0 3974,3074,5194,2,0 3975,3078,5195,2,0 3976,3078,5198,2,0 3977,3074,5199,2,0 3978,3079,5200,2,0 3979,3076,5201,2,0 3980,5201,5203,1,0 3981,5202,5203,1,0 3982,5205,5204,1,0 3983,5199,5204,1,0 3984,5204,5205,1,0 3985,5203,5202,1,0 3986,2757,2268,1,0 3987,3082,5196,2,0 3988,3083,5197,2,0 3989,2761,2268,1,0 3990,1308,5277,0,0 3991,1309,5278,0,0 3992,1310,5279,0,0 3993,3256,5280,1,0 3994,3258,5280,1,0 3995,5280,5281,1,0 3996,3260,5281,1,0 3997,5279,5295,1,0 3998,5303,5296,1,0 3999,5295,5296,1,0 4000,3010,5297,2,0 4001,3010,5298,2,0 4002,5296,5303,1,0 4003,2765,5300,1,0 4004,5301,5300,1,0 4005,5300,5301,1,0 4006,2767,2268,1,0 4007,5296,5302,1,0 4008,5295,2282,1,0 4009,5281,2285,1,0 4010,5296,5299,1,0 4011,5278,5304,1,0 4012,5309,5305,1,0 4013,5304,5305,1,0 4014,3010,5306,2,0 4015,5305,5309,1,0 4016,3010,5307,2,0 4017,5305,5308,1,0 4018,5279,5310,1,0 4019,3650,5311,1,0 4020,5311,5312,2,0 4021,5312,5313,2,0 4022,5313,5314,1,0 4023,5277,5315,1,0 4024,5277,5316,1,0 4025,5277,5317,1,0 4026,5315,5319,1,0 4027,5295,5319,1,0 4028,5315,5319,1,0 4029,5295,2282,1,0 4030,5304,2283,1,0 4031,5319,2284,1,0 4032,5281,2285,1,0 4033,5295,5318,1,0 4034,2767,2268,1,0 4035,3010,5282,2,0 4036,5281,5293,4,2 4037,5293,5294,2,0 4038,5281,5285,1,0 4039,5285,5286,2,0 4040,5281,5287,4,3 4041,5287,5288,2,0 4042,2710,2304,1,0 4043,5288,2305,1,0 4044,3470,5289,2,0 4045,2,5289,3,2 4046,5285,5290,2,0 4047,2710,2304,1,0 4048,5290,2305,1,0 4049,3470,5291,2,0 4050,2,5291,3,2 4051,5293,5292,2,0 4052,2710,2304,1,0 4053,5292,2305,1,0 4054,3469,5284,2,0 4055,2300,3469,3,0 4056,2763,2268,1,0 4057,3010,5283,2,0 4058,1311,5320,0,0 4059,2282,5321,1,0 4060,2283,5322,1,0 4061,2769,2268,1,0 4062,1171,5323,0,0 4063,5323,5324,2,0 4064,5324,5325,1,0 4065,2771,5326,1,0 4066,2771,5326,1,0 4067,5327,5326,1,0 4068,5326,5327,1,0 4069,2763,2268,1,0 4070,2285,5332,4,2 4071,5332,5333,2,0 4072,2285,5334,1,0 4073,5334,5335,2,0 4074,2775,2268,1,0 4075,2285,5336,4,3 4076,2777,2268,1,0 4077,3266,5337,2,0 4078,3263,3266,3,0 4079,3263,5338,1,0 4080,5337,5338,1,0 4081,5338,5339,1,0 4082,2779,2268,1,0 4083,2285,5354,1,0 4084,3266,5355,2,0 4085,2283,5356,1,0 4086,5359,5356,1,0 4087,5355,5357,1,0 4088,5358,5357,1,0 4089,5357,5358,1,0 4090,5356,5359,1,0 4091,2285,5360,4,2 4092,5355,5360,3,0 4093,5355,5361,1,0 4094,5361,3266,3,0 4095,2285,5368,4,3 4096,2282,5368,3,0 4097,2284,5362,1,0 4098,5365,5362,1,0 4099,5361,5363,1,0 4100,5364,5363,1,0 4101,5363,5364,1,0 4102,5362,5365,1,0 4103,2285,5366,4,3 4104,5361,5366,3,0 4105,5355,5367,1,0 4106,5367,3266,3,0 4107,3266,5340,2,0 4108,2282,5341,1,0 4109,5344,5341,1,0 4110,5340,5342,1,0 4111,5343,5342,1,0 4112,5342,5343,1,0 4113,5341,5344,1,0 4114,2285,5345,1,0 4115,5340,5345,3,0 4116,5340,5346,1,0 4117,5346,3266,3,0 4118,2285,5347,4,1 4119,3267,5348,2,0 4120,3265,3267,3,0 4121,3265,5349,1,0 4122,5348,5349,1,0 4123,5349,5347,3,0 4124,2282,5350,1,0 4125,5353,5350,1,0 4126,5320,2293,1,0 4127,5350,2294,1,0 4128,3267,5351,2,0 4129,5351,5352,1,0 4130,5352,3267,3,0 4131,5350,5353,1,0 4132,2285,5330,1,0 4133,5330,5331,2,0 4134,2773,2268,1,0 4135,2283,5328,1,0 4136,2283,5329,1,0 4137,2769,2268,1,0 4138,3010,5369,2,0 4139,3015,5371,2,0 4140,3483,5373,2,0 4141,3351,5379,1,0 4142,3352,3015,3,0 4143,3351,5375,1,0 4144,3351,5376,1,0 4145,3351,5377,1,0 4146,3352,3015,3,0 4147,3351,5378,1,0 4148,3351,5374,1,0 4149,3038,3483,3,0 4150,5371,5372,1,0 4151,5372,3015,3,0 4152,3010,5380,2,0 4153,2494,5381,1,0 4154,5369,5370,1,0 4155,5370,3010,3,0 4156,3010,5382,2,0 4157,2288,5383,1,0 4158,5384,5383,1,0 4159,5383,5384,1,0 4160,5383,5385,1,0 4161,5388,5385,1,0 4162,2288,5386,1,0 4163,5387,5386,1,0 4164,5386,5387,1,0 4165,5385,5388,1,0 4166,3471,5389,2,0 4167,3010,5402,2,0 4168,3004,5405,1,0 4169,3004,5405,1,0 4170,5403,5405,1,0 4171,3358,2268,1,0 4172,5405,5403,1,0 4173,3010,5404,2,0 4174,5405,5406,1,0 4175,5405,5407,1,0 4176,3026,5412,1,0 4177,3026,5412,1,0 4178,3026,5412,1,0 4179,5411,5412,1,0 4180,5414,5412,1,0 4181,3004,5413,1,0 4182,3004,5413,1,0 4183,3004,5413,1,0 4184,3004,5413,1,0 4185,5415,5413,1,0 4186,5412,5414,1,0 4187,5413,5415,1,0 4188,3004,2288,1,0 4189,3026,5409,1,0 4190,5408,5409,1,0 4191,5410,5411,1,0 4192,5409,5411,1,0 4193,5411,5410,1,0 4194,5409,5408,1,0 4195,3483,5401,2,0 4196,3038,3483,3,0 4197,3010,5399,2,0 4198,3010,5400,2,0 4199,3470,5395,2,0 4200,2,5395,3,2 4201,3470,5396,2,0 4202,2,5396,3,2 4203,3470,5397,2,0 4204,2,5397,3,2 4205,3010,5398,2,0 4206,3075,5393,2,0 4207,5393,5394,1,0 4208,5394,83,1,0 4209,3075,5390,2,0 4210,3079,5391,2,0 4211,3483,5392,2,0 4212,3038,3483,3,0 4213,3010,5416,2,0 4214,3074,5440,2,0 4215,3079,5441,2,0 4216,3075,5442,2,0 4217,3366,2304,1,0 4218,3001,2305,1,0 4219,3483,5439,2,0 4220,3038,3483,3,0 4221,3001,5435,1,0 4222,3001,5435,1,0 4223,5438,5435,1,0 4224,3068,5436,1,0 4225,3068,5436,1,0 4226,5437,5436,1,0 4227,5436,5437,1,0 4228,5435,5438,1,0 4229,3075,5433,2,0 4230,3079,5434,2,0 4231,3001,5429,1,0 4232,3001,5429,1,0 4233,5432,5429,1,0 4234,3140,5430,1,0 4235,3140,5430,1,0 4236,5431,5430,1,0 4237,5430,5431,1,0 4238,5429,5432,1,0 4239,3075,5423,2,0 4240,3079,5424,2,0 4241,3140,5425,1,0 4242,5428,5425,1,0 4243,3068,5426,1,0 4244,5427,5426,1,0 4245,5426,5427,1,0 4246,5425,5428,1,0 4247,3140,5417,1,0 4248,3140,5417,1,0 4249,5420,5417,1,0 4250,3001,5418,1,0 4251,3001,5418,1,0 4252,5419,5418,1,0 4253,5418,5419,1,0 4254,5417,5420,1,0 4255,3075,5421,2,0 4256,3079,5422,2,0 4257,3360,2268,1,0 4258,3010,5443,2,0 4259,3378,5444,1,0 4260,5446,5444,1,0 4261,3010,5445,2,0 4262,5444,5446,1,0 4263,1171,5447,0,0 4264,5447,5448,2,0 4265,3010,5449,2,0 4266,5448,5450,1,0 4267,5444,5455,1,0 4268,5444,5455,1,0 4269,3379,3094,3,0 4270,3384,5456,1,0 4271,5459,5456,1,0 4272,3004,5457,1,0 4273,5458,5457,1,0 4274,5457,5458,1,0 4275,5456,5459,1,0 4276,3008,5460,1,0 4277,5470,5460,1,0 4278,5474,5460,1,0 4279,3010,5461,2,0 4280,5460,5468,1,0 4281,5474,5468,1,0 4282,3388,2268,1,0 4283,5468,5469,1,0 4284,5460,5469,1,0 4285,5469,5470,1,0 4286,5462,5463,1,0 4287,5460,5463,1,0 4288,5460,5463,1,0 4289,5460,5462,1,0 4290,5460,5462,1,0 4291,3390,2268,1,0 4292,5472,5473,1,0 4293,3140,5473,1,0 4294,3068,5473,1,0 4295,3068,5473,1,0 4296,3140,5473,1,0 4297,5471,5474,1,0 4298,5460,5474,1,0 4299,5460,5474,1,0 4300,5460,5474,1,0 4301,5460,5474,1,0 4302,5474,5471,1,0 4303,5473,5472,1,0 4304,3392,2268,1,0 4305,3010,5464,2,0 4306,3386,5465,1,0 4307,3386,5465,1,0 4308,5466,5465,1,0 4309,5465,5466,1,0 4310,3010,5467,2,0 4311,1171,5452,0,0 4312,5452,5453,2,0 4313,5453,5454,1,0 4314,3010,5451,2,0 4315,3382,2268,1,0 4316,1312,5475,0,0 4317,1313,5476,0,0 4318,2290,5477,4,2 4319,2290,5478,4,3 4320,2290,5479,4,1 4321,5483,5484,1,0 4322,3004,5484,1,0 4323,1171,5485,0,0 4324,3008,5486,1,0 4325,5502,5486,1,0 4326,5478,5487,1,0 4327,5503,5487,1,0 4328,5477,5488,1,0 4329,5494,5488,1,0 4330,5485,5489,2,0 4331,5486,5491,1,0 4332,5490,5491,1,0 4333,5489,5492,1,0 4334,5491,5493,1,0 4335,5488,5504,1,0 4336,5487,5488,3,0 4337,5488,5494,1,0 4338,5493,5497,1,0 4339,5496,5497,1,0 4340,5487,5498,1,0 4341,5495,5498,1,0 4342,5498,5501,1,0 4343,5498,5501,1,0 4344,5497,5502,1,0 4345,5497,5502,1,0 4346,5501,5503,1,0 4347,5485,5499,2,0 4348,5499,5500,1,0 4349,5498,5495,1,0 4350,5497,5496,1,0 4351,5491,5490,1,0 4352,5482,5481,1,0 4353,3394,5481,1,0 4354,5481,5482,1,0 4355,5484,5483,1,0 4356,5476,5480,1,0 4357,3396,2268,1,0 4358,5476,5505,1,0 4359,3398,2268,1,0 4360,5476,5507,1,0 4361,2818,5508,2,0 4362,1092,5509,0,0 4363,2818,5510,2,0 4364,5510,2319,1,0 4365,5506,5511,1,0 4366,5507,5511,1,0 4367,5478,5512,1,0 4368,5524,5512,1,0 4369,5477,5513,1,0 4370,5525,5513,1,0 4371,5512,5513,3,0 4372,5512,5514,1,0 4373,5519,5514,1,0 4374,5519,5514,1,0 4375,1171,5516,0,0 4376,5516,5517,2,0 4377,5517,5518,1,0 4378,5514,5519,1,0 4379,3402,2268,1,0 4380,5515,5520,1,0 4381,5514,5520,1,0 4382,5514,5520,1,0 4383,5513,5521,2,0 4384,5522,5524,1,0 4385,5520,5524,1,0 4386,5523,5525,1,0 4387,5513,5525,1,0 4388,3404,2268,1,0 4389,5520,5522,1,0 4390,3402,2268,1,0 4391,5513,5523,1,0 4392,5514,5515,1,0 4393,5476,5506,1,0 4394,3406,2268,1,0 4395,3407,2290,1,0 4396,3410,2268,1,0 4397,3407,5526,4,2 4398,5526,5527,2,0 4399,2502,2268,1,0 4400,5527,5528,1,0 4401,5527,5528,1,0 4402,5531,5528,1,0 4403,3001,5529,1,0 4404,3001,5529,1,0 4405,5530,5529,1,0 4406,5529,5530,1,0 4407,5528,5531,1,0 4408,1314,5532,0,0 4409,1334,5533,0,0 4410,1335,5534,0,0 4411,1092,5535,0,0 4412,3469,5536,2,0 4413,3470,5537,2,0 4414,2,5537,3,2 4415,3470,5538,2,0 4416,2,5538,3,2 4417,1092,5539,0,0 4418,1355,5540,0,0 4419,2710,2268,1,0 4420,5540,2269,1,0 4421,5534,5544,4,3 4422,3072,5559,2,0 4423,5559,5560,1,0 4424,5560,3083,3,0 4425,5560,3082,3,0 4426,3483,5558,2,0 4427,3038,3483,3,0 4428,3424,2268,1,0 4429,5533,5549,1,0 4430,5533,5550,1,0 4431,3426,2268,1,0 4432,5533,5553,1,0 4433,5533,5554,1,0 4434,3428,2268,1,0 4435,5533,5555,1,0 4436,5533,5556,1,0 4437,5533,5557,1,0 4438,3430,2268,1,0 4439,5533,5551,1,0 4440,5533,5552,1,0 4441,3418,2268,1,0 4442,3420,2268,1,0 4443,3422,2268,1,0 4444,5534,5545,1,0 4445,5532,5546,1,0 4446,5534,5547,4,2 4447,5532,5548,4,2 4448,3416,2268,1,0 4449,3414,2268,1,0 4450,3470,5541,2,0 4451,2,5541,3,2 4452,1092,5542,0,0 4453,1356,5543,0,0 4454,2710,2268,1,0 4455,5543,2269,1,0 4456,1357,5561,0,0 4457,1358,5562,0,0 4458,3073,5564,2,0 4459,5564,5565,1,0 4460,3073,5567,2,0 4461,2291,2273,1,0 4462,5567,2274,1,0 4463,3075,5568,2,0 4464,5564,5569,1,0 4465,5568,5570,1,0 4466,5561,5571,1,0 4467,5580,5581,1,0 4468,5565,5581,1,0 4469,5570,5572,1,0 4470,5581,5572,1,0 4471,3026,5573,1,0 4472,5572,5580,1,0 4473,5573,5574,1,0 4474,5573,5575,1,0 4475,5573,5577,1,0 4476,5571,5578,1,0 4477,5571,5579,1,0 4478,5571,3010,3,0 4479,5573,5576,1,0 4480,5562,5566,4,10 4481,3072,5563,2,0 4482,5563,3081,3,0 4483,2490,5582,1,0 4484,3597,5582,1,0 4485,2490,5583,1,0 4486,3597,5583,1,0 4487,3469,5585,2,0 4488,3470,5586,2,0 4489,2,5586,3,2 4490,3483,5587,2,0 4491,3038,3483,3,0 4492,3470,5584,2,0 4493,2,5584,3,2 4494,3094,5588,2,0 4495,3074,5598,2,0 4496,3079,5599,2,0 4497,3076,5601,2,0 4498,2998,5602,2,0 4499,3074,5604,2,0 4500,3079,5605,2,0 4501,3293,5603,2,0 4502,5603,3330,3,0 4503,3076,5600,2,0 4504,5600,3075,3,0 4505,3079,5589,2,0 4506,5589,5590,1,0 4507,3074,5591,2,0 4508,5591,5592,1,0 4509,5590,5592,1,0 4510,3094,5593,2,0 4511,3076,5595,2,0 4512,2998,5596,2,0 4513,3293,5597,2,0 4514,5597,3330,3,0 4515,5592,3075,3,0 4516,3445,5594,1,0 4517,5593,5594,1,0 4518,5594,3010,3,0 4519,1378,5606,0,0 4520,1398,5607,0,0 4521,1418,5608,0,0 4522,3360,2268,1,0 4523,3072,5613,2,0 4524,3073,5614,2,0 4525,3076,5615,2,0 4526,5615,3072,3,0 4527,3074,5616,2,0 4528,5616,3073,3,0 4529,3140,5617,1,0 4530,5620,5617,1,0 4531,3001,5618,1,0 4532,5619,5618,1,0 4533,5618,5619,1,0 4534,5617,5620,1,0 4535,3366,2304,1,0 4536,3001,2305,1,0 4537,5614,5621,1,0 4538,5613,5622,1,0 4539,5608,5627,4,3 4540,3470,5636,2,0 4541,2,5636,3,2 4542,1092,5637,0,0 4543,1438,5638,0,0 4544,2710,2268,1,0 4545,5638,2269,1,0 4546,3451,2270,1,0 4547,3001,2271,1,0 4548,5621,5639,1,0 4549,5621,5639,1,0 4550,5621,5639,1,0 4551,5621,5639,1,0 4552,5621,5639,1,0 4553,5621,5639,1,0 4554,5621,5639,1,0 4555,5621,5639,1,0 4556,5621,5639,1,0 4557,5622,5640,1,0 4558,5622,5640,1,0 4559,5622,5640,1,0 4560,5622,5640,1,0 4561,5622,5640,1,0 4562,5622,5640,1,0 4563,5622,5640,1,0 4564,5622,5640,1,0 4565,5622,5640,1,0 4566,3470,5641,2,0 4567,2,5641,3,2 4568,1092,5642,0,0 4569,1439,5643,0,0 4570,2710,2268,1,0 4571,5643,2269,1,0 4572,5639,5651,1,0 4573,5639,5651,1,0 4574,5639,5651,1,0 4575,5639,5651,1,0 4576,5639,5651,1,0 4577,5640,5652,1,0 4578,5640,5652,1,0 4579,5640,5652,1,0 4580,5640,5652,1,0 4581,5640,5652,1,0 4582,5652,3072,3,0 4583,5651,3073,3,0 4584,3072,5653,2,0 4585,3076,5654,2,0 4586,3073,5655,2,0 4587,3074,5656,2,0 4588,3072,5644,2,0 4589,3076,5645,2,0 4590,3073,5646,2,0 4591,3074,5647,2,0 4592,5608,5632,1,0 4593,5606,5633,1,0 4594,5608,5634,4,2 4595,5606,5635,4,2 4596,5608,5628,1,0 4597,5607,5629,1,0 4598,5608,5630,4,2 4599,5607,5631,4,2 4600,3072,5623,2,0 4601,3076,5624,2,0 4602,3073,5625,2,0 4603,3074,5626,2,0 4604,3453,2268,1,0 4605,3455,2268,1,0 4606,3453,2268,1,0 4607,3010,5609,2,0 4608,3010,5610,2,0 4609,3010,5612,2,0 4610,3010,5611,2,0 4611,3447,2268,1,0 4612,3470,5648,2,0 4613,2,5648,3,2 4614,1092,5649,0,0 4615,1440,5650,0,0 4616,2710,2268,1,0 4617,5650,2269,1,0 4618,3458,5657,2,0 4619,3026,5658,1,0 4620,5665,5658,1,0 4621,5666,5658,1,0 4622,5657,5659,1,0 4623,5664,5659,1,0 4624,5664,5659,1,0 4625,5659,5660,1,0 4626,5658,5661,1,0 4627,5661,5662,1,0 4628,5662,5667,1,0 4629,5666,5667,1,0 4630,5660,5668,1,0 4631,5664,5668,1,0 4632,5667,5669,1,0 4633,5668,3458,3,0 4634,3004,5663,1,0 4635,5659,5663,1,0 4636,5663,5664,1,0 4637,5658,5665,1,0 4638,5658,5666,1,0 4639,3462,2268,1,0 4640,1441,5670,0,0 4641,3072,5671,2,0 4642,3073,5672,2,0 4643,5671,5674,1,0 4644,5671,5674,1,0 4645,5671,5674,1,0 4646,5676,5674,1,0 4647,3004,5675,1,0 4648,3004,5675,1,0 4649,3004,5675,1,0 4650,5682,5675,1,0 4651,5674,5676,1,0 4652,5675,5677,1,0 4653,5680,5677,1,0 4654,3026,5678,1,0 4655,5681,5678,1,0 4656,3004,5679,1,0 4657,5677,5679,1,0 4658,5679,5680,1,0 4659,5678,5681,1,0 4660,5680,5682,1,0 4661,5679,5683,1,0 4662,3073,5684,2,0 4663,5682,5685,1,0 4664,5670,5673,4,10 4665,3470,5686,2,0 4666,2,5686,3,2 4667,1092,5687,0,0 4668,1461,5688,0,0 4669,2710,2268,1,0 4670,5688,2269,1,0 4671,1462,5689,0,0 4672,1466,5690,0,0 4673,1470,5691,0,0 4674,1471,5692,0,0 4675,5690,5693,1,0 4676,4143,5693,3,0 4677,5690,5694,4,1 4678,5690,5695,4,2 4679,3010,5696,2,0 4680,3015,5697,2,0 4681,3464,2268,1,0 4682,1092,5700,0,0 4683,5697,3015,3,0 4684,2292,2319,1,0 4685,5691,5701,1,0 4686,5697,5702,1,0 4687,5692,5703,1,0 4688,3050,5704,1,0 4689,5707,5704,1,0 4690,5703,5705,1,0 4691,5706,5705,1,0 4692,5705,5706,1,0 4693,5704,5707,1,0 4694,5696,3010,3,0 4695,5697,3015,3,0 4696,5703,5716,1,0 4697,5719,5716,1,0 4698,3050,5717,1,0 4699,5718,5717,1,0 4700,5717,5718,1,0 4701,5716,5719,1,0 4702,5691,5714,1,0 4703,5697,5715,1,0 4704,5697,3015,3,0 4705,5703,5710,1,0 4706,5713,5710,1,0 4707,3050,5711,1,0 4708,5712,5711,1,0 4709,5711,5712,1,0 4710,5710,5713,1,0 4711,5691,5708,1,0 4712,5697,5709,1,0 4713,5691,5698,1,0 4714,5698,5699,1,0 4715,1474,5720,0,0 4716,1475,5721,0,0 4717,3010,5722,2,0 4718,2295,5723,1,0 4719,3010,5724,2,0 4720,2295,5725,1,0 4721,2295,5726,1,0 4722,3468,2268,1,0 4723,3469,5728,2,0 4724,2,5728,3,2 4725,1171,5729,0,0 4726,5729,5730,2,0 4727,5730,5731,1,0 4728,3469,5727,2,0 4729,2,5727,3,2 4730,3469,5744,2,0 4731,2,5744,3,2 4732,3473,5743,1,0 4733,5740,5743,1,0 4734,5743,5739,1,0 4735,5743,5740,1,0 4736,5743,5741,1,0 4737,3469,5742,2,0 4738,2,5742,3,2 4739,3469,5738,2,0 4740,2,5738,3,2 4741,1171,5735,0,0 4742,5735,5736,2,0 4743,5736,5737,1,0 4744,1171,5732,0,0 4745,5732,5733,2,0 4746,5733,5734,1,0 4747,3483,5746,2,0 4748,3884,5747,2,0 4749,3038,3483,3,0 4750,3470,5745,2,0 4751,1476,5748,0,0 4752,3026,3349,3,0 4753,3026,5751,1,0 4754,5749,5751,1,0 4755,5749,5751,1,0 4756,3470,5752,2,0 4757,2,5752,3,2 4758,5751,3349,3,0 4759,5748,2293,1,0 4760,5751,2294,1,0 4761,5751,5749,1,0 4762,3470,5750,2,0 4763,2,5750,3,2 4764,1477,5753,0,0 4765,3476,5759,2,0 4766,5759,5760,1,0 4767,5760,3476,3,0 4768,3476,5761,2,0 4769,5753,5755,1,0 4770,3476,5756,2,0 4771,5753,5757,1,0 4772,5756,5758,1,0 4773,5758,3476,3,0 4774,3476,5754,2,0 4775,3483,5762,2,0 4776,3038,3483,3,0 4777,1478,5763,0,0 4778,3476,5764,2,0 4779,3478,5776,1,0 4780,5765,5776,1,0 4781,5765,5776,1,0 4782,5765,5776,1,0 4783,5765,5776,1,0 4784,5775,5776,1,0 4785,5765,5776,1,0 4786,5765,5776,1,0 4787,3478,3476,3,0 4788,5763,2293,1,0 4789,5776,2294,1,0 4790,5776,5765,1,0 4791,5765,5766,1,0 4792,5770,5766,1,0 4793,5770,5766,1,0 4794,5763,2293,1,0 4795,5766,2294,1,0 4796,5766,5770,1,0 4797,5766,5774,1,0 4798,5766,5774,1,0 4799,5766,5774,1,0 4800,5766,5774,1,0 4801,5774,5775,1,0 4802,1171,5771,0,0 4803,5771,5772,2,0 4804,5772,5773,1,0 4805,1171,5767,0,0 4806,5767,5768,2,0 4807,5768,5769,1,0 4808,3174,5777,2,0 4809,3883,5781,2,0 4810,3161,5785,2,0 4811,3189,5787,2,0 4812,1479,5786,0,0 4813,2421,5786,1,0 4814,5785,2420,1,0 4815,3149,5788,2,0 4816,3149,5789,2,0 4817,3185,5790,2,0 4818,3884,5792,2,0 4819,1479,5791,0,0 4820,2421,5791,1,0 4821,5790,2420,1,0 4822,3199,5793,2,0 4823,1479,5794,0,0 4824,2421,5794,1,0 4825,5793,2420,1,0 4826,3883,5795,2,0 4827,3188,5800,2,0 4828,3187,5808,2,0 4829,3290,5810,1,0 4830,5810,5811,2,0 4831,5811,5812,1,0 4832,3884,5809,2,0 4833,3290,5802,1,0 4834,5802,5803,2,0 4835,5803,5804,1,0 4836,1171,5805,0,0 4837,5805,5806,2,0 4838,5806,5807,1,0 4839,1479,5801,0,0 4840,2421,5801,1,0 4841,5800,2420,1,0 4842,3884,5797,2,0 4843,3196,5798,2,0 4844,3884,5799,2,0 4845,3196,5796,2,0 4846,3189,5784,2,0 4847,3155,5783,2,0 4848,3884,5782,2,0 4849,3883,5779,2,0 4850,3186,5780,2,0 4851,3884,5778,2,0 4852,3189,5814,2,0 4853,3155,5813,2,0 4854,3189,5815,2,0 4855,3153,5817,2,0 4856,1479,5818,0,0 4857,2421,5818,1,0 4858,5817,2420,1,0 4859,3883,5816,2,0 4860,3163,5819,2,0 4861,3198,5820,2,0 4862,3483,5821,2,0 4863,3038,3483,3,0 4864,1480,5822,0,0 4865,3483,5827,2,0 4866,5827,5828,1,0 4867,5828,3483,3,0 4868,3483,5829,2,0 4869,3038,3483,3,0 4870,5822,5823,1,0 4871,3483,5824,2,0 4872,5822,5825,1,0 4873,5824,5826,1,0 4874,5826,3483,3,0 4875,3038,3483,3,0 4876,3483,5830,2,0 4877,3038,3483,3,0 4878,1481,5831,0,0 4879,5831,5832,1,0 4880,5831,5833,2,0 4881,3470,5834,2,0 4882,2296,3470,3,0 4883,5834,3470,3,0 4884,3470,5835,2,0 4885,2,5835,3,2 4886,3483,5836,2,0 4887,3038,3483,3,0 4888,3483,5837,2,0 4889,3247,5838,2,0 4890,5838,3231,3,0 4891,3247,5839,2,1 4892,5839,3231,3,1 4893,3247,5840,2,2 4894,5840,3231,3,2 4895,3247,5841,2,3 4896,5841,3231,3,3 4897,3247,5842,2,4 4898,5842,3231,3,4 4899,3247,5843,2,5 4900,5843,3231,3,5 4901,3247,5844,2,6 4902,5844,3231,3,6 4903,3247,5845,2,7 4904,5845,3231,3,7 4905,3038,3483,3,0 4906,1482,5846,0,0 4907,1490,5847,0,0 4908,1498,5848,0,0 4909,1499,5849,0,0 4910,1507,5850,0,0 4911,5848,5851,1,0 4912,3478,3476,3,0 4913,3038,3483,3,0 4914,5850,5852,1,0 4915,3247,5857,2,0 4916,5857,5852,3,0 4917,3247,5858,2,1 4918,5858,5852,3,1 4919,3247,5859,2,2 4920,5859,5852,3,2 4921,3247,5860,2,3 4922,5860,5852,3,3 4923,3247,5861,2,4 4924,5861,5852,3,4 4925,3247,5862,2,5 4926,5862,5852,3,5 4927,3247,5863,2,6 4928,5863,5852,3,6 4929,3247,5864,2,7 4930,5864,5852,3,7 4931,5847,5853,1,0 4932,5852,5865,2,0 4933,5865,5853,3,0 4934,5852,5866,2,1 4935,5866,5853,3,1 4936,5852,5867,2,2 4937,5867,5853,3,2 4938,5852,5868,2,3 4939,5868,5853,3,3 4940,5852,5869,2,4 4941,5869,5853,3,4 4942,5852,5870,2,5 4943,5870,5853,3,5 4944,5852,5871,2,6 4945,5871,5853,3,6 4946,5852,5872,2,7 4947,5872,5853,3,7 4948,5846,5854,1,0 4949,3231,5873,2,0 4950,5873,5854,3,0 4951,3231,5874,2,1 4952,5874,5854,3,1 4953,3231,5875,2,2 4954,5875,5854,3,2 4955,3231,5876,2,3 4956,5876,5854,3,3 4957,3231,5877,2,4 4958,5877,5854,3,4 4959,3231,5878,2,5 4960,5878,5854,3,5 4961,3231,5879,2,6 4962,5879,5854,3,6 4963,3231,5880,2,7 4964,5880,5854,3,7 4965,5853,5881,2,0 4966,5881,3231,3,0 4967,5853,5882,2,1 4968,5882,3231,3,1 4969,5853,5883,2,2 4970,5883,3231,3,2 4971,5853,5884,2,3 4972,5884,3231,3,3 4973,5853,5885,2,4 4974,5885,3231,3,4 4975,5853,5886,2,5 4976,5886,3231,3,5 4977,5853,5887,2,6 4978,5887,3231,3,6 4979,5853,5888,2,7 4980,5888,3231,3,7 4981,5849,5855,1,0 4982,5854,5889,2,0 4983,5889,5855,3,0 4984,5854,5890,2,1 4985,5890,5855,3,1 4986,5854,5891,2,2 4987,5891,5855,3,2 4988,5854,5892,2,3 4989,5892,5855,3,3 4990,5854,5893,2,4 4991,5893,5855,3,4 4992,5854,5894,2,5 4993,5894,5855,3,5 4994,5854,5895,2,6 4995,5895,5855,3,6 4996,5854,5896,2,7 4997,5896,5855,3,7 4998,5849,5856,4,5 4999,5856,5897,2,0 5000,5897,5851,3,0 5001,1092,5898,0,0 5002,1515,5899,0,0 5003,3485,2268,1,0 5004,5899,5900,1,0 5005,3231,5902,2,0 5006,5902,5900,3,0 5007,3231,5903,2,1 5008,5903,5900,3,1 5009,3231,5904,2,2 5010,5904,5900,3,2 5011,3231,5905,2,3 5012,5905,5900,3,3 5013,3231,5906,2,4 5014,5906,5900,3,4 5015,3231,5907,2,5 5016,5907,5900,3,5 5017,3231,5908,2,6 5018,5908,5900,3,6 5019,3231,5909,2,7 5020,5909,5900,3,7 5021,3247,5910,2,0 5022,5910,3231,3,0 5023,3247,5911,2,1 5024,5911,3231,3,1 5025,3247,5912,2,2 5026,5912,3231,3,2 5027,3247,5913,2,3 5028,5913,3231,3,3 5029,3247,5914,2,4 5030,5914,3231,3,4 5031,3247,5915,2,5 5032,5915,3231,3,5 5033,3247,5916,2,6 5034,5916,3231,3,6 5035,3247,5917,2,7 5036,5917,3231,3,7 5037,2306,5901,1,0 5038,5900,5918,2,0 5039,5918,5901,3,0 5040,5900,5919,2,1 5041,5919,5901,3,1 5042,5900,5920,2,2 5043,5920,5901,3,2 5044,5900,5921,2,3 5045,5921,5901,3,3 5046,5900,5922,2,4 5047,5922,5901,3,4 5048,5900,5923,2,5 5049,5923,5901,3,5 5050,5900,5924,2,6 5051,5924,5901,3,6 5052,5900,5925,2,7 5053,5925,5901,3,7 5054,1523,5926,0,0 5055,3202,5927,2,0 5056,3483,5928,2,0 5057,3183,5929,2,0 5058,3483,5930,2,0 5059,1543,5931,0,0 5060,1544,5932,0,0 5061,1545,5933,0,0 5062,5926,5935,4,3 5063,5931,5934,1,0 5064,5932,5934,1,0 5065,5933,5934,1,0 5066,3271,2340,1,0 5067,5934,2341,1,0 5068,3487,2342,1,0 5069,5934,2343,1,0 5070,3038,3483,3,0 5071,3038,3483,3,0 5072,1546,5936,0,0 5073,1554,5937,0,0 5074,1562,5938,0,0 5075,1563,5939,0,0 5076,1571,5940,0,0 5077,5938,5941,1,0 5078,2307,5942,4,1 5079,3483,5943,2,0 5080,5940,5944,1,0 5081,2307,5945,1,0 5082,5945,5950,2,0 5083,5950,5944,3,0 5084,5945,5951,2,1 5085,5951,5944,3,1 5086,5945,5952,2,2 5087,5952,5944,3,2 5088,5945,5953,2,3 5089,5953,5944,3,3 5090,5945,5954,2,4 5091,5954,5944,3,4 5092,5945,5955,2,5 5093,5955,5944,3,5 5094,5945,5956,2,6 5095,5956,5944,3,6 5096,5945,5957,2,7 5097,5957,5944,3,7 5098,5937,5946,1,0 5099,5944,5958,2,0 5100,5958,5946,3,0 5101,5944,5959,2,1 5102,5959,5946,3,1 5103,5944,5960,2,2 5104,5960,5946,3,2 5105,5944,5961,2,3 5106,5961,5946,3,3 5107,5944,5962,2,4 5108,5962,5946,3,4 5109,5944,5963,2,5 5110,5963,5946,3,5 5111,5944,5964,2,6 5112,5964,5946,3,6 5113,5944,5965,2,7 5114,5965,5946,3,7 5115,5936,5947,1,0 5116,3231,5966,2,0 5117,5966,5947,3,0 5118,3231,5967,2,1 5119,5967,5947,3,1 5120,3231,5968,2,2 5121,5968,5947,3,2 5122,3231,5969,2,3 5123,5969,5947,3,3 5124,3231,5970,2,4 5125,5970,5947,3,4 5126,3231,5971,2,5 5127,5971,5947,3,5 5128,3231,5972,2,6 5129,5972,5947,3,6 5130,3231,5973,2,7 5131,5973,5947,3,7 5132,5946,5974,2,0 5133,5974,3231,3,0 5134,5946,5975,2,1 5135,5975,3231,3,1 5136,5946,5976,2,2 5137,5976,3231,3,2 5138,5946,5977,2,3 5139,5977,3231,3,3 5140,5946,5978,2,4 5141,5978,3231,3,4 5142,5946,5979,2,5 5143,5979,3231,3,5 5144,5946,5980,2,6 5145,5980,3231,3,6 5146,5946,5981,2,7 5147,5981,3231,3,7 5148,5939,5948,1,0 5149,5947,5982,2,0 5150,5982,5948,3,0 5151,5947,5983,2,1 5152,5983,5948,3,1 5153,5947,5984,2,2 5154,5984,5948,3,2 5155,5947,5985,2,3 5156,5985,5948,3,3 5157,5947,5986,2,4 5158,5986,5948,3,4 5159,5947,5987,2,5 5160,5987,5948,3,5 5161,5947,5988,2,6 5162,5988,5948,3,6 5163,5947,5989,2,7 5164,5989,5948,3,7 5165,5939,5949,4,5 5166,5949,5990,2,0 5167,5990,5941,3,0 5168,3038,3483,3,0 5169,3201,5991,2,0 5170,3483,5992,2,0 5171,3179,5993,2,0 5172,3483,5994,2,0 5173,3038,3483,3,0 5174,3038,3483,3,0 5175,1579,5995,0,0 5176,1580,5996,0,0 5177,3074,5997,2,0 5178,3079,5998,2,0 5179,3010,5999,2,0 5180,2993,6000,2,0 5181,3489,2268,1,0 5182,3075,6001,2,0 5183,2998,6002,2,0 5184,3072,6004,2,0 5185,3079,6005,2,0 5186,3074,6006,2,0 5187,3588,2268,1,0 5188,3586,2268,1,0 5189,5996,6007,1,0 5190,6007,2295,1,0 5191,3110,2314,1,0 5192,3099,6008,1,0 5193,6011,6008,1,0 5194,3111,6009,1,0 5195,6010,6009,1,0 5196,6009,6010,1,0 5197,6008,6011,1,0 5198,5995,6012,1,0 5199,5995,6013,1,0 5200,6012,6018,1,0 5201,6016,6018,1,0 5202,6007,2295,1,0 5203,6015,6016,1,0 5204,6014,6016,1,0 5205,6018,6016,1,0 5206,6018,6016,1,0 5207,6018,6016,1,0 5208,5996,6017,1,0 5209,6016,6015,1,0 5210,3493,2268,1,0 5211,6018,6019,1,0 5212,6019,6020,1,0 5213,6018,6020,1,0 5214,6020,6021,1,0 5215,3074,6022,2,0 5216,3076,6023,2,0 5217,6023,2330,1,0 5218,6022,2331,1,0 5219,3076,6024,2,0 5220,6027,6028,1,0 5221,6024,6028,1,0 5222,3074,6029,2,0 5223,3076,6030,2,0 5224,6033,6034,1,0 5225,6030,6034,1,0 5226,3074,6035,2,0 5227,6035,6036,1,0 5228,5999,3010,3,0 5229,6000,2993,3,0 5230,3079,6037,2,0 5231,6031,6032,1,0 5232,6034,6032,1,0 5233,6032,6033,1,0 5234,6034,3075,3,0 5235,6012,3010,3,0 5236,3079,6031,2,0 5237,3072,6025,2,0 5238,6028,6027,1,0 5239,3073,6026,2,0 5240,6028,2315,1,0 5241,6007,2295,1,0 5242,6018,6014,1,0 5243,3491,2268,1,0 5244,3293,6003,2,0 5245,6003,3330,3,0 5246,3023,6038,2,0 5247,6038,6039,1,0 5248,6042,6039,1,0 5249,3026,6040,1,0 5250,6041,6040,1,0 5251,6040,6041,1,0 5252,6039,6042,1,0 5253,1581,6043,0,0 5254,1582,6044,0,0 5255,2309,2315,1,0 5256,6064,6065,1,0 5257,3026,6065,1,0 5258,3026,6065,1,0 5259,6063,6066,1,0 5260,3004,6066,1,0 5261,3004,6066,1,0 5262,3514,6067,2,0 5263,6066,6063,1,0 5264,6065,6064,1,0 5265,6066,6068,1,0 5266,6043,6069,1,0 5267,6068,6089,1,0 5268,6086,6089,1,0 5269,6074,6089,1,0 5270,6079,6089,1,0 5271,6085,6089,1,0 5272,3116,6090,1,0 5273,6070,6090,1,0 5274,6070,6090,1,0 5275,6070,6090,1,0 5276,6070,6090,1,0 5277,6070,6090,1,0 5278,6087,6090,1,0 5279,6070,6090,1,0 5280,6070,6090,1,0 5281,6070,6090,1,0 5282,3120,6091,1,0 5283,6071,6091,1,0 5284,6071,6091,1,0 5285,6071,6091,1,0 5286,6071,6091,1,0 5287,6071,6091,1,0 5288,6088,6091,1,0 5289,6071,6091,1,0 5290,6071,6091,1,0 5291,6071,6091,1,0 5292,3499,6092,2,0 5293,6089,6093,1,0 5294,6093,3499,3,0 5295,3514,6094,2,0 5296,6044,2293,1,0 5297,6093,2294,1,0 5298,3499,6095,2,0 5299,6095,6096,1,0 5300,6096,3499,3,0 5301,6092,6097,1,0 5302,6092,6097,1,0 5303,6100,6097,1,0 5304,6089,6098,1,0 5305,6089,6098,1,0 5306,6099,6098,1,0 5307,6098,6099,1,0 5308,6097,6100,1,0 5309,3004,6101,1,0 5310,6104,6101,1,0 5311,3026,6102,1,0 5312,6103,6102,1,0 5313,6102,6103,1,0 5314,6101,6104,1,0 5315,6074,6086,1,0 5316,6079,6086,1,0 5317,6081,6086,1,0 5318,6085,6086,1,0 5319,6099,6086,1,0 5320,6070,6087,1,0 5321,6070,6087,1,0 5322,6070,6087,1,0 5323,6070,6087,1,0 5324,6090,6087,1,0 5325,6071,6088,1,0 5326,6071,6088,1,0 5327,6071,6088,1,0 5328,6071,6088,1,0 5329,6091,6088,1,0 5330,3520,2268,1,0 5331,6044,2293,1,0 5332,6090,2294,1,0 5333,6090,6070,1,0 5334,6091,6071,1,0 5335,6081,6082,1,0 5336,6089,6082,1,0 5337,6089,6082,1,0 5338,6043,6080,1,0 5339,6082,6081,1,0 5340,6083,6085,1,0 5341,6084,6085,1,0 5342,6082,6085,1,0 5343,6089,6084,1,0 5344,6089,6083,1,0 5345,3517,6075,1,0 5346,6075,6076,2,0 5347,3518,6077,1,0 5348,6077,6078,2,0 5349,2313,6079,1,0 5350,6089,2310,1,0 5351,6078,2311,1,0 5352,6076,2312,1,0 5353,3499,6072,2,0 5354,3514,6073,2,0 5355,2313,6074,1,0 5356,6089,2310,1,0 5357,6073,2311,1,0 5358,6072,2312,1,0 5359,3471,6046,2,0 5360,3079,6047,2,0 5361,2,6046,3,2 5362,3514,6049,2,0 5363,6049,6050,1,0 5364,3029,6051,1,0 5365,6050,6051,1,0 5366,6051,2327,1,0 5367,3470,6052,2,0 5368,2,6052,3,2 5369,3499,6053,2,0 5370,6053,6054,1,0 5371,3029,6055,1,0 5372,6054,6055,1,0 5373,6055,2327,1,0 5374,3470,6056,2,0 5375,2,6056,3,2 5376,3483,6057,2,0 5377,3513,6058,1,0 5378,6062,6058,1,0 5379,6061,6062,1,0 5380,6058,6062,1,0 5381,6058,6062,1,0 5382,6061,6062,1,0 5383,6058,6061,1,0 5384,3470,6059,2,0 5385,2,6059,3,2 5386,3483,6060,2,0 5387,3038,3483,3,0 5388,3038,3483,3,0 5389,3470,6048,2,0 5390,2,6048,3,2 5391,3469,6045,2,0 5392,2300,3469,3,0 5393,1171,6105,0,0 5394,6105,6106,2,0 5395,6106,6107,1,0 5396,1583,6108,0,0 5397,1584,6109,0,0 5398,6109,6110,1,0 5399,2311,6117,1,0 5400,6111,6117,1,0 5401,6115,6117,1,0 5402,2310,6118,1,0 5403,6114,6118,1,0 5404,6116,6118,1,0 5405,6108,2293,1,0 5406,6117,2294,1,0 5407,6117,6111,1,0 5408,6118,6114,1,0 5409,6113,6114,1,0 5410,6109,6112,1,0 5411,6114,6113,1,0 5412,6118,6119,1,0 5413,6119,2313,1,0 5414,6117,6115,1,0 5415,6118,6116,1,0 5416,2314,6120,4,2 5417,6120,6121,2,0 5418,3110,6122,1,0 5419,3112,6122,1,0 5420,3112,6122,1,0 5421,3098,6123,1,0 5422,3110,6123,1,0 5423,3098,6123,1,0 5424,6123,6124,4,2 5425,6124,6125,2,0 5426,6122,6128,4,2 5427,6128,6129,2,0 5428,6121,6132,1,0 5429,6132,6133,4,1 5430,6120,6138,2,0 5431,6138,6139,1,0 5432,6139,6140,1,0 5433,6140,6141,2,0 5434,6141,6142,1,0 5435,6139,6143,1,0 5436,6142,6144,4,2 5437,6143,6144,3,0 5438,6139,6145,1,0 5439,6145,6146,2,0 5440,6146,6147,1,0 5441,6147,6145,3,0 5442,6132,6136,4,3 5443,6136,6137,2,0 5444,6137,2448,1,0 5445,6132,6134,4,2 5446,6134,6135,2,0 5447,6135,2436,1,0 5448,2314,6130,4,1 5449,6122,6131,4,1 5450,2314,6126,4,1 5451,6123,6127,4,1 5452,1585,6148,0,0 5453,1588,6149,0,0 5454,1589,6150,0,0 5455,3098,2314,1,0 5456,3105,6151,2,0 5457,1602,6152,0,0 5458,6152,3105,3,0 5459,6152,6153,1,0 5460,6151,6153,1,0 5461,6153,6154,1,0 5462,6150,6155,4,2 5463,6150,6156,4,3 5464,6150,6157,4,11 5465,6150,6158,4,6 5466,6150,6159,4,7 5467,6150,6160,4,8 5468,6150,6161,4,9 5469,6150,6162,4,12 5470,3100,6163,1,0 5471,3099,6163,1,0 5472,3099,6163,1,0 5473,6150,6164,4,1 5474,6163,6164,3,0 5475,6150,6165,4,4 5476,6150,6166,4,5 5477,6150,2461,1,0 5478,6167,6168,1,0 5479,6181,6183,1,0 5480,6168,6183,1,0 5481,6168,6183,1,0 5482,6155,6184,2,0 5483,6305,6306,1,0 5484,3905,6306,1,0 5485,6306,6319,2,0 5486,6319,3100,3,0 5487,3105,6307,2,0 5488,6307,6308,1,0 5489,3100,2268,1,0 5490,3105,6317,2,0 5491,6317,6318,1,0 5492,6308,6309,1,0 5493,6309,6310,2,0 5494,6310,6311,1,0 5495,6308,6312,1,0 5496,6311,6313,4,2 5497,6312,6313,3,0 5498,6308,6314,1,0 5499,6314,6315,2,0 5500,6315,6316,1,0 5501,6316,6314,3,0 5502,3906,6304,4,1 5503,6304,6305,2,0 5504,3105,6294,2,0 5505,6294,6295,1,0 5506,3526,2268,1,0 5507,6295,6296,1,0 5508,6296,6297,2,0 5509,6297,6298,1,0 5510,6295,6299,1,0 5511,6298,6300,4,2 5512,6299,6300,3,0 5513,6295,6301,1,0 5514,6301,6302,2,0 5515,6302,6303,1,0 5516,6303,6301,3,0 5517,6153,6194,1,0 5518,6154,6195,4,1 5519,6156,6196,2,0 5520,6154,6197,4,4 5521,6196,6197,3,0 5522,6154,6198,4,5 5523,1622,6237,0,0 5524,6237,6238,1,0 5525,6183,2457,1,0 5526,6154,6292,4,3 5527,6292,6293,2,0 5528,6293,2448,1,0 5529,6238,6239,4,3 5530,6237,6240,1,0 5531,1626,6241,0,0 5532,6241,6242,1,0 5533,6238,2457,1,0 5534,6242,6243,4,3 5535,6241,6244,1,0 5536,6238,6244,3,0 5537,6238,6245,4,2 5538,6242,6245,3,0 5539,6183,6246,1,0 5540,6246,6247,2,0 5541,2460,6248,1,0 5542,6242,2458,1,0 5543,6247,2459,1,0 5544,6248,6246,3,0 5545,6248,6249,4,2 5546,6183,6249,3,0 5547,1630,6250,0,0 5548,6250,6251,1,0 5549,6154,6252,4,2 5550,6251,6252,3,0 5551,6251,6253,4,1 5552,6251,6254,4,2 5553,6251,6255,4,3 5554,6251,6256,4,4 5555,2428,6257,1,0 5556,6154,2426,1,0 5557,6183,2427,1,0 5558,6251,2436,1,0 5559,6251,6258,4,5 5560,1649,6259,0,0 5561,6259,6260,1,0 5562,6260,6256,3,0 5563,6260,6261,1,0 5564,6261,6262,1,0 5565,6250,6263,1,0 5566,6262,6263,3,0 5567,6251,2433,1,0 5568,6257,2434,1,0 5569,6251,6264,4,7 5570,6251,6265,4,6 5571,1653,6266,0,0 5572,6266,6267,1,0 5573,6267,6254,3,0 5574,6256,6268,2,0 5575,6253,6269,2,0 5576,6268,6270,4,2 5577,6269,6271,1,0 5578,6271,6255,3,0 5579,6268,6272,4,1 5580,6251,6273,4,8 5581,6251,6274,4,16 5582,6251,2435,1,0 5583,1654,6275,0,0 5584,6275,6276,1,0 5585,6276,6255,3,0 5586,6251,6277,4,15 5587,6251,2437,1,0 5588,6251,6278,4,14 5589,6251,6279,4,10 5590,6251,6280,4,9 5591,6251,6281,4,9 5592,6251,6282,4,11 5593,6251,6283,4,11 5594,6251,6284,4,12 5595,6251,6285,4,13 5596,6251,6286,4,10 5597,6251,6287,4,10 5598,6251,6288,4,9 5599,6251,6289,4,9 5600,6251,6290,4,11 5601,6251,6291,4,11 5602,1655,6199,0,0 5603,6199,6200,1,0 5604,6199,6201,1,0 5605,6183,2444,1,0 5606,6201,2445,1,0 5607,6149,2446,1,0 5608,6199,6226,1,0 5609,6226,6227,2,0 5610,6199,6228,1,0 5611,6228,6229,1,0 5612,6229,6230,2,0 5613,6230,6231,1,0 5614,6228,6232,1,0 5615,6231,6233,4,2 5616,6232,6233,3,0 5617,6228,6234,1,0 5618,6234,6235,2,0 5619,6235,6236,1,0 5620,6236,6234,3,0 5621,6227,2440,1,0 5622,6149,6202,2,0 5623,6202,6203,4,1 5624,6200,6204,4,9 5625,6200,6205,4,10 5626,6148,6149,3,0 5627,6201,6206,2,0 5628,2443,6207,1,0 5629,6206,2441,1,0 5630,6149,2442,1,0 5631,6207,6201,3,0 5632,6149,6219,2,0 5633,6200,6220,4,1 5634,6200,6221,4,2 5635,6200,6222,4,6 5636,6200,6223,4,3 5637,6154,6224,4,3 5638,6200,6224,3,0 5639,6183,2447,1,0 5640,6200,6225,4,12 5641,6219,6208,1,0 5642,6208,6209,2,0 5643,6209,6149,3,0 5644,6219,6210,1,0 5645,6210,6211,1,0 5646,6211,6212,2,0 5647,6212,6213,1,0 5648,6210,6214,1,0 5649,6213,6215,4,2 5650,6214,6215,3,0 5651,6210,6216,1,0 5652,6216,6217,2,0 5653,6217,6218,1,0 5654,6218,6216,3,0 5655,6184,6185,1,0 5656,6185,6186,1,0 5657,6186,6187,2,0 5658,6187,6188,1,0 5659,6185,6189,1,0 5660,6188,6190,4,2 5661,6189,6190,3,0 5662,6185,6191,1,0 5663,6191,6192,2,0 5664,6192,6193,1,0 5665,6193,6191,3,0 5666,2467,6169,1,0 5667,6150,2466,1,0 5668,6169,6167,1,0 5669,6176,6167,1,0 5670,6181,6167,1,0 5671,6167,2457,1,0 5672,1668,6170,0,0 5673,6170,6171,1,0 5674,6169,2457,1,0 5675,6171,6172,4,3 5676,6170,6173,1,0 5677,6169,6173,3,0 5678,6169,6174,4,2 5679,6171,6174,3,0 5680,6171,6175,4,1 5681,6171,6176,1,0 5682,6169,6176,1,0 5683,1672,6177,0,0 5684,6177,6178,1,0 5685,6178,6179,4,3 5686,6177,6180,1,0 5687,2460,6181,1,0 5688,6176,2458,1,0 5689,6178,2459,1,0 5690,6181,6182,4,2 5691,1676,6320,0,0 5692,1677,6321,0,0 5693,1171,6322,0,0 5694,6322,6323,2,0 5695,6323,6324,1,0 5696,6320,6325,1,0 5697,6325,2295,1,0 5698,3534,2268,1,0 5699,3105,6334,2,0 5700,3507,2268,1,0 5701,6388,6335,1,0 5702,3099,6335,1,0 5703,3099,6335,1,0 5704,6335,6336,1,0 5705,6342,6389,1,0 5706,6337,6389,1,0 5707,6336,6389,1,0 5708,6336,6389,1,0 5709,3100,6390,1,0 5710,6389,6390,1,0 5711,6335,6337,1,0 5712,6338,6341,1,0 5713,6339,6341,1,0 5714,6340,6341,1,0 5715,6335,6341,1,0 5716,6335,6341,1,0 5717,6335,6341,1,0 5718,6335,6341,1,0 5719,6335,6341,1,0 5720,6335,6341,1,0 5721,6335,6341,1,0 5722,6341,6342,1,0 5723,6335,6343,1,0 5724,3120,6352,1,0 5725,6349,6352,1,0 5726,3116,6353,1,0 5727,6350,6353,1,0 5728,6341,6354,1,0 5729,6351,6354,1,0 5730,6382,6386,1,0 5731,6354,6386,1,0 5732,6372,6386,1,0 5733,6384,6386,1,0 5734,6387,6388,1,0 5735,6386,6388,1,0 5736,6325,2295,1,0 5737,6354,6387,1,0 5738,6355,6387,1,0 5739,6357,6387,1,0 5740,6362,6387,1,0 5741,6368,6387,1,0 5742,6373,6387,1,0 5743,6377,6387,1,0 5744,6383,6387,1,0 5745,6386,6387,1,0 5746,3544,2268,1,0 5747,6344,6345,1,0 5748,6354,6345,1,0 5749,6321,2293,1,0 5750,6353,2294,1,0 5751,6348,6349,1,0 5752,6352,6349,1,0 5753,6352,6349,1,0 5754,6352,6349,1,0 5755,6352,6349,1,0 5756,6347,6350,1,0 5757,6353,6350,1,0 5758,6353,6350,1,0 5759,6353,6350,1,0 5760,6353,6350,1,0 5761,6346,6351,1,0 5762,6345,6351,1,0 5763,6345,6351,1,0 5764,6345,6351,1,0 5765,6345,6351,1,0 5766,6351,6346,1,0 5767,6350,6347,1,0 5768,6349,6348,1,0 5769,6354,6344,1,0 5770,6321,2293,1,0 5771,6353,2294,1,0 5772,3536,2268,1,0 5773,3538,2268,1,0 5774,6341,6355,1,0 5775,6355,6356,1,0 5776,6372,6356,1,0 5777,6325,2295,1,0 5778,6357,6358,1,0 5779,6356,6358,1,0 5780,6356,6358,1,0 5781,6320,6359,1,0 5782,6358,6360,1,0 5783,6371,6372,1,0 5784,6360,6372,1,0 5785,6360,6372,1,0 5786,6360,6361,1,0 5787,6360,6361,1,0 5788,6360,6361,1,0 5789,6365,6361,1,0 5790,6365,6361,1,0 5791,6325,2295,1,0 5792,6362,6363,1,0 5793,6361,6363,1,0 5794,6361,6363,1,0 5795,6320,6364,1,0 5796,6363,6365,1,0 5797,3010,6366,2,0 5798,6365,6367,1,0 5799,6325,2295,1,0 5800,6367,6369,1,0 5801,6368,6369,1,0 5802,6320,6370,1,0 5803,6369,6371,1,0 5804,6369,6368,1,0 5805,6363,6362,1,0 5806,3526,2268,1,0 5807,6358,6357,1,0 5808,3526,2268,1,0 5809,6373,6374,1,0 5810,6341,6374,1,0 5811,6320,6375,1,0 5812,6374,6376,1,0 5813,6380,6376,1,0 5814,6325,2295,1,0 5815,6377,6378,1,0 5816,6376,6378,1,0 5817,6376,6378,1,0 5818,6320,6379,1,0 5819,6378,6380,1,0 5820,6380,6381,1,0 5821,6325,2295,1,0 5822,6381,6382,1,0 5823,3542,2268,1,0 5824,6378,6377,1,0 5825,3540,2268,1,0 5826,6374,6373,1,0 5827,6383,6384,1,0 5828,6341,6384,1,0 5829,6320,6385,1,0 5830,6384,6383,1,0 5831,6335,6338,1,0 5832,6325,2295,1,0 5833,6335,6339,1,0 5834,6325,2295,1,0 5835,6335,6340,1,0 5836,3532,2268,1,0 5837,3098,2314,1,0 5838,3113,6330,1,0 5839,6333,6330,1,0 5840,3099,6331,1,0 5841,6332,6331,1,0 5842,6331,6332,1,0 5843,6330,6333,1,0 5844,3530,2268,1,0 5845,3098,2314,1,0 5846,3111,6326,1,0 5847,6329,6326,1,0 5848,3099,6327,1,0 5849,6328,6327,1,0 5850,6327,6328,1,0 5851,6326,6329,1,0 5852,3528,2268,1,0 5853,1678,6391,0,0 5854,1679,6392,0,0 5855,1680,6393,0,0 5856,1681,6394,0,0 5857,1682,6395,0,0 5858,1683,6396,0,0 5859,1684,6397,0,0 5860,1685,6398,0,0 5861,3079,6400,2,0 5862,6399,6401,1,0 5863,3026,6401,1,0 5864,3105,6402,2,0 5865,6402,6403,1,0 5866,6403,6404,4,1 5867,6403,6405,4,5 5868,6403,6462,4,3 5869,6462,6463,2,0 5870,6463,6464,4,4 5871,6463,6465,4,5 5872,6463,6466,4,7 5873,6464,6466,3,0 5874,6463,6467,4,8 5875,6465,6467,3,0 5876,6463,6468,4,11 5877,6463,6469,4,10 5878,6463,6470,4,12 5879,6463,6471,1,0 5880,6463,6472,4,1 5881,6463,6473,4,6 5882,6398,6474,1,0 5883,6398,6475,4,1 5884,6483,6476,1,0 5885,6477,6476,1,0 5886,6401,6477,1,0 5887,6482,6477,1,0 5888,6480,6477,1,0 5889,6477,6478,1,0 5890,6479,6480,1,0 5891,6478,6480,1,0 5892,6478,6480,1,0 5893,6464,6481,2,0 5894,6480,6482,1,0 5895,6480,6482,1,0 5896,6480,6482,1,0 5897,6480,6482,1,0 5898,6477,6483,1,0 5899,6477,6483,1,0 5900,6477,6483,1,0 5901,6477,6483,1,0 5902,6476,6484,1,0 5903,6476,6484,1,0 5904,6476,6484,1,0 5905,6476,6484,1,0 5906,6471,6485,2,0 5907,6463,2454,1,0 5908,6485,2456,1,0 5909,6464,6486,2,0 5910,6486,6487,1,0 5911,6538,6487,1,0 5912,6544,6487,1,0 5913,6487,6488,4,3 5914,6487,6489,4,4 5915,6487,6490,4,5 5916,6487,6491,4,6 5917,6487,6492,4,2 5918,6487,6493,4,7 5919,6488,6494,1,0 5920,6520,6494,1,0 5921,6506,6494,1,0 5922,6494,6495,2,0 5923,6495,6496,4,2 5924,6495,6533,1,0 5925,6533,6534,1,0 5926,6533,6534,1,0 5927,6540,6534,1,0 5928,6541,6534,1,0 5929,6548,6534,1,0 5930,6558,6534,1,0 5931,6534,6535,4,1 5932,6535,6536,2,0 5933,6536,6488,3,0 5934,6487,6537,4,1 5935,6537,6538,2,0 5936,6467,6539,2,0 5937,6487,6539,3,0 5938,6537,6467,3,0 5939,6463,6590,4,3 5940,6590,6591,2,0 5941,6596,6595,1,0 5942,6593,6596,1,0 5943,6591,6596,1,0 5944,6463,6597,4,2 5945,6597,6598,2,0 5946,6603,6602,1,0 5947,6600,6603,1,0 5948,6598,6603,1,0 5949,6398,6604,1,0 5950,6398,6605,4,1 5951,3544,2268,1,0 5952,6398,6606,1,0 5953,6401,6607,1,0 5954,6607,3514,3,0 5955,6398,6608,4,1 5956,6401,6609,1,0 5957,6609,3499,3,0 5958,6398,6610,1,0 5959,3517,6616,1,0 5960,3518,6617,1,0 5961,6401,6611,1,0 5962,3518,6612,1,0 5963,6611,6612,3,0 5964,6398,6613,4,1 5965,6401,6614,1,0 5966,3517,6615,1,0 5967,6614,6615,3,0 5968,6603,6599,1,0 5969,6599,6600,2,0 5970,6603,6601,4,1 5971,6602,6601,3,0 5972,6603,6472,3,0 5973,6596,6592,1,0 5974,6592,6593,2,0 5975,6596,6594,4,1 5976,6595,6594,3,0 5977,6596,6473,3,0 5978,6467,6588,2,0 5979,6588,6466,3,0 5980,6465,6589,2,0 5981,6589,6464,3,0 5982,6464,6466,3,0 5983,6465,6467,3,0 5984,6570,6542,1,0 5985,6487,6542,1,0 5986,6487,6542,1,0 5987,6487,6542,1,0 5988,6487,6542,1,0 5989,6487,6542,1,0 5990,6487,6542,1,0 5991,6487,6542,1,0 5992,6487,6542,1,0 5993,6487,6542,1,0 5994,6487,6542,1,0 5995,6487,6542,1,0 5996,6487,6542,1,0 5997,6487,6542,1,0 5998,6487,6542,1,0 5999,6487,6542,1,0 6000,6487,6542,1,0 6001,6487,6542,1,0 6002,6487,6542,1,0 6003,6487,6542,1,0 6004,6487,6542,1,0 6005,6487,6542,1,0 6006,6487,6542,1,0 6007,6570,6542,1,0 6008,6570,6542,1,0 6009,6570,6542,1,0 6010,6570,6542,1,0 6011,6570,6542,1,0 6012,6570,6542,1,0 6013,6542,6543,4,1 6014,6543,6544,2,0 6015,6473,6545,2,0 6016,6545,6543,3,0 6017,6542,6473,3,0 6018,6498,6499,1,0 6019,6495,6499,1,0 6020,6495,6500,1,0 6021,6489,6501,2,0 6022,6490,6502,2,0 6023,6499,6509,1,0 6024,6499,6509,1,0 6025,6499,6509,1,0 6026,6495,6509,1,0 6027,6492,6510,2,0 6028,6509,6519,1,0 6029,6495,6519,1,0 6030,6495,6519,1,0 6031,6495,6519,1,0 6032,6509,6519,1,0 6033,6495,6519,1,0 6034,6495,6519,1,0 6035,6495,6519,1,0 6036,6495,6519,1,0 6037,6495,6519,1,0 6038,6495,6519,1,0 6039,6495,6519,1,0 6040,6495,6519,1,0 6041,6495,6519,1,0 6042,6495,6519,1,0 6043,6495,6519,1,0 6044,6519,6520,4,1 6045,6510,6511,4,1 6046,6511,6512,2,0 6047,6512,6492,3,0 6048,6510,6513,4,2 6049,6513,6514,2,0 6050,6514,6489,3,0 6051,6510,6515,4,3 6052,6515,6516,2,0 6053,6516,6490,3,0 6054,6510,6517,4,4 6055,6472,6518,2,0 6056,6518,6511,3,0 6057,6510,6472,3,0 6058,6482,6490,3,0 6059,6499,6507,1,0 6060,6507,6508,2,0 6061,6463,2454,1,0 6062,6487,2455,1,0 6063,6508,2456,1,0 6064,6500,6503,1,0 6065,6503,6504,1,0 6066,6500,6505,1,0 6067,6499,6506,1,0 6068,6463,2451,1,0 6069,6487,2452,1,0 6070,6499,2453,1,0 6071,6495,6521,1,0 6072,6521,6522,2,0 6073,6463,2454,1,0 6074,6487,2455,1,0 6075,6522,2456,1,0 6076,6495,6531,1,0 6077,6487,6532,4,9 6078,6495,6523,1,0 6079,6487,6524,4,8 6080,6487,6525,4,9 6081,6487,6526,4,8 6082,6530,6527,1,0 6083,6526,6527,1,0 6084,6527,6528,1,0 6085,6527,6529,4,1 6086,6527,6530,1,0 6087,6495,6497,4,1 6088,6497,6498,2,0 6089,6493,6569,1,0 6090,6487,6570,1,0 6091,6495,6571,1,0 6092,6570,6572,4,8 6093,6570,6573,4,9 6094,6570,6574,4,8 6095,6570,6575,4,8 6096,6575,6576,1,0 6097,6576,6618,2,0 6098,6618,6474,3,0 6099,6576,6619,2,1 6100,6619,6474,3,1 6101,6570,6577,4,9 6102,6398,6578,1,0 6103,6570,6579,4,8 6104,6579,6584,1,0 6105,6581,6584,1,0 6106,6578,6585,1,0 6107,6583,6585,1,0 6108,6398,6586,4,1 6109,6570,6587,4,9 6110,6570,6580,4,9 6111,6570,6581,4,8 6112,6398,6582,4,1 6113,6398,6583,1,0 6114,6489,6554,2,0 6115,6490,6547,2,0 6116,6495,6555,1,0 6117,6487,6556,4,9 6118,6487,6557,4,8 6119,6495,6558,1,0 6120,6401,6559,1,0 6121,6558,6552,1,0 6122,6548,6552,1,0 6123,6463,2451,1,0 6124,6487,2452,1,0 6125,6552,2453,1,0 6126,6552,6488,3,0 6127,6482,6553,1,0 6128,6553,6490,3,0 6129,6401,6560,1,0 6130,6559,6561,1,0 6131,6568,6561,1,0 6132,6483,6562,1,0 6133,6565,6562,1,0 6134,6562,6563,1,0 6135,6564,6565,1,0 6136,6563,6565,1,0 6137,6563,6565,1,0 6138,6561,6566,1,0 6139,6567,6568,1,0 6140,6566,6568,1,0 6141,6566,6568,1,0 6142,6561,6567,1,0 6143,6562,6564,1,0 6144,6489,6546,2,0 6145,6495,6548,1,0 6146,6548,6549,1,0 6147,6549,6550,2,0 6148,6550,6551,1,0 6149,6551,2474,1,0 6150,6482,2475,1,0 6151,6495,6540,1,0 6152,6495,6541,1,0 6153,6477,6479,1,0 6154,6403,6407,4,2 6155,6407,6408,2,0 6156,6408,6409,4,17 6157,6408,6446,4,14 6158,6408,6447,4,11 6159,6401,6448,1,0 6160,6401,6448,1,0 6161,6451,6448,1,0 6162,6408,6449,4,18 6163,6408,2437,1,0 6164,6408,6450,4,11 6165,6448,6451,1,0 6166,6408,6452,4,14 6167,6408,6453,4,11 6168,6401,6454,1,0 6169,6457,6454,1,0 6170,6457,6454,1,0 6171,6454,6455,1,0 6172,6456,6457,1,0 6173,6455,6457,1,0 6174,6455,6457,1,0 6175,6455,6457,1,0 6176,6408,6458,4,18 6177,6408,2437,1,0 6178,6408,6459,4,11 6179,6408,6460,4,11 6180,6408,6461,4,11 6181,6454,6456,1,0 6182,6408,6410,4,13 6183,6411,6412,1,0 6184,6410,6412,1,0 6185,6408,6413,4,11 6186,6401,6414,1,0 6187,6408,6415,4,12 6188,6414,6416,1,0 6189,6440,6416,1,0 6190,6401,6417,1,0 6191,6439,6417,1,0 6192,6401,6418,1,0 6193,6440,6418,1,0 6194,6417,6419,1,0 6195,6439,6419,1,0 6196,6439,6419,1,0 6197,6418,6420,1,0 6198,6440,6420,1,0 6199,6440,6420,1,0 6200,6420,6421,1,0 6201,6422,6423,1,0 6202,6421,6423,1,0 6203,6421,6423,1,0 6204,6421,6423,1,0 6205,6408,6424,4,18 6206,6408,2437,1,0 6207,6408,6425,4,11 6208,6432,6439,1,0 6209,6423,6439,1,0 6210,6419,6439,1,0 6211,6432,6440,1,0 6212,6423,6440,1,0 6213,6423,6440,1,0 6214,6408,6441,4,11 6215,6416,6426,1,0 6216,6423,6427,1,0 6217,6419,6428,1,0 6218,6427,6429,1,0 6219,6426,6429,1,0 6220,6435,6442,1,0 6221,6428,6442,1,0 6222,6419,6442,1,0 6223,6435,6442,1,0 6224,6438,6443,1,0 6225,6429,6443,1,0 6226,6416,6443,1,0 6227,6433,6443,1,0 6228,6398,6444,1,0 6229,6398,6445,4,1 6230,6419,6430,1,0 6231,6431,6432,1,0 6232,6430,6432,1,0 6233,6430,6432,1,0 6234,6419,6431,1,0 6235,6416,6433,1,0 6236,6423,6434,1,0 6237,6419,6435,1,0 6238,6408,6436,4,11 6239,6434,6437,1,0 6240,6437,6438,1,0 6241,6433,6438,1,0 6242,6420,6422,1,0 6243,6408,6411,4,12 6244,6402,6406,1,0 6245,3499,6399,2,0 6246,3010,6620,2,0 6247,1171,6621,0,0 6248,6621,6622,2,0 6249,6622,6623,1,0 6250,3010,6624,2,0 6251,2316,6625,1,0 6252,6625,6626,2,0 6253,2316,6627,4,2 6254,2316,6628,4,4 6255,3572,6629,1,0 6256,2490,6629,1,0 6257,2316,6630,4,4 6258,2316,6631,4,5 6259,6631,6632,2,0 6260,38,6633,1,0 6261,6636,6633,1,0 6262,37,6634,1,0 6263,6635,6634,1,0 6264,6634,6635,1,0 6265,6633,6636,1,0 6266,42,6637,1,0 6267,41,6638,1,0 6268,3200,6639,2,0 6269,3483,6640,2,0 6270,3038,3483,3,0 6271,1092,6641,0,0 6272,3366,2304,1,0 6273,2319,2305,1,0 6274,3470,6642,2,0 6275,2,6642,3,2 6276,1687,6643,0,0 6277,2710,2268,1,0 6278,6643,2269,1,0 6279,1171,6644,0,0 6280,6644,6645,2,0 6281,6645,6646,1,0 6282,2993,6647,2,0 6283,6647,6648,1,0 6284,2993,6649,2,0 6285,6649,6650,1,0 6286,3470,6652,2,0 6287,2,6652,3,2 6288,3470,6651,2,0 6289,2,6651,3,2 6290,2490,3332,3,0 6291,2490,3331,3,0 6292,3004,6653,1,0 6293,6656,6657,1,0 6294,6653,6657,1,0 6295,6655,6658,1,0 6296,6653,6658,1,0 6297,6658,2321,1,0 6298,6657,6656,1,0 6299,6657,6654,1,0 6300,6654,6655,1,0 6301,3026,6659,1,0 6302,3470,6660,2,0 6303,2,6660,3,2 6304,3027,6661,1,0 6305,3026,6661,1,0 6306,3151,6662,2,0 6307,3194,6663,2,0 6308,2321,6666,1,0 6309,6661,2320,1,0 6310,3194,6667,2,0 6311,3192,6668,2,0 6312,3483,6669,2,0 6313,3038,3483,3,0 6314,3192,6664,2,0 6315,3483,6665,2,0 6316,3038,3483,3,0 6317,1688,6670,0,0 6318,6670,6671,1,0 6319,6670,6672,2,0 6320,2324,2322,1,0 6321,6672,2323,1,0 6322,1689,6673,0,0 6323,2998,6674,2,0 6324,6674,6675,1,0 6325,6675,2998,3,0 6326,3590,3332,3,0 6327,3592,6676,1,0 6328,3590,6676,1,0 6329,2993,6677,2,0 6330,2321,6678,1,0 6331,3594,2320,1,0 6332,2490,3331,3,0 6333,3592,3332,3,0 6334,1690,6679,0,0 6335,3595,6682,1,0 6336,3595,6683,1,0 6337,3595,6684,1,0 6338,6679,6680,1,0 6339,6679,6681,1,0 6340,2345,6685,1,0 6341,3026,6694,1,0 6342,6690,6694,1,0 6343,6685,6695,1,0 6344,6693,6695,1,0 6345,6694,6696,1,0 6346,6698,6696,1,0 6347,6695,6697,1,0 6348,6686,6697,1,0 6349,6696,6698,1,0 6350,6689,6699,1,0 6351,6696,6699,1,0 6352,6699,6700,1,0 6353,3033,6701,1,0 6354,3035,6701,1,0 6355,6702,6703,1,0 6356,6701,6703,1,0 6357,6703,6702,1,0 6358,6697,6686,1,0 6359,6698,6687,1,0 6360,6697,6688,1,0 6361,6696,6689,1,0 6362,6687,3023,3,0 6363,6698,6690,1,0 6364,6697,6691,1,0 6365,6696,6692,1,0 6366,2345,6693,1,0 6367,1691,6704,0,0 6368,1692,6705,0,0 6369,3469,6706,2,0 6370,2329,3469,3,0 6371,6707,6709,1,0 6372,2327,6709,1,0 6373,3471,6710,2,0 6374,2,6710,3,2 6375,6706,3469,3,0 6376,6713,6714,1,0 6377,2328,6714,1,0 6378,6705,2293,1,0 6379,6714,2294,1,0 6380,3470,6712,2,0 6381,2,6712,3,2 6382,6714,6713,1,0 6383,6709,6711,1,0 6384,2327,6707,1,0 6385,3026,6707,1,0 6386,2327,6707,1,0 6387,2327,6707,1,0 6388,2327,6707,1,0 6389,2327,6707,1,0 6390,6707,6708,1,0 6391,6704,2293,1,0 6392,2327,2294,1,0 6393,3075,6715,2,0 6394,6715,3084,3,0 6395,3078,6716,2,0 6396,3074,6717,2,0 6397,2998,6718,2,0 6398,3077,6719,2,0 6399,3600,2268,1,0 6400,3078,6724,2,0 6401,6724,6725,1,0 6402,6725,3078,3,0 6403,3077,6726,2,0 6404,6726,6727,1,0 6405,6727,3077,3,0 6406,3074,6728,2,0 6407,2330,6729,1,0 6408,6732,6729,1,0 6409,6728,6730,1,0 6410,6731,6730,1,0 6411,6730,6731,1,0 6412,6729,6732,1,0 6413,2330,6733,1,0 6414,6733,3081,3,0 6415,2330,3082,3,0 6416,2331,6734,1,0 6417,6734,3083,3,0 6418,2318,6720,1,0 6419,2317,6720,1,0 6420,3078,6721,2,0 6421,6721,6722,1,0 6422,6721,6723,1,0 6423,6723,6720,3,2 6424,6722,6720,3,3 6425,2,6720,3,4 6426,1171,6735,0,0 6427,3010,6737,2,0 6428,6735,6738,2,0 6429,6738,6739,1,0 6430,3010,6736,2,0 6431,1693,6740,0,0 6432,3469,6741,2,0 6433,2329,3469,3,0 6434,3025,2327,1,0 6435,6743,6744,1,0 6436,3026,6744,1,0 6437,6744,6745,1,0 6438,6744,6745,1,0 6439,6746,6747,1,0 6440,6745,6747,1,0 6441,6741,3469,3,0 6442,6747,2332,1,0 6443,6745,6746,1,0 6444,6740,2293,1,0 6445,6744,2294,1,0 6446,3470,6742,2,0 6447,2,6742,3,2 6448,6744,6743,1,0 6449,1171,6748,0,0 6450,6748,6749,2,0 6451,3026,6750,1,0 6452,6752,6750,1,0 6453,6749,6751,1,0 6454,6750,6753,1,0 6455,6750,6753,1,0 6456,6753,2333,1,0 6457,6750,6752,1,0 6458,1171,6754,0,0 6459,6754,6755,2,0 6460,6758,6756,1,0 6461,2334,6756,1,0 6462,6755,6757,1,0 6463,6756,6759,1,0 6464,6759,2335,1,0 6465,6756,6758,1,0 6466,3075,6760,2,0 6467,3076,6761,2,0 6468,3074,6762,2,0 6469,2998,6763,2,0 6470,3293,6764,2,0 6471,6764,3330,3,0 6472,1694,6765,0,0 6473,1698,6766,0,0 6474,1702,6767,0,0 6475,1706,6768,0,0 6476,6768,6769,1,0 6477,4143,6769,3,0 6478,6768,6770,4,1 6479,6768,6771,4,2 6480,6766,6772,1,0 6481,4143,6772,3,0 6482,6766,6773,4,1 6483,6766,6774,4,2 6484,3038,3483,3,0 6485,3601,6775,1,0 6486,6775,2268,1,0 6487,1710,6776,0,0 6488,1714,6777,0,0 6489,1718,6778,0,0 6490,1722,6779,0,0 6491,2338,6780,1,0 6492,2362,6780,1,0 6493,6779,6781,1,0 6494,6780,6781,3,0 6495,6779,6782,4,1 6496,6779,6783,4,2 6497,6777,6784,1,0 6498,2339,6784,3,0 6499,6777,6785,4,1 6500,6777,6786,4,2 6501,3613,6787,2,0 6502,6787,2319,1,0 6503,1726,6788,0,0 6504,1730,6789,0,0 6505,1734,6790,0,0 6506,1742,6791,0,0 6507,1750,6792,0,0 6508,1754,6793,0,0 6509,1758,6794,0,0 6510,1759,6795,0,0 6511,1767,6796,0,0 6512,1775,6797,0,0 6513,1783,6798,0,0 6514,1784,6799,0,0 6515,1788,6800,0,0 6516,1796,6801,0,0 6517,1797,6802,0,0 6518,6794,6803,1,0 6519,6801,6804,1,0 6520,6797,6805,1,0 6521,3247,6826,2,0 6522,6826,6805,3,0 6523,3247,6827,2,1 6524,6827,6805,3,1 6525,3247,6828,2,2 6526,6828,6805,3,2 6527,3247,6829,2,3 6528,6829,6805,3,3 6529,3247,6830,2,4 6530,6830,6805,3,4 6531,3247,6831,2,5 6532,6831,6805,3,5 6533,3247,6832,2,6 6534,6832,6805,3,6 6535,3247,6833,2,7 6536,6833,6805,3,7 6537,6796,6806,1,0 6538,3231,6834,2,0 6539,6834,6806,3,0 6540,3231,6835,2,1 6541,6835,6806,3,1 6542,3231,6836,2,2 6543,6836,6806,3,2 6544,3231,6837,2,3 6545,6837,6806,3,3 6546,3231,6838,2,4 6547,6838,6806,3,4 6548,3231,6839,2,5 6549,6839,6806,3,5 6550,3231,6840,2,6 6551,6840,6806,3,6 6552,3231,6841,2,7 6553,6841,6806,3,7 6554,6805,6842,2,0 6555,6842,3231,3,0 6556,6805,6843,2,1 6557,6843,3231,3,1 6558,6805,6844,2,2 6559,6844,3231,3,2 6560,6805,6845,2,3 6561,6845,3231,3,3 6562,6805,6846,2,4 6563,6846,3231,3,4 6564,6805,6847,2,5 6565,6847,3231,3,5 6566,6805,6848,2,6 6567,6848,3231,3,6 6568,6805,6849,2,7 6569,6849,3231,3,7 6570,6800,6807,1,0 6571,6806,6850,2,0 6572,6850,6807,3,0 6573,6806,6851,2,1 6574,6851,6807,3,1 6575,6806,6852,2,2 6576,6852,6807,3,2 6577,6806,6853,2,3 6578,6853,6807,3,3 6579,6806,6854,2,4 6580,6854,6807,3,4 6581,6806,6855,2,5 6582,6855,6807,3,5 6583,6806,6856,2,6 6584,6856,6807,3,6 6585,6806,6857,2,7 6586,6857,6807,3,7 6587,3197,6808,2,0 6588,3483,6809,2,0 6589,3483,6810,2,0 6590,6793,6811,1,0 6591,6793,6812,4,1 6592,6793,6813,4,2 6593,6789,6814,1,0 6594,2339,6814,3,0 6595,6789,6815,4,1 6596,6789,6816,4,2 6597,6791,6817,1,0 6598,6807,6858,2,0 6599,6858,6817,3,0 6600,6807,6859,2,1 6601,6859,6817,3,1 6602,6807,6860,2,2 6603,6860,6817,3,2 6604,6807,6861,2,3 6605,6861,6817,3,3 6606,6807,6862,2,4 6607,6862,6817,3,4 6608,6807,6863,2,5 6609,6863,6817,3,5 6610,6807,6864,2,6 6611,6864,6817,3,6 6612,6807,6865,2,7 6613,6865,6817,3,7 6614,6790,6818,1,0 6615,3231,6866,2,0 6616,6866,6818,3,0 6617,3231,6867,2,1 6618,6867,6818,3,1 6619,3231,6868,2,2 6620,6868,6818,3,2 6621,3231,6869,2,3 6622,6869,6818,3,3 6623,3231,6870,2,4 6624,6870,6818,3,4 6625,3231,6871,2,5 6626,6871,6818,3,5 6627,3231,6872,2,6 6628,6872,6818,3,6 6629,3231,6873,2,7 6630,6873,6818,3,7 6631,6817,6874,2,0 6632,6874,3231,3,0 6633,6817,6875,2,1 6634,6875,3231,3,1 6635,6817,6876,2,2 6636,6876,3231,3,2 6637,6817,6877,2,3 6638,6877,3231,3,3 6639,6817,6878,2,4 6640,6878,3231,3,4 6641,6817,6879,2,5 6642,6879,3231,3,5 6643,6817,6880,2,6 6644,6880,3231,3,6 6645,6817,6881,2,7 6646,6881,3231,3,7 6647,6802,6819,1,0 6648,6818,6882,2,0 6649,6882,6819,3,0 6650,6818,6883,2,1 6651,6883,6819,3,1 6652,6818,6884,2,2 6653,6884,6819,3,2 6654,6818,6885,2,3 6655,6885,6819,3,3 6656,6818,6886,2,4 6657,6886,6819,3,4 6658,6818,6887,2,5 6659,6887,6819,3,5 6660,6818,6888,2,6 6661,6888,6819,3,6 6662,6818,6889,2,7 6663,6889,6819,3,7 6664,6802,6820,4,5 6665,6820,6890,2,0 6666,6890,6804,3,0 6667,3293,6825,2,0 6668,6825,2365,1,0 6669,3283,6824,4,2 6670,6799,6821,1,0 6671,6799,6822,4,1 6672,6795,6823,1,0 6673,3247,6891,2,0 6674,6891,6823,3,0 6675,3247,6892,2,1 6676,6892,6823,3,1 6677,3247,6893,2,2 6678,6893,6823,3,2 6679,3247,6894,2,3 6680,6894,6823,3,3 6681,3247,6895,2,4 6682,6895,6823,3,4 6683,3247,6896,2,5 6684,6896,6823,3,5 6685,3247,6897,2,6 6686,6897,6823,3,6 6687,3247,6898,2,7 6688,6898,6823,3,7 6689,3235,6899,2,0 6690,6899,6803,3,0 6691,6823,6900,2,0 6692,6900,3231,3,0 6693,6823,6901,2,1 6694,6901,3231,3,1 6695,6823,6902,2,2 6696,6902,3231,3,2 6697,6823,6903,2,3 6698,6903,3231,3,3 6699,6823,6904,2,4 6700,6904,3231,3,4 6701,6823,6905,2,5 6702,6905,3231,3,5 6703,6823,6906,2,6 6704,6906,3231,3,6 6705,6823,6907,2,7 6706,6907,3231,3,7 6707,3038,3483,3,0 6708,3038,3483,3,0 6709,1805,6908,0,0 6710,2340,6911,1,0 6711,6909,6911,1,0 6712,2341,6912,1,0 6713,6910,6912,1,0 6714,6908,6913,1,0 6715,6908,6914,2,0 6716,2342,2322,1,0 6717,6914,2323,1,0 6718,2676,2270,1,0 6719,3001,2271,1,0 6720,2342,2267,1,0 6721,6911,6909,1,0 6722,6912,6910,1,0 6723,1806,6915,0,0 6724,3004,6917,1,0 6725,6916,6917,1,0 6726,6916,6920,1,0 6727,6917,6920,1,0 6728,6918,6920,1,0 6729,2518,6921,1,0 6730,2518,6921,1,0 6731,6919,6921,1,0 6732,6915,6922,1,0 6733,6915,6923,2,0 6734,2516,2322,1,0 6735,6923,2323,1,0 6736,2676,2270,1,0 6737,3001,2271,1,0 6738,2516,2267,1,0 6739,6920,6918,1,0 6740,6921,6919,1,0 6741,6917,6916,1,0 6742,3610,6924,2,0 6743,3610,6925,2,0 6744,6925,6926,1,0 6745,6929,6933,1,0 6746,6925,6933,1,0 6747,6926,6934,1,0 6748,6932,6934,1,0 6749,3026,6935,1,0 6750,6931,6935,1,0 6751,3610,6928,2,0 6752,6928,6929,1,0 6753,6933,6929,1,0 6754,6928,6930,1,0 6755,6934,6930,1,0 6756,6935,6931,1,0 6757,6930,6932,1,0 6758,6931,6936,1,0 6759,6935,6936,1,0 6760,6936,6937,1,0 6761,6935,6927,1,0 6762,3613,6941,2,0 6763,3618,6942,2,0 6764,3197,6938,2,0 6765,3483,6939,2,0 6766,3483,6940,2,0 6767,3038,3483,3,0 6768,3038,3483,3,0 6769,2345,6943,1,0 6770,6943,6946,1,0 6771,6945,6946,1,0 6772,3026,6947,1,0 6773,6944,6947,1,0 6774,6946,6948,1,0 6775,6951,6948,1,0 6776,6947,6949,1,0 6777,6950,6949,1,0 6778,6949,6950,1,0 6779,6948,6951,1,0 6780,6950,6952,1,0 6781,6950,6944,1,0 6782,2345,6945,1,0 6783,3620,2268,1,0 6784,3130,6953,1,0 6785,6953,6959,1,0 6786,6954,6959,1,0 6787,6955,6959,1,0 6788,6956,6959,1,0 6789,6957,6959,1,0 6790,6958,6959,1,0 6791,6959,2345,1,0 6792,3132,6954,1,0 6793,3134,6955,1,0 6794,3131,2346,1,0 6795,2287,2347,1,0 6796,3130,6957,1,0 6797,3131,2346,1,0 6798,2286,2347,1,0 6799,3133,2346,1,0 6800,2287,2347,1,0 6801,3132,6956,1,0 6802,3133,2346,1,0 6803,2286,2347,1,0 6804,3134,6958,1,0 6805,3135,2346,1,0 6806,2286,2347,1,0 6807,2,2347,3,2 6808,2346,2347,3,3 6809,2,2347,3,4 6810,3613,6971,2,0 6811,6971,2319,1,0 6812,3613,6970,2,0 6813,6970,2319,1,0 6814,3621,6960,1,0 6815,6960,6961,1,0 6816,6965,6962,1,0 6817,6961,6962,1,0 6818,6964,6963,1,0 6819,2346,6963,1,0 6820,6963,6964,1,0 6821,6962,6965,1,0 6822,6969,6966,1,0 6823,2346,6966,1,0 6824,6968,6967,1,0 6825,6961,6967,1,0 6826,6967,6968,1,0 6827,6966,6969,1,0 6828,3074,6972,2,0 6829,3079,6973,2,0 6830,3079,6974,2,0 6831,6980,6983,1,0 6832,6974,6983,1,0 6833,6974,6984,1,0 6834,6981,6984,1,0 6835,6982,6985,1,0 6836,3141,6985,1,0 6837,3074,6986,2,0 6838,3079,6978,2,0 6839,3613,6979,2,0 6840,6979,2319,1,0 6841,3079,6980,2,0 6842,6984,6981,1,0 6843,6985,6982,1,0 6844,3620,2268,1,0 6845,6985,6975,1,0 6846,3074,6976,2,0 6847,6984,6977,1,0 6848,3620,2268,1,0 6849,3135,2346,1,0 6850,2286,2347,1,0 6851,3133,2346,1,0 6852,2286,2347,1,0 6853,3131,2346,1,0 6854,2286,2347,1,0 6855,3613,6987,2,0 6856,6987,2319,1,0 6857,2831,6988,2,0 6858,3618,6989,2,0 6859,6989,6990,1,0 6860,6990,3618,3,0 6861,3613,6991,2,0 6862,6991,6992,1,0 6863,6995,6992,1,0 6864,6990,6993,1,0 6865,6994,6993,1,0 6866,6993,6994,1,0 6867,6992,6995,1,0 6868,6996,6997,1,0 6869,6990,6997,1,0 6870,6997,6998,1,0 6871,6998,6999,1,0 6872,6998,7000,1,0 6873,7001,7000,1,0 6874,7000,7001,1,0 6875,3618,7002,2,0 6876,3618,7003,2,0 6877,7003,2319,1,0 6878,3623,7004,2,0 6879,7004,7005,1,0 6880,2,2348,3,2 6881,7005,2348,3,3 6882,2,2348,3,4 6883,6997,6996,1,0 6884,1171,7006,0,0 6885,7006,7007,2,0 6886,7007,7008,1,0 6887,7007,7009,1,0 6888,3629,7011,1,0 6889,7010,7012,1,0 6890,7011,7012,1,0 6891,7012,2349,1,0 6892,3629,7010,1,0 6893,3630,3623,3,0 6894,2349,7013,1,0 6895,7013,7014,4,2 6896,7013,7015,1,0 6897,3625,7016,1,0 6898,2350,2348,1,0 6899,3623,7017,2,0 6900,7017,7018,4,1 6901,3623,7019,2,0 6902,7019,7020,1,0 6903,3075,7021,2,0 6904,3074,7022,2,0 6905,3631,3623,3,0 6906,2349,7025,1,0 6907,7025,7026,4,2 6908,3635,2268,1,0 6909,1,2269,0,0 6910,3073,7030,2,0 6911,2352,2273,1,0 6912,7030,2274,1,0 6913,2349,7031,1,0 6914,7031,7032,1,0 6915,3074,7033,2,0 6916,7033,3078,3,0 6917,7022,3074,3,0 6918,7021,3075,3,0 6919,2349,7027,1,0 6920,7027,7028,1,0 6921,3637,2268,1,0 6922,3074,7029,2,0 6923,7029,3073,3,0 6924,7029,3072,3,0 6925,3072,7023,2,0 6926,7023,3081,3,0 6927,3072,7024,2,0 6928,7024,3083,3,0 6929,7024,3082,3,0 6930,7041,7034,1,0 6931,3026,7034,1,0 6932,2287,2348,1,0 6933,3623,7035,2,0 6934,7035,7036,4,1 6935,7035,7037,4,2 6936,7037,3638,3,0 6937,3638,7038,2,0 6938,7038,7039,1,0 6939,7039,3638,3,0 6940,7034,7040,1,0 6941,7034,7041,1,0 6942,1807,7042,0,0 6943,1171,7043,0,0 6944,7043,7044,2,0 6945,7044,7045,1,0 6946,7043,7054,2,0 6947,7054,7055,1,0 6948,2349,7056,1,0 6949,7056,3639,3,0 6950,7056,7059,1,0 6951,3640,3623,3,0 6952,7056,7060,4,3 6953,7042,7064,1,0 6954,3026,7065,1,0 6955,7068,7065,1,0 6956,7064,7066,1,0 6957,7067,7066,1,0 6958,7066,7067,1,0 6959,7065,7068,1,0 6960,3072,7069,2,0 6961,7093,7094,1,0 6962,7069,7094,1,0 6963,3073,7095,2,0 6964,3639,7096,2,0 6965,3073,7100,2,0 6966,3072,7101,2,0 6967,7064,7102,1,0 6968,7105,7102,1,0 6969,3026,7103,1,0 6970,7104,7103,1,0 6971,7103,7104,1,0 6972,7102,7105,1,0 6973,2286,2348,1,0 6974,7096,7097,4,2 6975,7096,7098,4,3 6976,7096,7099,4,1 6977,3623,7075,2,0 6978,7075,7076,4,1 6979,7075,7077,1,0 6980,7075,7078,4,2 6981,3026,7079,1,0 6982,7080,7079,1,0 6983,7079,7080,1,0 6984,3626,7082,1,0 6985,7081,7082,1,0 6986,7082,7083,1,0 6987,7081,7083,1,0 6988,7083,7085,1,0 6989,3628,2268,1,0 6990,3639,7086,2,0 6991,7078,3638,3,0 6992,3638,7090,2,0 6993,7090,7091,1,0 6994,7091,3638,3,0 6995,7091,7092,1,0 6996,7094,7093,1,0 6997,2286,2348,1,0 6998,7086,7087,4,2 6999,7086,7088,4,3 7000,7086,7089,4,1 7001,3625,7081,1,0 7002,7083,7084,1,0 7003,3073,7070,2,0 7004,3294,7071,2,0 7005,3072,7072,2,0 7006,3293,7073,2,0 7007,3026,7074,1,0 7008,2287,2348,1,0 7009,7056,7061,4,1 7010,3623,7062,2,0 7011,7062,7063,4,2 7012,7063,3638,3,0 7013,3293,7057,2,0 7014,3294,7058,2,0 7015,2349,7046,1,0 7016,7046,7047,1,0 7017,2349,7048,1,0 7018,7048,7049,1,0 7019,7049,7050,1,0 7020,7052,7050,1,0 7021,7047,7051,1,0 7022,7053,7051,1,0 7023,7050,7052,1,0 7024,7051,7053,1,0 7025,3641,3623,3,0 7026,2349,7106,1,0 7027,7106,7107,4,2 7028,3635,2268,1,0 7029,1,2269,0,0 7030,2353,7108,1,0 7031,7114,7115,1,0 7032,2353,7115,1,0 7033,7109,7111,1,0 7034,7115,7111,1,0 7035,7110,7112,1,0 7036,3026,7112,1,0 7037,7111,7113,1,0 7038,7113,7114,1,0 7039,7111,7109,1,0 7040,7112,7110,1,0 7041,3643,2268,1,0 7042,7115,7116,1,0 7043,2349,7117,1,0 7044,7117,7118,1,0 7045,7119,7120,1,0 7046,7116,7120,1,0 7047,3075,7121,2,0 7048,7116,7119,1,0 7049,3231,7122,2,0 7050,7122,3247,3,0 7051,3231,7123,2,1 7052,7123,3247,3,1 7053,3231,7124,2,2 7054,7124,3247,3,2 7055,3231,7125,2,3 7056,7125,3247,3,3 7057,3231,7126,2,4 7058,7126,3247,3,4 7059,3231,7127,2,5 7060,7127,3247,3,5 7061,3231,7128,2,6 7062,7128,3247,3,6 7063,3231,7129,2,7 7064,7129,3247,3,7 7065,1808,7130,0,0 7066,3652,7131,1,0 7067,2354,7131,1,0 7068,3197,7132,2,0 7069,3483,7133,2,0 7070,7130,7134,1,0 7071,3649,7139,1,0 7072,7150,7139,1,0 7073,3695,7140,1,0 7074,7151,7140,1,0 7075,3890,7141,2,0 7076,7140,7142,1,0 7077,7141,7144,1,0 7078,7143,7144,1,0 7079,7147,7144,1,0 7080,7147,7144,1,0 7081,7148,7144,1,0 7082,7148,7144,1,0 7083,7144,7143,1,0 7084,7144,7145,1,0 7085,7145,7146,1,0 7086,7144,7146,1,0 7087,7139,7149,2,0 7088,7139,7150,1,0 7089,7140,7151,1,0 7090,7141,7152,1,0 7091,3146,7153,1,0 7092,7185,7153,1,0 7093,3646,7154,1,0 7094,7188,7154,1,0 7095,3697,7155,1,0 7096,7189,7155,1,0 7097,7155,7156,1,0 7098,7152,7158,1,0 7099,7157,7158,1,0 7100,7161,7158,1,0 7101,7161,7158,1,0 7102,7162,7158,1,0 7103,7162,7158,1,0 7104,7158,7157,1,0 7105,7158,7159,1,0 7106,7159,7160,1,0 7107,7158,7160,1,0 7108,7184,7185,1,0 7109,7153,7185,1,0 7110,7153,7185,1,0 7111,7153,7186,1,0 7112,7154,7187,2,0 7113,7186,7187,3,0 7114,7154,7188,1,0 7115,7155,7189,1,0 7116,3184,7190,2,0 7117,7190,2282,1,0 7118,3656,2283,1,0 7119,3658,2284,1,0 7120,3256,2285,1,0 7121,3178,7191,2,0 7122,7191,2282,1,0 7123,3660,2283,1,0 7124,3662,2284,1,0 7125,3256,2285,1,0 7126,3181,7192,2,0 7127,7192,2282,1,0 7128,3664,2283,1,0 7129,3666,2284,1,0 7130,3256,2285,1,0 7131,3182,7193,2,0 7132,7193,2282,1,0 7133,3668,2283,1,0 7134,3670,2284,1,0 7135,3256,2285,1,0 7136,3180,7194,2,0 7137,7194,2282,1,0 7138,3672,2283,1,0 7139,3674,2284,1,0 7140,3256,2285,1,0 7141,3154,7195,2,0 7142,3148,7200,2,0 7143,3158,7202,2,0 7144,3175,7204,2,0 7145,3153,7209,2,0 7146,3195,7213,2,0 7147,3147,7214,2,0 7148,3161,7215,2,0 7149,1479,7216,0,0 7150,2421,7216,1,0 7151,7215,2420,1,0 7152,3185,7217,2,0 7153,1479,7218,0,0 7154,2421,7218,1,0 7155,7217,2420,1,0 7156,3188,7219,2,0 7157,1479,7220,0,0 7158,2421,7220,1,0 7159,7219,2420,1,0 7160,3647,7221,2,0 7161,7134,7223,1,0 7162,7222,7223,1,0 7163,7223,7222,1,0 7164,7223,7225,1,0 7165,7225,7226,1,0 7166,7227,7228,1,0 7167,7226,7228,1,0 7168,7228,7227,1,0 7169,7228,7229,1,0 7170,7228,7229,1,0 7171,7228,7229,1,0 7172,7226,7230,1,0 7173,7131,7230,1,0 7174,7131,7230,1,0 7175,2791,2340,1,0 7176,7230,2341,1,0 7177,3683,2342,1,0 7178,3147,7231,2,0 7179,3685,2270,1,0 7180,7131,2271,1,0 7181,3157,7232,2,0 7182,7223,7224,1,0 7183,1479,7210,0,0 7184,2421,7210,1,0 7185,7209,2420,1,0 7186,3153,7211,2,0 7187,1479,7212,0,0 7188,2421,7212,1,0 7189,7211,2420,1,0 7190,3676,2282,1,0 7191,3679,2283,1,0 7192,3681,2284,1,0 7193,3256,2285,1,0 7194,3255,7207,1,0 7195,7207,7208,2,0 7196,3676,2282,1,0 7197,3256,2285,1,0 7198,3176,7205,2,0 7199,2490,3176,3,0 7200,3163,7206,2,0 7201,2490,3163,3,0 7202,3157,7203,2,0 7203,2490,3157,3,0 7204,3147,7201,2,0 7205,2490,3147,3,0 7206,3191,7196,2,0 7207,3190,7197,2,0 7208,3147,7198,2,0 7209,2490,3147,3,0 7210,3157,7199,2,0 7211,2490,3157,3,0 7212,7160,7161,1,0 7213,7160,7162,1,0 7214,7160,7163,1,0 7215,7163,7164,1,0 7216,7164,7180,1,0 7217,7178,7180,1,0 7218,7179,7181,1,0 7219,7153,7181,1,0 7220,7180,7182,1,0 7221,7165,7178,1,0 7222,7166,7178,1,0 7223,7182,7178,1,0 7224,7166,7178,1,0 7225,7176,7178,1,0 7226,7176,7178,1,0 7227,7181,7179,1,0 7228,7180,7166,1,0 7229,3903,7167,1,0 7230,7170,7167,1,0 7231,7167,7168,1,0 7232,7168,7169,1,0 7233,7167,7170,1,0 7234,7167,7171,1,0 7235,1171,7172,0,0 7236,7172,7173,2,0 7237,7173,7174,1,0 7238,7166,7175,1,0 7239,7176,7175,1,0 7240,7175,7176,1,0 7241,7173,7177,1,0 7242,7180,7165,1,0 7243,7181,7183,1,0 7244,7181,7183,1,0 7245,7183,7184,1,0 7246,7146,7147,1,0 7247,7146,7148,1,0 7248,7134,7135,1,0 7249,7137,7135,1,0 7250,3654,7136,1,0 7251,7138,7136,1,0 7252,7135,7137,1,0 7253,7136,7138,1,0 7254,3038,3483,3,0 7255,1809,7233,0,0 7256,1813,7234,0,0 7257,1814,7236,0,0 7258,7233,7237,1,0 7259,7233,7235,4,1 7260,1815,7238,0,0 7261,7238,7239,1,0 7262,7239,7240,1,0 7263,7242,7240,1,0 7264,3070,7241,1,0 7265,7243,7241,1,0 7266,7240,7242,1,0 7267,7241,7243,1,0 7268,3010,7244,2,0 7269,3070,7245,1,0 7270,3070,7245,1,0 7271,7262,7245,1,0 7272,7262,7245,1,0 7273,7262,7245,1,0 7274,7250,7251,1,0 7275,7245,7251,1,0 7276,7251,7252,1,0 7277,7252,7262,1,0 7278,7256,7262,1,0 7279,7261,7262,1,0 7280,3010,7263,2,0 7281,7262,7264,1,0 7282,7262,7264,1,0 7283,3712,2268,1,0 7284,3470,7272,2,0 7285,2,7272,3,2 7286,3483,7273,2,0 7287,3038,3483,3,0 7288,3469,7271,2,0 7289,3714,2304,1,0 7290,3070,2305,1,0 7291,3074,7265,2,0 7292,3079,7266,2,0 7293,2321,7267,1,0 7294,3710,2320,1,0 7295,3469,7268,2,0 7296,3470,7269,2,0 7297,2,7269,3,2 7298,3483,7270,2,0 7299,3038,3483,3,0 7300,7245,7250,1,0 7301,7256,7250,1,0 7302,7261,7250,1,0 7303,3704,2268,1,0 7304,3706,2268,1,0 7305,7239,7255,1,0 7306,7254,7255,1,0 7307,7245,7256,1,0 7308,7253,7256,1,0 7309,7256,7253,1,0 7310,7255,7254,1,0 7311,3390,2268,1,0 7312,3140,7257,1,0 7313,3068,7257,1,0 7314,3068,7257,1,0 7315,3140,7257,1,0 7316,7257,7260,1,0 7317,7259,7260,1,0 7318,7245,7261,1,0 7319,7258,7261,1,0 7320,7261,7258,1,0 7321,7260,7259,1,0 7322,3708,2268,1,0 7323,3010,7246,2,0 7324,3702,7247,1,0 7325,3702,7247,1,0 7326,7248,7247,1,0 7327,7247,7248,1,0 7328,3010,7249,2,0 7329,3700,2268,1,0 7330,1816,7274,0,0 7331,1824,7275,0,0 7332,1832,7276,0,0 7333,1836,7277,0,0 7334,1840,7278,0,0 7335,1844,7279,0,0 7336,1848,7280,0,0 7337,1852,7281,0,0 7338,1856,7282,0,0 7339,1860,7283,0,0 7340,1864,7284,0,0 7341,1872,7285,0,0 7342,1880,7286,0,0 7343,1884,7287,0,0 7344,1888,7288,0,0 7345,1892,7289,0,0 7346,1896,7290,0,0 7347,1904,7291,0,0 7348,1905,7292,0,0 7349,1906,7293,0,0 7350,7292,7294,1,0 7351,7289,7295,1,0 7352,4143,7295,3,0 7353,7289,7296,4,1 7354,7289,7297,4,2 7355,3718,2268,1,0 7356,3040,7314,2,0 7357,7277,7315,1,0 7358,7314,7315,3,0 7359,7277,7316,4,1 7360,7277,7317,4,2 7361,3041,7318,2,0 7362,7279,7319,1,0 7363,7318,7319,3,0 7364,7279,7320,4,1 7365,7279,7321,4,2 7366,3042,7322,2,0 7367,7281,7323,1,0 7368,7322,7323,3,0 7369,7281,7324,4,1 7370,7281,7325,4,2 7371,2818,7329,2,0 7372,2818,7330,2,0 7373,2356,7333,1,0 7374,7290,7334,1,0 7375,7334,7335,2,0 7376,7335,7333,3,0 7377,7334,7336,2,1 7378,7336,7333,3,1 7379,7334,7337,2,2 7380,7337,7333,3,2 7381,7334,7338,2,3 7382,7338,7333,3,3 7383,7334,7339,2,4 7384,7339,7333,3,4 7385,7334,7340,2,5 7386,7340,7333,3,5 7387,7334,7341,2,6 7388,7341,7333,3,6 7389,7334,7342,2,7 7390,7342,7333,3,7 7391,7291,7331,1,0 7392,7291,7332,1,0 7393,7283,7326,1,0 7394,7283,7327,4,1 7395,7283,7328,4,2 7396,7291,7312,1,0 7397,7291,7313,1,0 7398,7291,7310,1,0 7399,7291,7311,1,0 7400,7291,7304,1,0 7401,3716,2268,1,0 7402,7275,7305,1,0 7403,7290,7306,1,0 7404,7306,7343,2,0 7405,7343,7305,3,0 7406,7306,7344,2,1 7407,7344,7305,3,1 7408,7306,7345,2,2 7409,7345,7305,3,2 7410,7306,7346,2,3 7411,7346,7305,3,3 7412,7306,7347,2,4 7413,7347,7305,3,4 7414,7306,7348,2,5 7415,7348,7305,3,5 7416,7306,7349,2,6 7417,7349,7305,3,6 7418,7306,7350,2,7 7419,7350,7305,3,7 7420,7274,7307,1,0 7421,3231,7351,2,0 7422,7351,7307,3,0 7423,3231,7352,2,1 7424,7352,7307,3,1 7425,3231,7353,2,2 7426,7353,7307,3,2 7427,3231,7354,2,3 7428,7354,7307,3,3 7429,3231,7355,2,4 7430,7355,7307,3,4 7431,3231,7356,2,5 7432,7356,7307,3,5 7433,3231,7357,2,6 7434,7357,7307,3,6 7435,3231,7358,2,7 7436,7358,7307,3,7 7437,7305,7359,2,0 7438,7359,3231,3,0 7439,7305,7360,2,1 7440,7360,3231,3,1 7441,7305,7361,2,2 7442,7361,3231,3,2 7443,7305,7362,2,3 7444,7362,3231,3,3 7445,7305,7363,2,4 7446,7363,3231,3,4 7447,7305,7364,2,5 7448,7364,3231,3,5 7449,7305,7365,2,6 7450,7365,3231,3,6 7451,7305,7366,2,7 7452,7366,3231,3,7 7453,7293,7308,1,0 7454,7307,7367,2,0 7455,7367,7308,3,0 7456,7307,7368,2,1 7457,7368,7308,3,1 7458,7307,7369,2,2 7459,7369,7308,3,2 7460,7307,7370,2,3 7461,7370,7308,3,3 7462,7307,7371,2,4 7463,7371,7308,3,4 7464,7307,7372,2,5 7465,7372,7308,3,5 7466,7307,7373,2,6 7467,7373,7308,3,6 7468,7307,7374,2,7 7469,7374,7308,3,7 7470,7293,7309,4,5 7471,7309,7375,2,0 7472,7375,7294,3,0 7473,7285,7301,1,0 7474,3247,7376,2,0 7475,7376,7301,3,0 7476,3247,7377,2,1 7477,7377,7301,3,1 7478,3247,7378,2,2 7479,7378,7301,3,2 7480,3247,7379,2,3 7481,7379,7301,3,3 7482,3247,7380,2,4 7483,7380,7301,3,4 7484,3247,7381,2,5 7485,7381,7301,3,5 7486,3247,7382,2,6 7487,7382,7301,3,6 7488,3247,7383,2,7 7489,7383,7301,3,7 7490,7284,7302,1,0 7491,3231,7384,2,0 7492,7384,7302,3,0 7493,3231,7385,2,1 7494,7385,7302,3,1 7495,3231,7386,2,2 7496,7386,7302,3,2 7497,3231,7387,2,3 7498,7387,7302,3,3 7499,3231,7388,2,4 7500,7388,7302,3,4 7501,3231,7389,2,5 7502,7389,7302,3,5 7503,3231,7390,2,6 7504,7390,7302,3,6 7505,3231,7391,2,7 7506,7391,7302,3,7 7507,7301,7392,2,0 7508,7392,3231,3,0 7509,7301,7393,2,1 7510,7393,3231,3,1 7511,7301,7394,2,2 7512,7394,3231,3,2 7513,7301,7395,2,3 7514,7395,3231,3,3 7515,7301,7396,2,4 7516,7396,3231,3,4 7517,7301,7397,2,5 7518,7397,3231,3,5 7519,7301,7398,2,6 7520,7398,3231,3,6 7521,7301,7399,2,7 7522,7399,3231,3,7 7523,7290,7303,1,0 7524,7302,7400,2,0 7525,7400,7303,3,0 7526,7302,7401,2,1 7527,7401,7303,3,1 7528,7302,7402,2,2 7529,7402,7303,3,2 7530,7302,7403,2,3 7531,7403,7303,3,3 7532,7302,7404,2,4 7533,7404,7303,3,4 7534,7302,7405,2,5 7535,7405,7303,3,5 7536,7302,7406,2,6 7537,7406,7303,3,6 7538,7302,7407,2,7 7539,7407,7303,3,7 7540,7287,7298,1,0 7541,7287,7299,4,1 7542,7287,7300,4,2 7543,1914,7408,0,0 7544,1922,7409,0,0 7545,1930,7410,0,0 7546,1934,7411,0,0 7547,1938,7412,0,0 7548,1939,7413,0,0 7549,7412,7414,1,0 7550,3483,7423,2,0 7551,3038,3483,3,0 7552,7409,7418,1,0 7553,2359,7419,1,0 7554,7419,7424,2,0 7555,7424,7418,3,0 7556,7419,7425,2,1 7557,7425,7418,3,1 7558,7419,7426,2,2 7559,7426,7418,3,2 7560,7419,7427,2,3 7561,7427,7418,3,3 7562,7419,7428,2,4 7563,7428,7418,3,4 7564,7419,7429,2,5 7565,7429,7418,3,5 7566,7419,7430,2,6 7567,7430,7418,3,6 7568,7419,7431,2,7 7569,7431,7418,3,7 7570,7408,7420,1,0 7571,3231,7432,2,0 7572,7432,7420,3,0 7573,3231,7433,2,1 7574,7433,7420,3,1 7575,3231,7434,2,2 7576,7434,7420,3,2 7577,3231,7435,2,3 7578,7435,7420,3,3 7579,3231,7436,2,4 7580,7436,7420,3,4 7581,3231,7437,2,5 7582,7437,7420,3,5 7583,3231,7438,2,6 7584,7438,7420,3,6 7585,3231,7439,2,7 7586,7439,7420,3,7 7587,7418,7440,2,0 7588,7440,3231,3,0 7589,7418,7441,2,1 7590,7441,3231,3,1 7591,7418,7442,2,2 7592,7442,3231,3,2 7593,7418,7443,2,3 7594,7443,3231,3,3 7595,7418,7444,2,4 7596,7444,3231,3,4 7597,7418,7445,2,5 7598,7445,3231,3,5 7599,7418,7446,2,6 7600,7446,3231,3,6 7601,7418,7447,2,7 7602,7447,3231,3,7 7603,7413,7421,1,0 7604,7420,7448,2,0 7605,7448,7421,3,0 7606,7420,7449,2,1 7607,7449,7421,3,1 7608,7420,7450,2,2 7609,7450,7421,3,2 7610,7420,7451,2,3 7611,7451,7421,3,3 7612,7420,7452,2,4 7613,7452,7421,3,4 7614,7420,7453,2,5 7615,7453,7421,3,5 7616,7420,7454,2,6 7617,7454,7421,3,6 7618,7420,7455,2,7 7619,7455,7421,3,7 7620,7413,7422,4,5 7621,7422,7456,2,0 7622,7456,7414,3,0 7623,7411,7415,1,0 7624,2339,7415,3,0 7625,7411,7416,4,1 7626,7411,7417,4,2 7627,1947,7457,0,0 7628,1951,7458,0,0 7629,1955,7459,0,0 7630,1975,7460,0,0 7631,3074,7461,2,0 7632,3079,7462,2,0 7633,7460,2356,1,0 7634,2669,2357,1,0 7635,3070,2358,1,0 7636,7460,2359,1,0 7637,3074,7473,2,0 7638,3079,7474,2,0 7639,3073,7472,2,0 7640,2291,2273,1,0 7641,7472,2274,1,0 7642,7459,7471,4,10 7643,3073,7469,2,0 7644,7469,7470,1,0 7645,7470,3083,3,0 7646,7470,3082,3,0 7647,3072,7466,2,0 7648,7466,7467,1,0 7649,7467,3073,3,0 7650,3072,7468,2,0 7651,7468,3081,3,0 7652,7458,7463,1,0 7653,4143,7463,3,0 7654,7458,7464,4,1 7655,7458,7465,4,2 7656,3727,2268,1,0 7657,3718,2268,1,0 7658,1983,7475,0,0 7659,7475,7476,1,0 7660,1984,7477,0,0 7661,1988,7478,0,0 7662,1992,7479,0,0 7663,1996,7480,0,0 7664,2000,7481,0,0 7665,2008,7482,0,0 7666,7482,7483,1,0 7667,7480,7485,1,0 7668,2363,7485,3,0 7669,7480,7486,4,1 7670,7480,7487,4,2 7671,3010,7488,2,0 7672,3010,7489,2,0 7673,3110,2314,1,0 7674,3111,7490,1,0 7675,7492,7490,1,0 7676,3099,7491,1,0 7677,7493,7491,1,0 7678,7490,7492,1,0 7679,7491,7493,1,0 7680,3075,7494,2,0 7681,7494,2315,1,0 7682,3740,2268,1,0 7683,3514,7495,2,0 7684,7495,7496,1,0 7685,7498,7499,1,0 7686,7496,7499,1,0 7687,7495,7499,1,0 7688,7495,7499,1,0 7689,3078,7501,2,0 7690,7501,3077,3,0 7691,3074,7502,2,0 7692,3076,7503,2,0 7693,7503,2330,1,0 7694,7502,2331,1,0 7695,3074,7504,2,0 7696,7504,3078,3,0 7697,7483,2361,1,0 7698,2407,3469,3,0 7699,7481,2306,1,0 7700,3075,7505,2,0 7701,7505,2413,1,0 7702,2333,7507,1,0 7703,7507,3294,3,0 7704,3026,3293,3,0 7705,2605,2993,3,0 7706,7481,2360,1,0 7707,7478,7508,1,0 7708,7478,7509,4,1 7709,7478,7510,4,2 7710,2332,7506,1,0 7711,7506,3294,3,0 7712,7499,3294,3,0 7713,3883,7500,2,0 7714,3075,7497,2,0 7715,2333,7498,1,0 7716,3075,7484,2,0 7717,7484,3073,3,0 7718,7484,3072,3,0 7719,3742,2268,1,0 7720,3074,7511,2,0 7721,3079,7512,2,0 7722,3073,7513,2,0 7723,7513,3075,3,0 7724,3744,2268,1,0 7725,2360,2307,1,0 7726,2300,3469,3,0 7727,3483,7514,2,0 7728,3074,7515,2,0 7729,3079,7516,2,0 7730,3038,3483,3,0 7731,3074,7517,2,0 7732,3079,7518,2,0 7733,2490,3834,3,0 7734,3075,7519,2,0 7735,2388,2273,1,0 7736,7519,2274,1,0 7737,3076,7520,2,0 7738,7520,3073,3,0 7739,7520,3072,3,0 7740,3073,7521,2,0 7741,3076,7522,2,0 7742,7522,3073,3,0 7743,2009,7523,0,0 7744,2013,7524,0,0 7745,3077,7528,2,0 7746,7528,3078,3,0 7747,3079,7529,2,0 7748,7529,3081,3,0 7749,3076,7530,2,0 7750,7530,3082,3,0 7751,3074,7531,2,0 7752,7531,7532,1,0 7753,7532,3083,3,0 7754,3084,7533,2,0 7755,7529,7534,1,0 7756,7534,3084,3,0 7757,7524,7525,1,0 7758,2338,7525,3,0 7759,7524,7526,4,1 7760,7524,7527,4,2 7761,3758,2268,1,0 7762,2017,7535,0,0 7763,2021,7536,0,0 7764,2993,7537,2,0 7765,3760,2270,1,0 7766,7537,2271,1,0 7767,3762,2268,1,0 7768,3764,2268,1,0 7769,2361,3292,3,0 7770,2361,7538,1,0 7771,7539,7538,1,0 7772,7538,7539,1,0 7773,3290,7540,1,0 7774,7542,7543,1,0 7775,2361,7543,1,0 7776,7543,7545,1,0 7777,7545,7546,1,0 7778,7546,3297,3,0 7779,7536,7547,1,0 7780,2362,7547,3,0 7781,7536,7548,4,1 7782,7536,7549,4,2 7783,3290,7544,1,0 7784,3290,7541,1,0 7785,7543,7541,3,0 7786,7543,7542,1,0 7787,2025,7550,0,0 7788,2029,7551,0,0 7789,7551,7552,1,0 7790,2362,7552,3,0 7791,7551,7553,4,1 7792,7551,7554,4,2 7793,3038,3483,3,0 7794,3601,7555,1,0 7795,7555,2268,1,0 7796,3038,3483,3,0 7797,2033,7556,0,0 7798,2034,7557,0,0 7799,7556,7558,1,0 7800,7557,7559,1,0 7801,3247,7560,2,0 7802,7560,7559,3,0 7803,3247,7561,2,1 7804,7561,7559,3,1 7805,3247,7562,2,2 7806,7562,7559,3,2 7807,3247,7563,2,3 7808,7563,7559,3,3 7809,3247,7564,2,4 7810,7564,7559,3,4 7811,3247,7565,2,5 7812,7565,7559,3,5 7813,3247,7566,2,6 7814,7566,7559,3,6 7815,3247,7567,2,7 7816,7567,7559,3,7 7817,3235,7568,2,0 7818,7568,7558,3,0 7819,7559,7569,2,0 7820,7569,3231,3,0 7821,7559,7570,2,1 7822,7570,3231,3,1 7823,7559,7571,2,2 7824,7571,3231,3,2 7825,7559,7572,2,3 7826,7572,3231,3,3 7827,7559,7573,2,4 7828,7573,3231,3,4 7829,7559,7574,2,5 7830,7574,3231,3,5 7831,7559,7575,2,6 7832,7575,3231,3,6 7833,7559,7576,2,7 7834,7576,3231,3,7 7835,3283,7577,1,0 7836,3283,7578,1,0 7837,7585,7586,1,0 7838,7578,7586,1,0 7839,3471,7587,2,0 7840,3029,2327,1,0 7841,3470,7589,2,0 7842,3283,7590,1,0 7843,3283,7591,4,1 7844,3283,7592,4,2 7845,3079,7593,2,0 7846,3283,7594,1,0 7847,3283,7595,1,0 7848,3283,7588,4,2 7849,7586,7579,1,0 7850,7586,7580,1,0 7851,7586,7581,4,1 7852,7586,7582,4,1 7853,7586,7583,4,2 7854,7586,7584,4,2 7855,7586,7585,1,0 7856,3766,2268,1,0 7857,3283,7596,4,1 7858,3029,2327,1,0 7859,3470,7598,2,0 7860,3283,7599,4,2 7861,7599,7600,1,0 7862,7597,7600,1,0 7863,3283,7601,1,0 7864,3471,7602,2,0 7865,2,7602,3,2 7866,3470,7603,2,0 7867,3029,2327,1,0 7868,3470,7604,2,0 7869,3283,7597,4,2 7870,3283,7605,1,0 7871,3283,7606,4,1 7872,3283,7607,1,0 7873,3147,7608,2,0 7874,3157,7609,2,0 7875,3283,7610,1,0 7876,3150,7611,2,0 7877,3195,7613,2,0 7878,3147,7617,2,0 7879,3283,7636,1,0 7880,3283,7637,1,0 7881,3283,7638,1,0 7882,3283,7639,4,2 7883,7636,7648,1,0 7884,7645,7648,1,0 7885,7648,7643,1,0 7886,7648,7644,4,1 7887,7648,7645,1,0 7888,7648,7646,1,0 7889,7648,7647,4,2 7890,3148,7618,2,0 7891,3154,7621,2,0 7892,3147,7631,2,0 7893,3147,7632,2,0 7894,3470,7633,2,0 7895,2,7633,3,2 7896,3283,7634,1,0 7897,3283,7635,1,0 7898,7634,7642,1,0 7899,7641,7642,1,0 7900,7642,7640,1,0 7901,7642,7641,1,0 7902,3147,7622,2,0 7903,3191,7623,2,0 7904,3154,7624,2,0 7905,1479,7625,0,0 7906,2421,7625,1,0 7907,7624,2420,1,0 7908,3190,7626,2,0 7909,3195,7627,2,0 7910,3154,7628,2,0 7911,1479,7629,0,0 7912,2421,7629,1,0 7913,7628,2420,1,0 7914,3190,7630,2,0 7915,1479,7620,0,0 7916,2421,7620,1,0 7917,7618,2420,1,0 7918,3147,7619,2,0 7919,3195,7614,2,0 7920,3470,7615,2,0 7921,2,7615,3,2 7922,3151,7616,2,0 7923,3150,7612,2,0 7924,2042,7649,0,0 7925,7649,7650,1,0 7926,3290,7651,1,0 7927,7654,7651,1,0 7928,7650,7652,1,0 7929,7653,7652,1,0 7930,7652,7653,1,0 7931,7651,7654,1,0 7932,7649,7658,1,0 7933,7658,7659,2,0 7934,3290,7660,1,0 7935,7659,7660,3,0 7936,7659,7661,1,0 7937,7662,7661,1,0 7938,7661,7662,1,0 7939,7649,7655,1,0 7940,7655,7656,2,0 7941,3290,7657,1,0 7942,7656,7657,3,0 7943,2043,7663,0,0 7944,7663,7664,1,0 7945,3290,7665,1,0 7946,7668,7665,1,0 7947,7664,7666,1,0 7948,7667,7666,1,0 7949,7666,7667,1,0 7950,7665,7668,1,0 7951,3283,7677,1,0 7952,7663,7672,1,0 7953,7672,7673,2,0 7954,3290,7674,1,0 7955,7673,7674,3,0 7956,7673,7675,1,0 7957,7676,7675,1,0 7958,7675,7676,1,0 7959,7663,7669,1,0 7960,7669,7670,2,0 7961,3290,7671,1,0 7962,7670,7671,3,0 7963,3768,2268,1,0 7964,3193,7680,2,0 7965,3291,7682,2,0 7966,7682,7683,1,0 7967,7684,7683,1,0 7968,7683,7684,1,0 7969,3193,7681,2,0 7970,3194,7678,2,0 7971,3192,7679,2,0 7972,3283,7685,1,0 7973,3283,7694,1,0 7974,3283,7695,4,1 7975,3283,7696,1,0 7976,3283,7692,1,0 7977,3283,7693,4,1 7978,3283,7686,1,0 7979,3283,7687,1,0 7980,3283,7688,4,1 7981,3283,7689,4,1 7982,3283,7690,4,2 7983,3283,7691,4,2 7984,3074,7697,2,0 7985,3079,7698,2,0 7986,3075,7699,2,0 7987,7699,2412,1,0 7988,3079,7700,2,0 7989,3770,2268,1,0 7990,2333,7702,1,0 7991,7702,3294,3,0 7992,3026,3293,3,0 7993,2332,7701,1,0 7994,7701,3294,3,0 7995,2365,3294,3,0 7996,3075,7703,2,0 7997,3283,7704,1,0 7998,3283,7705,1,0 7999,3283,7708,1,0 8000,2333,7712,1,0 8001,7712,3294,3,0 8002,3026,3293,3,0 8003,2332,7711,1,0 8004,7711,3294,3,0 8005,2365,3294,3,0 8006,3075,7706,2,0 8007,7706,7707,1,0 8008,7707,3075,3,0 8009,3283,7709,1,0 8010,7709,7710,1,0 8011,3277,7710,1,0 8012,2044,7713,0,0 8013,3772,2268,1,0 8014,7713,7714,1,0 8015,3026,7715,1,0 8016,7718,7715,1,0 8017,7714,7716,1,0 8018,7717,7716,1,0 8019,7716,7717,1,0 8020,7715,7718,1,0 8021,3075,7719,2,0 8022,7719,7720,1,0 8023,7720,7722,1,0 8024,7721,7722,1,0 8025,3283,7723,1,0 8026,7722,7721,1,0 8027,7722,7724,1,0 8028,7722,7724,1,0 8029,7724,7740,1,0 8030,7739,7740,1,0 8031,7735,7741,1,0 8032,7740,7741,1,0 8033,7740,7741,1,0 8034,7747,7748,1,0 8035,7741,7748,1,0 8036,7741,7748,1,0 8037,7714,7749,1,0 8038,7714,7749,1,0 8039,7752,7749,1,0 8040,3026,7750,1,0 8041,3026,7750,1,0 8042,7751,7750,1,0 8043,7750,7751,1,0 8044,7749,7752,1,0 8045,7748,2403,1,0 8046,7741,7745,1,0 8047,7744,7745,1,0 8048,3074,7746,2,0 8049,7745,7747,1,0 8050,7745,7747,1,0 8051,7745,7747,1,0 8052,3029,2327,1,0 8053,3470,7742,2,0 8054,7745,2364,1,0 8055,3283,7743,4,1 8056,7745,7744,1,0 8057,7714,7725,1,0 8058,7728,7725,1,0 8059,3026,7726,1,0 8060,7727,7726,1,0 8061,7726,7727,1,0 8062,7725,7728,1,0 8063,3283,7729,1,0 8064,3283,7730,1,0 8065,3283,7732,4,2 8066,3283,7737,4,1 8067,7729,7738,1,0 8068,7737,7738,1,0 8069,7740,7739,1,0 8070,3029,2327,1,0 8071,3470,7733,2,0 8072,3283,7734,4,1 8073,3079,7736,2,0 8074,7740,7735,1,0 8075,3150,7731,2,0 8076,2045,7753,0,0 8077,3157,7754,2,0 8078,3283,7755,4,2 8079,3158,7756,2,0 8080,3154,7759,2,0 8081,3157,7769,2,0 8082,7753,7770,1,0 8083,3290,7771,1,0 8084,7774,7771,1,0 8085,7770,7772,1,0 8086,7773,7772,1,0 8087,7772,7773,1,0 8088,7771,7774,1,0 8089,3283,7783,1,0 8090,7753,7778,1,0 8091,7778,7779,2,0 8092,3290,7780,1,0 8093,7779,7780,3,0 8094,7779,7781,1,0 8095,7782,7781,1,0 8096,7781,7782,1,0 8097,7753,7775,1,0 8098,7775,7776,2,0 8099,3290,7777,1,0 8100,7776,7777,3,0 8101,3157,7760,2,0 8102,3191,7761,2,0 8103,3154,7762,2,0 8104,1479,7763,0,0 8105,2421,7763,1,0 8106,7762,2420,1,0 8107,3153,7764,2,0 8108,1479,7765,0,0 8109,2421,7765,1,0 8110,7764,2420,1,0 8111,3154,7766,2,0 8112,1479,7767,0,0 8113,2421,7767,1,0 8114,7766,2420,1,0 8115,3190,7768,2,0 8116,1479,7758,0,0 8117,2421,7758,1,0 8118,7756,2420,1,0 8119,3157,7757,2,0 8120,2046,7784,0,0 8121,7784,7785,1,0 8122,3026,7786,1,0 8123,7789,7786,1,0 8124,7785,7787,1,0 8125,7788,7787,1,0 8126,7787,7788,1,0 8127,7786,7789,1,0 8128,3286,7791,1,0 8129,7790,7791,1,0 8130,7791,7792,1,0 8131,7791,7790,1,0 8132,7791,7793,1,0 8133,7791,7793,1,0 8134,7793,7794,1,0 8135,7810,7794,1,0 8136,7794,7795,1,0 8137,7794,7796,1,0 8138,7785,7813,1,0 8139,7785,7813,1,0 8140,7785,7813,1,0 8141,7816,7813,1,0 8142,3026,7814,1,0 8143,3026,7814,1,0 8144,3026,7814,1,0 8145,7815,7814,1,0 8146,7814,7815,1,0 8147,7813,7816,1,0 8148,7785,7798,1,0 8149,7801,7798,1,0 8150,3026,7799,1,0 8151,7800,7799,1,0 8152,7799,7800,1,0 8153,7798,7801,1,0 8154,3075,7807,2,0 8155,3079,7808,2,0 8156,7794,7809,4,1 8157,7794,7810,1,0 8158,7794,7804,4,2 8159,3029,2327,1,0 8160,3470,7805,2,0 8161,7794,7806,4,1 8162,3075,7802,2,0 8163,7802,7803,1,0 8164,7794,7797,4,2 8165,3075,7811,2,0 8166,7811,7812,1,0 8167,7812,2403,1,0 8168,3471,7838,2,0 8169,3283,7839,4,2 8170,3283,7819,4,2 8171,3147,7817,2,0 8172,3147,7826,2,0 8173,3283,7834,1,0 8174,3283,7835,1,0 8175,3283,7836,4,1 8176,3283,7837,4,2 8177,3283,7828,1,0 8178,3283,7829,1,0 8179,3283,7830,4,1 8180,3283,7831,4,1 8181,3283,7832,4,2 8182,3283,7833,4,2 8183,3157,7827,2,0 8184,3283,7820,1,0 8185,3283,7821,1,0 8186,3283,7822,4,1 8187,3283,7823,4,1 8188,3283,7824,4,2 8189,3283,7825,4,2 8190,3157,7818,2,0 8191,3471,7840,2,0 8192,3075,7841,2,0 8193,3079,7842,2,0 8194,3200,7843,2,0 8195,2047,7844,0,0 8196,2048,7845,0,0 8197,2049,7846,0,0 8198,3337,7847,2,0 8199,3340,7850,2,0 8200,3483,7855,2,0 8201,3259,7857,4,2 8202,7857,7858,2,0 8203,3774,7859,1,0 8204,7859,7860,2,0 8205,3775,7861,1,0 8206,7861,7862,2,0 8207,3777,7866,1,0 8208,3776,7867,1,0 8209,3776,7868,1,0 8210,3778,7869,1,0 8211,7869,7870,1,0 8212,3776,7873,1,0 8213,7873,7861,3,0 8214,3776,7874,1,0 8215,7874,7859,3,0 8216,7847,7879,1,0 8217,7850,7880,1,0 8218,7886,7887,1,0 8219,3785,7887,1,0 8220,7887,7884,1,0 8221,7884,7885,1,0 8222,7887,7886,1,0 8223,1171,7881,0,0 8224,7881,7882,2,0 8225,7882,7883,1,0 8226,1171,7876,0,0 8227,7876,7877,2,0 8228,7877,7878,1,0 8229,1092,7875,0,0 8230,3782,2268,1,0 8231,3776,7872,1,0 8232,3777,7871,1,0 8233,3776,7863,1,0 8234,7862,7864,1,0 8235,3776,7865,1,0 8236,3259,7856,4,4 8237,3038,3483,3,0 8238,7847,7851,1,0 8239,7850,7852,1,0 8240,7846,2293,1,0 8241,7852,2294,1,0 8242,3340,7853,2,0 8243,7853,7854,1,0 8244,7854,3340,3,0 8245,7847,7848,1,0 8246,7848,7849,1,0 8247,7849,3337,3,0 8248,2050,7888,0,0 8249,3293,7889,2,0 8250,3470,7890,2,0 8251,2,7890,3,2 8252,3026,3293,3,0 8253,3075,7895,2,0 8254,7895,2413,1,0 8255,2333,7897,1,0 8256,7897,3294,3,0 8257,3026,3293,3,0 8258,2332,7896,1,0 8259,7896,3294,3,0 8260,7889,3294,3,0 8261,3310,3337,3,0 8262,3471,7891,2,0 8263,2299,3471,3,0 8264,2387,7892,1,0 8265,3005,2385,1,0 8266,7888,2386,1,0 8267,3469,7893,2,0 8268,3470,7894,2,0 8269,2,7894,3,2 8270,7891,3471,3,0 8271,7889,3293,3,0 8272,3337,7898,2,0 8273,3340,7899,2,0 8274,3324,7900,2,0 8275,3347,7901,1,0 8276,7904,7901,1,0 8277,3322,7902,1,0 8278,7903,7902,1,0 8279,7902,7903,1,0 8280,7901,7904,1,0 8281,7906,7905,1,0 8282,2366,7905,1,0 8283,7905,7906,1,0 8284,7907,7908,1,0 8285,2366,7908,1,0 8286,7908,7909,1,0 8287,7909,2373,1,0 8288,2367,2374,1,0 8289,7908,7907,1,0 8290,3332,7910,2,0 8291,3470,7911,2,0 8292,2,7911,3,2 8293,3331,7912,2,0 8294,3331,7913,2,0 8295,7914,7915,1,0 8296,7913,7915,1,0 8297,7915,7916,1,0 8298,7916,7917,1,0 8299,3470,7919,2,0 8300,2,7919,3,2 8301,3470,7918,2,0 8302,2,7918,3,2 8303,7915,7914,1,0 8304,3200,7920,2,0 8305,2051,7921,0,0 8306,2052,7922,0,0 8307,2056,7923,0,0 8308,2060,7924,0,0 8309,2064,7925,0,0 8310,2068,7926,0,0 8311,2072,7927,0,0 8312,2076,7928,0,0 8313,2077,7929,0,0 8314,7929,7930,1,0 8315,7929,7931,1,0 8316,7927,7932,1,0 8317,7927,7933,4,1 8318,7927,7934,4,2 8319,7926,7935,1,0 8320,7925,7936,1,0 8321,7925,7937,4,1 8322,7925,7938,4,2 8323,7923,7939,1,0 8324,7923,7940,4,1 8325,7923,7941,4,2 8326,2369,7959,4,2 8327,7959,7960,2,0 8328,7959,7961,1,0 8329,7928,7962,1,0 8330,7931,7963,1,0 8331,7966,7963,1,0 8332,7962,7964,1,0 8333,7965,7964,1,0 8334,7964,7965,1,0 8335,7963,7966,1,0 8336,7962,2370,1,0 8337,2369,7942,4,1 8338,7942,7943,2,0 8339,7953,7955,1,0 8340,7943,7955,1,0 8341,7954,7956,1,0 8342,7930,7956,1,0 8343,7959,7957,1,0 8344,7957,7958,2,0 8345,7958,2370,1,0 8346,7959,7946,1,0 8347,7921,7947,1,0 8348,7947,7948,1,0 8349,7950,7948,1,0 8350,7931,7949,1,0 8351,7951,7949,1,0 8352,7948,7950,1,0 8353,7949,7951,1,0 8354,7947,2370,1,0 8355,7956,7952,1,0 8356,7955,7953,1,0 8357,7956,7954,1,0 8358,2371,7932,3,0 8359,7935,7944,2,0 8360,7944,7945,1,0 8361,4144,7945,1,0 8362,7945,7936,3,0 8363,2371,7939,3,0 8364,2078,7967,0,0 8365,3340,7968,2,0 8366,3791,2268,1,0 8367,3340,7969,2,0 8368,3339,7972,1,0 8369,3340,7973,2,0 8370,3339,3340,3,0 8371,7967,7974,1,0 8372,3339,7975,1,0 8373,7967,7970,1,0 8374,7970,7971,1,0 8375,1171,7976,0,0 8376,7976,7977,2,0 8377,7977,7978,1,0 8378,2079,7979,0,0 8379,2080,7980,0,0 8380,2081,7981,0,0 8381,2082,7982,0,0 8382,2083,7983,0,0 8383,2084,7984,0,0 8384,2085,7985,0,0 8385,2086,7986,0,0 8386,2087,7987,0,0 8387,2088,7988,0,0 8388,3013,7989,2,0 8389,8271,8300,1,0 8390,8271,8300,1,0 8391,8271,8300,1,0 8392,8272,8301,1,0 8393,8272,8301,1,0 8394,8272,8301,1,0 8395,7987,8302,1,0 8396,7983,8303,1,0 8397,7983,8304,1,0 8398,3200,8328,2,0 8399,1171,8000,0,0 8400,8000,8001,2,0 8401,8001,8002,1,0 8402,1171,7997,0,0 8403,7997,7998,2,0 8404,7998,7999,1,0 8405,3256,2369,1,0 8406,3347,3324,3,0 8407,3337,8006,2,0 8408,3348,3324,3,0 8409,3348,8007,1,0 8410,3347,8007,1,0 8411,8007,8173,1,0 8412,3200,8174,2,0 8413,3013,8175,2,0 8414,3340,8177,2,0 8415,3038,3483,3,0 8416,3601,8176,1,0 8417,8176,2268,1,0 8418,8007,8062,1,0 8419,3076,8063,2,0 8420,8063,8064,1,0 8421,3075,8065,2,0 8422,8065,8066,1,0 8423,3079,8067,2,0 8424,8066,3075,3,0 8425,8007,8036,1,0 8426,2333,8038,1,0 8427,8038,8039,1,0 8428,8037,8039,1,0 8429,8039,3294,3,0 8430,3026,3293,3,0 8431,2332,8037,1,0 8432,8007,8040,1,0 8433,3074,8041,2,0 8434,3079,8042,2,0 8435,3075,8043,2,0 8436,3293,8044,2,0 8437,2333,8046,1,0 8438,8046,3294,3,0 8439,3026,3293,3,0 8440,2332,8045,1,0 8441,8045,3294,3,0 8442,8044,3294,3,0 8443,8007,8058,1,0 8444,3075,8059,2,0 8445,8059,8060,1,0 8446,3074,8061,2,0 8447,8060,3075,3,0 8448,8007,8224,1,0 8449,3010,8225,2,0 8450,2583,3010,3,0 8451,8179,8226,1,0 8452,8223,8226,1,0 8453,8206,8226,1,0 8454,8221,8226,1,0 8455,8229,8226,1,0 8456,8225,8226,1,0 8457,3075,8227,2,0 8458,8300,8240,1,0 8459,8300,8240,1,0 8460,8301,8241,1,0 8461,8301,8241,1,0 8462,8231,8242,1,0 8463,8227,8242,1,0 8464,7991,8242,1,0 8465,8234,8243,1,0 8466,8226,8243,1,0 8467,7990,8243,1,0 8468,7988,8244,1,0 8469,7988,8245,1,0 8470,8262,8246,1,0 8471,8240,8246,1,0 8472,8263,8247,1,0 8473,8241,8247,1,0 8474,3471,8249,2,0 8475,3470,8250,2,0 8476,3075,8251,2,0 8477,3079,8252,2,0 8478,3074,8253,2,0 8479,3076,8254,2,0 8480,8254,3075,3,0 8481,8250,8262,1,0 8482,8250,8262,1,0 8483,8250,8262,1,0 8484,8246,8262,1,0 8485,8249,8263,1,0 8486,8249,8263,1,0 8487,8249,8263,1,0 8488,8247,8263,1,0 8489,8263,3471,3,0 8490,8262,3470,3,0 8491,3010,8264,2,0 8492,8263,8265,1,0 8493,8263,8265,1,0 8494,8262,8266,1,0 8495,8262,8266,1,0 8496,8243,3010,3,0 8497,3075,8267,2,0 8498,3079,8268,2,0 8499,8266,8271,1,0 8500,8300,8271,1,0 8501,8266,8271,1,0 8502,8265,8272,1,0 8503,8301,8272,1,0 8504,8265,8272,1,0 8505,8242,8273,1,0 8506,8231,8273,1,0 8507,8242,8273,1,0 8508,3075,8274,2,0 8509,3078,8275,2,0 8510,3077,8276,2,0 8511,3074,8277,2,0 8512,3079,8278,2,0 8513,8275,3077,3,0 8514,3076,8279,2,0 8515,8279,2330,1,0 8516,8277,2331,1,0 8517,3074,8280,2,0 8518,8280,3078,3,0 8519,3079,8281,2,0 8520,7988,8282,1,0 8521,3290,8283,1,0 8522,8283,8284,2,0 8523,8284,8285,1,0 8524,7988,8286,1,0 8525,8285,8287,1,0 8526,8290,8287,1,0 8527,8286,8288,1,0 8528,8289,8288,1,0 8529,8288,8289,1,0 8530,8287,8290,1,0 8531,8273,8291,1,0 8532,8281,8291,1,0 8533,8281,8291,1,0 8534,3075,8292,2,0 8535,3075,8293,2,0 8536,8293,2409,1,0 8537,7988,8299,1,0 8538,3074,8294,2,0 8539,3079,8295,2,0 8540,3075,8296,2,0 8541,3293,8298,2,0 8542,8298,2365,1,0 8543,3283,8297,4,2 8544,2297,8270,1,0 8545,2296,8270,1,0 8546,8270,3470,3,0 8547,2299,8269,1,0 8548,2298,8269,1,0 8549,8269,3471,3,0 8550,3290,8255,1,0 8551,8255,8256,2,0 8552,8256,8257,1,0 8553,8257,8258,1,0 8554,8261,8258,1,0 8555,8245,8259,1,0 8556,8260,8259,1,0 8557,8259,8260,1,0 8558,8258,8261,1,0 8559,3469,8248,2,0 8560,2300,3469,3,0 8561,8007,8116,1,0 8562,2089,8127,0,0 8563,8127,8128,1,0 8564,3337,8129,2,0 8565,3340,8130,2,0 8566,3324,8131,2,0 8567,3322,8132,1,0 8568,8134,8132,1,0 8569,3347,8133,1,0 8570,8135,8133,1,0 8571,8132,8134,1,0 8572,8133,8135,1,0 8573,8127,8136,1,0 8574,8136,8139,1,0 8575,8138,8139,1,0 8576,3293,8140,2,0 8577,8140,8141,1,0 8578,8139,8142,1,0 8579,8139,8142,1,0 8580,8142,8143,1,0 8581,3293,8144,2,0 8582,8144,8145,1,0 8583,8146,8147,1,0 8584,8143,8147,1,0 8585,2419,8148,1,0 8586,8127,2418,1,0 8587,8148,2370,1,0 8588,8127,8149,1,0 8589,8149,8150,1,0 8590,8150,8151,2,0 8591,8151,8152,1,0 8592,8149,8153,1,0 8593,8152,8154,4,2 8594,8153,8154,3,0 8595,8149,8155,1,0 8596,8155,8156,2,0 8597,8156,8157,1,0 8598,8157,8155,3,0 8599,8142,8146,1,0 8600,8139,8137,1,0 8601,8137,2396,1,0 8602,7979,2397,1,0 8603,8141,2398,1,0 8604,7980,2399,1,0 8605,8139,8138,1,0 8606,3340,8117,2,0 8607,3322,8118,1,0 8608,8120,8118,1,0 8609,3347,8119,1,0 8610,8121,8119,1,0 8611,8118,8120,1,0 8612,8119,8121,1,0 8613,3293,8122,2,0 8614,8304,2396,1,0 8615,7981,2397,1,0 8616,8122,2398,1,0 8617,7982,2399,1,0 8618,3293,8123,2,0 8619,8123,8124,1,0 8620,7983,8126,1,0 8621,8303,2370,1,0 8622,7983,8125,1,0 8623,8007,8068,1,0 8624,8007,8032,1,0 8625,2333,8034,1,0 8626,8034,8035,1,0 8627,8033,8035,1,0 8628,8035,3294,3,0 8629,3026,3293,3,0 8630,2332,8033,1,0 8631,8007,8047,1,0 8632,3075,8048,2,0 8633,3079,8049,2,0 8634,3293,8050,2,0 8635,2333,8052,1,0 8636,8052,3294,3,0 8637,3026,3293,3,0 8638,2332,8051,1,0 8639,8051,3294,3,0 8640,8050,3294,3,0 8641,8007,8228,1,0 8642,3010,8229,2,0 8643,2633,3010,3,0 8644,8007,8017,1,0 8645,3200,8018,2,0 8646,8007,8208,1,0 8647,3293,8209,2,0 8648,2335,8210,1,0 8649,8209,2334,1,0 8650,3010,8221,2,0 8651,2524,3010,3,0 8652,1171,8211,0,0 8653,8210,8212,1,0 8654,8217,8212,1,0 8655,3021,8213,1,0 8656,8214,8213,1,0 8657,8213,8214,1,0 8658,8211,8215,2,0 8659,8212,8216,1,0 8660,8217,8216,1,0 8661,8216,8217,1,0 8662,8215,8218,1,0 8663,8214,8219,1,0 8664,8217,8220,1,0 8665,8007,8205,1,0 8666,3010,8206,2,0 8667,3799,8207,1,0 8668,3797,8207,1,0 8669,8207,3010,3,0 8670,8007,8222,1,0 8671,3010,8223,2,0 8672,3801,3010,3,0 8673,8007,8028,1,0 8674,3322,3337,3,0 8675,1171,8029,0,0 8676,8029,8030,2,0 8677,8030,8031,1,0 8678,8007,8230,1,0 8679,3075,8231,2,0 8680,3075,8233,2,0 8681,3010,8234,2,0 8682,3297,8235,2,0 8683,3005,8236,1,0 8684,8239,8236,1,0 8685,8235,8237,1,0 8686,8238,8237,1,0 8687,8237,8238,1,0 8688,8236,8239,1,0 8689,8235,3010,3,0 8690,7988,8232,1,0 8691,8302,2353,1,0 8692,8302,2370,1,0 8693,3339,3340,3,0 8694,8007,8025,1,0 8695,3075,8026,2,0 8696,3293,8027,2,0 8697,8027,2365,1,0 8698,1171,8022,0,0 8699,8022,8023,2,0 8700,8023,8024,1,0 8701,1171,8019,0,0 8702,8019,8020,2,0 8703,8020,8021,1,0 8704,8007,8158,1,0 8705,3293,8159,2,0 8706,3293,8165,2,0 8707,8165,2404,1,0 8708,3293,8166,2,0 8709,8166,3810,3,0 8710,8166,3809,3,0 8711,3297,8167,2,0 8712,3026,8168,1,0 8713,8171,8168,1,0 8714,8167,8169,1,0 8715,8170,8169,1,0 8716,8169,8170,1,0 8717,8168,8171,1,0 8718,3337,8172,2,0 8719,7986,2293,1,0 8720,8159,2294,1,0 8721,3470,8160,2,0 8722,2,8160,3,2 8723,3293,8161,2,0 8724,8161,8162,1,0 8725,8162,3293,3,0 8726,8159,2402,1,0 8727,8159,8163,1,0 8728,8163,3293,3,0 8729,8007,8114,1,0 8730,3293,8115,2,0 8731,8007,8164,1,0 8732,8007,8070,1,0 8733,3075,8071,2,0 8734,3074,8072,2,0 8735,8073,8074,1,0 8736,3026,8074,1,0 8737,8074,8075,1,0 8738,8075,3293,3,0 8739,3075,8076,2,0 8740,8076,3072,3,0 8741,8076,8077,1,0 8742,8077,3073,3,0 8743,2589,3331,3,0 8744,3293,8078,2,0 8745,8078,8079,1,0 8746,3026,2400,1,0 8747,8078,2401,1,0 8748,8078,8080,1,0 8749,8080,3293,3,0 8750,8080,8081,1,0 8751,8078,8081,1,0 8752,8081,2365,1,0 8753,8076,3083,3,0 8754,8076,3082,3,0 8755,8074,8073,1,0 8756,8007,8009,1,0 8757,3337,8085,2,0 8758,3340,8086,2,0 8759,3324,8087,2,0 8760,3347,8088,1,0 8761,8091,8088,1,0 8762,3322,8089,1,0 8763,8090,8089,1,0 8764,8089,8090,1,0 8765,8088,8091,1,0 8766,3075,8094,2,0 8767,8094,8095,1,0 8768,8095,3075,3,0 8769,3079,8096,2,0 8770,3075,8099,2,0 8771,8099,3072,3,0 8772,8099,8100,1,0 8773,8100,3072,3,0 8774,3283,8103,1,0 8775,8106,8107,1,0 8776,3004,8107,1,0 8777,3004,8107,1,0 8778,3004,8107,1,0 8779,3004,8107,1,0 8780,3004,8107,1,0 8781,8108,8109,1,0 8782,8107,8109,1,0 8783,8109,8108,1,0 8784,8109,8110,1,0 8785,3004,3834,3,0 8786,3075,8111,2,0 8787,2388,2273,1,0 8788,8111,2274,1,0 8789,3075,8112,2,0 8790,8112,2364,1,0 8791,3283,8113,1,0 8792,3026,3293,3,0 8793,8107,8106,1,0 8794,3147,8104,2,0 8795,3157,8105,2,0 8796,3283,8101,1,0 8797,3283,8102,4,1 8798,8100,3083,3,0 8799,8100,3082,3,0 8800,8099,3081,3,0 8801,3075,8097,2,0 8802,8097,8098,1,0 8803,8098,83,1,0 8804,8093,8092,1,0 8805,3026,8092,1,0 8806,8092,8093,1,0 8807,3147,8083,2,0 8808,3157,8084,2,0 8809,8007,8180,1,0 8810,3078,8181,2,0 8811,3074,8182,2,0 8812,3045,8185,2,0 8813,3075,8188,2,0 8814,8188,8189,1,0 8815,8189,3075,3,0 8816,3074,8190,2,0 8817,2279,8191,1,0 8818,2351,8191,1,0 8819,8191,2372,1,0 8820,3074,8194,2,0 8821,3075,8199,2,0 8822,8199,8200,1,0 8823,8200,3075,3,0 8824,3293,8203,2,0 8825,8203,2365,1,0 8826,3293,8204,2,0 8827,8204,2405,1,0 8828,3293,8201,2,0 8829,3075,8202,2,0 8830,8202,2409,1,0 8831,8201,2410,1,0 8832,3082,8195,2,0 8833,8195,8196,1,0 8834,8196,3082,3,0 8835,3083,8197,2,0 8836,8197,8198,1,0 8837,8198,3083,3,0 8838,3075,8192,2,0 8839,8192,8193,1,0 8840,8193,3075,3,0 8841,3293,8186,2,0 8842,8186,2402,1,0 8843,8186,8187,1,0 8844,8187,3293,3,0 8845,2349,8183,1,0 8846,8183,8184,1,0 8847,3306,3337,3,0 8848,8007,8008,1,0 8849,8007,8082,1,0 8850,8007,8306,1,0 8851,3200,8309,2,0 8852,3300,8307,2,0 8853,3075,8308,2,0 8854,3297,8310,2,0 8855,3026,8311,1,0 8856,8314,8311,1,0 8857,8310,8312,1,0 8858,8313,8312,1,0 8859,8312,8313,1,0 8860,8311,8314,1,0 8861,3026,3809,3,0 8862,8315,8316,1,0 8863,3026,8316,1,0 8864,8316,8317,1,0 8865,8317,3810,3,0 8866,3033,8318,1,0 8867,3035,8318,1,0 8868,8319,8320,1,0 8869,8318,8320,1,0 8870,3026,3811,3,0 8871,8321,8322,1,0 8872,3026,8322,1,0 8873,8322,8323,1,0 8874,8323,3812,3,0 8875,3283,8327,1,0 8876,3026,3293,3,0 8877,3026,2405,1,0 8878,3283,8326,4,2 8879,3299,8324,2,0 8880,3075,8325,2,0 8881,8325,2409,1,0 8882,8324,2410,1,0 8883,8322,8321,1,0 8884,8320,8319,1,0 8885,8316,8315,1,0 8886,8007,8069,1,0 8887,8007,8178,1,0 8888,3010,8179,2,0 8889,3795,3010,3,0 8890,8007,8053,1,0 8891,3075,8054,2,0 8892,3032,8055,1,0 8893,3293,8056,2,0 8894,3328,8057,1,0 8895,8056,8057,3,0 8896,8007,8305,1,0 8897,3293,8013,2,0 8898,3075,8014,2,0 8899,8014,2409,1,0 8900,8013,2410,1,0 8901,3293,8015,2,0 8902,8015,2365,1,0 8903,3293,8016,2,0 8904,8016,2405,1,0 8905,3283,8012,4,2 8906,8007,8010,1,0 8907,3182,8011,2,0 8908,3793,2268,1,0 8909,1171,8003,0,0 8910,8003,8004,2,0 8911,8004,8005,1,0 8912,1171,7994,0,0 8913,7994,7995,2,0 8914,7995,7996,1,0 8915,3293,7993,2,0 8916,7993,2405,1,0 8917,3293,7992,2,0 8918,7992,2365,1,0 8919,3010,7990,2,0 8920,7989,3010,3,0 8921,3075,7991,2,0 8922,3075,8329,2,0 8923,8329,3072,3,0 8924,8329,8330,1,0 8925,8330,3072,3,0 8926,8330,3083,3,0 8927,8330,3082,3,0 8928,8329,3081,3,0 8929,3075,8331,2,0 8930,8331,3072,3,0 8931,8331,8332,1,0 8932,8332,3073,3,0 8933,2,2372,3,2 8934,8331,3083,3,0 8935,8331,3082,3,0 8936,2090,8333,0,0 8937,8333,8334,1,0 8938,8334,8335,1,0 8939,8337,8335,1,0 8940,3026,8336,1,0 8941,8338,8336,1,0 8942,8335,8337,1,0 8943,8336,8338,1,0 8944,3075,8339,2,0 8945,8339,3072,3,0 8946,8339,8340,1,0 8947,8340,3072,3,0 8948,3297,8341,2,0 8949,8341,8342,1,0 8950,8345,8342,1,0 8951,3026,8343,1,0 8952,8344,8343,1,0 8953,8343,8344,1,0 8954,8342,8345,1,0 8955,8339,2326,1,0 8956,3075,8346,2,0 8957,8346,3072,3,0 8958,8346,3073,3,0 8959,3075,8347,2,0 8960,3026,8348,1,0 8961,8350,8348,1,0 8962,8334,8349,1,0 8963,8351,8349,1,0 8964,8348,8350,1,0 8965,8349,8351,1,0 8966,3075,8352,2,0 8967,8352,2326,1,0 8968,8346,3083,3,0 8969,8346,3082,3,0 8970,8340,3083,3,0 8971,8340,3082,3,0 8972,8339,3081,3,0 8973,2091,8353,0,0 8974,2092,8354,0,0 8975,8353,8355,1,0 8976,3075,8376,2,0 8977,8371,8377,1,0 8978,8376,8377,1,0 8979,8366,8377,1,0 8980,8366,8377,1,0 8981,8366,8377,1,0 8982,8366,8377,1,0 8983,8366,8377,1,0 8984,3200,8382,2,0 8985,8377,8383,1,0 8986,8373,8383,1,0 8987,8377,8383,1,0 8988,8377,8383,1,0 8989,8377,8383,1,0 8990,8383,2409,1,0 8991,3074,8380,2,0 8992,3200,8381,2,0 8993,3076,8378,2,0 8994,3200,8379,2,0 8995,3075,8370,2,0 8996,8370,8371,1,0 8997,3075,8372,2,0 8998,8372,8373,1,0 8999,3076,8374,2,0 9000,3200,8375,2,0 9001,3079,8361,2,0 9002,8361,8362,1,0 9003,3076,8363,2,0 9004,8363,8364,1,0 9005,8362,8364,1,0 9006,3074,8365,2,0 9007,8365,8366,1,0 9008,8364,8366,1,0 9009,3075,8367,2,0 9010,2998,8368,2,0 9011,3293,8369,2,0 9012,8369,3330,3,0 9013,3247,2307,1,0 9014,2300,3469,3,0 9015,3075,8356,2,0 9016,8356,3073,3,0 9017,3470,8357,2,0 9018,2,8357,3,2 9019,2407,3469,3,0 9020,8354,2306,1,0 9021,8354,8358,4,5 9022,8358,8384,2,0 9023,8384,8355,3,0 9024,3293,8359,2,0 9025,3075,8360,2,0 9026,8360,2409,1,0 9027,8359,2410,1,0 9028,2100,8385,0,0 9029,2374,8386,1,0 9030,8388,8386,1,0 9031,2373,8387,1,0 9032,8389,8387,1,0 9033,8385,2293,1,0 9034,8386,2294,1,0 9035,8386,8388,1,0 9036,8387,8389,1,0 9037,2374,8390,1,0 9038,8393,8390,1,0 9039,2373,8391,1,0 9040,8392,8391,1,0 9041,8391,8392,1,0 9042,8390,8393,1,0 9043,2101,8394,0,0 9044,8394,2293,1,0 9045,2375,2294,1,0 9046,1171,8395,0,0 9047,8395,8396,2,0 9048,8396,8397,1,0 9049,2102,8398,0,0 9050,2103,8399,0,0 9051,2104,8400,0,0 9052,2105,8401,0,0 9053,2106,8402,0,0 9054,2107,8403,0,0 9055,8402,8404,1,0 9056,8401,8405,1,0 9057,8401,8406,1,0 9058,8402,8407,1,0 9059,8403,8408,1,0 9060,3293,8409,2,0 9061,8409,3294,3,0 9062,2368,8450,1,0 9063,2378,8450,1,0 9064,2368,8450,1,0 9065,8444,8451,1,0 9066,2377,8451,1,0 9067,8444,8451,1,0 9068,3200,8522,2,0 9069,3075,8523,2,0 9070,8523,8524,1,0 9071,8524,3295,3,0 9072,8451,8620,1,0 9073,8450,8620,1,0 9074,8451,8620,1,0 9075,8451,8620,1,0 9076,8451,8620,1,0 9077,8451,8620,1,0 9078,8451,8620,1,0 9079,8451,8620,1,0 9080,8451,8620,1,0 9081,8451,8620,1,0 9082,8451,8620,1,0 9083,8451,8620,1,0 9084,8451,8620,1,0 9085,8451,8620,1,0 9086,8451,8620,1,0 9087,8451,8620,1,0 9088,8451,8620,1,0 9089,8451,8620,1,0 9090,8451,8620,1,0 9091,8451,8620,1,0 9092,8451,8620,1,0 9093,8451,8620,1,0 9094,8451,8620,1,0 9095,8451,8620,1,0 9096,8451,8620,1,0 9097,8451,8620,1,0 9098,8451,8620,1,0 9099,8451,8620,1,0 9100,8451,8620,1,0 9101,8451,8620,1,0 9102,8451,8620,1,0 9103,8451,8620,1,0 9104,8451,8620,1,0 9105,8451,8620,1,0 9106,8451,8620,1,0 9107,8451,8620,1,0 9108,2,8620,3,2 9109,3295,8621,2,0 9110,3075,8622,2,0 9111,8622,3295,3,0 9112,3294,8512,2,0 9113,3294,8515,2,0 9114,3294,8516,2,0 9115,8516,8517,1,0 9116,8517,3294,3,0 9117,8515,2402,1,0 9118,8515,8514,1,0 9119,8514,3294,3,0 9120,3026,2400,1,0 9121,8515,2401,1,0 9122,8515,8513,1,0 9123,3075,8539,2,0 9124,8539,8540,1,0 9125,8540,3295,3,0 9126,3293,8541,2,0 9127,3029,8542,1,0 9128,8541,8542,1,0 9129,8542,2327,1,0 9130,3075,8537,2,0 9131,8537,8538,1,0 9132,8538,3295,3,0 9133,3075,8529,2,0 9134,8529,8530,1,0 9135,8530,3295,3,0 9136,3293,8531,2,0 9137,3029,8532,1,0 9138,8531,8532,1,0 9139,8532,2327,1,0 9140,3075,8506,2,0 9141,8506,8507,1,0 9142,8507,3295,3,0 9143,3026,3294,3,0 9144,3026,3294,3,0 9145,8508,8509,1,0 9146,3026,8509,1,0 9147,8509,8510,1,0 9148,8510,8511,1,0 9149,8511,3294,3,0 9150,3294,8501,2,0 9151,8501,8502,1,0 9152,8502,3294,3,0 9153,8501,2402,1,0 9154,8509,8508,1,0 9155,3075,8458,2,0 9156,3075,8463,2,0 9157,2998,8464,2,0 9158,3293,8465,2,0 9159,8465,3330,3,0 9160,3294,8459,2,0 9161,8459,8460,1,0 9162,8460,3294,3,0 9163,8459,2402,1,0 9164,3293,8461,2,0 9165,8461,8462,1,0 9166,8462,3293,3,0 9167,8461,2402,1,0 9168,3076,8548,2,0 9169,3074,8549,2,0 9170,3032,8550,1,0 9171,8552,8553,1,0 9172,8548,8553,1,0 9173,8553,8554,1,0 9174,8553,8551,1,0 9175,8551,3295,3,0 9176,3328,8555,1,0 9177,8555,8556,2,0 9178,8556,8557,1,0 9179,8557,3294,3,0 9180,3075,8558,2,0 9181,3293,8559,2,0 9182,3295,8562,2,0 9183,8563,8564,1,0 9184,3026,8564,1,0 9185,8564,8565,1,0 9186,3294,8566,2,0 9187,3075,8567,2,0 9188,8564,8563,1,0 9189,2998,8560,2,0 9190,3293,8561,2,0 9191,8561,3330,3,0 9192,8553,8552,1,0 9193,8451,2389,1,0 9194,3075,8452,2,0 9195,2998,8453,2,0 9196,3293,8454,2,0 9197,8454,3330,3,0 9198,3337,8488,2,0 9199,8408,3337,3,0 9200,1171,8485,0,0 9201,8485,8486,2,0 9202,8486,8487,1,0 9203,3075,8527,2,0 9204,8527,8528,1,0 9205,8528,3295,3,0 9206,3293,8574,2,0 9207,3075,8575,2,0 9208,3337,8576,2,0 9209,3010,8577,2,0 9210,3297,8578,2,0 9211,3004,8579,1,0 9212,8582,8579,1,0 9213,8578,8580,1,0 9214,8581,8580,1,0 9215,8580,8581,1,0 9216,8579,8582,1,0 9217,8578,3010,3,0 9218,3293,8583,2,0 9219,2266,8584,1,0 9220,8583,2265,1,0 9221,3010,8585,2,0 9222,2490,3010,3,0 9223,8587,8588,1,0 9224,2490,8588,1,0 9225,8585,8588,1,0 9226,8588,8589,1,0 9227,8589,3010,3,0 9228,8584,3075,3,0 9229,3514,8590,2,0 9230,8590,3293,3,0 9231,8584,8591,1,0 9232,8588,8592,1,0 9233,8575,3075,3,0 9234,8592,8593,1,0 9235,8593,3010,3,0 9236,8593,8594,1,0 9237,8592,8594,1,0 9238,3808,8596,1,0 9239,8597,8596,1,0 9240,8596,8597,1,0 9241,8598,8599,1,0 9242,8595,8599,1,0 9243,8594,8599,1,0 9244,8599,8603,1,0 9245,3808,8605,1,0 9246,8606,8605,1,0 9247,8605,8606,1,0 9248,8604,8607,1,0 9249,8603,8607,1,0 9250,8577,3010,3,0 9251,3514,8609,2,0 9252,8609,3294,3,0 9253,3293,8610,2,0 9254,8609,8613,1,0 9255,8613,3514,3,0 9256,8613,8614,1,0 9257,8609,8614,1,0 9258,8609,8614,1,0 9259,3075,8615,2,0 9260,3075,8616,2,0 9261,3075,8617,2,0 9262,8614,2327,1,0 9263,8591,2409,1,0 9264,8614,2410,1,0 9265,2998,8611,2,0 9266,3293,8612,2,0 9267,8612,3330,3,0 9268,3324,8618,2,0 9269,8618,8619,1,0 9270,8591,3295,3,0 9271,3200,8608,2,0 9272,8577,3010,3,0 9273,8575,3075,3,0 9274,8574,3293,3,0 9275,3075,8586,2,0 9276,8586,2409,1,0 9277,8574,2410,1,0 9278,8603,8604,1,0 9279,8604,3010,3,0 9280,8599,8598,1,0 9281,8598,3010,3,0 9282,1171,8600,0,0 9283,8600,8601,2,0 9284,8601,8602,1,0 9285,8594,8595,1,0 9286,8595,3010,3,0 9287,8585,8587,1,0 9288,8587,3010,3,0 9289,3026,3294,3,0 9290,8451,2389,1,0 9291,3294,8518,2,0 9292,3294,8521,2,0 9293,8521,2402,1,0 9294,8521,8520,1,0 9295,8520,3294,3,0 9296,3026,2400,1,0 9297,8521,2401,1,0 9298,8521,8519,1,0 9299,8451,2389,1,0 9300,3324,8489,2,0 9301,8489,8490,1,0 9302,8490,3324,3,0 9303,3337,8491,2,0 9304,3294,8492,2,0 9305,8492,8495,1,0 9306,8495,3294,3,0 9307,8398,2293,1,0 9308,8495,2294,1,0 9309,8399,2293,1,0 9310,8492,2294,1,0 9311,8492,8493,1,0 9312,3026,2400,1,0 9313,8493,2401,1,0 9314,8492,8494,1,0 9315,3294,8496,2,0 9316,8496,8497,1,0 9317,8497,3294,3,0 9318,8496,2402,1,0 9319,3294,8498,2,0 9320,3026,2400,1,0 9321,8498,2401,1,0 9322,8498,8500,1,0 9323,8500,3294,3,0 9324,8498,8499,1,0 9325,3079,8570,2,0 9326,8570,8571,1,0 9327,8571,3295,3,0 9328,3076,8572,2,0 9329,3074,8573,2,0 9330,8571,2336,1,0 9331,3074,8568,2,0 9332,3079,8569,2,0 9333,3075,8525,2,0 9334,8525,8526,1,0 9335,8526,3295,3,0 9336,8526,2336,1,0 9337,3075,8533,2,0 9338,8533,8534,1,0 9339,8534,3295,3,0 9340,8534,2336,1,0 9341,3075,8535,2,0 9342,8535,8536,1,0 9343,8536,3295,3,0 9344,8536,2336,1,0 9345,8402,8545,1,0 9346,8401,8545,1,0 9347,8545,8546,1,0 9348,8545,8547,1,0 9349,8547,8543,1,0 9350,3804,8543,1,0 9351,8546,8544,1,0 9352,3803,8544,1,0 9353,8543,3337,3,0 9354,3337,8466,2,0 9355,3075,8467,2,0 9356,8467,8468,1,0 9357,8469,8468,1,0 9358,8468,8469,1,0 9359,3076,8470,2,0 9360,8475,8476,1,0 9361,8468,8476,1,0 9362,8468,8476,1,0 9363,8473,8476,1,0 9364,8469,8476,1,0 9365,3075,8477,2,0 9366,3026,8478,1,0 9367,8478,8481,1,0 9368,8480,8481,1,0 9369,8481,3294,3,0 9370,8476,3295,3,0 9371,3075,8482,2,0 9372,2998,8483,2,0 9373,3293,8484,2,0 9374,8484,3330,3,0 9375,8479,8480,1,0 9376,3026,8480,1,0 9377,8480,8479,1,0 9378,3074,8471,2,0 9379,8469,8473,1,0 9380,8469,8473,1,0 9381,8469,8473,1,0 9382,8468,8474,1,0 9383,8468,8474,1,0 9384,8468,8474,1,0 9385,8474,8475,1,0 9386,2817,8472,2,0 9387,8472,2395,1,0 9388,2333,8505,1,0 9389,8505,3294,3,0 9390,8451,2389,1,0 9391,3075,8455,2,0 9392,2998,8456,2,0 9393,3293,8457,2,0 9394,8457,3330,3,0 9395,3471,8503,2,0 9396,2332,8504,1,0 9397,8504,3294,3,0 9398,2382,8444,1,0 9399,2380,8444,1,0 9400,2381,8444,1,0 9401,2379,8444,1,0 9402,2378,8444,1,0 9403,2379,8444,1,0 9404,3256,2369,1,0 9405,3324,8448,2,0 9406,8448,8449,1,0 9407,8449,3324,3,0 9408,1171,8445,0,0 9409,8445,8446,2,0 9410,8446,8447,1,0 9411,3293,8410,2,0 9412,3200,8411,2,0 9413,3293,8412,2,0 9414,8412,8413,1,0 9415,3029,8414,1,0 9416,8413,8414,1,0 9417,8414,2327,1,0 9418,3293,8415,2,0 9419,8415,2404,1,0 9420,3283,8416,1,0 9421,3337,8417,2,0 9422,3293,8418,2,0 9423,8418,2405,1,0 9424,3297,8419,2,0 9425,8419,8420,1,0 9426,8422,8420,1,0 9427,3026,8421,1,0 9428,8423,8421,1,0 9429,8420,8422,1,0 9430,8421,8423,1,0 9431,3293,8424,2,0 9432,8424,3294,3,0 9433,8426,8427,1,0 9434,8424,8427,1,0 9435,3293,8425,2,0 9436,8427,8426,1,0 9437,8426,3294,3,0 9438,8400,2293,1,0 9439,8427,2294,1,0 9440,8427,8428,1,0 9441,3293,8429,2,0 9442,8429,3809,3,0 9443,8428,3810,3,0 9444,8429,8430,1,0 9445,8432,8430,1,0 9446,8428,8431,1,0 9447,8433,8431,1,0 9448,8430,8432,1,0 9449,8431,8433,1,0 9450,3075,8434,2,0 9451,8434,3072,3,0 9452,8434,8435,1,0 9453,8435,3072,3,0 9454,3324,8436,2,0 9455,8436,8437,1,0 9456,8437,3324,3,0 9457,3337,8438,2,0 9458,3340,8439,2,0 9459,3347,8440,1,0 9460,8443,8440,1,0 9461,3322,8441,1,0 9462,8442,8441,1,0 9463,8441,8442,1,0 9464,8440,8443,1,0 9465,8435,3083,3,0 9466,8435,3082,3,0 9467,8434,3081,3,0 9468,2108,8623,0,0 9469,8623,2293,1,0 9470,2376,2294,1,0 9471,1171,8624,0,0 9472,8624,8625,2,0 9473,8625,8626,1,0 9474,2109,8627,0,0 9475,3294,8628,2,0 9476,8628,8629,1,0 9477,8627,2293,1,0 9478,8628,2294,1,0 9479,2110,8630,0,0 9480,2111,8631,0,0 9481,3200,8695,2,0 9482,3297,8648,2,0 9483,8631,8649,1,0 9484,8648,8650,1,0 9485,8653,8650,1,0 9486,8649,8651,1,0 9487,8652,8651,1,0 9488,8651,8652,1,0 9489,8650,8653,1,0 9490,3026,8654,1,0 9491,8657,8654,1,0 9492,8648,8655,1,0 9493,8656,8655,1,0 9494,8655,8656,1,0 9495,8654,8657,1,0 9496,3812,8658,2,0 9497,8658,8659,1,0 9498,3029,8660,1,0 9499,8659,8660,1,0 9500,8660,2327,1,0 9501,3811,8661,2,0 9502,8661,8662,1,0 9503,3029,8663,1,0 9504,8662,8663,1,0 9505,8663,2327,1,0 9506,8649,8664,1,0 9507,8667,8664,1,0 9508,3026,8665,1,0 9509,8666,8665,1,0 9510,8665,8666,1,0 9511,8664,8667,1,0 9512,3811,8668,2,0 9513,3809,8669,2,0 9514,8669,3811,3,0 9515,8668,3809,3,0 9516,3812,8670,2,0 9517,3810,8671,2,0 9518,8671,3812,3,0 9519,8670,3810,3,0 9520,8668,3293,3,0 9521,3075,8672,2,0 9522,8672,2364,1,0 9523,3293,8673,2,0 9524,2333,8675,1,0 9525,8675,3294,3,0 9526,3026,3293,3,0 9527,2332,8674,1,0 9528,8674,3294,3,0 9529,8673,3294,3,0 9530,8668,2404,1,0 9531,3469,8676,2,0 9532,2406,3469,3,0 9533,3812,8677,2,0 9534,8631,8678,1,0 9535,3811,8679,2,0 9536,8631,8680,1,0 9537,8680,8683,1,0 9538,8681,8683,1,0 9539,8681,8683,1,0 9540,8676,3469,3,0 9541,3163,8684,2,0 9542,3283,8685,1,0 9543,3283,8687,1,0 9544,3293,8688,2,0 9545,8689,8690,1,0 9546,3026,8690,1,0 9547,8690,8691,1,0 9548,8693,8694,1,0 9549,8688,8694,1,0 9550,8688,8694,1,0 9551,8694,2405,1,0 9552,3026,2400,1,0 9553,8688,2401,1,0 9554,8688,8693,1,0 9555,8693,3293,3,0 9556,8688,8692,1,0 9557,8690,8689,1,0 9558,3283,8686,4,2 9559,8630,2293,1,0 9560,8683,2294,1,0 9561,8683,8681,1,0 9562,3470,8682,2,0 9563,2,8682,3,2 9564,3075,8635,2,0 9565,8635,8636,1,0 9566,3082,8637,2,0 9567,3083,8638,2,0 9568,3200,8639,2,0 9569,3075,8646,2,0 9570,8646,2409,1,0 9571,3341,8647,2,0 9572,8647,2365,1,0 9573,3075,8645,2,0 9574,3283,8640,4,2 9575,3083,8643,2,0 9576,3082,8644,2,0 9577,3078,8641,2,0 9578,3074,8642,2,0 9579,3082,8632,2,0 9580,8632,3072,3,0 9581,3083,8633,2,0 9582,8633,8634,1,0 9583,8634,3073,3,0 9584,2112,8696,0,0 9585,3340,8697,2,0 9586,3075,8698,2,0 9587,3074,8699,2,0 9588,3293,8700,2,0 9589,8696,8701,1,0 9590,3026,8702,1,0 9591,8705,8702,1,0 9592,8701,8703,1,0 9593,8704,8703,1,0 9594,8703,8704,1,0 9595,8702,8705,1,0 9596,3074,8706,2,0 9597,3079,8707,2,0 9598,2998,8708,2,0 9599,3077,8709,2,0 9600,8709,8710,1,0 9601,3079,8711,2,0 9602,8711,8712,1,0 9603,8714,8712,1,0 9604,8710,8713,1,0 9605,8715,8713,1,0 9606,8712,8714,1,0 9607,8713,8715,1,0 9608,8710,8716,1,0 9609,8716,3077,3,0 9610,3074,8717,2,0 9611,3076,8718,2,0 9612,8718,2330,1,0 9613,8717,2331,1,0 9614,3074,8719,2,0 9615,3078,8724,2,0 9616,8724,8725,1,0 9617,8725,3078,3,0 9618,3077,8726,2,0 9619,3083,8727,2,0 9620,8727,8728,1,0 9621,8728,3083,3,0 9622,8726,8729,1,0 9623,8729,3077,3,0 9624,8726,8730,1,0 9625,3079,8731,2,0 9626,8730,8732,1,0 9627,8735,8732,1,0 9628,8731,8733,1,0 9629,8734,8733,1,0 9630,8733,8734,1,0 9631,8732,8735,1,0 9632,8698,3075,3,0 9633,8699,3074,3,0 9634,8700,3293,3,0 9635,8701,8736,1,0 9636,8739,8736,1,0 9637,3026,8737,1,0 9638,8738,8737,1,0 9639,8737,8738,1,0 9640,8736,8739,1,0 9641,2318,8720,1,0 9642,2317,8720,1,0 9643,3077,8721,2,0 9644,8719,8722,1,0 9645,8699,8723,1,0 9646,8723,8720,3,2 9647,8722,8720,3,3 9648,2,8720,3,4 9649,2113,8740,0,0 9650,3295,8741,2,0 9651,3300,8747,2,0 9652,3075,8748,2,0 9653,3294,8750,2,0 9654,3075,8751,2,0 9655,3079,8752,2,0 9656,3294,8760,2,0 9657,8760,2405,1,0 9658,3294,8753,2,0 9659,3293,8754,2,0 9660,8754,2405,1,0 9661,3293,8755,2,0 9662,8755,8758,1,0 9663,8756,8758,1,0 9664,8756,8758,1,0 9665,3294,8759,2,0 9666,8740,2293,1,0 9667,8758,2294,1,0 9668,8758,8756,1,0 9669,3470,8757,2,0 9670,2,8757,3,2 9671,3294,8749,2,0 9672,8749,3299,3,0 9673,8748,3300,3,0 9674,3076,8742,2,0 9675,3200,8744,2,0 9676,3074,8743,2,0 9677,3075,8745,2,0 9678,3294,8746,2,0 9679,8746,2411,1,0 9680,3295,8761,2,0 9681,3294,8762,2,0 9682,3026,3294,3,0 9683,3026,8767,1,0 9684,8762,8767,1,0 9685,3293,8768,2,0 9686,3200,8769,2,0 9687,3293,8770,2,0 9688,3294,8771,2,0 9689,3306,2366,1,0 9690,8770,2367,1,0 9691,3294,8772,2,0 9692,8772,8773,1,0 9693,8776,8773,1,0 9694,8770,8774,1,0 9695,8775,8774,1,0 9696,8774,8775,1,0 9697,8773,8776,1,0 9698,8770,8777,1,0 9699,8777,8778,1,0 9700,8770,8778,1,0 9701,8770,8778,1,0 9702,8778,2383,1,0 9703,8778,3293,3,0 9704,3293,8779,2,0 9705,3026,2400,1,0 9706,8779,2401,1,0 9707,8779,8781,1,0 9708,3029,8782,1,0 9709,8781,8782,1,0 9710,8782,2327,1,0 9711,3283,8783,4,1 9712,3075,8784,2,0 9713,3079,8785,2,0 9714,3283,8786,1,0 9715,3283,8787,1,0 9716,8778,2405,1,0 9717,8779,8780,1,0 9718,3075,8763,2,0 9719,8763,3295,3,0 9720,8763,3072,3,0 9721,8763,8764,1,0 9722,8764,3073,3,0 9723,2577,3331,3,0 9724,3295,8765,2,0 9725,3074,8766,2,0 9726,8763,3083,3,0 9727,8763,3082,3,0 9728,2114,8788,0,0 9729,3295,8789,2,0 9730,3294,8838,2,0 9731,3026,3294,3,0 9732,3026,8839,1,0 9733,8838,8839,1,0 9734,3293,8840,2,0 9735,3200,8841,2,0 9736,3293,8842,2,0 9737,8842,2383,1,0 9738,8842,3293,3,0 9739,3294,8857,2,0 9740,3306,2366,1,0 9741,8842,2367,1,0 9742,3294,8858,2,0 9743,3293,8859,2,0 9744,8858,8860,1,0 9745,8863,8860,1,0 9746,8859,8861,1,0 9747,8862,8861,1,0 9748,8861,8862,1,0 9749,8860,8863,1,0 9750,8859,8864,1,0 9751,3029,8865,1,0 9752,8864,8865,1,0 9753,8865,2327,1,0 9754,3283,8866,1,0 9755,3283,8867,1,0 9756,3294,8843,2,0 9757,8843,8845,1,0 9758,3029,8846,1,0 9759,8845,8846,1,0 9760,8846,2327,1,0 9761,3283,8847,1,0 9762,3294,8848,2,0 9763,3026,2400,1,0 9764,8848,2401,1,0 9765,3294,8850,2,0 9766,8850,8851,1,0 9767,8788,2293,1,0 9768,8851,2294,1,0 9769,3470,8855,2,0 9770,2,8855,3,2 9771,3283,8856,1,0 9772,3470,8854,2,0 9773,2,8854,3,2 9774,3294,8852,2,0 9775,8852,8853,1,0 9776,8848,8849,1,0 9777,3283,8844,1,0 9778,8842,2405,1,0 9779,3075,8790,2,0 9780,3294,8791,2,0 9781,3293,8792,2,0 9782,8807,8806,1,0 9783,3026,8806,1,0 9784,3026,8806,1,0 9785,8806,8807,1,0 9786,8808,8809,1,0 9787,3277,8809,1,0 9788,3075,8810,2,0 9789,8810,3072,3,0 9790,8810,8811,1,0 9791,8811,3073,3,0 9792,3294,8812,2,0 9793,2577,8814,1,0 9794,2575,8814,1,0 9795,8814,3331,3,0 9796,3074,8815,2,0 9797,3293,8824,2,0 9798,8824,3341,3,0 9799,3026,8825,1,0 9800,8827,8825,1,0 9801,3004,8826,1,0 9802,8828,8826,1,0 9803,8825,8827,1,0 9804,8826,8828,1,0 9805,3026,3834,3,0 9806,3075,8829,2,0 9807,2388,2273,1,0 9808,8829,2274,1,0 9809,3075,8831,2,0 9810,8831,2364,1,0 9811,3283,8832,1,0 9812,3293,8834,2,0 9813,8834,8835,1,0 9814,3026,2400,1,0 9815,8834,2401,1,0 9816,8834,8836,1,0 9817,8836,3293,3,0 9818,8836,8837,1,0 9819,8834,8837,1,0 9820,8837,2365,1,0 9821,3293,8833,2,0 9822,8833,2404,1,0 9823,3026,3293,3,0 9824,3026,2405,1,0 9825,3075,8830,2,0 9826,8830,2403,1,0 9827,8818,8819,1,0 9828,3004,8819,1,0 9829,8820,8821,1,0 9830,8819,8821,1,0 9831,8821,8820,1,0 9832,8821,8822,1,0 9833,3004,3834,3,0 9834,3075,8823,2,0 9835,2388,2273,1,0 9836,8823,2274,1,0 9837,8819,8818,1,0 9838,3075,8816,2,0 9839,8816,8817,1,0 9840,8817,3075,3,0 9841,3293,8813,2,0 9842,8813,3045,3,0 9843,8812,3046,3,0 9844,8810,3083,3,0 9845,8810,3082,3,0 9846,3283,8808,1,0 9847,3075,8805,2,0 9848,8805,83,1,0 9849,3004,8793,1,0 9850,3295,8794,2,0 9851,3294,8795,2,0 9852,3075,8796,2,0 9853,3200,8797,2,0 9854,3004,8798,1,0 9855,2335,8799,1,0 9856,3004,2334,1,0 9857,3075,8800,2,0 9858,2349,8803,1,0 9859,8803,8804,1,0 9860,2349,8801,1,0 9861,8801,8802,1,0 9862,3075,8868,2,0 9863,8868,3072,3,0 9864,8868,8869,1,0 9865,8869,3073,3,0 9866,3814,3331,3,0 9867,8868,3075,3,0 9868,8868,3083,3,0 9869,8868,3082,3,0 9870,2115,8870,0,0 9871,3337,8871,2,0 9872,3010,8873,2,0 9873,3005,3010,3,0 9874,8870,8874,1,0 9875,8874,2373,1,0 9876,3070,2374,1,0 9877,8873,3010,3,0 9878,3075,8875,2,0 9879,3483,8877,2,0 9880,3075,8878,2,0 9881,8878,3072,3,0 9882,8878,8879,1,0 9883,8879,3073,3,0 9884,3075,8881,2,0 9885,3079,8882,2,0 9886,3074,8883,2,0 9887,3076,8884,2,0 9888,8884,3075,3,0 9889,2490,3331,3,0 9890,3083,8885,2,0 9891,3082,8886,2,0 9892,8875,3075,3,0 9893,3074,8887,2,0 9894,8875,8888,1,0 9895,8888,3075,3,0 9896,8878,3083,3,0 9897,8878,3082,3,0 9898,3038,3483,3,0 9899,3283,8880,4,2 9900,3293,8876,2,0 9901,8876,2365,1,0 9902,8873,3010,3,0 9903,8870,8872,1,0 9904,8872,3337,3,0 9905,3295,8889,2,0 9906,3200,8892,2,0 9907,3076,8890,2,0 9908,3074,8891,2,0 9909,3337,8893,2,0 9910,3340,8894,2,0 9911,3324,8895,2,0 9912,3322,8896,1,0 9913,8898,8896,1,0 9914,3347,8897,1,0 9915,8899,8897,1,0 9916,8896,8898,1,0 9917,8897,8899,1,0 9918,3075,8900,2,0 9919,3295,8901,2,0 9920,8901,3075,3,0 9921,8900,3295,3,0 9922,3293,8904,2,0 9923,3294,8905,2,0 9924,8905,3293,3,0 9925,8904,3294,3,0 9926,8901,8906,1,0 9927,8900,8906,1,0 9928,8900,8906,1,0 9929,8900,8906,1,0 9930,8900,8907,1,0 9931,8901,8907,1,0 9932,8901,8907,1,0 9933,8901,8907,1,0 9934,3293,8908,2,0 9935,3295,8918,2,0 9936,3075,8919,2,0 9937,2569,8923,1,0 9938,8924,8923,1,0 9939,8923,8924,1,0 9940,3075,8921,2,0 9941,8921,3072,3,0 9942,8921,8922,1,0 9943,8922,3073,3,0 9944,8921,3083,3,0 9945,8921,3082,3,0 9946,8919,3072,3,0 9947,8919,8920,1,0 9948,8920,3073,3,0 9949,8919,3083,3,0 9950,8919,3082,3,0 9951,3294,8909,2,0 9952,8907,8910,1,0 9953,8910,3295,3,0 9954,2335,8911,1,0 9955,3026,2334,1,0 9956,3293,8912,2,0 9957,3295,8913,2,0 9958,8914,8915,1,0 9959,3026,8915,1,0 9960,8915,8916,1,0 9961,8916,3294,3,0 9962,3075,8917,2,0 9963,8915,8914,1,0 9964,3294,8902,2,0 9965,3293,8903,2,0 9966,3295,8925,2,0 9967,3294,8931,2,0 9968,3026,3294,3,0 9969,3026,8932,1,0 9970,8931,8932,1,0 9971,3293,8933,2,0 9972,3200,8934,2,0 9973,8933,3294,3,0 9974,8932,3293,3,0 9975,8932,8935,1,0 9976,8933,8935,1,0 9977,8933,8936,1,0 9978,8932,8936,1,0 9979,3306,2366,1,0 9980,8935,2367,1,0 9981,3200,8937,2,0 9982,3075,8926,2,0 9983,8926,3072,3,0 9984,8926,8927,1,0 9985,8927,3073,3,0 9986,3294,8928,2,0 9987,2659,3331,3,0 9988,3293,8930,2,0 9989,8930,2365,1,0 9990,3293,8929,2,0 9991,8929,3045,3,0 9992,8928,3046,3,0 9993,8926,3083,3,0 9994,8926,3082,3,0 9995,3029,8938,1,0 9996,2383,8938,1,0 9997,8938,2327,1,0 9998,3470,8939,2,0 9999,2,8939,3,2 10000,3337,8940,2,0 10001,3340,8941,2,0 10002,3324,8942,2,0 10003,3347,8943,1,0 10004,8946,8943,1,0 10005,3322,8944,1,0 10006,8945,8944,1,0 10007,8944,8945,1,0 10008,8943,8946,1,0 10009,3294,8952,2,0 10010,3293,8953,2,0 10011,8953,3294,3,0 10012,8952,3293,3,0 10013,8953,8954,1,0 10014,8952,8954,1,0 10015,8952,8955,1,0 10016,8953,8955,1,0 10017,8955,3812,3,0 10018,8955,3811,3,0 10019,8955,3809,3,0 10020,8954,3810,3,0 10021,3026,2400,1,0 10022,8954,2401,1,0 10023,8954,8957,1,0 10024,3029,8958,1,0 10025,8957,8958,1,0 10026,8958,2327,1,0 10027,8954,8956,1,0 10028,3297,8947,2,0 10029,3026,8948,1,0 10030,8951,8948,1,0 10031,8947,8949,1,0 10032,8950,8949,1,0 10033,8949,8950,1,0 10034,8948,8951,1,0 10035,3290,8959,1,0 10036,8959,8960,2,0 10037,8960,8961,1,0 10038,8961,8963,1,0 10039,8962,8963,1,0 10040,8963,8962,1,0 10041,3340,8964,2,0 10042,3293,8965,2,0 10043,3826,8966,1,0 10044,3822,8966,1,0 10045,3820,8966,1,0 10046,3818,8966,1,0 10047,3824,8966,1,0 10048,3828,8966,1,0 10049,3816,8966,1,0 10050,8966,8968,1,0 10051,8965,3293,3,0 10052,3470,8967,2,0 10053,2,8967,3,2 10054,3337,8969,2,0 10055,8971,8970,1,0 10056,3310,8970,1,0 10057,8970,8971,1,0 10058,8972,8973,1,0 10059,3310,8973,1,0 10060,8973,8974,1,0 10061,8974,8975,1,0 10062,8973,8972,1,0 10063,2116,8976,0,0 10064,2117,8977,0,0 10065,2118,8978,0,0 10066,2119,8979,0,0 10067,2120,8980,0,0 10068,2121,8981,0,0 10069,2122,8982,0,0 10070,2123,8983,0,0 10071,2124,8984,0,0 10072,3293,8994,2,0 10073,8994,2405,1,0 10074,3004,8995,1,0 10075,8990,8995,1,0 10076,8990,8995,1,0 10077,3004,8995,1,0 10078,3293,8996,2,0 10079,8996,3812,3,0 10080,8996,3811,3,0 10081,3337,8997,2,0 10082,3200,8998,2,0 10083,3310,3337,3,0 10084,3293,9000,2,0 10085,9094,9001,1,0 10086,8995,9001,1,0 10087,9001,9005,1,0 10088,9002,9005,1,0 10089,9002,9005,1,0 10090,9002,9005,1,0 10091,9005,9019,1,0 10092,9005,9019,1,0 10093,9018,9019,1,0 10094,3293,9020,2,0 10095,9021,9022,1,0 10096,3004,9022,1,0 10097,3293,9023,2,0 10098,9023,9025,1,0 10099,9024,9025,1,0 10100,8979,2293,1,0 10101,9025,2294,1,0 10102,9025,9024,1,0 10103,9025,9026,1,0 10104,3293,9027,2,0 10105,9026,9028,1,0 10106,9031,9028,1,0 10107,9027,9029,1,0 10108,9030,9029,1,0 10109,9029,9030,1,0 10110,9028,9031,1,0 10111,3810,9037,2,0 10112,9037,9038,1,0 10113,9038,3810,3,0 10114,2724,2268,1,0 10115,3293,9039,2,0 10116,3831,9040,2,0 10117,9019,9041,1,0 10118,9039,9042,1,0 10119,9045,9042,1,0 10120,9041,9043,1,0 10121,9044,9043,1,0 10122,9043,9044,1,0 10123,9042,9045,1,0 10124,3293,9046,2,0 10125,3004,9047,1,0 10126,9050,9047,1,0 10127,9046,9048,1,0 10128,9049,9048,1,0 10129,9048,9049,1,0 10130,9047,9050,1,0 10131,2406,3469,3,0 10132,2407,3469,3,0 10133,3293,9051,2,0 10134,9051,9052,1,0 10135,9052,3293,3,0 10136,3163,9053,2,0 10137,3293,9054,2,0 10138,9054,3812,3,0 10139,3831,9088,2,0 10140,9019,9089,1,0 10141,9089,9090,1,0 10142,9093,9090,1,0 10143,3004,9091,1,0 10144,9092,9091,1,0 10145,9091,9092,1,0 10146,9090,9093,1,0 10147,9083,9094,1,0 10148,3004,9094,1,0 10149,3004,3834,3,0 10150,3075,9098,2,0 10151,2388,2273,1,0 10152,9098,2274,1,0 10153,3283,9100,1,0 10154,3075,9101,2,0 10155,9101,2364,1,0 10156,3283,9102,1,0 10157,3026,9103,1,0 10158,3026,9103,1,0 10159,3026,9103,1,0 10160,9105,9103,1,0 10161,9094,9104,1,0 10162,9094,9104,1,0 10163,9094,9104,1,0 10164,9106,9104,1,0 10165,9103,9105,1,0 10166,9104,9106,1,0 10167,3026,3293,3,0 10168,3831,9108,2,0 10169,9108,2400,1,0 10170,3026,2401,1,0 10171,3024,9109,1,0 10172,9109,2327,1,0 10173,3004,2328,1,0 10174,3283,9110,1,0 10175,3831,9107,2,0 10176,3075,9099,2,0 10177,9099,2413,1,0 10178,3075,9095,2,0 10179,9095,3072,3,0 10180,9095,3073,3,0 10181,9095,3083,3,0 10182,9095,3082,3,0 10183,3082,9096,2,0 10184,9096,9097,1,0 10185,9097,3082,3,0 10186,8978,2293,1,0 10187,9019,2294,1,0 10188,9019,9071,1,0 10189,2335,9072,1,0 10190,9071,2334,1,0 10191,9072,9073,1,0 10192,9076,9073,1,0 10193,3026,9074,1,0 10194,9075,9074,1,0 10195,9074,9075,1,0 10196,9073,9076,1,0 10197,9077,9078,1,0 10198,3004,9078,1,0 10199,9079,9080,1,0 10200,9078,9080,1,0 10201,9080,9079,1,0 10202,9080,9081,1,0 10203,9081,9082,1,0 10204,3004,9083,1,0 10205,9081,9083,1,0 10206,3026,9084,1,0 10207,9087,9084,1,0 10208,9083,9085,1,0 10209,9086,9085,1,0 10210,9085,9086,1,0 10211,9084,9087,1,0 10212,9078,9077,1,0 10213,9070,9069,1,0 10214,3026,9069,1,0 10215,9069,9070,1,0 10216,3075,9067,2,0 10217,9067,9068,1,0 10218,9068,83,1,0 10219,3293,9111,2,0 10220,3026,2400,1,0 10221,9111,2401,1,0 10222,9111,9113,1,0 10223,9113,3293,3,0 10224,9113,9114,1,0 10225,9111,9114,1,0 10226,3293,9116,2,0 10227,9116,3294,3,0 10228,3283,9115,1,0 10229,9111,9112,1,0 10230,3283,9062,4,1 10231,3283,9063,1,0 10232,3075,9064,2,0 10233,3079,9065,2,0 10234,3283,9066,1,0 10235,3831,9055,2,0 10236,9019,9056,1,0 10237,3293,9057,2,0 10238,9056,9058,1,0 10239,9061,9058,1,0 10240,9057,9059,1,0 10241,9060,9059,1,0 10242,9059,9060,1,0 10243,9058,9061,1,0 10244,8976,2293,1,0 10245,9019,2294,1,0 10246,8977,2293,1,0 10247,9019,2294,1,0 10248,8980,2293,1,0 10249,9022,2294,1,0 10250,9022,9021,1,0 10251,9020,9032,1,0 10252,9032,9033,1,0 10253,9036,9033,1,0 10254,9020,9034,1,0 10255,9035,9034,1,0 10256,9034,9035,1,0 10257,9033,9036,1,0 10258,9007,9006,1,0 10259,3004,9006,1,0 10260,9006,9007,1,0 10261,2335,9008,1,0 10262,3004,2334,1,0 10263,9017,9018,1,0 10264,3004,9018,1,0 10265,9018,9017,1,0 10266,9009,9010,1,0 10267,3004,9010,1,0 10268,3004,9010,1,0 10269,9011,9012,1,0 10270,9010,9012,1,0 10271,9012,9011,1,0 10272,9012,9013,1,0 10273,9015,9013,1,0 10274,9008,9014,1,0 10275,9016,9014,1,0 10276,9013,9015,1,0 10277,9014,9016,1,0 10278,9010,9009,1,0 10279,2387,9002,1,0 10280,9001,2385,1,0 10281,8984,2386,1,0 10282,3337,9003,2,0 10283,3831,9004,2,0 10284,3310,2366,1,0 10285,9004,2367,1,0 10286,3337,8999,2,0 10287,8986,8987,1,0 10288,3004,8987,1,0 10289,8988,8989,1,0 10290,8987,8989,1,0 10291,8989,8988,1,0 10292,8989,8990,1,0 10293,3293,8991,2,0 10294,8991,8992,1,0 10295,8992,2327,1,0 10296,3004,2328,1,0 10297,3283,8993,1,0 10298,8981,2293,1,0 10299,3026,2294,1,0 10300,8987,8986,1,0 10301,3293,8985,2,0 10302,8985,3294,3,0 10303,2125,9117,0,0 10304,2384,9118,2,0 10305,3003,9119,1,0 10306,9117,9121,1,0 10307,2384,9122,2,0 10308,9117,9123,1,0 10309,9122,9124,1,0 10310,9124,2384,3,0 10311,9118,9125,1,0 10312,9125,2384,3,0 10313,3200,9120,2,0 10314,2126,9126,0,0 10315,2127,9127,0,0 10316,2128,9128,0,0 10317,2385,9127,3,0 10318,3469,9129,2,0 10319,2385,3831,3,0 10320,3483,9130,2,0 10321,3004,9131,1,0 10322,9132,9131,1,0 10323,9131,9132,1,0 10324,3337,9133,2,0 10325,2406,3469,3,0 10326,9128,9134,1,0 10327,9128,9135,1,0 10328,9126,9136,1,0 10329,3337,9137,2,0 10330,9127,9280,2,0 10331,3469,9281,2,0 10332,3163,9282,2,0 10333,9127,9283,2,0 10334,9283,2387,1,0 10335,9129,3469,3,0 10336,9127,9196,2,0 10337,3831,9197,2,0 10338,9134,2376,1,0 10339,9127,9198,2,0 10340,9198,9199,1,0 10341,9199,2376,1,0 10342,9127,9221,2,0 10343,2335,9222,1,0 10344,3004,2334,1,0 10345,3004,9223,1,0 10346,9224,9223,1,0 10347,9223,9224,1,0 10348,9127,9225,2,0 10349,3004,9227,1,0 10350,9226,9227,1,0 10351,9228,9229,1,0 10352,9227,9229,1,0 10353,9229,9228,1,0 10354,9229,9230,1,0 10355,9230,3831,3,0 10356,3004,9158,1,0 10357,9236,9158,1,0 10358,9230,9158,1,0 10359,9209,9158,1,0 10360,9195,9158,1,0 10361,9157,9158,1,0 10362,9142,9158,1,0 10363,9154,9158,1,0 10364,9154,9158,1,0 10365,9154,9158,1,0 10366,9127,9159,2,0 10367,3200,9160,2,0 10368,3163,9161,2,0 10369,3283,9162,1,0 10370,3293,9163,2,0 10371,3026,2400,1,0 10372,9163,2401,1,0 10373,9163,9165,1,0 10374,9165,2327,1,0 10375,3004,2328,1,0 10376,3283,9166,1,0 10377,9158,9127,3,0 10378,3283,9167,1,0 10379,9163,9164,1,0 10380,9227,9226,1,0 10381,3337,9239,2,0 10382,9239,9240,1,0 10383,3831,9241,2,0 10384,9241,9242,1,0 10385,9127,9243,2,0 10386,9127,9138,2,0 10387,3831,9141,2,0 10388,9141,2400,1,0 10389,9138,2401,1,0 10390,9138,9142,1,0 10391,3831,9143,2,0 10392,3200,9144,2,0 10393,3831,9139,2,0 10394,9138,9140,1,0 10395,9127,9231,2,0 10396,3004,9233,1,0 10397,9232,9233,1,0 10398,9234,9235,1,0 10399,9233,9235,1,0 10400,9235,9234,1,0 10401,9235,9236,1,0 10402,9236,3831,3,0 10403,9233,9232,1,0 10404,9222,9237,1,0 10405,3004,3831,3,0 10406,3163,9238,2,0 10407,3337,9244,2,0 10408,3470,9246,2,0 10409,2,9246,3,2 10410,3483,9247,2,0 10411,9127,9248,2,0 10412,2724,2268,1,0 10413,9127,2384,1,0 10414,9127,9249,2,0 10415,3293,9250,2,0 10416,9249,3294,3,0 10417,9136,9251,1,0 10418,3294,9252,2,0 10419,3293,9253,2,0 10420,9253,9254,1,0 10421,9255,9256,1,0 10422,3026,9256,1,0 10423,9256,9257,1,0 10424,9257,9258,1,0 10425,9258,3293,3,0 10426,3075,9259,2,0 10427,9259,9260,1,0 10428,9260,2391,1,0 10429,3026,9270,1,0 10430,9272,9270,1,0 10431,9136,9271,1,0 10432,9273,9271,1,0 10433,9270,9272,1,0 10434,9271,9273,1,0 10435,9250,9274,1,0 10436,3200,9275,2,0 10437,3026,9276,1,0 10438,3026,9276,1,0 10439,3026,9276,1,0 10440,3026,9276,1,0 10441,3026,9276,1,0 10442,9278,9276,1,0 10443,9136,9277,1,0 10444,9136,9277,1,0 10445,9136,9277,1,0 10446,9136,9277,1,0 10447,9136,9277,1,0 10448,9279,9277,1,0 10449,9276,9278,1,0 10450,9277,9279,1,0 10451,9250,3293,3,0 10452,3163,9261,2,0 10453,3294,9262,2,0 10454,3029,9263,1,0 10455,9262,9263,1,0 10456,9263,2327,1,0 10457,3295,9264,2,0 10458,3836,9265,2,0 10459,3283,9266,1,0 10460,9266,9267,1,0 10461,3281,9267,1,0 10462,3483,9268,2,0 10463,3176,9269,2,0 10464,3038,3483,3,0 10465,9256,9255,1,0 10466,3038,3483,3,0 10467,3200,9245,2,0 10468,3337,9220,2,0 10469,3337,9219,2,0 10470,9127,9200,2,0 10471,3831,9203,2,0 10472,9203,2400,1,0 10473,9200,2401,1,0 10474,9200,9204,1,0 10475,9200,9205,1,0 10476,9205,2376,1,0 10477,9204,9206,1,0 10478,9208,9206,1,0 10479,9208,9206,1,0 10480,3831,9207,2,0 10481,9206,9208,1,0 10482,9208,2375,1,0 10483,9208,2376,1,0 10484,9206,9209,1,0 10485,9206,9209,1,0 10486,9206,9209,1,0 10487,9127,9210,2,0 10488,3259,9217,4,2 10489,9217,9218,2,0 10490,3259,9211,4,4 10491,3259,9212,1,0 10492,9212,9213,2,0 10493,9211,9214,1,0 10494,9217,9215,1,0 10495,9134,2370,1,0 10496,9215,9216,2,0 10497,9216,2370,1,0 10498,3831,9201,2,0 10499,9200,9202,1,0 10500,9127,2384,1,0 10501,9127,9170,2,0 10502,9127,9171,2,0 10503,3831,9172,2,0 10504,9171,9173,1,0 10505,9176,9173,1,0 10506,1171,9174,0,0 10507,9174,9175,2,0 10508,9173,9176,1,0 10509,9175,9177,1,0 10510,9173,9178,1,0 10511,9173,9178,1,0 10512,9184,9188,1,0 10513,9178,9188,1,0 10514,3833,2370,1,0 10515,3831,9189,2,0 10516,9188,9190,1,0 10517,9193,9190,1,0 10518,1171,9191,0,0 10519,9191,9192,2,0 10520,9190,9193,1,0 10521,9192,9194,1,0 10522,9190,9195,1,0 10523,9190,9195,1,0 10524,9178,9179,1,0 10525,9182,9179,1,0 10526,1171,9180,0,0 10527,9180,9181,2,0 10528,9179,9182,1,0 10529,9181,9183,1,0 10530,9182,9184,1,0 10531,9179,9185,1,0 10532,9185,2370,1,0 10533,9171,9186,1,0 10534,9186,9127,3,0 10535,3200,9187,2,0 10536,9127,2384,1,0 10537,3831,9157,2,0 10538,3470,9169,2,0 10539,2,9169,3,2 10540,9127,9145,2,0 10541,3831,9146,2,0 10542,9145,9147,1,0 10543,9150,9147,1,0 10544,1171,9148,0,0 10545,9148,9149,2,0 10546,9147,9150,1,0 10547,9149,9151,1,0 10548,9147,9152,1,0 10549,9147,9152,1,0 10550,9152,9153,1,0 10551,9153,2376,1,0 10552,9152,9154,1,0 10553,9156,9154,1,0 10554,9156,9154,1,0 10555,3831,9155,2,0 10556,9154,9156,1,0 10557,9156,2375,1,0 10558,9156,2376,1,0 10559,3470,9168,2,0 10560,2,9168,3,2 10561,3258,2369,1,0 10562,3793,2268,1,0 10563,2407,3469,3,0 10564,3038,3483,3,0 10565,3834,9284,2,0 10566,9284,9285,1,0 10567,9288,9285,1,0 10568,3026,9286,1,0 10569,9287,9286,1,0 10570,9286,9287,1,0 10571,9285,9288,1,0 10572,2129,9289,0,0 10573,2130,9290,0,0 10574,2131,9291,0,0 10575,2132,9292,0,0 10576,2133,9293,0,0 10577,2389,3835,3,0 10578,9293,9294,1,0 10579,9294,9295,1,0 10580,3076,9296,2,0 10581,3074,9297,2,0 10582,9296,9298,1,0 10583,9297,9298,1,0 10584,9298,3836,3,0 10585,3075,9299,2,0 10586,9299,3295,3,0 10587,3293,9300,2,0 10588,9300,3294,3,0 10589,3295,9301,2,0 10590,3294,9302,2,0 10591,9302,2376,1,0 10592,3294,9308,2,0 10593,9308,2375,1,0 10594,3075,9332,2,0 10595,3295,9333,2,0 10596,3293,9334,2,0 10597,3294,9335,2,0 10598,9294,9370,1,0 10599,9294,9370,1,0 10600,9294,9370,1,0 10601,9294,9370,1,0 10602,9294,9370,1,0 10603,9294,9370,1,0 10604,9294,9370,1,0 10605,9294,9370,1,0 10606,9294,9370,1,0 10607,9294,9370,1,0 10608,9294,9370,1,0 10609,9294,9370,1,0 10610,9294,9370,1,0 10611,9294,9370,1,0 10612,9294,9370,1,0 10613,9294,9370,1,0 10614,9294,9370,1,0 10615,9294,9370,1,0 10616,9294,9370,1,0 10617,9294,9370,1,0 10618,9294,9370,1,0 10619,9373,9370,1,0 10620,3026,9371,1,0 10621,3026,9371,1,0 10622,3026,9371,1,0 10623,3026,9371,1,0 10624,3026,9371,1,0 10625,3026,9371,1,0 10626,3026,9371,1,0 10627,3026,9371,1,0 10628,3026,9371,1,0 10629,3026,9371,1,0 10630,3026,9371,1,0 10631,3026,9371,1,0 10632,3026,9371,1,0 10633,3026,9371,1,0 10634,3026,9371,1,0 10635,3026,9371,1,0 10636,3026,9371,1,0 10637,3026,9371,1,0 10638,3026,9371,1,0 10639,3026,9371,1,0 10640,3026,9371,1,0 10641,9372,9371,1,0 10642,9371,9372,1,0 10643,9370,9373,1,0 10644,3294,9324,2,0 10645,9324,2375,1,0 10646,3294,9325,2,0 10647,9325,2376,1,0 10648,3294,9327,2,0 10649,9327,2375,1,0 10650,3294,9328,2,0 10651,9328,9329,1,0 10652,9329,9326,1,0 10653,9326,3294,3,0 10654,3294,9330,2,0 10655,9330,9331,1,0 10656,9331,3294,3,0 10657,9327,2376,1,0 10658,3294,9307,2,0 10659,3294,9311,2,0 10660,3294,9315,2,0 10661,3025,3294,3,0 10662,9311,2375,1,0 10663,3294,9309,2,0 10664,9309,9310,1,0 10665,9310,3294,3,0 10666,9290,2293,1,0 10667,9309,2294,1,0 10668,3294,9312,2,0 10669,3295,9313,2,0 10670,9289,2293,1,0 10671,9302,2294,1,0 10672,9302,9314,1,0 10673,9314,3294,3,0 10674,3294,9303,2,0 10675,9303,9304,1,0 10676,3294,9305,2,0 10677,9305,9306,1,0 10678,9306,3294,3,0 10679,9292,2293,1,0 10680,9303,2294,1,0 10681,9308,2376,1,0 10682,3294,9316,2,0 10683,9316,2375,1,0 10684,3294,9317,2,0 10685,3294,9321,2,0 10686,3294,9322,2,0 10687,9322,9323,1,0 10688,9323,3294,3,0 10689,9291,2293,1,0 10690,9322,2294,1,0 10691,9321,2375,1,0 10692,9321,2376,1,0 10693,9317,2376,1,0 10694,3294,9318,2,0 10695,9318,2375,1,0 10696,3294,9319,2,0 10697,9319,9320,1,0 10698,9320,3294,3,0 10699,9318,2376,1,0 10700,3295,9336,2,0 10701,9336,9337,1,0 10702,9337,3295,3,0 10703,3026,3294,3,0 10704,9339,9340,1,0 10705,9337,9340,1,0 10706,9339,9340,1,0 10707,9338,9341,1,0 10708,3026,9341,1,0 10709,9338,9341,1,0 10710,3294,9342,2,0 10711,9342,9357,1,0 10712,9342,9357,1,0 10713,9342,9357,1,0 10714,9342,9357,1,0 10715,9342,9357,1,0 10716,9342,9357,1,0 10717,9342,9357,1,0 10718,9342,9357,1,0 10719,9357,9360,1,0 10720,3295,9361,2,0 10721,3836,9362,2,0 10722,3295,9366,2,0 10723,2490,2394,1,0 10724,2807,9367,2,0 10725,9367,2395,1,0 10726,2817,9368,2,0 10727,9368,2395,1,0 10728,3075,9363,2,0 10729,9363,3836,3,0 10730,9363,9364,1,0 10731,3293,9365,2,0 10732,2807,9358,2,0 10733,9358,2395,1,0 10734,2817,9359,2,0 10735,9359,2395,1,0 10736,2807,9343,2,0 10737,9343,2395,1,0 10738,2817,9344,2,0 10739,9344,2395,1,0 10740,3840,9345,1,0 10741,9346,9345,1,0 10742,9345,9346,1,0 10743,9342,9353,1,0 10744,9352,9353,1,0 10745,9352,9353,1,0 10746,9353,9354,1,0 10747,2807,9355,2,0 10748,9355,2395,1,0 10749,2817,9356,2,0 10750,9356,2395,1,0 10751,9342,9347,1,0 10752,9348,9347,1,0 10753,9347,9348,1,0 10754,3842,9349,1,0 10755,9350,9349,1,0 10756,9349,9350,1,0 10757,9347,9351,1,0 10758,9351,9352,1,0 10759,3294,9338,2,0 10760,3295,9339,2,0 10761,2490,2394,1,0 10762,3294,9369,2,0 10763,3838,2393,1,0 10764,3838,2392,1,0 10765,3838,2394,1,0 10766,3294,9374,2,0 10767,3295,9375,2,0 10768,83,9376,1,0 10769,9378,9376,1,0 10770,3076,9377,2,0 10771,9376,9378,1,0 10772,9379,9380,1,0 10773,3026,9380,1,0 10774,9380,9379,1,0 10775,2335,9381,1,0 10776,3026,2334,1,0 10777,9376,9382,1,0 10778,9384,9383,1,0 10779,3026,9383,1,0 10780,9383,9384,1,0 10781,9376,9385,1,0 10782,9382,9385,1,0 10783,3026,3294,3,0 10784,9385,3295,3,0 10785,3076,9386,2,0 10786,9386,3836,3,0 10787,2390,3835,3,0 10788,3838,2393,1,0 10789,9375,3295,3,0 10790,9374,3294,3,0 10791,3294,9387,2,0 10792,3295,9388,2,0 10793,9388,3836,3,0 10794,9387,3294,3,0 10795,3294,9389,2,0 10796,3029,9390,1,0 10797,9389,9390,1,0 10798,9390,2327,1,0 10799,3838,2392,1,0 10800,3838,2394,1,0 10801,3293,9391,2,0 10802,9391,9392,1,0 10803,9396,9392,1,0 10804,3844,9394,1,0 10805,9395,9394,1,0 10806,9394,9395,1,0 10807,9392,9396,1,0 10808,9392,9393,1,0 10809,3838,9397,1,0 10810,9398,9397,1,0 10811,9397,9398,1,0 10812,3846,9399,1,0 10813,9400,9399,1,0 10814,9399,9400,1,0 10815,3838,9401,1,0 10816,3846,9401,1,0 10817,3848,9401,1,0 10818,9401,9402,1,0 10819,3076,9403,2,0 10820,3074,9404,2,0 10821,9403,9405,1,0 10822,9404,9405,1,0 10823,9405,9406,1,0 10824,2391,9406,1,0 10825,9406,3836,3,0 10826,9393,3294,3,0 10827,3075,9408,2,0 10828,9408,3295,3,0 10829,9401,2393,1,0 10830,3075,9407,2,0 10831,9407,3836,3,0 10832,1171,9410,0,0 10833,9410,9411,2,0 10834,3294,9412,2,0 10835,9411,9413,1,0 10836,9411,9414,1,0 10837,9411,9414,1,0 10838,9412,9415,1,0 10839,9412,9415,1,0 10840,2392,9416,1,0 10841,2392,9416,1,0 10842,9417,9416,1,0 10843,9416,9417,1,0 10844,9415,9422,1,0 10845,9418,9422,1,0 10846,9422,9418,1,0 10847,9414,9419,1,0 10848,2392,9420,1,0 10849,9421,9420,1,0 10850,9420,9421,1,0 10851,9422,9423,1,0 10852,9422,9423,1,0 10853,9422,9423,1,0 10854,9423,3294,3,0 10855,3294,9409,2,0 10856,2393,9424,1,0 10857,3294,9425,2,0 10858,3294,9426,2,0 10859,2394,2392,1,0 10860,3294,9427,2,0 10861,3294,9433,2,0 10862,1171,9428,0,0 10863,9428,9429,2,0 10864,9429,9430,1,0 10865,2394,9431,1,0 10866,9432,9431,1,0 10867,9431,9432,1,0 10868,2134,9434,0,0 10869,3294,9435,2,0 10870,9436,9437,1,0 10871,9435,9437,1,0 10872,3295,9438,2,0 10873,3836,9439,2,0 10874,9438,9443,1,0 10875,9443,3295,3,0 10876,3026,3294,3,0 10877,3835,9440,2,0 10878,9437,9441,1,0 10879,3026,2400,1,0 10880,9437,2401,1,0 10881,9437,9442,1,0 10882,9442,3294,3,0 10883,9434,2293,1,0 10884,9435,2294,1,0 10885,9435,9436,1,0 10886,9436,3294,3,0 10887,3026,2400,1,0 10888,9435,2401,1,0 10889,9435,9445,1,0 10890,9445,3294,3,0 10891,3835,9446,2,0 10892,3295,9447,2,0 10893,9447,3836,3,0 10894,3295,9448,2,0 10895,3836,9449,2,0 10896,9448,9450,1,0 10897,9450,3295,3,0 10898,9454,9455,1,0 10899,3026,9455,1,0 10900,9455,3294,3,0 10901,9451,9452,1,0 10902,3026,9452,1,0 10903,9452,9453,1,0 10904,9453,9454,1,0 10905,9452,9451,1,0 10906,3026,3294,3,0 10907,9435,9444,1,0 10908,9456,9457,1,0 10909,2395,9457,1,0 10910,9457,9458,1,0 10911,9457,9456,1,0 10912,2135,9459,0,0 10913,9459,2293,1,0 10914,2398,2294,1,0 10915,1171,9460,0,0 10916,9460,9461,2,0 10917,9461,9462,1,0 10918,2136,9463,0,0 10919,2400,9464,1,0 10920,9465,9464,1,0 10921,9463,2293,1,0 10922,9464,2294,1,0 10923,9464,9465,1,0 10924,2137,9466,0,0 10925,9466,2293,1,0 10926,2402,2294,1,0 10927,3152,9467,2,0 10928,3292,9468,2,0 10929,9468,9469,1,0 10930,9470,9469,1,0 10931,9469,9470,1,0 10932,3074,9471,2,0 10933,3470,9472,2,0 10934,2,9472,3,2 10935,3850,2268,1,0 10936,3290,9473,1,0 10937,9473,9474,2,0 10938,9474,9475,1,0 10939,3151,9476,2,0 10940,9480,9481,1,0 10941,9475,9481,1,0 10942,9481,9480,1,0 10943,3151,9477,2,0 10944,9475,9478,1,0 10945,9479,9478,1,0 10946,9478,9479,1,0 10947,3150,9482,2,0 10948,3151,9483,2,0 10949,3290,9488,1,0 10950,9488,9489,2,0 10951,9489,9490,1,0 10952,9491,9490,1,0 10953,9490,9491,1,0 10954,3157,9487,2,0 10955,3150,9484,2,0 10956,3151,9485,2,0 10957,9485,9486,1,0 10958,9484,9486,1,0 10959,3483,9492,2,0 10960,3038,3483,3,0 10961,3026,2400,1,0 10962,2404,2401,1,0 10963,2404,9495,1,0 10964,3029,9496,1,0 10965,9495,9496,1,0 10966,9496,2327,1,0 10967,3283,9497,1,0 10968,2404,9494,1,0 10969,3283,9493,1,0 10970,3029,9498,1,0 10971,2405,9498,1,0 10972,9498,2327,1,0 10973,3283,9499,1,0 10974,3349,9500,2,0 10975,9500,3293,3,0 10976,3852,2268,1,0 10977,3163,9511,2,0 10978,3163,9512,2,0 10979,3290,9505,1,0 10980,9505,9506,2,0 10981,9506,9507,1,0 10982,9507,9510,1,0 10983,9508,9510,1,0 10984,9510,9508,1,0 10985,3884,9509,2,0 10986,3854,2268,1,0 10987,3290,9501,1,0 10988,9501,9502,2,0 10989,9502,9503,1,0 10990,9502,9504,1,0 10991,3469,9513,2,0 10992,2,9513,3,2 10993,2138,9514,0,0 10994,3292,9515,2,0 10995,9514,9516,1,0 10996,9515,9544,1,0 10997,9543,9544,1,0 10998,3283,9545,4,1 10999,3283,9517,1,0 11000,9544,9543,1,0 11001,3290,9518,1,0 11002,9518,9519,2,0 11003,2724,2268,1,0 11004,3290,9520,1,0 11005,9520,9521,2,0 11006,9520,9522,1,0 11007,9544,9523,1,0 11008,9523,9524,1,0 11009,9527,9524,1,0 11010,9516,9525,1,0 11011,9526,9525,1,0 11012,9525,9526,1,0 11013,9524,9527,1,0 11014,9518,9528,2,0 11015,9528,9529,1,0 11016,9522,9530,2,0 11017,9530,9531,1,0 11018,9529,9532,1,0 11019,9535,9532,1,0 11020,9531,9533,1,0 11021,9534,9533,1,0 11022,9533,9534,1,0 11023,9532,9535,1,0 11024,9518,9536,2,0 11025,9536,9537,1,0 11026,9516,9538,1,0 11027,9541,9538,1,0 11028,9537,9539,1,0 11029,9540,9539,1,0 11030,9539,9540,1,0 11031,9538,9541,1,0 11032,9518,9542,2,0 11033,9542,9522,3,0 11034,9544,9518,3,0 11035,3176,9546,2,0 11036,3292,9548,2,0 11037,9548,9549,1,0 11038,3283,9550,4,1 11039,3283,9551,1,0 11040,3147,9552,2,0 11041,3283,9553,1,0 11042,3283,9554,4,1 11043,3292,9555,2,0 11044,3283,9560,1,0 11045,9555,9566,1,0 11046,9566,9568,1,0 11047,9567,9568,1,0 11048,9568,9567,1,0 11049,9568,9569,1,0 11050,9568,9569,1,0 11051,9569,9571,1,0 11052,9570,9571,1,0 11053,9571,9570,1,0 11054,9555,9572,1,0 11055,3283,9615,1,0 11056,9615,9616,1,0 11057,3281,9616,1,0 11058,3163,9617,2,0 11059,3163,9618,2,0 11060,3176,9619,2,0 11061,3163,9620,2,0 11062,3176,9621,2,0 11063,3176,9622,2,0 11064,3292,9624,2,0 11065,9624,9625,1,0 11066,9625,9627,1,0 11067,9626,9627,1,0 11068,9627,9626,1,0 11069,3283,9628,1,0 11070,9628,9629,1,0 11071,3281,9629,1,0 11072,3292,9643,2,0 11073,9643,9644,1,0 11074,9643,9645,1,0 11075,9645,9648,1,0 11076,9646,9648,1,0 11077,9644,9649,1,0 11078,9647,9649,1,0 11079,9648,9646,1,0 11080,9649,9647,1,0 11081,9650,9651,1,0 11082,9648,9651,1,0 11083,9651,9650,1,0 11084,9651,9652,1,0 11085,9653,9654,1,0 11086,9652,9654,1,0 11087,9654,9653,1,0 11088,3283,9655,1,0 11089,3176,9656,2,0 11090,9546,3176,3,0 11091,3163,9623,2,0 11092,3292,9630,2,0 11093,3292,9639,2,0 11094,9639,9640,1,0 11095,9640,9642,1,0 11096,9641,9642,1,0 11097,9642,9641,1,0 11098,3283,9631,1,0 11099,9630,9632,1,0 11100,9632,9634,1,0 11101,9635,9634,1,0 11102,9634,9635,1,0 11103,3176,9633,2,0 11104,9630,9636,1,0 11105,9636,9638,1,0 11106,9637,9638,1,0 11107,9638,9637,1,0 11108,3176,9607,2,0 11109,3163,9608,2,0 11110,3283,9609,1,0 11111,3283,9610,4,1 11112,3156,9611,2,0 11113,3159,9612,2,0 11114,3162,9614,2,0 11115,3176,9613,2,0 11116,3292,9580,2,0 11117,3176,9581,2,0 11118,3163,9582,2,0 11119,3283,9583,1,0 11120,9583,9584,1,0 11121,3281,9584,1,0 11122,9580,9585,1,0 11123,9585,9587,1,0 11124,9586,9587,1,0 11125,9587,9586,1,0 11126,9580,9598,1,0 11127,9580,9599,1,0 11128,9599,9600,1,0 11129,9602,9600,1,0 11130,9598,9601,1,0 11131,9603,9601,1,0 11132,9600,9602,1,0 11133,9601,9603,1,0 11134,9599,9604,1,0 11135,9602,9604,1,0 11136,9604,9605,1,0 11137,9606,9605,1,0 11138,9605,9606,1,0 11139,3283,9590,4,1 11140,3283,9591,1,0 11141,9580,9593,1,0 11142,9593,9594,1,0 11143,9595,9594,1,0 11144,9594,9595,1,0 11145,3176,9592,2,0 11146,3283,9596,1,0 11147,3176,9597,2,0 11148,3283,9588,1,0 11149,3176,9589,2,0 11150,3292,9574,2,0 11151,9574,9575,1,0 11152,9575,9579,1,0 11153,9576,9579,1,0 11154,9579,9576,1,0 11155,3163,9577,2,0 11156,3283,9578,1,0 11157,3163,9573,2,0 11158,3163,9563,2,0 11159,3292,9564,2,0 11160,9564,9565,1,0 11161,9555,9562,1,0 11162,9555,9561,1,0 11163,3283,9556,4,1 11164,9555,9557,1,0 11165,9557,9558,1,0 11166,9559,9558,1,0 11167,9558,9559,1,0 11168,3163,9547,2,0 11169,3283,9657,4,1 11170,3163,9665,2,0 11171,3176,9658,2,0 11172,3163,9659,2,0 11173,3283,9660,1,0 11174,3163,9661,2,0 11175,3293,9662,2,0 11176,3150,9663,2,0 11177,3151,9664,2,0 11178,9662,3293,3,0 11179,3283,9666,4,1 11180,3283,9667,1,0 11181,3283,9668,1,0 11182,3469,9669,2,0 11183,2407,3469,3,0 11184,9669,3469,3,0 11185,3159,9670,2,0 11186,3163,9672,2,0 11187,3159,9673,2,0 11188,3176,9671,2,0 11189,3290,9675,1,0 11190,9675,9676,2,0 11191,9676,9677,1,0 11192,9676,9679,1,0 11193,3176,9680,2,0 11194,3283,9681,4,1 11195,3175,9682,2,0 11196,3283,9683,4,1 11197,3177,9684,2,0 11198,9677,9687,1,0 11199,9686,9687,1,0 11200,9687,9685,1,0 11201,9685,9686,1,0 11202,9687,9686,1,0 11203,9676,9678,1,0 11204,3469,9674,2,0 11205,2300,3469,3,0 11206,3156,9688,2,0 11207,3283,9698,1,0 11208,3290,9699,1,0 11209,9699,9700,2,0 11210,9700,9701,1,0 11211,9700,9702,1,0 11212,9701,9704,1,0 11213,9703,9704,1,0 11214,9704,9705,1,0 11215,9704,9705,1,0 11216,9700,9706,1,0 11217,9700,9707,1,0 11218,9696,9707,1,0 11219,9696,9707,1,0 11220,9702,9708,1,0 11221,3283,9709,4,1 11222,3156,9710,2,0 11223,3162,9711,2,0 11224,9707,9721,1,0 11225,9721,9722,1,0 11226,9707,9723,1,0 11227,9723,9724,1,0 11228,9722,9725,1,0 11229,9728,9725,1,0 11230,9724,9726,1,0 11231,9727,9726,1,0 11232,9726,9727,1,0 11233,9725,9728,1,0 11234,9708,9729,1,0 11235,9729,9730,1,0 11236,9731,9730,1,0 11237,9730,9731,1,0 11238,3292,9712,2,0 11239,9712,9713,1,0 11240,9712,9714,1,0 11241,9713,9716,1,0 11242,9715,9716,1,0 11243,9714,9717,1,0 11244,9718,9717,1,0 11245,9717,9718,1,0 11246,9716,9719,1,0 11247,9716,9719,1,0 11248,9720,9719,1,0 11249,9719,9720,1,0 11250,9716,9715,1,0 11251,9704,9703,1,0 11252,3292,9689,2,0 11253,9689,9690,1,0 11254,9690,9691,1,0 11255,9692,9691,1,0 11256,9691,9692,1,0 11257,9692,9693,1,0 11258,9693,9694,1,0 11259,9695,9694,1,0 11260,9694,9695,1,0 11261,9695,9696,1,0 11262,3283,9697,1,0 11263,2409,2413,1,0 11264,2333,9733,1,0 11265,9733,3294,3,0 11266,3026,3293,3,0 11267,2332,9732,1,0 11268,9732,3294,3,0 11269,2410,3294,3,0 11270,2409,2412,1,0 11271,2411,2365,1,0 11272,2333,9735,1,0 11273,9735,3294,3,0 11274,3026,3293,3,0 11275,2332,9734,1,0 11276,9734,3294,3,0 11277,2411,3294,3,0 11278,3075,9736,2,0 11279,3076,9737,2,0 11280,3200,9738,2,0 11281,3075,9739,2,0 11282,3079,9740,2,0 11283,9739,9742,1,0 11284,9742,3075,3,0 11285,3147,9743,2,0 11286,3195,9744,2,0 11287,3147,9746,2,0 11288,3195,9747,2,0 11289,3075,9750,2,0 11290,9750,9751,1,0 11291,9751,2412,1,0 11292,3075,9748,2,0 11293,9748,9749,1,0 11294,9749,2417,1,0 11295,3283,9754,1,0 11296,3075,9755,2,0 11297,9755,9756,1,0 11298,9756,3075,3,0 11299,9757,9758,1,0 11300,9756,9758,1,0 11301,9755,9757,1,0 11302,9757,3075,3,0 11303,3075,9752,2,0 11304,9752,9753,1,0 11305,9753,3075,3,0 11306,9753,2364,1,0 11307,9739,9745,1,0 11308,9745,2417,1,0 11309,9739,9741,1,0 11310,9741,2413,1,0 11311,3075,9759,2,0 11312,3074,9760,2,0 11313,3200,9761,2,0 11314,3074,9762,2,0 11315,3075,9763,2,0 11316,9763,9765,1,0 11317,9765,3075,3,0 11318,3075,9766,2,0 11319,9766,9767,1,0 11320,9767,2412,1,0 11321,9765,2417,1,0 11322,3075,9768,2,0 11323,9768,9769,1,0 11324,9769,3075,3,0 11325,9768,9770,1,0 11326,9770,3075,3,0 11327,9770,9771,1,0 11328,9769,9771,1,0 11329,9763,9764,1,0 11330,9764,2413,1,0 11331,9774,9779,1,0 11332,2412,9779,1,0 11333,2412,9779,1,0 11334,2412,9779,1,0 11335,9776,9780,1,0 11336,9778,9780,1,0 11337,2412,9780,1,0 11338,2412,9780,1,0 11339,9779,2413,1,0 11340,9780,2414,1,0 11341,9773,9774,1,0 11342,2412,9774,1,0 11343,3029,2327,1,0 11344,3470,9775,2,0 11345,2416,9776,1,0 11346,9774,2415,1,0 11347,3029,2327,1,0 11348,3470,9777,2,0 11349,2416,9778,1,0 11350,2412,2415,1,0 11351,3029,2327,1,0 11352,3470,9772,2,0 11353,2416,9773,1,0 11354,2412,2415,1,0 11355,3075,9781,2,0 11356,2413,2412,1,0 11357,2414,3075,3,0 11358,2413,3075,3,0 11359,3283,9782,1,0 11360,2413,3075,3,0 11361,2413,2364,1,0 11362,2413,3075,3,0 11363,9783,9785,1,0 11364,2415,9785,1,0 11365,3076,9786,2,0 11366,9785,9783,1,0 11367,3029,2327,1,0 11368,3470,9784,2,0 11369,2415,9787,1,0 11370,9785,9787,1,0 11371,9785,9787,1,0 11372,9787,2416,1,0 11373,2417,9788,1,0 11374,3029,2327,1,0 11375,3470,9789,2,0 11376,3075,9790,2,0 11377,3283,9791,1,0 11378,3283,9795,1,0 11379,3075,9792,2,0 11380,9792,9793,1,0 11381,9793,3075,3,0 11382,3283,9794,1,0 11383,9793,2364,1,0 11384,2418,9796,1,0 11385,9796,9806,1,0 11386,9805,9806,1,0 11387,9806,2419,1,0 11388,2418,9797,1,0 11389,2418,9798,1,0 11390,9798,9800,1,0 11391,9799,9800,1,0 11392,9800,9799,1,0 11393,9800,9801,1,0 11394,9801,9805,1,0 11395,9804,9805,1,0 11396,2418,9802,1,0 11397,9801,9803,1,0 11398,9804,9803,1,0 11399,9803,9804,1,0 11400,3878,9834,1,0 11401,3880,9834,1,0 11402,9834,2421,1,0 11403,3878,9829,1,0 11404,9808,9829,1,0 11405,9817,9829,1,0 11406,9817,9829,1,0 11407,2420,9830,1,0 11408,9807,9830,1,0 11409,9809,9830,1,0 11410,9818,9830,1,0 11411,9809,9830,1,0 11412,9809,9830,1,0 11413,9820,9830,1,0 11414,9809,9830,1,0 11415,9818,9830,1,0 11416,9830,9831,1,0 11417,9809,9807,1,0 11418,9831,9807,1,0 11419,9829,9808,1,0 11420,9829,9832,1,0 11421,9832,9833,1,0 11422,9830,9809,1,0 11423,9830,9821,1,0 11424,9821,9822,1,0 11425,9809,9822,1,0 11426,9809,9814,1,0 11427,9822,9814,1,0 11428,9829,9815,1,0 11429,9813,9815,1,0 11430,9815,9816,1,0 11431,9829,9817,1,0 11432,9816,9817,1,0 11433,9809,9818,1,0 11434,9814,9818,1,0 11435,3883,9823,2,0 11436,3883,9826,2,0 11437,9825,9827,1,0 11438,9826,9827,1,0 11439,3882,9828,1,0 11440,3884,9824,2,0 11441,3886,9825,1,0 11442,9824,9825,1,0 11443,9810,9811,1,0 11444,9829,9811,1,0 11445,9829,9811,1,0 11446,9811,9812,1,0 11447,9812,9813,1,0 11448,9829,9813,1,0 11449,9829,9810,1,0 11450,9830,9819,1,0 11451,9830,9820,1,0 11452,3890,9835,2,0 11453,9839,9840,1,0 11454,9835,9840,1,0 11455,9838,9841,1,0 11456,2422,9841,1,0 11457,9842,9843,1,0 11458,9840,9843,1,0 11459,9840,9843,1,0 11460,9843,9842,1,0 11461,9843,9844,1,0 11462,9840,9837,1,0 11463,9843,9837,1,0 11464,9836,9838,1,0 11465,2422,9838,1,0 11466,9837,9839,1,0 11467,9841,9836,1,0 11468,2139,9845,0,0 11469,2140,9846,0,0 11470,2141,9847,0,0 11471,3890,9848,2,0 11472,9847,9849,1,0 11473,9847,9850,1,0 11474,9846,9851,1,0 11475,9845,9852,1,0 11476,9848,9877,1,0 11477,9857,9877,1,0 11478,9858,9877,1,0 11479,9858,9877,1,0 11480,9859,9877,1,0 11481,9853,9854,1,0 11482,9877,9854,1,0 11483,9854,9853,1,0 11484,9854,9855,1,0 11485,9855,9856,1,0 11486,9856,9857,1,0 11487,9854,9857,1,0 11488,9857,9858,1,0 11489,9857,9859,1,0 11490,9860,9861,1,0 11491,9849,9861,1,0 11492,9863,9862,1,0 11493,9859,9862,1,0 11494,9862,9863,1,0 11495,9861,9860,1,0 11496,9862,9864,1,0 11497,9862,9864,1,0 11498,9861,9865,1,0 11499,9861,9865,1,0 11500,9848,3890,3,0 11501,9864,9866,1,0 11502,9852,9867,1,0 11503,9868,9869,1,0 11504,9851,9869,1,0 11505,9869,9870,1,0 11506,9874,9872,1,0 11507,9870,9872,1,0 11508,9871,9873,1,0 11509,9857,9873,1,0 11510,9872,9874,1,0 11511,9873,9875,1,0 11512,9875,9876,1,0 11513,9873,9871,1,0 11514,9869,9868,1,0 11515,2142,9878,0,0 11516,9878,9879,1,0 11517,9879,9909,1,0 11518,9879,9910,1,0 11519,9879,9910,1,0 11520,9909,9910,1,0 11521,9910,2425,1,0 11522,2424,9880,4,3 11523,9879,9881,4,3 11524,2423,9885,4,2 11525,9885,9886,2,0 11526,9886,9887,4,5 11527,9878,9888,1,0 11528,1,9889,0,0 11529,9889,9888,3,0 11530,2424,9890,4,1 11531,9890,9891,2,0 11532,2425,9892,1,0 11533,9891,2424,1,0 11534,9879,9893,4,1 11535,9892,9893,3,0 11536,9878,9894,1,0 11537,9894,9895,1,0 11538,9895,9896,2,0 11539,9896,9897,1,0 11540,9894,9898,1,0 11541,9897,9899,4,2 11542,9898,9899,3,0 11543,9894,9900,1,0 11544,9900,9901,2,0 11545,9901,9902,1,0 11546,9902,9900,3,0 11547,9892,9903,4,2 11548,9879,9903,3,0 11549,2424,9904,1,0 11550,9904,9905,2,0 11551,2425,9906,1,0 11552,9905,2424,1,0 11553,9878,9907,1,0 11554,9906,9907,3,0 11555,9879,2457,1,0 11556,9906,9908,4,2 11557,9879,9908,3,0 11558,2424,9882,4,1 11559,9882,9883,2,0 11560,9879,9884,4,1 11561,9883,9884,3,0 11562,2427,9911,4,3 11563,2426,9912,4,1 11564,2426,9933,4,2 11565,9933,9934,2,0 11566,9934,9935,4,5 11567,2427,9936,1,0 11568,1,9937,0,0 11569,9937,9936,3,0 11570,2427,9990,1,0 11571,2427,9990,1,0 11572,9944,9990,1,0 11573,9987,9990,1,0 11574,9989,9990,1,0 11575,9990,2428,1,0 11576,2146,9913,0,0 11577,9913,9914,1,0 11578,2427,9989,1,0 11579,9914,9915,4,3 11580,9913,9916,1,0 11581,9914,9917,4,2 11582,2427,9917,3,0 11583,2426,9918,4,2 11584,9918,9919,2,0 11585,9919,9920,4,5 11586,1,9921,0,0 11587,9921,9916,3,0 11588,2427,9922,1,0 11589,9914,9922,3,0 11590,2150,9923,0,0 11591,9923,9924,1,0 11592,2427,9925,4,1 11593,9924,9926,4,3 11594,9923,9927,1,0 11595,2427,9928,4,1 11596,9924,9928,3,0 11597,9924,9929,4,2 11598,2427,9929,3,0 11599,9918,9930,2,0 11600,9930,9931,4,5 11601,1,9932,0,0 11602,9932,9927,3,0 11603,2427,9938,4,1 11604,9938,9939,2,0 11605,2428,9940,1,0 11606,9939,2427,1,0 11607,9940,9938,3,0 11608,2427,9941,1,0 11609,9941,9942,2,0 11610,2428,9943,1,0 11611,9942,2427,1,0 11612,9943,9941,3,0 11613,2427,9944,1,0 11614,2427,9945,1,0 11615,9945,9946,2,0 11616,2428,9947,1,0 11617,9946,2427,1,0 11618,9947,9945,3,0 11619,2427,9948,4,2 11620,9948,9949,2,0 11621,2427,9950,4,1 11622,9950,9951,1,0 11623,9950,9952,1,0 11624,9952,9953,1,0 11625,2425,9954,1,0 11626,2426,2423,1,0 11627,9947,2424,1,0 11628,9954,9955,4,2 11629,2427,9955,3,0 11630,2427,9956,4,1 11631,9954,9956,3,0 11632,9945,9957,2,0 11633,2154,9958,0,0 11634,9958,9959,1,0 11635,9957,2457,1,0 11636,9959,9960,4,3 11637,9958,9961,1,0 11638,9957,9961,3,0 11639,9959,9945,3,0 11640,9959,9963,4,2 11641,2427,9963,3,0 11642,2427,9967,1,0 11643,9966,9967,1,0 11644,9967,9976,4,1 11645,9976,9977,2,0 11646,2158,9978,0,0 11647,9978,9979,1,0 11648,9977,2457,1,0 11649,9979,9980,4,3 11650,9978,9981,1,0 11651,9977,9981,3,0 11652,9979,9976,3,0 11653,9979,9983,4,2 11654,9967,9983,3,0 11655,9967,9986,1,0 11656,9985,9986,1,0 11657,9967,9987,1,0 11658,9967,9987,1,0 11659,9986,9987,1,0 11660,9987,9988,4,2 11661,9949,9988,3,0 11662,2425,9984,1,0 11663,2426,2423,1,0 11664,9979,2424,1,0 11665,2460,9985,1,0 11666,9986,2458,1,0 11667,9984,2459,1,0 11668,9977,9982,4,2 11669,9979,9982,3,0 11670,9967,9968,4,1 11671,9968,9969,2,0 11672,2162,9970,0,0 11673,9970,9971,1,0 11674,9969,2457,1,0 11675,9971,9972,4,3 11676,9970,9973,1,0 11677,9969,9973,3,0 11678,9971,9968,3,0 11679,9971,9975,4,2 11680,9967,9975,3,0 11681,9969,9974,4,2 11682,9971,9974,3,0 11683,9957,9962,4,2 11684,9959,9962,3,0 11685,2427,9966,1,0 11686,2427,9966,1,0 11687,9965,9966,1,0 11688,2425,9964,1,0 11689,2426,2423,1,0 11690,9954,2424,1,0 11691,2460,9965,1,0 11692,9966,2458,1,0 11693,9964,2459,1,0 11694,2430,9991,4,3 11695,2429,10010,1,0 11696,10010,10011,2,0 11697,2430,10012,1,0 11698,10011,10013,1,0 11699,2429,10014,4,8 11700,2430,9998,1,0 11701,9998,9999,2,0 11702,9999,2430,1,0 11703,2430,10000,4,1 11704,10000,10001,2,0 11705,10001,2430,1,0 11706,2430,9994,1,0 11707,9994,9995,2,0 11708,9995,2430,1,0 11709,2430,9996,4,1 11710,9996,9997,2,0 11711,9997,2430,1,0 11712,2430,10008,1,0 11713,10008,10009,2,0 11714,10009,2430,1,0 11715,2430,10002,4,1 11716,10002,10003,1,0 11717,2430,10006,1,0 11718,10006,10007,2,0 11719,10007,2430,1,0 11720,2430,10004,1,0 11721,10004,10005,2,0 11722,10005,2430,1,0 11723,2429,9993,4,17 11724,2429,9992,4,17 11725,2432,10015,4,2 11726,10015,10016,2,0 11727,10016,10017,4,3 11728,10016,10018,1,0 11729,10018,10019,2,0 11730,10016,10020,4,1 11731,10020,10021,2,0 11732,2431,2429,1,0 11733,10021,2430,1,0 11734,10016,2432,1,0 11735,2431,2429,1,0 11736,2432,2430,1,0 11737,10016,2432,1,0 11738,2434,10022,4,3 11739,2433,10043,4,4 11740,10043,10044,2,0 11741,2434,10045,1,0 11742,10044,10046,1,0 11743,10046,10047,1,0 11744,10036,10047,1,0 11745,10047,10048,4,3 11746,2433,10049,4,5 11747,2433,10050,1,0 11748,10050,10051,2,0 11749,2433,10052,4,8 11750,2433,2431,1,0 11751,2434,2432,1,0 11752,2433,10053,4,17 11753,2433,10054,4,1 11754,10054,10055,2,0 11755,10047,10056,4,1 11756,2433,10057,4,7 11757,2433,10058,4,6 11758,10054,10059,2,0 11759,10059,10060,1,0 11760,10060,10061,1,0 11761,10061,10062,1,0 11762,10062,10054,3,0 11763,10062,10063,1,0 11764,10055,10063,1,0 11765,2433,10064,4,6 11766,10047,10065,4,2 11767,10063,10066,1,0 11768,10050,10067,2,0 11769,10066,10068,1,0 11770,10072,10068,1,0 11771,10067,10069,1,0 11772,10070,10069,1,0 11773,10069,10070,1,0 11774,10068,10072,1,0 11775,10071,10072,1,0 11776,10068,10071,1,0 11777,2434,10023,4,1 11778,10023,10024,2,0 11779,10024,2434,1,0 11780,2434,10025,1,0 11781,10025,10026,2,0 11782,10026,2434,1,0 11783,2433,10027,4,4 11784,10027,10028,2,0 11785,2434,10029,1,0 11786,10028,10030,4,3 11787,10028,10031,4,2 11788,10028,10032,4,1 11789,2433,10033,4,4 11790,10033,10034,2,0 11791,2434,10035,1,0 11792,10034,10036,1,0 11793,2434,10037,4,1 11794,10037,10038,2,0 11795,10038,10039,1,0 11796,10034,10040,1,0 11797,10039,10040,3,0 11798,2433,10042,4,17 11799,2433,10041,4,17 11800,2435,10073,4,16 11801,2435,10074,4,8 11802,2435,10075,4,2 11803,2435,10076,4,3 11804,2435,10077,4,9 11805,10075,10078,2,0 11806,2435,10079,4,10 11807,10078,10080,1,0 11808,10076,10081,2,0 11809,10080,10082,1,0 11810,10084,10082,1,0 11811,10081,10083,1,0 11812,10085,10083,1,0 11813,10082,10084,1,0 11814,10083,10085,1,0 11815,2435,10087,4,14 11816,2435,10088,4,10 11817,2435,10089,4,9 11818,2435,10090,4,7 11819,2435,10091,4,6 11820,2435,10092,4,15 11821,2435,10093,4,18 11822,2435,10094,4,11 11823,10086,10095,1,0 11824,10090,10095,1,0 11825,10075,10096,2,0 11826,2435,10097,4,6 11827,10096,10098,1,0 11828,10098,10099,1,0 11829,10099,10100,1,0 11830,10100,10075,3,0 11831,10100,10101,1,0 11832,10096,10101,1,0 11833,2435,10102,4,11 11834,2435,10103,4,9 11835,10076,10104,2,0 11836,2435,10105,4,6 11837,2435,10106,4,10 11838,10101,10107,1,0 11839,10107,10108,1,0 11840,10110,10108,1,0 11841,10104,10109,1,0 11842,10111,10109,1,0 11843,10108,10110,1,0 11844,10109,10111,1,0 11845,2435,10086,4,7 11846,2436,10112,4,1 11847,10112,10113,2,0 11848,2436,10123,4,2 11849,10123,10124,2,0 11850,2436,10134,4,3 11851,10134,10135,2,0 11852,2436,10145,4,4 11853,10145,10146,2,0 11854,2436,10173,1,0 11855,10173,10174,1,0 11856,10174,10175,2,0 11857,10175,10176,1,0 11858,10173,10177,1,0 11859,10176,10178,4,2 11860,10177,10178,3,0 11861,10173,10179,1,0 11862,10179,10180,2,0 11863,10180,10181,1,0 11864,10181,10179,3,0 11865,2436,10147,4,5 11866,10146,10148,1,0 11867,10162,10148,1,0 11868,10148,10149,4,3 11869,10148,10150,1,0 11870,10150,10151,2,0 11871,10151,2473,1,0 11872,10150,10152,2,0 11873,10152,10153,1,0 11874,10148,10162,1,0 11875,10145,10163,2,0 11876,10163,10164,1,0 11877,10164,10165,1,0 11878,10165,10166,2,0 11879,10166,10167,1,0 11880,10164,10168,1,0 11881,10167,10169,4,2 11882,10168,10169,3,0 11883,10164,10170,1,0 11884,10170,10171,2,0 11885,10171,10172,1,0 11886,10172,10170,3,0 11887,10153,10154,1,0 11888,10154,10155,2,0 11889,10155,10156,1,0 11890,10153,10157,1,0 11891,10156,10158,4,2 11892,10157,10158,3,0 11893,10153,10159,1,0 11894,10159,10160,2,0 11895,10160,10161,1,0 11896,10161,10159,3,0 11897,10135,10136,1,0 11898,10136,10137,1,0 11899,10137,10138,2,0 11900,10138,10139,1,0 11901,10136,10140,1,0 11902,10139,10141,4,2 11903,10140,10141,3,0 11904,10136,10142,1,0 11905,10142,10143,2,0 11906,10143,10144,1,0 11907,10144,10142,3,0 11908,10124,10125,1,0 11909,10125,10126,1,0 11910,10126,10127,2,0 11911,10127,10128,1,0 11912,10125,10129,1,0 11913,10128,10130,4,2 11914,10129,10130,3,0 11915,10125,10131,1,0 11916,10131,10132,2,0 11917,10132,10133,1,0 11918,10133,10131,3,0 11919,10113,10114,1,0 11920,10114,10115,1,0 11921,10115,10116,2,0 11922,10116,10117,1,0 11923,10114,10118,1,0 11924,10117,10119,4,2 11925,10118,10119,3,0 11926,10114,10120,1,0 11927,10120,10121,2,0 11928,10121,10122,1,0 11929,10122,10120,3,0 11930,2437,10182,4,9 11931,2437,10183,4,5 11932,2437,10184,1,0 11933,10184,10185,2,0 11934,2437,10186,4,8 11935,2437,10187,4,2 11936,10187,10188,2,0 11937,2437,10189,4,10 11938,10188,10190,1,0 11939,2437,10191,4,4 11940,2437,10192,4,1 11941,2437,10193,4,17 11942,10190,10194,1,0 11943,10207,10194,1,0 11944,10191,10195,2,0 11945,10195,10196,4,3 11946,10195,10199,4,1 11947,10192,10200,2,0 11948,10195,10201,4,2 11949,10200,10202,1,0 11950,10202,10203,1,0 11951,10206,10203,1,0 11952,10184,10204,2,0 11953,10204,10205,1,0 11954,10203,10206,1,0 11955,10194,10207,1,0 11956,2437,2435,1,0 11957,2437,10216,4,18 11958,2437,10208,4,3 11959,10208,10209,2,0 11960,10184,10210,2,0 11961,10209,10211,1,0 11962,10215,10211,1,0 11963,10210,10212,1,0 11964,10213,10212,1,0 11965,10212,10213,1,0 11966,10211,10215,1,0 11967,10214,10215,1,0 11968,10211,10214,1,0 11969,10195,10197,1,0 11970,10197,10198,2,0 11971,10198,2474,1,0 11972,2438,10217,4,1 11973,10217,10218,2,0 11974,2438,10235,4,2 11975,2439,10236,2,0 11976,2438,10237,1,0 11977,10236,10237,3,0 11978,2438,2439,3,0 11979,2438,10219,4,2 11980,10218,2438,1,0 11981,2438,10222,1,0 11982,10222,10223,2,0 11983,10223,10224,1,0 11984,10224,2473,1,0 11985,10222,10225,2,0 11986,10225,10226,1,0 11987,10226,10227,1,0 11988,10227,10228,2,0 11989,10228,10229,1,0 11990,10226,10230,1,0 11991,10229,10231,4,2 11992,10230,10231,3,0 11993,10226,10232,1,0 11994,10232,10233,2,0 11995,10233,10234,1,0 11996,10234,10232,3,0 11997,2438,10220,1,0 11998,10220,10221,2,0 11999,10221,2438,1,0 12000,2166,10238,0,0 12001,2169,10239,0,0 12002,10238,10239,3,0 12003,2440,2438,1,0 12004,10239,2439,1,0 12005,10239,10251,2,0 12006,10251,10240,1,0 12007,10240,10241,2,0 12008,10241,10239,3,0 12009,10251,10242,1,0 12010,10242,10243,1,0 12011,10243,10244,2,0 12012,10244,10245,1,0 12013,10242,10246,1,0 12014,10245,10247,4,2 12015,10246,10247,3,0 12016,10242,10248,1,0 12017,10248,10249,2,0 12018,10249,10250,1,0 12019,10250,10248,3,0 12020,2441,10252,4,1 12021,10252,10253,2,0 12022,2441,10263,1,0 12023,10253,10263,1,0 12024,10262,10264,1,0 12025,10263,10264,1,0 12026,10264,2443,1,0 12027,2441,10254,4,2 12028,2441,10255,1,0 12029,10255,10256,2,0 12030,2442,10257,2,0 12031,10257,10255,3,0 12032,2441,2442,3,0 12033,2443,10261,1,0 12034,10253,2441,1,0 12035,10261,10252,3,0 12036,10261,10262,1,0 12037,2441,10262,1,0 12038,2441,10258,1,0 12039,10258,10259,2,0 12040,2443,10260,1,0 12041,10259,2441,1,0 12042,10260,10258,3,0 12043,2170,10265,0,0 12044,2171,10266,0,0 12045,2172,10267,0,0 12046,2173,10268,0,0 12047,2444,10269,4,3 12048,10271,10273,1,0 12049,10273,2445,3,0 12050,10273,2446,3,0 12051,2444,10284,4,1 12052,10284,10285,2,0 12053,10285,2444,1,0 12054,10266,2445,1,0 12055,10265,2446,1,0 12056,10266,10352,2,0 12057,10268,10353,2,0 12058,10273,10354,1,0 12059,10354,10355,1,0 12060,10355,10356,2,0 12061,10356,10357,1,0 12062,10354,10358,1,0 12063,10357,10359,4,2 12064,10358,10359,3,0 12065,10354,10360,1,0 12066,10360,10361,2,0 12067,10361,10362,1,0 12068,10362,10360,3,0 12069,10353,2440,1,0 12070,10352,2440,1,0 12071,2444,10286,1,0 12072,10286,10287,2,0 12073,10287,2444,1,0 12074,10268,2445,1,0 12075,10267,2446,1,0 12076,10267,10300,2,0 12077,10266,10301,2,0 12078,10300,10302,4,1 12079,10301,10302,3,0 12080,10268,10303,2,0 12081,10303,2445,3,0 12082,10265,10304,2,0 12083,10304,2446,3,0 12084,2174,10288,0,0 12085,10288,10289,1,0 12086,10289,10290,4,2 12087,10288,10291,1,0 12088,10267,10292,2,0 12089,10292,10293,4,1 12090,10289,10293,3,0 12091,10265,10294,2,0 12092,10294,10295,4,1 12093,10289,10295,3,0 12094,10268,10296,2,0 12095,10273,10297,4,1 12096,10296,10297,3,0 12097,10266,10298,2,0 12098,10273,10299,1,0 12099,10298,10299,3,0 12100,10273,2445,3,0 12101,10289,2446,3,0 12102,2177,10339,0,0 12103,10339,10340,1,0 12104,10340,10341,4,2 12105,2444,10342,4,1 12106,10342,10343,1,0 12107,10339,10344,1,0 12108,1,10345,0,0 12109,10345,10344,3,0 12110,10273,10346,1,0 12111,1,10347,0,0 12112,10347,10346,3,0 12113,10268,10348,2,0 12114,10273,10349,4,1 12115,10348,10349,3,0 12116,10267,10350,2,0 12117,10350,10351,4,1 12118,10340,10351,3,0 12119,10273,2445,3,0 12120,10340,2446,3,0 12121,2180,10322,0,0 12122,10322,10323,1,0 12123,10323,10324,4,2 12124,10268,10325,2,0 12125,10322,10326,1,0 12126,10325,10326,3,0 12127,10267,10327,2,0 12128,10327,10328,4,1 12129,10273,10328,3,0 12130,10273,10329,4,1 12131,10323,10329,3,0 12132,2444,10330,4,1 12133,10330,10331,1,0 12134,10331,10332,1,0 12135,10273,10333,1,0 12136,10333,10334,1,0 12137,10330,10335,1,0 12138,10273,10336,1,0 12139,10337,10338,1,0 12140,10273,10338,1,0 12141,10338,2445,3,0 12142,10323,2446,3,0 12143,10268,10337,2,0 12144,2183,10305,0,0 12145,10305,10306,1,0 12146,10306,10307,4,2 12147,10305,10308,1,0 12148,10273,10309,4,2 12149,10268,10310,2,0 12150,10273,10311,4,1 12151,10310,10311,3,0 12152,10273,10312,1,0 12153,10306,10312,3,0 12154,10267,10313,2,0 12155,10313,10314,4,1 12156,10306,10314,3,0 12157,10273,2445,3,0 12158,10306,2446,3,0 12159,10268,10321,2,0 12160,10321,10315,1,0 12161,10273,10315,1,0 12162,10315,2445,3,0 12163,10273,10316,4,2 12164,10268,10317,2,0 12165,10273,10318,1,0 12166,10317,10318,3,0 12167,10267,10319,2,0 12168,10319,10320,4,1 12169,10273,10320,3,0 12170,10273,2446,3,0 12171,2444,10274,4,1 12172,10274,10275,1,0 12173,10273,10276,1,0 12174,1,10277,0,0 12175,10277,10276,3,0 12176,10273,2445,3,0 12177,10273,2446,3,0 12178,2444,10278,4,1 12179,10278,10279,2,0 12180,10273,10280,1,0 12181,10279,10281,1,0 12182,10281,10280,3,0 12183,10273,10282,4,2 12184,10273,10283,1,0 12185,10273,2445,3,0 12186,10273,2446,3,0 12187,2186,10270,0,0 12188,10270,10271,1,0 12189,10271,10272,4,2 12190,2447,10363,4,3 12191,2447,10370,1,0 12192,10370,10371,2,0 12193,10371,2447,1,0 12194,2447,10364,1,0 12195,10364,10365,2,0 12196,10365,2447,1,0 12197,2447,10366,4,1 12198,10366,10367,2,0 12199,10367,2447,1,0 12200,2447,10368,4,1 12201,10368,10369,1,0 12202,2448,10372,1,0 12203,10372,10373,2,0 12204,2448,10374,4,3 12205,10374,10375,2,0 12206,10375,10387,1,0 12207,10377,10387,1,0 12208,2448,10388,4,2 12209,10388,10389,2,0 12210,10389,10401,1,0 12211,10391,10401,1,0 12212,2448,10402,1,0 12213,10402,10403,1,0 12214,10403,10404,2,0 12215,10404,10405,1,0 12216,10402,10406,1,0 12217,10405,10407,4,2 12218,10406,10407,3,0 12219,10402,10408,1,0 12220,10408,10409,2,0 12221,10409,10410,1,0 12222,10410,10408,3,0 12223,10401,10390,1,0 12224,10390,10391,2,0 12225,10401,10392,1,0 12226,10392,10393,1,0 12227,10393,10394,2,0 12228,10394,10395,1,0 12229,10392,10396,1,0 12230,10395,10397,4,2 12231,10396,10397,3,0 12232,10392,10398,1,0 12233,10398,10399,2,0 12234,10399,10400,1,0 12235,10400,10398,3,0 12236,10387,10376,1,0 12237,10376,10377,2,0 12238,10387,10378,1,0 12239,10378,10379,1,0 12240,10379,10380,2,0 12241,10380,10381,1,0 12242,10378,10382,1,0 12243,10381,10383,4,2 12244,10382,10383,3,0 12245,10378,10384,1,0 12246,10384,10385,2,0 12247,10385,10386,1,0 12248,10386,10384,3,0 12249,10373,2440,1,0 12250,2449,10411,4,1 12251,10411,10412,2,0 12252,2449,10413,4,2 12253,10411,10417,1,0 12254,10416,10417,1,0 12255,2189,10418,0,0 12256,10418,10419,1,0 12257,10416,10420,1,0 12258,10417,10420,1,0 12259,10411,10421,2,0 12260,10422,10425,1,0 12261,10425,2450,1,0 12262,10412,10422,1,0 12263,10421,10422,1,0 12264,10422,10423,4,1 12265,10423,10424,2,0 12266,10424,10411,3,0 12267,10413,10414,2,0 12268,10418,10415,1,0 12269,10414,10415,3,0 12270,10419,10413,3,0 12271,10419,10417,3,0 12272,10419,10416,4,1 12273,2452,10426,4,2 12274,10426,10427,2,0 12275,10427,10428,4,2 12276,10428,10429,2,0 12277,2452,10430,4,4 12278,10429,10430,3,0 12279,10427,10431,4,3 12280,10431,10432,2,0 12281,2452,10433,4,5 12282,10432,10433,3,0 12283,10427,10434,4,4 12284,2452,10435,4,6 12285,10427,10436,4,1 12286,10436,10437,2,0 12287,10437,10426,3,0 12288,10436,10438,2,0 12289,2451,10439,4,1 12290,10439,10440,2,0 12291,10440,10436,3,0 12292,10427,10439,3,0 12293,10455,10441,1,0 12294,10438,10441,1,0 12295,10454,10442,1,0 12296,10427,10442,1,0 12297,10441,10443,4,2 12298,10443,10444,2,0 12299,10442,10445,4,2 12300,10444,10445,3,0 12301,10441,10446,4,3 12302,10446,10447,2,0 12303,10442,10448,4,3 12304,10447,10448,3,0 12305,10441,10449,4,4 12306,10442,10450,4,4 12307,10441,10451,4,1 12308,10451,10452,2,0 12309,10442,10453,4,1 12310,10452,10453,3,0 12311,2450,10454,1,0 12312,2451,2449,1,0 12313,10454,10453,3,0 12314,10451,10455,2,0 12315,2452,10456,4,4 12316,10456,10457,2,0 12317,2452,10458,4,5 12318,2452,10459,4,6 12319,10459,10471,1,0 12320,10469,10471,1,0 12321,10458,10472,1,0 12322,10466,10472,1,0 12323,2453,10456,3,0 12324,2450,10460,1,0 12325,2451,2449,1,0 12326,2452,10461,4,2 12327,10461,10462,2,0 12328,10460,10463,4,1 12329,10462,10463,3,0 12330,10460,10461,3,0 12331,10456,10464,2,0 12332,10460,10465,4,2 12333,10464,10465,3,0 12334,2452,10466,4,5 12335,10466,10467,2,0 12336,10460,10468,4,3 12337,10467,10468,3,0 12338,2452,10469,4,6 12339,10460,10470,4,4 12340,2454,10473,4,6 12341,10473,10474,2,0 12342,2454,10475,4,9 12343,2454,10476,4,3 12344,10473,10480,1,0 12345,10479,10480,1,0 12346,2194,10481,0,0 12347,10481,10482,1,0 12348,10479,10483,1,0 12349,10480,10483,1,0 12350,10473,10484,2,0 12351,10474,10485,1,0 12352,10484,10485,1,0 12353,10485,10486,4,1 12354,10486,10487,2,0 12355,10487,10473,3,0 12356,10485,10488,4,3 12357,2456,10488,3,0 12358,10485,10489,4,2 12359,10485,10490,4,4 12360,10485,10491,4,7 12361,2454,10513,4,7 12362,10513,10514,2,0 12363,10485,10514,3,0 12364,10486,10513,3,0 12365,2455,10492,4,2 12366,10492,10493,2,0 12367,2455,10494,4,4 12368,10494,10495,2,0 12369,10495,10490,3,0 12370,2455,10496,4,5 12371,10496,10497,2,0 12372,10485,10498,4,5 12373,10497,10498,3,0 12374,2455,10499,4,6 12375,10485,10500,4,6 12376,2454,10501,4,11 12377,2455,10502,4,7 12378,10485,10503,4,8 12379,2455,10504,4,8 12380,10503,10505,1,0 12381,10511,10505,1,0 12382,10504,10506,1,0 12383,10512,10506,1,0 12384,10506,10507,1,0 12385,10505,10508,1,0 12386,10506,10509,4,1 12387,10505,10510,4,1 12388,10505,10511,1,0 12389,10506,10512,1,0 12390,10493,10489,3,0 12391,2454,2451,1,0 12392,10485,2452,1,0 12393,10476,10477,2,0 12394,10481,10478,1,0 12395,10477,10478,3,0 12396,10482,10476,3,0 12397,10482,10480,3,0 12398,10482,10479,4,1 12399,2457,10515,4,3 12400,2457,10533,1,0 12401,10533,10534,1,0 12402,10534,10535,2,0 12403,10535,10536,1,0 12404,10533,10537,1,0 12405,10536,10538,4,2 12406,10537,10538,3,0 12407,10533,10539,1,0 12408,10539,10540,2,0 12409,10540,10541,1,0 12410,10541,10539,3,0 12411,2457,10520,4,1 12412,10520,10521,2,0 12413,10521,10522,1,0 12414,10522,2473,1,0 12415,10520,10523,2,0 12416,10523,10524,1,0 12417,10524,10525,1,0 12418,10525,10526,2,0 12419,10526,10527,1,0 12420,10524,10528,1,0 12421,10527,10529,4,2 12422,10528,10529,3,0 12423,10524,10530,1,0 12424,10530,10531,2,0 12425,10531,10532,1,0 12426,10532,10530,3,0 12427,2457,10518,1,0 12428,10518,10519,2,0 12429,10519,2457,1,0 12430,2457,10516,4,1 12431,10516,10517,2,0 12432,10517,2457,1,0 12433,2204,10542,0,0 12434,10542,10543,1,0 12435,2458,2457,1,0 12436,2459,2457,1,0 12437,10543,10549,1,0 12438,10549,2460,1,0 12439,10543,10544,4,3 12440,10542,10545,1,0 12441,2458,10545,3,0 12442,2458,10546,4,2 12443,10543,10546,3,0 12444,10543,10547,4,1 12445,2459,10547,3,0 12446,2459,10548,4,2 12447,10543,10548,3,0 12448,2208,10550,0,0 12449,2215,10551,0,0 12450,2216,10552,0,0 12451,2219,10553,0,0 12452,2226,10554,0,0 12453,2227,10555,0,0 12454,2461,10556,4,12 12455,2461,10557,4,1 12456,2461,10558,4,4 12457,2461,10559,4,5 12458,10557,10560,2,0 12459,10560,10561,1,0 12460,10561,10557,3,0 12461,10561,10810,1,0 12462,10778,10810,1,0 12463,10810,10811,1,0 12464,10557,10812,2,0 12465,10812,10813,1,0 12466,10813,10557,3,0 12467,2461,10814,4,11 12468,10561,10562,1,0 12469,10560,10563,1,0 12470,10563,10557,3,0 12471,10561,10612,1,0 12472,10560,10613,1,0 12473,2461,10614,4,7 12474,2461,10615,4,8 12475,2461,10616,4,11 12476,10600,10599,1,0 12477,10603,10599,1,0 12478,10561,10599,1,0 12479,10599,10602,1,0 12480,10601,10602,1,0 12481,10602,10603,1,0 12482,10603,10557,3,0 12483,10599,10600,1,0 12484,10600,10557,3,0 12485,10599,10601,1,0 12486,10561,10564,1,0 12487,10560,10565,1,0 12488,2461,10566,4,7 12489,2461,10567,4,9 12490,2461,10572,4,2 12491,10572,10573,2,0 12492,10573,10574,1,0 12493,2461,10575,4,7 12494,2461,10568,4,2 12495,10568,10569,2,0 12496,10569,10570,1,0 12497,2461,10571,4,11 12498,10570,10568,3,0 12499,10561,10576,1,0 12500,10560,10577,1,0 12501,2461,10578,4,8 12502,2461,10579,4,7 12503,2461,10580,4,7 12504,2461,10581,4,2 12505,10581,10582,2,0 12506,10582,10583,1,0 12507,10583,10584,1,0 12508,10561,10587,1,0 12509,10560,10588,1,0 12510,10592,10589,1,0 12511,10587,10589,1,0 12512,10589,10593,1,0 12513,10590,10591,1,0 12514,10593,10591,1,0 12515,10590,10592,1,0 12516,10593,10592,1,0 12517,10591,10557,3,0 12518,10589,10590,1,0 12519,10561,10604,1,0 12520,10560,10605,1,0 12521,10607,10606,1,0 12522,10604,10606,1,0 12523,10606,10607,1,0 12524,10607,10557,3,0 12525,10561,10585,1,0 12526,10560,10586,1,0 12527,10561,10608,1,0 12528,10560,10609,1,0 12529,10611,10610,1,0 12530,10608,10610,1,0 12531,10610,10611,1,0 12532,10611,10557,3,0 12533,10561,10619,1,0 12534,10560,10620,1,0 12535,2228,10621,0,0 12536,10621,10622,1,0 12537,2461,10623,1,0 12538,10622,10623,3,0 12539,2461,10624,4,11 12540,2461,10629,4,10 12541,10557,10630,2,0 12542,10630,10631,1,0 12543,10631,10557,3,0 12544,2461,10632,4,3 12545,10632,10633,2,0 12546,10621,10634,1,0 12547,10633,10634,3,0 12548,10557,10635,2,0 12549,10623,10636,2,0 12550,10636,10637,1,0 12551,10637,10638,2,0 12552,10636,10639,1,0 12553,3952,10815,2,0 12554,10815,10639,3,0 12555,3952,10816,2,1 12556,10816,10639,3,1 12557,3952,10817,2,2 12558,10817,10639,3,2 12559,3952,10818,2,3 12560,10818,10639,3,3 12561,3952,10819,2,4 12562,10819,10639,3,4 12563,3952,10820,2,5 12564,10820,10639,3,5 12565,3952,10821,2,6 12566,10821,10639,3,6 12567,3952,10822,2,7 12568,10822,10639,3,7 12569,3952,10823,2,8 12570,10823,10639,3,8 12571,3952,10824,2,9 12572,10824,10639,3,9 12573,3952,10825,2,10 12574,10825,10639,3,10 12575,3952,10826,2,11 12576,10826,10639,3,11 12577,10638,10637,3,0 12578,10636,10640,4,11 12579,10554,10641,1,0 12580,10636,10642,4,8 12581,10636,10643,4,1 12582,10553,10644,1,0 12583,10553,10645,4,1 12584,10553,10646,4,2 12585,10553,10647,4,3 12586,10553,10648,4,4 12587,10553,10649,4,5 12588,10553,10650,4,6 12589,10636,10651,4,9 12590,10636,10652,4,2 12591,10550,10653,1,0 12592,10550,10654,4,1 12593,10550,10655,4,2 12594,10550,10656,4,3 12595,10550,10657,4,4 12596,10550,10658,4,5 12597,10550,10659,4,6 12598,10635,10660,1,0 12599,10730,10660,1,0 12600,10730,10660,1,0 12601,10730,10660,1,0 12602,10730,10660,1,0 12603,10731,10660,1,0 12604,10724,10725,1,0 12605,10662,10725,1,0 12606,10660,10725,1,0 12607,10660,10725,1,0 12608,10660,10725,1,0 12609,10661,10725,1,0 12610,10661,10725,1,0 12611,10661,10725,1,0 12612,10661,10725,1,0 12613,10661,10725,1,0 12614,10661,10725,1,0 12615,10661,10725,1,0 12616,10661,10725,1,0 12617,10661,10725,1,0 12618,10671,10725,1,0 12619,10675,10725,1,0 12620,10660,10725,1,0 12621,10660,10725,1,0 12622,10660,10725,1,0 12623,10660,10725,1,0 12624,10637,10726,2,0 12625,2478,10727,1,0 12626,10726,2476,1,0 12627,10552,2477,1,0 12628,10636,2469,1,0 12629,10680,10729,1,0 12630,10680,10729,1,0 12631,10680,10729,1,0 12632,10680,10729,1,0 12633,10725,10729,1,0 12634,10680,10729,1,0 12635,10680,10729,1,0 12636,10680,10729,1,0 12637,10680,10729,1,0 12638,10680,10729,1,0 12639,10680,10729,1,0 12640,10680,10729,1,0 12641,10680,10729,1,0 12642,10680,10729,1,0 12643,10680,10729,1,0 12644,10680,10729,1,0 12645,10680,10729,1,0 12646,10680,10729,1,0 12647,10680,10729,1,0 12648,10725,10729,1,0 12649,10725,10729,1,0 12650,10636,2473,1,0 12651,10623,10733,2,0 12652,10733,10734,1,0 12653,2461,10743,4,11 12654,10734,10735,1,0 12655,10735,10736,2,0 12656,10736,10737,1,0 12657,10734,10738,1,0 12658,10737,10739,4,2 12659,10738,10739,3,0 12660,10734,10740,1,0 12661,10740,10741,2,0 12662,10741,10742,1,0 12663,10742,10740,3,0 12664,10557,10744,2,0 12665,10744,10745,1,0 12666,10623,10746,2,0 12667,10746,2474,1,0 12668,10557,10747,2,0 12669,10747,10748,1,0 12670,10748,10557,3,0 12671,10729,10730,1,0 12672,10730,10732,1,0 12673,10729,10731,1,0 12674,10727,10728,4,2 12675,10660,10724,1,0 12676,10660,10676,1,0 12677,10678,10677,1,0 12678,10676,10677,1,0 12679,10677,10678,1,0 12680,10677,10679,1,0 12681,10679,10680,1,0 12682,10678,10681,1,0 12683,10677,10682,1,0 12684,10682,10718,1,0 12685,10681,10653,3,0 12686,10718,10654,3,0 12687,10636,10655,3,0 12688,10637,10719,2,0 12689,10719,10656,3,0 12690,10550,2470,1,0 12691,10718,2472,1,0 12692,10657,10720,2,0 12693,10654,10721,2,0 12694,10653,10722,2,0 12695,10636,2469,1,0 12696,10720,10723,4,2 12697,10682,10683,1,0 12698,10683,10827,2,0 12699,10827,10641,3,0 12700,10554,10684,1,0 12701,10643,10686,2,0 12702,10686,10687,1,0 12703,10687,10688,1,0 12704,10688,10689,1,0 12705,10689,10643,3,0 12706,10643,10690,2,0 12707,10690,10691,1,0 12708,10636,10685,4,4 12709,10682,10692,1,0 12710,10681,10644,3,0 12711,10692,10645,3,0 12712,10636,10646,3,0 12713,10637,10693,2,0 12714,10693,10647,3,0 12715,10553,2470,1,0 12716,10692,2472,1,0 12717,10648,10694,2,0 12718,10645,10695,2,0 12719,10644,10696,2,0 12720,10636,2469,1,0 12721,10636,2469,1,0 12722,10647,10697,2,0 12723,10697,10698,4,11 12724,10694,10699,4,2 12725,10637,10700,2,0 12726,2481,10701,1,0 12727,10700,2479,1,0 12728,10694,2480,1,0 12729,10701,10716,1,0 12730,10694,10716,1,0 12731,10694,10716,1,0 12732,10716,10717,4,2 12733,10701,10702,4,2 12734,10701,10703,4,1 12735,10701,10704,4,2 12736,10652,10708,2,0 12737,10708,10709,1,0 12738,10709,10710,1,0 12739,10710,10711,1,0 12740,10711,10652,3,0 12741,10652,10712,2,0 12742,10648,10713,2,0 12743,10713,10714,4,2 12744,10712,10715,1,0 12745,10648,10705,2,0 12746,10705,10706,4,2 12747,10636,10707,4,5 12748,10636,2469,1,0 12749,10701,10648,3,0 12750,10660,10661,1,0 12751,10661,10662,1,0 12752,10660,10672,1,0 12753,10673,10674,1,0 12754,10672,10674,1,0 12755,10673,10674,1,0 12756,10674,10675,1,0 12757,10660,10673,1,0 12758,1171,10663,0,0 12759,10663,10664,2,0 12760,10660,10665,1,0 12761,10664,10666,1,0 12762,10669,10667,1,0 12763,10665,10667,1,0 12764,10664,10668,1,0 12765,10667,10669,1,0 12766,10664,10670,1,0 12767,10667,10671,1,0 12768,2461,10625,4,10 12769,3950,10626,2,0 12770,3949,10627,1,0 12771,3949,10627,1,0 12772,2461,10628,4,3 12773,10627,10628,3,0 12774,10561,10776,1,0 12775,10560,10777,1,0 12776,10777,10778,1,0 12777,10778,10557,3,0 12778,2461,10779,4,11 12779,2461,10780,4,8 12780,2461,10781,4,7 12781,2461,10782,4,11 12782,10800,10791,1,0 12783,10778,10791,1,0 12784,10778,10791,1,0 12785,10778,10791,1,0 12786,2461,10796,4,11 12787,10791,10795,1,0 12788,10791,10792,1,0 12789,10792,10557,3,0 12790,10791,10557,3,0 12791,10791,10794,1,0 12792,10791,10793,1,0 12793,10793,10557,3,0 12794,10798,10797,1,0 12795,10778,10797,1,0 12796,10797,10798,1,0 12797,10798,10557,3,0 12798,10797,10799,1,0 12799,10799,10800,1,0 12800,10800,10557,3,0 12801,2461,10783,4,7 12802,2461,10787,4,11 12803,2461,10784,4,2 12804,10784,10785,2,0 12805,10785,10786,1,0 12806,2461,10788,1,0 12807,1,10789,0,0 12808,10789,10788,3,0 12809,2461,10790,4,6 12810,1171,10801,0,0 12811,10801,10802,2,0 12812,10802,10803,1,0 12813,10807,10804,1,0 12814,10778,10804,1,0 12815,10801,10805,2,0 12816,10805,10806,1,0 12817,10804,10807,1,0 12818,10807,10557,3,0 12819,10805,10808,1,0 12820,2461,10809,4,11 12821,10749,10751,1,0 12822,10778,10751,1,0 12823,1171,10752,0,0 12824,10752,10753,2,0 12825,10753,10754,1,0 12826,2461,10755,4,11 12827,10557,10756,2,0 12828,10751,10757,1,0 12829,10759,10757,1,0 12830,10752,10758,2,0 12831,10757,10759,1,0 12832,10759,10557,3,0 12833,10758,10760,1,0 12834,2461,10761,1,0 12835,2461,10762,1,0 12836,10762,10763,1,0 12837,10752,10764,2,0 12838,10557,10765,2,0 12839,10765,10766,1,0 12840,10766,10557,3,0 12841,10764,10767,1,0 12842,10557,10772,2,0 12843,10772,10773,1,0 12844,10773,10557,3,0 12845,10557,10774,2,0 12846,10774,10775,1,0 12847,10775,10557,3,0 12848,10766,10768,1,0 12849,10770,10768,1,0 12850,10752,10769,2,0 12851,10768,10770,1,0 12852,10770,10557,3,0 12853,10769,10771,1,0 12854,10595,10594,1,0 12855,10598,10594,1,0 12856,10561,10594,1,0 12857,10594,10597,1,0 12858,10596,10597,1,0 12859,10597,10598,1,0 12860,10598,10557,3,0 12861,10594,10595,1,0 12862,10595,10557,3,0 12863,10594,10596,1,0 12864,10561,10749,1,0 12865,10560,10750,1,0 12866,10561,10617,1,0 12867,10560,10618,1,0 12868,2240,10828,0,0 12869,10828,10829,1,0 12870,2462,10830,4,11 12871,10887,10888,1,0 12872,10888,2463,1,0 12873,2462,10831,4,5 12874,10829,10832,4,3 12875,2462,10833,4,11 12876,10829,10834,4,1 12877,10828,10840,1,0 12878,10829,2457,1,0 12879,10829,10874,1,0 12880,10829,10874,1,0 12881,10829,10874,1,0 12882,10874,10887,1,0 12883,10886,10887,1,0 12884,10874,10875,1,0 12885,10874,10875,1,0 12886,10874,10875,1,0 12887,10874,10875,1,0 12888,2244,10876,0,0 12889,10876,10877,1,0 12890,2462,10881,4,11 12891,10875,2457,1,0 12892,10877,10878,4,3 12893,10876,10879,1,0 12894,10875,10879,3,0 12895,2462,10882,1,0 12896,10882,10883,2,0 12897,10877,10884,4,1 12898,10883,10885,1,0 12899,10885,10884,3,0 12900,10877,10886,1,0 12901,10874,10886,1,0 12902,10877,10886,1,0 12903,2462,2461,1,0 12904,10886,2457,1,0 12905,10875,10880,4,2 12906,10877,10880,3,0 12907,10874,2457,1,0 12908,2462,2461,1,0 12909,2462,10853,4,7 12910,10829,10854,4,1 12911,1,10855,0,0 12912,10855,10854,3,0 12913,2462,2461,1,0 12914,2462,10856,4,4 12915,2248,10858,0,0 12916,10858,10859,1,0 12917,10828,10860,1,0 12918,10859,10861,4,3 12919,10858,10862,1,0 12920,10828,10863,1,0 12921,10859,10863,3,0 12922,10867,10871,1,0 12923,10863,10871,1,0 12924,10871,10872,2,0 12925,10872,10873,4,2 12926,10829,10873,3,0 12927,2462,10857,4,11 12928,2467,10864,1,0 12929,2462,2466,1,0 12930,10828,10865,1,0 12931,10864,10865,3,0 12932,2462,10866,4,11 12933,2462,10869,4,8 12934,2462,10870,4,11 12935,10828,10867,1,0 12936,2462,10868,4,11 12937,2462,10839,4,11 12938,2462,10835,4,4 12939,2462,10836,4,1 12940,10836,10837,2,0 12941,10837,10838,1,0 12942,2462,10850,1,0 12943,10829,10851,4,1 12944,1,10852,0,0 12945,10852,10851,3,0 12946,2462,2461,1,0 12947,2462,10845,4,11 12948,2462,10841,4,4 12949,2462,10842,4,1 12950,10842,10843,2,0 12951,10843,10844,1,0 12952,2462,10846,1,0 12953,10846,10847,2,0 12954,10829,10848,4,1 12955,10847,10849,1,0 12956,10849,10848,3,0 12957,2463,10889,1,0 12958,2464,2462,1,0 12959,10891,10897,1,0 12960,10891,10897,1,0 12961,10891,10897,1,0 12962,10897,10898,1,0 12963,10898,2465,1,0 12964,2464,10890,4,5 12965,10889,10891,1,0 12966,10893,10891,1,0 12967,2463,10892,1,0 12968,2464,2462,1,0 12969,10891,10896,1,0 12970,10896,2457,1,0 12971,2460,10893,1,0 12972,10891,2458,1,0 12973,10892,2459,1,0 12974,10891,10894,1,0 12975,2464,10895,4,11 12976,2465,10899,1,0 12977,2466,2464,1,0 12978,10901,10907,1,0 12979,10901,10907,1,0 12980,10907,10908,1,0 12981,10908,2467,1,0 12982,2466,10900,4,5 12983,10899,10901,1,0 12984,10903,10901,1,0 12985,2466,2461,1,0 12986,2465,10902,1,0 12987,2466,2464,1,0 12988,10901,10906,1,0 12989,10901,10906,1,0 12990,10906,2457,1,0 12991,2460,10903,1,0 12992,10901,2458,1,0 12993,10902,2459,1,0 12994,10901,10904,1,0 12995,2466,10905,4,11 12996,2468,10909,4,10 12997,2468,10911,4,3 12998,10911,10912,2,0 12999,10912,10913,1,0 13000,10913,10914,1,0 13001,10914,10915,1,0 13002,10915,10911,3,0 13003,2468,10916,4,3 13004,10916,10917,2,0 13005,10917,10918,1,0 13006,2468,10910,4,6 13007,2469,2468,1,0 13008,2469,10921,4,7 13009,2469,10919,4,11 13010,2469,2468,1,0 13011,2469,2468,1,0 13012,2469,2468,1,0 13013,2469,10920,4,7 13014,2252,10922,0,0 13015,2253,10923,0,0 13016,2470,10924,4,5 13017,2472,10925,1,0 13018,2472,10929,1,0 13019,10925,10929,1,0 13020,10926,10929,1,0 13021,10925,10929,1,0 13022,2470,10930,4,2 13023,10930,10931,2,0 13024,10931,10932,4,11 13025,2470,10933,4,3 13026,2470,10934,1,0 13027,2470,10935,4,1 13028,2470,10936,4,4 13029,2470,10937,4,6 13030,10933,10938,2,0 13031,2478,10939,1,0 13032,10938,2476,1,0 13033,10923,2477,1,0 13034,10939,10943,1,0 13035,10939,10943,1,0 13036,10939,10943,1,0 13037,10929,10935,3,0 13038,10943,10936,3,0 13039,10933,10940,2,0 13040,10940,10941,4,9 13041,10934,10942,2,0 13042,10944,10945,1,0 13043,10939,10945,1,0 13044,10945,10946,4,2 13045,10945,10949,1,0 13046,10934,10950,2,0 13047,10945,2471,1,0 13048,10929,2472,1,0 13049,10935,10947,2,0 13050,10929,10935,3,0 13051,10945,10936,3,0 13052,10936,10948,2,0 13053,2481,10944,1,0 13054,10938,2479,1,0 13055,2471,2480,1,0 13056,2472,10926,1,0 13057,2470,10927,1,0 13058,10927,10928,2,0 13059,2473,10951,4,1 13060,10951,10952,2,0 13061,2473,10962,4,2 13062,10962,10963,2,0 13063,2473,10973,4,3 13064,10973,10974,2,0 13065,10974,10975,1,0 13066,10975,10976,1,0 13067,10976,10977,2,0 13068,10977,10978,1,0 13069,10975,10979,1,0 13070,10978,10980,4,2 13071,10979,10980,3,0 13072,10975,10981,1,0 13073,10981,10982,2,0 13074,10982,10983,1,0 13075,10983,10981,3,0 13076,10963,10964,1,0 13077,10964,10965,1,0 13078,10965,10966,2,0 13079,10966,10967,1,0 13080,10964,10968,1,0 13081,10967,10969,4,2 13082,10968,10969,3,0 13083,10964,10970,1,0 13084,10970,10971,2,0 13085,10971,10972,1,0 13086,10972,10970,3,0 13087,10952,10953,1,0 13088,10953,10954,1,0 13089,10954,10955,2,0 13090,10955,10956,1,0 13091,10953,10957,1,0 13092,10956,10958,4,2 13093,10957,10958,3,0 13094,10953,10959,1,0 13095,10959,10960,2,0 13096,10960,10961,1,0 13097,10961,10959,3,0 13098,2256,10984,0,0 13099,10984,10985,4,1 13100,2475,10985,3,0 13101,10984,10986,4,5 13102,2474,10987,4,8 13103,10984,10995,1,0 13104,10984,10996,4,2 13105,2474,10996,3,0 13106,2474,10997,1,0 13107,10997,10998,2,0 13108,10984,10999,4,3 13109,10998,10999,3,0 13110,10984,11000,4,4 13111,10984,2470,1,0 13112,2475,2472,1,0 13113,11000,11001,2,0 13114,2474,11004,4,11 13115,10984,11006,4,6 13116,11006,11007,1,0 13117,11005,11007,1,0 13118,11005,11007,1,0 13119,2474,11010,4,10 13120,2474,11023,4,9 13121,10985,11031,2,0 13122,2474,11024,4,5 13123,11001,11025,4,2 13124,2474,11026,4,5 13125,2474,11027,4,2 13126,11024,11028,1,0 13127,11030,11028,1,0 13128,11029,11028,1,0 13129,2474,11032,4,11 13130,10985,11033,2,0 13131,11028,11029,1,0 13132,11027,11030,2,0 13133,2474,11011,4,6 13134,2474,11012,4,6 13135,2474,11013,4,3 13136,11011,11014,1,0 13137,11022,11014,1,0 13138,11017,11014,1,0 13139,11021,11014,1,0 13140,11014,11015,1,0 13141,11013,11016,2,0 13142,11016,11017,1,0 13143,11015,11017,1,0 13144,11017,11018,1,0 13145,11013,11019,2,0 13146,11019,11020,1,0 13147,11018,11020,1,0 13148,11020,11021,1,0 13149,11013,11022,2,0 13150,2474,11008,4,7 13151,2474,11009,4,7 13152,10984,11005,4,6 13153,11001,11002,4,2 13154,10984,11003,4,6 13155,2474,10988,4,4 13156,2474,10989,4,11 13157,2474,10990,4,4 13158,2474,10991,4,1 13159,10988,10992,1,0 13160,10994,10992,1,0 13161,10993,10992,1,0 13162,10992,10993,1,0 13163,10991,10994,2,0 13164,1,11064,0,0 13165,11064,11062,1,0 13166,11064,11062,1,0 13167,11064,11062,1,0 13168,2477,11062,1,0 13169,11042,11063,1,0 13170,11061,11063,1,0 13171,11062,11063,1,0 13172,11063,2478,1,0 13173,2476,11034,4,9 13174,2476,11035,4,2 13175,11035,11036,2,0 13176,11036,11037,1,0 13177,2476,11044,4,10 13178,2476,11045,4,7 13179,11037,11046,1,0 13180,11046,11047,1,0 13181,11046,11048,1,0 13182,11048,11049,1,0 13183,11049,11050,4,2 13184,11049,11051,1,0 13185,11051,11052,4,1 13186,2477,11053,1,0 13187,2477,11054,4,1 13188,11051,11055,4,3 13189,2477,11056,4,2 13190,2476,11057,4,11 13191,11051,11058,4,3 13192,2477,11059,4,2 13193,11049,11060,1,0 13194,11060,11061,4,1 13195,2476,11043,4,7 13196,2476,11038,4,10 13197,11037,11039,1,0 13198,11039,11040,1,0 13199,11040,11041,4,2 13200,11040,11042,1,0 13201,11076,11077,1,0 13202,11077,2481,1,0 13203,2480,11065,1,0 13204,2479,11066,4,3 13205,11066,11067,2,0 13206,11067,11068,1,0 13207,2479,11069,4,10 13208,11068,11070,1,0 13209,11071,11072,1,0 13210,11070,11072,1,0 13211,11072,11073,1,0 13212,11072,11074,1,0 13213,11074,11075,1,0 13214,11075,11076,4,1 13215,11072,11071,1,0
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/random/CMakeLists.txt
function(rgraph base numnodes) add_custom_command(OUTPUT ${base}.dimacs COMMAND python ${CMAKE_BINARY_DIR}/tools/generators/random-graph.py --density 4 ${numnodes} 0 > ${base}.dimacs) add_custom_command(OUTPUT ${base}.gr COMMAND graph-convert-standalone -dimacs2gr ${base}.dimacs ${base}.gr DEPENDS ${base}.dimacs graph-convert-standalone) endfunction(rgraph) rgraph(r4-2e23 8388608) # powers of 2 rgraph(r4-2e24 16777216) rgraph(r4-2e25 33554432) rgraph(r4-2e26 67108864) add_custom_target(more-random-graphs DEPENDS r4-2e23.gr r4-2e24.gr r4-2e25.gr r4-2e26.gr) add_dependencies(more-inputs more-random-graphs)
0
rapidsai_public_repos/code-share/maxflow/galois/inputs
rapidsai_public_repos/code-share/maxflow/galois/inputs/road/CMakeLists.txt
find_program(WGET wget) find_program(GUNZIP gunzip) function(dlinput base url) add_custom_command(OUTPUT ${base}.gz COMMAND ${WGET} -O ${base}.gz ${url}) add_custom_command(OUTPUT ${base}.dimacs COMMAND ${GUNZIP} -c ${base}.gz > ${base}.dimacs DEPENDS ${base}.gz) add_custom_command(OUTPUT ${base}.gr COMMAND graph-convert-standalone -dimacs2gr ${base}.dimacs ${base}.gr DEPENDS ${base}.dimacs graph-convert-standalone) endfunction(dlinput) dlinput(USA-road-d.USA http://www.dis.uniroma1.it/~challenge9/data/USA-road-d/USA-road-d.USA.gr.gz) dlinput(USA-road-d.W http://www.dis.uniroma1.it/~challenge9/data/USA-road-d/USA-road-d.W.gr.gz) dlinput(USA-road-d.NY http://www.dis.uniroma1.it/~challenge9/data/USA-road-d/USA-road-d.NY.gr.gz) add_custom_target(more-road-graphs DEPENDS USA-road-d.USA.gr USA-road-d.W.gr USA-road-d.NY.gr) add_dependencies(more-inputs more-road-graphs)
0
rapidsai_public_repos/code-share/maxflow
rapidsai_public_repos/code-share/maxflow/push-relabel/push-relabel_operations_gpu.cu
//Copyright (c) 2016, NVIDIA CORPORATION. All rights reserved. #include <stdio.h> #include <limits.h> //#include "../utils.cu" #include "vector_types.h" #include "push-relabel_operations.h" //Number of times the push/relabel method is applied between two global relabeling #define KERNEL_CYCLES 10 //Number of threads to process the reductions in discharge //Must be less than warpsize //Only power of two (lots of divisions) #define THREADS_PER_VERTEX 4 #define THREADS_PER_BLOCK 128 #define BLOCK_Y_SIZE (THREADS_PER_BLOCK / THREADS_PER_VERTEX) //Min on int3 using first int __inline__ __device__ int3 min3_x(int3 i1, int3 i2) { return (i1.x < i2.x) ? i1 : i2; } //Reducing using min inside of warps, by group of THREADS_PER_VERTEX __inline__ __device__ int3 warpReduceMin(int3 val) { for(int offset = THREADS_PER_VERTEX/2; offset > 0; offset >>= 1) { //Reducing only in same groups int3 other; other.x = __shfl_down(val.x, offset, THREADS_PER_VERTEX); other.y = __shfl_down(val.y, offset, THREADS_PER_VERTEX); other.z = __shfl_down(val.z, offset, THREADS_PER_VERTEX); //the min3_x function has to be branch-free val = min3_x(val, other); } return val; } //#if defined(__CUDA_ARCH__) && (__CUDA_ARCH__ < 600) __device__ double atomicAdd(double* address, double val) { unsigned long long int* address_as_ull = (unsigned long long int*)address; unsigned long long int old = *address_as_ull, assumed; do { assumed = old; old = atomicCAS(address_as_ull, assumed, __double_as_longlong(val + __longlong_as_double(assumed))); // Note: uses integer comparison to avoid hang in case of NaN (since NaN != NaN) } while (assumed != old); return __longlong_as_double(old); } //#endif __host__ __device__ int blockIdyForNode(int u) { return (u / BLOCK_Y_SIZE); } __global__ void discharge_kernel(int blocky_offset, double *cf, int num_nodes, int s, int t, int *row_offsets, int *col_indices, int *reverse, double *e, int *h, int *active_blocks) { //branch diverging inside the kernel //ID of the current block of nodes int blocky = blocky_offset + blockIdx.y; //Node concerned by this thread int u = blocky * blockDim.y + threadIdx.y; #ifdef ACTIVE_FLAGS __shared__ bool is_block_active; if(threadIdx.x == 0 && threadIdx.y ==0) { is_block_active = atomicExch(&active_blocks[blocky], 0); } __syncthreads(); if(!is_block_active) return; is_block_active = false; #endif //Shared between threads of the x-axis //8 byte aligned extern __shared__ double sh[]; double *local_e = sh; int *local_h = (int*)&sh[blockDim.y]; //Vertex concerned by the discharge op int local_u = threadIdx.y; if (u >= num_nodes || u == s || u == t) return; int cycle = KERNEL_CYCLES + 1; while(--cycle) { if(threadIdx.x == 0) { local_h[local_u] = h[u]; local_e[local_u] = e[u]; //no sync, same warp } //if node is not active, nothing to do if(local_e[local_u] <= 0.0 || local_h[local_u] == num_nodes) break; #if LOG_LEVEL > 3 if(threadIdx.x == 0) printf("%i is active : e=%f le=%f lh=%i h=%i \n", u, e[u], local_e[local_u], local_h[local_u], h[u]); #endif //Looking for lowest neighbor //First is neighbor height //Second is correcponding edge index int3 thread_candidate; thread_candidate.x = INT_MAX; //TODO put row_offsets in shared ? int end_edge = row_offsets[u+1]; for(int i_edge = row_offsets[u] + threadIdx.x; i_edge < end_edge; i_edge += blockDim.x) { int neighbor = col_indices[i_edge]; int3 candidate; //setting neighbor height //if neighbor cannot be chosen, use identity element of min candidate.x = (cf[i_edge] > 0 && h[neighbor] < num_nodes) ? h[neighbor] : INT_MAX; candidate.y = i_edge; candidate.z = neighbor; thread_candidate = min3_x( thread_candidate, candidate ); } //using warpReduceMin //TODO if blockDim.x is bigger than a warp, use blockDim.y = 1 and blockReduceMin #if THREADS_PER_VERTEX > 1 //printf("Y=%i ; T:%i : we have a candidate for %i with h %i \n",threadIdx.y, threadIdx.x, u, thread_candidate.x); thread_candidate = warpReduceMin(thread_candidate); #endif //Only first of blocks has the result if(threadIdx.x == 0) { //printf("the winner for %i is h=%i \n", u, thread_candidate.x); //Retrieving result int h_neighbor = thread_candidate.x; int i_edge = thread_candidate.y; int neighbor = thread_candidate.z; if(h_neighbor == INT_MAX) break; //no admissible neighbor //If pushing is possible, push if(local_h[local_u] > h_neighbor) { //pushing from u to neighbor double d = min(local_e[local_u], cf[i_edge]); #if LOG_LEVEL > 3 printf("Pushing %f/%f from %i to %i, h = %i and %i, eu = %f \n", d, cf[i_edge], u, col_indices[i_edge], local_h[local_u], h_neighbor, local_e[local_u]); #endif atomicAdd(&cf[reverse[i_edge]], d); //TODO directly set mask ? atomicAdd(&cf[i_edge], -d); atomicAdd(&e[neighbor], d); local_e[local_u] = atomicAdd(&e[u], -d) - d; //postfix operator #ifdef ACTIVE_FLAGS if(local_e[local_u] > 0) is_block_active = 1; active_blocks[blockIdyForNode(neighbor)] = 1; #endif } else { //if we can't push, relabel to lowest + 1 (key to the lock free algo) #if LOG_LEVEL > 3 printf("Relabeling %i from %i to %i, excess was %f \n", u, local_h[local_u], h_neighbor+1, local_e[local_u]); #endif h[u] = local_h[local_u] = h_neighbor + 1; is_block_active = 1; } } } //setting global flag for current block #ifdef ACTIVE_FLAGS __syncthreads(); //Not sure if its alive //if(threadIdx.x == 0 && threadIdx.y ==0) { //TODO we only need to do it once if(is_block_active) active_blocks[blocky] = 1; //printf("------------ SACTIVATING %i \n", blockIdx.y); //} #endif } __global__ void remove_violating_edges_kernel(double *cf, int num_nodes, int *row_offsets, int *col_indices, int *reverse, double *e, int *h, int *active_blocks) { int u = blockIdx.x * blockDim.x + threadIdx.x; if (u >= num_nodes) return; for (int i = row_offsets[u]; i < row_offsets[u+1]; ++i) { int v = col_indices[i]; double cf_uv = cf[i]; //random accesses global memory if(cf_uv > 0 && h[u] > h[v] + 1) { printf("%i is violating edge \n", u); int vu = reverse[i]; double eu = atomicAdd(&e[u], -cf_uv) - cf_uv; double ev = atomicAdd(&e[v], cf_uv) + cf_uv; atomicAdd(&cf[vu], cf_uv); cf[i] = 0; #ifdef ACTIVE_FLAGS //we cant turn off the associated blocks //other vertices may be active #endif } } } __global__ void global_gap_relabeling_post_bfs_kernel(int* global_relabel_h, int *h, double *e, int num_nodes) { int u = blockIdx.x * blockDim.x + threadIdx.x; if (u >= num_nodes) return; if(global_relabel_h[u] == -1) { //we cant go from the node to the sink h[u] = num_nodes; } else { if(global_relabel_h[u] > h[u]) h[u] = global_relabel_h[u]; } } //Wrapper functions //Discharge : apply the push/relabel ops //return true if there is still active nodes in the graph bool discharge(double *cf, int num_nodes, int s, int t, int *row_offsets, int *col_indices, int *reverse, double *e, int *h, int *q, int *active_blocks) { //first and last y block to execute, [start; end[ int block_idy_start = 0, block_idy_end = 0; int total_y_blocks = blockIdyForNode(num_nodes) + 1; #if LOG_LEVEL > 4 cudaDeviceSynchronize(); //e need to be ready printf("Actives nodes : "); for(int u=0; u != num_nodes; ++u) if(e[u] > 0) printf("\t%i", u); printf("\n"); #endif #ifdef ACTIVE_FLAGS cudaDeviceSynchronize(); //active_blocks need to be ready #if LOG_LEVEL > 4 printf("Actives blocks : "); #endif int y=0; for(; y != total_y_blocks; ++y) if(active_blocks[y]) { #if LOG_LEVEL > 4 printf("\t%i:[%i;%i[", y, y*BLOCK_Y_SIZE, (y+1)*BLOCK_Y_SIZE); #endif block_idy_start = y; block_idy_end = y + 1; break; } for(++y; y != total_y_blocks; ++y) if(active_blocks[y]) { #if LOG_LEVEL > 4 printf("\t%i:[%i;%i[", y, y*BLOCK_Y_SIZE, (y+1)*BLOCK_Y_SIZE); #endif block_idy_end = y + 1; } #if LOG_LEVEL > 4 printf("\n"); printf("Discharge : from %i to %i, %f%% of the vertices \n", block_idy_start * BLOCK_Y_SIZE, block_idy_end * BLOCK_Y_SIZE, 100 * (double)(block_idy_end - block_idy_start) / total_y_blocks); #endif #else block_idy_start = 0; block_idy_end = total_y_blocks+1; #endif dim3 block(THREADS_PER_VERTEX, BLOCK_Y_SIZE); dim3 grid(1, (block_idy_end - block_idy_start)); int shared_memory_size = block.y * sizeof(int) + block.y * sizeof(double); discharge_kernel<<<grid, block, shared_memory_size>>>(block_idy_start, cf, num_nodes, s, t, row_offsets, col_indices, reverse, e, h, active_blocks); cudaDeviceSynchronize(); //TODO use indep flag ? for(y=0; y != total_y_blocks; ++y) if(active_blocks[y]) return true; return false; } void remove_violating_edges(double *cf, int num_nodes, int *row_offsets, int *col_indices, int *reverse, double *e, int *h, int *active_blocks) { cudaDeviceSynchronize(); //TODO remove_violating_edges_kernel<<<(num_nodes + 255)/256, 256>>>(cf, num_nodes, row_offsets, col_indices, reverse, e, h, active_blocks); } void global_gap_relabeling_post_bfs(int *global_relabel_h, int* h, double *e, int num_nodes) { cudaDeviceSynchronize(); //TODO global_gap_relabeling_post_bfs_kernel<<<(num_nodes + 255)/256, 256>>>(global_relabel_h, h, e, num_nodes); }
0
rapidsai_public_repos/code-share/maxflow
rapidsai_public_repos/code-share/maxflow/push-relabel/push-relabel_operations_cpu_omp.cpp
#include <climits> #include <algorithm> #include <functional> #define DISCHARGE_CYCLES 1000 //returns true is the node is active inline bool is_active(int u, int* h, double* e, int num_nodes) { return (h[u] < num_nodes && e[u] > 0); } void discharge(double *cf, int num_nodes, int s, int t, int *row_offsets, int *col_indices, int *reverse, double *e, int *h, int *q) { for(int it=0; it < DISCHARGE_CYCLES; ++it) { int size = 0; #pragma omp parallel for for(int u=0; u < num_nodes; ++u) if(u != s && u != t) { if(!is_active(u, h, e, num_nodes)) continue; if(size != 0 && h[u] > h[q[0]]) //if the new element is higher than those in the queue size = 0; //reset queue (highest elements first) int pos = __sync_fetch_and_add(&size, 1); q[pos] = u; } if(!size) break; //TODO floating points comparaison #pragma omp parallel for for(int i=0; i < size; ++i) { int u = q[i]; while(e[u] > 0) { int hu = h[u]; //height of u double eu = e[u]; //excess of u #if LOG_LEVEL > 3 printf("%i is active with e = %f, h=%i\n", u, eu, hu); #endif //Looking for lowest neighbor int hp = INT_MAX; int vp; int uvp; double cf_uvp; //TODO parallel reduction ? //row_offsets in shared ? for (int i = row_offsets[u]; i < row_offsets[u+1]; ++i) { double cf_uv = cf[i]; int v = col_indices[i]; int hpp = h[v]; if(cf_uv <= 0.0 || hpp == num_nodes) continue; if(hpp < hp) { vp = v; hp = hpp; uvp = i; cf_uvp = cf_uv; } } if(hp == INT_MAX) break; //No outgoing edges (can happen if the node is linked to the source) //If pushing is possible, push if(hu > hp) { //pushing from u to vp double d = std::min(eu, cf_uvp); #if LOG_LEVEL > 3 printf("Pushing %f/%f from %i to %i, h = %i and %i, eu = %f \n", d,cf_uvp, u, vp, hu, hp, eu); #endif //sync fetch and add doesnt work on doubles #pragma omp atomic cf[reverse[uvp]] += d; #pragma omp atomic cf[uvp] -= d; #pragma omp atomic e[vp] += d; #pragma omp atomic e[u] -= d; } else { //if we can't push, relabel to lowest + 1 (key to the lock free algo) h[u] = hp + 1; #if LOG_LEVEL > 3 printf("Relabeling %i from %i to %i, excess was %f \n", u, hu, hp+1, eu); #endif } } } } } void remove_violating_edges(double *cf, int num_nodes, int *row_offsets, int *col_indices, int *reverse, double *e, int *h) { #pragma omp parallel for for(int u=0; u < num_nodes; ++u) { for (int i = row_offsets[u]; i < row_offsets[u+1]; ++i) { int v = col_indices[i]; double cf_uv = cf[i]; if(cf_uv > 0 && h[u] > h[v] + 1) { #if LOG_LEVEL > 3 printf("%i is violating edge \n", u); #endif int vu = reverse[i]; #pragma omp atomic e[u] -= cf_uv; #pragma omp atomic e[v] += cf_uv; #pragma omp atomic cf[vu] += cf_uv; cf[i] = 0; } } } } void update_excess_total(int *h, double *e, int num_nodes, int *node_mask, double *ExcessTotal) { #pragma omp parallel for for(int u=0; u < num_nodes; ++u) { if(h[u] != -1) continue; h[u] = num_nodes; if(node_mask[u]) continue; node_mask[u] = 1; if(e[u] <= 0.0) continue; #pragma omp atomic *ExcessTotal -= e[u]; #if LOG_LEVEL > 3 printf("Removing edge with excess : %f \n", e[u]); #endif } }
0
rapidsai_public_repos/code-share/maxflow
rapidsai_public_repos/code-share/maxflow/push-relabel/push-relabel.cpp
// Copyright (c) 2016, NVIDIA CORPORATION. All rights reserved. #include "../matrix.h" #include "../allocator.h" #include <stdio.h> #include "push-relabel_operations.h" #include "../bfs/bfs.h" #include "../graph_tools.h" #include <unistd.h> //#define REORDER_GRAPH //Push-relabel max flow implementation //GPU implementation double maxflowimplementation(csr_graph* orig_g, int s, int t) { int *h = (int*)my_malloc(orig_g->n * sizeof(int)); // nodes height int *q = (int*)my_malloc(orig_g->n * sizeof(int)); // bfs vertices queue #ifdef REORDER_GRAPH csr_graph* g = new csr_graph; reorder_memory(orig_g, g, q, h, &s, &t); #else csr_graph* g = orig_g; #endif double *e = (double*)my_malloc(g->n * sizeof(double)); // flow excess int *global_relabel_h = (int*)my_malloc(g->n * sizeof(int)); // nodes height int *reverse = (int*)my_malloc(g->nnz * sizeof(int)); //reverse edge id double *cf = g->vals_cap; //using vals_cap as cf, vals_flow will not be valid after this function int *p = (int*)my_malloc(g->n * sizeof(int)); // parent vertices int *mask = (int*)my_malloc(g->nnz * sizeof(int)); // edge mask (used in Gunrock only) //Keeping track of blocks containing active nodes int *active_blocks = NULL; #ifdef ACTIVE_FLAGS int n_node_blocks = blockIdyForNode(g->n) + 1; active_blocks = (int*)my_malloc(n_node_blocks * sizeof(int)); fill(n_node_blocks, active_blocks, 0); #endif fill(g->n, h, 0); fill(g->n, global_relabel_h, 0); fill(g->n, e, 0.0); h[s] = g->n; //Saturating out-edges from source for (int i = g->row_offsets[s]; i < g->row_offsets[s+1]; ++i) { int u = g->col_indices[i]; int su = i; int us = g->edge(u,s); double vf_su = g->vals_cap[su]; e[u] = vf_su; g->vals_cap[us] += vf_su; g->vals_cap[su] -= vf_su; active_blocks[blockIdyForNode(u)] = 1; #if LOG_LEVEL > 3 printf("init : pushing %f from %i to %i \n", vf_su, s, u); #endif } //Naive reverse edges finding //We could do it linearly in the kernel for(int u=0; u != g->n; ++u) { for (int i = g->row_offsets[u]; i < g->row_offsets[u+1]; ++i) { int v = g->col_indices[i]; int uv = i; int vu = g->edge(v,u); reverse[uv] = vu; } } double oldet = -1; //forcing init global relabel do { //cudaDeviceSynchronize(); //Mark as valid an edge if its reversal is valid if(e[t] > oldet) { printf("--------- Global relabeling --------- \n"); oldet = e[t]; //Violating edges can exists during lock-free push relabel //We need to treat them (saturate them) before bfs //BFS will make them valid //can be avoided by using while(e[u] > 0) in discharge kernel remove_violating_edges(cf, g->n, g->row_offsets, g->col_indices, reverse, e, h, active_blocks); setup_mask_unsaturated_backward(g->nnz, mask, cf, reverse); //Backwards BFS from sink (global relabeling) bfs(g->row_offsets, g->col_indices, g->n, g->nnz, t, -1, q, global_relabel_h, BFS_MARK_DEPTH, mask); //Post bfs global relabeling + gap relabeling global_gap_relabeling_post_bfs(global_relabel_h, h, e, g->n); cudaDeviceSynchronize(); } #if LOG_LEVEL > 2 printf("Finished push session, s=%f, t=%f \n", e[s], e[t]); #endif } while(discharge(cf, g->n, s, t, g->row_offsets, g->col_indices, reverse, e, h, q, active_blocks)); #if LOG_LEVEL > 2 printf("Finished push-relabel algorithm, s=%f, t=%f \n", e[s], e[t]); #endif return e[t]; }
0
rapidsai_public_repos/code-share/maxflow
rapidsai_public_repos/code-share/maxflow/push-relabel/push-relabel_operations.h
bool discharge(double *cf, int num_nodes, int s, int t, int *row_offsets, int *col_indices, int *reverse, double *e, int *h, int *q, int *active_blocks); void remove_violating_edges(double *cf, int num_nodes, int *row_offsets, int *col_indices, int *reverse, double *e, int *h, int *active_blocks); void global_gap_relabeling_post_bfs(int *global_relabel_h, int* h, double *e, int num_nodes); //GPU conf //Keeps track of active nodes //Execute only those that are actives #define ACTIVE_FLAGS #ifdef USE_GPU int blockIdyForNode(int u); #endif
0
rapidsai_public_repos/code-share/maxflow
rapidsai_public_repos/code-share/maxflow/boost_push_relabel/push-relabel.cpp
#include <boost/config.hpp> #include <iostream> #include <string> #include <boost/graph/push_relabel_max_flow.hpp> #include <boost/graph/adjacency_list.hpp> #include <boost/graph/read_dimacs.hpp> #include <boost/graph/graph_utility.hpp> #include <time.h> #include <fstream> using std::istream; int main() { using namespace boost; typedef adjacency_list_traits<vecS, vecS, directedS> Traits; typedef adjacency_list<listS, vecS, directedS, property<vertex_name_t, std::string>, property<edge_capacity_t, double, property<edge_residual_capacity_t, double, property<edge_reverse_t, Traits::edge_descriptor> > > > Graph; std::ifstream dimacs("../data/dimacs_autoexport.dat"); Graph g; property_map<Graph, edge_capacity_t>::type capacity = get(edge_capacity, g); property_map<Graph, edge_reverse_t>::type rev = get(edge_reverse, g); property_map<Graph, edge_residual_capacity_t>::type residual_capacity = get(edge_residual_capacity, g); Traits::vertex_descriptor s, t; read_dimacs_max_flow(g, capacity, rev, s, t, dimacs); struct timespec start, end; clock_gettime(CLOCK_MONOTONIC, &start); long flow; #if defined(BOOST_MSVC) && BOOST_MSVC <= 1300 // Use non-named parameter version property_map<Graph, vertex_index_t>::type indexmap = get(vertex_index, g); flow = push_relabel_max_flow(g, s, t, capacity, residual_capacity, rev, indexmap); #else flow = push_relabel_max_flow(g, s, t); #endif clock_gettime(CLOCK_MONOTONIC, &end); float time = (end.tv_sec - start.tv_sec) + (end.tv_nsec - start.tv_nsec) * 1e-9; double f_as_d = (double)flow / 1000000000.0; printf("max flow = %f\n", f_as_d); printf("time: %.3f s\n", time); /* std::cout << "c flow values:" << std::endl; graph_traits<Graph>::vertex_iterator u_iter, u_end; graph_traits<Graph>::out_edge_iterator ei, e_end; for (boost::tie(u_iter, u_end) = vertices(g); u_iter != u_end; ++u_iter) for (boost::tie(ei, e_end) = out_edges(*u_iter, g); ei != e_end; ++ei) if (capacity[*ei] > 0) std::cout << "f " << *u_iter << " " << target(*ei, g) << " " << (capacity[*ei] - residual_capacity[*ei]) << std::endl; */ return 0; }
0
rapidsai_public_repos
rapidsai_public_repos/kvikio/.pre-commit-config.yaml
# Copyright (c) 2019-2022, NVIDIA CORPORATION. repos: - repo: https://github.com/pre-commit/pre-commit-hooks rev: v4.4.0 hooks: - id: trailing-whitespace - id: end-of-file-fixer - repo: https://github.com/PyCQA/isort rev: 5.12.0 hooks: - id: isort args: ["--config-root=python/", "--resolve-all-configs"] files: python/.* types_or: [python, cython, pyi] - id: isort args: ["--config-root=legate/", "--resolve-all-configs"] files: legate/.* types_or: [python, cython, pyi] - repo: https://github.com/psf/black rev: 23.3.0 hooks: - id: black files: (python|legate)/.* args: ["--config", "python/pyproject.toml"] - repo: https://github.com/PyCQA/flake8 rev: 6.0.0 hooks: - id: flake8 args: ["--config=.flake8"] files: (python|legate)/.*$ types: [file] types_or: [python, cython] additional_dependencies: ["flake8-force"] - repo: https://github.com/MarcoGorelli/cython-lint rev: v0.15.0 hooks: - id: cython-lint - repo: https://github.com/pre-commit/mirrors-mypy rev: 'v1.3.0' hooks: - id: mypy additional_dependencies: [types-cachetools] args: ["--config-file=python/pyproject.toml", "python/kvikio", "python/tests", "python/examples", "python/benchmarks"] pass_filenames: false - repo: https://github.com/pre-commit/mirrors-clang-format rev: v16.0.6 hooks: - id: clang-format types_or: [c, c++, cuda] args: ["-fallback-style=none", "-style=file", "-i"] - repo: local hooks: - id: copyright-check name: copyright-check entry: python ./ci/checks/copyright.py --git-modified-only --update-current-year language: python pass_filenames: false additional_dependencies: [gitpython] - id: cmake-format name: cmake-format entry: ./cpp/scripts/run-cmake-format.sh cmake-format language: python types: [cmake] # Note that pre-commit autoupdate does not update the versions # of dependencies, so we'll have to update this manually. additional_dependencies: - cmakelang==0.6.13 verbose: true require_serial: true - id: cmake-lint name: cmake-lint entry: ./cpp/scripts/run-cmake-format.sh cmake-lint language: python types: [cmake] # Note that pre-commit autoupdate does not update the versions # of dependencies, so we'll have to update this manually. additional_dependencies: - cmakelang==0.6.13 verbose: true require_serial: true - repo: https://github.com/codespell-project/codespell rev: v2.2.4 hooks: - id: codespell exclude: | (?x)^( ^CHANGELOG.md$ ) - repo: https://github.com/rapidsai/dependency-file-generator rev: v1.5.2 hooks: - id: rapids-dependency-file-generator args: ["--clean"] default_language_version: python: python3
0
rapidsai_public_repos
rapidsai_public_repos/kvikio/.flake8
# Copyright (c) 2023, NVIDIA CORPORATION. [flake8] filename = *.py, *.pyx, *.pxd, *.pxi force-check = True max-line-length = 88 exclude = .eggs, *.egg, build, docs, .git, _skbuild, ignore = # line break before binary operator W503, # whitespace before : E203 per-file-ignores = # Ignore black/flake8-pyi conflicts *.pyi:E301 E302 E704 # Rules ignored only in Cython: # E211: whitespace before '(' (used in multi-line imports) # E225: Missing whitespace around operators (breaks cython casting syntax like <int>) # E226: Missing whitespace around arithmetic operators (breaks cython pointer syntax like int*) # E227: Missing whitespace around bitwise or shift operator (Can also break casting syntax) # E275: Missing whitespace after keyword (Doesn't work with Cython except?) # E402: invalid syntax (works for Python, not Cython) # E999: invalid syntax (works for Python, not Cython) # W503: line break before binary operator (breaks lines that start with a pointer) # W504: line break after binary operator (breaks lines that end with a pointer) *.pyx: E211, E225, E226, E227, E275, E402, E999, W503, W504 *.pxd: E211, E225, E226, E227, E275, E402, E999, W503, W504 *.pxi: E211, E225, E226, E227, E275, E402, E999, W503, W504
0
rapidsai_public_repos
rapidsai_public_repos/kvikio/README.md
# KvikIO: High Performance File IO ## Summary KvikIO is a Python and C++ library for high performance file IO. It provides C++ and Python bindings to [cuFile](https://docs.nvidia.com/gpudirect-storage/api-reference-guide/index.html), which enables [GPUDirect Storage (GDS)](https://developer.nvidia.com/blog/gpudirect-storage/). KvikIO also works efficiently when GDS isn't available and can read/write both host and device data seamlessly. The C++ library is header-only making it easy to include in [existing projects](https://github.com/rapidsai/kvikio/blob/HEAD/cpp/examples/downstream/). ### Features * Object oriented API of [cuFile](https://docs.nvidia.com/gpudirect-storage/api-reference-guide/index.html) with C++/Python exception handling. * A Python [Zarr](https://zarr.readthedocs.io/en/stable/) backend for reading and writing GPU data to file seamlessly. * Concurrent reads and writes using an internal thread pool. * Non-blocking API. * Handle both host and device IO seamlessly. * Provides Python bindings to [nvCOMP](https://github.com/NVIDIA/nvcomp). ### Documentation * Python: <https://docs.rapids.ai/api/kvikio/nightly/> * C++: <https://docs.rapids.ai/api/libkvikio/nightly/>
0
rapidsai_public_repos
rapidsai_public_repos/kvikio/CHANGELOG.md
# kvikio 23.10.00 (11 Oct 2023) ## 🚨 Breaking Changes - Update to Cython 3.0.0 ([#258](https://github.com/rapidsai/kvikio/pull/258)) [@vyasr](https://github.com/vyasr) ## πŸ› Bug Fixes - Add numcodecs pin ([#300](https://github.com/rapidsai/kvikio/pull/300)) [@vyasr](https://github.com/vyasr) - Add missed filename to sed_runner call ([#286](https://github.com/rapidsai/kvikio/pull/286)) [@raydouglass](https://github.com/raydouglass) - Use `conda mambabuild` not `mamba mambabuild` ([#278](https://github.com/rapidsai/kvikio/pull/278)) [@bdice](https://github.com/bdice) - fixes #254 ([#262](https://github.com/rapidsai/kvikio/pull/262)) [@madsbk](https://github.com/madsbk) ## πŸ“– Documentation - minor doc fixes ([#279](https://github.com/rapidsai/kvikio/pull/279)) [@madsbk](https://github.com/madsbk) - Docs ([#268](https://github.com/rapidsai/kvikio/pull/268)) [@madsbk](https://github.com/madsbk) - Zarr notebook ([#261](https://github.com/rapidsai/kvikio/pull/261)) [@madsbk](https://github.com/madsbk) ## πŸ› οΈ Improvements - Use branch-23.10 for devcontainers workflow. ([#289](https://github.com/rapidsai/kvikio/pull/289)) [@bdice](https://github.com/bdice) - Update image names ([#284](https://github.com/rapidsai/kvikio/pull/284)) [@AyodeAwe](https://github.com/AyodeAwe) - Update to clang 16.0.6. ([#280](https://github.com/rapidsai/kvikio/pull/280)) [@bdice](https://github.com/bdice) - Update doxygen to 1.9.1 ([#277](https://github.com/rapidsai/kvikio/pull/277)) [@vyasr](https://github.com/vyasr) - Async I/O using by-value arguments ([#275](https://github.com/rapidsai/kvikio/pull/275)) [@madsbk](https://github.com/madsbk) - Zarr-IO Benchmark ([#274](https://github.com/rapidsai/kvikio/pull/274)) [@madsbk](https://github.com/madsbk) - Add KvikIO devcontainers ([#273](https://github.com/rapidsai/kvikio/pull/273)) [@trxcllnt](https://github.com/trxcllnt) - async: fall back to blocking ([#272](https://github.com/rapidsai/kvikio/pull/272)) [@madsbk](https://github.com/madsbk) - Unify batch and stream API check ([#271](https://github.com/rapidsai/kvikio/pull/271)) [@madsbk](https://github.com/madsbk) - Use `copy-pr-bot` ([#269](https://github.com/rapidsai/kvikio/pull/269)) [@ajschmidt8](https://github.com/ajschmidt8) - Zarr+CuPy+GDS+nvCOMP made easy ([#267](https://github.com/rapidsai/kvikio/pull/267)) [@madsbk](https://github.com/madsbk) - Remove sphinx pinning ([#260](https://github.com/rapidsai/kvikio/pull/260)) [@vyasr](https://github.com/vyasr) - Initial changes to support cufile stream I/O. ([#259](https://github.com/rapidsai/kvikio/pull/259)) [@tell-rebanta](https://github.com/tell-rebanta) - Update to Cython 3.0.0 ([#258](https://github.com/rapidsai/kvikio/pull/258)) [@vyasr](https://github.com/vyasr) - Modernize Python build ([#257](https://github.com/rapidsai/kvikio/pull/257)) [@vyasr](https://github.com/vyasr) - Enable roundtrip for nvCOMP batch codecs. ([#253](https://github.com/rapidsai/kvikio/pull/253)) [@Alexey-Kamenev](https://github.com/Alexey-Kamenev) # kvikio 23.08.00 (9 Aug 2023) ## πŸ› Bug Fixes - Add nvcomp support to older CUDA 11 versions on aarch64. ([#255](https://github.com/rapidsai/kvikio/pull/255)) [@bdice](https://github.com/bdice) - Unify `KVIKIO_CUFILE_FOUND` ([#243](https://github.com/rapidsai/kvikio/pull/243)) [@madsbk](https://github.com/madsbk) - Disable the batch API when in compatibility mode ([#239](https://github.com/rapidsai/kvikio/pull/239)) [@madsbk](https://github.com/madsbk) - Fix libcufile dependency. ([#237](https://github.com/rapidsai/kvikio/pull/237)) [@bdice](https://github.com/bdice) ## πŸš€ New Features - KvikIO: Build CUDA 12 packages ([#224](https://github.com/rapidsai/kvikio/pull/224)) [@bdice](https://github.com/bdice) ## πŸ› οΈ Improvements - Revert CUDA 12.0 CI workflows to branch-23.08. ([#252](https://github.com/rapidsai/kvikio/pull/252)) [@bdice](https://github.com/bdice) - Add support for nvCOMP batch API ([#249](https://github.com/rapidsai/kvikio/pull/249)) [@Alexey-Kamenev](https://github.com/Alexey-Kamenev) - Use cuda-version to constrain cudatoolkit. ([#247](https://github.com/rapidsai/kvikio/pull/247)) [@bdice](https://github.com/bdice) - Make C++ &amp; Python teams owners of `legate/` ([#246](https://github.com/rapidsai/kvikio/pull/246)) [@jakirkham](https://github.com/jakirkham) - Use nvcomp conda package. ([#245](https://github.com/rapidsai/kvikio/pull/245)) [@bdice](https://github.com/bdice) - Adding code owners ([#244](https://github.com/rapidsai/kvikio/pull/244)) [@madsbk](https://github.com/madsbk) - Clean up dependency lists ([#241](https://github.com/rapidsai/kvikio/pull/241)) [@vyasr](https://github.com/vyasr) - Clean up isort configs ([#240](https://github.com/rapidsai/kvikio/pull/240)) [@vyasr](https://github.com/vyasr) - Update to CMake 3.26.4 ([#238](https://github.com/rapidsai/kvikio/pull/238)) [@vyasr](https://github.com/vyasr) - use rapids-upload-docs script ([#234](https://github.com/rapidsai/kvikio/pull/234)) [@AyodeAwe](https://github.com/AyodeAwe) - Migrate as much as possible to pyproject.toml, stop using versioneer to manage versions, update dependencies.yaml. ([#232](https://github.com/rapidsai/kvikio/pull/232)) [@bdice](https://github.com/bdice) - Remove documentation build scripts for Jenkins ([#230](https://github.com/rapidsai/kvikio/pull/230)) [@ajschmidt8](https://github.com/ajschmidt8) - Use the Zarr&#39;s new `getitems()` API ([#131](https://github.com/rapidsai/kvikio/pull/131)) [@madsbk](https://github.com/madsbk) # kvikio 23.06.00 (7 Jun 2023) ## 🚨 Breaking Changes - Drop Python 3.8 and run Python 3.9 tests/builds ([#206](https://github.com/rapidsai/kvikio/pull/206)) [@shwina](https://github.com/shwina) - Use the new registry and mapper API of Legate ([#202](https://github.com/rapidsai/kvikio/pull/202)) [@madsbk](https://github.com/madsbk) ## πŸ› Bug Fixes - Add sccache s3 controls ([#226](https://github.com/rapidsai/kvikio/pull/226)) [@robertmaynard](https://github.com/robertmaynard) - fixed import of `ArrayLike` and `DTypeLike` ([#219](https://github.com/rapidsai/kvikio/pull/219)) [@madsbk](https://github.com/madsbk) - `load_library()`: fixed the mode argument, which was ignored by mistake ([#199](https://github.com/rapidsai/kvikio/pull/199)) [@madsbk](https://github.com/madsbk) ## πŸ“– Documentation - Update docs ([#218](https://github.com/rapidsai/kvikio/pull/218)) [@madsbk](https://github.com/madsbk) - Update README. ([#207](https://github.com/rapidsai/kvikio/pull/207)) [@bdice](https://github.com/bdice) ## πŸ› οΈ Improvements - Legate HDF5 using kerchunk ([#222](https://github.com/rapidsai/kvikio/pull/222)) [@madsbk](https://github.com/madsbk) - run docs nightly too ([#221](https://github.com/rapidsai/kvikio/pull/221)) [@AyodeAwe](https://github.com/AyodeAwe) - C++ bindings to the Batch API ([#220](https://github.com/rapidsai/kvikio/pull/220)) [@madsbk](https://github.com/madsbk) - mypy: bump to v1.3.0 ([#214](https://github.com/rapidsai/kvikio/pull/214)) [@madsbk](https://github.com/madsbk) - Update cupy dependency ([#213](https://github.com/rapidsai/kvikio/pull/213)) [@vyasr](https://github.com/vyasr) - Enable sccache hits for local builds ([#210](https://github.com/rapidsai/kvikio/pull/210)) [@AyodeAwe](https://github.com/AyodeAwe) - Revert to branch-23.06 for shared-action-workflows ([#209](https://github.com/rapidsai/kvikio/pull/209)) [@shwina](https://github.com/shwina) - Zarr+nvCOMP ([#208](https://github.com/rapidsai/kvikio/pull/208)) [@madsbk](https://github.com/madsbk) - Drop Python 3.8 and run Python 3.9 tests/builds ([#206](https://github.com/rapidsai/kvikio/pull/206)) [@shwina](https://github.com/shwina) - isort clean up ([#205](https://github.com/rapidsai/kvikio/pull/205)) [@madsbk](https://github.com/madsbk) - Only look for libcufile.so.0 ([#203](https://github.com/rapidsai/kvikio/pull/203)) [@wence-](https://github.com/wence-) - Use the new registry and mapper API of Legate ([#202](https://github.com/rapidsai/kvikio/pull/202)) [@madsbk](https://github.com/madsbk) - Remove usage of rapids-get-rapids-version-from-git ([#201](https://github.com/rapidsai/kvikio/pull/201)) [@jjacobelli](https://github.com/jjacobelli) - Legate Zarr ([#198](https://github.com/rapidsai/kvikio/pull/198)) [@madsbk](https://github.com/madsbk) - Add API to get compatibility mode status in a FileHandle object ([#197](https://github.com/rapidsai/kvikio/pull/197)) [@vuule](https://github.com/vuule) - Update clang-format to 16.0.1. ([#196](https://github.com/rapidsai/kvikio/pull/196)) [@bdice](https://github.com/bdice) - Use ARC V2 self-hosted runners for GPU jobs ([#195](https://github.com/rapidsai/kvikio/pull/195)) [@jjacobelli](https://github.com/jjacobelli) - Optimize small reads and writes ([#190](https://github.com/rapidsai/kvikio/pull/190)) [@madsbk](https://github.com/madsbk) - Remove underscore in build string. ([#188](https://github.com/rapidsai/kvikio/pull/188)) [@bdice](https://github.com/bdice) # kvikio 23.04.00 (6 Apr 2023) ## πŸ› Bug Fixes - Fallback to use the CUDA primary context ([#189](https://github.com/rapidsai/kvikio/pull/189)) [@madsbk](https://github.com/madsbk) - posix_io: fix error message and allow `nbytes == 0` on write ([#184](https://github.com/rapidsai/kvikio/pull/184)) [@madsbk](https://github.com/madsbk) - Support of stream ordered device memory allocations (async mallocs) ([#181](https://github.com/rapidsai/kvikio/pull/181)) [@madsbk](https://github.com/madsbk) ## πŸ› οΈ Improvements - Implement `build.sh` ([#185](https://github.com/rapidsai/kvikio/pull/185)) [@madsbk](https://github.com/madsbk) - Legate Support ([#183](https://github.com/rapidsai/kvikio/pull/183)) [@madsbk](https://github.com/madsbk) - Fix docs build to be `pydata-sphinx-theme=0.13.0` compatible ([#180](https://github.com/rapidsai/kvikio/pull/180)) [@galipremsagar](https://github.com/galipremsagar) - Update to GCC 11 ([#179](https://github.com/rapidsai/kvikio/pull/179)) [@bdice](https://github.com/bdice) - Fix GHA build workflow ([#177](https://github.com/rapidsai/kvikio/pull/177)) [@AjayThorve](https://github.com/AjayThorve) - Remove Jenkins/`gpuCI` references ([#174](https://github.com/rapidsai/kvikio/pull/174)) [@ajschmidt8](https://github.com/ajschmidt8) - Update `ops-bot.yaml` config ([#173](https://github.com/rapidsai/kvikio/pull/173)) [@ajschmidt8](https://github.com/ajschmidt8) - nvcomp xfail compression ratios ([#167](https://github.com/rapidsai/kvikio/pull/167)) [@madsbk](https://github.com/madsbk) - Move date to build string in `conda` recipe ([#165](https://github.com/rapidsai/kvikio/pull/165)) [@ajschmidt8](https://github.com/ajschmidt8) - Add gh actions ([#164](https://github.com/rapidsai/kvikio/pull/164)) [@AjayThorve](https://github.com/AjayThorve) # kvikio 23.02.00 (9 Feb 2023) ## πŸ› Bug Fixes - Manually open and close the cuFile driver ([#160](https://github.com/rapidsai/kvikio/pull/160)) [@madsbk](https://github.com/madsbk) - nvcomp tests: update hardcoded lengths ([#156](https://github.com/rapidsai/kvikio/pull/156)) [@madsbk](https://github.com/madsbk) ## πŸ› οΈ Improvements - Update changelog for releases 22.06-22.12. ([#157](https://github.com/rapidsai/kvikio/pull/157)) [@bdice](https://github.com/bdice) - Add nvcomp to kvikio-exports export set ([#155](https://github.com/rapidsai/kvikio/pull/155)) [@trxcllnt](https://github.com/trxcllnt) - Use pre-commit for style checks. ([#154](https://github.com/rapidsai/kvikio/pull/154)) [@bdice](https://github.com/bdice) - Enable copy_prs. ([#151](https://github.com/rapidsai/kvikio/pull/151)) [@bdice](https://github.com/bdice) # kvikio 22.12.00 (4 Jan 2023) ## πŸ› Bug Fixes - Don't use CMake 3.25.0 as it has a FindCUDAToolkit show stopping bug (#146) @robertmaynard - dlopen: now trying "libcufile.so.1", "libcufile.so.0", "libcufile.so" (#141) @madsbk - Update nvcomp's expected sizes when testing (#134) @madsbk - `is_host_memory()`: returns `true` when `CUDA_ERROR_NOT_INITIALIZED` (#133) @madsbk ## πŸ“– Documentation - Use rapidsai CODE_OF_CONDUCT.md (#144) @bdice ## πŸ› οΈ Improvements - Dependency clean up (#137) @madsbk - Overload `numpy.fromfile()` and `cupy.fromfile()` (#135) @madsbk # kvikio 22.10.00 (25 Oct 2022) ## 🚨 Breaking Changes - Rename `reset_num_threads()` and `reset_task_size()` (#123) @madsbk ## πŸ› Bug Fixes - Fixing `kvikio_dev_cuda11.5.yml` and clean up (#122) @madsbk ## πŸ“– Documentation - Document that minimum required CMake version is now 3.23.1 (#132) @robertmaynard ## πŸ› οΈ Improvements - Use Zarr v2.13.0a2 (#129) @madsbk - Allow cupy 11 (#128) @galipremsagar - Set version when dlopen() cuda and cufile (#127) @madsbk - Fall back to compat mode if we cannot open the file with `O_DIRECT` (#126) @madsbk - Update versioneer to v0.22 (#124) @madsbk - Rename `reset_num_threads()` and `reset_task_size()` (#123) @madsbk - document channel_priority for conda (#121) @dcherian - Update nvComp bindings to 2.3.3 (#120) @thomcom - Use rapids-cmake 22.10 best practice for RAPIDS.cmake location (#118) @robertmaynard - Standalone Downstream C++ Build Example (#29) @madsbk # kvikio 22.08.00 (18 Aug 2022) ## 🚨 Breaking Changes - Fix typo in GDS availability check (#78) @jakirkham ## πŸ› Bug Fixes - CI: install cuDF to test nvCOMP (#108) @madsbk - Require `python` in `run` (#101) @jakirkham - Check stub error (#86) @madsbk - FindcuFile now searches in the current CUDA Toolkit location (#85) @robertmaynard - Fix typo in GDS availability check (#78) @jakirkham ## πŸ“– Documentation - Defer loading of `custom.js` (#114) @galipremsagar - Add stable channel install instruction (#107) @dcherian - Use documented header template for `doxygen` (#105) @galipremsagar - Fix issues with day & night modes in docs (#95) @galipremsagar - add Notes related to page-aligned read/write methods to the Python docstrings (#91) @grlee77 - minor docstring fixes (#89) @grlee77 ## πŸ› οΈ Improvements - Conda environment file (#103) @madsbk - CI: build without cuFile (#100) @madsbk - Support host memory (#82) @madsbk # kvikio 22.06.00 (7 Jun 2022) ## πŸ› Bug Fixes - Mark detail functions as inline (#69) @vyasr - Embed Cython docstrings in generated files. (#58) @vyasr - Add new files to update version script (#53) @charlesbluca ## πŸ› οΈ Improvements - Fix conda recipes (#74) @Ethyling - Use conda compilers (#71) @Ethyling - dlopen `libcuda.so` (#70) @madsbk - Use CMake provided targets for the cuda driver and dl libraries (#68) @robertmaynard - Use namespace kvikio::detail (#67) @madsbk - Build kvikio using libkvikio from CPU job in GPU job (#64) @Ethyling - Use conda to build python packages during GPU tests (#62) @Ethyling - `convert_size2off()`: fix different signedness (#60) @madsbk - Keep the rapids-cmake version insync with calver (#59) @robertmaynard - compat_mode per `FileHandle` (#54) @madsbk - Add `ops-bot.yaml` config file (#52) @ajschmidt8 - python: bump versions to v22.06 (#51) @madsbk
0