Voronoi Image

Simply using a raw dump of an image and feeding it to the image intensity input of the Delaunator.

Log in to post a comment.

// LL 2021

// Voronoi code from from "Raytraced sphere #5" by reinder
// https://turtletoy.net/turtle/186c7c9e4f
// - Originally from:
// https://github.com/mapbox/delaunator

Canvas.setpenopacity(1);


const canvas_size = 90;

const max_radius = 1.65; // min=1, max=3, step=0.01
const min_radius = .27; // min = 0.25, max = 0.7, step = 0.01
const radius_decr = .9;
const max_tries = 100;
const circle_radius = .5;
const circle_buckets = [];
const circle_num_buckets = canvas_size/max_radius;
const coords = [];
const line_segments = [];
let delaunay;
let radius = max_radius;
const circles = [];
const turtle = new Turtle();

function walk(i)
{
    if (i == 0) {
        do {
            if(!add_circle(turtle, radius)) {
                radius *= radius_decr;
            }
        } while(radius >= min_radius);
        delaunay = Delaunator.from(coords);
    }
    
    const t0i = i;
    const t0 = (t0i/3|0) * 3;
    const t1i = delaunay.halfedges[i];
    const tt = delaunay.triangles;
    const c = delaunay.coords;
    
    if (t1i >= t0i) {
        const t1 = (t1i/3|0) * 3;
        const p0 = circumcenter(c[tt[t0+0]*2+0], c[tt[t0+0]*2+1], c[tt[t0+1]*2+0], c[tt[t0+1]*2+1], c[tt[t0+2]*2+0], c[tt[t0+2]*2+1]);
        const p1 = circumcenter(c[tt[t1+0]*2+0], c[tt[t1+0]*2+1], c[tt[t1+1]*2+0], c[tt[t1+1]*2+1], c[tt[t1+2]*2+0], c[tt[t1+2]*2+1]);

        turtle.jump(p0.x, p0.y);
        turtle.goto(p1.x, p1.y);
    } else if (t1i < 0) {
        const p0 = circumcenter(c[tt[t0+0]*2+0], c[tt[t0+0]*2+1], c[tt[t0+1]*2+0], c[tt[t0+1]*2+1], c[tt[t0+2]*2+0], c[tt[t0+2]*2+1]);
        const v0 = [c[tt[t0+(t0i % 3)]*2+0], c[tt[t0+(t0i % 3)]*2+1]];
        const v1 = [c[tt[t0+((t0i + 1) % 3)]*2+0], c[tt[t0+((t0i + 1) % 3)]*2+1]];

        const d = [(v0[1]-v1[1]), -(v0[0]-v1[0])];
        const l = Math.sqrt(d[0]**2 + d[1]**2);
        
        turtle.jump(p0.x, p0.y);
        turtle.goto(p0.x + 200*d[0]/l, p0.y + 200*d[1]/l);
    }
    
    return i < delaunay.halfedges.length - 1;
}

for (let i=0; i<circle_num_buckets+2; i++) {
    circle_buckets[i]=[];
    for (let j=0; j<circle_num_buckets+2; j++) {
        circle_buckets[i][j] = [];
    }
}

function add_circle(t, r) {
    let coord_found = false;
    let tries = 0;
    const drdr = r*r*2;
    
    while (!coord_found && tries < max_tries) {
        tries ++;
        const x = Math.random() * (canvas_size-r)*2 -canvas_size + r;
        const y = Math.random() * (canvas_size-r)*2 -canvas_size + r;
        let possible = true;
        
        const xb = Math.max(0,((.5*x/canvas_size+.5)*circle_num_buckets)|0);
        const yb = Math.max(0,((.5*y/canvas_size+.5)*circle_num_buckets)|0);

        for (let xbi = Math.max(0,xb-1); xbi<xb+2 && possible; xbi++) {
            for (let ybi = Math.max(0,yb-1); ybi<yb+2 && possible; ybi++) {
                const circles = circle_buckets[xbi][ybi];
                for (let i=0; i<circles.length && possible; i++) {
                    const dx = circles[i][0] - x;
                    const dy = circles[i][1] - y;
                
                    if ( dx*dx + dy*dy < drdr) {
                        possible = false;
                        break;
                    }
                }       
            }
        }
        if (possible) {
            coord_found = true;
            draw_circle(x,y,t, r);
            circle_buckets[xb][yb].push([x,y]);
            return true;
        }
    }
    return false;
}

function draw_circle(x,y,t,r) {
    const intensity = get_image_intensity(x/canvas_size, y/canvas_size);
    // use intensity squared because it looks better 
    if ((r-min_radius)/max_radius > .65 * intensity ** 2) {
        coords.push([x,y]);
    }
}


function get_image_intensity(x,y)
{
    var ratio_x = 1;
    var ratio_y = 1;
    if (image_width < image_height) ratio_x = image_height / image_width;
    else ratio_y = image_width / image_height;
    
    var index_x = Math.floor((x * ratio_x + 1) * 0.5 * (image_width-1));
    var index_y = Math.floor((y * ratio_y + 1) * 0.5 * (image_height-1));
    
    if (index_x < 0 || index_x >= image_width || index_y < 0 || index_y >= image_height)
        return -100;
    
    index_x = Math.max(Math.min(image_width-1,  index_x), 0);
    index_y = Math.max(Math.min(image_height-1, index_y), 0);
    
    const brightness_xy = brightness[index_y][index_x] / 255;

    return brightness_xy;

    //var v = Math.cos(x*10) + Math.sin(y*10);
    //v = v / 4 + 0.5;
    //return v;
}

//
// https://github.com/mapbox/delaunator
//
// ISC License
//
// Copyright (c) 2017, Mapbox
//
// Permission to use, copy, modify, and/or distribute this software for any purpose
// with or without fee is hereby granted, provided that the above copyright notice
// and this permission notice appear in all copies.
//
// THE SOFTWARE IS PROVIDED "AS IS" AND THE AUTHOR DISCLAIMS ALL WARRANTIES WITH
// REGARD TO THIS SOFTWARE INCLUDING ALL IMPLIED WARRANTIES OF MERCHANTABILITY AND
// FITNESS. IN NO EVENT SHALL THE AUTHOR BE LIABLE FOR ANY SPECIAL, DIRECT,
// INDIRECT, OR CONSEQUENTIAL DAMAGES OR ANY DAMAGES WHATSOEVER RESULTING FROM LOSS
// OF USE, DATA OR PROFITS, WHETHER IN AN ACTION OF CONTRACT, NEGLIGENCE OR OTHER
// TORTIOUS ACTION, ARISING OUT OF OR IN CONNECTION WITH THE USE OR PERFORMANCE OF
// THIS SOFTWARE.
//

const EPSILON = Math.pow(2, -52);
const EDGE_STACK = new Uint32Array(512);

class Delaunator {
    static from(points, getX = defaultGetX, getY = defaultGetY) {
        const n = points.length;
        const coords = new Float64Array(n * 2);

        for (let i = 0; i < n; i++) {
            const p = points[i];
            coords[2 * i] = getX(p);
            coords[2 * i + 1] = getY(p);
        }

        return new Delaunator(coords);
    }

    constructor(coords) {
        const n = coords.length >> 1;
        if (n > 0 && typeof coords[0] !== 'number') throw new Error('Expected coords to contain numbers.');

        this.coords = coords;

        // arrays that will store the triangulation graph
        const maxTriangles = 2 * n - 5;
        const triangles = this.triangles = new Uint32Array(maxTriangles * 3);
        const halfedges = this.halfedges = new Int32Array(maxTriangles * 3);

        // temporary arrays for tracking the edges of the advancing convex hull
        this._hashSize = Math.ceil(Math.sqrt(n));
        const hullPrev = this.hullPrev = new Uint32Array(n); // edge to prev edge
        const hullNext = this.hullNext = new Uint32Array(n); // edge to next edge
        const hullTri = this.hullTri = new Uint32Array(n); // edge to adjacent triangle
        const hullHash = new Int32Array(this._hashSize).fill(-1); // angular edge hash

        // populate an array of point indices; calculate input data bbox
        const ids = new Uint32Array(n);
        let minX = Infinity;
        let minY = Infinity;
        let maxX = -Infinity;
        let maxY = -Infinity;

        for (let i = 0; i < n; i++) {
            const x = coords[2 * i];
            const y = coords[2 * i + 1];
            if (x < minX) minX = x;
            if (y < minY) minY = y;
            if (x > maxX) maxX = x;
            if (y > maxY) maxY = y;
            ids[i] = i;
        }
        const cx = (minX + maxX) / 2;
        const cy = (minY + maxY) / 2;

        let minDist = Infinity;
        let i0, i1, i2;

        // pick a seed point close to the center
        for (let i = 0; i < n; i++) {
            const d = dist(cx, cy, coords[2 * i], coords[2 * i + 1]);
            if (d < minDist) {
                i0 = i;
                minDist = d;
            }
        }
        const i0x = coords[2 * i0];
        const i0y = coords[2 * i0 + 1];

        minDist = Infinity;

        // find the point closest to the seed
        for (let i = 0; i < n; i++) {
            if (i === i0) continue;
            const d = dist(i0x, i0y, coords[2 * i], coords[2 * i + 1]);
            if (d < minDist && d > 0) {
                i1 = i;
                minDist = d;
            }
        }
        let i1x = coords[2 * i1];
        let i1y = coords[2 * i1 + 1];

        let minRadius = Infinity;

        // find the third point which forms the smallest circumcircle with the first two
        for (let i = 0; i < n; i++) {
            if (i === i0 || i === i1) continue;
            const r = circumradius(i0x, i0y, i1x, i1y, coords[2 * i], coords[2 * i + 1]);
            if (r < minRadius) {
                i2 = i;
                minRadius = r;
            }
        }
        let i2x = coords[2 * i2];
        let i2y = coords[2 * i2 + 1];

        if (minRadius === Infinity) {
            throw new Error('No Delaunay triangulation exists for this input.');
        }

        // swap the order of the seed points for counter-clockwise orientation
        if (orient(i0x, i0y, i1x, i1y, i2x, i2y)) {
            const i = i1;
            const x = i1x;
            const y = i1y;
            i1 = i2;
            i1x = i2x;
            i1y = i2y;
            i2 = i;
            i2x = x;
            i2y = y;
        }

        const center = circumcenter(i0x, i0y, i1x, i1y, i2x, i2y);
        this._cx = center.x;
        this._cy = center.y;

        const dists = new Float64Array(n);
        for (let i = 0; i < n; i++) {
            dists[i] = dist(coords[2 * i], coords[2 * i + 1], center.x, center.y);
        }

        // sort the points by distance from the seed triangle circumcenter
        quicksort(ids, dists, 0, n - 1);

        // set up the seed triangle as the starting hull
        this.hullStart = i0;
        let hullSize = 3;

        hullNext[i0] = hullPrev[i2] = i1;
        hullNext[i1] = hullPrev[i0] = i2;
        hullNext[i2] = hullPrev[i1] = i0;

        hullTri[i0] = 0;
        hullTri[i1] = 1;
        hullTri[i2] = 2;

        hullHash[this._hashKey(i0x, i0y)] = i0;
        hullHash[this._hashKey(i1x, i1y)] = i1;
        hullHash[this._hashKey(i2x, i2y)] = i2;

        this.trianglesLen = 0;
        this._addTriangle(i0, i1, i2, -1, -1, -1);

        for (let k = 0, xp, yp; k < ids.length; k++) {
            const i = ids[k];
            const x = coords[2 * i];
            const y = coords[2 * i + 1];

            // skip near-duplicate points
            if (k > 0 && Math.abs(x - xp) <= EPSILON && Math.abs(y - yp) <= EPSILON) continue;
            xp = x;
            yp = y;

            // skip seed triangle points
            if (i === i0 || i === i1 || i === i2) continue;

            // find a visible edge on the convex hull using edge hash
            let start = 0;
            for (let j = 0, key = this._hashKey(x, y); j < this._hashSize; j++) {
                start = hullHash[(key + j) % this._hashSize];
                if (start !== -1 && start !== hullNext[start]) break;
            }

            start = hullPrev[start];
            let e = start, q;
            while (q = hullNext[e], !orient(x, y, coords[2 * e], coords[2 * e + 1], coords[2 * q], coords[2 * q + 1])) {
                e = q;
                if (e === start) {
                    e = -1;
                    break;
                }
            }
            if (e === -1) continue; // likely a near-duplicate point; skip it

            // add the first triangle from the point
            let t = this._addTriangle(e, i, hullNext[e], -1, -1, hullTri[e]);

            // recursively flip triangles from the point until they satisfy the Delaunay condition
            hullTri[i] = this._legalize(t + 2);
            hullTri[e] = t; // keep track of boundary triangles on the hull
            hullSize++;

            // walk forward through the hull, adding more triangles and flipping recursively
            let n = hullNext[e];
            while (q = hullNext[n], orient(x, y, coords[2 * n], coords[2 * n + 1], coords[2 * q], coords[2 * q + 1])) {
                t = this._addTriangle(n, i, q, hullTri[i], -1, hullTri[n]);
                hullTri[i] = this._legalize(t + 2);
                hullNext[n] = n; // mark as removed
                hullSize--;
                n = q;
            }

            // walk backward from the other side, adding more triangles and flipping
            if (e === start) {
                while (q = hullPrev[e], orient(x, y, coords[2 * q], coords[2 * q + 1], coords[2 * e], coords[2 * e + 1])) {
                    t = this._addTriangle(q, i, e, -1, hullTri[e], hullTri[q]);
                    this._legalize(t + 2);
                    hullTri[q] = t;
                    hullNext[e] = e; // mark as removed
                    hullSize--;
                    e = q;
                }
            }

            // update the hull indices
            this.hullStart = hullPrev[i] = e;
            hullNext[e] = hullPrev[n] = i;
            hullNext[i] = n;

            // save the two new edges in the hash table
            hullHash[this._hashKey(x, y)] = i;
            hullHash[this._hashKey(coords[2 * e], coords[2 * e + 1])] = e;
        }

        this.hull = new Uint32Array(hullSize);
        for (let i = 0, e = this.hullStart; i < hullSize; i++) {
            this.hull[i] = e;
            e = hullNext[e];
        }
        this.hullPrev = this.hullNext = this.hullTri = null; // get rid of temporary arrays

        // trim typed triangle mesh arrays
        this.triangles = triangles.subarray(0, this.trianglesLen);
        this.halfedges = halfedges.subarray(0, this.trianglesLen);
    }

    _hashKey(x, y) {
        return Math.floor(pseudoAngle(x - this._cx, y - this._cy) * this._hashSize) % this._hashSize;
    }

    _legalize(a) {
        const {triangles, coords, halfedges} = this;

        let i = 0;
        let ar = 0;

        // recursion eliminated with a fixed-size stack
        while (true) {
            const b = halfedges[a];

            /* if the pair of triangles doesn't satisfy the Delaunay condition
             * (p1 is inside the circumcircle of [p0, pl, pr]), flip them,
             * then do the same check/flip recursively for the new pair of triangles
             *
             *           pl                    pl
             *          /||\                  /  \
             *       al/ || \bl            al/    \a
             *        /  ||  \              /      \
             *       /  a||b  \    flip    /___ar___\
             *     p0\   ||   /p1   =>   p0\---bl---/p1
             *        \  ||  /              \      /
             *       ar\ || /br             b\    /br
             *          \||/                  \  /
             *           pr                    pr
             */
            const a0 = a - a % 3;
            ar = a0 + (a + 2) % 3;

            if (b === -1) { // convex hull edge
                if (i === 0) break;
                a = EDGE_STACK[--i];
                continue;
            }

            const b0 = b - b % 3;
            const al = a0 + (a + 1) % 3;
            const bl = b0 + (b + 2) % 3;

            const p0 = triangles[ar];
            const pr = triangles[a];
            const pl = triangles[al];
            const p1 = triangles[bl];

            const illegal = inCircle(
                coords[2 * p0], coords[2 * p0 + 1],
                coords[2 * pr], coords[2 * pr + 1],
                coords[2 * pl], coords[2 * pl + 1],
                coords[2 * p1], coords[2 * p1 + 1]);

            if (illegal) {
                triangles[a] = p1;
                triangles[b] = p0;

                const hbl = halfedges[bl];

                // edge swapped on the other side of the hull (rare); fix the halfedge reference
                if (hbl === -1) {
                    let e = this.hullStart;
                    do {
                        if (this.hullTri[e] === bl) {
                            this.hullTri[e] = a;
                            break;
                        }
                        e = this.hullNext[e];
                    } while (e !== this.hullStart);
                }
                this._link(a, hbl);
                this._link(b, halfedges[ar]);
                this._link(ar, bl);

                const br = b0 + (b + 1) % 3;

                // don't worry about hitting the cap: it can only happen on extremely degenerate input
                if (i < EDGE_STACK.length) {
                    EDGE_STACK[i++] = br;
                }
            } else {
                if (i === 0) break;
                a = EDGE_STACK[--i];
            }
        }

        return ar;
    }

    _link(a, b) {
        this.halfedges[a] = b;
        if (b !== -1) this.halfedges[b] = a;
    }

    // add a new triangle given vertex indices and adjacent half-edge ids
    _addTriangle(i0, i1, i2, a, b, c) {
        const t = this.trianglesLen;

        this.triangles[t] = i0;
        this.triangles[t + 1] = i1;
        this.triangles[t + 2] = i2;

        this._link(t, a);
        this._link(t + 1, b);
        this._link(t + 2, c);

        this.trianglesLen += 3;

        return t;
    }
}

// monotonically increases with real angle, but doesn't need expensive trigonometry
function pseudoAngle(dx, dy) {
    const p = dx / (Math.abs(dx) + Math.abs(dy));
    return (dy > 0 ? 3 - p : 1 + p) / 4; // [0..1]
}

function dist(ax, ay, bx, by) {
    const dx = ax - bx;
    const dy = ay - by;
    return dx * dx + dy * dy;
}

function orient(px, py, qx, qy, rx, ry) {
    return (qy - py) * (rx - qx) - (qx - px) * (ry - qy) < 0;
}

function inCircle(ax, ay, bx, by, cx, cy, px, py) {
    const dx = ax - px;
    const dy = ay - py;
    const ex = bx - px;
    const ey = by - py;
    const fx = cx - px;
    const fy = cy - py;

    const ap = dx * dx + dy * dy;
    const bp = ex * ex + ey * ey;
    const cp = fx * fx + fy * fy;

    return dx * (ey * cp - bp * fy) -
           dy * (ex * cp - bp * fx) +
           ap * (ex * fy - ey * fx) < 0;
}

function circumradius(ax, ay, bx, by, cx, cy) {
    const dx = bx - ax;
    const dy = by - ay;
    const ex = cx - ax;
    const ey = cy - ay;

    const bl = dx * dx + dy * dy;
    const cl = ex * ex + ey * ey;
    const d = 0.5 / (dx * ey - dy * ex);

    const x = (ey * bl - dy * cl) * d;
    const y = (dx * cl - ex * bl) * d;

    return x * x + y * y;
}

function circumcenter(ax, ay, bx, by, cx, cy) {
    const dx = bx - ax;
    const dy = by - ay;
    const ex = cx - ax;
    const ey = cy - ay;

    const bl = dx * dx + dy * dy;
    const cl = ex * ex + ey * ey;
    const d = 0.5 / (dx * ey - dy * ex);

    const x = ax + (ey * bl - dy * cl) * d;
    const y = ay + (dx * cl - ex * bl) * d;

    return {x, y};
}

function quicksort(ids, dists, left, right) {
    if (right - left <= 20) {
        for (let i = left + 1; i <= right; i++) {
            const temp = ids[i];
            const tempDist = dists[temp];
            let j = i - 1;
            while (j >= left && dists[ids[j]] > tempDist) ids[j + 1] = ids[j--];
            ids[j + 1] = temp;
        }
    } else {
        const median = (left + right) >> 1;
        let i = left + 1;
        let j = right;
        swap(ids, median, i);
        if (dists[ids[left]] > dists[ids[right]]) swap(ids, left, right);
        if (dists[ids[i]] > dists[ids[right]]) swap(ids, i, right);
        if (dists[ids[left]] > dists[ids[i]]) swap(ids, left, i);

        const temp = ids[i];
        const tempDist = dists[temp];
        while (true) {
            do i++; while (dists[ids[i]] < tempDist);
            do j--; while (dists[ids[j]] > tempDist);
            if (j < i) break;
            swap(ids, i, j);
        }
        ids[left + 1] = ids[j];
        ids[j] = temp;

        if (right - i + 1 >= j - left) {
            quicksort(ids, dists, i, right);
            quicksort(ids, dists, left, j - 1);
        } else {
            quicksort(ids, dists, left, j - 1);
            quicksort(ids, dists, i, right);
        }
    }
}

function swap(arr, i, j) {
    const tmp = arr[i];
    arr[i] = arr[j];
    arr[j] = tmp;
}

function defaultGetX(p) {
    return p[0];
}
function defaultGetY(p) {
    return p[1];
}

//////////////////////////
// Image brightness
//////////////////////////

const image_width=256;
const image_height=256;
var brightness = loadImage();
function loadImage() {
list = [];
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,255,255,255,255,255,253,255,248,254,252,252,254,254,254,254,254,254,255,254,253,253,252,255,249,254,254,251,254,254,254,254,254,254,254,254,254,253,254,254,254,253,253,251,253,254,254,253,254,253,254,254,254,253,249,249,253,253,253,254,255,254,253,254,253,249,252,250,253,254,254,253,254,250,250,251,250,253,252,254,249,252,254,144,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,254,254,254,254,255,255,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,254,255,255,255,255,255,255,255,255,253,254,254,254,254,254,251,255,251,255,245,253,252,253,253,255,253,253,255,254,254,254,254,254,254,254,254,255,253,252,249,254,248,160,253,253,254,254,252,254,254,254,254,254,252,254,254,253,251,255,249,255,254,254,254,254,253,249,251,252,252,254,250,254,253,254,253,249,254,254,252,254,145,74,255,252,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,254,254,254,254,255,255,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,250,255,255,247,253,255,254,251,255,254,253,251,254,250,254,250,255,252,253,253,254,254,254,254,254,254,254,255,254,254,252,254,253,246,165,117,251,249,251,254,254,252,251,254,254,252,254,252,255,254,255,254,254,254,253,254,254,246,254,254,254,255,147,90,72,100,254,254,251,254,252,254,249,81,23,172,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,255,255,248,255,255,255,254,247,254,251,254,255,255,255,254,254,249,254,251,254,252,252,251,254,254,254,255,255,255,254,254,254,253,253,171,52,253,251,253,251,250,254,252,253,251,251,251,251,254,250,252,249,252,254,254,254,253,249,254,254,250,125,60,2,8,40,113,166,254,254,251,254,139,39,9,137,250,253,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,254,250,254,254,254,254,253,250,251,247,254,99,72,163,253,254,254,252,253,252,253,253,255,255,254,254,254,254,253,253,253,250,162,34,98,252,247,252,252,250,252,247,253,253,253,253,253,250,253,253,253,123,120,152,253,253,254,162,107,46,6,4,25,95,142,153,144,161,254,142,66,2,3,94,254,254,255,252,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,252,255,250,254,252,252,247,253,254,137,33,0,48,116,254,254,247,253,248,249,149,148,255,255,254,254,254,254,253,253,246,171,20,39,251,252,252,252,252,247,253,251,254,248,251,254,253,254,160,82,23,28,89,147,161,133,79,32,1,5,17,48,123,156,145,152,149,136,74,9,0,0,61,251,252,253,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,253,254,253,252,255,246,254,254,253,152,72,6,2,13,74,134,252,254,253,246,253,126,63,246,254,254,254,254,253,253,253,253,162,22,14,120,253,248,253,251,253,254,250,176,150,148,137,110,84,51,13,47,72,124,147,149,135,89,29,8,10,44,95,144,145,150,146,147,141,83,1,3,3,18,146,252,254,254,252,255,255,255,255,255,255,255,255,255,254,254,254,254,255,255,255,255,255,255,255,254,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,253,252,254,255,255,108,73,62,44,28,12,23,0,26,107,143,253,249,253,253,62,7,102,252,255,254,254,254,253,253,253,253,36,6,42,249,253,253,252,253,162,97,60,32,40,37,62,99,112,110,129,142,160,165,148,117,60,17,12,38,95,135,147,153,149,143,153,152,115,14,9,8,0,87,162,254,253,254,253,255,255,255,255,255,255,255,255,255,254,255,254,255,255,255,255,255,255,254,254,254,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,254,252,255,255,255,255,252,255,252,250,254,251,253,253,253,251,253,247,167,58,22,63,65,51,44,34,27,1,10,24,96,148,180,165,99,13,2,30,252,252,254,254,255,252,254,252,253,57,2,0,92,254,253,254,254,72,17,4,2,1,2,2,2,27,59,89,101,93,84,65,30,7,12,53,97,136,155,149,148,147,144,157,168,125,27,17,45,1,33,152,138,254,253,254,247,255,255,254,255,253,255,253,255,255,254,251,254,254,253,252,254,254,254,254,251,254,253,253,253,253,254,247,254,252,255,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,255,255,254,252,251,247,255,251,254,254,254,254,253,249,250,253,162,66,10,61,122,72,35,18,4,16,2,27,49,9,70,112,73,30,4,4,5,79,254,252,250,254,254,255,248,253,80,0,0,8,107,255,252,253,66,3,0,1,6,12,20,24,13,4,7,8,10,13,10,6,27,70,124,144,154,149,151,137,144,153,160,128,74,17,38,97,48,6,101,138,152,253,254,248,255,254,255,253,253,251,255,255,251,254,252,254,254,252,254,254,246,254,254,149,254,254,253,248,251,251,254,254,251,254,255,254,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,254,248,254,254,254,253,254,249,254,254,254,253,253,138,63,14,38,115,134,52,4,8,3,2,4,16,74,73,1,43,60,8,2,8,3,8,109,168,123,254,254,249,249,254,95,6,3,4,5,90,254,254,110,1,3,17,57,83,85,65,31,23,40,62,66,67,68,69,73,95,129,147,143,145,137,92,95,141,137,74,23,9,86,132,132,23,21,155,106,254,253,248,254,255,252,255,246,255,255,249,255,253,254,253,253,253,250,253,252,141,39,35,122,254,250,254,254,254,254,249,253,254,254,250,251,253,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,251,248,254,249,254,253,251,254,254,250,128,64,21,12,52,113,146,116,41,3,32,40,48,16,3,69,98,66,4,44,41,7,13,23,1,45,151,112,52,164,180,174,157,111,6,0,0,2,7,104,254,162,7,9,13,77,107,94,45,11,26,75,98,93,100,100,97,99,99,98,100,102,116,124,80,29,99,101,33,9,20,104,149,154,84,11,85,165,94,248,254,254,251,251,255,252,255,251,255,253,253,255,255,253,249,253,252,139,30,7,77,158,255,246,255,250,255,245,255,254,249,254,249,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,253,253,251,253,246,252,253,144,69,7,8,29,77,130,152,130,68,3,8,50,46,70,79,12,24,102,96,50,6,59,37,9,36,39,8,62,155,75,54,150,140,153,128,17,7,1,4,9,1,140,252,74,3,19,80,104,87,36,15,42,83,104,92,108,98,93,101,106,97,90,94,97,102,96,29,53,111,43,12,13,82,153,148,119,20,4,152,124,138,254,254,249,254,255,249,255,254,254,254,255,255,247,255,250,253,140,39,4,70,175,250,254,253,254,254,254,249,178,146,250,254,254,254,251,254,248,251,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,249,253,251,253,115,33,9,39,81,110,129,160,149,71,15,5,40,68,41,51,100,83,10,54,108,96,33,9,78,22,14,70,27,6,81,159,41,62,156,145,126,23,11,2,3,39,3,41,194,152,7,10,71,103,89,31,7,44,87,97,97,97,57,40,27,37,69,98,106,104,109,99,54,14,93,75,7,12,59,127,144,132,52,7,64,185,80,169,253,254,252,105,255,255,255,253,255,253,255,255,255,255,154,62,7,23,134,253,246,254,254,251,254,164,109,83,90,128,130,130,163,254,249,254,254,253,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,253,253,253,167,75,32,34,69,109,134,138,161,160,123,33,9,12,70,71,31,26,93,97,60,10,76,101,82,18,44,81,12,29,87,14,9,103,129,34,122,167,120,32,5,9,26,81,43,8,95,181,57,5,61,104,85,23,11,58,104,96,94,102,90,81,86,74,44,23,31,54,70,59,30,9,59,108,35,14,49,95,104,144,85,7,5,112,157,75,251,254,252,48,108,249,255,252,254,254,255,252,255,254,85,11,0,69,190,193,107,58,53,58,48,29,13,40,77,102,78,28,22,124,249,254,253,254,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,254,254,85,25,61,107,117,112,127,153,160,124,77,10,10,27,94,65,13,15,69,99,96,32,16,97,102,54,10,83,53,9,55,83,5,4,106,99,43,133,93,29,7,7,38,98,82,6,29,121,97,4,45,104,84,32,10,65,99,93,97,100,90,101,87,67,65,81,72,38,17,16,12,24,63,109,54,16,24,90,96,109,97,17,5,55,157,114,127,252,251,69,39,254,255,255,255,255,251,255,255,120,35,5,0,115,207,145,34,1,18,16,14,18,41,76,78,58,25,2,2,90,252,254,254,252,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,255,255,254,254,251,254,255,255,254,253,253,249,251,253,253,250,252,252,249,252,249,58,55,128,134,109,86,110,153,128,62,14,3,5,16,86,82,7,15,66,90,93,76,7,42,112,79,12,43,100,13,10,83,58,8,28,98,69,54,87,9,2,6,44,93,94,59,7,77,101,26,19,96,97,45,9,67,108,102,98,96,96,97,50,6,1,7,38,72,98,84,81,82,87,100,90,17,7,80,100,98,96,35,8,68,106,138,108,252,254,128,2,148,250,252,252,250,253,171,112,59,6,9,13,127,198,93,10,58,93,105,110,126,138,128,69,40,39,13,1,119,254,254,251,254,251,253,252,253,253,252,253,254,251,254,254,251,252,252,251,253,253,253,250,254,254,254,254,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,255,255,254,254,254,252,254,252,254,253,253,253,253,253,249,143,249,252,252,253,94,112,147,98,63,76,108,126,92,21,6,1,17,12,50,101,34,7,67,94,100,92,41,7,79,96,18,22,102,75,12,36,101,27,5,35,104,49,59,42,4,8,16,82,107,85,19,44,101,60,8,74,104,63,8,49,103,101,99,93,105,98,45,11,7,32,40,51,47,87,104,96,97,101,92,42,13,55,101,101,95,56,7,65,118,137,126,155,254,167,24,75,252,249,249,252,253,72,24,13,3,11,18,119,160,49,27,100,142,150,161,158,152,104,54,52,75,9,0,131,253,254,254,254,254,254,246,252,254,248,255,249,255,255,253,253,252,246,253,253,252,254,254,254,254,254,254,254,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,254,254,255,255,255,253,254,250,253,253,251,253,106,101,247,253,247,146,143,122,50,7,30,42,45,32,8,10,1,28,39,13,100,83,11,35,100,94,98,72,6,36,100,27,17,87,103,45,10,72,66,7,10,70,102,32,62,64,13,8,44,107,91,62,9,89,87,14,31,104,83,19,37,103,103,95,99,99,96,55,10,25,60,44,79,75,41,66,93,97,94,98,83,13,25,97,100,100,81,13,50,109,136,155,143,181,254,85,13,255,251,253,253,149,25,0,9,6,7,31,99,131,36,56,121,162,158,145,111,78,48,35,92,102,2,29,158,252,252,254,249,255,253,252,253,253,250,253,246,253,247,252,254,253,253,253,254,252,251,255,252,254,254,254,254,254,254,255,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,254,254,255,255,251,254,250,253,250,251,253,104,5,155,253,253,253,127,66,12,1,9,6,6,15,33,34,8,21,70,19,34,109,46,10,72,104,92,88,37,5,73,49,14,86,106,79,12,35,87,36,39,58,100,80,27,71,83,59,13,25,100,92,31,36,104,54,14,87,100,38,13,92,98,96,94,92,100,56,8,36,70,24,70,95,26,16,44,74,94,93,96,41,13,71,107,90,91,41,15,90,103,120,130,155,180,143,14,148,254,254,254,135,10,3,6,2,3,45,100,90,22,69,138,163,133,72,20,24,48,92,130,83,3,74,172,253,252,254,250,254,254,252,253,252,252,253,253,249,253,253,251,252,249,252,254,161,254,255,251,254,253,254,254,254,255,255,255,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,249,255,254,254,254,253,251,253,84,6,29,253,254,251,76,6,0,2,9,5,42,47,85,79,58,2,47,77,4,72,90,20,27,95,97,100,58,5,41,80,10,67,103,90,44,7,77,91,88,86,100,97,45,23,98,94,86,63,22,79,80,16,82,88,15,40,100,77,14,64,108,87,93,105,104,64,10,34,74,25,53,102,61,11,16,26,69,107,98,88,8,39,104,93,99,69,8,78,101,100,74,37,100,164,57,63,253,252,254,111,2,8,19,8,7,66,98,69,18,86,151,151,72,15,29,73,123,138,112,49,22,105,249,254,244,173,145,146,253,252,253,253,126,90,76,109,151,248,253,251,251,251,154,78,138,253,254,254,253,254,254,254,255,255,255,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,248,253,252,250,253,63,21,3,68,252,254,95,0,4,7,3,13,70,56,75,102,85,18,12,75,63,9,86,72,6,73,102,94,93,18,6,78,44,35,101,88,54,7,58,99,97,95,97,88,61,10,40,102,95,97,99,64,62,32,39,107,63,10,84,103,37,18,98,97,103,101,82,32,8,60,81,27,27,97,87,13,4,18,68,96,103,94,36,17,79,102,100,94,21,30,101,99,80,25,3,75,109,40,248,254,254,112,9,19,50,40,14,60,85,38,21,86,126,119,53,34,84,134,151,126,79,34,63,133,253,253,171,122,91,110,126,131,103,56,24,53,92,154,250,251,253,252,151,83,38,51,136,254,251,254,249,254,253,254,254,255,255,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,255,255,255,255,253,252,254,254,253,251,42,46,20,1,97,254,129,0,10,15,5,27,68,45,82,99,89,46,12,17,89,44,5,78,41,19,102,97,96,66,6,42,71,13,71,103,73,4,35,101,101,99,98,98,53,12,8,83,107,100,101,91,84,53,23,78,95,35,24,100,87,12,54,104,99,97,54,6,23,76,85,34,18,96,94,49,7,16,61,98,95,97,61,8,55,100,101,104,55,8,82,100,107,48,6,10,64,61,107,253,248,115,6,4,81,45,5,49,78,15,46,82,100,120,131,128,142,153,142,107,80,90,130,156,171,160,106,36,27,32,32,17,19,35,75,140,207,208,186,155,99,51,16,14,55,109,166,252,254,254,251,254,254,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,255,255,255,255,255,253,254,250,252,45,51,75,2,11,125,162,35,9,34,21,16,78,45,52,98,88,58,13,2,53,101,35,11,70,12,56,104,94,98,29,5,71,48,21,103,86,19,17,94,94,96,97,94,35,6,8,75,102,79,59,63,94,93,45,42,94,84,12,61,103,56,23,94,101,83,30,9,46,88,80,19,18,82,107,73,5,11,50,105,93,102,69,6,40,96,104,102,59,9,64,108,100,58,11,37,40,50,62,254,254,122,6,19,89,43,5,46,67,15,54,96,97,105,139,141,110,102,104,105,128,146,141,113,80,48,20,9,10,7,7,37,59,118,165,213,199,132,80,29,10,1,37,122,155,163,150,253,253,254,254,251,253,253,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,250,252,255,255,253,253,254,252,254,254,75,42,91,1,4,26,140,104,0,50,41,4,71,85,18,73,101,79,22,5,17,83,94,27,12,53,7,84,104,100,78,9,35,84,14,64,106,53,6,71,109,95,93,97,43,8,8,80,104,71,17,5,14,25,64,60,68,106,48,11,85,104,37,33,101,50,11,18,71,93,69,14,14,69,104,84,21,5,51,96,97,101,74,9,26,93,99,101,55,28,70,106,91,38,11,39,67,47,47,159,248,115,1,28,90,42,5,38,53,10,61,101,98,95,58,34,34,61,94,128,143,113,60,22,17,18,18,19,24,38,71,107,134,146,161,154,111,47,7,3,2,59,151,177,132,85,108,254,253,253,254,251,251,253,254,254,254,249,255,254,254,254,253,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,247,254,255,254,255,253,254,254,251,254,254,133,28,79,14,0,0,44,131,38,37,59,4,43,101,60,9,93,94,51,3,7,37,100,85,19,28,34,11,97,100,94,42,11,75,53,13,93,86,12,30,102,96,95,100,67,5,6,76,103,61,10,2,3,4,7,24,63,101,87,33,28,100,94,28,33,37,10,41,78,96,64,10,11,53,105,97,51,10,44,89,99,108,70,7,26,81,98,93,72,60,87,94,56,9,19,54,86,69,56,86,156,91,1,28,91,28,2,27,25,10,51,107,105,59,18,16,57,108,139,154,112,48,16,34,76,105,122,130,126,129,141,148,149,149,148,112,36,10,8,3,32,139,165,99,50,59,133,250,253,254,254,253,253,253,253,250,250,254,254,255,252,253,251,252,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,249,255,255,254,254,253,254,254,253,253,51,52,18,13,10,4,54,94,25,66,16,15,96,98,31,29,104,86,23,3,15,76,103,72,6,51,22,29,96,98,80,6,43,83,13,51,105,56,10,70,112,91,98,84,24,3,73,104,54,7,8,7,41,47,29,19,81,97,79,9,55,103,82,35,15,17,64,96,106,54,11,7,46,101,96,61,8,34,95,94,102,76,8,27,87,92,94,101,83,84,79,42,10,47,80,76,70,77,91,77,42,12,39,82,36,2,2,4,13,54,108,88,29,17,39,89,142,162,125,61,18,49,111,137,152,160,156,149,145,147,144,145,157,126,51,14,17,4,11,83,164,113,33,45,138,249,253,250,252,253,254,254,254,254,250,254,254,255,255,254,254,254,254,254,249,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,255,254,253,253,250,254,254,252,124,15,30,0,53,17,1,72,76,44,37,2,79,101,74,10,62,98,80,7,11,27,97,95,62,6,71,11,40,103,95,37,14,85,43,11,95,93,25,22,101,99,95,100,45,3,39,108,60,5,2,18,86,89,47,22,46,106,101,39,10,90,99,79,25,9,78,98,100,44,6,6,52,96,102,73,9,42,93,100,99,73,9,20,99,104,106,98,59,47,91,49,13,59,99,80,27,14,32,30,16,7,60,90,27,4,6,8,28,70,107,67,18,21,60,92,121,138,83,19,29,91,139,161,156,146,119,115,130,142,148,160,144,95,27,8,5,8,24,111,154,73,28,102,253,254,253,253,253,252,254,254,252,254,254,253,254,251,252,255,254,254,251,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,250,254,254,254,252,252,253,252,251,253,43,31,1,53,66,2,14,89,77,45,7,49,103,91,54,6,82,97,59,4,17,40,107,84,32,39,82,8,46,108,65,4,64,78,10,55,105,69,8,58,110,86,100,64,4,38,112,70,2,7,15,89,90,21,14,65,90,94,66,11,43,104,94,77,8,45,105,96,44,10,27,61,99,102,63,8,46,84,95,105,72,8,25,93,107,96,57,19,34,87,69,6,45,102,102,40,7,7,7,8,40,81,63,10,9,23,55,73,96,93,45,16,43,90,106,110,83,28,9,64,128,154,152,122,74,54,90,118,154,165,143,99,45,9,11,15,18,62,135,118,47,41,164,253,252,170,140,145,255,247,253,253,254,253,253,254,254,254,254,253,252,255,255,255,254,250,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,254,253,253,253,247,250,253,113,41,11,24,81,43,2,65,97,75,40,10,89,93,93,21,25,98,98,25,19,21,53,110,67,23,88,56,3,65,93,12,27,94,29,24,96,99,33,14,94,101,99,75,4,26,94,70,7,8,1,58,102,28,20,82,94,103,81,6,5,79,103,93,52,13,91,97,77,25,63,90,98,94,50,8,53,89,105,97,56,8,22,82,108,73,31,21,57,99,92,24,23,102,104,47,5,6,20,57,87,70,32,13,38,55,84,94,100,65,28,41,79,103,91,67,24,8,42,109,145,160,124,65,46,86,136,155,145,105,53,23,8,11,26,45,83,132,146,90,35,89,198,202,137,56,33,68,134,253,253,253,253,177,160,157,170,252,254,254,251,255,255,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,250,253,252,252,252,252,253,253,253,51,50,3,64,84,2,26,95,94,76,24,31,106,94,63,6,65,103,69,6,44,24,65,95,56,59,87,13,6,84,59,2,79,70,6,67,104,81,9,50,94,92,90,21,11,94,79,7,5,1,28,94,58,11,87,100,100,69,13,8,28,88,102,79,16,43,103,105,45,68,105,105,83,36,7,58,106,105,76,30,6,24,78,101,72,43,51,87,104,97,42,6,71,109,53,7,3,50,88,82,31,10,28,71,87,111,97,94,69,51,74,88,62,38,14,8,38,93,138,147,158,114,76,96,138,153,131,66,24,17,40,58,86,118,126,141,151,107,56,52,122,172,124,47,24,63,104,145,167,157,162,160,172,167,127,80,58,61,72,128,174,254,255,253,246,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,253,254,161,160,252,154,59,86,7,28,89,49,7,72,98,71,69,9,62,112,85,21,27,99,90,27,9,60,23,76,92,59,82,29,4,40,90,12,34,95,33,20,99,94,51,8,86,104,97,32,4,81,82,11,10,7,9,55,98,29,72,103,98,71,8,18,10,38,97,96,42,6,90,103,81,83,102,108,75,19,8,73,102,92,64,10,9,23,64,93,88,80,86,94,98,106,65,3,25,101,61,7,9,65,102,52,13,25,70,89,99,95,98,111,90,72,65,37,18,21,25,54,101,135,145,141,160,135,112,132,151,151,108,16,15,74,117,133,146,146,144,154,146,84,50,89,126,96,55,49,84,125,145,162,158,164,165,159,153,148,150,148,148,141,121,109,97,152,254,252,254,253,253,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,249,255,255,254,254,252,252,250,100,118,168,100,30,93,60,0,64,94,3,34,103,78,60,59,6,90,98,50,7,74,100,42,8,55,55,61,87,74,56,18,3,19,88,66,1,81,85,5,54,103,91,23,30,102,98,58,7,61,86,20,18,51,3,16,77,81,58,103,94,48,7,21,61,4,47,104,75,9,41,109,93,94,103,100,61,8,27,77,98,79,52,3,3,21,34,83,75,75,95,102,102,100,64,6,4,59,55,6,21,82,104,49,10,56,98,96,99,103,100,83,55,31,15,17,31,61,84,102,129,149,148,153,160,124,95,124,150,150,86,11,39,125,146,149,151,159,159,149,123,65,65,115,136,104,100,127,144,154,141,123,104,89,86,97,110,114,116,134,152,159,152,146,152,166,187,253,252,253,253,246,251,255,255,255,250,254,254,254,254,254,254,255,254,254,253,253,253,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,248,254,255,254,255,254,254,252,248,252,88,67,161,81,1,82,94,1,30,94,56,1,71,100,54,55,56,11,97,81,20,53,103,56,2,54,84,88,83,41,27,6,3,7,69,94,17,27,99,50,6,81,102,74,6,65,108,75,6,38,95,73,50,53,41,5,36,101,76,101,75,22,5,16,86,73,10,53,106,33,13,94,95,93,101,89,41,10,42,98,91,59,65,21,6,16,12,41,89,55,79,100,104,91,44,7,1,25,43,8,26,88,101,45,13,61,102,96,94,100,63,26,7,13,27,50,79,98,100,101,113,144,166,164,134,86,65,125,162,125,46,12,60,136,145,152,157,151,127,79,38,30,63,132,150,135,124,116,101,70,43,33,25,22,24,26,24,23,24,27,37,51,98,142,146,152,164,200,253,253,254,253,253,252,248,255,248,255,254,251,253,254,254,254,255,255,254,253,253,253,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,253,255,255,252,151,10,124,114,7,47,111,46,0,74,92,15,26,101,76,26,76,32,28,104,46,29,96,70,5,49,106,99,56,12,10,2,8,5,40,101,74,2,65,99,19,26,99,97,45,10,94,92,28,12,92,86,85,91,71,26,3,84,103,89,48,4,5,11,81,99,61,5,65,87,7,62,105,100,92,52,22,5,60,103,76,29,66,58,3,6,3,26,72,73,59,95,112,65,28,2,5,13,15,5,26,86,99,44,8,68,106,95,107,82,32,9,29,66,93,100,104,102,93,82,76,65,81,92,69,57,74,136,144,72,17,33,91,150,156,158,132,89,31,13,35,71,108,143,150,126,80,53,42,39,48,69,87,108,124,129,128,123,119,118,114,122,94,45,86,153,140,151,191,252,254,253,254,254,253,254,254,255,255,247,255,254,254,254,254,255,255,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,255,251,255,255,254,254,255,248,63,38,132,34,9,99,67,0,51,97,56,1,74,95,35,32,96,9,48,98,35,74,98,25,17,104,78,13,7,5,2,35,33,18,84,97,41,15,91,72,7,59,102,83,14,45,102,60,6,63,109,89,93,91,66,3,49,107,80,27,4,5,11,71,90,100,49,6,89,52,46,104,96,58,16,5,32,90,105,59,5,62,83,6,4,9,18,72,84,70,99,80,37,12,22,4,1,4,11,15,85,111,50,15,79,106,103,99,57,15,19,72,97,99,75,63,63,64,65,73,60,45,39,45,68,104,132,96,38,21,68,122,154,151,119,68,24,19,58,104,133,145,156,149,130,129,121,121,137,143,151,147,148,150,150,154,161,162,158,162,157,137,49,20,107,162,148,147,165,253,254,254,251,254,254,252,254,253,255,250,255,249,254,254,254,255,255,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,253,250,254,148,0,89,107,2,62,88,6,18,81,88,23,22,98,62,12,74,77,6,66,86,63,100,60,2,80,66,11,14,34,11,40,67,15,40,104,86,20,29,102,38,7,90,100,46,5,83,96,27,21,103,89,98,94,85,22,19,97,79,11,10,38,8,54,103,89,89,15,18,85,79,76,59,24,8,17,81,101,76,20,10,66,102,28,5,4,12,73,89,96,99,50,6,26,58,10,5,3,6,15,88,99,62,21,80,106,102,74,26,9,51,92,98,93,80,73,77,77,75,81,85,92,96,93,97,100,82,56,39,52,90,103,86,61,35,21,23,81,135,160,156,141,137,129,151,165,154,152,154,140,119,89,70,66,59,58,69,85,98,102,82,68,18,22,107,167,134,64,22,12,39,45,46,64,64,86,139,250,246,254,255,255,255,255,255,255,255,255,255,255,255,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,254,253,255,254,254,248,60,19,113,57,1,89,42,9,68,74,61,0,63,95,27,26,105,43,14,85,85,88,91,15,26,77,46,61,76,25,34,84,30,8,80,105,68,2,59,99,12,30,109,78,5,36,103,68,4,56,111,87,91,98,53,3,75,77,5,26,66,4,37,96,95,93,52,2,78,91,48,22,8,3,48,92,99,50,4,28,87,103,37,6,6,7,70,98,101,77,34,4,55,84,37,5,10,7,17,81,97,79,41,93,106,87,38,7,34,79,95,100,104,88,75,58,39,38,61,81,102,108,102,89,78,47,17,21,28,45,25,9,15,10,21,51,101,132,109,73,58,53,67,79,90,104,102,82,50,23,27,47,85,103,119,117,97,71,49,38,34,28,65,118,154,118,38,17,11,32,34,46,52,68,77,118,142,253,254,254,255,253,255,249,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,255,255,255,255,255,255,254,248,250,164,17,37,90,25,15,98,31,29,75,51,30,3,92,77,10,63,94,17,35,100,91,92,57,4,67,84,73,98,57,2,80,65,3,51,107,89,33,10,95,74,4,66,101,36,13,81,97,29,11,88,95,97,94,71,7,48,82,8,23,90,31,3,86,98,95,75,2,44,101,41,7,3,11,72,106,91,23,6,52,96,94,53,4,5,3,52,102,102,83,14,11,71,98,62,4,1,1,15,83,95,83,70,99,92,45,15,18,65,89,102,102,53,26,20,23,35,49,62,61,46,42,31,31,19,6,7,15,26,40,46,48,60,63,56,59,52,38,37,31,54,97,103,70,44,20,7,15,27,56,103,129,151,154,153,153,155,156,154,152,151,145,152,150,146,123,79,66,85,116,147,183,191,253,254,255,248,255,255,252,255,255,255,255,255,255,255,255,255,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,255,255,253,254,255,251,254,253,253,115,5,49,60,3,44,88,30,69,54,27,5,31,101,57,10,91,70,1,65,103,90,93,22,17,96,87,100,72,2,52,87,2,30,93,103,66,4,42,108,42,10,89,77,5,55,106,77,4,40,100,93,94,85,30,28,79,9,21,92,66,3,54,102,97,80,4,38,105,52,5,5,25,76,102,87,28,5,60,105,87,30,2,16,5,27,95,107,59,5,22,84,105,75,1,5,0,5,77,97,98,95,83,41,10,17,45,85,99,103,71,22,22,56,78,90,86,74,48,20,9,8,20,40,54,78,92,88,97,88,84,86,86,87,92,89,80,78,73,96,99,65,27,9,16,31,59,75,93,108,109,94,70,53,40,33,43,66,83,91,93,100,104,128,140,144,149,145,144,156,184,199,194,203,254,253,253,254,254,254,254,255,250,255,253,255,255,255,255,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,254,255,246,254,253,251,253,62,29,39,22,1,68,90,56,78,37,6,0,51,101,48,16,86,18,27,96,99,83,65,2,64,103,93,77,7,26,92,31,13,95,100,75,4,15,84,92,24,19,97,37,33,104,90,32,5,79,99,92,94,70,33,53,14,16,85,89,18,19,96,95,75,14,47,91,54,6,4,24,83,93,96,30,5,65,105,71,6,11,35,5,5,82,103,45,7,52,93,108,59,5,3,12,0,58,95,107,81,43,10,18,57,84,104,107,81,38,6,16,49,67,58,42,28,26,37,53,63,81,78,75,70,61,57,69,85,97,92,86,88,94,101,101,99,88,72,47,19,8,20,57,85,88,67,39,22,17,21,23,21,29,31,46,61,62,62,65,68,72,82,98,117,134,146,153,155,170,191,213,252,251,254,251,254,254,253,253,254,254,254,253,254,255,249,255,254,253,254,253,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,255,249,254,253,250,252,165,45,58,14,9,8,71,97,80,90,37,5,4,59,109,47,15,49,6,63,101,94,93,30,12,92,98,86,31,11,81,67,2,72,106,54,2,9,63,102,84,1,42,80,39,91,94,62,2,44,98,93,91,96,69,36,6,18,81,100,44,3,76,106,79,42,70,84,35,3,9,50,95,89,101,49,9,53,108,61,10,41,56,9,5,69,99,44,25,80,101,83,27,2,28,26,3,5,85,86,50,11,22,58,88,111,104,74,34,5,3,33,65,73,57,38,24,29,42,49,51,52,43,31,15,8,8,10,13,13,39,63,80,80,72,65,44,22,20,16,17,26,53,88,92,67,21,11,17,42,61,74,104,138,130,131,139,147,149,146,132,113,83,61,41,32,26,26,43,69,91,127,149,174,190,248,254,254,254,254,254,251,254,254,254,253,248,255,254,255,252,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,255,255,250,252,253,253,146,22,81,0,6,12,75,99,91,89,35,2,7,65,106,41,11,11,35,100,93,98,70,2,52,102,90,58,2,54,95,22,28,93,28,4,32,77,95,92,43,4,56,83,68,106,74,15,15,90,97,97,94,90,40,5,23,83,103,73,3,43,102,82,72,76,56,14,3,44,88,93,89,102,77,3,26,102,74,33,54,60,7,9,66,93,59,62,87,68,25,5,15,64,73,21,0,28,37,11,14,50,86,109,93,53,18,9,21,54,82,91,75,49,24,12,3,3,4,3,3,7,6,7,10,15,25,28,22,12,16,12,13,14,7,5,19,44,55,71,86,100,104,73,29,10,34,70,96,95,90,105,130,147,157,162,160,150,142,145,140,126,108,87,64,49,36,23,13,11,11,8,9,24,30,41,39,36,35,40,37,53,67,105,145,254,254,254,250,252,255,255,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,255,251,253,253,249,248,105,26,68,2,12,6,82,101,92,92,32,1,14,76,99,37,6,12,84,98,95,94,18,12,90,96,81,19,11,99,69,2,61,53,38,76,91,101,102,77,14,1,73,96,94,82,38,4,75,100,93,90,96,35,2,37,86,100,83,10,19,95,100,97,69,22,3,35,78,108,95,80,92,87,26,10,87,96,45,52,39,3,34,78,97,85,71,43,13,3,23,59,97,87,34,1,0,3,15,51,87,104,89,43,9,8,31,65,84,70,40,13,3,5,3,15,30,38,40,42,44,43,45,53,65,76,85,93,92,91,64,45,25,23,40,65,83,91,96,110,98,67,36,13,20,51,76,69,61,57,57,68,102,139,129,94,58,38,27,22,31,48,68,78,90,97,99,94,84,75,59,34,13,7,9,12,26,41,87,119,147,147,153,146,144,172,252,254,255,254,255,250,254,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,250,255,251,253,253,252,52,32,57,22,20,2,86,97,90,92,28,1,27,95,94,28,2,49,101,88,101,50,2,65,98,93,43,2,57,98,27,11,73,75,105,99,94,81,52,30,3,29,95,93,97,63,7,46,104,90,94,98,41,3,52,97,100,84,21,11,85,106,90,35,3,27,77,93,102,65,47,91,103,64,6,60,103,77,39,11,9,60,97,99,82,44,9,1,33,74,99,102,67,19,2,3,26,61,86,103,82,33,4,12,49,84,91,62,19,2,16,43,65,80,90,89,85,85,88,93,94,91,93,94,101,107,102,81,50,29,17,25,43,67,90,102,103,100,83,44,18,10,7,19,36,35,31,38,45,55,67,66,51,39,23,42,72,100,115,117,113,110,112,102,90,79,67,60,61,67,83,89,108,122,140,146,161,174,188,199,203,253,251,253,253,253,254,252,251,254,246,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,254,254,254,250,250,251,11,43,57,43,24,5,88,92,93,87,17,1,45,104,86,12,7,85,98,101,67,1,38,97,95,74,5,10,91,81,2,43,100,97,72,43,8,5,50,42,3,62,90,92,92,27,15,93,95,97,95,44,3,60,97,104,85,27,9,83,103,50,11,18,62,96,107,80,36,8,44,105,83,8,40,113,76,19,19,45,86,84,60,28,6,14,47,85,103,98,71,39,7,4,31,71,95,99,88,36,5,10,37,80,95,71,21,12,29,64,81,76,61,46,29,22,18,18,22,32,56,77,95,98,92,65,30,8,12,28,60,80,98,103,105,96,66,34,15,10,28,58,75,85,91,86,98,91,75,55,29,13,26,60,112,128,129,111,101,106,109,109,118,123,130,138,141,141,138,135,139,138,148,165,177,173,177,189,188,189,193,178,169,141,129,106,109,130,149,254,255,255,255,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,254,255,250,253,248,130,1,39,33,50,21,11,92,94,99,77,4,12,76,98,72,1,33,99,95,87,18,16,83,97,92,38,2,41,96,62,5,77,84,37,2,5,20,75,67,1,27,85,70,98,69,3,57,105,91,94,51,11,43,99,101,82,24,5,81,94,21,8,41,92,110,84,28,9,12,11,64,84,22,24,63,36,15,41,77,64,24,3,15,38,72,94,99,89,57,21,8,2,36,80,94,97,77,34,4,7,31,80,109,83,33,6,7,29,49,39,10,3,11,14,35,40,45,39,22,6,8,20,33,26,17,15,29,56,83,101,100,84,69,53,28,5,7,24,50,83,102,103,106,97,79,69,36,21,8,19,43,65,88,118,141,123,105,102,101,90,86,94,98,113,127,128,125,131,145,157,143,127,93,64,47,43,35,33,37,44,38,22,32,44,53,61,79,68,83,104,148,254,254,253,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,254,252,254,251,252,50,0,24,8,57,24,16,96,94,93,58,1,35,106,89,62,1,65,102,92,39,1,75,99,94,84,13,5,69,95,29,5,74,21,8,39,64,95,79,11,5,86,72,68,101,30,14,92,100,99,67,7,32,93,100,87,27,5,79,90,8,21,79,105,69,23,7,31,54,19,10,62,49,4,18,26,37,68,62,17,3,37,78,97,93,79,56,28,2,1,12,34,73,87,70,49,18,2,8,26,74,105,91,53,16,1,3,1,4,2,3,20,42,65,86,96,99,98,93,87,80,74,69,65,71,77,82,88,81,56,31,13,8,2,2,13,40,73,96,101,93,83,70,47,23,8,6,6,36,64,82,100,108,109,111,120,116,103,93,93,92,84,79,71,53,38,33,26,28,54,90,133,145,142,141,133,135,127,129,115,130,128,141,158,167,254,253,253,253,254,254,254,245,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,255,255,254,254,255,254,254,253,251,249,129,1,8,0,14,81,10,34,95,89,93,29,0,83,99,91,32,7,95,91,78,1,43,101,94,93,69,1,17,97,81,10,29,62,57,81,94,100,81,15,5,73,96,43,73,91,11,37,101,98,64,5,22,97,99,86,19,6,78,95,23,18,89,69,20,18,43,77,70,26,0,11,42,52,49,67,68,65,30,2,27,75,92,93,51,11,2,5,7,26,61,79,84,54,19,5,3,6,31,69,97,101,69,22,6,4,5,11,26,31,43,63,83,98,105,105,103,95,79,58,43,35,30,26,24,26,21,16,13,8,12,25,43,53,64,75,88,92,79,60,30,18,13,13,14,18,38,61,86,95,104,104,85,55,31,21,18,16,16,16,19,20,16,14,26,31,45,57,64,50,23,14,16,34,44,44,46,52,66,83,105,146,190,206,205,192,253,250,252,252,251,251,252,254,254,253,253,255,253,255,255,251,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,255,255,254,254,255,254,248,253,253,253,54,0,10,3,58,80,2,38,109,94,79,6,27,98,93,87,8,31,105,94,37,7,98,96,90,90,50,5,49,103,61,3,56,88,92,99,94,84,23,2,70,103,58,17,91,72,5,72,111,82,7,23,93,96,82,19,10,70,102,46,2,81,64,38,65,82,68,35,3,0,10,12,6,13,21,18,19,4,2,48,85,95,100,53,16,33,57,76,92,106,101,82,31,10,3,13,41,79,101,100,74,32,4,2,6,20,42,55,65,74,83,86,88,84,71,55,33,11,5,10,18,35,53,56,60,53,55,61,70,83,91,87,85,75,68,68,68,66,67,71,75,74,73,78,91,102,107,104,106,92,61,27,13,19,37,48,61,69,79,82,82,81,82,84,82,89,92,64,37,29,24,22,19,26,31,37,48,51,46,42,48,45,87,162,252,253,253,254,255,253,251,251,253,254,252,254,255,253,251,255,255,253,253,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,255,254,254,247,253,123,7,0,2,24,96,61,1,71,98,95,48,0,67,101,93,60,1,71,104,84,16,36,108,94,93,91,12,11,81,99,32,13,91,87,90,99,87,23,1,60,103,84,22,33,101,57,15,93,87,12,18,82,102,79,11,13,88,98,67,5,48,90,72,70,52,27,11,7,2,4,2,2,5,15,26,21,8,2,43,93,98,93,85,58,66,82,83,72,67,52,28,13,17,29,55,81,98,103,80,43,12,2,15,46,62,68,58,33,18,10,7,10,10,6,5,8,12,38,59,75,95,98,85,78,78,96,101,92,82,59,33,17,4,4,4,4,10,17,24,30,43,56,66,66,63,61,54,46,28,17,17,42,71,85,92,97,95,96,96,95,93,95,100,105,100,69,40,14,6,19,31,36,51,64,75,84,91,91,89,89,81,66,50,37,92,145,186,254,254,254,254,254,254,254,255,254,255,255,255,255,249,255,255,251,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,255,255,251,248,252,53,0,5,9,75,101,30,14,96,93,76,11,18,93,94,92,19,13,98,93,67,1,77,98,86,91,64,1,33,104,80,8,35,96,97,105,75,21,2,49,95,100,56,11,56,105,30,33,93,15,12,83,108,73,10,30,81,100,85,16,23,92,62,26,6,2,6,2,2,2,2,1,24,62,81,74,48,6,31,97,98,84,107,85,40,12,21,26,31,40,42,48,64,78,95,106,105,87,51,15,1,10,51,85,92,93,96,90,80,79,66,57,57,60,61,71,85,92,108,110,101,79,44,32,51,80,66,45,28,14,5,7,32,60,69,68,47,21,3,2,2,3,4,11,25,37,41,41,39,46,62,82,94,92,81,68,60,67,70,78,95,108,105,87,70,29,12,7,10,14,17,18,24,30,34,35,33,30,29,30,32,30,24,17,10,8,12,13,21,14,12,22,40,53,84,132,161,255,255,255,254,254,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,255,255,254,253,164,4,0,5,48,102,87,11,42,97,97,35,0,43,101,96,56,0,50,103,91,50,4,86,85,81,88,18,1,67,101,61,1,71,112,82,46,9,3,27,95,100,73,1,11,96,78,24,52,24,5,88,104,68,7,21,54,94,93,54,15,52,45,11,10,28,38,39,48,26,25,39,62,93,106,106,77,18,2,79,94,95,104,68,41,48,69,80,89,94,98,100,99,100,103,87,61,36,15,1,8,33,79,96,96,90,94,95,98,110,99,108,110,105,103,105,101,92,84,59,42,25,10,26,65,86,40,15,7,5,7,44,87,93,72,44,19,15,24,37,56,73,82,84,86,76,58,53,70,94,98,98,96,81,49,28,45,77,87,93,96,87,65,39,19,10,26,46,70,78,84,84,87,109,127,128,130,131,128,124,123,122,116,120,110,99,74,62,52,41,74,89,103,116,116,116,141,164,255,252,253,248,255,250,252,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,255,255,253,253,123,0,5,18,93,99,67,8,68,103,60,1,3,61,104,89,4,15,84,103,92,25,19,86,76,74,48,2,11,82,102,54,12,95,84,31,1,5,11,83,111,83,13,8,67,103,46,14,13,10,91,107,69,4,9,27,76,96,89,41,27,54,62,81,90,85,100,86,94,104,97,101,99,90,69,43,20,2,36,99,102,90,70,49,66,63,54,55,59,63,66,68,64,57,43,24,11,5,6,32,74,103,108,101,87,67,40,23,30,48,57,64,69,65,61,56,46,35,28,27,36,52,73,87,59,9,8,3,14,41,75,100,78,26,11,26,49,74,85,84,82,81,67,50,29,18,19,25,28,27,80,86,70,32,6,6,13,15,29,29,26,16,13,24,53,77,99,103,100,95,100,97,104,136,160,159,161,166,167,167,168,167,163,155,147,152,155,140,138,179,197,252,254,254,254,254,253,253,249,255,255,255,255,255,255,254,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,255,255,253,245,95,7,1,63,103,85,51,12,86,84,10,2,13,76,98,46,4,59,99,99,68,5,28,87,59,41,1,4,23,88,91,39,33,73,14,1,5,9,74,105,60,22,1,61,92,76,7,3,30,98,90,34,16,2,13,39,86,101,73,27,40,62,52,36,36,26,22,25,25,33,38,35,19,6,6,2,9,44,91,99,95,81,61,37,15,2,4,1,1,2,5,1,1,4,3,2,2,3,6,26,49,58,69,77,93,100,87,63,33,8,10,5,4,8,11,8,10,13,23,40,49,45,34,13,4,12,36,58,86,104,95,47,11,12,70,86,99,94,82,68,47,29,21,22,29,51,80,88,64,34,5,3,4,4,3,3,5,10,17,24,39,62,86,97,96,91,86,83,83,84,91,87,90,114,130,111,94,87,81,77,70,61,51,56,55,53,91,128,160,209,220,253,254,247,254,254,254,252,255,255,249,255,245,250,255,253,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,255,254,253,253,66,0,38,90,77,90,44,17,94,34,0,21,10,86,82,0,49,99,98,88,33,1,63,59,4,2,3,2,25,99,91,37,4,9,1,18,38,74,71,22,8,1,55,98,93,37,3,29,102,69,26,20,1,6,8,80,97,87,34,13,20,2,4,43,49,34,7,4,3,20,28,37,53,56,67,81,88,106,103,97,81,47,27,32,49,69,70,75,70,60,53,45,43,48,44,49,40,31,29,22,9,2,4,7,13,27,54,80,91,90,79,77,75,75,75,72,67,62,56,50,44,42,44,51,69,86,99,103,91,59,22,10,46,98,105,103,96,83,70,64,66,72,84,90,94,96,97,99,100,98,63,41,26,34,49,60,68,76,81,81,74,60,41,25,15,12,8,12,15,11,15,26,25,25,27,34,52,62,59,56,59,60,72,81,105,122,139,138,144,144,116,88,56,50,34,18,33,41,60,89,138,255,255,255,255,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,254,254,254,253,254,249,254,253,251,44,0,69,83,59,88,38,27,56,0,43,36,8,88,32,38,107,98,78,25,1,33,61,1,8,2,1,3,29,97,84,39,16,47,78,89,73,29,2,7,1,47,105,97,51,1,24,97,76,15,41,6,7,4,66,103,94,51,1,4,4,14,77,80,31,4,8,29,59,70,73,62,52,53,51,50,47,41,40,27,12,6,10,20,33,41,49,62,74,85,97,101,100,104,102,102,102,104,102,95,84,75,58,43,27,12,6,5,15,23,27,22,19,16,8,7,14,13,19,24,29,35,45,56,59,55,46,38,22,14,31,61,72,66,40,25,10,5,5,3,4,6,18,45,85,104,89,70,63,61,76,82,86,89,90,91,87,82,66,55,41,32,31,35,39,40,45,39,29,18,12,10,15,19,40,103,140,138,139,142,141,147,147,151,140,114,80,44,26,28,37,43,58,72,83,91,103,109,120,147,251,255,252,255,255,250,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,252,254,251,253,251,22,3,96,74,36,99,41,12,29,19,80,45,7,73,58,106,84,54,5,1,31,63,5,21,61,42,4,1,46,102,86,70,91,102,80,38,4,11,21,1,38,93,100,48,1,23,93,87,24,44,29,8,1,58,100,98,61,2,5,7,3,71,94,25,1,4,9,5,0,2,5,24,27,7,0,7,0,6,3,0,0,5,5,0,0,4,5,5,6,12,24,35,43,50,54,54,51,46,49,63,79,89,96,99,99,93,83,71,60,53,48,49,54,53,55,50,36,38,26,17,11,11,7,2,2,5,6,2,2,6,15,19,12,3,14,29,45,56,63,62,52,39,15,2,12,56,88,72,34,11,9,12,13,12,10,12,15,17,23,30,45,64,82,94,99,101,96,99,97,81,62,50,51,57,99,139,161,159,163,165,160,159,142,106,70,55,59,83,128,170,188,253,253,254,252,254,253,252,253,255,252,253,255,252,253,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,254,254,245,254,251,253,253,251,154,0,37,106,69,8,81,68,4,6,37,98,47,16,81,91,59,17,1,7,59,74,10,23,92,92,39,1,16,87,99,79,101,85,32,1,14,45,55,1,13,79,101,54,6,19,91,98,31,32,60,4,1,41,95,104,63,1,8,1,5,40,115,50,0,5,3,0,14,35,64,100,64,11,2,0,1,0,1,0,0,0,1,1,2,4,4,1,0,4,3,0,0,3,6,0,7,19,24,16,1,1,4,18,29,39,41,39,35,28,20,22,29,33,57,75,83,100,100,101,93,85,80,77,73,70,68,70,69,66,60,54,56,69,82,92,99,101,99,101,107,106,100,96,78,40,24,51,86,92,85,74,72,71,72,72,70,67,66,63,71,83,94,99,98,92,87,79,78,79,85,93,95,93,89,90,107,110,98,85,68,50,37,32,49,87,125,145,162,182,191,166,155,135,137,137,149,162,251,255,255,254,255,255,255,252,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,251,254,254,254,253,251,253,252,120,1,60,91,51,8,60,91,10,3,53,106,49,17,64,30,1,6,9,70,88,41,5,89,98,68,1,8,73,97,86,103,57,1,6,59,80,52,1,1,69,103,65,1,6,81,98,57,10,76,15,1,53,103,110,62,5,17,15,1,9,112,118,9,0,7,70,125,132,163,199,108,3,9,115,145,131,99,64,54,55,58,62,65,67,64,59,53,46,39,25,7,3,1,0,2,1,12,42,73,80,56,28,1,1,1,4,10,19,24,25,19,1,1,9,35,52,41,43,64,72,82,90,96,99,97,94,91,95,98,99,99,99,95,90,86,82,78,75,73,69,64,60,62,68,60,45,47,62,77,87,93,91,93,95,94,91,86,87,86,82,71,58,41,24,11,5,11,9,9,9,13,17,20,21,19,17,14,12,17,31,46,54,73,73,74,73,77,101,135,156,163,145,113,97,91,98,145,254,254,246,253,255,252,255,251,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,249,252,254,254,253,250,252,72,4,76,84,56,16,25,90,36,0,49,106,49,12,30,0,4,5,65,105,84,1,39,99,82,19,4,62,95,91,102,52,3,40,87,59,15,6,24,78,97,57,5,1,54,104,82,2,63,62,4,38,90,85,54,0,20,45,3,2,62,169,68,0,1,102,145,92,134,204,121,0,8,140,210,189,188,179,179,167,157,150,146,141,136,139,146,141,137,135,129,118,104,78,47,1,2,1,0,14,44,74,89,87,53,20,6,1,6,36,70,86,93,44,2,9,37,62,56,30,21,15,16,17,24,47,71,97,93,88,88,90,87,73,61,37,31,21,14,7,6,7,10,10,5,13,26,26,16,7,2,2,4,7,11,7,2,2,4,1,0,2,5,14,27,42,50,48,49,46,37,30,29,38,45,47,63,90,114,123,124,119,112,94,81,70,74,89,106,131,158,192,250,254,248,254,253,254,249,255,255,255,252,255,252,255,251,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,248,251,254,251,252,253,253,251,252,21,11,92,67,59,44,2,57,62,0,30,94,50,25,33,15,4,31,107,92,64,1,69,96,56,1,56,98,89,98,63,1,58,86,39,2,25,59,69,48,15,2,1,46,112,76,2,45,90,9,5,34,49,29,1,9,66,12,5,16,152,165,15,0,62,170,72,41,164,135,2,0,125,207,191,198,198,193,189,189,190,180,160,145,142,143,140,153,151,152,154,155,155,147,136,110,51,2,0,1,0,7,29,61,91,102,76,46,32,20,5,22,59,96,57,1,4,33,58,85,81,77,78,81,85,88,91,65,45,24,15,15,17,23,29,41,52,64,70,75,82,84,84,84,81,85,86,83,83,77,60,29,20,12,10,16,25,34,40,59,66,77,84,86,81,74,68,60,63,69,77,86,92,93,93,104,126,148,149,130,109,96,89,105,123,141,150,148,128,111,112,110,147,254,254,248,254,253,255,255,254,255,253,255,253,255,253,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,247,254,252,137,165,252,133,4,30,100,56,36,82,8,12,51,4,16,79,65,41,50,15,0,67,104,90,47,1,79,87,1,22,98,93,97,68,1,55,75,18,1,50,56,23,4,1,19,39,59,91,61,15,55,87,37,1,11,27,23,1,6,66,37,0,5,83,197,107,3,3,130,171,12,38,99,9,2,82,195,199,187,180,106,174,195,190,195,193,178,169,164,156,145,124,119,115,114,113,115,134,159,146,135,91,29,0,3,8,0,7,30,70,104,108,87,68,62,42,29,49,77,45,1,2,7,20,31,39,43,53,58,43,22,2,1,0,14,28,29,21,13,2,6,13,22,31,34,33,30,29,24,14,3,0,14,41,63,84,86,90,95,98,98,91,83,67,56,40,30,26,34,44,51,68,75,86,97,104,105,103,102,115,141,160,158,144,131,124,121,109,104,82,48,21,10,7,9,13,11,28,92,133,170,254,252,253,254,253,255,255,254,248,255,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,250,253,254,252,157,57,250,252,75,2,59,107,49,23,101,49,0,25,4,0,58,82,47,56,9,7,83,104,87,32,1,69,34,1,60,101,99,77,10,38,72,11,17,40,16,1,19,46,75,87,92,91,58,42,73,77,23,4,7,29,43,1,5,48,68,0,4,34,174,188,56,0,42,192,136,0,30,17,0,54,188,200,186,198,121,21,176,202,192,184,188,197,173,113,55,29,16,6,0,3,5,7,35,77,148,149,150,135,84,24,0,2,4,1,9,44,84,98,77,49,44,57,64,78,93,63,15,3,1,2,4,3,1,2,1,0,3,31,63,86,98,104,97,87,70,38,8,0,0,0,0,4,14,28,35,36,40,39,39,44,49,59,62,47,26,9,3,1,1,13,36,60,75,79,73,68,68,65,64,65,71,74,75,74,77,95,105,112,130,144,144,140,113,82,60,58,61,66,64,56,38,23,7,2,7,25,53,92,136,255,255,252,254,255,255,254,255,255,255,255,255,255,255,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,252,249,67,45,253,126,17,10,85,100,46,10,102,77,4,1,4,5,71,75,53,50,1,23,90,93,91,15,4,27,2,21,98,97,84,19,19,43,15,13,11,9,24,62,95,101,106,95,87,72,59,68,55,7,1,1,50,65,1,6,22,89,22,3,8,127,194,159,0,4,95,215,106,0,10,0,54,177,197,188,195,188,36,15,183,202,193,194,193,171,57,7,0,3,1,11,15,12,11,0,2,0,57,137,146,154,176,160,100,36,1,3,5,1,16,59,90,88,42,15,23,56,83,101,97,70,41,15,7,25,41,51,63,70,78,91,90,74,64,59,55,51,44,41,26,6,3,8,19,47,71,80,84,77,71,63,45,26,3,3,3,4,8,26,58,81,97,99,77,43,23,16,15,18,28,27,28,28,24,21,20,22,30,38,57,84,113,137,152,159,155,152,148,148,149,150,150,149,146,135,116,100,73,33,13,16,18,84,156,159,138,160,253,252,251,253,253,252,254,252,254,249]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,253,249,253,24,52,148,89,4,23,101,97,34,14,98,87,20,1,1,49,85,55,71,19,4,17,86,103,83,8,1,6,5,78,104,90,27,1,5,6,10,27,49,74,99,107,90,69,36,15,2,6,34,55,17,2,1,54,79,16,5,10,88,96,1,0,65,197,201,101,5,6,146,218,89,0,5,47,178,200,188,200,197,130,3,46,194,192,191,197,180,49,0,3,5,63,117,143,139,144,127,105,45,0,0,51,137,150,166,190,195,171,123,20,0,8,1,7,31,65,92,75,33,3,6,27,54,83,97,92,82,70,60,51,41,32,36,29,11,1,4,2,1,5,26,55,65,76,72,55,39,13,3,3,3,3,3,4,8,11,21,36,66,98,120,121,105,90,67,42,27,31,42,56,69,70,56,66,76,81,83,86,87,88,78,82,88,94,99,105,112,118,137,145,156,160,159,156,156,156,156,158,155,145,142,139,101,45,8,6,84,178,194,153,139,253,253,249,250,254,254,251,254,254]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,253,253,162,2,63,124,48,0,55,104,90,27,15,95,93,22,3,29,88,74,70,52,1,5,7,82,107,65,9,1,3,66,103,89,36,1,8,21,41,73,93,99,86,64,33,7,1,4,23,41,66,82,54,0,5,47,110,53,2,8,60,171,64,6,4,119,214,183,42,0,26,179,205,98,0,9,116,215,191,193,190,180,38,0,60,199,179,193,194,102,3,0,22,112,152,135,93,88,89,101,142,145,98,13,0,67,143,145,181,190,192,187,175,77,0,0,3,1,9,35,77,99,81,46,15,2,5,22,45,66,72,64,49,32,21,1,0,1,1,0,0,9,23,59,74,104,82,27,2,3,17,36,45,61,75,81,86,92,100,108,112,110,93,70,53,49,53,57,84,105,100,78,57,41,34,30,26,20,20,24,26,25,22,22,24,30,37,41,41,36,33,22,24,28,34,40,45,46,47,55,72,102,129,141,148,149,141,95,43,20,40,68,127,160,254,253,250,254,254,251,254,254,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,252,254,164,2,42,109,21,9,88,88,84,26,15,98,91,20,1,62,97,73,81,11,4,14,2,52,101,63,1,4,66,111,82,20,1,1,36,79,102,90,60,28,13,5,2,25,60,88,105,87,76,78,32,7,23,120,108,22,1,13,145,190,36,0,19,164,208,148,3,8,44,186,205,110,1,14,148,209,188,191,194,108,0,0,81,196,147,201,171,29,3,16,103,155,109,64,102,122,119,102,76,119,145,105,14,4,92,159,177,196,189,192,191,194,128,31,0,1,3,1,11,47,86,102,94,69,41,14,1,0,1,5,3,1,0,13,17,8,3,3,1,19,64,87,99,47,3,15,58,90,104,105,111,115,115,110,108,105,103,103,101,94,86,85,94,109,122,142,133,97,44,16,33,67,85,87,82,76,67,53,43,46,53,54,62,77,94,110,118,120,119,103,90,72,63,64,75,86,93,110,116,121,135,151,151,146,149,145,141,120,98,80,51,75,143,254,253,253,254,255,254,254,251]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,250,251,253,6,13,75,3,41,93,74,89,20,15,103,87,23,1,75,104,93,42,1,7,41,9,31,101,51,2,57,97,52,1,9,24,76,92,106,62,11,3,1,4,26,64,95,105,77,49,27,55,86,6,1,67,153,107,12,1,42,188,181,38,0,28,181,211,114,4,66,33,186,203,133,2,2,135,219,188,196,174,27,3,8,103,169,111,210,150,1,1,48,158,122,85,139,133,97,100,131,135,100,122,147,87,0,27,132,172,193,185,186,188,197,199,176,100,17,3,6,0,1,18,55,94,109,101,84,65,49,30,16,26,48,57,40,6,1,11,32,60,85,94,76,14,3,45,103,116,111,104,107,109,110,109,108,108,105,101,107,107,109,115,123,124,111,99,69,24,8,25,62,84,69,33,18,19,24,33,45,52,55,55,65,74,83,90,97,109,129,143,146,147,147,145,143,141,142,143,134,124,107,101,116,131,139,145,146,143,174,190,209,171,150,154,252,254,249,254,254,248,251,255]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,14,2,65,11,66,70,64,98,14,15,103,85,14,11,89,111,67,5,3,9,58,23,7,76,38,15,74,37,5,14,59,96,101,102,34,4,11,35,62,77,94,110,86,37,9,2,14,49,82,3,2,107,173,128,0,0,78,204,183,40,6,29,182,205,86,35,95,14,167,211,159,6,0,91,217,188,200,121,0,0,8,141,109,94,218,131,0,5,84,156,119,140,99,6,1,13,17,99,148,128,130,137,37,4,89,175,181,190,191,190,186,187,190,196,168,96,12,0,3,12,4,17,54,82,97,101,105,99,94,91,70,36,1,10,44,70,77,91,85,46,3,8,73,121,109,102,106,114,118,111,105,104,103,102,104,107,104,99,81,55,38,27,22,19,18,55,87,94,70,22,2,14,52,62,66,62,62,73,84,89,97,111,131,143,149,149,149,150,157,158,159,161,162,162,160,158,156,141,134,130,120,119,135,147,153,153,142,139,154,140,125,147,252,254,254,252,254,254,254,254]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,255,254,249,22,0,40,26,64,49,43,96,20,11,97,84,1,31,102,82,18,4,1,13,78,43,1,46,56,22,29,14,48,93,98,92,63,24,6,15,35,49,70,81,68,41,14,1,4,0,13,66,70,1,23,161,198,137,0,0,110,222,181,56,0,22,174,209,70,59,91,4,123,226,169,37,2,35,179,204,187,89,0,5,37,173,42,97,220,116,3,3,107,155,126,106,3,5,0,0,0,13,101,145,134,141,86,1,62,158,166,172,194,183,197,190,187,198,190,197,166,73,0,0,5,5,3,6,23,45,61,63,56,35,9,0,30,73,89,88,92,57,8,2,31,101,116,105,107,103,97,81,74,84,98,106,106,102,100,100,109,107,95,80,74,76,82,85,99,105,69,18,0,1,35,87,104,97,89,80,70,54,35,23,10,14,18,24,31,34,33,31,31,33,42,56,73,85,87,84,81,78,84,93,94,96,89,74,84,91,101,132,133,136,124,86,101,154,249,254,254,252,254,254]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,252,251,254,28,0,27,14,49,42,18,86,33,6,89,80,1,43,100,33,4,9,1,13,74,23,4,20,20,4,1,14,22,34,24,17,1,5,4,5,10,10,3,3,14,16,7,2,1,4,10,80,52,1,53,193,197,152,2,0,147,206,189,83,0,15,140,209,66,72,104,0,87,207,192,78,0,7,98,208,186,63,0,29,135,143,2,116,212,129,0,11,125,146,142,55,1,14,30,19,0,1,38,147,140,138,101,4,35,153,146,134,204,190,184,189,191,191,190,192,190,191,111,15,0,5,2,7,0,1,0,0,4,0,9,57,84,85,90,81,34,3,20,89,108,109,109,103,92,62,43,50,59,82,101,102,99,103,107,105,102,104,107,110,110,100,75,52,35,18,13,16,27,62,92,88,63,32,8,6,7,9,23,45,70,63,51,40,30,25,25,25,28,29,31,32,33,32,30,29,28,32,30,28,34,42,58,79,84,96,108,124,152,188,197,176,152,163,255,252,253,254,253,252]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,254,60,3,12,5,21,66,18,60,43,2,85,63,1,51,44,4,4,9,1,7,47,8,0,6,1,1,6,0,1,0,0,4,3,0,0,2,10,34,54,56,42,18,1,3,1,0,42,118,29,3,78,211,195,156,0,5,159,209,194,120,0,1,107,214,61,88,109,0,62,212,194,139,0,8,32,184,196,45,0,132,191,78,1,139,211,144,2,0,119,155,130,36,4,29,101,90,37,1,16,129,144,138,114,0,28,152,128,108,214,184,191,197,191,193,189,190,192,192,193,150,64,4,0,3,0,12,20,19,32,55,72,83,89,91,71,25,4,45,117,116,107,107,108,103,92,84,87,98,102,102,102,99,98,98,101,103,100,104,105,103,103,104,97,87,88,97,111,114,104,95,91,85,72,55,48,61,76,87,99,111,103,109,118,126,130,133,136,139,146,146,149,152,153,149,146,145,146,146,141,133,128,118,99,80,76,59,66,90,100,166,253,253,254,254,255,252,254,252,252,254]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,252,254,250,105,4,0,9,13,64,43,42,38,5,87,47,1,23,4,1,26,32,6,0,18,6,1,3,1,0,1,4,4,3,5,1,5,6,0,2,0,16,26,26,9,0,1,3,3,56,113,138,35,1,111,210,186,170,11,2,157,208,190,158,6,0,78,201,72,86,143,1,56,212,194,175,60,0,24,163,193,37,75,197,178,25,6,170,208,177,30,1,103,150,137,39,1,19,78,115,73,0,14,133,145,141,109,1,32,171,105,107,207,191,190,187,188,192,187,192,189,187,193,192,181,160,112,56,18,3,23,46,72,91,87,97,82,40,9,3,54,125,111,111,104,96,96,103,106,103,102,106,99,98,95,96,98,99,100,99,103,99,101,110,118,120,123,128,116,102,88,77,68,73,91,104,97,88,88,80,60,57,64,60,70,97,128,148,158,159,149,136,131,118,106,99,93,90,96,102,95,92,82,64,42,31,32,40,36,44,28,23,17,12,67,142,254,254,253,255,253,255,255,254]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,149,4,4,0,4,50,66,22,29,7,85,27,0,11,0,4,37,32,3,2,0,1,2,0,0,2,2,0,0,3,2,0,0,0,3,0,10,0,2,2,1,0,19,75,117,121,144,160,28,0,130,210,186,178,22,0,141,208,194,178,38,1,48,182,64,82,167,0,52,206,193,200,117,0,27,166,190,29,128,216,158,0,40,193,195,192,95,0,82,169,136,73,1,3,12,23,23,0,35,150,142,145,96,3,56,184,77,138,206,190,184,189,194,191,188,191,193,187,190,195,195,193,192,189,160,107,70,88,96,94,89,45,13,2,3,59,120,116,97,93,105,114,114,104,99,102,103,100,103,99,98,102,100,95,96,102,106,118,125,121,111,90,54,23,11,4,2,1,6,28,62,89,91,107,102,89,91,99,114,139,153,151,143,123,89,51,25,13,22,25,28,31,34,32,20,11,15,9,12,31,65,102,130,144,173,196,196,176,150,107,58,29,59,155,255,253,255,253,254,254]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,252,252,252,253,19,8,1,0,27,70,13,16,9,81,19,0,5,0,3,22,16,0,0,4,0,0,5,2,0,1,0,11,17,25,49,57,49,43,6,0,5,1,0,0,63,140,155,99,88,191,175,30,0,128,210,195,183,42,0,89,167,193,197,86,0,29,145,49,65,180,1,65,215,188,202,124,2,27,188,170,25,158,216,131,0,100,211,182,197,165,10,42,157,138,131,23,4,0,6,0,12,102,151,141,138,76,0,85,189,66,166,199,190,186,190,189,188,188,181,186,189,189,188,187,187,189,191,187,177,152,130,109,60,13,3,1,2,81,126,107,108,107,116,104,85,78,91,105,105,100,98,97,103,103,96,99,111,119,116,109,84,47,22,7,5,5,10,9,5,2,2,1,1,1,4,19,31,50,67,80,85,86,87,72,48,21,4,2,10,33,52,56,60,63,64,55,40,23,13,17,51,93,125,141,142,129,113,107,116,138,163,198,218,203,192,147,120,166,254,252,254,252,254]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,250,254,254,247,253,84,0,6,0,10,58,13,3,15,80,18,0,2,0,0,0,3,3,2,0,2,0,18,65,94,105,119,118,127,130,128,129,134,131,116,60,0,0,26,78,147,120,44,8,133,211,174,43,1,97,212,187,192,76,0,36,87,146,213,134,0,13,109,39,40,187,27,98,214,190,192,91,0,64,209,140,53,178,188,84,11,172,207,192,191,190,59,1,139,145,137,124,49,19,19,49,113,143,138,137,134,31,1,140,160,77,216,180,193,206,214,211,204,209,215,211,207,200,200,208,207,195,185,184,190,171,103,29,1,0,1,9,88,117,113,115,119,103,56,36,49,77,101,106,96,95,103,103,95,95,110,123,109,76,47,19,15,17,32,56,77,89,95,105,99,85,72,63,52,36,26,13,7,1,0,9,17,18,16,15,24,31,37,56,82,93,89,78,67,69,84,94,96,104,117,137,148,157,160,159,152,134,116,94,56,41,36,32,46,80,124,173,254,255,245,254,254,254,254]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,249,253,253,129,11,0,0,6,39,12,1,19,78,16,2,3,5,2,0,0,2,0,0,6,66,130,142,143,149,140,155,139,143,137,125,98,84,132,143,86,9,21,86,67,8,0,93,215,186,181,61,1,49,195,194,200,100,0,14,21,62,191,181,55,21,108,15,29,174,70,149,206,191,176,16,5,133,214,137,99,202,130,94,155,217,186,125,188,196,145,0,89,164,132,133,143,130,126,131,126,125,132,152,92,5,34,188,99,161,201,202,203,164,101,70,74,86,101,131,159,180,174,152,144,164,190,202,151,57,1,0,1,4,3,71,128,113,95,85,46,35,54,79,97,108,103,98,102,102,95,97,105,110,89,49,22,22,35,68,86,107,119,126,127,120,110,106,114,115,110,111,113,110,108,107,96,48,6,1,22,61,100,119,131,136,126,109,98,90,84,79,103,131,144,139,124,112,105,92,93,93,91,93,108,134,156,196,193,191,162,121,82,41,17,9,43,73,139,164,251,254,254]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,252,253,251,253,250,41,0,0,5,15,6,0,13,67,11,6,1,0,0,4,2,0,3,29,105,143,140,150,153,148,157,139,145,153,149,147,120,56,20,118,155,98,6,6,0,0,95,199,185,194,196,103,1,15,130,209,196,134,7,16,4,11,155,210,132,82,118,0,37,166,129,196,190,189,76,2,41,197,192,159,157,162,154,192,207,135,37,102,208,186,186,38,0,131,160,136,115,109,105,100,114,137,158,109,1,1,147,162,125,207,190,195,95,21,0,3,4,0,1,0,4,10,23,62,116,145,145,79,13,1,3,6,3,4,51,123,111,110,102,77,77,101,107,105,101,101,102,104,100,99,101,105,87,53,33,42,81,110,114,134,128,118,96,63,43,52,73,92,102,106,104,102,102,105,110,115,112,107,70,18,2,3,1,3,9,25,38,33,22,26,39,61,70,65,40,20,21,32,40,48,49,51,48,41,34,31,33,54,97,135,163,201,211,180,155,116,64,32,12,13,32,39,82]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,253,250,250,252,103,3,1,3,1,1,7,3,53,8,0,3,3,4,2,0,14,55,120,134,143,148,137,98,57,42,35,33,43,99,145,154,126,56,12,104,157,87,0,0,90,201,188,190,193,192,144,2,1,61,190,180,188,60,38,16,2,130,215,173,156,108,0,46,180,181,192,201,125,4,2,150,206,192,188,178,187,212,166,66,1,62,192,194,177,188,156,4,2,90,148,154,150,146,142,151,140,76,0,2,134,180,126,191,193,184,60,0,0,0,0,37,65,61,48,40,55,88,111,99,55,9,2,1,6,4,6,0,21,115,122,110,108,110,107,106,109,112,102,103,105,103,101,99,98,101,105,89,83,97,112,106,83,66,56,38,25,23,38,63,89,101,101,99,95,100,114,123,128,136,136,138,142,138,121,105,101,104,84,55,22,7,9,22,44,60,51,18,3,28,70,90,89,83,84,89,97,111,129,131,109,83,31,8,8,25,64,148,210,203,196,198,178,166,152,139,145,124]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,252,255,255,249,255,254,21,0,8,0,0,5,3,17,1,1,5,5,15,44,71,101,134,139,135,145,139,92,14,28,3,5,1,7,5,55,151,148,133,51,12,124,131,16,45,184,184,186,192,185,194,182,63,0,27,147,169,171,159,79,48,0,123,214,187,185,70,0,72,204,190,197,166,15,1,89,211,189,192,196,218,198,105,17,0,68,191,197,190,191,157,173,151,33,1,11,41,72,77,66,33,1,1,48,157,172,132,188,195,186,54,3,3,0,34,139,183,180,180,167,160,147,114,57,9,0,1,2,7,0,4,2,19,92,119,110,101,101,115,127,127,119,113,94,107,105,97,102,103,99,98,98,98,100,101,91,73,57,49,50,54,69,89,100,99,100,103,100,103,115,130,142,147,149,150,148,148,149,151,153,156,154,152,162,161,150,125,102,89,77,60,33,27,77,129,138,135,120,94,75,54,35,28,31,49,90,129,143,118,46,9,9,35,144,216,201,200,197,198,200,200,198,194]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,254,254,253,255,255,249,110,7,0,6,0,2,1,16,4,3,0,10,32,47,53,74,102,126,144,149,142,66,29,106,41,0,0,0,0,4,61,158,140,134,37,51,164,52,85,173,170,170,190,192,193,196,141,6,1,129,162,95,202,149,49,4,142,214,190,179,27,1,109,210,192,195,91,0,55,196,188,196,206,204,143,52,1,0,86,202,196,192,191,191,163,119,131,155,116,66,30,8,7,15,34,82,146,189,133,127,183,191,196,72,1,0,0,65,189,199,199,197,188,189,180,175,163,138,108,90,82,78,53,59,60,78,115,120,115,115,123,130,111,67,29,25,35,75,94,105,103,101,100,96,98,98,100,98,95,99,109,116,115,111,91,72,74,86,97,101,101,98,109,127,142,149,150,150,151,151,150,151,151,153,153,151,149,117,97,89,100,105,95,80,66,50,65,112,145,144,144,150,155,149,142,131,114,88,60,45,42,85,123,144,102,31,10,30,133,217,216,207,196,188,191,194,194]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,252,255,254,249,254,253,44,5,2,0,18,0,0,1,1,1,3,0,0,0,2,0,4,49,125,149,110,42,117,93,1,9,2,1,0,4,98,153,149,111,22,147,94,59,163,135,124,207,191,189,200,185,67,0,111,157,44,200,186,70,0,168,206,190,123,2,18,173,205,193,170,5,24,179,197,211,208,148,66,10,0,5,104,204,187,187,187,189,195,198,168,107,73,78,119,124,135,139,148,159,140,113,77,123,181,202,196,89,0,3,5,72,204,198,191,187,189,196,202,199,202,204,200,196,193,189,183,186,174,157,147,133,123,133,131,90,35,6,7,27,61,86,98,100,100,99,102,103,99,97,98,96,98,109,120,114,79,42,29,37,51,74,94,102,97,91,99,120,142,150,153,155,154,153,152,151,151,152,152,152,149,148,135,91,41,10,2,6,6,1,11,65,126,142,139,134,115,100,97,110,127,141,149,145,131,118,110,111,136,137,134,108,48,18,50,118,188,217,218,216,209,198]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,253,255,255,254,254,248,250,146,5,6,1,0,7,1,0,0,0,26,70,96,95,81,71,58,25,29,132,140,47,91,124,14,0,1,8,0,2,35,138,141,147,46,111,125,18,174,77,113,205,193,184,189,200,136,1,104,143,14,192,200,70,28,202,199,183,33,0,100,209,192,202,79,18,171,220,197,145,48,4,1,0,50,141,196,196,186,200,195,196,193,190,192,192,159,97,59,47,43,44,40,44,63,86,155,196,193,205,93,1,0,3,82,197,197,192,191,211,225,234,239,242,245,240,229,220,213,206,192,199,179,164,141,133,133,85,14,6,17,59,100,112,110,110,99,100,103,102,99,98,101,100,98,101,111,102,58,22,16,32,67,82,98,102,100,98,97,98,107,131,148,150,150,153,155,155,151,150,151,152,153,153,153,150,154,156,150,124,87,67,64,64,80,123,162,159,152,149,128,108,92,80,69,76,102,133,152,157,150,147,141,138,150,152,165,130,72,42,29,55,100,143,181,209]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,254,250,254,253,253,247,78,5,3,0,1,0,5,1,54,114,147,155,149,148,153,140,114,55,65,146,73,76,140,40,5,0,0,0,3,10,99,153,146,80,91,145,15,154,42,121,211,188,188,180,195,174,38,97,113,12,197,190,54,95,216,191,68,0,48,190,200,195,159,85,172,212,175,86,2,3,0,70,138,181,192,198,193,189,190,187,192,196,189,192,199,194,194,172,153,131,127,138,152,172,191,183,199,212,103,5,0,8,100,201,194,188,191,225,235,243,249,245,245,247,246,243,241,231,215,202,190,191,179,150,116,58,7,27,72,112,116,104,103,106,106,103,101,102,101,100,101,103,101,99,104,85,49,35,51,87,110,98,105,106,102,99,99,101,100,116,140,151,147,147,152,153,152,148,149,150,152,154,154,154,152,150,148,152,157,162,165,158,144,140,110,89,74,73,83,85,86,94,90,78,52,31,32,54,79,106,133,145,158,150,152,154,167,169,136,94,55,18,1,5,26]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,255,254,247,251,253,253,121,9,2,1,2,0,8,75,114,145,134,97,55,29,24,22,32,39,57,96,72,49,152,70,0,3,0,7,0,1,67,152,149,114,70,129,20,116,20,167,205,183,182,131,182,199,87,91,98,22,205,163,38,161,214,99,6,16,162,205,190,183,167,179,211,147,33,0,3,54,152,189,205,206,203,193,185,190,190,196,182,189,189,187,188,181,190,195,197,192,196,197,189,189,194,218,191,92,8,0,2,87,208,197,184,198,216,236,248,243,243,248,244,242,241,241,241,232,217,206,193,185,162,130,76,43,76,118,123,123,120,118,120,118,113,106,104,99,98,103,106,103,98,104,103,98,92,96,106,107,104,103,101,97,94,99,103,103,101,116,141,153,149,150,152,150,150,150,151,151,152,152,152,152,151,151,152,152,148,146,154,160,158,137,104,90,84,75,66,51,38,27,21,18,17,15,12,13,18,18,18,31,70,115,150,156,153,156,160,146,116,102,105,101,88]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,250,254,254,253,246,158,122,56,0,0,3,17,101,137,132,104,65,50,56,44,14,1,6,0,0,37,36,46,149,108,0,1,7,1,0,2,51,154,149,145,75,89,33,86,44,204,189,201,124,50,166,198,139,123,95,15,207,115,36,205,154,4,0,146,204,193,203,201,217,201,107,7,0,8,93,205,217,205,183,183,186,198,211,208,215,210,222,210,214,215,207,214,204,192,200,198,196,199,208,215,202,140,55,0,0,3,58,189,198,186,197,205,223,244,251,246,251,250,249,251,251,251,250,247,236,215,200,185,165,136,119,126,140,139,129,111,92,81,79,77,73,75,94,105,103,101,98,96,99,94,100,103,100,102,108,106,100,95,97,97,95,95,96,97,98,108,137,151,150,151,150,148,149,150,151,152,152,152,151,150,150,148,149,156,152,118,72,47,38,51,54,74,84,86,97,110,119,128,122,116,114,114,109,105,103,87,66,44,16,16,37,109,145,160,182,203,212,211,208,206,205]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,250,255,255,254,249,253,252,157,127,44,1,7,38,124,146,137,123,108,76,34,37,84,121,134,118,108,88,67,54,19,103,153,61,0,0,2,2,1,52,151,158,172,102,76,52,33,136,206,209,137,2,68,206,189,156,172,79,31,179,32,64,200,31,0,126,201,215,208,197,165,123,59,0,1,14,131,213,158,98,57,35,33,34,49,85,98,98,88,83,101,113,130,144,153,176,192,195,199,204,193,166,121,58,10,0,3,0,65,182,201,192,193,202,227,251,250,220,190,156,148,146,150,165,186,209,224,223,208,200,191,170,152,137,115,101,61,21,6,16,30,34,44,64,82,103,107,100,101,100,98,101,101,102,102,101,98,97,100,103,98,100,101,101,96,95,96,100,102,132,149,148,148,147,146,150,149,150,150,151,151,151,151,152,154,153,154,154,151,136,98,57,33,20,14,12,10,8,7,16,24,51,87,117,133,140,141,139,146,141,129,112,73,33,14,39,64,84,111,131,146,161,182,196]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,249,255,253,254,252,252,252,148,132,41,3,51,143,139,147,153,154,157,143,112,64,18,13,45,71,91,98,93,67,41,34,122,139,90,10,0,1,1,49,148,157,191,135,49,21,104,203,209,121,1,68,186,194,189,201,157,32,71,80,0,119,99,33,153,215,211,151,88,27,0,0,0,17,83,149,135,53,0,1,1,0,0,1,0,2,4,2,2,1,0,2,1,0,9,23,38,52,57,55,46,19,1,3,1,0,34,127,188,193,191,189,194,229,246,172,78,30,9,7,5,2,4,10,16,22,33,41,49,42,38,46,36,24,22,2,2,13,68,103,101,107,111,107,105,104,103,102,102,102,100,99,102,99,102,104,99,100,102,101,98,100,99,96,95,98,97,94,102,115,139,152,146,145,150,150,147,146,151,153,150,150,153,151,153,153,152,152,153,154,156,156,150,144,144,147,140,122,97,75,70,64,63,85,121,149,157,153,150,147,147,147,143,128,89,46,26,13,8,7,5,24,23,47]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,252,254,248,252,252,252,160,127,17,13,144,141,149,147,106,65,78,127,151,147,117,79,44,31,22,26,43,62,75,78,60,94,130,134,99,24,1,49,143,152,182,155,14,61,192,210,92,1,90,194,195,203,213,142,40,22,17,0,62,146,144,196,192,124,46,3,0,6,33,67,127,155,159,118,72,58,62,66,63,30,5,1,4,7,10,10,23,41,53,43,22,7,2,0,0,0,1,1,0,0,1,3,57,132,178,190,193,190,192,201,221,186,77,1,2,7,1,1,1,1,1,1,1,0,1,3,4,7,2,0,0,0,2,1,43,103,129,111,107,110,107,116,108,106,105,105,104,104,102,103,103,100,95,95,100,101,99,99,101,100,98,96,94,95,94,94,95,102,129,150,149,148,151,144,153,152,153,150,148,152,155,152,150,150,150,152,153,153,152,153,161,153,144,134,133,145,154,155,149,133,98,58,35,44,78,108,140,148,157,161,160,161,156,145,125,102,74,38,4,7,2,3]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,254,246,252,254,253,252,251,251,114,19,79,151,139,148,79,2,1,0,2,45,116,161,158,145,144,143,141,143,152,158,155,142,98,74,88,122,123,91,81,134,142,174,103,8,170,214,70,5,124,200,205,208,169,68,9,0,0,2,76,176,196,186,107,15,1,1,64,121,147,179,187,194,192,185,179,180,187,192,191,184,186,152,76,9,0,3,8,45,84,131,160,168,161,140,117,99,76,62,66,78,101,137,163,187,194,196,192,182,181,183,172,99,13,6,0,0,0,3,78,131,149,157,134,84,36,6,0,1,1,0,0,2,11,46,97,129,135,122,113,115,108,101,103,122,123,126,126,123,119,119,122,120,124,120,112,108,98,91,94,99,101,102,100,95,91,94,100,101,102,124,146,147,151,157,154,152,149,148,149,148,150,150,149,151,151,152,152,152,152,152,152,156,147,124,83,45,28,28,34,67,99,127,131,109,75,42,24,15,38,65,83,95,105,116,130,137,150,144,137,114,64,14,10]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,250,255,255,254,251,168,128,158,159,59,9,117,150,145,107,3,20,66,77,53,15,0,30,83,115,126,124,108,98,96,100,105,121,137,139,107,94,115,125,125,130,148,150,47,105,202,91,37,153,212,215,177,71,1,0,6,45,75,134,188,221,167,45,0,1,73,154,185,197,200,193,204,201,199,198,199,197,192,190,190,194,190,196,199,165,100,45,21,4,18,51,99,147,181,197,201,190,194,190,189,196,196,190,192,193,199,207,178,122,94,67,22,1,5,0,0,29,112,206,248,253,253,250,252,252,226,172,127,87,82,78,77,97,114,111,117,116,116,117,120,111,105,101,74,45,35,30,26,24,21,21,23,26,32,43,64,91,106,108,106,113,105,99,99,100,99,98,99,98,97,111,135,149,152,151,148,151,145,143,149,151,149,147,148,152,153,153,153,152,152,150,149,146,133,135,150,146,116,72,40,8,7,7,20,56,96,116,117,90,56,25,24,32,33,47,76,114,136,145,147,146,139,89,20]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,255,254,253,149,34,11,3,0,57,152,145,131,16,13,65,63,76,118,132,99,52,10,3,0,14,50,71,63,52,49,60,95,133,141,135,132,131,133,132,132,97,116,204,155,121,157,178,144,74,6,15,64,141,172,200,212,220,201,120,35,0,33,128,204,221,212,208,200,202,187,183,191,194,196,203,213,216,210,195,191,187,188,192,191,180,169,159,156,161,177,189,189,188,189,193,194,192,192,195,192,191,198,206,207,148,63,25,12,2,3,2,0,60,159,226,250,249,248,248,251,250,246,244,248,250,251,238,225,199,153,115,103,92,87,87,91,98,118,127,119,110,94,86,71,58,57,63,68,68,68,64,56,58,64,71,87,99,95,69,75,85,97,100,98,96,99,109,107,111,131,161,171,164,165,155,157,154,150,146,147,152,156,152,153,154,155,154,152,150,149,122,110,114,137,156,161,158,153,139,105,67,41,19,8,22,48,82,117,136,131,125,128,129,132,138,147,154,152,142,140,124,66]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,250,253,244,139,77,52,77,126,145,142,73,5,35,21,8,2,19,54,99,136,144,113,73,24,1,25,86,133,141,143,143,144,152,158,154,149,155,146,129,158,172,130,77,72,71,73,68,82,125,182,209,205,191,151,119,92,51,10,3,36,83,141,153,145,109,79,63,44,38,39,33,37,49,60,81,122,164,202,211,211,202,195,191,189,190,195,192,188,187,188,190,192,193,187,184,189,190,186,196,204,201,134,59,16,6,0,1,8,3,71,178,242,250,250,245,247,249,250,247,245,245,249,250,246,240,241,232,219,169,95,45,18,6,6,17,29,50,86,122,140,134,127,117,101,87,82,86,94,100,103,96,97,85,63,65,76,71,67,76,90,101,105,102,102,103,87,91,84,84,91,84,77,80,96,129,151,153,151,152,151,147,150,151,152,153,154,153,151,152,154,151,152,154,153,157,155,148,154,165,163,144,126,110,86,63,45,45,58,90,127,148,154,156,156,162,178,190,186,159,127,80]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,247,253,249,250,248,150,144,144,118,5,8,9,3,1,1,4,2,0,27,80,135,146,129,81,28,0,11,59,78,77,63,50,57,75,93,104,111,101,79,42,25,26,8,0,0,48,98,144,131,102,46,3,0,1,2,0,0,1,0,0,0,3,0,3,4,0,7,0,2,0,1,2,0,0,9,25,51,90,139,180,207,214,213,214,206,211,215,213,211,211,209,206,217,213,212,209,208,193,124,36,0,0,3,1,2,21,85,170,236,251,252,249,242,245,250,241,247,246,246,247,246,245,247,249,243,247,231,175,103,62,46,21,10,2,2,3,3,9,45,83,111,120,118,97,65,39,25,19,22,16,17,22,34,62,90,94,96,95,97,101,100,82,50,30,24,24,22,21,27,46,74,95,123,145,156,151,148,150,150,151,149,150,150,151,151,151,150,149,150,154,160,158,152,155,156,151,130,96,70,76,104,128,140,144,141,129,112,92,76,77,92,107,130,159,205,208,194,195,181,113]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,249,254,253,253,250,251,253,252,250,116,137,51,1,0,2,4,5,6,0,7,15,3,0,44,124,150,138,136,90,32,27,45,67,87,93,84,67,53,44,37,51,84,125,164,168,156,117,40,1,0,0,5,9,38,74,83,72,40,23,10,11,15,31,31,39,34,26,32,52,73,82,78,67,43,14,0,0,1,0,1,1,9,30,61,90,115,137,149,144,129,105,80,67,68,75,83,89,97,91,60,22,4,7,29,49,88,130,182,225,239,248,250,250,249,244,250,250,236,248,247,245,246,248,248,245,245,248,250,241,217,183,135,101,92,79,71,65,67,65,58,32,3,2,5,22,44,66,85,106,118,122,121,116,109,104,104,109,106,99,95,99,100,99,99,99,96,91,95,92,99,104,109,133,156,157,153,153,151,150,152,148,146,150,151,151,151,151,149,149,147,147,153,152,155,158,157,156,155,153,152,144,106,45,14,13,21,21,37,46,72,100,116,123,121,113,106,109,149,191,222,211,196,178]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,252,251,246,251,243,172,142,105,75,127,111,5,4,2,1,4,3,1,1,6,15,51,34,3,50,145,134,117,159,143,129,110,103,98,88,99,124,134,144,145,163,191,208,204,195,188,183,177,131,67,15,12,38,81,143,195,213,202,179,152,159,164,173,175,182,171,169,175,181,193,190,192,189,182,167,142,109,62,20,0,0,1,0,0,0,5,10,14,13,9,4,2,3,3,1,7,5,5,14,36,81,138,180,213,233,239,231,228,233,242,251,244,247,248,246,244,246,248,248,249,249,247,247,248,243,240,243,242,232,216,202,181,154,132,120,120,117,116,120,125,120,99,77,46,24,9,6,5,6,16,31,47,66,85,93,96,100,100,99,109,108,109,112,115,112,107,102,104,97,92,97,99,111,142,151,147,148,149,148,148,148,150,152,151,150,150,150,150,150,151,151,147,150,151,151,153,157,161,160,170,172,172,154,108,68,57,48,42,31,19,15,22,36,57,74,89,75,71,78,108,165,208,219]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,128,70,50,19,14,16,17,51,108,164,39,0,30,3,2,0,0,9,2,1,3,22,78,43,1,61,142,99,53,80,96,128,148,140,106,64,33,40,65,101,110,138,161,173,191,205,200,198,207,201,183,151,111,65,18,17,77,145,191,215,208,197,193,189,190,192,199,195,191,197,195,197,194,193,194,196,195,187,177,144,97,42,13,3,0,0,0,0,0,0,0,0,1,0,0,0,0,0,1,2,11,31,47,58,70,87,123,183,234,250,246,247,247,244,245,249,249,246,247,239,237,241,243,243,249,251,248,252,244,215,153,77,35,35,42,83,116,141,138,124,123,125,125,121,115,106,98,85,68,49,37,28,22,29,56,88,102,101,98,104,98,89,86,85,89,96,103,100,102,98,95,94,103,132,151,146,145,149,150,149,149,150,150,151,150,150,150,150,150,151,151,148,149,152,155,155,138,106,80,71,88,114,130,120,114,125,124,135,135,125,108,95,86,71,58,48,59,56,54,52,41,70,132]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,149,116,113,129,138,141,145,156,251,252,144,6,7,23,4,2,3,13,0,6,6,3,1,34,93,38,1,53,125,106,45,21,8,22,68,130,139,113,81,31,1,1,1,6,10,13,48,98,120,126,125,140,174,213,199,129,43,0,6,30,77,137,195,212,211,201,194,186,187,192,186,186,182,189,191,199,212,206,192,192,192,193,184,159,135,121,114,109,104,111,117,117,115,115,117,119,120,117,114,112,115,124,142,156,176,190,209,228,242,246,248,251,250,251,250,250,249,243,243,251,251,251,247,250,252,209,132,94,96,90,55,12,0,2,2,2,2,23,69,117,142,141,130,124,118,115,116,119,120,115,112,112,103,106,106,103,103,108,107,101,64,44,27,20,21,25,30,35,51,80,104,99,94,98,116,143,148,143,147,152,151,149,151,150,151,151,150,150,151,151,152,152,151,150,149,152,153,146,132,119,104,94,102,126,131,123,125,126,131,131,134,138,139,136,130,128,127,112,123,164,178,163,126,65]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,251,252,252,251,251,252,252,252,78,2,28,16,1,1,18,20,0,5,9,5,3,1,46,113,67,0,19,74,108,116,94,73,36,28,60,113,154,161,163,145,136,132,116,98,72,42,63,78,79,64,24,69,186,217,165,60,1,0,13,0,19,89,150,195,211,218,207,192,199,186,194,175,148,123,129,176,213,212,207,198,196,206,218,227,234,240,245,247,249,247,244,244,246,248,249,249,250,249,248,248,249,250,250,250,248,245,249,250,249,242,243,240,244,251,252,251,250,249,224,201,169,130,78,26,2,1,3,1,1,2,0,0,1,2,1,0,2,17,53,92,122,137,138,136,132,124,114,107,106,107,109,106,104,105,108,110,109,108,120,117,119,126,125,119,118,122,116,103,99,98,98,96,105,140,151,144,147,153,151,150,152,149,150,150,150,151,151,152,151,152,150,150,149,151,155,162,168,172,173,163,134,93,49,29,23,16,7,2,2,7,14,18,28,40,63,89,133,188,202,195,207,199]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,253,253,253,252,252,250,252,252,34,0,58,3,2,5,48,4,5,3,21,23,1,5,3,48,125,117,58,21,6,32,58,64,75,69,51,30,42,88,124,166,191,199,210,200,181,179,160,169,178,174,135,26,10,164,219,158,51,1,10,52,47,0,0,32,72,102,152,199,208,210,202,193,174,144,98,57,71,123,169,191,203,204,214,238,248,245,250,246,243,245,247,249,248,246,250,249,247,246,245,245,245,245,246,244,245,249,249,245,244,245,253,250,253,248,210,160,111,70,42,15,4,5,1,0,2,1,5,1,1,0,1,4,1,6,2,3,2,1,1,4,21,38,61,80,98,110,120,131,134,127,115,115,112,108,107,105,96,85,73,62,53,52,48,40,39,43,48,72,105,107,96,96,102,120,152,147,148,152,150,150,152,151,150,151,151,151,152,151,151,152,149,148,151,154,149,133,110,94,101,123,132,125,100,82,78,71,61,66,71,74,79,89,98,102,116,131,145,188,210,184,166,158]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,246,254,254,249,251,252,252,253,253,114,2,36,30,1,1,44,49,0,4,0,33,36,0,0,0,4,30,95,137,135,122,95,82,77,86,82,81,85,68,58,58,55,64,94,139,181,202,206,193,183,194,186,198,169,55,2,163,217,154,72,1,8,76,107,73,1,0,5,7,38,83,134,172,215,214,185,183,165,108,60,51,70,98,122,141,163,197,225,244,245,247,249,247,246,244,246,242,245,248,249,250,250,248,245,250,247,247,249,249,250,251,251,243,188,126,71,26,6,3,0,0,1,2,0,1,4,2,0,2,0,8,8,4,8,2,1,5,1,0,5,4,1,1,4,2,2,3,12,31,53,75,88,100,109,112,111,121,129,113,87,51,30,15,14,23,32,38,40,42,37,59,98,108,94,94,116,148,149,149,149,150,150,151,152,151,150,151,151,151,151,152,152,150,150,153,156,146,124,95,77,65,53,43,47,45,35,33,34,45,55,76,98,119,133,146,155,155,157,160,178,188,193,193,171]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,251,254,254,254,253,251,250,247,70,0,51,16,3,5,60,15,6,0,0,12,16,5,3,1,0,2,5,26,68,104,125,137,136,113,84,73,65,58,68,100,141,152,133,123,124,147,188,206,203,182,196,191,196,181,61,4,160,218,179,117,37,6,51,147,136,48,0,1,0,1,3,22,73,158,211,207,192,188,179,170,174,173,159,133,107,93,89,105,131,172,211,234,242,244,246,248,248,244,239,237,237,237,235,231,235,241,246,251,238,181,117,54,24,0,0,2,0,0,5,0,3,32,71,111,158,174,151,86,11,1,9,0,1,11,4,4,7,7,5,9,18,20,15,9,3,1,1,1,2,3,10,15,15,20,27,35,52,82,112,116,120,127,134,136,133,130,130,118,108,94,97,103,96,98,106,138,149,150,147,151,151,148,152,150,150,151,151,150,150,151,151,152,152,155,156,156,153,152,153,151,150,136,126,115,98,81,63,37,19,4,2,2,7,26,48,63,83,96,108,119,123,141,163]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,252,251,254,254,253,165,4,15,49,1,3,35,36,0,5,0,6,0,2,1,0,5,0,0,2,1,1,3,16,24,20,22,39,43,48,54,35,8,14,19,23,19,4,14,49,123,207,205,187,193,191,195,181,83,16,116,197,194,165,126,96,82,133,173,100,12,0,0,2,1,1,8,68,164,209,198,187,168,144,143,178,208,205,188,179,174,165,158,168,186,203,215,221,241,237,228,217,212,212,213,211,213,204,197,170,102,29,0,0,2,0,0,0,2,2,38,98,155,194,227,241,248,251,251,252,246,179,86,14,3,7,0,2,0,0,0,0,0,3,18,34,45,57,49,18,1,1,4,0,1,1,1,2,2,3,3,6,16,22,30,31,29,28,29,29,55,103,116,106,101,97,101,104,130,146,149,144,151,152,146,150,150,150,151,151,151,150,150,151,152,150,151,154,153,152,153,156,152,158,155,156,159,159,162,160,163,142,111,81,53,29,11,2,4,7,7,7,13,10,12,32]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,252,254,255,248,254,249,105,0,51,29,6,0,35,4,1,3,0,0,4,1,0,6,3,0,7,0,5,1,1,2,9,1,8,20,47,63,37,76,111,106,109,101,81,55,19,0,1,55,164,217,200,187,189,193,186,154,90,136,184,188,195,186,170,145,160,188,157,69,2,0,1,1,1,6,18,106,206,199,157,19,5,29,74,133,163,173,175,188,218,203,182,196,192,189,142,138,152,158,168,179,165,152,143,130,107,80,56,42,35,32,42,54,79,112,149,188,226,253,251,251,251,251,251,251,251,251,250,250,238,210,175,138,108,93,93,98,90,68,38,0,0,4,3,31,66,102,79,35,2,6,3,4,3,2,1,2,13,19,30,31,37,47,53,51,47,41,20,28,110,118,99,100,98,100,112,147,146,142,150,150,150,149,151,149,149,149,151,151,151,152,149,150,149,151,151,151,153,153,150,151,153,152,151,152,156,159,165,164,163,161,154,143,130,125,114,108,105,98,90,81,56,27]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,253,255,247,254,42,0,60,7,0,9,6,5,5,0,0,1,1,1,1,0,0,5,1,0,10,2,3,1,1,9,1,6,17,61,84,52,49,69,55,40,40,55,69,53,16,0,24,97,186,216,191,190,196,192,192,183,174,195,191,192,195,192,188,187,196,191,145,92,29,2,0,0,3,10,81,208,198,59,0,0,0,8,9,32,28,43,90,183,209,180,190,191,97,1,0,25,22,27,20,16,9,18,29,51,100,169,222,245,250,252,252,250,248,250,250,248,250,250,250,250,250,250,250,250,246,249,249,246,247,251,241,227,209,201,194,187,180,150,102,34,2,0,18,44,98,111,92,40,11,3,3,7,2,11,34,49,50,46,47,52,52,53,51,42,55,45,68,111,104,104,98,90,102,134,153,148,148,147,145,150,149,149,149,149,150,151,152,152,149,150,151,151,151,152,152,152,155,154,153,155,159,161,159,157,161,158,159,155,138,106,77,65,54,57,67,81,94,111,123,125]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,255,252,255,254,255,156,3,24,52,1,1,5,3,1,0,0,0,2,1,1,3,2,0,2,7,6,6,1,4,3,5,4,1,4,1,11,61,122,94,52,40,25,2,1,3,30,26,11,1,1,32,129,211,204,189,192,197,183,160,185,202,190,192,192,192,193,192,197,199,192,173,129,76,13,1,0,3,81,208,159,20,4,13,0,6,0,1,1,1,23,119,201,199,186,181,93,5,0,1,0,5,4,7,0,2,12,13,29,89,156,209,229,244,245,246,252,251,249,250,250,250,250,250,250,250,250,247,241,244,250,251,251,251,249,244,222,207,196,195,196,197,172,114,0,0,4,9,45,59,64,32,7,1,3,1,8,37,55,68,62,56,47,33,27,26,22,3,33,55,105,122,108,93,101,101,119,148,148,143,148,147,152,148,149,149,149,149,151,151,152,151,151,152,152,153,153,153,154,152,153,152,145,138,136,141,147,154,161,163,164,162,150,116,84,64,55,55,69,89,109,129,139]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,255,253,255,252,106,0,52,27,4,3,2,7,1,1,6,1,0,2,1,1,25,58,6,2,1,14,54,72,78,61,28,6,4,3,1,2,48,114,133,120,107,100,58,14,2,0,9,2,2,1,1,72,177,209,188,190,198,136,90,205,190,197,191,189,193,192,193,197,189,196,199,191,162,137,114,88,83,135,199,158,42,0,4,0,6,0,4,1,3,2,66,183,213,196,194,144,69,20,2,0,0,0,2,3,0,0,0,1,1,0,9,22,40,83,150,215,251,250,250,250,250,249,249,249,249,248,244,244,223,173,133,118,113,131,144,173,195,205,192,193,194,194,128,1,6,0,0,4,19,37,14,4,7,2,2,5,7,14,19,20,17,15,15,29,48,39,1,13,50,98,121,120,106,98,108,137,152,152,153,148,144,149,148,148,149,149,150,151,152,151,151,151,151,153,153,153,153,155,156,148,124,96,79,78,84,93,105,109,108,123,152,170,172,168,147,121,112,112,108,109,107]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,247,254,254,254,254,254,255,51,0,61,8,1,9,5,1,7,0,1,0,0,4,1,22,67,92,25,5,4,3,21,17,10,23,52,23,1,1,7,3,1,23,65,108,132,137,137,113,64,3,4,2,6,14,3,1,31,134,215,203,189,177,64,140,209,188,188,193,198,194,188,189,188,187,196,196,202,201,195,194,185,178,182,193,183,118,28,3,0,1,4,1,0,8,1,41,159,230,223,224,229,205,158,113,80,54,55,70,97,119,130,140,150,150,154,162,178,201,227,244,250,250,250,249,249,249,249,249,249,244,243,248,242,227,210,176,132,72,48,38,55,112,161,187,188,193,189,112,0,0,1,1,6,9,3,1,1,6,3,0,0,2,6,1,0,2,0,5,38,80,12,4,3,13,37,74,108,117,125,143,162,160,156,160,154,150,149,148,149,149,149,150,151,148,149,149,150,151,151,151,152,148,152,155,154,149,147,149,150,141,131,115,95,76,64,62,67,82,82,63,51,44,32,26,20]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,249,250,254,254,254,17,13,59,1,1,1,7,13,6,11,7,10,19,21,27,63,110,89,49,2,2,3,6,19,27,36,54,13,1,2,0,2,3,5,0,26,69,120,157,148,139,107,29,9,2,14,40,1,0,8,92,193,212,190,141,59,202,195,196,194,183,191,211,211,206,191,190,190,191,189,195,205,204,199,188,190,193,196,169,132,60,28,0,0,1,0,0,1,12,109,220,252,246,253,247,246,239,239,238,239,243,251,252,252,249,251,249,248,251,251,251,248,247,250,250,250,250,249,249,249,249,249,250,250,249,245,251,249,236,205,171,157,142,143,166,193,194,188,200,188,57,1,3,2,2,5,9,3,1,1,1,1,3,2,3,0,0,6,0,0,26,81,53,8,3,4,6,4,14,34,48,64,93,107,111,133,142,150,149,150,149,149,149,150,150,149,149,149,150,151,151,152,151,152,151,151,152,154,156,155,152,155,152,152,154,150,136,118,107,106,116,99,92,99,100,106,105]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,253,248,253,253,253,137,0,42,46,1,6,1,30,25,1,6,2,0,8,17,28,60,97,103,70,2,1,4,11,28,38,44,15,1,6,0,7,6,2,2,3,2,13,27,74,137,149,123,98,39,10,1,28,63,19,0,1,63,180,209,189,83,119,210,187,161,109,67,64,105,180,210,194,188,197,196,183,174,168,192,212,217,200,195,195,195,192,169,158,135,118,98,60,23,1,2,29,155,251,252,251,253,246,250,252,252,250,247,248,249,249,252,252,251,250,247,245,248,251,250,250,250,250,250,250,250,250,249,247,249,251,251,246,245,246,225,190,193,197,192,189,192,186,194,190,194,160,5,0,5,0,1,3,5,4,3,1,1,3,6,5,0,2,6,2,1,10,79,101,98,98,79,66,48,35,35,41,43,54,78,101,129,154,150,150,150,151,150,149,149,149,150,151,151,151,152,152,151,151,149,149,149,148,148,149,153,155,149,156,159,155,154,159,161,158,160,156,117,102,114,121,127,123]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,253,252,253,252,252,107,2,58,24,6,1,19,74,10,1,39,37,13,1,5,2,5,31,58,42,9,6,1,1,1,2,2,4,1,2,0,1,0,3,3,3,1,2,5,6,24,70,101,106,99,43,1,9,42,75,42,3,0,53,192,206,149,69,200,191,191,171,162,135,72,53,127,194,198,185,193,179,127,65,36,61,110,175,209,223,204,202,206,214,210,205,202,193,175,147,108,58,16,43,126,209,253,253,252,249,249,252,251,248,246,249,247,247,248,250,251,251,251,250,250,250,250,250,250,250,250,250,250,253,250,248,248,248,246,245,231,197,189,192,205,205,200,197,188,194,192,192,130,1,1,3,4,2,2,3,1,1,1,0,3,2,3,3,2,2,3,1,20,61,96,111,134,121,114,115,110,108,108,118,150,163,148,156,153,150,151,151,149,149,150,150,152,152,153,153,152,153,152,152,150,150,151,151,152,152,154,153,151,149,149,151,153,154,156,156,155,153,115,103,110,97,82,66]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,252,253,248,254,51,3,76,16,3,20,83,69,1,6,52,83,98,86,68,50,24,3,5,3,2,4,4,2,5,11,21,15,4,2,6,2,1,9,0,3,0,0,0,0,5,4,14,35,57,59,12,5,2,29,56,40,0,2,79,218,186,91,127,218,190,194,198,191,188,144,104,144,199,190,197,189,189,175,130,74,37,23,51,126,194,228,214,210,224,229,230,237,233,233,233,225,189,140,75,55,88,155,222,252,248,250,251,246,251,244,250,250,250,250,250,250,250,250,250,250,250,250,249,249,249,249,251,246,249,251,245,249,250,242,200,185,196,201,141,101,146,202,195,181,203,187,192,87,4,2,3,0,3,3,0,1,0,0,4,1,2,2,2,0,1,0,0,6,12,23,58,113,124,106,96,99,96,104,135,152,148,149,152,150,149,150,144,136,133,137,147,149,152,153,152,152,152,153,151,152,152,152,152,152,151,151,151,155,156,154,153,154,155,155,154,160,124,103,111,109,91,60]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,254,253,253,254,251,18,20,82,14,3,61,96,40,1,1,14,36,52,61,79,94,93,84,61,52,42,40,48,64,76,83,60,60,38,9,1,6,6,1,3,0,0,3,0,0,0,0,4,0,5,30,35,4,2,3,1,9,15,0,13,153,215,155,69,192,197,189,190,191,189,197,184,195,184,194,182,194,192,192,198,193,169,143,107,44,43,116,216,225,212,206,205,210,227,232,252,247,252,246,247,214,188,188,225,253,252,249,252,243,243,251,250,250,250,250,250,250,250,250,250,250,250,250,249,249,249,249,247,251,251,247,245,250,231,190,194,219,192,139,94,154,88,174,197,198,186,187,197,180,46,0,7,2,0,4,4,0,2,0,1,1,1,2,2,0,0,0,1,0,0,3,2,20,93,124,97,97,95,102,131,150,148,148,151,148,149,150,147,141,140,143,147,149,152,153,152,152,152,153,152,152,152,152,152,151,151,151,156,155,155,154,155,155,154,156,159,158,121,105,114,117,128,131]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,254,251,254,147,2,30,94,12,9,93,91,10,1,6,4,7,4,2,2,12,34,56,87,89,93,98,98,85,53,25,9,27,51,54,33,15,20,35,26,17,11,0,0,0,0,6,6,15,19,24,27,18,18,3,12,6,3,2,0,76,215,185,115,123,200,188,192,195,182,197,194,181,185,199,193,200,188,185,192,188,199,201,189,187,141,47,49,165,222,216,213,203,199,203,199,201,210,226,251,246,252,253,247,250,252,248,246,252,251,248,250,250,250,250,250,250,250,250,250,250,250,250,250,250,249,249,251,250,250,247,246,250,242,220,234,233,181,144,176,186,106,153,209,183,195,190,190,204,154,23,0,5,2,0,3,2,0,4,0,0,1,1,1,2,0,0,0,3,2,4,12,4,42,125,100,97,95,100,125,147,148,149,149,148,149,151,150,146,147,150,148,150,152,153,152,151,152,152,152,152,152,152,152,151,151,151,148,146,144,145,148,150,150,151,149,160,141,127,123,110,96,80]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,252,254,252,118,0,62,98,11,20,102,71,2,12,16,21,39,51,50,39,23,10,6,2,15,28,29,20,10,3,1,3,15,45,76,91,89,72,49,21,1,0,0,0,4,0,6,1,8,14,27,24,21,3,25,65,17,0,3,2,19,170,206,183,126,191,194,192,186,194,185,187,202,214,197,194,199,208,221,207,197,185,192,197,200,201,181,98,40,67,129,152,175,196,198,172,134,94,79,77,98,130,200,253,247,242,251,252,251,251,243,250,250,250,250,250,250,250,250,250,250,250,250,250,250,249,249,250,245,249,251,247,244,248,250,250,233,195,190,201,176,80,181,198,193,192,191,189,192,189,142,26,0,8,1,0,8,0,5,0,1,0,2,1,3,0,1,1,5,0,2,46,36,8,109,106,96,95,99,119,145,148,150,150,149,149,151,151,149,151,154,149,150,153,153,152,151,151,152,152,152,152,152,152,151,151,151,145,150,155,160,166,171,172,170,176,172,123,61,25,7,5,7]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,250,254,252,254,83,15,74,88,13,27,105,57,2,30,14,46,82,106,104,102,100,87,71,57,40,20,8,4,4,7,10,5,1,12,39,46,33,15,3,4,1,31,31,2,1,13,25,54,52,39,37,29,12,15,82,78,5,6,0,3,5,106,206,186,185,188,191,185,196,185,192,206,175,89,35,20,19,39,78,138,201,220,207,202,210,223,227,213,162,113,86,108,164,194,203,211,210,206,215,199,183,142,103,140,241,252,247,252,239,251,252,251,251,251,251,250,250,250,250,250,250,250,250,250,250,250,250,249,251,251,249,247,250,249,243,241,247,227,193,172,114,139,195,192,190,193,161,152,191,193,193,123,9,0,11,0,6,0,0,3,2,1,6,1,3,2,3,2,0,0,0,39,73,4,92,112,94,97,98,114,144,150,151,151,150,150,149,150,149,151,153,150,151,152,152,152,151,151,152,152,152,152,151,151,151,151,151,154,154,143,121,106,102,100,96,67,39,12,13,39,72,92,101]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,248,254,252,252,48,0,73,81,17,27,105,43,2,51,9,3,24,40,41,39,35,31,32,18,8,2,2,2,2,1,2,3,3,5,6,2,1,3,4,13,59,83,45,7,1,1,5,20,29,39,24,10,2,59,100,66,1,5,0,5,1,72,190,190,195,188,192,186,193,192,201,138,5,20,92,113,109,99,63,34,39,109,208,247,246,242,231,233,214,190,187,183,183,194,189,196,225,250,240,252,252,250,232,182,180,245,253,242,252,249,250,251,251,251,251,250,250,250,250,250,250,250,250,250,250,250,250,250,251,251,248,247,251,250,247,250,243,242,218,163,157,193,196,189,198,167,98,160,189,191,185,192,57,0,5,3,0,0,2,8,2,4,17,2,2,3,5,0,3,0,4,33,90,6,77,115,93,98,97,109,142,151,151,152,151,150,148,149,150,151,152,150,151,152,152,151,151,151,152,152,152,152,151,151,151,151,151,159,152,128,90,65,53,46,40,37,32,30,50,91,118,125,123]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,250,254,251,249,254,15,10,66,79,13,34,101,25,9,65,6,5,2,2,3,9,4,5,14,17,18,27,43,53,44,19,1,2,1,1,5,4,2,22,53,85,104,66,8,2,11,2,1,6,2,7,3,7,29,96,100,39,5,0,1,0,0,49,155,190,189,183,199,189,181,202,140,2,63,160,167,175,186,194,185,166,119,43,28,120,221,251,251,249,235,210,181,148,154,195,206,151,112,199,252,248,242,246,252,252,252,241,248,250,245,252,249,251,251,251,251,251,251,251,251,250,250,250,250,250,250,250,250,246,247,249,251,251,246,245,248,245,248,245,239,210,199,186,192,193,188,135,131,191,191,193,196,182,69,1,3,4,0,0,4,10,1,9,29,3,3,4,4,0,6,0,0,30,90,7,72,117,91,98,96,105,140,150,150,151,151,151,150,149,150,151,150,150,151,152,152,152,151,152,152,152,152,152,151,151,151,151,151,152,155,158,155,153,151,151,153,152,143,109,60,31,19,12,8]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,251,254,152,1,20,65,74,3,48,99,13,23,70,2,2,8,7,2,10,30,55,75,92,97,99,96,92,88,82,75,65,75,74,70,79,91,96,97,84,52,16,2,1,3,6,2,5,3,5,3,31,82,97,90,15,7,4,0,3,2,8,79,162,188,187,186,190,212,143,2,54,184,168,167,181,186,190,195,198,196,172,100,32,22,93,193,247,252,251,235,221,216,213,227,226,141,47,152,252,250,249,241,235,247,253,251,250,248,247,252,251,251,251,251,251,251,251,251,250,250,250,250,250,250,250,250,251,249,246,247,251,251,251,251,248,250,247,242,238,211,200,191,189,173,159,186,195,193,193,187,152,27,0,17,3,1,0,0,12,1,14,38,6,3,4,3,5,0,4,1,31,89,10,72,119,90,98,95,101,138,149,149,150,151,149,150,150,151,152,151,150,151,152,152,152,151,152,153,152,152,152,151,151,151,151,152,155,152,152,157,158,155,156,160,158,160,158,147,134,122,114,115]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,252,130,4,32,53,72,2,58,84,16,59,39,2,2,2,3,3,2,3,5,8,20,27,38,41,38,46,56,55,55,59,67,68,63,54,41,26,11,3,2,2,10,31,53,63,61,57,59,71,92,103,92,76,4,4,1,3,0,0,6,7,82,160,173,178,187,136,8,36,184,198,196,209,215,200,195,192,192,195,202,203,182,128,65,23,48,129,232,251,252,244,241,233,248,242,183,46,109,250,253,242,221,152,139,215,250,253,251,247,244,245,252,252,249,248,251,247,250,251,247,247,251,250,248,251,248,249,252,246,251,245,247,250,248,248,250,249,242,232,217,203,204,214,195,153,189,200,194,172,119,9,1,31,4,2,0,3,2,2,33,37,3,9,2,7,0,1,1,1,25,90,8,78,115,97,97,95,99,133,148,150,151,151,151,152,151,150,150,150,151,151,152,152,152,152,152,152,153,152,151,152,152,152,152,151,153,153,153,153,152,151,152,152,152,155,157,155,155,155,159,160]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,252,120,2,34,49,71,9,52,73,32,37,2,2,22,53,77,78,74,73,63,49,38,23,4,2,11,23,17,4,2,1,1,6,6,3,2,2,2,4,11,47,106,120,96,95,85,84,83,94,91,97,96,48,2,4,1,3,6,0,0,3,28,120,148,153,124,11,20,179,213,208,176,151,159,174,189,203,216,216,227,235,243,251,238,196,119,47,22,89,214,250,252,252,246,250,245,201,65,82,248,253,245,223,170,95,107,173,242,253,252,249,243,245,252,252,248,252,252,247,251,251,242,247,251,246,251,252,244,246,251,251,251,250,251,249,247,242,240,246,232,199,168,113,86,139,203,188,186,174,119,14,1,37,9,1,0,4,4,0,43,45,3,9,5,0,0,0,1,1,28,86,4,87,113,92,103,98,91,121,145,146,151,152,151,152,151,151,151,152,151,151,152,152,152,152,152,152,152,152,151,151,152,152,152,151,150,152,154,157,159,161,162,164,160,160,149,123,89,59,49,46]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,255,253,253,103,1,39,44,62,4,64,67,16,7,8,48,106,101,98,98,97,96,98,102,98,95,86,73,48,14,3,17,18,17,13,8,5,5,3,2,16,69,105,113,81,32,14,8,24,50,76,92,91,103,88,16,2,8,3,2,23,6,0,0,12,126,142,115,20,2,123,206,142,36,10,12,2,8,12,23,48,76,100,112,129,162,209,247,252,231,168,65,11,114,248,253,246,247,252,249,221,90,69,197,253,253,253,223,171,111,78,130,206,253,250,250,252,242,249,252,248,249,245,245,252,252,248,248,250,248,248,252,252,248,242,251,248,247,251,251,247,250,227,182,110,114,157,196,199,193,188,185,135,14,0,45,9,2,1,1,5,4,53,48,3,6,4,0,0,0,2,1,25,68,3,98,119,103,94,90,99,110,146,147,150,151,152,152,152,151,152,152,151,151,151,152,152,152,152,152,152,151,151,151,152,152,152,151,150,153,153,148,140,136,138,142,155,161,168,174,176,172,167,163]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,254,83,1,43,40,70,2,69,48,2,13,39,63,41,31,18,13,18,23,23,20,35,45,55,69,80,67,32,5,2,16,11,3,5,2,19,77,130,128,83,26,2,9,41,75,91,82,91,102,104,86,35,2,5,12,4,5,40,14,3,1,25,128,116,44,0,36,184,146,36,78,132,144,137,128,100,78,40,28,8,7,23,29,52,92,142,205,245,236,146,17,77,249,247,246,211,218,251,252,159,66,94,204,247,253,244,240,201,132,82,78,127,187,231,252,250,249,246,247,252,252,250,245,249,252,250,251,252,245,251,252,251,246,251,245,245,247,245,250,250,236,240,237,243,217,182,198,194,193,157,6,0,49,3,2,5,1,4,8,60,46,4,2,0,4,0,1,1,0,14,39,7,108,115,93,106,99,100,105,141,148,149,151,152,151,152,152,152,152,150,151,151,152,152,152,152,152,152,151,150,150,151,152,152,151,143,150,155,146,118,82,55,40,34,33,30,31,41,61,89,109]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,253,64,1,44,38,67,2,67,50,50,67,53,31,27,24,14,4,3,12,22,27,8,3,3,17,36,57,61,52,28,9,10,7,2,50,119,145,110,33,2,4,44,97,99,91,94,98,106,96,73,34,1,8,19,10,2,17,50,12,1,4,33,71,37,1,3,48,175,120,116,204,205,195,206,197,197,186,189,172,163,169,173,170,163,155,157,170,200,248,247,176,7,119,249,253,225,172,148,181,253,242,152,73,74,149,233,251,252,252,218,180,122,81,68,103,188,252,251,252,249,245,249,252,248,247,242,248,252,250,252,242,252,246,250,250,251,251,251,247,246,250,241,250,240,235,200,188,191,196,152,0,3,41,1,1,1,3,2,5,68,48,5,1,2,3,1,2,1,1,4,11,23,121,104,104,103,93,102,100,139,147,149,150,150,151,151,151,152,152,150,150,151,152,152,152,152,152,152,151,150,150,151,152,152,151,150,150,150,154,154,151,143,137,124,114,96,74,51,33,19,11]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,253,46,2,40,38,71,4,68,43,54,86,95,94,94,93,90,81,71,66,68,73,49,22,10,13,7,3,2,3,3,8,2,8,66,131,132,90,23,3,2,58,100,69,31,24,21,35,32,21,9,3,6,6,27,4,2,31,47,2,2,10,24,19,1,2,0,52,170,128,172,182,174,173,186,200,210,209,194,195,194,190,192,197,201,202,230,244,251,237,243,243,161,7,134,246,253,244,203,151,136,178,228,228,170,86,55,84,171,251,253,243,248,234,200,138,81,92,171,228,252,250,252,252,245,252,252,242,252,242,250,247,248,251,248,251,248,244,247,246,245,251,245,250,240,234,205,192,194,197,115,0,9,24,1,1,2,19,1,6,78,48,3,0,6,0,1,3,2,6,1,2,45,130,99,96,108,99,96,105,139,147,148,149,149,151,151,150,151,151,150,150,151,151,152,152,152,152,152,151,150,150,151,152,152,152,147,148,150,152,153,155,158,160,160,158,159,164,168,160,142,126]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,252,254,251,33,3,35,39,70,2,70,31,6,26,56,82,95,97,93,87,91,100,106,105,100,95,86,78,74,65,47,27,14,22,41,76,109,103,52,2,2,16,49,101,73,8,4,3,2,1,2,10,5,1,9,26,18,1,5,41,34,2,11,14,6,12,14,0,3,33,157,156,158,129,115,86,68,75,98,158,205,212,202,191,188,171,137,110,111,149,202,250,252,247,248,155,38,53,174,253,251,249,228,194,169,189,219,238,204,137,60,76,229,253,245,244,253,252,234,183,139,178,230,252,247,244,231,202,194,211,241,252,245,252,245,252,251,251,249,246,249,251,251,250,250,242,246,242,204,189,195,194,76,0,11,8,2,1,26,37,2,23,87,32,0,2,4,1,1,4,6,7,1,1,52,129,99,52,105,118,85,110,137,146,148,149,150,151,150,150,151,151,150,150,150,151,152,152,152,152,153,152,151,151,151,152,152,152,152,157,161,164,160,156,154,154,151,153,155,155,154,155,158,162]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,250,254,250,26,3,30,39,72,2,63,28,6,11,19,42,46,18,3,6,10,12,34,63,92,102,103,103,110,108,98,93,89,88,94,98,78,36,6,3,4,32,101,97,30,2,17,53,63,31,15,1,3,6,9,43,4,2,15,45,20,5,25,17,7,25,11,2,1,44,151,167,161,175,168,160,150,120,77,34,43,115,193,212,194,190,184,160,125,89,60,71,132,232,250,252,213,119,31,45,140,243,253,250,246,225,221,230,246,252,223,116,52,220,253,235,253,250,250,253,248,243,248,252,247,235,212,184,167,147,112,225,252,246,252,252,250,244,245,249,248,249,251,250,247,249,249,247,189,160,202,185,57,0,9,0,1,6,55,48,1,45,91,13,1,4,0,5,2,3,10,6,3,2,49,122,106,66,36,87,110,101,140,144,147,148,150,150,150,150,150,150,149,150,150,151,152,152,152,152,154,152,151,151,151,152,152,152,157,142,130,128,140,155,164,167,167,165,161,158,156,156,155,155]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,252,167,18,7,33,45,73,4,40,15,1,1,13,7,8,14,43,52,48,37,18,8,7,25,43,53,46,71,93,103,102,98,91,73,45,10,4,3,24,89,100,81,16,2,66,102,54,11,30,22,6,1,31,47,3,1,25,46,19,9,23,7,10,28,29,1,5,56,148,132,116,76,64,78,98,130,142,120,59,7,26,136,212,208,195,198,195,206,187,143,78,45,119,231,246,254,204,124,37,21,89,202,253,252,253,247,242,253,248,244,126,38,231,252,245,247,249,253,253,253,252,249,249,251,251,249,249,247,175,154,251,249,247,248,252,250,251,251,249,247,251,251,248,250,248,247,164,112,214,187,62,1,7,1,1,25,89,35,6,74,69,1,4,0,8,2,1,0,5,1,4,1,49,128,109,105,72,52,86,115,140,151,148,147,146,150,155,156,150,145,151,151,150,151,151,151,152,152,152,152,152,152,152,152,152,152,153,131,95,63,46,44,53,66,87,113,139,161,174,171,162,161]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,251,250,169,8,4,30,49,76,1,25,8,3,1,4,9,45,89,104,89,76,87,95,85,56,33,6,3,6,5,19,59,103,98,85,74,34,7,2,24,85,96,105,64,2,28,103,70,2,31,46,33,5,7,49,54,5,1,8,29,36,34,28,7,15,25,30,2,3,76,134,97,32,12,0,0,8,24,60,96,124,124,59,1,53,169,217,184,183,151,188,235,244,173,76,31,109,231,254,252,214,145,62,1,51,179,251,247,253,246,253,252,248,125,38,167,253,243,251,240,248,249,251,252,252,252,250,248,252,252,202,169,252,246,250,252,244,218,202,211,228,243,250,249,251,250,250,235,83,116,221,183,63,0,8,0,1,60,88,2,28,97,30,4,4,0,0,0,1,0,4,1,3,2,41,125,111,110,108,94,92,102,141,150,148,147,146,150,154,155,148,146,151,151,150,151,151,151,152,152,152,152,152,152,152,152,152,152,155,155,153,144,127,105,84,72,53,48,42,41,64,120,154,152]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,161,18,14,30,43,80,2,10,2,4,2,2,31,100,100,79,72,56,38,44,90,103,86,64,15,2,2,1,15,63,94,97,78,16,4,21,73,100,103,90,30,2,68,96,21,7,56,45,38,3,7,62,55,1,3,2,9,21,30,36,34,24,30,28,5,17,98,119,86,1,5,4,3,5,1,1,11,31,70,103,103,34,31,146,216,183,157,83,68,166,250,253,182,74,31,112,238,250,253,229,170,70,5,64,220,249,252,242,243,253,253,168,53,76,214,251,253,249,247,245,246,247,249,250,252,252,251,205,173,252,248,252,251,234,209,180,170,193,232,250,246,245,241,251,199,29,172,207,180,34,0,4,1,18,88,53,3,76,74,1,25,8,2,5,5,2,0,1,1,1,2,28,119,114,105,104,111,98,97,139,151,150,148,148,149,154,154,149,146,151,151,150,150,151,151,152,152,152,152,152,152,152,152,152,152,153,152,151,155,159,159,155,152,154,144,142,126,76,31,20,24]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,159,11,14,29,43,82,2,3,2,7,1,6,69,104,103,100,101,86,49,5,48,108,95,103,62,3,3,2,1,17,73,102,78,5,8,64,117,102,91,42,3,22,91,42,2,52,43,27,40,4,8,81,65,6,5,2,1,1,6,16,18,29,29,7,2,54,115,106,91,53,33,28,35,33,22,11,2,3,5,21,60,97,40,26,166,208,189,172,101,26,53,149,249,253,175,66,30,133,253,253,252,234,176,55,15,132,252,253,253,240,245,253,223,138,54,115,222,253,253,252,251,251,252,247,242,250,249,185,169,252,249,252,249,252,248,246,251,251,251,251,251,247,251,243,88,70,217,200,137,1,4,0,2,43,91,13,31,94,29,32,29,1,33,44,0,1,0,1,1,1,2,16,112,115,102,71,88,107,101,127,152,151,149,148,149,152,152,149,147,151,151,150,150,151,151,151,152,152,152,152,152,152,152,152,152,146,149,151,151,151,155,164,171,172,170,163,159,155,124,80,54]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,251,251,176,3,12,28,44,85,4,1,8,16,3,17,96,101,89,67,42,31,32,2,7,87,98,97,93,29,5,9,5,6,44,95,72,2,21,95,96,68,29,4,18,66,76,2,27,71,13,30,40,4,27,99,57,1,1,3,5,3,2,3,6,8,17,1,9,80,107,103,106,98,86,92,98,88,82,80,68,40,1,7,1,19,33,15,54,207,195,193,205,164,95,21,40,146,251,252,162,46,43,165,250,253,253,229,139,18,43,180,251,253,251,248,251,253,210,126,81,110,137,168,192,215,238,250,252,250,252,170,169,249,246,246,251,248,251,251,245,241,243,246,247,244,251,181,24,193,210,169,33,0,3,1,1,69,67,5,61,70,17,64,16,3,69,65,3,0,0,1,3,1,1,14,108,115,110,62,71,115,100,112,152,151,151,148,149,151,151,150,148,150,151,151,150,151,151,151,151,152,152,152,152,152,152,152,152,155,153,152,156,155,143,123,106,113,134,162,177,159,118,98,111]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,253,160,13,10,32,33,90,5,1,15,30,5,28,101,97,68,39,27,9,2,12,6,49,113,93,97,57,3,4,1,3,41,104,62,2,44,87,27,3,3,34,65,94,32,2,77,59,1,46,24,3,62,97,25,3,3,1,1,3,1,1,3,1,6,3,36,94,103,109,111,100,106,106,100,98,106,104,94,92,83,34,1,2,5,3,6,107,220,190,187,197,197,169,97,36,44,149,252,245,126,37,67,207,252,252,253,208,98,18,51,165,249,251,252,253,249,248,208,159,144,127,132,171,220,248,252,250,252,164,163,250,249,247,251,248,248,221,190,200,237,251,249,245,217,61,124,231,195,68,1,5,0,1,15,93,24,18,90,34,47,56,2,34,80,55,14,0,0,1,2,1,1,22,111,119,114,67,61,114,97,107,149,153,151,149,148,150,150,149,150,150,150,151,151,151,151,151,151,152,152,152,152,152,152,152,152,153,146,145,153,157,140,103,71,54,38,33,48,80,114,122,110]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,251,168,10,5,30,26,92,5,1,20,39,3,38,102,94,93,91,88,60,4,7,4,27,91,98,96,78,5,2,8,3,62,115,45,3,61,47,5,22,61,91,94,79,4,38,102,26,1,49,8,14,92,68,5,2,2,6,3,1,5,2,4,8,1,5,66,107,101,76,58,49,46,45,59,77,83,90,103,107,106,82,35,2,8,15,0,16,162,214,195,193,187,195,196,168,109,38,69,182,252,218,107,25,106,238,253,253,241,197,110,36,33,100,185,253,253,250,253,250,250,247,246,246,248,250,250,249,246,181,158,252,250,249,248,251,249,237,233,243,251,246,239,227,145,84,226,226,113,1,2,3,1,5,55,78,3,47,81,24,73,31,1,63,65,54,16,0,0,3,1,2,1,38,121,119,114,73,51,112,97,106,140,152,153,150,148,148,149,151,150,150,150,151,151,150,151,151,151,152,152,152,152,152,152,152,152,153,153,152,151,150,151,153,157,145,136,111,61,25,28,64,107]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,251,254,253,11,14,27,27,92,5,1,22,41,1,48,107,97,97,96,92,97,30,2,4,2,46,109,95,90,29,6,2,12,79,105,27,15,67,11,34,87,102,93,100,54,5,72,83,2,7,51,10,30,95,26,2,2,21,62,53,9,1,5,3,1,1,23,98,104,70,12,3,3,5,6,5,5,7,19,32,44,66,71,53,1,1,53,39,4,37,188,206,189,197,193,188,196,200,177,117,70,119,222,248,191,77,39,138,253,253,247,249,222,163,87,45,49,115,209,253,253,249,246,252,253,251,248,248,250,248,215,165,250,242,249,249,243,247,246,245,247,245,239,239,208,129,180,242,169,24,0,0,1,5,13,93,35,12,82,33,51,58,2,19,89,32,53,24,1,0,4,1,3,1,50,130,112,116,84,49,115,97,100,131,152,153,150,148,148,149,151,152,150,150,151,151,150,151,151,151,152,152,152,152,152,152,152,152,145,148,152,152,153,152,153,154,156,160,157,142,105,63,58,79]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,254,249,16,0,40,24,93,4,1,30,40,2,51,108,99,101,96,95,95,47,2,6,3,6,67,103,91,56,2,2,46,104,81,14,40,54,24,90,99,90,101,94,32,5,104,45,1,26,43,2,65,79,2,2,2,58,131,120,99,59,9,7,1,2,42,105,108,17,6,25,31,18,8,7,6,3,3,5,3,6,3,7,10,1,26,84,42,1,65,207,196,186,198,187,188,183,180,172,192,172,171,214,249,239,170,54,64,221,253,246,248,253,240,221,161,90,38,75,193,250,253,245,241,238,252,252,243,250,232,217,228,232,231,243,245,240,243,246,245,244,240,233,198,172,219,212,91,2,0,5,3,4,53,89,7,33,68,23,72,9,2,56,85,9,53,24,0,2,3,1,2,1,42,130,112,117,88,60,115,99,91,132,154,151,149,148,150,150,150,152,150,150,150,150,151,151,150,150,153,153,153,153,153,153,153,153,147,150,150,151,153,155,154,151,150,153,157,134,105,104,106,102]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,255,254,251,24,0,38,30,91,5,1,24,40,2,53,107,97,98,96,98,95,44,4,2,6,6,23,92,99,57,9,15,81,94,62,12,70,15,36,74,84,99,94,88,22,35,93,9,2,35,13,18,94,50,2,15,4,69,160,144,147,131,80,1,1,1,50,131,74,3,67,100,87,92,93,89,85,83,78,70,59,55,45,34,15,1,9,38,91,38,0,102,221,193,189,189,191,146,127,89,90,152,215,234,247,252,253,228,127,40,161,253,252,253,252,253,253,253,205,112,27,93,224,246,253,253,242,249,252,251,241,227,214,206,213,229,228,226,228,228,232,239,234,219,197,201,203,179,14,2,3,1,1,7,90,61,3,62,38,45,42,6,13,82,72,5,47,25,0,0,2,1,2,1,23,114,117,115,97,84,103,99,97,129,153,151,149,148,150,151,151,153,150,150,150,150,151,151,150,150,152,152,152,152,152,152,152,152,149,149,151,155,155,153,150,150,156,151,150,127,104,101,104,105]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,255,252,253,35,0,38,38,89,5,2,18,42,2,54,106,98,99,98,97,96,44,7,1,15,16,2,58,99,74,2,33,102,79,32,66,58,6,14,17,51,93,99,81,3,58,70,6,16,29,2,54,96,13,2,18,3,58,155,140,148,147,84,1,1,5,66,140,44,30,110,90,100,96,82,63,54,58,66,68,77,69,61,43,14,1,2,2,39,85,39,0,162,209,188,201,187,161,93,155,72,13,33,122,219,249,251,249,245,191,94,149,240,247,249,250,247,252,249,248,191,72,16,89,168,209,252,249,245,242,239,228,216,213,201,179,179,189,201,206,207,210,207,198,188,207,195,99,0,3,1,5,2,45,106,37,4,68,27,57,13,2,23,102,53,2,41,24,0,0,1,1,3,1,5,87,117,116,107,105,96,98,102,130,153,151,148,148,151,151,151,153,150,150,150,150,151,151,150,150,152,152,152,152,152,152,153,153,151,151,151,150,151,151,152,153,150,146,147,123,96,106,117,107]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,255,252,253,49,0,42,43,88,6,1,17,45,1,52,106,100,98,100,95,97,47,1,3,15,53,4,20,96,85,5,12,81,99,85,72,3,17,49,54,71,91,100,63,2,75,30,2,16,8,11,86,71,2,12,40,2,49,151,149,147,135,34,5,2,1,75,137,22,55,112,95,98,64,27,8,2,2,3,8,10,8,12,7,1,2,7,1,1,45,82,17,52,211,180,187,203,182,125,101,204,161,76,20,22,121,247,246,253,247,239,202,214,239,250,250,251,248,253,250,251,243,169,97,63,65,86,213,251,231,227,217,160,91,58,54,74,100,142,180,195,195,191,190,195,191,189,31,2,0,2,6,27,90,97,23,16,57,31,56,2,1,19,98,41,4,39,21,0,5,0,1,5,2,1,56,105,115,113,107,101,96,99,134,153,150,148,148,151,151,151,152,150,150,150,150,151,151,150,150,151,151,151,151,151,151,152,152,145,151,154,152,152,155,154,151,154,155,136,104,105,108,69,31]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,253,253,69,0,47,46,87,10,1,17,46,1,46,107,99,82,95,101,96,56,1,2,12,58,31,2,68,102,45,3,6,37,47,10,10,73,97,97,103,99,96,45,15,68,3,1,8,1,35,98,41,5,28,73,3,42,146,147,146,102,1,1,4,1,77,130,10,77,107,98,60,25,1,3,18,17,7,2,1,1,0,1,1,3,4,1,1,8,71,64,0,127,218,148,189,203,187,104,78,193,205,162,95,8,26,147,234,251,251,252,252,243,252,238,251,250,249,252,247,253,246,246,224,193,112,104,215,217,190,133,93,106,145,171,179,179,184,193,197,195,193,196,191,200,131,4,2,3,3,13,74,101,91,12,23,61,23,57,1,1,13,82,37,4,39,25,0,8,1,2,4,4,1,27,89,112,117,104,107,95,100,136,153,150,147,148,152,151,151,151,149,149,150,150,151,151,151,151,151,151,151,151,151,151,151,151,153,154,153,152,152,153,154,156,153,144,108,96,103,56,38,98]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,253,253,98,0,47,51,85,17,1,16,39,1,41,107,98,62,74,106,96,66,5,1,10,37,60,4,23,95,96,51,7,7,5,4,28,90,100,99,96,102,92,30,16,32,1,4,4,1,55,92,11,3,58,85,8,39,149,148,138,46,2,6,1,5,65,116,15,102,88,31,1,1,8,28,41,39,24,12,4,3,0,0,3,2,1,1,6,2,31,94,26,9,157,192,99,175,207,185,121,58,169,219,187,167,88,5,28,85,125,174,186,222,248,252,243,252,243,248,253,247,252,249,250,225,173,139,184,198,193,175,175,192,201,197,194,198,196,193,193,193,191,191,204,189,43,0,7,6,8,39,106,96,80,5,34,66,18,63,0,0,13,75,34,3,42,44,0,5,14,6,3,3,1,7,69,99,118,106,106,97,106,134,153,149,146,148,152,152,150,150,149,149,150,150,151,151,151,151,151,151,151,151,151,151,151,151,159,153,150,153,153,148,150,155,149,106,109,114,84,81,105,115]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,253,131,0,41,59,83,25,1,11,27,1,37,105,100,59,40,96,99,70,5,0,8,40,49,21,2,40,100,95,80,55,37,5,7,55,98,99,97,100,85,16,9,8,4,2,3,4,72,63,2,13,93,87,6,29,153,151,116,5,1,2,0,1,48,115,29,87,41,2,3,6,5,0,0,0,3,6,2,0,0,1,2,2,2,2,3,2,9,86,51,2,31,173,163,81,182,209,186,136,45,152,215,184,196,168,109,77,57,58,73,71,72,196,252,245,248,252,246,246,248,244,246,210,200,190,195,192,189,189,193,195,192,187,190,197,198,196,195,194,191,193,199,97,0,0,0,12,23,67,107,100,66,5,48,61,22,66,0,1,15,80,26,3,51,71,5,0,38,17,3,3,1,1,37,86,111,107,102,101,105,136,153,149,146,148,152,152,149,149,150,150,149,149,151,151,151,151,151,151,151,151,151,151,151,151,149,150,152,153,155,153,149,144,128,102,102,108,104,111,111,104]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,251,154,0,35,66,81,32,1,6,17,1,36,104,103,69,13,81,104,70,1,4,17,42,34,24,4,5,39,94,99,100,90,50,6,18,49,80,99,96,90,15,2,1,12,18,12,34,94,31,4,29,101,86,7,31,156,145,92,7,3,4,2,1,50,121,44,73,2,2,2,1,0,0,2,4,2,0,2,1,2,2,1,1,3,0,2,2,3,65,71,1,0,42,181,129,54,201,207,187,135,34,179,207,170,197,214,193,180,176,173,160,95,21,169,252,251,250,252,248,251,243,222,207,201,200,202,200,204,206,200,201,207,209,215,202,187,186,192,193,195,205,119,0,0,3,4,45,18,92,98,103,61,5,56,57,22,68,0,3,14,85,18,3,58,91,13,0,57,28,5,5,0,1,16,80,101,105,98,107,99,142,153,149,146,147,152,152,149,148,150,150,149,149,151,151,151,151,151,151,151,151,151,151,151,151,152,156,147,132,136,154,158,150,112,101,103,109,109,107,100,103]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,253,252,252,9,28,72,77,45,1,3,7,1,31,96,108,80,22,78,101,66,10,13,20,44,25,7,6,2,6,26,91,98,96,78,6,15,37,60,87,97,89,24,3,12,58,74,77,94,74,18,7,40,102,86,10,26,147,132,90,36,8,6,3,2,48,126,57,58,2,1,0,6,3,0,4,3,1,6,12,24,26,17,13,5,0,1,0,8,0,41,102,48,2,5,63,202,109,52,194,209,188,85,66,220,168,112,138,222,194,203,201,197,189,96,6,155,249,250,250,247,242,226,208,199,192,190,190,191,184,190,190,178,170,156,132,105,133,194,191,197,209,121,0,3,0,4,43,47,23,104,95,101,53,4,70,52,15,68,2,2,27,89,5,2,64,94,13,6,53,94,28,15,2,5,9,74,107,88,89,107,104,142,151,150,148,148,149,149,151,150,148,148,149,150,151,151,150,150,151,151,150,150,151,151,150,150,148,153,149,124,89,70,85,114,124,122,114,114,108,116,110,115]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,251,253,252,251,44,4,78,74,50,2,4,2,3,14,96,100,89,35,84,101,59,20,17,19,34,38,5,1,8,1,27,88,102,98,74,13,9,62,90,95,97,96,52,6,12,65,106,97,80,29,49,9,40,108,78,9,30,129,119,82,67,17,2,7,3,53,136,71,50,1,2,3,0,2,6,0,0,3,3,1,5,13,12,3,0,0,3,3,0,5,4,80,121,56,3,4,84,212,108,61,189,203,159,19,151,214,156,54,105,196,163,185,201,195,190,94,1,89,161,162,145,113,76,47,26,18,21,17,24,12,9,17,20,24,33,67,122,192,198,193,208,112,1,1,0,4,12,75,28,28,103,97,90,48,3,72,55,13,71,1,2,29,91,6,1,73,94,13,1,23,87,83,61,32,3,3,66,124,72,56,118,105,141,151,149,148,147,149,149,150,151,150,150,150,151,151,151,150,150,151,151,150,151,151,151,151,150,152,155,154,156,148,119,60,13,9,54,106,139,122,118,118,97]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,254,253,253,251,59,4,73,69,63,1,4,2,5,2,86,104,97,69,98,97,45,13,12,6,13,21,12,4,8,42,88,102,96,96,77,4,2,54,87,95,96,102,73,9,5,52,108,89,34,29,77,4,50,100,82,11,38,122,113,104,59,1,2,15,4,58,149,91,37,1,3,5,0,1,6,0,7,20,20,20,3,0,2,0,0,2,0,4,0,0,3,24,87,132,76,7,0,101,213,120,100,199,201,96,50,221,189,164,49,93,153,96,163,216,185,193,101,7,0,0,0,0,4,48,93,116,123,120,118,115,118,128,133,143,169,183,199,191,197,213,99,0,3,1,0,4,29,94,11,40,107,91,70,40,2,76,57,9,76,2,3,29,91,10,0,81,89,4,1,1,7,14,16,10,0,4,86,126,46,48,120,105,144,151,150,149,149,148,150,150,152,150,150,151,151,151,151,151,151,152,152,152,152,152,151,151,151,150,152,150,151,154,161,148,103,32,4,6,65,102,138,114,29]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,252,254,247,253,98,16,70,63,77,6,1,7,1,4,68,109,92,104,84,28,3,5,1,4,5,14,44,45,27,61,85,99,108,96,90,11,8,19,28,31,57,103,91,26,3,48,105,51,2,75,80,3,60,93,78,9,54,145,123,67,7,1,10,25,4,57,157,109,26,2,4,4,1,2,17,40,54,49,36,7,8,5,1,8,26,24,5,0,0,2,2,1,16,72,108,93,29,0,91,206,153,154,207,164,31,127,222,192,156,54,98,119,43,148,220,195,191,169,118,86,92,104,132,163,182,195,198,205,209,225,218,206,210,205,198,190,196,198,204,88,0,1,0,3,3,1,58,88,7,54,108,73,48,33,3,80,55,5,83,13,2,24,85,15,0,83,82,3,6,0,0,0,0,2,2,28,109,118,32,59,117,102,146,150,150,150,149,148,149,150,152,152,152,152,151,151,152,152,152,152,152,152,152,152,151,151,151,147,150,155,156,145,151,159,133,108,61,3,1,20,36,23,4]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,250,253,122,2,56,59,73,32,1,10,1,6,53,108,96,73,21,5,20,27,18,2,2,15,60,99,63,25,2,34,93,100,92,20,2,6,7,2,15,88,99,40,4,61,98,18,16,103,66,3,67,97,67,11,83,113,74,4,1,7,6,34,3,52,158,118,18,3,5,4,1,0,8,18,17,6,0,2,0,0,14,35,39,29,22,9,3,6,1,2,2,1,35,81,102,61,0,63,205,188,182,203,127,15,170,224,194,144,101,134,117,32,112,221,204,187,197,196,192,184,184,180,177,174,155,124,102,120,147,158,168,177,188,185,195,184,64,0,0,2,0,19,2,2,87,74,5,70,102,45,33,29,5,84,48,3,89,32,1,15,71,22,0,79,81,2,4,25,83,82,63,52,52,88,112,114,23,75,114,103,143,150,151,150,150,149,149,151,152,152,152,152,152,152,152,152,152,152,152,152,152,151,152,152,152,155,150,150,156,149,150,151,125,114,124,51,1,3,3,4,1]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,254,252,253,249,165,0,37,60,55,67,3,5,1,2,43,111,92,35,28,78,98,93,81,62,9,2,51,95,87,92,51,8,28,100,102,47,3,2,2,6,4,82,102,36,5,76,80,5,50,109,44,4,82,99,74,28,66,33,5,2,5,3,1,38,3,49,156,119,13,3,6,11,0,2,8,1,0,2,7,2,0,1,21,30,12,1,1,1,6,1,6,1,1,8,4,7,49,96,72,6,54,203,212,191,194,95,25,186,214,198,168,165,183,123,19,61,183,215,202,193,198,191,182,160,153,177,189,162,115,77,76,111,154,178,188,203,142,31,0,0,0,2,35,43,1,16,94,55,3,88,96,20,31,30,7,86,40,5,93,48,0,7,50,24,2,70,81,2,3,67,91,70,95,87,104,118,119,99,20,95,105,107,140,150,151,151,150,149,149,151,151,153,153,152,152,152,152,152,152,152,152,151,151,152,152,152,152,157,154,155,152,148,145,131,108,106,109,72,4,2,9,2,5]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,249,252,254,253,248,35,23,68,39,82,13,1,4,1,30,107,80,64,99,105,93,103,102,97,78,8,23,104,73,65,98,78,23,78,95,65,11,4,3,2,33,97,93,19,23,95,59,5,76,103,20,16,98,97,77,25,14,1,1,6,0,4,6,37,3,50,155,115,10,1,7,16,7,0,0,3,5,2,0,0,0,0,5,37,62,48,18,2,8,1,3,1,1,1,19,30,4,36,111,86,8,47,190,208,193,188,84,16,157,221,206,185,189,201,151,47,10,103,199,199,196,184,196,192,165,173,197,194,191,186,185,185,194,205,204,125,26,0,0,5,6,32,85,47,1,32,91,33,9,101,79,6,40,32,7,89,34,9,92,60,0,4,25,17,1,53,74,4,7,76,41,8,71,91,110,114,109,87,34,111,97,108,141,151,151,151,150,149,149,149,151,153,152,152,152,151,151,151,152,152,152,151,152,152,152,152,152,147,148,153,150,155,149,116,101,115,112,68,3,6,4,1,50]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,255,255,254,247,253,81,0,75,33,79,23,2,6,3,17,94,97,96,101,68,28,25,58,100,97,42,12,88,59,16,72,73,61,68,107,85,2,4,2,40,94,101,56,3,55,105,21,11,96,89,3,38,104,100,57,2,7,1,10,0,8,0,9,35,5,53,156,111,8,1,7,40,54,32,1,1,3,0,3,0,1,3,0,7,44,86,102,70,27,1,6,0,4,0,0,42,29,2,91,141,98,8,42,190,209,195,185,101,15,82,193,222,187,191,203,186,108,5,35,181,212,197,187,197,192,190,190,193,194,191,195,204,218,181,91,6,1,0,2,4,36,76,97,29,2,43,94,20,28,104,56,2,48,34,7,91,31,11,91,65,1,3,8,8,1,40,66,4,9,56,35,2,30,100,118,110,73,94,54,109,102,104,144,152,152,152,151,150,149,149,149,153,152,152,151,151,151,151,151,152,151,152,152,151,152,153,153,149,151,158,151,152,139,104,109,111,117,46,11,21,1,41,80]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,255,252,254,250,253,123,1,66,38,62,45,4,5,1,2,77,100,94,63,6,7,17,15,76,104,73,10,83,66,3,61,59,60,82,102,85,12,5,45,107,97,64,14,7,84,87,6,38,109,62,5,66,108,87,17,1,15,39,9,0,0,0,13,37,3,63,156,92,2,2,2,12,52,58,36,13,2,4,0,3,0,0,1,8,1,10,58,94,88,28,2,5,0,0,1,19,36,2,60,145,148,109,17,34,185,208,197,192,144,40,27,135,220,187,188,199,201,149,32,9,166,218,190,199,193,198,195,192,202,212,209,179,105,34,1,0,0,2,9,61,54,95,80,7,3,53,91,5,43,103,34,2,47,28,8,88,28,12,96,63,3,1,3,2,5,16,43,2,6,35,38,19,17,109,122,87,32,101,91,101,100,102,149,153,152,151,151,150,149,149,149,150,151,151,150,150,150,149,149,149,151,152,154,154,150,153,156,153,156,149,155,148,119,105,106,115,104,28,23,27,5,84,48]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,251,254,254,253,250,148,3,49,54,58,61,2,4,1,2,41,105,93,34,20,67,65,3,47,110,76,24,70,60,5,59,59,46,100,99,82,14,22,86,63,49,20,2,35,102,59,5,55,103,35,9,101,102,30,2,12,62,52,3,2,3,0,6,35,2,70,154,72,1,2,5,2,0,5,7,0,0,4,1,4,3,0,3,10,16,11,2,22,94,71,1,1,6,3,0,12,21,2,22,87,128,128,104,24,51,220,197,188,202,183,104,22,107,222,191,146,180,213,167,46,5,139,210,190,188,181,184,193,166,122,76,24,0,6,0,3,4,7,76,37,74,100,38,2,2,76,85,4,46,96,10,3,50,18,8,86,22,16,98,65,1,1,1,0,2,7,22,0,1,19,42,27,12,117,124,87,16,84,106,100,100,110,144,153,152,151,151,150,151,149,149,150,150,150,150,150,150,149,149,153,150,154,153,151,157,153,153,155,161,162,163,141,108,103,111,119,95,4,47,22,54,66,23]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,255,252,253,252,253,251,23,21,67,46,69,3,4,1,1,16,86,102,72,81,102,81,5,18,93,95,29,69,45,4,66,56,44,110,88,88,4,26,48,29,16,2,13,64,100,27,1,81,85,11,50,108,48,2,5,52,97,45,0,1,0,0,18,29,2,83,152,42,1,1,1,0,4,7,1,1,6,5,6,0,6,2,0,1,14,29,13,1,29,92,21,1,1,6,2,3,8,9,2,17,38,59,96,104,25,82,221,193,192,196,195,133,13,108,218,163,105,177,206,175,74,34,100,164,183,194,167,91,30,0,1,10,3,0,6,0,15,99,62,19,102,81,5,2,16,85,54,2,57,80,1,6,49,8,9,81,15,20,100,62,0,1,1,0,3,2,4,1,0,4,47,41,6,119,127,91,6,59,119,103,98,112,145,153,152,151,152,152,151,150,149,151,151,151,150,150,149,150,150,150,147,153,156,154,159,148,115,84,65,96,144,139,113,109,113,122,67,3,59,18,84,36,19]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,253,254,253,254,253,253,60,1,75,43,64,3,4,3,0,5,53,104,97,101,98,75,7,5,48,105,55,61,23,11,84,40,49,112,87,67,2,26,34,41,2,5,15,92,85,4,6,59,71,39,74,55,2,5,23,88,93,28,2,7,0,0,18,23,2,95,144,16,2,6,1,1,5,0,0,7,1,1,6,7,6,0,2,2,1,10,28,9,1,66,42,1,6,3,1,1,4,1,2,3,1,7,29,95,113,12,143,211,192,189,197,199,133,3,141,221,143,115,195,197,169,150,162,200,197,121,39,0,5,17,9,0,16,18,1,14,120,101,5,51,112,35,4,3,40,68,16,8,70,50,2,7,40,1,9,72,12,19,102,55,2,5,3,9,12,1,3,2,0,0,51,53,3,109,127,98,6,43,118,104,96,106,147,152,152,151,152,152,151,151,150,151,151,150,150,150,149,150,150,150,157,147,152,158,141,145,165,156,106,39,17,43,98,122,130,111,20,29,48,37,72,8,42]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,253,253,253,250,251,116,0,71,58,56,14,2,4,0,4,20,92,99,95,98,79,3,2,12,68,92,50,4,45,95,21,47,102,74,22,7,14,42,20,2,4,48,107,33,0,1,12,22,18,21,9,1,4,56,106,76,15,0,13,4,0,14,18,5,107,126,1,4,9,1,0,1,5,27,34,29,25,1,1,1,5,2,2,2,1,3,1,8,24,65,5,1,8,17,13,21,10,6,5,1,2,1,30,110,66,47,209,198,192,189,199,187,98,27,147,187,130,159,173,164,152,146,120,63,12,0,14,37,17,16,30,27,4,3,106,151,15,13,98,89,11,4,3,58,40,5,14,68,17,2,5,24,0,7,56,13,14,100,56,4,4,1,19,25,2,4,2,0,1,50,61,2,97,128,101,10,38,120,103,97,105,147,150,151,152,151,152,152,152,151,151,151,151,150,150,151,150,152,152,148,165,156,129,86,52,59,128,167,159,70,7,7,55,125,78,6,59,26,60,42,1,62]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,254,249,254,252,252,252,160,6,41,73,48,24,2,2,0,5,2,81,109,99,100,87,11,3,6,12,70,68,7,82,87,9,59,101,45,15,18,51,56,3,4,16,99,57,4,1,7,8,5,1,1,9,5,4,58,92,46,0,0,26,4,0,22,8,18,117,98,1,1,0,0,1,20,29,44,57,71,88,80,27,4,1,1,1,7,1,2,5,0,3,54,44,8,2,8,11,17,22,12,5,5,3,6,1,51,119,26,152,208,190,197,191,199,176,85,60,102,112,135,158,146,105,41,5,3,0,28,46,9,25,65,48,8,2,74,155,45,2,70,106,56,5,10,14,65,18,22,10,41,1,0,3,11,0,4,37,12,11,95,63,4,1,1,20,30,2,0,0,0,5,47,62,2,96,130,97,7,44,128,101,99,112,143,148,150,151,152,152,152,152,152,151,151,151,151,151,151,152,153,159,145,120,152,173,149,114,55,21,41,101,136,111,34,5,41,52,33,65,10,54,12,1,70]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,254,254,253,254,247,252,42,11,82,45,29,3,1,1,1,5,68,102,87,87,96,38,6,6,1,19,66,32,97,72,4,61,93,64,91,77,79,16,4,2,59,82,1,8,0,1,0,0,3,2,1,1,5,20,39,11,0,11,39,2,2,19,1,35,117,58,3,1,7,32,55,33,13,4,5,6,29,79,99,44,4,1,6,0,0,5,5,2,2,6,69,66,21,2,4,0,1,1,1,4,1,6,0,7,104,62,117,211,195,197,200,184,168,131,110,122,148,157,121,47,10,7,0,30,48,34,3,40,92,91,31,5,25,117,78,4,46,104,89,27,5,35,31,70,7,47,10,13,2,1,1,4,0,2,19,6,11,88,69,2,3,1,11,22,1,0,0,0,4,43,57,2,107,126,91,6,55,134,102,99,113,141,147,148,151,152,151,152,153,153,151,151,151,151,151,151,152,153,152,149,109,59,101,180,176,162,113,42,6,27,120,130,42,5,48,74,46,1,37,13,4,64]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,253,253,249,252,252,252,88,1,89,48,32,10,1,0,3,3,48,107,95,74,96,68,6,2,15,3,25,58,94,66,5,71,108,99,74,47,17,2,3,29,84,12,0,19,110,125,59,3,2,0,6,3,1,2,1,1,8,9,27,0,17,10,4,50,111,23,4,6,34,91,60,7,1,1,2,7,2,25,87,96,50,3,0,6,7,0,0,3,0,1,14,82,92,74,62,56,44,21,4,1,3,2,2,2,63,94,89,197,181,169,159,153,135,150,155,143,107,57,7,0,9,46,61,57,24,4,42,100,97,77,3,5,72,81,2,23,94,96,78,5,27,49,40,73,3,65,22,2,7,0,0,3,0,0,8,2,13,82,70,2,9,4,1,12,2,1,1,1,2,43,51,2,117,122,86,6,61,134,104,99,111,143,145,148,150,152,151,151,153,153,151,151,151,151,151,151,152,153,153,158,160,121,47,38,111,173,161,112,86,20,9,99,103,10,54,87,20,0,37,38,4,50]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,253,253,137,4,54,75,18,28,2,8,1,0,39,101,95,62,62,94,24,1,7,1,9,35,90,80,16,82,95,39,2,2,4,2,12,65,28,0,58,253,253,253,252,36,7,0,11,16,0,0,0,5,4,2,2,9,14,0,11,88,87,10,2,25,82,97,27,1,0,8,0,1,7,1,31,90,107,57,10,3,7,13,17,20,4,2,3,37,88,75,57,63,63,82,56,1,1,5,1,0,39,101,102,160,156,142,143,146,153,134,74,29,2,2,14,46,64,40,48,38,3,35,98,100,93,31,7,22,92,25,7,87,99,100,46,3,72,38,55,76,4,76,39,1,2,0,3,0,2,0,7,1,12,86,67,2,11,17,1,6,2,2,0,3,1,23,40,9,112,125,98,5,49,126,96,99,118,155,151,151,150,151,151,151,151,150,156,154,152,150,150,150,152,152,150,145,156,146,141,90,22,31,110,132,113,109,33,15,83,40,68,68,6,2,60,70,4,26]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,253,253,253,19,23,84,25,35,6,7,3,0,16,94,98,70,48,86,54,2,8,1,4,10,71,96,49,76,46,7,4,3,3,3,44,28,6,63,253,250,253,252,253,121,0,3,0,12,3,0,2,1,0,4,16,12,1,1,78,115,66,8,4,39,106,72,1,1,4,2,0,1,6,2,8,32,82,112,83,30,4,2,19,38,38,28,2,2,45,71,44,21,8,32,57,40,9,1,3,4,22,104,133,143,139,144,145,145,89,16,0,1,19,44,56,53,10,26,61,6,15,83,101,96,73,7,4,59,65,7,59,102,99,85,21,17,88,26,56,76,3,77,54,3,2,0,2,0,14,30,8,4,16,89,63,3,20,26,4,5,2,8,6,7,1,3,32,13,115,121,105,5,29,125,98,99,118,153,151,150,150,151,152,151,151,150,154,153,152,149,149,150,152,152,152,149,150,161,162,166,137,49,6,39,115,126,105,17,42,65,78,33,1,14,87,85,9,12]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,253,253,253,74,0,91,45,32,23,2,0,1,6,62,95,82,51,76,70,6,1,23,1,2,27,98,73,51,7,2,7,1,1,15,20,10,42,254,250,254,254,254,250,253,11,3,4,0,0,0,2,0,19,22,9,1,14,99,155,124,38,2,14,69,105,58,2,3,0,0,7,4,1,3,6,3,17,61,93,98,77,49,23,30,26,28,19,1,3,19,11,3,2,3,23,23,0,6,0,4,27,136,132,153,138,149,139,59,0,0,16,44,40,49,29,2,19,82,60,3,60,106,97,95,29,6,40,89,39,9,101,103,99,71,4,44,96,9,60,77,3,78,74,3,2,1,0,5,48,68,4,2,22,97,66,2,34,38,1,5,2,0,6,36,3,2,5,7,98,129,112,17,10,114,104,100,117,150,150,150,150,151,152,153,151,151,151,151,150,149,150,151,152,153,149,145,101,122,160,160,158,124,63,15,18,117,128,32,26,84,65,3,2,33,102,85,16,5]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,253,253,253,133,3,48,64,12,51,4,0,5,8,25,91,89,69,77,78,6,1,46,21,4,5,74,97,37,5,5,2,1,0,12,1,40,254,250,254,251,251,254,253,253,54,0,8,2,0,5,3,16,9,6,2,53,136,141,101,36,4,5,8,71,104,47,1,3,2,1,2,1,6,24,41,44,35,32,47,61,68,74,82,76,64,57,54,33,9,5,13,10,9,1,6,14,0,0,0,0,60,149,146,145,147,135,41,0,0,7,20,9,37,35,2,19,80,101,25,12,79,102,96,81,3,28,86,92,17,36,107,93,98,52,3,72,83,3,69,76,4,76,84,2,4,1,0,16,86,71,2,1,33,102,62,1,41,44,1,2,4,6,16,70,21,0,5,2,65,138,117,44,5,87,115,100,118,151,149,149,149,151,152,153,152,152,149,150,150,150,150,152,152,154,157,152,132,80,96,155,144,115,110,102,43,69,116,15,42,118,33,2,6,43,103,85,22,4]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,253,252,253,17,17,77,23,53,14,0,3,2,10,80,95,82,84,80,17,1,45,64,3,11,42,107,56,11,2,1,3,7,0,8,251,253,253,253,254,255,255,248,252,96,10,0,2,3,0,4,1,1,31,107,143,96,40,5,3,2,9,14,73,104,35,3,5,1,1,19,55,87,104,105,107,94,74,58,38,20,14,12,12,15,11,9,10,9,17,25,35,38,19,1,0,3,5,0,5,98,152,141,144,143,59,4,3,3,4,1,19,57,16,8,77,104,66,3,49,102,103,98,42,3,58,100,70,3,60,104,94,93,22,12,95,56,3,82,72,4,74,84,2,9,3,4,32,106,43,2,4,50,102,64,1,33,45,20,29,14,1,5,75,82,1,6,1,50,133,116,75,5,57,122,97,117,150,147,149,150,151,152,152,153,152,150,150,151,151,151,152,152,153,155,156,156,149,110,111,138,101,109,108,106,94,98,6,82,110,9,12,2,46,107,91,26,5]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,253,253,85,0,59,54,52,22,0,5,1,6,49,106,92,79,54,49,1,27,92,23,2,19,85,94,36,1,2,2,7,0,99,253,248,247,254,254,255,252,252,248,152,0,1,0,2,0,1,3,69,139,111,34,1,1,6,2,26,37,11,54,101,43,1,2,16,41,65,76,67,51,44,37,28,14,3,5,6,3,4,3,3,5,1,0,0,1,3,8,7,4,0,0,8,0,0,22,132,152,145,144,74,0,1,3,0,9,10,75,42,4,57,101,100,34,7,89,106,94,80,5,17,99,98,30,3,71,101,101,82,3,38,102,26,6,93,65,4,76,81,8,20,3,3,54,99,14,1,8,63,102,61,1,34,51,35,80,91,51,3,20,96,49,2,1,39,123,116,92,5,39,120,97,117,149,147,148,150,150,152,152,152,152,150,151,151,152,152,152,152,152,152,145,153,155,152,136,108,101,107,114,106,117,59,6,116,86,2,37,1,48,107,95,30,7]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,253,249,138,5,27,54,38,59,1,6,1,3,19,99,100,76,28,56,26,10,74,68,2,7,47,109,75,9,3,0,0,36,251,250,253,249,254,249,254,252,252,251,253,5,0,4,1,0,40,108,150,87,34,52,64,67,58,74,82,32,3,50,98,40,9,1,2,12,15,6,2,6,9,2,7,22,28,30,30,25,8,5,2,1,2,0,0,0,0,0,0,0,0,0,4,0,3,61,156,139,151,75,0,4,0,5,9,2,63,71,5,30,97,105,69,4,42,107,96,103,41,3,53,109,63,2,9,71,102,97,58,3,69,89,6,27,100,55,4,81,79,25,35,2,11,79,63,3,2,21,69,88,54,1,32,42,5,41,94,97,59,1,32,68,21,1,20,119,122,92,6,44,113,101,123,150,146,147,149,151,152,152,151,151,151,152,152,153,153,152,150,150,147,157,154,148,151,135,105,100,108,116,102,116,40,21,140,54,4,55,3,36,96,97,39,6]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,252,253,254,36,1,30,29,65,13,0,8,4,10,76,100,85,33,31,74,2,39,102,29,2,14,86,93,14,2,3,0,96,250,252,251,253,254,247,254,253,251,253,85,3,0,0,44,98,136,141,111,104,125,136,145,146,127,94,36,7,2,33,110,41,1,3,7,11,16,10,3,4,2,20,35,47,61,68,71,79,72,57,21,1,2,5,6,1,0,0,0,0,4,1,0,2,7,109,163,148,77,0,0,5,5,1,2,36,89,21,3,84,101,96,41,10,86,104,99,77,8,22,101,78,6,2,4,66,106,87,33,5,86,68,2,57,103,47,3,86,80,38,45,2,29,94,20,1,7,41,71,66,56,3,18,50,27,1,32,97,99,67,7,16,30,1,20,118,132,89,6,55,107,106,128,153,146,148,149,151,152,151,150,150,152,152,152,152,152,152,149,149,152,148,151,160,156,128,98,95,58,91,114,105,18,61,139,26,16,63,4,17,85,104,50,2]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,252,253,253,111,3,9,7,54,59,0,9,2,2,46,100,96,63,6,68,33,8,89,67,2,6,51,103,23,4,2,11,154,253,253,252,253,254,251,254,254,150,84,1,4,21,109,138,143,145,140,124,94,73,104,148,147,106,21,2,10,2,65,103,32,2,12,42,66,75,81,76,55,13,5,2,7,2,3,10,14,38,37,17,8,14,13,8,4,0,4,1,0,0,3,3,0,41,150,151,62,0,0,7,0,11,1,14,90,59,3,51,105,96,80,5,34,110,94,98,29,3,83,91,26,2,12,2,60,106,76,4,39,93,31,7,81,101,20,17,99,75,73,27,2,71,59,4,1,14,46,44,67,41,0,15,23,43,50,0,25,85,106,70,29,9,1,10,115,141,69,7,86,114,100,140,155,149,148,150,150,150,150,150,150,150,152,153,153,151,149,146,147,151,156,137,114,155,120,94,101,71,43,111,96,12,108,120,9,37,67,0,8,80,109,53,3]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,254,253,248,168,17,0,1,18,79,15,3,8,3,17,89,99,89,21,31,70,5,51,96,26,2,23,96,43,6,0,39,253,252,143,36,9,16,21,17,22,9,2,0,26,111,149,143,130,105,69,40,29,69,140,149,112,21,3,1,3,51,99,87,19,5,13,14,9,12,24,40,51,75,71,66,68,74,74,64,56,43,26,13,1,7,4,17,23,19,1,2,1,5,3,0,20,123,150,47,6,9,24,0,21,11,1,56,98,22,11,76,103,92,42,3,88,97,103,60,7,52,107,54,2,2,5,7,48,108,47,3,60,99,9,19,102,85,8,36,97,91,58,2,31,83,12,1,4,16,48,26,77,23,0,2,17,30,90,43,2,21,85,108,84,39,1,10,96,138,42,5,113,103,110,148,153,149,148,149,150,149,150,149,150,152,152,153,152,150,147,146,147,150,162,155,86,44,131,104,99,107,68,93,81,32,124,104,3,61,63,1,11,73,105,68,12]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,255,255,247,254,254,248,69,2,0,7,60,54,1,7,1,2,45,104,101,59,4,73,32,10,93,72,6,6,63,74,8,0,50,254,251,19,0,0,0,9,1,1,2,0,6,39,140,140,131,135,127,114,100,131,146,147,136,67,8,1,13,67,108,110,41,2,2,3,3,4,4,2,2,8,16,43,62,62,56,46,37,38,31,5,1,9,53,73,53,34,12,3,12,13,2,1,32,116,137,45,4,19,35,6,19,50,5,19,94,75,3,29,93,91,76,15,32,100,99,88,19,4,94,93,18,7,3,2,5,62,92,20,10,87,77,3,46,107,67,3,62,101,94,32,2,65,43,2,3,5,23,30,20,77,13,1,0,4,7,92,92,42,0,18,83,109,77,38,5,75,111,15,26,123,94,123,152,153,150,148,149,149,149,149,149,149,153,153,153,153,150,148,147,147,153,150,162,156,53,34,129,112,102,97,97,84,71,133,76,3,77,51,0,9,65,110,84,13]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,255,255,254,254,249,254,152,7,0,1,16,71,9,1,3,1,9,91,99,91,20,33,63,2,54,105,38,3,22,82,32,2,51,157,76,0,11,0,5,3,3,1,0,3,4,22,84,121,141,154,152,161,151,151,145,130,110,64,1,17,80,94,80,32,4,4,2,34,71,84,85,82,52,5,4,3,2,1,1,6,2,2,1,8,43,89,66,28,14,2,17,47,35,2,7,71,123,116,26,3,29,63,4,6,80,30,1,51,103,33,3,45,98,70,56,3,72,103,101,39,3,60,103,74,2,2,17,3,20,85,63,12,22,102,44,5,63,103,43,5,82,107,64,6,34,70,2,7,9,2,19,6,29,67,2,0,8,7,8,60,108,84,43,5,1,71,91,60,16,80,75,5,73,115,95,132,153,152,151,149,148,149,149,150,151,150,154,153,153,153,152,149,149,149,148,153,148,154,140,34,32,130,120,111,108,109,94,120,53,3,86,34,0,6,59,111,90,39]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,255,250,254,252,253,250,65,4,3,1,39,34,1,8,1,6,53,105,96,62,5,55,25,17,95,89,16,3,49,69,1,62,96,5,13,0,7,1,1,4,4,3,4,1,6,9,34,51,61,75,72,59,69,75,116,128,26,2,21,38,34,6,7,3,36,88,94,92,76,68,79,82,68,11,1,7,7,1,0,0,0,6,39,67,23,6,3,2,49,66,37,8,37,85,96,63,9,2,49,79,20,2,70,85,8,5,82,76,4,6,68,93,46,39,14,99,105,54,3,16,99,98,53,6,8,19,11,75,72,43,6,43,99,23,6,75,99,16,19,98,98,23,2,60,41,5,10,23,1,6,1,29,52,1,2,0,29,22,26,97,87,82,66,10,3,33,49,50,80,29,8,102,106,105,140,156,150,152,149,147,147,149,151,152,151,154,153,152,152,152,151,151,151,155,143,155,148,159,129,26,23,104,124,113,106,110,125,39,9,94,21,1,7,50,101,91,83]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,255,255,254,253,249,254,154,0,3,5,6,22,0,4,6,6,20,98,99,92,15,28,49,2,59,114,58,7,13,70,21,63,83,2,7,8,26,53,76,53,44,31,11,1,3,4,1,2,8,2,12,48,65,108,125,50,1,6,0,5,1,14,25,48,71,54,34,9,2,5,2,13,43,39,3,1,2,0,6,3,0,7,14,18,6,2,9,80,64,14,18,69,99,63,19,3,5,66,89,40,5,46,108,56,3,30,95,26,3,35,101,67,36,30,25,76,51,6,2,55,99,90,21,3,42,43,66,76,33,34,2,74,78,2,19,101,70,2,42,110,72,4,12,68,13,7,38,46,1,6,2,18,31,5,5,0,75,38,1,71,97,63,73,87,35,32,61,82,52,4,57,113,94,116,146,153,154,152,148,145,146,149,151,153,153,153,153,152,151,152,153,153,153,147,155,143,148,155,161,131,34,10,58,101,114,115,114,22,17,93,20,1,7,35,100,96,89]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,255,255,249,252,253,254,250,77,0,4,1,0,3,1,21,23,5,64,105,98,53,12,38,2,23,90,99,26,2,43,39,55,80,9,2,7,5,40,64,96,108,100,94,77,57,49,33,14,2,3,2,6,26,43,27,1,8,3,0,1,10,8,21,15,4,1,6,5,17,42,49,48,54,44,8,1,1,1,4,0,0,0,6,1,2,17,59,77,16,50,96,81,25,3,6,35,91,81,50,19,16,92,91,22,5,62,63,2,18,81,107,33,42,29,3,21,3,5,17,87,103,71,8,11,69,87,87,18,18,20,9,86,37,2,57,98,24,3,63,102,35,2,24,74,6,1,71,65,1,7,1,7,10,1,2,36,106,67,1,27,96,91,36,31,55,78,80,74,6,20,108,108,92,129,149,149,155,152,148,144,144,148,152,154,154,150,149,150,150,152,155,155,156,149,160,146,155,150,152,144,116,76,50,76,114,112,109,22,12,93,22,1,22,16,84,101,79]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,255,253,254,252,252,254,251,182,0,3,2,1,2,2,30,62,2,31,104,96,91,9,9,18,1,53,107,46,6,29,30,57,87,7,6,6,1,8,8,26,49,74,94,102,106,92,90,80,80,61,38,13,5,1,1,4,1,0,2,0,1,5,1,2,6,3,1,1,1,12,30,37,32,13,1,1,2,1,1,0,5,0,7,1,5,3,82,67,71,99,63,17,3,8,56,102,75,41,49,3,67,108,67,3,22,82,10,4,58,107,83,18,53,26,2,5,1,3,39,108,92,48,3,68,101,76,11,4,34,4,40,72,3,26,93,59,2,10,72,82,5,2,20,83,10,7,68,72,5,1,1,1,1,5,4,71,90,84,23,0,72,98,67,57,82,85,76,12,3,83,112,94,104,140,147,151,149,151,147,143,143,148,152,155,155,149,149,149,150,152,155,156,158,167,148,149,151,153,150,145,112,111,110,114,114,113,105,8,24,106,25,2,48,5,50,99,91]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,250,255,252,108,4,0,7,0,8,17,102,31,4,76,109,97,58,4,5,5,11,80,70,1,11,22,37,100,42,3,1,4,6,2,4,4,2,13,39,85,103,109,98,98,96,98,96,87,81,76,64,51,42,28,12,6,10,16,19,20,19,12,5,3,1,12,4,4,0,5,0,1,3,0,4,0,1,0,1,6,3,51,92,75,80,29,10,2,54,106,82,22,63,23,21,106,92,27,9,61,51,4,41,101,95,68,5,68,30,2,4,2,14,54,104,80,5,29,96,84,11,2,54,29,3,60,24,3,67,73,6,1,10,68,49,1,2,12,85,21,2,64,77,1,2,0,0,2,3,21,87,68,88,36,2,44,98,77,81,77,75,23,4,60,110,95,95,119,144,150,148,148,150,150,151,151,151,152,151,151,151,146,151,152,150,158,147,110,125,161,168,154,154,153,132,105,102,105,98,103,113,109,5,17,112,28,2,74,32,7,55,101]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,249,253,255,255,252,255,252,20,3,4,2,7,19,90,77,6,28,103,95,92,43,6,3,6,32,80,8,5,13,21,99,61,2,1,1,0,16,18,15,15,9,1,16,39,75,89,96,96,84,78,82,84,84,91,101,102,98,85,67,61,71,85,92,84,75,59,37,12,1,1,1,3,0,1,3,1,2,9,24,12,11,1,0,1,24,91,75,71,37,2,26,93,94,22,37,69,5,72,101,68,2,24,79,7,22,92,102,89,36,3,95,38,2,5,26,18,54,106,45,5,60,103,31,5,47,69,1,20,47,1,39,87,13,1,4,12,53,34,1,5,8,74,42,1,57,75,1,2,0,0,2,0,42,92,58,75,35,0,37,93,86,72,81,34,3,28,125,98,94,105,131,147,146,146,152,150,150,151,151,151,152,151,151,152,150,153,153,149,155,148,123,75,78,114,158,155,147,140,104,102,97,83,92,110,103,15,36,122,45,1,64,78,12,8,57]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,255,250,254,255,252,255,148,7,12,10,1,5,75,100,39,3,71,107,98,89,47,5,1,6,56,27,5,2,17,88,72,2,1,8,3,0,2,12,7,7,1,3,5,14,16,19,12,10,5,2,4,15,25,29,40,55,70,73,65,50,34,23,20,24,31,37,37,23,12,4,1,0,0,2,3,24,28,12,0,0,19,25,5,2,74,81,87,47,3,58,111,71,3,74,35,12,99,103,35,7,66,53,4,60,105,94,90,15,29,104,46,5,11,57,13,66,92,9,21,101,66,2,32,89,36,1,32,20,1,87,59,1,1,11,21,45,23,1,6,1,51,61,1,45,71,1,1,0,0,2,0,42,94,51,52,37,1,39,85,88,76,57,6,10,97,115,91,102,123,143,148,144,146,152,150,151,151,151,151,152,151,151,145,147,151,151,151,155,155,147,150,108,90,129,152,150,138,93,97,100,79,83,111,104,52,75,123,50,2,39,106,54,2,15]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,250,255,255,251,254,255,250,253,80,0,16,3,5,45,112,77,8,25,100,99,96,93,41,1,7,22,40,5,2,15,79,44,2,3,0,6,0,6,0,0,1,0,1,1,1,1,1,3,2,2,6,5,2,2,2,2,2,7,27,42,42,37,37,37,30,27,30,30,7,0,0,0,7,4,2,5,9,0,0,39,103,152,82,1,6,73,84,90,29,11,88,102,31,23,85,5,53,105,81,3,26,89,15,20,97,95,99,67,3,67,102,46,5,31,66,7,89,56,2,58,106,17,10,82,75,1,12,23,1,45,92,13,11,2,38,22,47,20,2,3,1,31,70,2,32,69,1,0,0,0,1,3,21,97,61,22,16,0,48,97,69,82,17,4,65,113,96,100,123,143,145,145,147,149,147,151,150,151,151,151,152,151,151,148,151,152,151,151,152,154,155,153,155,139,149,157,151,136,91,84,110,85,80,109,111,96,110,113,24,5,13,84,100,25,2]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,255,255,250,255,255,248,254,0,1,21,1,17,87,98,39,3,50,110,89,101,89,33,3,11,35,4,2,4,71,32,1,30,6,4,0,5,0,0,6,7,2,0,0,7,10,39,61,81,89,91,90,76,58,27,10,2,1,3,2,1,1,9,16,10,0,2,8,10,5,0,0,3,13,0,25,88,157,253,253,184,49,4,7,67,100,77,6,38,108,74,3,62,63,5,85,103,34,4,59,64,6,48,106,95,96,22,11,92,97,34,2,63,47,23,98,17,17,95,77,2,43,101,26,1,7,5,6,82,48,4,1,22,63,11,50,17,2,1,2,21,72,7,21,68,1,0,1,0,0,4,12,92,85,18,0,4,64,85,79,52,4,27,110,100,108,125,140,149,147,144,151,152,146,151,150,152,151,152,152,151,151,149,151,151,150,152,152,153,156,153,160,156,155,145,153,145,75,77,112,81,79,109,112,115,119,92,3,0,5,45,104,63,4]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,250,255,252,253,255,255,253,255,253,250,128,2,10,14,1,57,110,79,17,5,76,107,94,100,79,11,3,16,14,3,5,43,15,16,133,156,104,57,17,5,6,0,0,5,15,9,18,30,29,19,22,40,49,48,58,74,83,76,61,44,34,32,35,37,38,49,51,42,22,10,0,3,6,2,44,95,166,255,252,250,246,253,127,0,15,11,81,102,47,4,82,105,28,12,95,20,45,108,59,3,30,95,28,5,86,100,98,63,3,60,102,90,18,11,80,23,59,76,2,47,108,56,2,77,79,2,9,4,1,28,60,9,2,1,65,39,8,58,12,10,4,4,12,64,17,14,70,3,0,2,0,0,3,13,74,98,55,18,42,86,81,73,4,9,80,117,123,132,145,145,147,147,149,150,151,152,150,151,151,151,152,151,151,151,148,148,149,150,153,153,153,155,154,151,151,156,146,153,145,80,86,111,68,83,115,109,115,117,66,3,0,10,24,82,96,18]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,250,251,250,255,253,253,254,43,2,21,7,9,86,102,57,5,21,95,99,93,101,51,3,4,20,3,7,14,9,8,129,254,253,252,195,155,115,65,21,0,2,1,19,35,58,48,37,32,31,33,39,45,53,70,84,84,73,59,42,29,7,0,0,4,0,10,28,93,145,254,251,255,255,253,254,254,253,247,71,2,5,6,95,94,9,27,107,73,5,57,76,13,93,89,9,3,55,75,7,30,101,98,88,25,14,92,99,67,8,43,65,19,87,39,6,78,101,44,5,96,50,1,2,5,2,26,16,0,1,36,82,4,23,67,5,25,18,4,4,58,26,11,73,5,0,2,0,0,1,10,69,97,86,67,78,87,78,18,4,52,125,124,146,161,149,146,145,150,151,149,150,153,150,152,151,152,152,151,151,151,152,152,152,151,150,150,151,148,155,149,145,151,154,155,137,91,95,111,61,91,120,109,114,118,62,4,1,18,24,51,109,49]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,255,250,255,252,255,255,255,252,253,251,171,1,1,34,2,34,100,92,24,3,43,102,98,96,90,22,3,12,6,1,7,11,0,71,253,253,253,246,253,252,254,244,185,128,71,32,0,1,0,2,7,9,6,1,0,2,1,1,1,0,0,0,1,20,58,82,106,155,255,254,255,249,254,254,255,252,255,244,254,253,181,1,40,7,21,97,66,5,73,103,29,11,95,38,68,91,18,3,31,85,24,3,79,100,97,55,3,60,106,91,23,4,74,38,29,96,12,18,99,93,30,24,94,35,4,6,1,0,6,0,0,9,69,61,1,36,71,1,39,33,6,3,60,32,10,75,7,0,3,0,0,0,7,84,90,83,88,84,70,17,3,32,125,148,147,156,147,146,148,150,150,150,150,150,149,151,151,151,152,151,151,151,151,150,149,151,151,148,152,155,153,151,151,155,154,149,153,140,103,96,111,57,93,118,107,113,122,78,3,1,27,34,19,98,79]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,251,254,254,87,4,23,31,5,57,104,69,3,13,64,103,97,96,61,6,3,2,1,3,3,0,29,178,253,253,249,253,253,253,253,253,254,254,254,254,141,121,94,74,68,71,78,82,86,93,95,96,110,126,171,249,254,254,254,254,254,254,254,254,254,254,255,255,255,255,254,254,252,136,1,68,5,27,100,40,10,107,70,5,53,89,59,86,20,3,27,81,52,3,49,98,98,72,5,19,94,103,60,2,50,62,12,80,73,3,52,106,92,22,29,99,17,3,1,3,1,0,0,0,20,92,23,4,58,64,1,36,44,17,5,65,39,1,78,14,0,2,0,0,1,29,84,84,81,89,57,10,3,23,118,158,144,149,148,157,150,149,149,150,150,150,149,150,152,151,151,151,151,151,151,151,152,152,152,152,152,152,152,152,151,153,153,151,152,148,147,106,103,110,71,54,118,114,111,116,87,4,1,23,53,5,82,99]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,252,254,254,254,24,1,47,16,8,71,92,34,3,31,103,95,102,88,10,8,7,3,1,5,1,0,150,253,247,253,252,253,253,253,253,254,254,254,254,254,254,253,253,255,255,255,253,253,253,253,251,254,254,249,254,254,254,254,254,254,254,254,254,254,254,255,255,255,255,254,253,253,98,14,85,4,34,89,17,50,99,35,12,86,84,74,25,4,45,85,78,6,12,90,103,92,30,5,74,109,86,15,14,74,19,42,100,31,5,83,99,84,20,32,96,13,2,0,2,0,0,1,4,34,84,10,1,73,53,2,27,56,22,4,72,37,2,75,16,2,1,0,0,1,36,81,83,82,37,2,2,31,119,161,153,148,150,154,148,149,149,150,150,150,149,150,151,151,151,151,150,151,151,151,151,152,152,152,152,152,152,152,152,151,152,152,151,152,149,147,109,100,109,100,56,82,114,112,118,101,5,3,11,66,8,44,107]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,250,253,254,252,137,12,22,72,25,7,90,59,5,16,86,103,90,99,41,2,2,5,1,0,9,2,84,246,253,245,253,254,254,254,254,254,254,254,254,253,252,252,253,255,255,255,255,251,254,255,255,252,255,255,252,255,255,254,254,254,254,254,254,254,254,255,255,255,255,254,253,253,61,48,90,2,47,73,8,87,80,3,52,102,84,50,3,55,91,93,42,3,61,105,97,60,3,35,106,94,45,2,60,53,12,84,78,3,36,106,90,74,17,38,93,7,1,0,1,0,0,0,1,42,65,4,13,85,43,1,25,55,11,17,87,28,4,68,16,4,0,0,1,1,43,73,90,32,3,4,64,130,165,150,147,150,144,154,147,149,150,150,150,149,150,151,150,151,151,151,150,151,151,151,151,152,152,152,152,152,152,152,152,151,152,152,151,153,151,150,116,99,98,112,93,81,104,112,113,107,14,4,5,64,30,11,78]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,249,254,247,254,254,254,43,1,45,84,34,41,83,3,3,68,110,92,93,73,2,2,1,4,1,0,0,30,254,248,253,254,254,254,254,254,254,254,254,254,254,254,254,254,255,254,255,255,255,254,255,255,253,254,255,255,255,255,254,254,254,254,254,254,254,254,255,255,255,255,254,253,253,52,93,69,1,54,51,22,100,40,11,92,102,71,5,40,106,100,81,12,19,93,93,90,16,5,85,110,68,7,32,80,7,47,104,30,3,77,105,72,66,14,43,91,3,0,0,1,0,0,0,0,46,46,2,29,87,11,10,20,45,1,44,96,16,6,59,12,2,1,1,1,1,42,88,53,2,14,88,148,160,153,146,148,145,145,150,145,150,150,150,150,150,151,150,150,151,151,150,151,151,151,151,151,152,152,152,152,152,152,152,152,151,151,153,150,153,152,150,123,90,60,100,122,104,106,113,113,108,35,2,8,46,54,2,24]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,251,254,250,255,251,254,5,1,67,93,54,71,38,4,22,80,105,101,87,24,9,1,2,4,2,0,7,158,255,253,253,254,254,254,254,255,255,255,255,252,253,255,255,255,255,255,255,255,253,251,255,255,255,254,253,255,255,255,255,255,255,255,255,254,254,255,255,255,255,254,253,253,56,119,41,1,50,34,44,93,3,49,104,100,33,6,87,104,92,75,5,41,104,98,71,5,36,108,95,34,2,69,46,3,81,86,5,32,100,93,44,65,10,47,88,1,0,1,0,1,1,2,5,50,34,1,24,55,1,3,44,19,5,76,88,6,12,50,7,0,2,2,0,1,64,84,9,12,90,152,152,146,148,152,147,149,152,145,149,149,150,149,150,150,150,150,150,151,150,150,151,151,151,151,152,152,152,152,152,152,152,152,152,151,150,155,151,152,151,150,130,96,38,90,116,107,116,109,114,109,50,3,5,29,60,9,1]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,250,255,254,255,142,1,15,78,100,79,72,5,7,25,72,104,101,54,4,1,9,1,1,1,1,80,252,255,255,254,254,254,254,255,255,255,255,255,255,255,254,253,253,254,255,252,255,255,253,253,251,254,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,254,253,251,66,115,29,3,41,34,60,65,3,82,109,72,3,50,108,94,98,47,3,73,106,101,43,7,75,109,71,2,32,79,3,39,103,51,3,68,108,75,20,69,6,46,86,1,1,1,1,1,0,0,6,42,27,2,15,13,1,25,54,1,17,90,81,2,18,41,3,0,0,1,0,14,87,42,2,75,156,153,143,153,153,148,147,150,149,148,151,149,149,150,150,150,150,151,150,150,150,151,151,151,151,152,152,152,152,152,152,151,152,152,152,152,150,154,150,153,151,152,137,105,39,68,117,106,111,114,117,102,63,32,2,12,53,25,0]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,247,254,247,254,255,252,255,116,1,15,86,105,90,59,3,3,20,71,104,80,18,2,15,7,0,10,1,30,254,253,254,255,255,255,255,255,255,255,255,253,254,254,254,254,254,254,252,253,254,254,253,254,254,254,254,254,254,254,254,254,254,254,254,254,254,255,255,255,255,254,253,250,103,105,35,4,32,43,64,37,15,96,102,30,7,89,103,92,97,20,17,96,95,84,23,14,99,101,45,2,67,44,2,78,99,21,15,94,103,53,18,75,3,43,83,1,1,0,0,0,0,2,5,21,15,5,8,2,11,69,14,3,26,92,74,2,19,30,2,0,0,1,2,47,77,11,25,147,153,146,150,150,154,157,153,144,146,152,143,149,150,150,150,150,151,150,149,149,150,151,151,151,151,151,151,152,151,151,152,151,152,152,152,152,149,154,149,152,151,151,143,107,46,42,124,98,105,116,115,90,68,64,8,3,36,35,3]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,254,249,254,255,255,255,252,252,77,4,41,90,97,92,49,6,4,27,86,103,58,1,9,45,0,1,0,0,130,253,254,255,255,255,255,255,255,255,255,255,255,253,253,254,254,254,254,254,254,253,254,254,252,254,253,254,254,254,254,254,254,254,254,254,254,255,255,255,255,254,253,253,151,107,45,2,25,45,59,30,18,101,81,13,31,106,91,98,77,6,40,105,97,77,3,45,108,83,14,17,76,2,35,103,73,3,40,107,90,38,28,80,3,40,80,2,1,0,0,0,4,11,10,5,1,1,1,4,69,40,2,1,32,105,57,1,16,21,2,4,0,3,10,67,67,2,86,164,146,142,144,153,147,152,153,152,152,144,150,150,150,150,150,150,151,149,149,150,151,151,151,151,152,151,151,151,151,151,152,151,152,152,152,152,149,154,149,153,151,151,145,118,54,40,119,72,104,97,94,87,65,70,43,3,18,31,3]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,39,11,46,103,98,88,38,0,5,42,104,82,22,5,56,39,2,1,2,55,245,253,251,254,254,247,254,250,255,253,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,253,254,254,254,253,254,254,251,195,136,55,0,23,49,59,25,22,107,63,3,75,102,93,100,46,5,73,104,98,52,3,77,105,67,8,52,42,5,70,107,57,3,62,108,84,18,42,70,2,27,81,0,5,0,0,1,0,10,9,6,4,0,5,58,49,5,2,3,27,99,50,1,11,8,2,2,5,2,45,98,23,7,139,157,150,153,148,149,149,151,152,151,151,149,148,148,148,149,149,150,151,151,151,150,150,150,150,149,150,150,150,151,151,150,149,150,150,151,152,151,151,152,152,151,151,151,150,118,57,48,115,58,117,73,77,98,56,60,65,12,2,34,6]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,255,255,6,5,52,111,91,68,16,1,8,73,107,58,3,43,69,2,6,0,6,162,253,254,254,254,254,254,254,247,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,253,254,254,254,253,254,254,253,247,150,59,3,14,63,48,23,29,109,36,10,93,101,104,85,11,19,96,104,85,25,20,100,98,32,3,67,19,21,98,99,35,2,67,96,74,6,54,60,2,17,73,15,1,0,0,0,1,2,1,4,0,0,34,42,6,0,8,2,35,98,37,1,4,2,6,5,1,25,98,80,3,46,163,160,153,141,152,150,151,151,151,151,151,149,148,148,149,149,149,150,151,151,151,150,150,150,150,150,150,150,150,152,151,150,150,150,150,151,152,151,151,152,152,151,151,151,150,128,68,47,112,43,119,67,58,98,38,49,81,52,3,1,18]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,249,255,186,4,6,60,110,97,51,1,3,26,101,90,19,22,80,17,8,1,5,62,250,249,248,251,254,244,254,255,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,255,254,254,253,254,254,253,252,165,65,2,11,51,58,21,28,99,14,31,103,99,95,45,3,52,106,101,65,4,51,110,67,3,36,61,2,45,111,66,7,4,72,80,64,2,70,46,5,8,57,39,1,3,0,5,0,0,0,0,3,5,14,1,5,8,1,2,47,67,11,3,0,1,0,1,11,76,95,5,29,126,163,150,153,151,141,150,151,151,151,151,150,149,149,150,150,150,150,150,151,151,151,150,150,149,149,150,150,151,151,152,152,150,150,150,150,151,152,151,151,152,152,152,151,151,151,138,85,60,103,30,114,64,41,101,51,14,68,80,39,3,2]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,255,251,254,150,0,12,68,108,91,48,4,7,40,105,43,2,79,50,0,5,0,12,169,254,254,253,250,254,251,255,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,255,255,254,253,254,254,252,250,160,86,6,0,46,74,20,28,87,7,51,106,97,53,9,10,83,104,95,34,9,90,98,25,3,61,23,6,82,80,22,1,12,72,64,54,3,80,33,4,3,33,51,3,3,2,0,0,4,3,0,3,5,0,1,0,1,0,3,21,26,2,2,0,0,2,16,37,93,7,34,108,158,151,155,152,155,143,150,151,151,151,151,150,150,149,150,150,150,151,151,151,151,151,150,150,149,149,150,150,152,152,152,152,151,150,150,150,151,152,151,151,152,152,152,151,151,151,145,103,83,92,23,108,64,37,101,58,18,20,97,69,39,4]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,255,255,255,255,132,7,6,60,102,104,71,37,3,65,89,4,38,86,0,4,0,9,73,254,252,252,252,254,254,255,253,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,254,255,254,254,254,254,253,253,165,107,23,0,32,82,29,33,79,3,64,109,75,10,2,31,100,103,72,3,48,108,54,1,22,32,3,25,83,19,1,2,11,59,54,42,4,79,21,0,2,9,42,5,0,3,1,4,0,0,3,0,0,5,4,5,0,0,3,3,2,1,2,13,37,47,2,52,42,29,115,143,157,152,153,151,144,153,151,152,152,151,151,150,149,148,151,151,151,151,151,151,150,150,149,149,149,150,151,152,152,152,152,152,152,152,150,150,151,152,151,151,152,152,151,151,150,151,148,122,96,89,20,107,65,38,94,60,51,6,56,91,72,38]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,255,251,254,127,5,2,45,68,105,100,67,32,62,45,4,65,28,0,4,0,13,174,254,250,254,249,253,255,253,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,254,255,254,254,254,254,253,252,174,125,67,0,4,73,58,33,62,3,77,101,31,2,6,51,110,87,31,10,88,78,4,2,18,8,3,27,32,0,1,5,1,35,45,32,8,83,18,0,1,0,22,5,0,2,5,5,3,5,4,1,4,3,6,6,0,7,9,4,18,49,71,70,85,41,6,38,23,106,126,148,155,153,146,150,141,150,151,151,151,151,150,150,150,150,151,151,151,151,151,151,150,150,149,149,149,150,151,151,152,152,152,152,152,152,151,150,150,151,151,151,151,152,152,152,152,150,149,139,100,95,18,96,72,33,95,62,63,29,5,63,93,75]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,255,249,254,255,255,251,154,15,2,19,40,88,107,80,63,64,21,4,31,3,1,0,1,66,251,254,254,254,253,251,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,254,255,254,254,254,254,252,253,195,157,131,13,2,41,81,37,41,4,80,85,2,7,6,70,106,52,3,50,84,27,0,7,0,2,0,7,0,9,5,5,1,13,29,23,12,85,20,1,1,0,6,4,2,2,2,5,23,32,10,2,7,1,5,2,7,3,2,42,81,81,74,79,62,1,15,4,69,125,139,154,146,149,149,147,148,148,151,150,150,152,151,150,150,151,150,150,150,150,150,150,149,149,150,150,151,151,151,151,152,152,151,152,152,152,152,152,150,151,151,151,151,152,152,151,152,152,152,150,113,100,27,62,89,24,99,59,68,67,7,4,62,86]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,255,255,254,255,255,254,186,53,4,1,19,65,103,98,82,70,18,4,10,1,1,2,7,159,254,254,250,254,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,255,255,255,254,254,254,254,248,251,180,173,58,6,17,82,47,31,3,68,75,3,2,7,82,92,26,4,83,50,1,5,0,0,6,6,0,11,0,8,9,6,1,14,15,10,80,25,6,1,8,1,1,6,3,3,1,11,40,38,6,0,4,5,2,2,2,17,71,79,75,78,68,7,3,4,53,111,133,151,146,152,151,146,148,155,152,150,150,151,151,151,150,151,150,151,151,151,151,149,149,149,149,150,150,151,151,151,151,151,151,151,151,152,152,152,152,150,151,150,151,151,151,152,151,151,152,154,155,132,100,39,28,108,19,93,75,60,66,52,5,5,54]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,249,254,95,0,4,2,49,97,104,86,83,19,3,5,2,6,5,41,251,254,250,254,252,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,255,255,255,255,255,255,255,254,252,252,254,190,106,3,3,77,65,3,8,68,60,9,3,12,81,83,5,18,90,48,2,3,9,0,4,24,16,0,3,8,39,1,2,1,11,14,57,27,8,1,4,3,1,2,5,1,0,0,8,21,11,0,2,1,1,6,4,31,53,65,72,77,33,4,2,54,113,115,151,150,151,151,152,151,152,152,151,150,151,150,150,150,151,149,149,150,150,150,150,151,151,151,151,151,151,150,150,150,150,150,150,150,151,151,151,152,151,151,151,151,152,151,151,152,152,152,152,156,153,144,119,75,8,86,36,73,101,60,55,73,26,4,6]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,251,248,129,3,0,9,20,80,112,98,80,28,7,6,5,0,0,91,253,250,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,253,254,248,254,129,1,6,73,67,3,6,46,54,2,3,11,84,82,3,27,98,57,9,8,27,1,0,26,54,5,2,14,42,5,1,0,4,1,7,2,1,3,3,2,5,2,0,0,0,0,0,0,0,0,0,8,21,21,10,32,27,84,84,68,7,6,77,112,114,145,146,151,151,150,151,152,153,151,151,151,150,150,149,150,151,150,151,151,151,151,151,151,151,151,151,151,151,150,150,150,150,150,150,150,150,151,151,152,151,151,151,151,152,151,151,151,152,152,152,155,152,149,136,96,20,36,62,51,121,66,65,71,51,3,9]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,248,252,252,250,150,27,2,6,18,58,107,115,69,19,3,3,0,4,10,114,254,251,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,255,254,254,153,45,0,61,81,2,6,30,45,1,1,10,85,82,1,30,101,68,10,7,56,3,1,13,60,59,1,4,24,0,0,3,0,0,0,0,1,8,13,10,4,1,1,1,1,3,0,0,5,25,37,37,26,5,39,32,22,109,120,92,53,85,111,116,144,151,157,151,152,152,152,152,152,151,151,150,150,150,149,150,151,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,152,151,151,151,151,151,151,151,151,151,151,152,151,149,149,148,123,51,6,68,36,133,83,59,58,63,22,3]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,247,244,253,253,172,60,0,0,13,33,84,113,76,4,12,10,0,0,9,128,253,254,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,255,255,253,250,250,65,3,46,90,0,1,17,26,2,1,8,80,87,1,20,89,81,8,6,72,7,1,1,25,91,28,0,12,6,14,44,57,66,76,79,81,89,93,80,53,23,8,5,1,0,1,2,4,12,21,18,28,36,59,7,21,119,111,114,111,114,111,131,152,147,152,152,152,152,153,153,152,151,151,150,150,149,149,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,151,151,151,151,151,151,151,151,150,149,148,147,140,97,6,29,41,105,115,65,59,63,63,5]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,253,252,254,250,187,100,4,0,10,23,63,106,78,4,0,3,2,0,24,162,250,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,254,254,254,255,247,255,249,253,92,2,59,98,1,0,6,6,0,2,5,71,93,4,4,66,93,16,9,71,10,1,3,0,50,85,0,0,9,2,6,12,14,22,26,30,22,8,3,5,8,8,1,3,1,1,6,3,1,9,10,8,38,24,2,29,126,111,106,103,101,134,151,146,151,146,152,152,152,152,152,151,151,151,151,151,151,150,150,150,151,151,149,149,149,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,151,151,150,151,151,151,151,151,155,152,149,147,146,130,45,5,41,69,126,91,69,60,68,43]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,251,255,254,252,254,249,254,142,12,4,0,5,35,79,54,11,5,0,12,0,42,255,249,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,254,254,255,253,254,255,253,244,148,1,63,110,17,4,3,1,0,3,2,64,94,7,1,40,95,38,7,71,6,4,2,0,12,93,54,1,0,2,1,1,2,3,7,9,13,27,49,62,65,65,63,53,18,2,2,4,2,1,2,2,7,2,10,84,126,101,96,100,136,149,145,150,150,152,151,151,151,152,152,151,151,150,152,152,151,150,151,150,150,149,149,149,149,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,150,150,151,151,150,150,151,151,151,151,154,150,151,151,150,145,106,17,9,64,100,116,84,63,62,69]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,253,253,255,254,251,250,254,65,0,11,0,17,34,20,3,0,0,3,2,54,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,253,254,253,255,254,253,252,35,51,161,30,1,0,3,0,3,1,63,88,5,2,15,83,64,6,70,2,5,0,1,7,47,99,39,14,45,70,87,88,80,65,61,53,44,30,20,31,56,92,109,106,79,52,37,33,36,37,41,46,67,81,113,103,102,101,122,143,150,152,151,151,151,149,149,150,151,150,151,150,151,152,151,152,151,151,150,149,149,149,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,150,150,150,150,151,151,149,151,153,153,153,148,139,72,5,48,77,115,110,78,66,55]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,253,254,254,250,254,254,252,253,252,132,14,3,0,9,19,17,1,1,0,2,4,66,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,254,254,254,254,254,254,255,250,254,253,246,159,74,250,56,1,1,3,1,0,1,66,81,2,8,2,68,81,10,60,3,0,6,0,0,13,81,99,86,94,88,69,47,24,20,10,2,10,42,74,100,116,112,114,117,117,114,113,113,109,107,113,113,106,108,99,100,97,117,146,151,147,148,152,157,158,148,149,149,149,150,150,149,151,151,152,151,151,151,150,150,149,149,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,150,150,150,150,149,151,151,150,150,150,150,151,151,148,158,157,150,153,147,146,118,42,17,72,84,120,91,76,60]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,254,254,252,203,91,6,0,5,20,29,7,0,3,5,2,66,254,254,250,254,253,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,168,252,76,4,5,0,0,1,1,68,78,2,3,1,59,82,4,64,7,2,1,0,5,2,62,100,79,26,26,16,4,27,18,13,55,88,102,106,105,103,101,101,102,102,101,101,100,99,97,97,102,101,97,98,98,108,146,147,148,149,151,151,152,152,151,151,150,150,149,149,151,151,151,152,152,151,150,150,149,147,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,152,151,151,150,150,150,150,150,148,153,147,154,150,145,151,138,92,15,73,66,120,98,97,78]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,254,254,253,247,172,63,1,5,8,15,13,3,0,0,5,45,250,254,252,253,254,250,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,114,0,4,6,4,1,4,74,68,0,1,3,59,80,6,53,16,6,0,2,1,2,84,82,5,30,54,15,92,81,14,92,121,109,104,105,106,100,100,100,101,101,101,101,100,99,100,97,96,94,95,98,109,133,147,147,148,150,151,151,152,152,151,151,151,150,149,149,151,151,151,152,152,151,150,149,149,148,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,152,151,151,150,150,150,150,150,154,149,151,148,148,153,149,148,122,43,38,63,90,120,101,103]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,247,252,254,253,253,253,249,150,40,2,12,0,6,4,3,4,6,44,179,254,247,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,150,28,0,1,11,1,7,92,68,0,9,2,60,80,3,55,29,2,6,0,1,48,88,13,19,101,25,63,141,63,18,130,117,104,106,104,105,97,100,100,100,100,100,100,98,98,100,96,100,98,98,111,130,151,148,148,149,150,151,151,152,152,151,151,151,151,151,150,151,151,152,152,152,151,150,150,149,148,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,150,150,150,150,150,148,148,156,149,146,150,145,154,142,91,43,48,70,112,104,111]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,249,253,253,249,253,254,254,126,29,0,2,2,8,0,6,0,19,137,254,253,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,252,108,0,4,4,1,10,124,83,2,29,1,61,83,2,56,46,1,6,0,32,90,30,5,111,98,8,112,130,40,27,133,102,106,103,96,102,103,99,99,100,100,100,98,97,97,97,94,103,100,101,128,148,150,149,149,150,151,151,151,153,152,151,151,151,151,151,152,151,151,152,151,151,151,150,150,149,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,151,151,150,150,150,155,156,148,149,153,152,152,149,152,111,79,71,71,89,113,104]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,252,254,254,252,252,253,249,253,251,254,140,37,8,0,3,0,0,7,14,118,251,252,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,190,111,2,3,8,18,159,95,0,50,0,60,85,4,44,67,5,0,18,77,53,4,74,133,55,14,129,120,46,21,132,110,109,102,102,101,103,99,99,99,99,98,97,97,96,96,94,97,96,112,141,150,148,150,151,150,151,151,152,153,153,151,151,151,152,152,152,151,151,151,151,151,150,150,150,149,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,151,151,151,151,150,155,155,146,148,150,147,152,151,148,133,94,101,97,98,106,110]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,254,254,253,254,253,253,253,252,253,252,251,252,164,92,24,0,5,0,0,20,253,253,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,251,254,253,254,129,2,0,32,183,88,0,63,1,60,84,3,42,81,5,1,54,75,3,48,129,121,42,17,136,117,47,13,124,108,99,101,107,97,99,99,98,98,98,97,97,96,96,94,99,98,105,136,152,145,152,150,151,150,151,151,152,152,153,150,151,152,152,152,152,152,152,151,151,150,150,150,149,149,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,151,151,151,151,150,146,150,152,151,151,150,150,148,147,104,98,107,112,107,99]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,251,254,254,250,248,254,253,253,253,253,253,253,253,253,253,175,134,95,107,171,253,250,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,253,254,252,254,247,94,1,41,192,73,2,67,2,55,82,1,46,85,4,5,75,33,12,119,129,119,21,24,134,114,65,14,121,113,102,99,97,95,102,98,97,97,97,97,96,96,96,96,101,108,117,141,153,148,151,151,150,151,150,151,152,152,152,150,150,152,152,152,152,151,151,151,150,150,149,150,149,149,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,149,149,150,150,150,150,150,150,150,151,151,151,151,151,151,151,155,148,145,155,155,155,161,150,153,139,124,96,93,93,107,83]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,252,254,254,253,253,251,253,252,253,253,253,252,253,252,253,249,250,253,252,253,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,255,249,253,252,254,161,1,42,193,63,17,68,2,50,81,4,43,86,11,5,73,5,69,132,126,108,24,19,132,113,77,14,109,107,102,102,101,106,95,98,97,97,97,97,97,96,96,100,99,114,119,121,145,155,146,151,150,151,151,151,152,152,152,150,150,152,152,152,152,152,151,151,150,150,149,149,149,149,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,149,149,150,150,150,150,150,150,150,150,150,151,152,151,151,151,142,153,147,154,129,117,163,164,146,151,128,97,101,71,69,105]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,255,254,255,254,255,254,255,254,254,254,254,254,254,253,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,252,252,253,253,190,22,37,205,55,24,64,5,48,79,4,42,98,17,5,63,11,103,128,116,115,21,15,131,111,87,22,99,113,99,101,99,102,97,101,99,98,96,97,98,97,96,98,108,130,139,101,106,155,151,151,151,151,152,151,152,152,152,153,149,150,152,153,151,150,150,148,155,151,152,145,144,156,146,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,149,149,149,149,150,150,150,150,150,150,149,151,151,151,152,152,150,147,151,151,150,87,60,153,174,148,145,120,92,98,46,39]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,252,254,253,252,254,253,195,31,44,197,51,27,77,2,52,90,8,37,94,26,3,51,19,111,125,115,117,18,8,112,121,94,37,88,111,101,100,102,101,102,98,96,97,97,98,98,97,96,99,108,132,148,126,122,151,153,151,152,151,152,151,151,152,152,145,143,152,156,148,149,154,150,154,150,147,151,158,151,142,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,149,149,149,149,150,150,150,150,150,150,150,150,150,151,152,152,150,150,152,149,158,154,94,40,117,177,149,144,115,95,98,53]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,253,253,254,253,192,33,58,209,44,50,102,3,67,93,12,29,97,46,5,33,28,120,120,112,121,20,5,84,128,101,66,83,109,103,98,104,98,104,96,96,98,98,97,96,96,95,99,110,135,152,147,142,149,154,151,152,151,151,151,151,151,151,151,156,150,144,151,155,153,158,149,149,149,151,145,147,155,148,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,152,152,155,153,149,153,150,157,156,119,41,88,172,155,146,108,102,107]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,254,254,254,252,184,26,78,194,44,73,243,3,94,129,26,14,91,58,3,17,33,120,116,110,118,32,5,50,124,105,91,90,107,103,97,103,97,102,98,98,98,98,96,95,95,95,98,110,136,146,149,153,150,152,152,152,151,151,151,151,151,151,146,148,146,153,157,137,123,135,165,154,154,162,153,149,153,144,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,150,151,150,151,151,151,152,153,155,145,154,155,145,156,158,133,53,71,170,157,144,109,93]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,250,252,253,255,253,178,22,91,203,34,94,249,4,107,162,51,3,81,70,7,9,35,122,116,109,104,43,4,22,110,111,102,101,100,98,99,100,100,100,99,98,98,97,96,96,97,98,98,104,133,145,146,152,151,152,151,151,151,151,151,151,151,151,154,152,151,144,147,157,132,83,111,160,162,147,153,154,150,151,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,151,151,151,151,151,151,157,157,152,145,148,158,158,165,147,55,76,170,158,142,111]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,250,253,254,255,251,174,22,107,200,34,102,249,2,123,177,73,3,82,108,36,3,39,131,115,106,76,45,3,8,90,120,102,106,97,96,101,99,103,99,97,95,95,95,96,98,98,98,98,97,127,148,149,149,149,153,150,151,150,151,151,151,151,151,151,145,149,151,149,154,152,139,76,76,153,172,144,154,149,153,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,151,151,151,154,150,151,149,149,151,149,148,158,158,136,46,129,163,150,140]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,250,177,34,129,241,31,122,248,7,133,186,108,4,67,139,79,3,42,128,105,99,47,41,2,3,71,126,101,102,96,98,99,97,102,99,97,95,94,95,97,97,95,92,95,97,121,145,151,149,149,153,149,150,150,150,150,151,151,151,149,155,152,146,153,152,150,155,153,98,59,117,171,152,152,149,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,151,151,151,146,155,156,151,152,151,149,154,148,157,165,107,49,166,156,150]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,251,254,253,254,253,186,51,138,245,39,249,249,2,158,237,148,5,32,139,103,4,42,113,94,94,28,38,2,3,60,128,104,98,99,102,97,96,99,98,99,96,94,97,98,96,90,84,90,100,118,138,149,151,152,151,149,149,149,150,150,151,151,151,149,151,151,150,149,149,153,158,157,160,120,62,88,160,153,146,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,152,151,151,149,147,145,151,150,149,154,146,151,150,155,154,51,100,167,148]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,253,246,253,252,180,104,166,251,53,246,252,3,253,252,248,40,3,130,118,19,31,110,86,124,23,31,4,5,54,136,99,102,108,99,93,96,106,99,101,101,96,96,90,99,107,59,68,117,108,148,146,148,147,145,148,112,133,166,148,148,152,149,149,149,149,149,150,150,151,153,152,154,157,136,84,86,145,154,151,151,151,150,150,149,150,150,149,149,147,148,150,151,150,149,151,151,152,151,150,150,150,149,150,150,150,150,151,151,152,152,155,153,151,150,152,152,150,150,151,152,154,160,116,37,159,165]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,255,254,248,252,249,150,182,251,80,251,248,17,251,251,245,87,3,109,128,30,34,93,73,138,28,18,40,4,43,126,101,106,98,90,99,93,98,104,100,98,95,101,92,97,104,60,43,115,104,141,151,146,149,148,151,113,94,161,154,149,148,151,149,149,149,149,150,150,151,152,150,152,149,159,148,118,130,160,151,151,151,150,150,150,150,150,149,145,141,142,146,150,149,147,148,149,149,150,150,150,150,150,150,150,150,150,151,151,152,152,154,153,151,151,152,152,151,151,153,152,152,148,165,67,63,177]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,251,254,250,254,249,247,251,188,249,248,251,252,252,24,252,253,248,117,7,76,134,36,37,89,47,241,70,4,59,6,27,133,103,108,82,62,107,99,95,98,97,99,96,103,93,96,103,69,20,104,106,128,153,145,151,150,154,125,69,144,159,149,149,152,150,149,149,149,149,150,151,151,150,157,152,151,157,155,151,152,151,151,151,150,150,150,150,150,151,145,139,139,146,150,150,148,146,147,147,148,149,150,150,151,150,150,151,151,152,152,152,152,152,152,152,152,152,152,151,152,153,158,159,161,156,146,38,108]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,251,254,253,253,252,252,250,249,251,245,252,50,250,253,249,143,2,57,139,32,62,40,47,238,146,2,44,25,8,126,103,106,77,36,108,102,102,86,84,106,98,99,96,98,103,86,19,75,118,114,149,144,151,151,151,146,79,114,161,148,151,152,150,150,149,149,149,149,151,151,152,146,155,153,149,158,155,146,151,151,151,150,150,150,150,151,153,148,144,144,148,150,151,150,146,146,147,148,149,150,151,151,150,150,150,151,151,152,152,152,151,152,153,153,152,151,151,153,157,150,143,159,156,157,126,41]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,252,255,252,248,253,251,253,253,252,253,253,249,115,250,250,244,166,20,28,117,39,37,8,101,246,239,35,11,66,10,111,109,105,85,21,106,100,106,79,65,110,100,95,98,101,100,97,38,40,125,107,145,148,150,150,150,157,109,85,159,148,153,150,150,150,150,149,149,149,149,150,152,146,153,155,153,151,143,154,151,151,151,150,150,150,150,151,152,151,152,151,150,151,151,151,148,148,148,149,150,150,151,151,150,150,150,151,151,151,151,151,152,152,153,152,151,151,152,153,154,155,109,115,165,158,159,92]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,254,255,255,254,254,254,251,254,253,251,253,198,179,253,253,251,248,54,8,108,36,14,50,166,248,248,88,7,71,7,81,120,107,87,16,102,106,105,75,54,109,99,95,100,101,94,98,70,23,117,107,141,152,151,148,151,153,133,75,146,152,152,150,150,150,150,150,150,149,149,149,151,151,153,145,147,151,148,153,151,151,151,151,151,150,151,151,150,152,153,153,150,149,149,150,150,150,150,150,150,150,150,150,150,150,150,151,151,151,151,151,151,151,151,151,150,150,151,152,152,154,146,83,133,164,149,157]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,250,252,255,250,252,254,254,252,247,253,251,253,247,253,252,251,130,7,91,59,51,166,249,247,249,127,2,38,40,23,115,114,91,16,87,115,101,82,58,108,98,98,98,99,93,96,92,24,92,110,135,151,151,150,150,152,147,91,121,157,150,148,150,150,150,150,150,150,149,149,150,143,149,153,150,148,149,148,151,151,151,151,150,150,150,150,150,151,152,152,151,150,149,149,150,150,150,150,150,150,150,150,150,150,151,151,151,151,151,151,151,151,150,151,152,151,151,151,153,157,162,133,83,143,166,150]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,251,254,254,255,255,255,255,249,254,254,252,254,253,251,253,251,252,251,80,79,64,141,249,251,249,251,251,54,2,71,6,93,124,102,21,65,114,98,96,69,110,97,101,95,96,95,98,104,35,71,110,127,148,151,152,147,154,157,111,98,162,151,147,151,151,151,150,151,150,149,149,149,152,150,148,148,150,151,149,151,151,151,151,150,150,150,150,151,151,150,149,151,151,151,150,150,150,149,149,150,150,150,150,150,151,151,151,151,151,151,151,151,151,151,152,153,153,151,151,156,150,154,156,115,97,155,155]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,254,254,254,255,255,255,254,254,253,253,253,248,252,247,123,127,248,251,252,251,249,252,143,12,45,27,29,129,110,42,37,102,85,112,93,97,97,97,101,91,97,97,109,53,58,113,121,148,147,152,150,148,158,132,88,155,152,142,152,150,150,153,152,149,147,149,149,149,149,150,150,153,142,154,151,147,150,147,146,152,150,147,149,150,150,150,150,150,151,151,152,150,157,142,155,150,151,152,149,148,152,153,149,150,153,152,146,151,152,154,156,157,159,147,152,153,150,157,153,121,139,157]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,254,254,254,254,255,255,255,254,253,253,252,254,251,252,249,250,251,252,209,253,251,253,250,87,14,64,7,94,127,65,21,77,57,97,103,105,104,98,92,99,94,104,101,65,59,113,98,137,154,146,150,153,152,145,81,131,160,142,153,151,150,150,151,151,149,149,147,150,155,151,145,141,157,148,142,154,148,151,156,147,149,154,149,149,150,150,150,150,151,151,150,153,150,158,147,153,157,148,154,147,147,157,156,149,152,154,162,148,153,151,153,124,155,160,151,154,154,148,154,146,149,155]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,254,254,254,254,254,254,255,255,254,254,252,249,254,252,247,252,247,253,254,253,251,254,253,183,53,47,38,17,116,103,36,48,38,47,124,99,106,99,98,93,100,104,103,73,60,119,88,105,157,150,150,151,149,154,95,89,160,149,153,151,149,148,149,152,152,150,154,148,145,152,157,153,147,151,153,149,149,150,151,154,150,143,150,149,149,149,149,149,149,149,152,150,148,157,149,156,148,150,151,158,151,147,148,154,147,118,123,168,154,150,155,124,86,166,153,144,157,150,152,157,153,155]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,255,255,255,255,254,254,254,254,254,254,255,255,255,255,254,254,254,254,253,253,253,248,252,253,254,254,253,251,139,25,64,11,49,126,82,57,70,16,79,125,98,102,93,99,99,103,103,73,60,118,94,64,144,156,149,151,147,158,120,52,160,153,150,152,151,149,149,151,151,148,148,155,155,154,147,151,155,153,148,149,153,152,150,149,147,153,150,149,149,149,149,149,149,150,150,151,153,148,155,153,156,155,150,155,149,150,152,154,151,129,78,122,167,151,155,150,80,123,167,140,152,158,151,152,152,154]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,254,254,255,255,255,255,254,254,252,254,251,252,253,247,254,255,254,254,254,255,252,253,247,58,29,76,7,96,113,73,95,44,9,118,119,95,98,104,103,102,102,78,52,111,99,46,110,162,146,154,146,159,138,48,126,166,147,152,153,151,149,151,152,151,152,150,132,154,160,149,148,154,149,150,158,154,149,155,151,150,151,150,150,150,150,150,150,151,145,156,154,151,152,151,159,159,150,153,151,154,150,148,156,154,118,58,131,167,153,155,129,77,163,154,149,156,153,150,153,152]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,254,254,254,254,254,254,254,254,254,254,254,255,255,255,254,254,254,252,254,254,255,255,255,250,254,254,253,247,254,249,251,144,6,66,50,28,119,97,89,102,16,22,123,109,104,102,105,84,106,89,40,105,109,49,62,170,154,150,147,150,156,83,49,181,149,151,153,151,149,150,151,151,154,152,124,82,157,167,145,154,152,159,132,151,161,143,155,153,151,150,150,150,150,150,151,151,148,153,151,154,153,150,106,151,160,154,154,152,151,151,150,146,164,118,50,153,160,153,154,85,118,160,153,151,154,150,152,151]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,254,254,254,253,253,253,253,254,254,255,254,254,254,254,254,254,254,248,254,254,252,255,254,254,254,254,252,253,253,251,40,6,100,22,77,130,96,108,85,5,54,124,98,105,93,45,95,106,39,81,120,67,35,152,160,145,148,144,161,135,28,137,155,151,148,149,150,150,151,152,154,152,149,104,58,149,171,146,152,155,139,85,116,175,152,146,151,151,150,151,151,151,151,152,152,148,148,151,154,155,86,102,168,149,149,152,155,157,148,150,162,159,102,65,160,164,154,130,105,157,155,153,150,148,153,153]);
list.push([255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,255,253,253,254,254,253,253,253,253,253,253,254,255,254,254,254,254,254,252,253,254,254,252,255,250,254,252,250,254,254,250,253,253,130,3,49,76,17,120,105,110,120,65,7,86,114,91,94,16,68,119,49,45,119,91,27,115,157,150,147,149,148,159,71,56,160,150,143,145,150,152,152,152,153,149,156,157,103,52,111,174,153,151,158,119,52,78,168,161,151,150,150,151,151,152,151,152,149,151,147,153,150,160,126,56,154,156,159,129,124,152,152,147,152,160,163,89,87,165,157,154,147,159,148,155,147,149,155,153]);
return list;
}