QOJ.ac

QOJ

IDProblemSubmitterResultTimeMemoryLanguageFile sizeSubmit timeJudge time
#458272#8830. Breaking Baducup-team987#AC ✓402ms15748kbC++2022.5kb2024-06-29 16:30:232024-06-29 16:30:24

Judging History

你现在查看的是最新测评结果

  • [2024-06-29 16:30:24]
  • 评测
  • 测评结果:AC
  • 用时:402ms
  • 内存:15748kb
  • [2024-06-29 16:30:23]
  • 提交

answer

/**
 * date   : 2024-06-29 17:30:14
 * author : Nyaan
 */

#define NDEBUG

using namespace std;

// intrinstic
#include <immintrin.h>

#include <algorithm>
#include <array>
#include <bitset>
#include <cassert>
#include <cctype>
#include <cfenv>
#include <cfloat>
#include <chrono>
#include <cinttypes>
#include <climits>
#include <cmath>
#include <complex>
#include <cstdarg>
#include <cstddef>
#include <cstdint>
#include <cstdio>
#include <cstdlib>
#include <cstring>
#include <deque>
#include <fstream>
#include <functional>
#include <initializer_list>
#include <iomanip>
#include <ios>
#include <iostream>
#include <istream>
#include <iterator>
#include <limits>
#include <list>
#include <map>
#include <memory>
#include <new>
#include <numeric>
#include <ostream>
#include <queue>
#include <random>
#include <set>
#include <sstream>
#include <stack>
#include <streambuf>
#include <string>
#include <tuple>
#include <type_traits>
#include <typeinfo>
#include <unordered_map>
#include <unordered_set>
#include <utility>
#include <vector>

// utility

namespace Nyaan {
using ll = long long;
using i64 = long long;
using u64 = unsigned long long;
using i128 = __int128_t;
using u128 = __uint128_t;

template <typename T>
using V = vector<T>;
template <typename T>
using VV = vector<vector<T>>;
using vi = vector<int>;
using vl = vector<long long>;
using vd = V<double>;
using vs = V<string>;
using vvi = vector<vector<int>>;
using vvl = vector<vector<long long>>;
template <typename T>
using minpq = priority_queue<T, vector<T>, greater<T>>;

template <typename T, typename U>
struct P : pair<T, U> {
  template <typename... Args>
  P(Args... args) : pair<T, U>(args...) {}

  using pair<T, U>::first;
  using pair<T, U>::second;

  P &operator+=(const P &r) {
    first += r.first;
    second += r.second;
    return *this;
  }
  P &operator-=(const P &r) {
    first -= r.first;
    second -= r.second;
    return *this;
  }
  P &operator*=(const P &r) {
    first *= r.first;
    second *= r.second;
    return *this;
  }
  template <typename S>
  P &operator*=(const S &r) {
    first *= r, second *= r;
    return *this;
  }
  P operator+(const P &r) const { return P(*this) += r; }
  P operator-(const P &r) const { return P(*this) -= r; }
  P operator*(const P &r) const { return P(*this) *= r; }
  template <typename S>
  P operator*(const S &r) const {
    return P(*this) *= r;
  }
  P operator-() const { return P{-first, -second}; }
};

using pl = P<ll, ll>;
using pi = P<int, int>;
using vp = V<pl>;

constexpr int inf = 1001001001;
constexpr long long infLL = 4004004004004004004LL;

template <typename T>
int sz(const T &t) {
  return t.size();
}

template <typename T, typename U>
inline bool amin(T &x, U y) {
  return (y < x) ? (x = y, true) : false;
}
template <typename T, typename U>
inline bool amax(T &x, U y) {
  return (x < y) ? (x = y, true) : false;
}

template <typename T>
inline T Max(const vector<T> &v) {
  return *max_element(begin(v), end(v));
}
template <typename T>
inline T Min(const vector<T> &v) {
  return *min_element(begin(v), end(v));
}
template <typename T>
inline long long Sum(const vector<T> &v) {
  return accumulate(begin(v), end(v), 0LL);
}

template <typename T>
int lb(const vector<T> &v, const T &a) {
  return lower_bound(begin(v), end(v), a) - begin(v);
}
template <typename T>
int ub(const vector<T> &v, const T &a) {
  return upper_bound(begin(v), end(v), a) - begin(v);
}

constexpr long long TEN(int n) {
  long long ret = 1, x = 10;
  for (; n; x *= x, n >>= 1) ret *= (n & 1 ? x : 1);
  return ret;
}

template <typename T, typename U>
pair<T, U> mkp(const T &t, const U &u) {
  return make_pair(t, u);
}

template <typename T>
vector<T> mkrui(const vector<T> &v, bool rev = false) {
  vector<T> ret(v.size() + 1);
  if (rev) {
    for (int i = int(v.size()) - 1; i >= 0; i--) ret[i] = v[i] + ret[i + 1];
  } else {
    for (int i = 0; i < int(v.size()); i++) ret[i + 1] = ret[i] + v[i];
  }
  return ret;
};

template <typename T>
vector<T> mkuni(const vector<T> &v) {
  vector<T> ret(v);
  sort(ret.begin(), ret.end());
  ret.erase(unique(ret.begin(), ret.end()), ret.end());
  return ret;
}

template <typename F>
vector<int> mkord(int N, F f) {
  vector<int> ord(N);
  iota(begin(ord), end(ord), 0);
  sort(begin(ord), end(ord), f);
  return ord;
}

template <typename T>
vector<int> mkinv(vector<T> &v) {
  int max_val = *max_element(begin(v), end(v));
  vector<int> inv(max_val + 1, -1);
  for (int i = 0; i < (int)v.size(); i++) inv[v[i]] = i;
  return inv;
}

vector<int> mkiota(int n) {
  vector<int> ret(n);
  iota(begin(ret), end(ret), 0);
  return ret;
}

template <typename T>
T mkrev(const T &v) {
  T w{v};
  reverse(begin(w), end(w));
  return w;
}

template <typename T>
bool nxp(T &v) {
  return next_permutation(begin(v), end(v));
}

// 返り値の型は入力の T に依存
// i 要素目 : [0, a[i])
template <typename T>
vector<vector<T>> product(const vector<T> &a) {
  vector<vector<T>> ret;
  vector<T> v;
  auto dfs = [&](auto rc, int i) -> void {
    if (i == (int)a.size()) {
      ret.push_back(v);
      return;
    }
    for (int j = 0; j < a[i]; j++) v.push_back(j), rc(rc, i + 1), v.pop_back();
  };
  dfs(dfs, 0);
  return ret;
}

// F : function(void(T&)), mod を取る操作
// T : 整数型のときはオーバーフローに注意する
template <typename T>
T Power(T a, long long n, const T &I, const function<void(T &)> &f) {
  T res = I;
  for (; n; f(a = a * a), n >>= 1) {
    if (n & 1) f(res = res * a);
  }
  return res;
}
// T : 整数型のときはオーバーフローに注意する
template <typename T>
T Power(T a, long long n, const T &I = T{1}) {
  return Power(a, n, I, function<void(T &)>{[](T &) -> void {}});
}

template <typename T>
T Rev(const T &v) {
  T res = v;
  reverse(begin(res), end(res));
  return res;
}

template <typename T>
vector<T> Transpose(const vector<T> &v) {
  using U = typename T::value_type;
  if(v.empty()) return {};
  int H = v.size(), W = v[0].size();
  vector res(W, T(H, U{}));
  for (int i = 0; i < H; i++) {
    for (int j = 0; j < W; j++) {
      res[j][i] = v[i][j];
    }
  }
  return res;
}

template <typename T>
vector<T> Rotate(const vector<T> &v, int clockwise = true) {
  using U = typename T::value_type;
  int H = v.size(), W = v[0].size();
  vector res(W, T(H, U{}));
  for (int i = 0; i < H; i++) {
    for (int j = 0; j < W; j++) {
      if (clockwise) {
        res[W - 1 - j][i] = v[i][j];
      } else {
        res[j][H - 1 - i] = v[i][j];
      }
    }
  }
  return res;
}

}  // namespace Nyaan


// bit operation

namespace Nyaan {
__attribute__((target("popcnt"))) inline int popcnt(const u64 &a) {
  return __builtin_popcountll(a);
}
inline int lsb(const u64 &a) { return a ? __builtin_ctzll(a) : 64; }
inline int ctz(const u64 &a) { return a ? __builtin_ctzll(a) : 64; }
inline int msb(const u64 &a) { return a ? 63 - __builtin_clzll(a) : -1; }
template <typename T>
inline int gbit(const T &a, int i) {
  return (a >> i) & 1;
}
template <typename T>
inline void sbit(T &a, int i, bool b) {
  if (gbit(a, i) != b) a ^= T(1) << i;
}
constexpr long long PW(int n) { return 1LL << n; }
constexpr long long MSK(int n) { return (1LL << n) - 1; }
}  // namespace Nyaan


// inout

namespace Nyaan {

template <typename T, typename U>
ostream &operator<<(ostream &os, const pair<T, U> &p) {
  os << p.first << " " << p.second;
  return os;
}
template <typename T, typename U>
istream &operator>>(istream &is, pair<T, U> &p) {
  is >> p.first >> p.second;
  return is;
}

template <typename T>
ostream &operator<<(ostream &os, const vector<T> &v) {
  int s = (int)v.size();
  for (int i = 0; i < s; i++) os << (i ? " " : "") << v[i];
  return os;
}
template <typename T>
istream &operator>>(istream &is, vector<T> &v) {
  for (auto &x : v) is >> x;
  return is;
}

istream &operator>>(istream &is, __int128_t &x) {
  string S;
  is >> S;
  x = 0;
  int flag = 0;
  for (auto &c : S) {
    if (c == '-') {
      flag = true;
      continue;
    }
    x *= 10;
    x += c - '0';
  }
  if (flag) x = -x;
  return is;
}

istream &operator>>(istream &is, __uint128_t &x) {
  string S;
  is >> S;
  x = 0;
  for (auto &c : S) {
    x *= 10;
    x += c - '0';
  }
  return is;
}

ostream &operator<<(ostream &os, __int128_t x) {
  if (x == 0) return os << 0;
  if (x < 0) os << '-', x = -x;
  string S;
  while (x) S.push_back('0' + x % 10), x /= 10;
  reverse(begin(S), end(S));
  return os << S;
}
ostream &operator<<(ostream &os, __uint128_t x) {
  if (x == 0) return os << 0;
  string S;
  while (x) S.push_back('0' + x % 10), x /= 10;
  reverse(begin(S), end(S));
  return os << S;
}

void in() {}
template <typename T, class... U>
void in(T &t, U &...u) {
  cin >> t;
  in(u...);
}

void out() { cout << "\n"; }
template <typename T, class... U, char sep = ' '>
void out(const T &t, const U &...u) {
  cout << t;
  if (sizeof...(u)) cout << sep;
  out(u...);
}

struct IoSetupNya {
  IoSetupNya() {
    cin.tie(nullptr);
    ios::sync_with_stdio(false);
    cout << fixed << setprecision(15);
    cerr << fixed << setprecision(7);
  }
} iosetupnya;

}  // namespace Nyaan


// debug


#ifdef NyaanDebug
#define trc(...) (void(0))
#else
#define trc(...) (void(0))
#endif

#ifdef NyaanLocal
#define trc2(...) (void(0))
#else
#define trc2(...) (void(0))
#endif


// macro

#define each(x, v) for (auto&& x : v)
#define each2(x, y, v) for (auto&& [x, y] : v)
#define all(v) (v).begin(), (v).end()
#define rep(i, N) for (long long i = 0; i < (long long)(N); i++)
#define repr(i, N) for (long long i = (long long)(N)-1; i >= 0; i--)
#define rep1(i, N) for (long long i = 1; i <= (long long)(N); i++)
#define repr1(i, N) for (long long i = (N); (long long)(i) > 0; i--)
#define reg(i, a, b) for (long long i = (a); i < (b); i++)
#define regr(i, a, b) for (long long i = (b)-1; i >= (a); i--)
#define fi first
#define se second
#define ini(...)   \
  int __VA_ARGS__; \
  in(__VA_ARGS__)
#define inl(...)         \
  long long __VA_ARGS__; \
  in(__VA_ARGS__)
#define ins(...)      \
  string __VA_ARGS__; \
  in(__VA_ARGS__)
#define in2(s, t)                           \
  for (int i = 0; i < (int)s.size(); i++) { \
    in(s[i], t[i]);                         \
  }
#define in3(s, t, u)                        \
  for (int i = 0; i < (int)s.size(); i++) { \
    in(s[i], t[i], u[i]);                   \
  }
#define in4(s, t, u, v)                     \
  for (int i = 0; i < (int)s.size(); i++) { \
    in(s[i], t[i], u[i], v[i]);             \
  }
#define die(...)             \
  do {                       \
    Nyaan::out(__VA_ARGS__); \
    return;                  \
  } while (0)


namespace Nyaan {
void solve();
}
int main() { Nyaan::solve(); }


//










namespace atcoder {

namespace internal {

template <class T> struct simple_queue {
    std::vector<T> payload;
    int pos = 0;
    void reserve(int n) { payload.reserve(n); }
    int size() const { return int(payload.size()) - pos; }
    bool empty() const { return pos == int(payload.size()); }
    void push(const T& t) { payload.push_back(t); }
    T& front() { return payload[pos]; }
    void clear() {
        payload.clear();
        pos = 0;
    }
    void pop() { pos++; }
};

}  // namespace internal

}  // namespace atcoder



namespace atcoder {

template <class Cap> struct mf_graph {
  public:
    mf_graph() : _n(0) {}
    mf_graph(int n) : _n(n), g(n) {}

    virtual int add_edge(int from, int to, Cap cap) {
        assert(0 <= from && from < _n);
        assert(0 <= to && to < _n);
        assert(0 <= cap);
        int m = int(pos.size());
        pos.push_back({from, int(g[from].size())});
        int from_id = int(g[from].size());
        int to_id = int(g[to].size());
        if (from == to) to_id++;
        g[from].push_back(_edge{to, to_id, cap});
        g[to].push_back(_edge{from, from_id, 0});
        return m;
    }

    struct edge {
        int from, to;
        Cap cap, flow;
    };

    edge get_edge(int i) {
        int m = int(pos.size());
        assert(0 <= i && i < m);
        auto _e = g[pos[i].first][pos[i].second];
        auto _re = g[_e.to][_e.rev];
        return edge{pos[i].first, _e.to, _e.cap + _re.cap, _re.cap};
    }
    std::vector<edge> edges() {
        int m = int(pos.size());
        std::vector<edge> result;
        for (int i = 0; i < m; i++) {
            result.push_back(get_edge(i));
        }
        return result;
    }
    void change_edge(int i, Cap new_cap, Cap new_flow) {
        int m = int(pos.size());
        assert(0 <= i && i < m);
        assert(0 <= new_flow && new_flow <= new_cap);
        auto& _e = g[pos[i].first][pos[i].second];
        auto& _re = g[_e.to][_e.rev];
        _e.cap = new_cap - new_flow;
        _re.cap = new_flow;
    }

    Cap flow(int s, int t) {
        return flow(s, t, std::numeric_limits<Cap>::max());
    }
    Cap flow(int s, int t, Cap flow_limit) {
        assert(0 <= s && s < _n);
        assert(0 <= t && t < _n);
        assert(s != t);

        std::vector<int> level(_n), iter(_n);
        internal::simple_queue<int> que;

        auto bfs = [&]() {
            std::fill(level.begin(), level.end(), -1);
            level[s] = 0;
            que.clear();
            que.push(s);
            while (!que.empty()) {
                int v = que.front();
                que.pop();
                for (auto e : g[v]) {
                    if (e.cap == 0 || level[e.to] >= 0) continue;
                    level[e.to] = level[v] + 1;
                    if (e.to == t) return;
                    que.push(e.to);
                }
            }
        };
        auto dfs = [&](auto self, int v, Cap up) {
            if (v == s) return up;
            Cap res = 0;
            int level_v = level[v];
            for (int& i = iter[v]; i < int(g[v].size()); i++) {
                _edge& e = g[v][i];
                if (level_v <= level[e.to] || g[e.to][e.rev].cap == 0) continue;
                Cap d =
                    self(self, e.to, std::min(up - res, g[e.to][e.rev].cap));
                if (d <= 0) continue;
                g[v][i].cap += d;
                g[e.to][e.rev].cap -= d;
                res += d;
                if (res == up) return res;
            }
            level[v] = _n;
            return res;
        };

        Cap flow = 0;
        while (flow < flow_limit) {
            bfs();
            if (level[t] == -1) break;
            std::fill(iter.begin(), iter.end(), 0);
            Cap f = dfs(dfs, t, flow_limit - flow);
            if (!f) break;
            flow += f;
        }
        return flow;
    }

    std::vector<bool> min_cut(int s) {
        std::vector<bool> visited(_n);
        internal::simple_queue<int> que;
        que.push(s);
        while (!que.empty()) {
            int p = que.front();
            que.pop();
            visited[p] = true;
            for (auto e : g[p]) {
                if (e.cap && !visited[e.to]) {
                    visited[e.to] = true;
                    que.push(e.to);
                }
            }
        }
        return visited;
    }

  private:
    int _n;
    struct _edge {
        int to, rev;
        Cap cap;
    };
    std::vector<std::pair<int, int>> pos;
    std::vector<std::vector<_edge>> g;
};

}  // namespace atcoder



namespace BipartiteGraphImpl {
using namespace atcoder;
struct BipartiteGraph : mf_graph<long long> {
  int L, R, s, t;
  bool is_flow;

  explicit BipartiteGraph(int N, int M)
      : mf_graph<long long>(N + M + 2),
        L(N),
        R(M),
        s(N + M),
        t(N + M + 1),
        is_flow(false) {
    for (int i = 0; i < L; i++) mf_graph<long long>::add_edge(s, i, 1);
    for (int i = 0; i < R; i++) mf_graph<long long>::add_edge(i + L, t, 1);
  }

  int add_edge(int n, int m, long long cap = 1) override {
    assert(0 <= n && n < L);
    assert(0 <= m && m < R);
    return mf_graph<long long>::add_edge(n, m + L, cap);
  }

  long long flow() {
    is_flow = true;
    return mf_graph<long long>::flow(s, t);
  }

  vector<pair<int, int>> MaximumMatching() {
    if (!is_flow) flow();
    auto es = mf_graph<long long>::edges();
    vector<pair<int, int>> ret;
    for (auto &e : es) {
      if (e.flow > 0 && e.from != s && e.to != t) {
        ret.emplace_back(e.from, e.to - L);
      }
    }
    return ret;
  }

  // call after calclating flow !
  pair<vector<int>, vector<int>> MinimumVertexCover() {
    if (!is_flow) flow();
    auto colored = PreCalc();
    vector<int> nl, nr;
    for (int i = 0; i < L; i++)
      if (!colored[i]) nl.push_back(i);
    for (int i = 0; i < R; i++)
      if (colored[i + L]) nr.push_back(i);
    return make_pair(nl, nr);
  }

  // call after calclating flow !
  pair<vector<int>, vector<int>> MaximumIndependentSet() {
    if (!is_flow) flow();
    auto colored = PreCalc();
    vector<int> nl, nr;
    for (int i = 0; i < L; i++)
      if (colored[i]) nl.push_back(i);
    for (int i = 0; i < R; i++)
      if (!colored[i + L]) nr.push_back(i);
    return make_pair(nl, nr);
  }

  vector<pair<int, int>> MinimumEdgeCover() {
    if (!is_flow) flow();
    auto es = MaximumMatching();
    vector<bool> useL(L), useR(R);
    for (auto &p : es) {
      useL[p.first] = true;
      useR[p.second] = true;
    }
    for (auto &e : mf_graph<long long>::edges()) {
      if (e.flow > 0 || e.from == s || e.to == t) continue;
      if (useL[e.from] == false || useR[e.to - L] == false) {
        es.emplace_back(e.from, e.to - L);
        useL[e.from] = useR[e.to - L] = true;
      }
    }
    return es;
  }

 private:
  vector<bool> PreCalc() {
    vector<vector<int>> ag(L + R);
    vector<bool> used(L, false);
    for (auto &e : mf_graph<long long>::edges()) {
      if (e.from == s || e.to == t) continue;
      if (e.flow > 0) {
        ag[e.to].push_back(e.from);
        used[e.from] = true;
      } else {
        ag[e.from].push_back(e.to);
      }
    }
    vector<bool> colored(L + R, false);
    auto dfs = [&](auto rc, int cur) -> void {
      for (auto &d : ag[cur]) {
        if (!colored[d]) colored[d] = true, rc(rc, d);
      }
    };
    for (int i = 0; i < L; i++)
      if (!used[i]) colored[i] = true, dfs(dfs, i);
    return colored;
  }
};

}  // namespace BipartiteGraphImpl

using BipartiteGraphImpl::BipartiteGraph;

/**
 * @brief 二部グラフのフロー
 * @docs docs/flow/flow-on-bipartite-graph.md
 */







using namespace std;

namespace internal {
unsigned long long non_deterministic_seed() {
  unsigned long long m =
      chrono::duration_cast<chrono::nanoseconds>(
          chrono::high_resolution_clock::now().time_since_epoch())
          .count();
  m ^= 9845834732710364265uLL;
  m ^= m << 24, m ^= m >> 31, m ^= m << 35;
  return m;
}
unsigned long long deterministic_seed() { return 88172645463325252UL; }

// 64 bit の seed 値を生成 (手元では seed 固定)
// 連続で呼び出すと同じ値が何度も返ってくるので注意
// #define RANDOMIZED_SEED するとシードがランダムになる
unsigned long long seed() {
#if defined(NyaanLocal) && !defined(RANDOMIZED_SEED)
  return deterministic_seed();
#else
  return non_deterministic_seed();
#endif
}

}  // namespace internal


namespace my_rand {
using i64 = long long;
using u64 = unsigned long long;

// [0, 2^64 - 1)
u64 rng() {
  static u64 _x = internal::seed();
  return _x ^= _x << 7, _x ^= _x >> 9;
}

// [l, r]
i64 rng(i64 l, i64 r) {
  assert(l <= r);
  return l + rng() % u64(r - l + 1);
}

// [l, r)
i64 randint(i64 l, i64 r) {
  assert(l < r);
  return l + rng() % u64(r - l);
}

// choose n numbers from [l, r) without overlapping
vector<i64> randset(i64 l, i64 r, i64 n) {
  assert(l <= r && n <= r - l);
  unordered_set<i64> s;
  for (i64 i = n; i; --i) {
    i64 m = randint(l, r + 1 - i);
    if (s.find(m) != s.end()) m = r - i;
    s.insert(m);
  }
  vector<i64> ret;
  for (auto& x : s) ret.push_back(x);
  sort(begin(ret), end(ret));
  return ret;
}

// [0.0, 1.0)
double rnd() { return rng() * 5.42101086242752217004e-20; }
// [l, r)
double rnd(double l, double r) {
  assert(l < r);
  return l + rnd() * (r - l);
}

template <typename T>
void randshf(vector<T>& v) {
  int n = v.size();
  for (int i = 1; i < n; i++) swap(v[i], v[randint(0, i + 1)]);
}

}  // namespace my_rand

using my_rand::randint;
using my_rand::randset;
using my_rand::randshf;
using my_rand::rnd;
using my_rand::rng;


using namespace Nyaan;

vi naive(int N, const vvi a) {
  vi ans(5);
  vi p = mkiota(N);
  if (N <= 6) {
    do {
      int s = 0;
      rep(i, N) s += a[i][p[i]];
      ans[s % 5] = 1;
    } while (nxp(p));
  } else {
    rep(t, 50000) {
      randshf(p);
      int s = 0;
      rep(i, N) s += a[i][p[i]];
      ans[s % 5] = 1;
    }
  }
  return ans;
}

vi calc(int N, const vvi a) {
  vi ans(5);

#ifndef NyaanLocal
  ans = naive(N, a);
#endif

  // trc(ans);

  int Tlimit = 30;
  int Xlimit = 12;

  rep(t, Tlimit) {
    vi p = mkiota(N);
    vi q = mkiota(N);
    randshf(p);
    randshf(q);

    vi h(N), w(N);
    // h[p[0]] = 0 とする
    rep(i, N) {
      w[q[i]] = a[p[i]][q[i]] - h[p[i]];
      if (w[q[i]] < 0) w[q[i]] += 5;
      if (i + 1 == N) break;
      h[p[i + 1]] = a[p[i + 1]][q[i]] - w[q[i]];
      if (h[p[i + 1]] < 0) h[p[i + 1]] += 5;
    }

    int hwsum = (Sum(h) + Sum(w)) % 5;

    // h, w が決まる
    V<pair<pair<int, int>, int>> nonzero;
    rep(i, N) rep(j, N) {
      int x = a[i][j] - h[i] - w[j];
      x %= 5;
      if (x < 0) x += 5;
      if (x != 0) nonzero.emplace_back(mkp(i, j), x);
      if (sz(nonzero) > Xlimit) break;
    }

    if (sz(nonzero) > Xlimit) continue;

    vi useh(N), usew(N);
    rep(b, PW(sz(nonzero))) {
      int ok = 1, s = 0;
      rep(i, sz(nonzero)) {
        if (gbit(b, i)) {
          if (useh[nonzero[i].fi.fi]) ok = 0;
          if (usew[nonzero[i].fi.se]) ok = 0;
          useh[nonzero[i].fi.fi] = 1;
          usew[nonzero[i].fi.se] = 1;
          s += nonzero[i].se;
        }
      }
      if (ok) {
        if (N < sz(nonzero) * 2) {
          BipartiteGraph flow(N, N);
          rep(i, N) rep(j, N) {
            if (useh[i] or usew[j]) continue;
            if (a[i][j] != (h[i] + w[j]) % 5) continue;
            flow.add_edge(i, j);
          }
          if (flow.flow() != N - Sum(useh)) ok = 0;
        }
        if (ok) ans[(s + hwsum) % 5] = 1;
      }
      rep(i, sz(nonzero)) {
        if (gbit(b, i)) {
          useh[nonzero[i].fi.fi] = 0;
          usew[nonzero[i].fi.se] = 0;
        }
      }
    }
  }
  return ans;
}

void test() {
  rep(t, 1000) {
    int N = rng(1, 5);
    vvi a(N, vi(N));
    each(v, a) each(x, v) x = rng(0, 4);
    auto an = naive(N, a);
    auto ac = calc(N, a);
    // trc2(N, a, an, ac);
    assert(an == ac);
  }
  trc2("OK");
}

void q() {
  // test();

  ini(N);
  vvi a(N, vi(N));
  in(a);
  auto ans = calc(N, a);
  rep(i, 5) cout << (ans[i] ? "Y" : "N");
  cout << endl;
}

void Nyaan::solve() {
  int t = 1;
  // in(t);
  while (t--) q();
}

这程序好像有点Bug,我给组数据试试?

Details

Tip: Click on the bar to expand more detailed information

Test #1:

score: 100
Accepted
time: 0ms
memory: 3664kb

input:

2
0 4
4 0

output:

YNNYN

result:

ok "YNNYN"

Test #2:

score: 0
Accepted
time: 0ms
memory: 3664kb

input:

2
1 1
1 1

output:

NNYNN

result:

ok "NNYNN"

Test #3:

score: 0
Accepted
time: 1ms
memory: 3900kb

input:

4
0 0 1 0
0 1 0 1
0 0 0 0
1 1 0 0

output:

YYYYN

result:

ok "YYYYN"

Test #4:

score: 0
Accepted
time: 1ms
memory: 3672kb

input:

4
0 0 0 1
0 1 0 1
1 0 0 0
0 1 0 0

output:

YYYYN

result:

ok "YYYYN"

Test #5:

score: 0
Accepted
time: 2ms
memory: 3668kb

input:

10
1 4 2 0 0 2 0 1 3 3
0 3 1 4 4 1 4 0 2 2
1 4 2 0 0 2 0 1 0 3
0 3 1 4 4 1 4 0 2 2
4 2 0 3 3 0 3 4 1 1
2 0 3 1 1 3 1 2 4 4
4 2 0 3 3 0 3 4 1 1
2 0 3 1 1 3 1 2 4 4
1 4 2 0 0 2 0 1 3 3
3 1 4 2 2 4 2 3 0 0

output:

NYNNY

result:

ok "NYNNY"

Test #6:

score: 0
Accepted
time: 5ms
memory: 3676kb

input:

10
4 4 4 1 3 4 1 4 3 0
3 3 3 0 2 3 0 3 2 4
3 3 3 0 2 3 0 3 2 4
4 4 4 1 3 4 1 4 3 0
2 2 2 4 1 2 4 2 1 3
2 2 2 4 1 3 4 2 1 3
4 4 4 1 3 4 1 4 3 0
3 3 3 0 2 3 0 3 2 4
2 2 2 4 1 2 4 2 1 3
4 4 4 1 3 4 1 1 3 0

output:

YYYNY

result:

ok "YYYNY"

Test #7:

score: 0
Accepted
time: 2ms
memory: 3672kb

input:

10
1 2 0 4 2 3 4 0 2 3
0 1 4 3 1 2 3 4 1 2
4 0 3 2 0 1 2 3 0 1
1 2 0 4 2 3 4 0 2 3
3 4 2 1 4 0 1 2 4 0
0 1 4 3 1 2 3 4 1 2
2 3 1 0 3 4 0 1 3 4
3 1 1 1 4 0 1 2 4 0
1 2 0 4 2 3 4 0 2 3
1 3 0 4 2 3 4 0 2 3

output:

NYYYY

result:

ok "NYYYY"

Test #8:

score: 0
Accepted
time: 5ms
memory: 3608kb

input:

10
3 4 0 3 2 2 0 4 0 2
0 1 2 0 4 4 2 1 2 4
2 3 4 2 1 1 4 3 4 1
0 1 2 0 4 4 2 1 2 4
0 1 2 0 4 4 2 1 2 4
0 1 2 0 4 4 2 1 2 4
3 4 0 3 2 2 0 4 0 2
0 1 2 0 4 4 2 1 2 4
3 4 0 3 2 2 0 4 0 2
0 1 2 0 4 4 2 1 2 4

output:

NYNNN

result:

ok "NYNNN"

Test #9:

score: 0
Accepted
time: 6ms
memory: 3676kb

input:

10
4 1 3 1 2 0 3 2 4 4
0 2 4 2 3 1 4 3 0 0
1 1 1 1 2 0 3 2 4 1
2 4 1 4 0 3 1 0 2 2
1 3 0 3 4 2 0 4 1 1
2 4 1 4 0 3 1 0 2 2
2 4 1 4 0 3 1 0 2 2
0 2 4 2 3 1 4 3 0 0
3 0 2 1 1 4 2 1 3 3
4 1 3 1 2 0 3 2 4 4

output:

YYYYY

result:

ok "YYYYY"

Test #10:

score: 0
Accepted
time: 5ms
memory: 3896kb

input:

10
1 2 0 2 4 2 3 1 2 1
4 0 3 0 2 0 1 4 0 4
0 1 4 1 3 1 2 0 1 0
0 1 4 1 3 1 2 0 1 0
3 4 2 4 1 4 0 3 4 3
4 0 3 0 2 0 1 4 0 4
0 1 4 1 3 1 2 0 1 0
0 1 4 1 3 1 2 0 1 0
3 4 2 4 1 4 0 3 4 3
0 1 4 1 3 1 2 0 1 0

output:

NNNYN

result:

ok "NNNYN"

Test #11:

score: 0
Accepted
time: 3ms
memory: 3912kb

input:

10
1 4 1 2 1 3 3 2 1 2
0 3 0 1 0 2 2 1 0 1
0 4 0 3 0 2 2 1 0 1
1 4 1 2 1 3 3 2 1 2
4 2 4 0 4 1 1 0 4 0
1 1 1 4 1 0 3 2 1 2
0 0 0 1 0 2 2 1 0 1
2 0 2 3 2 4 4 3 2 3
2 0 2 3 2 4 4 3 2 3
2 0 2 3 2 4 4 3 2 3

output:

YYYYY

result:

ok "YYYYY"

Test #12:

score: 0
Accepted
time: 7ms
memory: 3844kb

input:

10
1 2 0 1 4 0 1 2 2 2
1 2 0 1 4 3 1 2 2 2
0 1 4 0 3 1 0 1 1 1
1 2 0 1 4 3 1 2 2 2
3 4 2 3 1 4 3 4 4 4
0 1 4 0 3 1 0 1 1 1
4 0 3 4 2 0 4 0 0 0
3 4 2 3 1 4 3 4 4 4
4 0 3 4 2 0 4 0 0 0
0 1 4 0 3 1 0 1 1 1

output:

YNYNY

result:

ok "YNYNY"

Test #13:

score: 0
Accepted
time: 5ms
memory: 3684kb

input:

10
1 3 0 0 2 1 3 4 3 3
3 3 0 0 4 1 3 4 3 3
1 1 3 3 2 4 1 2 1 1
2 4 1 1 3 2 4 0 4 4
4 1 3 3 0 4 1 2 1 1
2 4 1 1 3 2 4 0 4 4
0 2 4 4 1 0 2 3 2 2
3 0 2 2 4 3 0 1 0 0
3 0 2 2 4 3 0 1 0 0
4 2 4 4 1 0 2 3 2 2

output:

YYYNY

result:

ok "YYYNY"

Test #14:

score: 0
Accepted
time: 5ms
memory: 3604kb

input:

10
2 0 3 1 3 0 0 0 4 1
1 4 2 0 2 4 4 4 3 0
2 0 3 1 3 0 0 0 4 1
1 4 2 0 2 4 4 4 3 0
1 4 2 0 2 4 4 4 3 0
3 3 4 2 4 1 1 1 0 2
3 1 4 2 4 1 1 1 0 2
4 2 0 3 0 2 2 2 1 3
3 1 4 2 4 1 1 1 0 2
1 4 2 0 2 4 4 4 3 0

output:

YNYNN

result:

ok "YNYNN"

Test #15:

score: 0
Accepted
time: 335ms
memory: 15748kb

input:

1000
3 4 1 2 4 1 0 3 0 4 1 4 3 1 4 4 1 0 1 2 3 1 0 1 3 4 4 0 3 0 3 2 2 1 0 4 1 3 3 0 3 1 3 2 2 0 3 3 2 2 3 0 4 2 1 2 1 2 1 4 2 4 1 4 2 4 3 2 0 3 0 4 2 1 2 3 3 0 2 0 3 3 1 1 0 3 4 3 2 0 4 0 3 4 4 2 3 4 2 3 4 2 1 3 2 2 4 1 0 2 2 4 0 1 2 0 4 1 3 2 3 2 2 2 1 4 4 4 2 0 0 4 4 1 3 4 0 2 2 3 1 1 3 2 3 2 3 0...

output:

NNNYN

result:

ok "NNNYN"

Test #16:

score: 0
Accepted
time: 332ms
memory: 15744kb

input:

1000
2 3 0 1 0 0 0 1 1 4 1 4 2 3 0 3 4 2 3 2 4 2 1 1 1 1 0 0 3 3 2 0 2 2 2 4 3 0 3 3 3 0 1 3 0 2 0 1 0 0 0 3 1 4 3 1 4 0 3 4 4 1 3 3 4 0 1 4 2 3 0 1 0 0 2 3 1 4 0 0 2 1 2 3 3 4 4 3 3 2 0 0 4 3 2 3 3 2 4 0 2 2 3 0 3 2 4 1 0 2 4 2 4 1 2 1 3 0 3 3 0 1 1 0 2 3 0 2 4 1 4 3 4 1 2 2 2 4 0 1 3 3 0 0 1 3 2 4...

output:

NYYYY

result:

ok "NYYYY"

Test #17:

score: 0
Accepted
time: 337ms
memory: 15504kb

input:

1000
3 3 2 2 0 1 0 1 0 4 3 3 2 2 4 3 0 1 3 0 1 3 4 2 1 3 4 3 0 1 2 1 4 4 2 4 1 1 3 0 0 2 2 0 1 1 2 1 4 2 0 1 0 0 1 3 0 2 0 3 1 2 1 0 3 2 1 4 4 0 3 1 2 4 0 2 3 4 3 0 1 0 0 3 4 2 4 2 3 1 3 1 4 3 0 2 2 1 3 2 3 2 4 2 4 4 3 1 2 0 4 4 3 4 2 2 3 4 0 1 4 3 1 3 0 0 2 2 0 0 2 0 4 0 1 0 1 3 1 2 0 4 2 3 4 3 2 2...

output:

NNYYY

result:

ok "NNYYY"

Test #18:

score: 0
Accepted
time: 333ms
memory: 15744kb

input:

1000
2 3 0 0 0 4 2 0 4 1 4 2 4 3 2 0 1 2 3 1 1 4 0 0 1 3 0 0 4 4 4 2 4 4 3 2 2 4 1 1 4 0 3 4 4 2 2 4 1 2 2 1 0 2 2 0 2 0 1 0 2 0 0 2 0 0 3 2 3 1 3 2 4 2 2 1 0 2 4 4 2 3 2 4 2 2 3 0 4 3 3 0 3 2 2 2 1 2 2 4 1 2 4 1 1 2 0 2 4 4 0 4 0 3 1 3 1 0 0 4 0 1 1 1 0 3 0 2 1 2 3 4 3 1 3 3 3 4 2 2 1 3 2 4 0 3 2 1...

output:

NYYYY

result:

ok "NYYYY"

Test #19:

score: 0
Accepted
time: 384ms
memory: 15412kb

input:

1000
3 3 2 0 1 1 4 3 3 1 1 2 2 2 2 1 2 4 1 2 4 0 2 1 0 2 2 4 4 2 1 0 1 0 2 2 1 4 2 1 0 1 3 1 0 0 3 4 3 0 2 4 2 0 4 0 0 0 0 4 4 2 0 3 4 1 2 1 1 3 1 0 3 3 1 2 1 3 3 0 3 4 3 0 3 4 4 4 1 1 4 3 0 2 3 3 2 1 0 2 0 3 2 0 3 4 4 3 0 0 0 1 3 1 2 0 1 2 4 2 4 3 0 1 4 0 1 3 1 3 1 0 4 2 2 1 2 4 2 1 4 2 0 1 1 0 1 4...

output:

NYYYN

result:

ok "NYYYN"

Test #20:

score: 0
Accepted
time: 330ms
memory: 15672kb

input:

1000
1 1 4 3 1 2 1 0 0 0 0 3 1 3 0 2 3 4 4 2 2 3 2 4 3 0 0 0 3 4 3 0 4 1 4 3 0 2 3 3 1 4 1 4 2 2 3 1 4 4 3 1 1 1 4 0 0 1 3 2 3 2 4 2 0 1 3 3 0 1 4 4 2 3 2 4 2 0 3 4 0 3 4 0 4 2 0 3 4 2 4 1 1 3 0 4 0 1 0 2 3 0 1 0 3 4 0 4 4 2 2 2 3 0 3 0 3 1 4 1 4 0 0 1 1 1 4 0 1 4 0 2 1 4 3 3 2 0 2 3 4 0 4 1 3 3 3 2...

output:

NYYNN

result:

ok "NYYNN"

Test #21:

score: 0
Accepted
time: 397ms
memory: 15744kb

input:

1000
1 4 1 4 4 4 2 4 0 2 2 0 1 0 4 3 0 3 2 4 0 0 1 0 4 3 4 4 1 1 4 2 2 4 0 0 4 3 1 4 3 1 0 0 3 1 2 1 2 4 4 4 1 1 3 2 0 3 3 2 2 2 0 3 4 1 3 4 3 0 4 3 2 0 3 1 0 2 4 0 1 4 3 2 3 0 2 3 2 1 0 3 3 0 1 2 1 1 4 1 0 2 3 2 1 1 3 2 0 3 2 1 3 3 2 1 0 3 0 4 2 2 0 1 1 4 1 1 2 2 4 0 3 3 3 4 2 0 3 1 2 2 3 4 1 0 1 1...

output:

YYYYN

result:

ok "YYYYN"

Test #22:

score: 0
Accepted
time: 398ms
memory: 15688kb

input:

1000
4 1 0 0 1 1 4 1 0 2 1 3 1 0 3 0 1 4 3 4 2 4 0 4 1 3 2 0 3 4 3 3 2 3 1 2 4 0 4 1 2 3 3 4 4 1 2 4 0 3 4 0 0 2 4 1 0 0 1 4 1 2 1 0 1 0 2 4 4 4 1 3 1 4 3 4 2 3 4 2 0 1 3 1 2 2 2 4 0 1 0 2 0 2 4 3 0 1 0 4 1 2 2 2 2 1 4 3 2 3 3 3 1 0 4 1 0 4 0 1 2 4 0 3 3 2 4 0 4 2 3 4 2 1 0 4 2 0 4 3 2 4 3 2 3 4 3 1...

output:

YYYYY

result:

ok "YYYYY"

Test #23:

score: 0
Accepted
time: 339ms
memory: 15672kb

input:

1000
0 2 1 2 3 4 0 2 3 3 0 0 4 4 2 2 2 0 3 2 4 4 3 0 2 1 1 0 0 1 4 2 3 0 1 2 3 2 4 1 0 1 3 2 1 0 4 0 3 0 1 0 4 2 0 1 4 2 0 1 4 2 2 4 1 2 3 0 1 0 4 2 2 2 4 3 4 4 4 4 2 0 1 3 2 3 0 0 2 1 3 2 2 2 1 0 1 2 2 3 3 3 2 1 0 1 4 0 1 0 3 1 0 2 4 3 1 1 2 1 2 2 4 1 3 3 2 1 0 3 2 0 2 1 0 0 2 1 4 0 4 0 1 0 3 2 1 2...

output:

NYNYN

result:

ok "NYNYN"

Test #24:

score: 0
Accepted
time: 330ms
memory: 15744kb

input:

1000
2 4 1 3 0 3 3 2 1 1 1 2 0 3 3 3 4 3 3 2 2 4 0 4 0 2 4 2 0 0 4 4 2 1 4 0 4 0 0 3 2 3 3 1 4 2 3 0 4 0 4 1 2 3 2 3 2 4 0 2 3 4 0 3 0 4 0 1 1 4 3 3 4 4 2 0 0 3 0 2 3 4 3 4 2 3 1 1 1 4 1 1 4 1 3 1 1 4 0 2 4 1 4 1 0 0 3 2 1 4 1 0 0 2 0 2 4 1 0 3 0 2 1 0 1 0 0 0 1 3 0 1 1 4 3 4 3 3 0 2 4 2 0 4 2 1 2 0...

output:

YNYNY

result:

ok "YNYNY"

Test #25:

score: 0
Accepted
time: 328ms
memory: 15580kb

input:

1000
3 3 4 4 3 1 1 3 0 1 1 4 0 2 3 4 3 3 3 1 4 4 4 4 0 0 0 4 2 2 0 3 1 3 2 0 3 1 0 1 0 0 4 3 4 1 1 0 1 1 1 1 3 3 2 1 2 2 1 2 2 2 1 0 0 0 4 1 4 3 1 2 3 4 2 3 1 4 0 4 4 0 1 2 1 3 4 1 3 1 4 2 0 3 4 4 3 3 4 1 1 2 1 1 3 0 3 3 4 3 3 3 1 1 1 1 0 4 1 1 0 0 4 1 0 3 3 2 4 1 4 4 0 3 3 0 3 3 3 0 2 4 3 0 2 3 0 2...

output:

YYYYY

result:

ok "YYYYY"

Test #26:

score: 0
Accepted
time: 336ms
memory: 15448kb

input:

1000
2 0 1 1 2 3 2 3 4 3 0 2 3 3 1 0 0 3 2 4 4 2 4 4 4 0 4 4 4 3 3 4 3 4 4 3 3 4 3 2 4 4 1 0 1 3 0 3 0 4 1 2 1 3 2 0 1 4 2 2 1 0 3 2 0 4 1 2 4 3 2 1 3 1 3 1 3 0 1 1 2 4 2 0 0 1 4 0 1 0 3 0 1 0 0 4 1 3 0 2 1 1 2 3 4 4 4 0 0 2 3 0 4 4 3 0 2 4 4 4 4 2 1 0 3 0 4 0 2 1 3 1 3 3 0 0 4 4 1 3 2 2 4 1 2 1 2 2...

output:

NYNNN

result:

ok "NYNNN"

Test #27:

score: 0
Accepted
time: 384ms
memory: 15464kb

input:

1000
2 0 2 0 3 2 1 3 1 3 1 4 1 4 4 0 3 0 0 1 0 2 0 2 2 2 0 2 0 0 3 4 4 0 2 3 4 3 1 0 0 3 4 1 2 0 2 2 3 0 0 0 3 2 3 1 4 3 1 4 0 0 0 3 4 0 0 0 1 3 0 3 1 3 0 3 3 4 3 0 2 4 3 2 1 2 0 4 2 3 4 1 3 2 2 0 0 1 4 4 1 1 1 0 0 3 4 0 1 4 2 0 2 1 4 1 2 3 1 1 2 1 4 4 0 0 0 0 1 3 4 1 4 3 3 4 2 1 4 2 4 1 4 2 0 2 4 1...

output:

YYNNN

result:

ok "YYNNN"

Test #28:

score: 0
Accepted
time: 327ms
memory: 15460kb

input:

1000
2 0 4 2 4 1 2 2 4 2 3 1 1 4 1 0 4 4 0 0 1 4 4 0 3 0 3 2 3 2 1 3 3 3 3 4 0 4 3 0 2 1 0 3 2 4 0 2 1 3 0 4 3 4 3 4 3 0 4 3 3 3 0 0 4 2 4 1 3 2 1 2 2 4 1 0 4 3 2 3 3 0 2 3 0 0 3 3 0 3 3 4 3 3 2 4 3 0 3 2 3 2 4 4 3 0 4 1 4 1 1 2 3 2 0 2 3 3 3 3 1 4 2 4 3 1 3 0 1 2 3 3 4 2 4 3 0 1 3 3 3 2 3 2 1 0 0 1...

output:

YNNNN

result:

ok "YNNNN"

Test #29:

score: 0
Accepted
time: 335ms
memory: 15568kb

input:

1000
1 0 2 0 4 3 1 1 3 2 4 1 4 0 3 4 2 0 2 3 2 3 0 2 2 1 3 3 1 2 0 1 4 2 1 1 0 3 3 2 2 0 2 3 0 0 1 0 3 3 4 1 3 2 3 3 2 2 4 0 4 3 2 3 1 1 1 4 4 1 0 1 1 3 0 0 4 0 3 3 2 0 0 0 1 4 4 1 4 3 3 3 1 2 2 4 3 3 4 3 0 2 0 4 3 1 1 4 1 0 4 0 0 3 4 4 1 1 2 2 3 2 0 1 4 1 0 3 3 3 4 3 3 3 0 1 2 3 1 2 2 1 4 2 0 3 2 4...

output:

NNYNN

result:

ok "NNYNN"

Test #30:

score: 0
Accepted
time: 334ms
memory: 15504kb

input:

1000
2 0 3 4 0 4 2 3 1 1 1 3 3 2 0 2 2 3 4 1 0 1 1 4 2 1 4 1 1 2 0 0 1 3 4 4 2 1 1 3 3 3 1 4 4 2 1 2 1 2 1 4 4 0 4 1 0 2 0 2 0 3 0 3 4 1 0 2 0 4 2 3 3 0 1 0 3 4 1 1 2 4 1 4 3 2 4 1 4 3 4 3 2 2 0 0 3 4 1 0 0 1 1 1 1 3 0 4 2 2 3 2 4 3 4 4 0 3 0 4 0 3 1 4 4 0 0 3 1 4 0 3 4 4 3 4 0 2 1 3 0 3 0 4 3 4 2 1...

output:

YNNYN

result:

ok "YNNYN"

Test #31:

score: 0
Accepted
time: 332ms
memory: 15480kb

input:

1000
1 3 1 3 1 1 0 1 1 3 0 2 4 4 4 0 3 1 2 1 0 1 2 0 4 2 4 4 0 1 4 1 1 3 0 4 3 4 0 0 3 4 4 0 3 4 3 0 3 2 0 1 3 2 3 0 1 0 2 2 1 2 2 1 4 1 2 0 0 4 1 3 1 0 3 2 2 2 2 4 1 2 2 0 0 1 1 4 0 2 3 1 0 4 3 1 2 2 3 2 0 4 0 2 0 2 2 4 1 2 1 1 1 4 3 0 3 4 0 4 2 1 3 2 0 4 1 2 3 1 0 2 2 0 1 2 2 3 1 0 4 2 0 4 3 3 0 3...

output:

NYNYY

result:

ok "NYNYY"

Test #32:

score: 0
Accepted
time: 327ms
memory: 15504kb

input:

1000
3 1 3 4 2 0 0 1 0 4 2 4 1 4 0 2 0 4 0 4 3 3 1 4 1 0 0 4 1 3 1 1 2 3 0 4 1 1 0 1 0 0 4 4 2 2 1 1 1 0 4 3 4 1 3 2 2 2 4 3 3 0 2 3 0 1 2 0 4 0 2 2 3 4 3 4 2 3 1 0 2 3 1 2 3 4 3 0 3 3 1 4 2 4 0 0 3 1 0 1 2 4 0 4 0 1 4 2 1 1 4 3 0 4 3 2 2 1 4 2 1 4 4 1 2 1 0 3 0 1 4 0 3 4 1 1 2 3 3 2 4 0 0 3 3 2 1 4...

output:

NYNNN

result:

ok "NYNNN"

Test #33:

score: 0
Accepted
time: 394ms
memory: 15504kb

input:

1000
4 4 1 1 0 1 2 3 0 1 0 1 3 4 3 4 1 4 1 3 3 1 0 1 3 4 4 4 1 0 3 1 2 1 2 0 2 3 4 1 1 2 0 3 2 2 0 2 3 4 2 4 3 2 3 2 2 4 4 3 3 2 0 2 1 0 3 1 2 2 4 1 4 1 0 3 3 1 2 0 2 1 1 1 3 2 2 1 1 4 1 2 0 2 3 3 0 1 0 0 2 1 4 4 4 2 0 3 1 4 1 0 3 4 2 2 0 2 2 0 2 2 3 2 3 0 0 1 0 4 3 2 2 3 1 4 2 4 3 1 2 1 3 2 3 3 1 4...

output:

YYNYN

result:

ok "YYNYN"

Test #34:

score: 0
Accepted
time: 328ms
memory: 15508kb

input:

1000
2 2 3 3 3 4 2 2 0 4 3 2 2 4 0 0 4 2 1 3 3 4 3 0 3 0 0 4 0 2 1 3 2 2 2 3 2 2 0 3 4 0 2 4 2 1 3 1 0 2 3 4 0 1 4 0 0 2 3 1 4 1 4 2 2 3 2 4 0 4 2 4 2 0 1 2 3 3 1 0 2 3 1 1 3 4 1 1 4 3 1 3 2 4 4 3 2 1 2 3 2 4 4 0 3 3 1 3 4 3 0 3 3 1 0 4 3 2 3 4 4 1 2 3 3 1 0 4 2 2 0 1 1 4 1 1 3 4 4 0 3 2 4 1 3 0 2 3...

output:

YYYYY

result:

ok "YYYYY"

Test #35:

score: 0
Accepted
time: 330ms
memory: 15744kb

input:

1000
1 3 4 1 4 3 3 4 2 2 4 2 2 1 1 4 0 1 1 0 0 4 0 0 2 2 1 2 1 2 2 0 3 2 1 1 4 4 3 1 0 4 0 4 2 3 2 0 3 3 3 3 1 4 4 1 2 2 3 3 1 2 4 2 3 4 1 4 1 3 4 1 0 3 0 1 1 2 3 2 1 3 2 3 4 0 1 2 0 0 3 3 4 3 0 0 2 3 1 2 2 3 0 1 4 1 4 2 3 2 3 3 1 3 3 2 3 1 2 1 0 3 3 4 1 4 1 4 1 0 2 4 1 2 4 0 1 2 4 0 3 2 0 2 0 2 3 1...

output:

YYYYN

result:

ok "YYYYN"

Test #36:

score: 0
Accepted
time: 329ms
memory: 15712kb

input:

1000
4 1 1 4 4 1 0 2 0 0 2 1 3 0 2 0 4 1 3 2 3 0 0 2 2 3 0 0 3 0 2 1 1 3 3 2 4 1 1 3 3 2 1 3 0 2 4 4 2 2 3 3 0 1 0 4 3 1 3 3 4 4 0 4 4 2 1 0 4 0 2 0 2 0 0 4 4 0 4 0 4 2 3 0 0 3 1 3 3 1 1 2 1 0 2 4 0 4 2 3 2 1 2 0 0 0 0 0 1 2 4 2 3 1 3 2 0 1 0 4 1 4 0 1 3 3 1 1 1 1 1 4 2 0 0 0 1 2 3 1 0 3 0 4 1 4 0 1...

output:

YYYYN

result:

ok "YYYYN"

Test #37:

score: 0
Accepted
time: 325ms
memory: 15480kb

input:

1000
4 1 4 0 1 3 1 0 0 1 2 4 2 0 0 3 2 1 4 2 2 2 0 0 1 0 1 4 1 2 4 2 4 1 1 3 3 4 1 3 3 4 2 1 0 2 1 1 2 0 0 1 0 0 4 3 2 4 1 1 3 2 0 2 4 3 4 2 3 3 2 4 4 1 1 4 0 1 3 1 1 3 1 4 2 3 0 3 0 1 0 3 1 1 4 1 2 4 1 1 0 0 3 4 3 2 3 3 2 0 2 2 3 0 4 3 1 4 3 1 0 2 0 2 3 0 0 4 2 4 4 4 0 4 4 1 1 3 0 3 2 0 4 2 0 3 1 3...

output:

NNYNN

result:

ok "NNYNN"

Test #38:

score: 0
Accepted
time: 148ms
memory: 7600kb

input:

571
0 0 3 4 0 3 0 0 1 4 1 3 1 1 0 3 3 0 0 1 1 0 0 1 3 1 0 0 0 1 0 0 1 2 0 1 3 4 3 0 0 0 2 0 4 2 4 1 0 0 0 3 0 4 3 1 1 1 3 4 2 2 1 2 2 4 0 2 4 0 1 0 0 3 3 3 0 0 1 2 4 4 3 1 1 0 1 4 0 2 4 2 4 0 3 4 2 4 2 0 2 2 3 3 1 2 4 3 1 4 0 0 2 2 4 3 4 0 4 4 4 2 2 4 4 0 3 4 1 0 1 1 2 4 2 0 3 3 1 3 1 1 1 2 2 1 1 0 ...

output:

NYNNN

result:

ok "NYNNN"

Test #39:

score: 0
Accepted
time: 100ms
memory: 5740kb

input:

415
1 0 4 0 1 2 3 4 1 3 4 1 3 0 0 4 4 2 2 1 4 3 0 2 2 1 2 2 1 2 3 3 1 2 1 1 0 2 3 3 1 3 2 4 1 2 2 4 4 2 0 1 1 1 1 0 1 1 2 3 4 4 2 1 2 4 2 4 0 3 2 0 1 4 0 4 1 0 1 1 4 3 2 0 3 0 0 1 4 0 3 2 2 2 1 2 0 2 2 4 1 0 3 1 0 0 2 4 2 0 4 3 0 3 1 0 2 4 2 2 1 3 3 2 1 4 0 2 4 3 3 2 3 2 1 2 2 1 4 0 2 0 0 2 1 4 3 2 ...

output:

YNYYN

result:

ok "YNYYN"

Test #40:

score: 0
Accepted
time: 58ms
memory: 4652kb

input:

260
2 3 2 1 1 1 0 3 2 4 1 0 4 3 4 0 1 3 4 4 0 2 1 0 1 0 2 1 2 4 2 0 3 0 2 4 1 3 2 1 2 1 0 1 2 0 3 2 0 3 3 2 0 2 2 1 1 0 0 0 1 3 3 1 0 3 1 2 4 2 3 1 3 4 1 0 2 2 2 1 1 2 1 4 1 0 4 2 4 0 0 2 2 0 3 4 0 2 0 3 2 1 1 1 0 4 3 1 4 0 4 4 0 0 3 4 2 1 1 3 0 3 0 4 4 4 0 3 3 4 1 1 4 2 4 1 1 0 2 0 0 1 2 1 1 3 4 0 ...

output:

YYYYN

result:

ok "YYYYN"

Test #41:

score: 0
Accepted
time: 24ms
memory: 3976kb

input:

104
1 3 0 3 0 0 4 3 4 1 4 4 3 1 3 1 3 3 0 2 1 2 1 1 3 4 0 3 2 1 0 2 1 4 4 4 3 0 2 4 0 4 0 1 0 2 0 0 0 1 1 0 2 4 3 1 2 1 4 3 4 3 3 2 0 0 0 4 2 2 4 3 4 0 4 2 3 2 3 3 3 4 1 4 4 1 3 2 3 4 0 2 1 4 0 4 0 2 3 0 2 1 2 0
4 1 3 1 3 3 2 1 2 4 2 2 1 4 1 4 1 1 3 0 4 0 4 4 1 2 3 1 0 4 3 0 4 2 2 2 1 3 0 2 3 2 3 4 ...

output:

YNYNN

result:

ok "YNYNN"

Test #42:

score: 0
Accepted
time: 17ms
memory: 3936kb

input:

52
2 4 2 0 3 4 1 3 0 3 4 4 1 3 2 0 0 3 1 0 1 0 3 2 3 4 4 2 1 3 3 1 3 2 2 2 1 1 3 3 3 3 2 3 1 2 1 2 1 0 3 2
4 1 4 2 0 1 3 0 2 0 1 1 3 0 4 2 2 0 3 2 3 2 0 4 0 1 1 4 3 0 0 3 0 4 4 4 3 3 0 0 0 0 4 0 3 4 3 4 3 2 0 4
4 1 4 2 0 1 3 0 2 0 1 1 3 0 4 2 2 0 3 2 3 2 0 4 0 1 1 4 3 0 0 3 0 4 4 4 3 3 0 0 0 0 4 0 3...

output:

NYYYY

result:

ok "NYYYY"

Test #43:

score: 0
Accepted
time: 286ms
memory: 13164kb

input:

897
4 4 1 4 2 0 3 0 3 4 4 4 3 3 1 1 4 0 1 3 3 2 3 0 4 0 1 3 4 2 0 0 3 4 1 0 2 3 3 1 4 1 1 0 2 4 4 3 2 0 1 2 0 0 0 0 0 3 4 1 3 0 0 2 0 2 2 4 1 2 1 2 0 4 2 1 2 1 0 3 1 1 1 4 3 2 3 3 2 1 0 1 4 1 4 2 0 4 4 1 0 0 1 0 4 1 2 1 1 2 2 3 2 2 0 4 1 3 0 1 2 1 1 3 1 1 2 3 3 4 0 0 0 0 4 1 1 0 1 3 1 0 4 3 3 2 0 1 ...

output:

YYNNY

result:

ok "YYNNY"

Test #44:

score: 0
Accepted
time: 62ms
memory: 4492kb

input:

275
0 4 4 2 2 3 2 4 3 1 0 0 2 4 3 3 2 3 0 4 2 1 4 3 1 0 4 0 1 1 2 0 0 2 4 1 3 2 2 4 4 1 0 0 0 1 4 3 1 4 2 4 3 0 0 4 4 1 2 3 1 0 1 2 1 3 1 1 1 3 3 0 3 0 0 4 2 3 1 2 1 0 4 2 0 2 4 3 2 2 1 4 4 2 4 3 0 4 2 4 0 4 0 0 3 0 3 0 2 2 1 3 4 1 4 0 2 4 4 1 0 3 0 2 1 3 4 4 4 4 1 3 2 4 2 1 2 1 3 3 2 1 3 2 2 2 0 2 ...

output:

YYYYN

result:

ok "YYYYN"

Test #45:

score: 0
Accepted
time: 27ms
memory: 3852kb

input:

120
2 0 1 4 0 3 4 4 4 4 0 0 3 3 4 4 0 3 1 0 4 0 1 3 3 4 3 3 4 4 2 2 2 3 2 4 2 3 3 4 2 3 1 1 4 4 0 4 3 3 4 4 1 4 3 1 3 4 0 0 4 3 4 4 2 2 1 3 0 3 0 2 1 2 0 1 0 0 0 0 3 1 4 3 3 4 1 1 3 2 0 3 4 2 2 2 0 1 1 2 2 0 3 0 1 0 1 3 0 0 2 4 1 4 2 4 0 0 3 1
2 0 1 4 0 3 4 4 4 4 0 0 3 3 4 4 0 3 1 0 4 0 1 3 3 4 3 3 ...

output:

NYNNY

result:

ok "NYNNY"

Test #46:

score: 0
Accepted
time: 58ms
memory: 4564kb

input:

260
3 2 0 2 2 3 1 1 2 1 2 0 2 0 0 3 4 0 4 0 2 2 3 1 2 4 3 2 2 2 2 1 2 1 3 0 3 4 1 3 1 4 0 3 4 2 0 0 3 3 3 1 1 0 4 4 2 1 3 1 4 4 2 1 1 3 0 1 4 4 3 3 1 3 0 4 2 2 1 1 1 3 1 3 3 3 0 0 0 3 3 2 1 1 2 4 2 3 0 4 3 2 1 1 4 4 2 0 1 2 1 1 0 3 3 3 2 1 4 2 2 1 2 0 3 2 0 1 2 2 4 4 4 2 3 3 3 1 1 2 4 2 1 0 1 2 3 0 ...

output:

NYYNN

result:

ok "NYYNN"

Test #47:

score: 0
Accepted
time: 165ms
memory: 8192kb

input:

616
4 0 1 0 0 3 1 2 0 3 2 4 2 0 2 0 1 1 0 4 0 0 0 3 0 3 3 2 1 0 2 1 3 4 2 3 2 2 0 1 2 4 0 1 4 2 2 2 1 2 3 0 4 4 4 4 0 1 2 1 4 0 1 2 2 3 0 4 3 4 0 4 0 3 4 1 0 0 3 1 4 3 2 4 1 1 4 0 0 3 0 2 1 0 1 1 0 3 2 3 0 2 3 0 3 3 3 4 0 4 4 2 2 0 1 2 0 3 3 0 1 4 0 2 2 1 3 1 1 3 3 3 2 1 3 2 2 3 4 3 1 1 0 0 2 0 2 3 ...

output:

NNYNN

result:

ok "NNYNN"

Test #48:

score: 0
Accepted
time: 110ms
memory: 6208kb

input:

461
3 0 2 0 1 3 0 0 4 3 0 3 0 2 4 4 4 3 0 3 0 4 2 1 4 1 0 3 0 2 3 1 0 1 3 4 3 1 1 2 3 3 0 1 4 1 1 4 0 3 3 1 1 0 4 4 2 1 4 0 1 2 0 2 4 0 2 0 4 2 1 3 2 2 3 2 3 4 4 3 1 3 2 1 1 2 3 0 3 0 0 1 4 3 3 4 3 0 4 3 4 1 3 3 0 1 0 1 4 4 4 0 1 1 3 3 2 2 2 4 2 3 2 0 3 4 0 4 2 3 1 2 2 0 3 2 4 2 1 0 0 0 2 2 4 4 1 4 ...

output:

YNYNY

result:

ok "YNYNY"

Test #49:

score: 0
Accepted
time: 159ms
memory: 7964kb

input:

601
3 2 0 3 4 1 2 1 0 0 4 2 4 3 3 2 1 0 3 2 0 2 4 2 3 1 1 1 0 4 4 0 2 4 1 2 2 2 0 1 0 3 3 2 3 4 0 0 4 2 0 0 4 1 0 3 0 2 2 1 4 1 3 2 4 2 4 4 0 2 3 0 1 3 3 0 1 0 1 2 4 4 3 1 4 1 2 1 4 0 1 1 0 1 0 0 4 4 2 2 4 0 1 3 2 4 4 3 3 1 0 1 3 4 2 3 0 1 1 3 2 3 1 4 2 0 0 0 1 3 1 1 2 0 1 0 0 0 4 0 3 1 2 0 1 4 1 3 ...

output:

YNYYY

result:

ok "YNYYY"

Test #50:

score: 0
Accepted
time: 109ms
memory: 6008kb

input:

445
3 2 1 1 1 0 1 4 2 3 1 0 3 0 1 2 2 1 2 3 4 1 3 2 3 3 4 0 3 0 1 2 2 4 2 0 4 3 1 2 0 2 2 2 0 4 4 3 4 1 2 0 2 3 4 2 2 0 2 1 2 1 4 0 0 0 1 3 2 0 3 2 3 3 0 0 4 0 1 4 2 4 3 3 2 1 0 2 2 0 1 2 3 3 2 4 2 4 3 3 4 3 1 0 4 1 3 4 0 2 0 4 3 0 4 3 1 2 3 2 4 3 2 2 4 4 3 2 4 0 2 3 2 0 2 2 2 4 0 3 4 3 3 2 4 1 1 0 ...

output:

YYNNY

result:

ok "YYNNY"

Test #51:

score: 0
Accepted
time: 155ms
memory: 7752kb

input:

586
0 3 1 0 1 0 3 1 0 3 3 0 4 3 1 0 1 3 2 0 3 3 1 1 2 0 4 4 1 4 1 1 3 2 0 0 0 0 3 4 0 0 2 0 3 3 1 0 2 2 2 1 1 0 2 0 1 2 2 4 2 2 2 4 4 1 3 4 2 2 1 0 4 1 1 4 4 3 0 1 4 1 4 1 2 2 3 1 0 2 4 3 0 1 3 3 0 2 3 1 4 0 4 3 4 3 1 3 1 2 1 2 4 2 4 4 0 4 4 1 0 4 2 0 0 3 0 0 0 2 0 1 2 1 1 2 3 3 1 4 4 1 4 4 0 2 2 0 ...

output:

YYNNN

result:

ok "YYNNN"

Test #52:

score: 0
Accepted
time: 31ms
memory: 3952kb

input:

134
0 2 3 1 2 0 2 1 0 0 1 3 2 3 4 0 3 2 1 0 2 4 2 0 3 3 3 3 4 2 4 4 4 3 2 3 0 0 0 2 2 4 4 0 3 4 1 1 1 0 3 3 0 3 3 1 0 4 0 2 1 2 2 3 1 0 1 0 0 1 4 1 2 1 4 0 0 4 1 3 2 2 0 3 0 3 1 0 4 0 0 4 0 3 0 3 2 1 4 3 3 0 0 2 0 2 1 2 4 4 2 3 1 4 3 2 3 4 4 1 4 2 4 4 2 4 3 1 3 2 2 4 0 1
0 2 3 1 2 0 2 1 0 0 1 3 2 3 ...

output:

YNNYN

result:

ok "YNNYN"

Test #53:

score: 0
Accepted
time: 335ms
memory: 15744kb

input:

1000
3 4 1 2 4 1 1 3 4 1 1 3 4 3 2 0 2 1 3 2 4 3 0 1 0 3 1 1 0 2 1 1 0 0 2 2 2 0 0 0 0 4 3 1 0 4 0 2 2 2 0 0 3 0 4 1 2 1 2 1 4 1 1 1 0 3 1 3 4 2 0 1 1 0 3 4 2 3 2 2 1 3 4 2 3 3 3 4 1 1 1 4 2 4 1 0 0 0 0 0 1 3 4 2 3 2 4 0 1 2 1 4 3 1 4 4 1 3 0 0 1 0 3 3 0 4 0 4 2 4 3 4 2 2 4 2 4 2 2 1 3 2 3 3 4 1 0 0...

output:

NYYNN

result:

ok "NYYNN"

Test #54:

score: 0
Accepted
time: 327ms
memory: 15508kb

input:

1000
4 1 2 1 2 4 0 2 4 1 2 0 2 2 3 2 4 0 1 0 4 4 0 4 2 1 1 0 3 3 4 2 1 1 3 4 4 0 0 1 2 1 0 1 2 0 2 2 1 2 2 4 4 2 3 3 3 2 1 2 3 3 0 1 0 3 3 4 3 0 0 1 0 3 1 3 3 1 1 3 4 2 2 0 1 4 1 2 3 4 0 2 2 2 3 2 2 3 4 0 4 1 4 1 1 4 3 3 0 4 0 4 1 4 3 3 4 4 2 4 1 4 0 3 1 0 4 2 3 1 4 0 4 1 4 0 4 2 1 4 2 2 1 1 4 1 2 2...

output:

NNYNN

result:

ok "NNYNN"

Test #55:

score: 0
Accepted
time: 332ms
memory: 15544kb

input:

1000
3 1 1 4 2 1 0 2 0 0 2 2 0 1 0 4 1 1 1 2 0 4 1 1 0 0 1 2 3 2 3 1 0 0 3 2 0 3 2 4 0 0 4 1 1 1 1 4 3 2 0 2 4 4 4 1 4 0 4 3 4 1 3 4 1 3 0 2 0 0 2 2 0 2 1 1 2 4 2 1 4 1 3 1 3 3 1 4 1 2 1 2 4 4 0 4 1 1 0 2 4 1 1 3 1 4 0 3 3 4 1 4 3 2 1 3 2 3 2 3 2 4 0 2 0 1 1 1 4 0 0 0 3 2 2 2 1 4 3 3 2 1 1 2 0 3 0 2...

output:

NYYNN

result:

ok "NYYNN"

Test #56:

score: 0
Accepted
time: 338ms
memory: 15568kb

input:

1000
2 1 2 3 3 2 0 3 4 4 1 2 1 2 2 0 1 4 1 2 2 1 3 3 0 4 1 3 3 3 4 4 0 4 2 1 2 4 4 4 2 0 2 1 4 4 1 0 0 4 3 0 1 3 2 0 1 2 2 1 1 3 4 1 0 0 0 1 2 4 4 0 4 1 2 2 2 3 1 2 0 0 1 2 0 3 2 4 3 4 3 3 2 4 1 0 2 4 1 0 1 1 2 1 0 4 4 2 3 0 1 4 2 0 1 0 2 1 4 0 1 0 4 3 4 4 4 1 4 0 2 0 0 0 1 0 4 3 2 4 1 1 2 4 3 3 2 2...

output:

YYNNY

result:

ok "YYNNY"

Test #57:

score: 0
Accepted
time: 337ms
memory: 15504kb

input:

1000
2 0 1 2 3 1 3 4 3 1 4 1 1 3 3 2 1 1 2 3 2 1 4 1 4 3 1 4 3 2 2 0 0 4 1 3 0 3 0 1 2 0 1 1 3 2 0 3 2 1 0 4 0 0 2 4 2 4 1 3 2 4 4 4 1 2 2 3 1 3 0 1 1 3 3 1 0 1 1 3 2 1 3 3 2 1 3 3 4 1 1 1 0 2 4 2 0 1 2 1 1 0 2 4 0 3 3 4 3 1 2 4 3 4 1 0 1 0 4 0 2 0 2 0 4 4 4 0 2 4 2 4 0 0 0 3 2 0 4 2 4 2 4 0 2 3 0 0...

output:

YNYYN

result:

ok "YNYYN"

Test #58:

score: 0
Accepted
time: 333ms
memory: 15480kb

input:

1000
0 1 2 3 0 2 3 1 1 2 1 0 3 1 4 2 0 4 0 1 4 4 2 3 4 0 3 3 0 2 0 3 2 1 4 0 2 3 1 4 0 0 0 2 0 0 1 2 0 3 0 3 1 4 0 1 0 0 0 1 3 3 3 4 0 0 2 2 4 4 1 2 4 4 3 0 1 1 0 3 4 0 0 4 4 3 0 3 4 3 3 3 4 3 1 3 1 4 1 4 3 1 4 2 3 0 3 4 2 2 4 0 1 2 1 2 2 2 3 2 1 0 4 3 1 4 1 2 2 3 1 0 3 2 3 1 0 3 0 2 3 3 1 3 2 3 4 0...

output:

YYNNY

result:

ok "YYNNY"

Test #59:

score: 0
Accepted
time: 328ms
memory: 15452kb

input:

1000
1 4 4 4 3 4 0 0 4 0 4 3 4 1 0 2 3 4 2 4 3 1 1 0 0 0 2 4 1 1 4 3 1 4 1 1 1 4 4 3 4 3 1 1 1 0 1 4 0 1 2 4 4 0 0 1 0 1 4 0 3 3 1 3 2 3 2 0 3 0 2 1 3 4 2 2 3 0 1 0 3 3 1 3 4 1 0 3 3 4 2 3 3 3 2 3 3 4 1 3 1 3 3 3 1 0 4 1 4 2 3 4 2 0 3 2 4 2 3 4 1 4 1 4 0 3 2 4 2 4 3 4 2 2 0 4 1 4 0 1 3 0 0 2 1 4 3 0...

output:

NNYNY

result:

ok "NNYNY"

Test #60:

score: 0
Accepted
time: 328ms
memory: 15500kb

input:

1000
2 4 1 2 1 0 2 0 2 3 2 4 2 1 4 2 1 2 1 2 2 3 4 1 2 2 4 3 4 1 4 1 2 1 2 0 0 4 4 3 0 4 1 2 1 4 3 3 4 4 2 3 1 0 3 1 4 2 2 3 1 1 3 4 1 4 1 4 0 1 3 4 1 0 2 4 4 4 3 1 1 1 3 4 0 3 2 3 4 4 0 4 3 0 0 1 4 4 4 0 4 1 0 4 0 2 3 2 3 4 3 4 2 3 0 3 4 4 4 2 0 4 4 4 3 3 4 4 2 1 0 3 4 4 4 2 0 3 0 0 1 1 3 1 1 4 3 0...

output:

YNYYN

result:

ok "YNYYN"

Test #61:

score: 0
Accepted
time: 328ms
memory: 15476kb

input:

1000
2 1 2 3 1 2 3 4 2 0 1 3 4 0 1 4 3 1 4 1 4 0 3 2 3 2 2 2 2 0 1 1 0 1 1 1 3 0 1 3 3 1 2 4 2 2 4 3 2 2 1 3 4 4 2 1 3 2 1 4 4 0 4 0 0 1 2 4 4 1 3 2 2 4 3 1 0 1 3 0 4 0 3 3 1 1 2 4 1 3 3 0 0 0 4 4 0 2 2 0 2 2 0 3 2 3 3 3 3 1 4 4 2 1 1 1 0 2 2 1 4 0 4 4 0 1 1 0 3 0 4 2 4 3 4 3 4 3 4 1 0 3 2 4 1 2 1 4...

output:

NNYNN

result:

ok "NNYNN"

Test #62:

score: 0
Accepted
time: 330ms
memory: 15484kb

input:

1000
4 3 4 4 0 3 4 1 3 2 4 1 4 4 1 0 2 2 0 2 3 4 1 1 4 4 0 2 4 1 3 2 3 4 0 3 1 2 3 3 1 2 3 1 3 1 0 3 2 3 3 3 4 4 3 3 3 0 4 3 2 4 0 1 0 4 1 0 1 3 0 1 0 2 3 2 2 1 2 1 1 2 1 0 0 0 4 1 4 2 2 2 2 2 2 2 4 3 1 3 4 3 3 3 2 0 0 4 1 0 3 4 3 4 2 3 3 4 4 4 4 3 4 4 0 2 0 1 2 0 2 0 1 3 4 2 4 2 1 4 3 3 1 3 0 3 2 2...

output:

YYYYY

result:

ok "YYYYY"

Test #63:

score: 0
Accepted
time: 387ms
memory: 15508kb

input:

1000
2 4 4 1 3 1 0 0 3 2 1 2 4 2 3 0 4 1 4 2 0 2 0 0 3 3 1 2 0 3 3 1 1 0 0 4 0 3 3 3 3 0 3 3 3 1 0 0 2 1 2 3 2 4 2 0 0 0 3 1 0 2 0 3 3 1 1 0 4 1 4 0 4 2 3 3 2 2 3 2 4 2 0 4 3 3 1 2 3 1 0 0 2 1 3 0 1 2 0 3 4 0 0 4 0 4 1 1 2 2 1 0 3 2 0 3 0 4 3 0 3 4 3 0 1 4 0 2 2 3 0 2 4 0 4 3 4 2 1 4 2 0 4 4 4 2 3 0...

output:

YNNYY

result:

ok "YNNYY"

Test #64:

score: 0
Accepted
time: 82ms
memory: 5320kb

input:

351
0 0 4 0 1 0 1 0 3 3 0 3 2 1 2 3 4 3 0 0 3 3 2 0 3 0 4 0 4 0 0 4 3 4 3 3 0 0 2 2 3 0 0 0 1 3 3 1 2 2 0 3 2 2 3 2 2 3 2 3 3 3 0 4 0 4 3 3 4 3 4 0 4 3 3 0 2 1 1 2 4 4 1 1 3 3 4 1 1 2 2 4 1 2 4 1 1 1 4 1 4 4 3 4 3 3 1 1 2 3 3 3 0 4 0 0 4 0 0 3 1 1 3 0 1 1 4 1 0 2 3 3 2 3 2 3 1 4 0 3 4 4 3 3 2 0 2 0 ...

output:

NNYNN

result:

ok "NNYNN"

Test #65:

score: 0
Accepted
time: 119ms
memory: 6556kb

input:

491
1 3 2 1 3 0 1 4 0 0 4 1 3 4 2 4 0 2 2 2 4 3 3 1 0 4 2 1 4 2 0 1 1 4 4 0 4 4 3 2 0 4 3 1 4 0 3 4 2 0 0 3 3 0 2 2 3 4 4 4 1 3 1 3 0 4 4 4 1 2 4 0 1 3 1 0 2 3 1 2 1 3 2 1 2 0 3 2 1 0 0 3 0 1 2 0 1 0 0 2 4 3 4 3 0 2 0 3 2 0 3 3 0 1 1 3 0 3 4 1 4 0 1 1 4 1 3 4 3 0 3 3 0 4 3 1 1 4 2 0 0 0 1 2 3 0 0 2 ...

output:

YYNNN

result:

ok "YYNNN"

Test #66:

score: 0
Accepted
time: 77ms
memory: 5084kb

input:

335
3 1 0 1 3 0 0 1 3 4 1 2 0 3 2 2 1 1 0 1 3 4 1 0 4 4 3 3 0 2 0 3 0 3 4 0 4 4 4 3 0 3 3 4 1 4 4 4 0 1 2 0 0 2 1 4 0 0 0 2 2 0 4 2 0 0 4 0 1 4 3 4 1 2 3 0 3 1 0 3 2 3 4 1 2 0 1 2 3 2 4 3 2 3 3 0 1 2 1 3 2 0 4 4 0 3 3 0 3 0 2 0 0 0 4 2 0 1 1 4 1 1 1 3 0 0 3 2 3 3 3 4 0 1 0 0 2 3 1 2 0 2 0 3 4 1 2 3 ...

output:

NYYYN

result:

ok "NYYYN"

Test #67:

score: 0
Accepted
time: 40ms
memory: 4004kb

input:

180
2 1 2 0 0 4 3 4 2 2 4 1 1 0 4 2 3 3 4 3 1 2 1 4 0 3 2 0 4 3 2 4 4 4 0 1 1 3 1 1 0 1 2 2 4 4 4 2 4 4 2 0 1 4 4 2 0 0 1 1 4 0 0 1 0 1 1 4 0 2 4 4 3 1 0 0 1 1 0 0 1 2 2 0 2 2 3 1 2 0 3 1 2 4 4 4 4 2 2 3 0 3 1 2 4 1 4 4 0 0 3 4 0 3 1 4 2 1 2 4 2 4 2 2 2 4 1 0 1 2 0 1 1 3 1 2 4 3 3 4 4 3 3 0 3 4 2 1 ...

output:

YYYNY

result:

ok "YYYNY"

Test #68:

score: 0
Accepted
time: 8ms
memory: 3872kb

input:

24
0 3 0 1 3 0 0 0 1 0 3 0 2 1 3 4 0 4 2 1 2 1 0 1
2 0 2 3 0 2 2 2 3 2 0 2 4 3 0 1 2 1 4 3 4 3 2 3
0 3 0 1 3 0 0 0 1 0 3 0 2 1 3 4 0 4 2 1 2 1 0 1
1 4 1 2 4 1 1 1 2 1 4 1 3 2 4 0 1 0 3 2 3 2 1 2
2 0 2 3 0 2 2 2 3 2 0 2 4 3 0 1 2 1 4 3 4 3 2 3
1 4 1 0 4 1 1 1 2 1 4 1 3 2 4 0 1 0 3 2 3 2 1 2
0 3 0 1 3...

output:

YNYNN

result:

ok "YNYNN"

Test #69:

score: 0
Accepted
time: 276ms
memory: 12684kb

input:

869
4 1 3 3 0 4 0 1 2 2 3 1 0 0 2 1 3 4 2 3 4 1 2 3 4 2 1 3 0 3 4 1 0 1 3 4 0 2 2 2 1 3 2 4 4 1 4 2 2 3 0 0 3 2 1 4 1 1 1 1 3 3 4 4 4 0 4 0 2 2 3 4 1 4 3 0 4 3 1 3 2 4 0 0 3 2 4 0 3 4 2 1 3 3 0 0 1 2 3 4 2 0 0 1 2 3 0 0 3 3 1 1 1 4 4 2 2 1 2 0 1 0 2 1 3 4 4 0 4 3 0 1 3 1 1 3 4 3 1 3 0 4 1 2 4 1 2 0 ...

output:

YYNYN

result:

ok "YYNYN"

Test #70:

score: 0
Accepted
time: 242ms
memory: 11512kb

input:

817
0 1 3 0 3 3 4 2 3 4 1 0 4 3 4 1 0 4 1 0 2 2 2 1 0 4 3 0 2 0 0 3 3 2 1 0 4 1 0 1 2 2 3 1 4 1 4 1 0 1 1 4 1 2 2 0 0 1 4 2 0 3 2 3 2 3 2 0 0 1 4 4 2 0 2 1 1 4 2 3 0 3 1 3 1 4 1 0 2 4 2 4 3 0 4 1 0 1 4 4 3 3 2 0 3 1 3 2 3 3 3 0 2 0 2 4 0 2 0 2 3 3 4 0 0 4 3 0 2 4 2 3 4 0 3 2 2 3 2 2 2 0 4 1 3 0 1 2 ...

output:

YYYYY

result:

ok "YYYYY"

Test #71:

score: 0
Accepted
time: 182ms
memory: 8828kb

input:

661
3 4 4 0 1 4 4 4 0 1 4 1 0 3 1 2 4 2 3 1 0 4 0 4 0 1 0 2 0 0 1 2 2 0 1 1 4 4 2 2 2 3 3 1 2 1 3 0 3 2 0 3 1 3 0 2 1 0 4 0 1 3 1 0 4 0 2 1 1 2 4 2 1 2 3 1 4 3 1 3 0 1 4 1 1 0 3 3 0 1 1 0 0 1 3 4 2 2 4 1 0 0 0 3 4 4 4 2 4 4 3 2 1 0 1 4 2 4 2 0 0 1 4 3 0 3 0 1 2 4 3 1 1 4 4 0 3 1 2 3 2 2 0 2 2 1 0 2 ...

output:

NYNYY

result:

ok "NYNYY"

Test #72:

score: 0
Accepted
time: 122ms
memory: 6720kb

input:

506
0 1 4 4 1 2 1 3 1 1 2 4 4 0 3 0 0 0 0 3 3 1 0 0 0 2 2 3 2 1 2 0 2 0 2 4 1 0 3 2 3 3 1 0 4 2 0 3 4 4 3 3 3 2 3 2 0 2 3 4 3 2 1 0 4 2 0 1 4 1 3 2 2 3 0 1 3 3 1 1 0 0 4 2 3 1 0 0 3 4 0 1 3 4 0 3 4 1 3 2 4 4 0 1 1 4 2 4 1 4 4 1 2 2 0 2 4 4 4 4 2 3 0 2 1 2 3 0 4 2 4 3 3 2 0 2 1 1 4 1 1 3 2 0 0 3 2 4 ...

output:

NYNNN

result:

ok "NYNNN"

Test #73:

score: 0
Accepted
time: 83ms
memory: 5108kb

input:

350
2 2 3 2 0 1 3 3 3 3 2 2 2 3 1 3 2 0 1 4 0 2 4 1 2 1 3 1 4 3 1 2 1 3 0 1 0 1 1 1 4 3 3 1 3 4 1 0 3 3 0 1 1 0 1 2 0 4 2 4 2 3 3 1 1 0 3 0 2 1 1 3 4 4 2 3 1 4 0 4 3 2 4 3 4 4 1 0 3 3 2 4 3 2 3 4 4 2 1 3 1 4 2 1 2 4 2 1 1 2 4 1 4 0 3 4 2 0 1 1 3 1 3 2 1 3 2 2 2 4 0 2 0 2 3 1 1 0 2 1 4 4 1 2 1 2 3 2 ...

output:

YYYYY

result:

ok "YYYYY"

Test #74:

score: 0
Accepted
time: 213ms
memory: 10000kb

input:

728
0 0 2 3 2 2 1 3 0 0 4 2 1 1 1 0 3 0 1 0 4 0 3 0 3 0 3 0 3 4 2 4 0 2 4 4 3 0 4 1 4 1 1 3 3 1 1 1 4 4 3 3 0 4 2 0 1 1 0 2 2 4 2 2 4 1 2 3 4 0 1 2 4 4 4 2 3 3 2 0 4 2 2 2 2 3 3 4 1 2 1 0 0 4 3 1 1 1 2 3 2 0 3 0 3 0 2 2 4 2 0 2 2 1 2 1 4 2 4 0 1 1 0 4 3 0 0 3 4 2 2 2 2 4 1 3 2 1 1 2 1 1 2 2 2 1 1 2 ...

output:

NYYYN

result:

ok "NYYYN"

Test #75:

score: 0
Accepted
time: 90ms
memory: 5352kb

input:

381
2 0 4 4 4 0 4 4 2 3 3 2 1 2 1 3 0 2 0 3 3 3 0 1 1 1 3 1 3 2 0 1 4 2 0 2 1 4 3 4 2 1 1 1 3 2 3 3 2 3 0 0 3 2 3 1 4 2 4 4 0 2 3 2 4 4 3 0 3 0 3 4 4 0 0 3 4 0 4 4 2 0 4 4 0 0 4 0 2 2 3 3 0 0 0 0 2 1 1 1 4 1 0 2 2 4 4 0 3 0 1 2 4 1 1 4 3 2 0 4 0 4 2 2 1 1 0 3 4 2 1 2 0 4 1 2 3 3 0 3 4 1 1 1 2 1 0 0 ...

output:

NNNYY

result:

ok "NNNYY"

Test #76:

score: 0
Accepted
time: 328ms
memory: 15460kb

input:

1000
0 4 4 4 1 2 2 2 2 0 3 2 0 3 0 2 2 4 0 4 1 1 1 1 4 2 0 3 1 0 4 2 4 1 2 0 2 1 4 1 3 0 2 4 4 0 2 0 0 0 2 1 4 2 3 2 2 2 0 2 4 0 1 3 4 4 0 0 0 2 2 1 3 0 4 2 1 4 2 3 2 4 3 1 2 1 2 4 4 4 4 2 2 0 2 4 4 0 4 2 1 2 1 2 1 0 2 2 3 2 3 1 2 1 2 3 2 2 1 2 2 1 2 1 4 0 3 1 3 0 4 3 3 0 4 2 1 4 0 2 3 3 1 3 2 4 3 0...

output:

NNYNN

result:

ok "NNYNN"

Test #77:

score: 0
Accepted
time: 329ms
memory: 15576kb

input:

1000
1 2 0 3 3 3 3 0 2 1 4 3 3 2 3 3 4 3 4 3 3 2 3 1 0 2 2 2 2 4 1 0 4 3 1 0 4 1 3 0 4 2 1 4 4 4 1 0 3 2 1 0 0 2 3 0 1 2 3 0 2 3 2 3 3 4 4 4 3 0 1 2 1 2 4 3 1 0 0 0 3 1 2 3 1 2 3 4 2 3 1 4 3 4 4 3 4 0 0 0 0 3 0 4 2 0 1 1 3 2 2 1 0 3 3 2 2 4 4 0 0 3 2 1 1 4 4 2 4 0 1 1 4 3 0 2 4 4 2 2 2 4 4 1 1 1 0 0...

output:

NYNNN

result:

ok "NYNNN"

Test #78:

score: 0
Accepted
time: 333ms
memory: 15448kb

input:

1000
2 4 3 0 0 0 0 2 3 4 4 1 4 2 3 0 3 1 4 2 2 0 3 0 3 2 2 3 1 1 3 0 4 2 4 1 0 0 0 3 3 4 3 3 0 3 0 1 4 0 3 1 0 4 3 2 0 3 4 1 2 4 3 0 4 3 0 1 1 3 4 2 2 0 3 1 4 2 2 2 4 3 1 1 1 0 4 0 1 4 0 2 1 2 1 1 2 0 1 0 3 0 3 2 3 4 0 3 2 2 1 0 1 2 2 2 4 2 2 3 1 1 1 0 1 3 4 0 3 4 1 4 2 1 1 2 4 0 0 4 0 1 2 0 1 3 1 1...

output:

NYNNN

result:

ok "NYNNN"

Test #79:

score: 0
Accepted
time: 325ms
memory: 15744kb

input:

1000
1 0 4 2 4 2 1 1 2 2 1 0 1 2 0 1 4 1 3 0 2 4 2 1 3 2 4 3 4 4 4 2 2 4 3 3 4 1 2 2 1 1 3 2 2 2 3 2 2 4 3 1 0 3 3 0 0 0 2 4 4 3 1 3 3 1 1 1 0 3 3 0 3 4 3 3 0 3 2 0 2 4 0 0 0 3 1 1 2 2 3 0 3 3 3 0 4 0 0 4 2 3 0 1 1 4 0 4 3 0 0 2 2 0 3 0 1 2 1 1 0 4 1 0 3 4 4 2 4 2 4 0 3 0 0 4 4 0 3 2 0 2 2 0 0 2 0 3...

output:

YYNNY

result:

ok "YYNNY"

Test #80:

score: 0
Accepted
time: 331ms
memory: 15460kb

input:

1000
4 4 3 4 2 0 3 3 1 0 0 4 2 3 1 3 0 3 0 4 2 2 1 0 2 0 3 4 1 1 1 2 3 3 3 0 4 3 4 3 1 4 4 2 3 3 3 4 4 1 0 2 4 4 1 1 0 4 2 0 4 2 4 0 0 2 3 2 4 2 2 0 1 2 1 3 3 4 2 2 1 1 0 3 0 2 1 0 1 3 3 2 1 0 4 4 2 0 1 0 2 2 0 2 2 3 1 2 0 0 2 4 3 3 4 0 3 4 0 1 1 1 3 4 3 2 2 0 2 4 3 4 2 0 2 1 0 0 0 0 4 3 1 2 0 4 2 2...

output:

YNYYN

result:

ok "YNYYN"

Test #81:

score: 0
Accepted
time: 329ms
memory: 15508kb

input:

1000
4 4 4 4 4 1 4 2 3 1 3 0 1 4 2 3 2 1 3 3 3 4 4 4 1 3 3 2 3 2 0 0 0 2 3 0 1 4 0 0 3 0 4 4 0 3 4 4 1 3 3 1 1 3 4 1 2 2 4 3 1 2 3 0 4 4 0 2 1 3 0 4 0 2 4 0 3 1 1 2 1 3 3 0 2 1 3 3 4 2 3 3 1 4 1 1 3 4 4 2 2 2 2 3 3 0 0 1 2 1 0 1 0 0 2 1 3 3 2 3 4 3 0 0 4 2 4 0 1 0 3 4 2 2 1 4 3 4 1 3 2 4 2 4 4 2 2 3...

output:

YNYYN

result:

ok "YNYYN"

Test #82:

score: 0
Accepted
time: 331ms
memory: 15580kb

input:

1000
0 0 0 0 2 2 0 3 3 1 1 4 3 3 2 3 1 1 3 4 1 1 3 2 2 0 1 2 1 0 2 0 3 0 3 1 0 3 2 4 0 1 0 1 0 1 3 4 2 1 1 0 3 3 3 3 2 3 4 1 0 4 2 4 4 2 1 3 0 3 2 2 0 2 4 2 1 2 4 0 2 4 1 2 1 3 4 4 0 2 2 0 2 0 2 1 0 4 1 2 0 3 4 2 3 0 0 4 4 3 1 1 0 3 3 0 1 1 2 4 3 4 0 1 3 1 0 2 0 0 1 3 0 1 1 0 3 4 4 1 4 0 2 3 1 3 0 2...

output:

NYYNY

result:

ok "NYYNY"

Test #83:

score: 0
Accepted
time: 389ms
memory: 15508kb

input:

1000
4 4 4 3 4 4 2 4 1 3 4 2 4 4 1 1 4 1 4 4 1 0 2 4 0 1 0 3 2 2 0 4 1 3 4 4 1 0 3 0 4 0 1 0 3 2 2 2 1 4 1 2 0 3 4 4 2 1 3 2 4 3 4 1 4 1 3 4 3 1 3 2 3 4 0 2 3 3 0 4 1 1 3 2 0 1 1 0 3 2 1 0 1 2 2 4 2 4 1 2 3 3 3 2 2 3 3 0 0 4 3 1 1 2 4 2 3 4 1 4 3 0 0 3 2 2 3 0 2 1 0 4 2 2 2 0 4 0 2 4 4 3 1 2 3 3 2 2...

output:

YNNYY

result:

ok "YNNYY"

Test #84:

score: 0
Accepted
time: 329ms
memory: 15452kb

input:

1000
4 3 2 3 0 1 1 4 3 0 2 0 4 4 3 2 4 1 1 4 2 2 2 2 3 1 1 4 1 4 4 2 1 0 1 4 1 0 0 1 0 1 2 1 0 3 4 3 0 3 4 0 2 1 3 2 0 3 0 4 2 0 0 1 4 3 2 2 1 3 0 3 0 3 1 4 0 2 0 4 0 0 2 1 0 4 2 4 1 3 2 4 0 1 0 4 1 4 1 1 4 1 1 2 1 3 3 3 0 3 2 4 0 0 0 2 2 0 2 3 2 1 3 1 3 4 4 3 4 4 3 3 0 2 2 3 1 0 1 0 4 3 4 4 1 4 0 2...

output:

YYYYN

result:

ok "YYYYN"

Test #85:

score: 0
Accepted
time: 75ms
memory: 4908kb

input:

321
1 2 3 1 4 3 3 0 2 4 0 2 0 2 3 4 3 1 3 0 0 1 2 4 1 0 3 3 1 2 1 0 3 4 4 4 0 4 0 3 0 3 2 1 0 3 1 3 0 3 0 1 0 1 4 4 1 0 4 1 4 1 3 1 2 0 4 4 1 3 2 3 2 4 3 2 4 0 0 3 3 3 3 2 3 2 2 0 4 2 1 2 2 3 3 3 2 4 1 4 0 4 3 1 0 0 0 2 0 4 3 4 1 0 1 4 2 1 1 4 2 3 3 3 1 0 3 3 3 4 4 4 3 3 1 3 4 3 4 4 3 1 1 1 1 2 3 3 ...

output:

NYNYN

result:

ok "NYNYN"

Test #86:

score: 0
Accepted
time: 36ms
memory: 3952kb

input:

165
3 0 2 3 4 0 0 0 4 1 4 2 0 0 3 2 1 1 3 2 0 1 4 0 4 0 4 0 0 4 0 3 0 1 2 0 4 4 1 2 4 3 4 2 2 0 0 2 4 2 0 4 2 1 1 1 4 1 3 2 4 0 4 1 3 4 4 1 1 3 4 4 0 1 2 3 4 1 3 1 4 0 4 1 2 4 0 2 4 4 3 3 2 4 0 0 3 0 2 3 0 1 4 1 0 3 3 0 4 1 3 3 4 2 3 3 0 1 0 0 1 0 1 0 0 1 2 2 2 0 2 4 2 3 3 2 0 0 2 4 1 0 4 1 1 2 2 1 ...

output:

YYYYY

result:

ok "YYYYY"

Test #87:

score: 0
Accepted
time: 3ms
memory: 3684kb

input:

10
1 1 4 1 2 2 0 0 0 1
0 0 3 0 1 1 4 4 4 0
4 4 2 4 0 0 3 3 3 4
1 1 4 1 2 2 0 0 0 1
0 1 4 0 1 1 4 4 0 0
0 0 3 0 1 1 4 4 4 0
2 2 0 2 3 3 1 1 1 2
4 4 2 4 0 0 3 3 3 4
4 0 2 4 0 0 3 3 3 4
2 2 0 2 3 3 1 1 1 2

output:

YYYNN

result:

ok "YYYNN"

Test #88:

score: 0
Accepted
time: 182ms
memory: 9100kb

input:

662
0 0 2 2 2 4 1 0 3 0 4 1 4 0 4 4 1 3 1 4 3 0 4 4 3 3 4 4 0 4 0 0 1 4 3 0 4 3 0 3 3 1 3 3 1 3 1 4 2 0 4 4 4 1 2 3 2 2 2 1 1 1 0 3 2 4 0 2 4 1 3 2 2 4 1 3 3 4 3 2 0 1 2 3 0 0 1 0 0 3 1 0 2 0 3 1 3 4 3 2 2 2 0 2 4 2 3 0 4 0 4 0 2 3 4 0 2 4 4 3 4 1 2 3 3 1 2 3 4 2 2 2 3 1 1 3 4 3 4 2 4 1 3 2 2 1 4 4 ...

output:

NNYNN

result:

ok "NNYNN"

Test #89:

score: 0
Accepted
time: 126ms
memory: 6880kb

input:

506
3 1 2 1 0 2 3 3 0 3 4 2 1 1 4 4 0 4 3 3 4 0 2 1 1 3 0 3 2 2 0 4 4 2 1 0 3 0 4 2 3 2 2 1 1 1 3 2 2 0 2 4 3 0 4 1 1 4 3 4 1 1 3 0 0 4 0 2 3 2 2 3 3 1 1 2 1 3 0 3 0 4 0 2 4 0 1 4 1 4 3 1 4 4 3 2 3 1 3 0 4 3 4 3 1 1 0 0 4 4 3 1 2 4 2 0 1 4 0 4 1 0 2 1 2 4 1 4 0 4 2 4 3 2 4 3 4 1 4 2 3 3 4 2 4 2 1 3 ...

output:

NNYNN

result:

ok "NNYNN"

Test #90:

score: 0
Accepted
time: 174ms
memory: 8860kb

input:

647
2 2 2 1 1 2 1 2 0 3 1 4 2 0 0 3 0 2 1 3 2 1 1 2 1 1 1 1 4 3 2 0 2 2 0 3 0 1 0 0 3 1 4 0 2 1 2 0 2 2 1 4 1 3 0 0 2 2 0 3 3 1 3 0 4 0 3 1 0 1 2 3 3 1 3 1 1 2 0 4 1 2 2 2 1 2 4 4 4 2 3 1 2 3 3 2 2 4 3 1 3 0 4 1 3 3 2 0 2 3 1 0 2 0 4 1 0 3 1 2 3 2 4 4 2 3 4 2 0 2 3 1 3 0 0 3 3 1 0 1 4 1 1 0 3 4 3 4 ...

output:

YNNYN

result:

ok "YNNYN"

Test #91:

score: 0
Accepted
time: 122ms
memory: 6524kb

input:

491
2 4 1 3 0 4 3 2 3 4 1 3 3 0 0 0 2 4 1 2 2 0 1 0 0 3 0 4 4 2 0 4 4 3 3 0 4 1 3 3 4 0 2 2 1 3 1 3 4 1 3 3 3 2 0 0 0 3 3 0 0 4 2 0 3 4 2 3 1 0 4 4 3 2 3 4 4 3 3 0 3 4 4 0 2 4 3 0 0 2 4 0 4 2 3 2 1 1 1 1 0 1 1 0 0 2 1 3 0 0 2 0 4 2 4 0 3 1 1 2 3 0 2 0 1 3 4 3 0 0 4 4 2 2 3 3 2 2 2 4 2 4 4 4 0 4 1 0 ...

output:

YYNNN

result:

ok "YYNNN"

Test #92:

score: 0
Accepted
time: 78ms
memory: 5024kb

input:

335
4 0 4 2 0 1 3 2 4 1 1 3 2 4 0 1 1 3 2 0 4 1 2 2 0 2 2 4 4 4 3 2 3 0 1 3 3 2 3 2 3 1 4 0 0 0 3 0 4 0 4 0 3 4 0 1 4 3 4 4 0 3 2 2 4 3 1 2 0 0 1 1 3 4 3 3 4 0 1 4 1 0 0 2 1 1 3 3 0 1 1 3 4 0 2 3 2 4 0 2 0 2 3 4 4 3 2 0 4 3 2 1 2 1 3 4 1 0 4 2 1 4 1 0 0 0 4 3 2 1 2 0 0 1 1 2 1 4 2 0 3 0 4 2 0 4 0 3 ...

output:

YNYYY

result:

ok "YNYYY"

Test #93:

score: 0
Accepted
time: 324ms
memory: 15196kb

input:

988
4 2 1 1 3 3 4 2 0 2 0 2 1 1 4 4 3 4 4 1 1 4 3 4 4 2 1 2 0 2 2 0 0 3 4 1 1 0 1 0 1 3 1 1 4 0 2 0 0 4 0 4 0 1 2 2 2 4 3 1 4 0 0 3 2 4 1 2 3 0 3 4 0 4 3 3 2 1 3 2 4 1 1 4 4 0 4 0 0 1 0 2 4 0 0 0 3 0 2 0 3 2 1 4 3 1 1 0 1 0 4 1 4 4 0 2 4 1 1 1 0 0 3 4 3 1 3 3 2 2 2 0 3 1 4 3 1 2 4 0 1 1 2 0 0 3 1 1 ...

output:

YYNNN

result:

ok "YYNNN"

Test #94:

score: 0
Accepted
time: 327ms
memory: 15540kb

input:

1000
3 4 4 0 3 1 1 2 3 1 3 1 2 2 3 0 3 0 3 1 1 4 2 3 2 1 3 2 0 3 2 2 4 3 0 3 3 2 3 2 0 3 1 2 4 4 2 0 1 1 1 3 4 3 3 4 0 4 3 3 1 3 2 4 3 3 4 4 0 4 0 0 3 1 2 3 2 4 3 1 0 4 0 2 3 1 1 0 1 4 2 4 0 4 0 2 2 3 3 1 4 2 0 2 2 3 2 1 2 1 2 0 2 0 1 0 2 2 2 3 0 2 0 1 4 1 0 0 4 3 0 4 1 0 1 4 3 0 1 2 0 4 1 1 4 1 4 4...

output:

YYNYN

result:

ok "YYNYN"

Test #95:

score: 0
Accepted
time: 340ms
memory: 15440kb

input:

1000
4 3 1 0 0 1 0 3 1 2 4 3 0 0 1 4 4 2 0 1 2 0 4 0 2 3 0 1 0 3 3 0 2 0 4 3 1 1 2 2 1 1 1 4 4 2 2 4 1 3 0 2 1 3 1 2 0 4 2 3 3 0 2 1 2 0 4 4 3 3 2 2 1 3 0 4 1 0 1 1 2 4 1 2 3 3 3 4 3 0 4 1 4 0 1 4 3 2 1 3 0 3 2 4 1 4 2 2 3 4 1 2 4 3 4 4 3 3 3 3 3 4 2 1 3 3 2 1 3 0 3 1 3 2 0 2 1 3 2 4 4 2 3 4 2 0 3 0...

output:

NYYNY

result:

ok "NYYNY"

Test #96:

score: 0
Accepted
time: 333ms
memory: 15544kb

input:

1000
1 0 4 3 3 4 2 2 0 0 4 0 1 0 4 1 3 2 2 1 3 1 4 2 4 3 2 2 4 1 0 3 4 4 1 1 0 3 0 4 0 3 2 0 2 2 0 1 0 2 2 3 2 4 1 0 3 0 1 1 3 2 3 3 3 1 1 0 2 1 2 2 0 1 2 1 0 1 2 3 0 1 3 2 3 4 2 0 3 4 0 4 0 2 3 0 4 2 4 4 1 0 3 2 0 4 3 2 4 4 4 4 1 1 4 1 0 3 3 3 4 1 3 0 1 0 3 4 0 2 3 0 1 2 1 4 2 1 2 1 2 0 3 3 3 1 2 4...

output:

NNNNY

result:

ok "NNNNY"

Test #97:

score: 0
Accepted
time: 329ms
memory: 15448kb

input:

1000
3 3 0 3 4 4 2 4 1 0 0 4 2 1 4 1 0 1 1 4 1 2 2 3 1 4 4 0 2 3 2 2 1 0 1 0 4 4 2 4 1 0 2 2 2 2 1 2 4 4 0 2 0 2 4 2 1 1 4 0 0 3 3 3 2 4 4 4 4 2 3 0 0 4 1 2 0 0 0 0 4 4 0 3 4 0 4 0 2 3 2 3 2 3 4 1 0 1 3 2 2 0 4 0 4 3 2 2 1 4 3 3 4 4 0 0 0 1 4 1 2 3 3 4 3 2 4 4 4 0 3 1 1 0 0 2 1 0 2 2 2 0 0 2 0 1 2 0...

output:

YYYYY

result:

ok "YYYYY"

Test #98:

score: 0
Accepted
time: 328ms
memory: 15512kb

input:

1000
1 1 4 0 4 4 2 4 3 1 4 3 3 2 3 4 0 1 2 3 0 1 2 1 2 1 0 2 3 2 0 3 2 2 2 3 0 2 4 2 3 3 1 2 4 3 3 4 4 4 4 1 4 4 0 2 3 4 4 1 0 4 4 2 4 3 0 2 4 0 0 0 1 4 2 0 4 1 1 0 0 1 1 4 2 4 0 2 2 0 3 3 1 4 2 1 4 2 4 3 1 1 4 2 3 1 4 1 4 1 0 0 2 3 1 4 3 0 4 4 4 1 3 4 3 4 4 4 1 4 0 1 0 0 3 0 3 1 0 1 3 4 0 3 2 1 0 1...

output:

NYYNN

result:

ok "NYYNN"

Test #99:

score: 0
Accepted
time: 330ms
memory: 15580kb

input:

1000
2 0 4 1 0 3 1 4 3 1 1 3 1 4 4 2 1 4 4 0 2 1 4 3 2 3 0 0 4 2 4 3 1 3 2 2 1 2 4 4 3 3 0 2 3 0 3 2 2 3 1 2 0 2 1 3 0 4 1 4 1 3 2 3 2 2 3 0 0 1 0 2 4 3 2 0 3 4 4 4 4 1 3 4 2 0 1 3 4 1 3 3 1 3 2 3 0 1 1 0 0 0 0 2 1 1 4 0 3 0 2 4 0 4 4 0 3 1 2 0 1 1 1 4 4 0 3 2 0 2 1 0 1 2 1 2 4 4 3 0 4 0 2 0 3 0 2 1...

output:

NNYNN

result:

ok "NNYNN"

Test #100:

score: 0
Accepted
time: 339ms
memory: 15508kb

input:

1000
2 2 1 2 2 0 2 2 3 4 0 2 2 2 3 0 4 2 0 3 0 4 3 2 4 0 3 4 2 4 4 2 0 1 0 3 0 3 1 2 1 0 0 0 4 4 3 4 3 1 3 3 1 3 0 1 4 0 0 2 0 1 3 3 1 0 3 1 3 4 4 3 3 3 1 1 0 1 3 0 4 4 2 2 2 2 0 3 0 2 1 2 2 1 4 2 4 2 0 2 2 2 3 1 4 3 0 1 2 0 3 2 0 1 0 2 4 3 4 4 0 2 0 0 2 1 0 3 2 0 4 3 1 1 2 3 4 4 2 2 3 0 0 3 4 0 3 0...

output:

YYYYY

result:

ok "YYYYY"

Test #101:

score: 0
Accepted
time: 334ms
memory: 15456kb

input:

1000
1 0 0 4 3 2 4 3 3 0 4 1 0 4 4 2 1 0 1 3 4 0 3 3 3 2 3 1 4 0 2 3 0 0 2 2 1 2 4 4 1 4 4 4 2 1 2 2 3 0 4 4 0 4 1 1 0 2 0 3 0 1 1 1 3 0 0 4 4 4 4 0 4 0 3 0 3 3 0 4 4 1 4 1 2 1 4 0 1 2 0 1 0 4 3 2 2 3 4 3 0 1 2 2 0 2 2 0 0 4 1 1 3 2 0 3 3 0 0 3 1 2 2 0 2 1 0 2 3 2 4 1 0 0 0 0 1 1 1 0 2 4 1 4 4 2 1 1...

output:

NNYNN

result:

ok "NNYNN"

Test #102:

score: 0
Accepted
time: 333ms
memory: 15516kb

input:

1000
2 0 0 3 1 3 3 4 4 0 0 1 3 1 0 1 1 3 4 4 1 0 0 1 1 1 4 4 1 3 3 2 4 0 1 1 4 2 3 1 1 3 1 3 2 2 0 0 1 2 3 3 2 3 3 1 0 1 3 2 2 0 3 3 1 1 4 1 0 4 2 2 2 3 1 0 0 2 2 1 4 1 0 3 0 0 2 4 2 0 1 1 1 1 1 4 1 1 2 0 3 0 3 1 0 2 0 1 0 4 0 1 1 2 4 4 2 1 0 4 4 1 4 4 0 0 4 2 0 0 1 2 1 2 3 4 4 3 3 1 0 4 2 0 3 4 2 1...

output:

NNYYN

result:

ok "NNYYN"

Test #103:

score: 0
Accepted
time: 335ms
memory: 15504kb

input:

1000
0 0 3 3 2 3 3 3 1 3 4 0 1 2 1 4 2 4 4 3 3 0 1 2 0 3 3 3 1 2 1 0 0 0 4 2 4 0 0 4 1 2 4 3 0 3 0 3 1 2 1 4 2 0 4 3 3 1 1 3 2 0 0 1 3 4 0 4 0 1 1 2 2 1 3 2 0 2 4 4 1 3 2 2 2 3 1 3 0 3 2 0 4 4 1 3 0 3 3 2 2 0 4 3 2 1 4 1 4 4 1 0 1 3 2 4 0 0 1 4 0 1 0 3 3 0 4 0 3 0 1 2 0 4 0 0 1 0 1 3 4 0 3 1 2 2 0 1...

output:

YYYYN

result:

ok "YYYYN"

Test #104:

score: 0
Accepted
time: 178ms
memory: 8552kb

input:

643
3 2 3 4 0 0 4 0 3 4 0 4 2 2 3 3 1 2 2 0 4 1 3 1 1 0 0 1 4 0 2 4 1 4 0 4 2 2 3 3 0 3 2 0 2 3 2 4 3 4 4 3 4 4 1 1 2 4 0 3 1 3 2 0 4 0 0 0 3 0 0 4 3 3 0 4 2 3 3 2 0 1 0 1 1 1 3 0 3 0 4 3 1 4 2 0 1 4 0 1 4 0 3 4 3 2 4 1 0 3 2 1 1 2 0 1 1 0 2 4 3 0 1 2 1 4 1 2 0 2 0 3 1 1 3 1 4 4 4 1 3 2 1 4 4 4 4 3 ...

output:

NNYYN

result:

ok "NNYYN"

Test #105:

score: 0
Accepted
time: 122ms
memory: 6716kb

input:

487
4 0 4 4 3 3 4 1 1 0 4 4 1 4 3 0 3 3 4 4 0 1 4 1 4 0 4 3 0 3 1 2 0 1 1 3 2 3 1 2 1 3 0 1 2 0 3 4 4 0 1 2 2 0 1 2 0 0 3 4 0 3 0 3 3 3 2 3 2 0 2 0 2 4 0 0 0 0 0 0 3 3 1 2 0 4 2 1 3 1 1 0 3 3 0 1 1 1 0 2 0 3 0 4 2 4 0 1 4 0 4 1 2 1 3 3 3 0 3 4 2 3 3 2 0 0 1 1 3 3 0 2 0 1 3 0 0 2 3 1 0 0 2 4 3 2 1 3 ...

output:

NYNNN

result:

ok "NYNNN"

Test #106:

score: 0
Accepted
time: 73ms
memory: 5016kb

input:

332
1 2 3 1 2 4 4 2 3 2 4 4 1 3 1 1 2 2 2 0 2 0 4 2 0 4 0 4 0 1 1 2 2 4 4 1 1 1 4 1 0 3 2 3 2 2 2 4 0 4 2 3 1 3 3 2 3 0 0 4 4 1 2 3 4 3 1 0 3 3 0 2 1 2 4 4 2 1 2 0 2 3 3 4 3 0 1 4 4 1 2 0 3 1 3 2 2 2 3 2 1 3 3 0 0 4 4 4 4 3 0 2 4 4 3 2 2 2 2 0 1 2 1 3 4 1 4 2 2 0 4 2 2 1 0 2 4 4 1 1 3 4 0 2 3 2 0 1 ...

output:

NNNYY

result:

ok "NNNYY"

Test #107:

score: 0
Accepted
time: 116ms
memory: 6336kb

input:

472
1 2 0 2 4 1 4 1 2 2 3 2 3 1 4 4 3 2 2 3 0 0 4 3 3 3 4 1 0 2 3 3 2 3 1 4 4 1 2 2 2 4 3 3 0 3 2 4 0 2 2 2 3 0 2 2 2 0 2 4 1 2 2 3 1 3 0 2 0 2 0 1 4 1 2 0 4 1 2 3 4 4 1 1 4 3 1 0 3 4 3 2 3 0 2 3 4 1 0 1 1 4 3 4 2 3 3 4 1 0 3 2 1 0 1 4 3 1 0 1 0 2 4 4 2 1 2 1 4 0 1 0 4 3 1 1 2 3 2 0 3 4 4 4 2 1 1 4 ...

output:

YYYNY

result:

ok "YYYNY"

Test #108:

score: 0
Accepted
time: 10ms
memory: 3708kb

input:

21
1 4 1 4 3 1 4 0 3 3 1 0 4 2 2 4 3 4 0 1 0
4 2 4 2 1 4 2 3 1 1 4 3 2 0 0 2 1 2 3 4 3
4 2 4 2 1 4 2 3 1 1 4 3 2 0 0 2 1 2 3 4 3
3 1 3 1 0 3 1 2 0 0 3 2 1 4 4 1 0 1 2 3 2
4 2 4 2 1 4 2 3 1 1 4 3 2 0 0 2 1 2 3 4 3
0 3 0 3 2 0 3 4 2 2 0 4 3 1 1 3 2 3 4 0 4
4 2 4 2 1 4 2 3 1 1 4 3 2 0 0 2 1 2 3 4 3
2 0...

output:

NYYNN

result:

ok "NYYNN"

Test #109:

score: 0
Accepted
time: 188ms
memory: 9108kb

input:

673
0 0 3 1 1 3 0 4 0 4 0 3 0 0 3 0 1 4 3 3 0 0 0 4 0 3 0 2 3 1 1 3 1 1 4 4 0 2 1 4 0 1 2 3 4 2 1 4 1 1 2 2 4 2 1 3 1 3 2 0 3 2 0 3 2 2 1 0 0 1 3 2 0 3 2 3 0 3 1 0 1 0 3 3 4 3 3 0 2 2 4 2 2 0 1 2 3 2 4 1 0 3 1 4 1 3 2 0 0 2 4 3 4 1 2 0 1 1 3 4 2 2 3 0 3 4 4 1 1 4 4 3 4 1 4 0 0 1 2 2 2 0 4 1 2 3 0 4 ...

output:

YNYNN

result:

ok "YNYNN"

Test #110:

score: 0
Accepted
time: 241ms
memory: 11500kb

input:

813
2 0 3 0 1 1 3 3 4 3 2 0 3 1 0 3 0 2 0 2 2 0 3 3 4 4 2 2 4 1 1 2 2 2 0 0 2 1 1 4 0 0 2 1 1 2 4 0 3 2 1 0 4 1 1 0 2 2 1 2 4 2 4 0 0 3 1 4 1 3 1 0 0 0 3 2 3 2 0 0 2 1 0 2 4 2 2 0 4 4 2 3 4 2 2 1 0 2 4 0 3 4 0 1 2 0 2 4 1 1 3 1 4 1 2 0 1 4 0 2 3 3 3 3 3 3 2 4 0 3 0 4 0 0 0 1 1 0 4 2 2 4 1 2 3 4 2 0 ...

output:

NNYYN

result:

ok "NNYYN"

Test #111:

score: 0
Accepted
time: 182ms
memory: 8740kb

input:

658
3 4 0 1 2 2 4 3 3 4 0 3 1 1 0 0 3 1 0 0 3 0 2 4 0 2 0 1 4 3 4 0 3 4 4 2 4 0 1 1 0 4 3 1 4 3 2 0 3 1 3 3 2 3 0 1 3 1 3 0 2 4 2 2 3 1 1 2 1 2 3 1 2 1 0 4 4 2 4 0 4 1 1 4 2 4 4 0 4 2 3 1 3 0 0 2 0 1 0 3 3 4 1 4 3 2 1 1 4 1 1 1 0 3 1 2 3 4 2 4 1 0 3 3 0 3 0 2 4 3 2 1 2 4 2 1 4 2 0 1 4 3 4 2 2 4 2 2 ...

output:

NYNNN

result:

ok "NYNNN"

Test #112:

score: 0
Accepted
time: 244ms
memory: 11204kb

input:

798
3 4 3 3 0 1 2 3 1 1 4 3 1 1 4 2 4 1 0 3 2 3 3 4 3 2 4 4 0 0 1 2 0 1 2 0 3 3 3 1 4 4 0 3 1 0 4 0 4 0 3 1 0 4 1 2 2 2 1 2 1 4 4 2 4 0 3 4 4 2 1 2 3 2 4 1 0 3 3 0 3 4 2 1 0 4 3 1 4 2 4 2 3 3 3 2 3 1 4 0 4 4 3 3 2 0 2 3 3 4 3 1 2 0 1 0 3 0 1 4 0 4 2 3 2 4 3 3 2 3 3 2 4 3 4 0 4 2 3 0 0 2 4 2 1 3 1 1 ...

output:

YYYYY

result:

ok "YYYYY"

Test #113:

score: 0
Accepted
time: 84ms
memory: 5056kb

input:

346
3 2 0 2 2 4 3 1 0 1 2 1 4 0 4 0 2 0 1 4 2 2 3 2 2 4 3 1 2 1 2 4 3 0 3 2 1 2 0 3 4 0 1 4 3 1 3 0 1 1 4 1 2 0 1 4 2 3 3 2 2 3 0 0 0 4 0 4 0 0 1 2 4 2 3 1 1 3 4 3 2 1 0 2 0 4 0 3 3 0 4 0 2 2 4 0 2 3 0 1 0 2 3 1 3 3 3 1 2 0 2 0 3 2 2 3 3 4 0 2 2 3 3 3 4 3 2 1 0 0 4 0 2 1 0 2 2 2 0 4 1 1 0 4 3 0 4 2 ...

output:

NNNYY

result:

ok "NNNYY"

Test #114:

score: 0
Accepted
time: 335ms
memory: 15448kb

input:

1000
3 4 3 1 4 2 0 2 4 0 3 0 1 2 2 1 4 0 0 0 2 0 2 4 4 1 2 4 0 3 2 1 2 2 1 1 4 0 0 2 2 1 3 2 4 1 4 3 3 2 1 4 4 1 1 4 2 1 0 1 2 1 4 4 3 4 3 3 0 2 1 3 4 0 1 2 0 1 2 3 4 0 2 2 0 2 2 1 2 2 0 0 1 3 4 3 1 3 1 4 2 4 0 0 1 2 2 3 2 0 2 0 3 3 0 0 3 0 0 2 3 1 4 1 1 3 0 2 1 2 4 2 3 3 2 3 0 0 4 2 2 3 2 3 0 4 4 0...

output:

NYNYY

result:

ok "NYNYY"

Test #115:

score: 0
Accepted
time: 19ms
memory: 3792kb

input:

100
0 4 2 3 0 1 1 2 1 2 3 2 4 3 3 1 4 1 2 0 1 1 1 0 4 4 0 0 4 0 0 4 2 1 4 0 0 0 4 4 4 0 3 2 3 3 0 4 3 2 0 0 2 4 3 3 3 2 1 3 2 2 1 3 0 0 3 4 0 3 2 3 4 4 1 4 2 4 2 1 2 4 4 1 1 2 3 3 2 4 4 3 2 3 0 1 1 4 1 1
3 2 0 1 3 4 4 0 4 0 1 0 2 1 1 4 2 4 0 3 4 4 4 3 2 2 3 3 2 3 3 2 0 4 2 3 3 3 2 2 2 3 1 0 1 1 3 2 ...

output:

YYYNN

result:

ok "YYYNN"

Test #116:

score: 0
Accepted
time: 23ms
memory: 3796kb

input:

100
0 0 1 0 4 4 4 0 3 0 0 1 0 0 2 0 4 0 4 0 1 2 2 0 2 1 0 4 2 3 4 3 1 1 1 4 1 2 3 1 4 3 1 1 1 4 1 1 3 2 1 2 2 4 2 3 4 1 3 1 3 1 3 2 2 0 1 2 1 3 3 4 2 3 2 2 0 1 3 4 2 3 0 1 4 1 0 1 2 4 0 2 0 2 3 2 4 1 2 2
1 1 2 1 0 0 0 1 4 1 1 2 1 1 3 1 0 1 0 1 2 3 3 1 3 2 1 0 3 4 0 4 2 2 2 0 2 3 4 2 0 4 2 2 2 0 2 2 ...

output:

YNNNN

result:

ok "YNNNN"

Test #117:

score: 0
Accepted
time: 23ms
memory: 3864kb

input:

100
0 1 4 1 2 0 4 4 3 4 2 1 0 4 0 4 1 2 4 2 3 4 0 4 4 1 2 3 4 0 4 2 2 3 1 4 4 2 1 1 1 4 1 3 1 2 4 2 0 1 2 0 4 4 1 4 3 2 4 4 0 4 1 2 1 0 4 1 3 1 4 2 4 1 2 4 2 2 2 4 3 0 2 3 2 3 0 2 4 2 2 0 1 2 4 4 4 4 0 0
0 1 4 1 2 0 4 4 3 4 2 1 0 4 0 4 1 2 4 2 3 4 0 4 4 1 2 3 4 0 4 2 2 3 1 4 4 2 1 1 1 4 1 3 1 2 4 2 ...

output:

NYYYN

result:

ok "NYYYN"

Test #118:

score: 0
Accepted
time: 23ms
memory: 3744kb

input:

100
2 0 2 4 0 3 1 1 4 2 1 4 3 3 4 1 0 2 3 1 2 2 4 3 0 2 0 3 2 2 2 2 2 1 2 4 0 0 0 1 4 2 2 4 4 2 2 4 2 0 2 2 2 4 1 4 4 2 0 3 4 2 3 1 3 3 4 2 3 0 0 2 4 3 4 1 3 0 2 4 0 1 3 2 1 0 1 4 1 2 2 2 4 2 1 3 2 0 0 1
0 3 0 2 3 1 4 4 2 0 4 2 1 1 2 4 3 0 1 4 0 0 2 1 3 0 3 1 0 0 0 0 0 4 0 2 3 3 3 4 2 0 0 2 2 0 0 2 ...

output:

NNYNY

result:

ok "NNYNY"

Test #119:

score: 0
Accepted
time: 24ms
memory: 3732kb

input:

100
4 2 4 0 4 4 2 0 3 0 3 4 2 2 4 2 3 2 4 0 1 4 3 4 0 1 4 3 4 4 4 1 4 4 1 2 3 1 2 4 2 4 3 2 1 3 2 2 0 3 4 1 4 4 0 1 1 3 2 3 2 4 4 1 2 1 0 2 2 3 3 0 0 1 2 1 1 1 1 0 2 1 1 3 0 3 0 3 0 2 4 4 2 3 4 3 4 0 2 0
2 0 2 3 2 2 0 3 1 3 1 2 0 0 2 0 1 0 2 3 4 2 1 2 3 4 2 1 2 2 2 4 2 2 4 0 1 4 0 2 0 2 1 0 4 1 0 0 ...

output:

YNYYY

result:

ok "YNYYY"

Test #120:

score: 0
Accepted
time: 23ms
memory: 3764kb

input:

100
0 3 1 0 0 1 0 1 1 0 0 4 2 3 1 1 0 1 3 2 3 2 1 1 4 3 2 3 2 2 4 3 2 2 1 3 3 3 2 0 0 2 3 0 1 2 0 3 1 1 3 4 1 4 3 0 1 1 1 4 1 3 0 3 2 1 4 4 4 2 1 2 0 0 4 3 0 2 1 1 4 3 0 3 4 0 4 4 3 3 2 2 2 0 4 1 1 3 2 3
0 3 1 0 0 1 0 1 1 0 0 4 2 3 1 1 0 1 3 2 3 2 1 1 4 3 2 3 2 2 4 3 2 2 1 3 3 3 2 0 0 2 3 0 1 2 0 3 ...

output:

NNYNN

result:

ok "NNYNN"

Test #121:

score: 0
Accepted
time: 23ms
memory: 3996kb

input:

100
4 1 3 2 2 3 0 4 0 0 1 2 0 2 1 1 1 0 2 1 4 1 0 3 4 3 2 2 4 4 0 3 0 2 2 3 1 4 0 4 4 3 4 2 3 1 4 0 4 0 4 2 4 4 0 3 4 3 1 3 0 3 3 1 2 0 4 4 2 4 4 0 2 2 3 0 0 4 0 2 0 1 4 4 3 1 1 2 0 1 1 4 3 2 1 3 2 4 1 3
4 1 3 2 2 3 0 4 0 0 1 2 0 2 1 1 1 0 2 1 4 1 0 3 4 3 2 2 4 4 0 3 0 2 2 3 1 4 0 4 4 3 4 2 3 1 4 0 ...

output:

YYYYY

result:

ok "YYYYY"

Test #122:

score: 0
Accepted
time: 23ms
memory: 3800kb

input:

100
0 2 0 4 0 0 1 3 3 2 3 3 3 1 3 4 2 0 3 0 2 3 4 0 0 4 1 2 2 3 1 2 2 4 3 3 0 0 2 0 1 3 1 0 2 0 2 0 4 4 4 2 0 4 4 0 3 3 3 0 2 1 4 2 2 3 0 4 1 4 4 4 2 1 3 3 3 4 4 1 3 2 3 4 0 4 4 2 3 1 4 0 2 1 2 2 1 3 0 1
0 2 0 4 0 0 1 3 3 2 3 3 3 1 3 4 2 0 3 0 2 3 4 0 0 4 1 2 2 3 1 2 2 4 3 3 0 0 2 0 1 3 1 0 2 0 2 0 ...

output:

YNNNN

result:

ok "YNNNN"

Test #123:

score: 0
Accepted
time: 19ms
memory: 3904kb

input:

100
3 4 3 0 0 2 3 1 2 0 2 4 4 2 3 0 3 4 4 3 1 1 3 3 3 0 4 3 4 4 4 1 2 3 4 2 1 3 3 3 4 2 3 1 0 1 0 1 3 4 1 3 4 0 3 4 4 0 3 1 2 0 1 0 3 2 1 1 0 2 2 4 3 3 0 4 4 1 0 3 0 4 2 1 1 1 4 4 1 3 4 1 3 3 1 1 3 0 1 0
0 1 0 2 2 4 0 3 4 2 4 1 1 4 0 2 0 1 1 0 3 3 0 0 0 2 1 0 1 1 1 3 4 0 1 4 3 0 0 0 1 4 0 3 2 3 2 3 ...

output:

YYYYY

result:

ok "YYYYY"

Test #124:

score: 0
Accepted
time: 19ms
memory: 3756kb

input:

63
1 2 0 2 1 4 0 1 0 2 2 0 0 2 3 2 0 0 2 3 1 3 0 2 4 3 3 1 4 2 4 3 4 0 2 2 3 1 4 1 3 3 0 0 4 1 4 0 3 4 2 3 0 3 1 2 1 3 3 4 2 2 0
1 2 0 2 1 4 0 1 0 2 2 0 0 2 3 2 0 0 2 3 1 3 0 2 4 3 3 1 4 2 4 3 4 0 2 2 3 1 4 1 3 3 0 0 4 1 4 0 3 4 2 3 0 3 1 2 1 3 3 4 2 2 0
0 1 4 1 0 3 4 0 4 1 1 4 4 1 2 1 4 4 1 2 0 2 4...

output:

YYYNY

result:

ok "YYYNY"

Test #125:

score: 0
Accepted
time: 5ms
memory: 3616kb

input:

8
3 4 4 3 2 3 2 2
2 3 3 2 1 2 1 1
1 2 2 1 0 1 0 0
4 0 0 4 3 4 3 3
0 1 1 0 4 0 4 4
1 2 2 1 0 1 0 0
1 2 2 1 1 3 2 0
4 0 0 4 3 4 3 3

output:

YYYNN

result:

ok "YYYNN"

Test #126:

score: 0
Accepted
time: 18ms
memory: 3908kb

input:

56
2 1 1 4 0 3 3 3 0 0 2 0 4 0 4 2 0 4 2 4 0 3 3 0 0 4 2 2 0 3 2 4 0 3 0 0 4 0 2 3 3 2 0 3 1 2 4 2 3 2 4 0 2 4 3 4
3 2 2 0 1 4 4 4 1 1 3 1 0 1 0 3 1 0 3 0 1 4 4 1 1 0 3 3 1 4 3 0 1 4 1 1 0 1 3 4 4 3 1 4 2 3 0 3 4 3 0 1 3 0 4 0
0 4 4 2 3 1 1 1 3 3 0 3 2 3 2 0 3 2 0 2 3 1 1 3 3 2 0 0 3 1 0 2 3 1 3 3 2...

output:

YNYYN

result:

ok "YNYYN"

Test #127:

score: 0
Accepted
time: 24ms
memory: 3740kb

input:

100
4 3 4 2 3 2 0 4 0 2 0 2 0 1 4 3 2 4 0 1 4 3 3 1 0 4 1 2 1 2 1 4 2 4 4 3 2 0 4 2 1 4 2 0 4 4 0 4 0 0 1 2 1 0 0 1 0 0 1 1 4 2 3 1 0 3 2 0 1 1 3 0 2 0 0 3 2 2 1 2 1 2 0 0 1 0 3 0 1 4 0 4 2 4 4 0 0 0 2 4
2 1 2 0 1 0 3 2 3 0 3 0 3 4 2 1 0 2 3 4 2 1 1 4 3 2 4 0 4 0 4 2 0 2 2 1 0 3 2 0 4 2 0 3 2 2 3 2 ...

output:

NYNNN

result:

ok "NYNNN"

Test #128:

score: 0
Accepted
time: 16ms
memory: 3644kb

input:

49
0 4 3 4 0 3 1 4 4 0 0 1 3 1 3 4 1 0 1 1 1 2 4 3 3 3 0 0 1 4 1 1 1 0 3 4 1 1 2 1 4 4 4 1 3 1 0 3 3
2 1 0 1 2 0 3 1 1 2 2 3 0 3 0 1 3 2 3 3 3 4 1 0 0 0 2 2 3 1 3 3 3 2 0 1 3 3 4 3 1 1 1 3 0 3 2 0 0
3 2 1 2 3 1 4 2 2 3 3 4 1 4 1 2 4 3 4 4 4 0 2 1 1 1 3 3 4 2 4 4 4 3 1 2 4 4 0 4 2 2 2 4 1 4 3 1 1
4 3...

output:

NYNNN

result:

ok "NYNNN"

Test #129:

score: 0
Accepted
time: 21ms
memory: 3824kb

input:

89
0 1 1 1 4 0 0 0 4 4 4 4 2 1 2 2 3 0 3 3 0 1 0 2 1 1 3 4 0 1 4 3 2 1 0 0 3 3 0 3 0 0 0 1 4 0 0 0 1 4 2 2 2 3 4 2 1 0 2 2 1 2 2 2 3 0 3 4 2 0 0 2 2 2 2 1 4 0 0 0 0 3 1 2 0 2 2 2 2
3 4 4 4 2 3 3 3 2 2 2 2 0 4 0 0 1 3 1 1 3 4 3 0 4 4 1 2 3 4 2 1 0 4 3 3 1 1 3 1 3 3 3 4 2 3 3 3 4 2 0 0 0 1 2 0 4 3 0 0...

output:

NYNNY

result:

ok "NYNNY"

Test #130:

score: 0
Accepted
time: 15ms
memory: 3720kb

input:

34
0 1 4 3 1 0 4 0 0 0 0 3 0 4 2 2 0 3 3 3 1 4 0 2 1 4 4 1 3 2 2 0 3 3
0 1 4 3 1 0 4 0 0 0 0 3 0 4 2 2 0 3 3 3 1 4 0 2 1 4 4 1 3 2 2 0 3 3
2 3 1 0 3 2 1 2 2 2 2 0 2 1 4 4 2 0 0 0 3 1 2 4 3 1 1 3 0 4 4 2 0 0
4 0 3 2 0 4 3 4 4 4 4 2 4 3 1 1 4 2 2 2 0 3 4 1 0 3 3 0 2 1 1 4 2 2
2 3 1 0 3 2 1 2 2 2 2 0 2...

output:

NYNYN

result:

ok "NYNYN"

Test #131:

score: 0
Accepted
time: 19ms
memory: 3768kb

input:

78
0 0 2 4 1 1 0 1 0 3 4 3 0 3 2 4 2 4 2 2 2 0 1 4 4 4 3 0 0 0 1 4 2 3 4 0 2 4 1 0 0 3 2 2 2 4 4 3 2 2 1 2 3 1 2 1 3 4 1 3 2 2 1 1 1 3 2 3 1 3 4 4 4 4 0 0 1 1
3 3 0 2 4 4 3 4 3 1 2 1 3 1 0 2 0 2 0 0 0 3 4 2 2 2 1 3 3 3 4 2 0 1 2 3 0 2 4 3 3 1 0 0 0 2 2 1 0 0 4 0 1 4 0 4 1 2 4 1 0 0 4 4 4 1 0 1 4 1 2...

output:

YYNYY

result:

ok "YYNYY"

Test #132:

score: 0
Accepted
time: 13ms
memory: 3640kb

input:

26
3 1 1 3 1 0 3 2 0 1 0 2 3 0 3 3 1 2 4 2 3 2 2 1 3 4
0 3 4 0 3 2 0 4 2 3 2 4 0 2 0 0 3 4 1 4 0 4 4 3 0 1
4 2 2 4 2 1 4 3 1 2 1 3 4 1 4 4 2 3 0 3 4 3 3 2 4 0
1 4 4 1 4 3 1 0 3 4 3 0 1 3 1 1 4 0 2 0 1 0 0 4 1 2
1 4 4 1 4 3 1 0 3 4 3 0 1 3 1 1 4 0 2 0 1 0 0 4 1 2
4 2 2 4 2 1 4 3 1 2 1 3 4 1 4 4 2 3 0...

output:

YNNNY

result:

ok "YNNNY"

Test #133:

score: 0
Accepted
time: 19ms
memory: 3748kb

input:

75
2 2 3 1 3 0 2 1 0 1 4 1 4 4 4 3 3 0 1 4 4 2 2 2 2 2 1 2 4 1 1 4 3 2 2 3 0 1 4 1 0 0 1 2 3 3 0 4 4 4 4 3 0 1 3 4 0 0 3 3 1 0 0 3 0 1 3 0 2 3 3 4 2 2 0
1 1 2 0 2 4 1 0 4 0 3 0 3 3 3 2 2 4 0 3 3 1 1 1 1 1 0 1 3 0 0 3 2 1 1 2 4 0 3 0 4 4 0 1 2 2 4 3 3 3 3 2 4 0 2 3 4 4 2 2 0 4 4 2 4 0 2 4 1 2 2 3 1 1...

output:

NYNNY

result:

ok "NYNNY"

Test #134:

score: 0
Accepted
time: 23ms
memory: 3736kb

input:

100
3 4 2 3 1 1 2 0 3 0 3 2 1 0 4 1 4 0 0 4 4 1 3 4 3 3 4 3 3 1 2 0 0 0 3 3 0 4 1 1 3 1 0 4 3 2 1 0 1 0 0 2 4 0 2 4 4 3 1 1 3 3 3 3 2 3 4 4 3 2 2 3 4 1 2 4 4 0 2 3 0 4 4 1 3 3 0 3 1 4 3 4 4 2 2 4 0 3 3 2
4 0 3 4 2 2 3 1 4 1 4 3 2 1 0 2 0 1 1 0 0 2 4 0 4 4 0 4 4 2 3 1 1 1 4 4 1 0 2 2 4 2 1 0 4 3 2 1 ...

output:

YNNNY

result:

ok "YNNNY"

Test #135:

score: 0
Accepted
time: 23ms
memory: 3852kb

input:

100
0 0 0 4 4 4 0 0 3 3 4 0 0 1 0 1 3 2 0 0 1 2 0 3 3 4 1 4 0 0 0 0 2 2 3 2 3 1 2 3 3 1 1 2 2 1 1 1 0 3 1 4 0 4 3 3 1 4 4 3 4 1 2 4 1 2 3 1 3 0 0 4 0 4 0 0 0 0 2 0 1 2 1 2 2 3 4 4 3 4 4 0 3 0 4 4 1 4 4 4
3 3 3 2 2 2 3 3 1 1 2 3 3 4 3 4 1 0 3 3 4 0 3 1 1 2 4 2 3 3 3 3 0 0 1 0 1 4 0 1 1 4 4 0 0 4 4 4 ...

output:

YYYYY

result:

ok "YYYYY"

Test #136:

score: 0
Accepted
time: 31ms
memory: 3864kb

input:

100
4 2 3 0 2 1 1 3 1 4 2 2 0 1 4 3 4 1 2 3 3 3 4 4 4 4 4 1 2 1 1 2 1 2 2 0 2 3 0 3 1 3 1 0 0 0 4 2 2 1 3 4 0 0 1 3 4 1 2 0 2 0 1 2 2 0 4 1 1 2 2 3 0 0 0 0 4 0 2 2 4 1 4 4 2 0 4 0 0 4 3 3 3 2 2 1 3 4 1 3
2 0 1 3 0 4 4 1 4 2 0 0 3 4 2 1 2 4 0 1 1 1 2 2 2 2 2 4 0 4 4 0 4 0 0 3 0 0 3 1 4 1 4 3 3 3 2 0 ...

output:

NYYYN

result:

ok "NYYYN"

Test #137:

score: 0
Accepted
time: 23ms
memory: 3864kb

input:

100
3 2 3 1 4 2 2 4 4 0 3 2 0 4 2 0 3 3 2 0 1 0 1 1 0 0 1 0 4 2 1 0 3 3 3 3 0 3 4 3 3 3 1 1 4 3 2 2 4 4 1 2 1 4 3 4 3 2 4 3 0 4 4 2 1 2 2 2 4 2 2 0 3 4 4 2 2 0 0 2 3 0 3 2 4 4 0 3 1 2 0 1 0 3 2 0 0 3 4 2
4 3 4 2 0 3 3 0 0 1 4 3 1 0 3 1 4 4 3 1 2 1 2 2 1 1 2 1 0 3 2 1 4 4 4 4 1 4 0 4 4 4 2 2 0 4 3 3 ...

output:

YYYNY

result:

ok "YYYNY"

Test #138:

score: 0
Accepted
time: 23ms
memory: 3796kb

input:

100
1 0 1 3 3 3 4 0 3 2 2 0 1 0 2 2 1 4 3 4 4 2 1 3 1 0 0 0 3 0 4 0 0 2 4 0 0 0 2 3 3 0 3 3 1 3 3 3 1 2 3 4 0 4 3 1 4 4 0 4 3 3 2 4 1 1 3 3 3 0 3 4 2 2 1 0 3 2 1 1 1 2 2 4 0 3 1 2 0 2 0 4 2 3 3 4 3 0 0 1
2 1 2 4 4 4 0 1 4 3 3 1 2 1 3 3 2 0 4 0 0 3 2 4 2 1 1 1 4 1 0 1 1 3 0 1 1 1 3 4 4 1 4 4 2 4 4 4 ...

output:

YNNNN

result:

ok "YNNNN"

Test #139:

score: 0
Accepted
time: 19ms
memory: 3960kb

input:

100
2 3 3 4 4 0 0 1 1 3 2 0 1 3 3 3 0 0 0 4 3 1 4 0 3 3 3 0 3 2 0 3 4 0 4 2 3 1 2 0 1 3 2 0 2 0 4 3 4 1 3 3 1 0 3 1 3 3 4 1 2 1 1 1 1 1 4 3 2 0 4 4 2 4 2 0 1 3 0 3 4 0 1 3 1 0 4 3 4 3 3 1 3 4 2 2 4 0 4 1
0 1 1 2 2 3 3 4 4 1 0 3 4 1 1 1 3 3 3 2 1 4 2 3 1 1 1 3 1 0 3 1 2 3 2 0 1 4 0 3 4 1 0 3 0 3 2 1 ...

output:

YYYYY

result:

ok "YYYYY"

Test #140:

score: 0
Accepted
time: 23ms
memory: 3836kb

input:

100
2 1 2 3 0 4 3 0 2 2 2 2 0 4 1 1 4 2 4 2 0 1 0 4 2 4 1 2 3 2 3 4 4 0 2 1 1 0 2 4 0 1 1 0 0 0 4 0 1 3 4 3 1 1 4 1 3 3 3 2 2 4 3 1 3 1 1 1 2 3 3 4 3 1 3 4 3 3 1 2 1 4 1 2 3 0 2 0 2 4 3 0 3 3 3 3 3 1 0 4
2 1 2 3 0 4 3 0 2 2 2 2 0 4 1 1 4 2 4 2 0 1 0 4 2 4 1 2 3 2 3 4 4 0 2 1 1 0 2 4 0 1 1 0 0 0 4 0 ...

output:

NNNNY

result:

ok "NNNNY"

Test #141:

score: 0
Accepted
time: 23ms
memory: 3800kb

input:

100
1 4 3 2 4 4 2 2 2 0 2 3 3 1 1 4 2 3 0 4 1 2 2 4 1 4 2 4 4 1 4 2 4 0 1 4 2 3 1 1 1 1 1 1 3 2 2 4 3 4 3 0 1 4 4 1 0 1 1 1 4 1 2 0 2 1 4 4 2 4 3 1 0 4 2 4 4 2 4 1 1 2 4 4 2 0 0 4 3 2 0 0 1 2 4 4 3 0 3 1
2 0 4 3 0 0 3 3 3 1 3 4 4 2 2 0 3 4 1 0 2 3 3 0 2 0 3 0 0 2 0 3 0 1 2 0 3 4 2 2 2 2 2 2 4 3 3 0 ...

output:

YYYYY

result:

ok "YYYYY"

Test #142:

score: 0
Accepted
time: 23ms
memory: 3800kb

input:

100
3 3 0 4 4 1 1 0 3 1 1 1 4 4 2 2 0 3 2 4 0 1 1 1 2 4 0 0 1 0 4 3 3 1 4 1 1 1 2 3 4 4 3 0 2 3 0 1 0 3 4 1 4 0 3 0 1 4 0 1 4 0 3 2 2 4 3 0 2 0 3 0 1 0 1 0 0 4 3 2 0 4 0 2 0 3 4 1 2 1 2 3 3 3 1 0 1 4 1 2
1 1 3 2 2 4 4 3 1 4 4 4 2 2 0 0 3 1 0 2 3 4 4 4 0 2 3 3 4 3 2 1 1 4 2 4 4 4 0 1 2 2 1 3 0 1 3 4 ...

output:

NNYNN

result:

ok "NNYNN"

Test #143:

score: 0
Accepted
time: 14ms
memory: 3664kb

input:

28
0 2 3 1 1 0 2 3 0 0 0 3 0 2 4 1 0 2 0 3 2 0 0 4 2 4 4 2
4 1 2 0 0 4 1 2 4 4 4 2 4 1 3 0 4 1 4 2 1 4 4 3 1 3 3 1
1 3 4 2 2 1 3 4 1 1 1 4 1 3 0 2 1 3 1 4 3 1 1 0 3 0 0 3
0 2 3 1 1 0 2 3 0 0 0 3 0 2 4 1 0 2 0 3 2 0 0 4 2 4 4 2
4 1 2 0 0 4 1 2 4 4 4 2 4 1 3 0 4 1 4 2 1 4 4 3 1 3 3 1
2 4 0 3 3 2 4 0 2...

output:

NNYNY

result:

ok "NNYNY"

Test #144:

score: 0
Accepted
time: 19ms
memory: 3728kb

input:

100
3 1 3 3 4 0 4 3 0 3 4 3 2 1 0 3 4 1 1 1 4 4 2 3 4 4 4 1 0 0 2 0 3 3 3 2 0 3 4 2 3 4 2 1 1 0 0 2 1 3 1 4 2 0 0 4 1 3 2 2 0 0 2 2 0 2 2 0 4 4 3 4 0 2 0 2 4 0 2 3 2 1 3 4 2 3 0 0 3 4 2 2 4 2 2 3 4 2 2 0
0 3 0 0 1 2 1 0 2 0 1 0 4 3 2 0 1 3 3 3 1 1 4 0 1 1 1 3 2 2 4 2 0 0 0 4 2 0 1 4 0 1 4 3 3 2 2 4 ...

output:

NYNNN

result:

ok "NYNNN"

Test #145:

score: 0
Accepted
time: 23ms
memory: 3772kb

input:

100
2 1 1 4 0 4 2 0 3 2 0 1 1 3 4 1 0 2 1 0 1 1 2 1 0 0 3 3 4 1 0 2 2 2 2 4 3 3 4 4 1 2 0 0 0 1 2 1 3 2 1 0 3 1 3 2 2 4 3 3 4 2 3 1 3 2 2 4 3 3 2 4 3 3 2 1 0 4 4 4 1 2 3 4 2 3 3 3 2 2 4 3 1 4 2 1 1 4 3 2
0 4 4 2 3 2 0 3 1 0 3 4 4 1 2 4 3 0 3 3 4 4 0 4 3 3 1 1 2 4 3 0 0 0 0 2 1 1 2 2 4 0 3 3 3 4 0 4 ...

output:

YYNNN

result:

ok "YYNNN"

Test #146:

score: 0
Accepted
time: 23ms
memory: 3800kb

input:

100
2 4 4 3 2 4 0 1 3 2 0 0 3 0 4 0 2 3 1 0 3 4 2 1 3 4 2 0 2 2 2 4 2 2 0 3 3 2 4 2 2 0 3 4 4 2 0 0 1 2 2 1 4 3 0 0 3 0 0 2 4 0 0 0 0 2 4 1 4 3 1 4 4 2 3 0 3 1 0 0 1 0 0 3 0 3 2 1 2 3 0 2 2 3 1 1 4 0 3 4
3 0 0 4 3 0 1 2 4 3 1 1 4 1 0 1 3 4 2 1 4 0 3 2 4 0 3 1 3 3 3 0 3 3 1 4 4 3 0 3 3 1 4 0 0 3 1 1 ...

output:

NNYYN

result:

ok "NNYYN"

Test #147:

score: 0
Accepted
time: 23ms
memory: 3788kb

input:

100
1 0 0 2 4 2 4 1 0 2 0 2 3 3 1 4 2 0 4 1 4 3 3 0 3 2 4 4 3 2 2 3 1 2 1 2 1 2 2 0 3 4 1 1 3 1 4 2 3 3 1 4 4 0 2 1 0 0 0 4 0 2 4 4 3 3 2 4 4 1 0 1 3 0 2 0 3 1 2 4 0 4 1 0 2 0 0 1 4 2 1 1 0 3 4 3 4 4 4 0
3 2 2 4 1 4 1 3 2 4 2 4 0 0 3 1 4 2 1 3 1 0 0 0 0 4 1 1 0 4 4 0 3 4 3 4 3 4 4 2 0 1 3 3 0 3 1 4 ...

output:

YNYNN

result:

ok "YNYNN"

Test #148:

score: 0
Accepted
time: 23ms
memory: 3832kb

input:

100
0 2 2 4 2 1 3 0 1 0 1 1 4 4 1 0 2 1 1 0 3 0 4 3 4 4 0 4 2 1 0 3 4 3 3 4 1 4 0 3 1 3 3 4 0 1 2 3 4 4 2 0 3 2 2 1 1 3 1 0 4 0 4 3 4 4 4 1 3 3 1 0 4 1 2 3 0 2 3 2 1 3 2 2 1 4 3 3 1 1 0 2 1 4 2 2 1 3 0 0
4 1 1 3 1 0 2 4 0 4 0 0 3 3 0 4 1 0 0 4 2 4 3 2 3 3 4 3 1 0 4 2 3 2 2 3 0 3 4 2 0 2 2 3 4 0 1 2 ...

output:

YYYYY

result:

ok "YYYYY"

Test #149:

score: 0
Accepted
time: 24ms
memory: 3832kb

input:

100
1 4 0 1 0 3 3 3 2 4 4 3 4 3 0 2 0 3 4 0 1 3 2 4 2 4 4 4 2 3 2 4 3 1 3 3 0 0 2 4 4 0 4 1 1 0 4 4 2 2 4 4 4 2 0 4 4 4 0 4 3 2 0 3 4 3 4 1 2 1 2 4 1 3 3 4 2 3 1 3 0 0 0 2 4 2 2 3 0 2 3 3 0 4 3 2 3 3 4 0
0 3 4 0 4 2 2 2 1 3 3 2 3 2 4 1 4 2 3 4 0 2 1 3 1 3 3 3 1 2 1 3 2 0 2 2 4 4 1 3 3 4 3 0 0 4 3 3 ...

output:

NNYNN

result:

ok "NNYNN"

Test #150:

score: 0
Accepted
time: 128ms
memory: 6820kb

input:

507
4 2 1 0 3 3 2 4 4 3 3 3 3 2 1 3 0 1 2 2 4 2 4 0 3 1 0 4 0 1 1 4 3 2 2 4 4 0 3 3 2 1 0 1 4 1 1 3 1 1 0 2 0 3 0 2 3 2 4 0 2 0 2 0 1 1 3 0 4 4 1 0 3 4 1 0 0 0 2 2 4 2 2 4 3 3 1 4 4 0 0 0 1 1 1 2 3 4 1 3 4 4 3 2 4 1 3 2 0 4 4 2 0 3 3 4 0 0 2 2 0 2 2 0 4 4 4 2 2 1 4 3 4 3 1 4 4 0 3 1 1 4 1 4 1 4 3 1 ...

output:

YYYNY

result:

ok "YYYNY"

Test #151:

score: 0
Accepted
time: 18ms
memory: 3680kb

input:

55
2 2 2 1 4 2 1 3 3 3 1 0 3 4 4 4 1 3 3 4 2 4 4 3 2 2 2 3 2 1 3 3 2 3 1 0 2 4 3 0 3 3 4 0 3 1 3 1 0 3 0 2 0 0 3
4 4 4 3 1 4 3 0 0 0 3 2 0 1 1 1 3 0 0 1 4 1 1 0 4 4 4 0 4 3 0 0 4 0 3 2 4 1 0 2 0 0 1 2 0 3 0 3 2 0 2 4 2 2 0
4 4 4 3 1 4 3 0 0 0 3 2 0 1 1 1 3 0 0 1 4 1 1 0 4 4 4 0 4 3 0 0 4 0 3 2 4 1 0...

output:

YYYYY

result:

ok "YYYYY"

Test #152:

score: 0
Accepted
time: 36ms
memory: 4380kb

input:

195
3 4 0 4 2 0 2 2 2 3 0 4 0 0 3 2 4 4 4 2 2 4 3 0 0 1 1 1 2 4 1 0 1 0 4 3 1 2 2 4 2 3 1 1 3 3 4 4 2 1 1 1 4 0 1 1 1 1 4 0 3 4 3 0 3 3 0 4 1 2 3 1 4 0 4 1 2 1 1 4 2 3 3 2 3 0 4 2 3 4 1 2 0 3 0 3 2 4 0 1 0 0 0 4 1 1 3 2 4 0 0 3 2 4 4 0 3 0 2 1 1 3 2 0 3 4 2 1 0 1 4 1 2 4 1 4 2 3 1 3 0 0 2 4 3 0 1 1 ...

output:

YYYYY

result:

ok "YYYYY"

Test #153:

score: 0
Accepted
time: 15ms
memory: 3656kb

input:

40
2 4 2 2 2 4 1 2 1 4 3 1 0 4 4 1 4 3 4 4 1 1 2 0 0 3 0 1 0 4 0 0 1 4 0 3 2 4 4 4
2 4 2 2 2 4 1 2 1 4 3 1 0 4 4 1 4 3 4 4 1 1 2 0 0 3 0 1 0 4 0 0 1 4 0 3 2 4 4 4
1 3 1 1 1 3 0 1 0 3 2 0 4 3 3 0 3 2 3 3 0 0 1 4 4 2 4 0 4 3 4 4 0 3 4 2 1 3 3 3
4 1 4 4 4 1 3 4 3 1 0 3 2 1 1 3 1 0 1 1 3 3 4 2 2 0 2 3 2...

output:

YYYYY

result:

ok "YYYYY"

Test #154:

score: 0
Accepted
time: 191ms
memory: 9312kb

input:

692
3 2 4 4 0 1 2 2 2 1 3 1 3 3 3 2 4 3 1 0 1 1 4 4 2 2 4 1 0 2 4 0 3 1 3 3 1 0 3 3 4 4 1 1 0 4 2 3 2 1 3 4 4 1 0 1 0 1 2 4 0 4 2 3 1 4 4 2 1 0 1 2 3 3 4 0 3 3 3 0 1 2 3 4 3 1 2 2 2 1 2 0 3 3 1 2 4 2 4 4 2 0 3 1 4 0 4 0 1 4 4 2 4 2 1 4 1 0 1 2 2 3 0 0 3 1 1 1 0 2 1 3 4 1 4 4 4 0 1 4 2 4 4 1 1 4 1 1 ...

output:

YYNNY

result:

ok "YYNNY"

Test #155:

score: 0
Accepted
time: 332ms
memory: 15544kb

input:

1000
2 2 0 0 2 2 2 2 4 1 1 4 3 1 2 2 1 3 1 4 2 2 2 2 4 1 0 0 4 2 3 1 4 3 2 1 3 3 1 4 4 3 3 3 3 0 3 0 1 4 0 4 3 0 2 1 1 1 3 3 0 0 4 3 1 3 2 3 0 0 2 0 1 1 1 4 1 4 0 4 2 0 0 2 0 0 3 1 0 1 4 4 3 4 4 1 2 2 0 4 0 0 3 0 4 1 1 4 0 4 2 3 3 4 0 4 2 1 3 3 0 0 0 0 1 1 0 1 4 4 3 2 0 2 0 4 1 0 4 0 0 1 4 2 2 3 1 3...

output:

NNYNY

result:

ok "NNYNY"

Test #156:

score: 0
Accepted
time: 399ms
memory: 15484kb

input:

1000
4 2 2 2 0 3 4 2 3 1 4 0 1 3 2 4 4 1 1 2 0 1 1 4 4 1 3 0 3 1 1 1 3 2 3 0 2 0 4 0 4 1 4 2 2 0 0 2 3 3 0 4 2 1 2 4 2 0 4 4 0 4 0 0 2 0 4 1 4 1 4 0 2 2 4 0 0 2 1 1 0 2 4 0 1 3 2 2 2 1 3 2 4 1 3 0 0 3 0 2 3 4 2 0 0 3 4 1 0 3 0 0 1 1 4 3 4 1 2 1 1 4 1 4 1 2 4 3 2 0 3 4 3 3 1 1 1 2 4 4 4 4 3 1 2 1 3 3...

output:

NYNYY

result:

ok "NYNYY"

Test #157:

score: 0
Accepted
time: 327ms
memory: 15456kb

input:

1000
4 1 3 3 2 4 3 3 0 0 0 0 3 0 4 3 1 3 0 3 4 2 2 4 2 2 3 3 1 1 0 2 4 2 1 3 0 0 0 0 0 0 2 2 0 3 1 0 0 3 4 2 1 0 3 2 1 4 3 1 1 1 2 4 0 2 2 0 0 0 2 1 3 1 3 1 3 2 3 2 3 0 1 2 1 1 3 1 3 4 0 1 0 3 1 3 4 1 3 0 2 4 0 0 1 3 3 0 4 4 3 2 0 2 3 1 0 0 3 3 3 3 4 3 0 3 0 1 1 1 4 4 1 0 3 3 4 4 3 4 1 4 0 3 4 2 4 2...

output:

YYYYN

result:

ok "YYYYN"

Test #158:

score: 0
Accepted
time: 335ms
memory: 15740kb

input:

1000
4 3 4 3 0 0 4 2 0 2 0 1 0 0 1 4 4 2 4 3 2 3 1 0 3 1 1 3 4 3 1 1 1 4 0 3 4 1 0 0 3 3 3 0 2 2 1 2 0 2 4 2 4 4 2 3 1 3 3 3 0 1 3 2 0 4 1 1 4 4 0 0 3 0 3 2 0 2 2 3 1 2 4 4 2 3 1 1 2 3 3 4 1 0 4 1 1 1 2 4 2 1 2 3 1 1 3 2 0 2 3 3 1 0 3 3 2 0 3 0 3 1 3 2 0 4 2 3 0 0 0 1 4 2 0 4 4 4 2 4 0 1 3 1 4 3 0 1...

output:

NYNNN

result:

ok "NYNNN"

Test #159:

score: 0
Accepted
time: 390ms
memory: 15452kb

input:

1000
4 4 2 2 4 2 4 1 4 2 1 1 3 0 1 1 4 3 1 3 0 3 0 4 3 1 2 4 3 4 2 4 2 0 1 0 1 3 0 0 3 4 0 2 3 4 3 1 2 4 2 1 3 0 0 0 2 0 2 3 3 1 0 0 4 1 2 0 2 3 3 0 0 0 0 0 2 0 1 3 3 1 3 2 2 2 0 0 0 3 4 0 4 0 4 3 1 1 4 2 4 4 0 0 0 2 0 3 0 3 3 0 0 2 3 4 3 2 4 1 2 3 1 1 2 1 4 0 2 4 3 4 4 4 0 0 2 2 0 1 2 2 3 0 4 4 2 1...

output:

NNYNN

result:

ok "NNYNN"

Test #160:

score: 0
Accepted
time: 328ms
memory: 15504kb

input:

1000
2 0 0 3 4 0 3 4 2 0 4 2 0 0 0 4 2 3 2 0 4 1 0 3 1 4 0 0 3 3 2 1 1 3 3 4 0 1 4 1 0 2 1 1 0 0 2 2 1 2 2 2 0 2 4 2 3 2 1 3 3 3 1 2 4 0 4 2 2 4 4 4 0 1 0 3 1 2 0 1 1 1 4 2 2 0 3 2 4 0 3 0 0 4 0 1 3 0 4 3 2 0 0 0 4 0 4 0 2 2 3 4 2 1 4 2 2 1 3 0 3 2 1 0 0 0 2 2 3 2 3 2 3 4 0 2 2 3 0 4 3 0 2 4 3 2 1 4...

output:

YNNNN

result:

ok "YNNNN"

Test #161:

score: 0
Accepted
time: 335ms
memory: 15456kb

input:

1000
2 3 2 4 2 1 4 4 2 2 3 4 1 1 4 4 2 3 2 4 3 0 4 3 2 2 4 0 3 4 4 1 2 1 4 4 3 4 4 2 3 2 1 4 1 4 1 2 1 0 3 1 2 1 3 1 3 0 4 2 1 1 0 3 4 1 3 1 0 2 4 4 1 3 1 3 1 3 0 3 1 1 0 3 0 3 2 1 3 4 1 3 2 1 2 4 0 4 2 0 1 0 4 2 4 0 4 2 0 0 3 1 2 4 3 0 3 3 1 3 2 3 1 0 0 2 0 0 3 2 1 4 4 2 1 1 1 2 1 2 0 1 1 3 3 1 2 3...

output:

NNNYY

result:

ok "NNNYY"

Test #162:

score: 0
Accepted
time: 329ms
memory: 15500kb

input:

1000
4 3 3 1 2 1 4 4 0 1 4 3 0 4 1 2 4 1 0 0 4 1 1 0 2 0 3 4 4 1 0 4 3 3 3 4 3 0 0 3 4 0 1 3 1 2 2 4 4 3 3 1 0 1 0 3 1 4 3 1 4 3 0 4 3 3 3 1 2 2 1 1 2 2 2 0 3 2 4 0 3 1 1 2 3 2 4 2 3 3 3 3 2 1 3 3 1 3 0 3 3 0 1 0 0 2 3 0 1 1 4 3 2 1 3 3 4 2 3 4 1 1 0 1 1 1 0 0 3 1 4 1 0 0 4 1 0 2 4 2 4 2 4 1 1 0 2 3...

output:

YYYYY

result:

ok "YYYYY"

Test #163:

score: 0
Accepted
time: 92ms
memory: 5484kb

input:

389
2 2 0 3 3 1 0 1 3 4 2 3 0 4 4 3 2 3 2 1 1 1 4 3 0 4 2 4 2 2 4 0 1 3 2 2 2 2 1 3 4 2 1 4 2 4 3 4 2 3 2 1 1 3 2 2 4 3 2 0 4 2 2 1 0 3 4 2 1 4 3 0 0 2 0 1 4 2 4 1 4 3 2 0 0 4 2 0 1 1 2 2 1 3 1 0 4 3 2 0 3 0 2 3 4 1 3 4 1 0 3 0 4 0 4 1 4 4 2 3 3 0 4 2 0 1 1 3 3 1 3 1 1 4 0 1 4 3 1 1 4 4 1 4 4 0 2 3 ...

output:

YYYYY

result:

ok "YYYYY"

Test #164:

score: 0
Accepted
time: 52ms
memory: 4404kb

input:

233
2 2 1 2 0 4 2 4 2 4 0 0 2 2 1 2 1 0 4 1 0 1 3 4 1 0 3 0 4 2 0 4 4 2 2 4 3 0 2 4 2 1 4 4 4 2 1 0 4 4 1 2 3 1 4 4 1 2 2 0 0 3 3 4 3 1 0 3 2 3 2 3 2 0 1 4 3 1 4 2 0 3 4 2 1 4 4 3 3 3 1 2 3 4 2 3 1 3 3 0 1 3 0 0 0 1 1 3 1 0 3 3 3 0 2 3 1 4 2 0 4 1 4 4 1 3 4 0 2 4 2 4 2 0 4 2 1 2 0 2 4 3 2 0 1 2 2 4 ...

output:

YYYYY

result:

ok "YYYYY"

Test #165:

score: 0
Accepted
time: 40ms
memory: 4068kb

input:

181
0 2 3 3 2 1 4 4 4 4 4 4 0 1 4 3 3 0 2 4 3 1 3 4 3 3 4 4 4 4 3 1 2 2 0 1 0 2 0 2 4 0 1 1 3 3 1 4 0 2 4 2 4 3 3 4 1 0 2 0 3 3 4 0 0 4 4 3 4 2 3 4 1 0 1 1 3 2 0 2 2 2 0 0 4 0 2 0 2 1 0 1 2 1 4 4 0 1 0 2 0 3 2 4 3 0 0 2 0 1 2 3 4 3 3 0 4 3 4 4 0 4 2 1 1 3 2 4 1 0 3 1 4 4 1 1 4 2 4 0 1 0 2 2 0 0 4 2 ...

output:

YYYYY

result:

ok "YYYYY"

Test #166:

score: 0
Accepted
time: 12ms
memory: 3904kb

input:

26
1 0 4 0 0 1 1 2 4 3 3 2 4 4 1 4 0 3 2 2 3 3 3 0 3 2
2 1 0 1 1 2 2 3 0 4 4 3 0 0 2 0 1 4 3 3 4 4 4 1 4 3
1 0 4 0 0 1 1 2 4 3 3 2 4 4 1 4 0 3 2 2 3 3 3 0 3 2
2 1 0 1 1 2 2 3 0 4 4 3 0 0 2 0 1 4 3 3 4 4 4 1 4 3
3 2 1 2 2 3 3 4 1 0 0 4 1 1 3 1 2 0 4 4 0 0 0 2 0 4
4 3 2 3 3 4 4 0 2 1 1 0 2 2 4 2 3 1 0...

output:

NYNYN

result:

ok "NYNYN"

Test #167:

score: 0
Accepted
time: 276ms
memory: 12596kb

input:

870
1 4 1 2 2 3 0 2 4 4 2 0 2 3 3 1 2 4 4 2 3 3 4 1 0 3 4 0 1 2 1 1 1 4 1 0 0 1 0 3 2 0 0 0 1 0 4 3 4 4 3 2 0 0 3 0 2 2 2 1 4 0 3 3 2 0 0 1 0 0 1 4 4 2 3 0 0 3 2 3 4 2 2 3 2 1 3 0 1 0 1 4 0 3 0 3 0 4 4 4 1 0 3 2 1 4 2 4 0 4 1 2 1 1 0 4 3 3 4 1 1 1 1 1 2 2 2 2 1 0 3 1 3 4 4 0 1 4 2 2 3 0 3 4 1 3 4 1 ...

output:

NYNYN

result:

ok "NYNYN"

Test #168:

score: 0
Accepted
time: 204ms
memory: 9640kb

input:

714
1 3 0 4 0 4 3 2 1 2 0 0 2 3 3 1 3 3 0 1 2 1 4 2 3 3 4 3 1 0 0 4 3 4 4 0 0 4 3 0 0 4 3 1 2 2 4 4 0 3 0 4 4 1 4 0 1 1 1 2 4 1 4 0 3 3 3 2 0 0 3 1 4 2 1 2 3 0 4 3 3 2 3 4 0 3 4 4 2 0 2 3 1 1 2 0 2 4 4 3 2 0 4 3 1 4 3 2 2 2 3 2 3 1 3 4 2 4 3 0 0 4 4 1 1 4 3 3 1 1 4 4 1 3 3 3 1 1 1 2 1 4 0 3 1 2 0 0 ...

output:

NNNNY

result:

ok "NNNNY"

Test #169:

score: 0
Accepted
time: 22ms
memory: 3948kb

input:

93
4 2 2 2 4 1 3 1 2 3 2 2 2 0 3 4 3 3 0 2 0 3 1 1 1 2 3 2 1 0 4 0 2 3 2 2 1 2 1 4 0 2 3 3 0 4 0 0 4 3 2 4 3 1 4 3 1 1 2 4 1 2 3 4 0 3 3 0 1 4 2 4 3 0 1 3 4 1 2 0 3 3 4 2 0 1 2 1 4 2 0 3 1
3 1 1 1 3 0 2 0 1 2 1 1 1 4 2 3 2 2 4 1 4 2 0 0 0 1 2 1 0 4 3 4 1 2 1 1 0 1 0 3 4 1 2 2 4 3 4 4 3 2 1 3 2 0 3 2...

output:

YYYYY

result:

ok "YYYYY"

Test #170:

score: 0
Accepted
time: 36ms
memory: 4016kb

input:

167
2 0 1 4 3 0 1 1 2 0 3 0 3 1 3 0 0 2 1 2 4 3 4 1 3 0 4 3 4 3 1 0 3 2 4 2 2 2 4 1 0 2 4 3 4 3 1 0 2 1 3 3 4 0 0 1 3 1 2 3 4 0 1 2 3 4 2 3 2 4 4 1 0 0 4 1 1 4 0 3 4 2 3 1 0 2 0 2 2 2 3 1 1 4 2 2 3 4 2 2 4 2 2 2 3 1 0 2 4 1 4 2 4 3 2 0 1 1 4 1 0 1 3 4 4 4 0 3 2 3 3 2 2 4 0 2 4 2 1 3 3 1 2 1 2 1 3 0 ...

output:

NYNNN

result:

ok "NYNNN"

Test #171:

score: 0
Accepted
time: 75ms
memory: 5052kb

input:

308
1 0 2 3 2 4 4 3 0 4 4 2 0 3 4 4 0 3 2 0 3 0 2 4 3 2 1 4 0 3 2 4 4 1 4 4 0 2 4 2 1 4 4 1 0 3 4 0 1 1 4 4 0 0 3 0 2 1 4 0 4 1 3 3 2 3 0 2 3 1 3 4 1 3 1 3 1 4 4 1 0 4 2 0 0 2 0 0 3 4 2 2 3 4 2 0 1 1 3 1 2 4 0 4 3 4 0 0 1 0 1 0 3 3 4 1 1 3 1 4 0 3 4 2 4 0 1 1 3 0 3 3 2 3 0 1 0 3 3 1 3 4 4 2 0 2 0 1 ...

output:

YYYYY

result:

ok "YYYYY"

Test #172:

score: 0
Accepted
time: 34ms
memory: 4192kb

input:

152
3 4 3 3 2 4 2 2 0 3 1 0 4 3 2 3 0 2 0 1 3 2 2 4 4 4 3 0 0 3 4 1 4 0 0 4 3 0 0 4 2 4 0 3 1 3 1 3 0 3 4 4 0 3 1 4 4 2 0 4 3 2 1 3 1 1 2 3 2 1 3 4 3 3 3 4 0 3 4 4 4 4 1 1 0 3 4 4 1 2 4 2 1 0 0 0 0 1 3 3 1 1 0 4 0 0 4 2 3 1 2 3 0 4 0 1 1 3 0 4 1 4 4 1 2 4 0 3 4 0 0 2 3 1 0 2 2 4 4 3 3 3 1 0 3 4 4 3 ...

output:

YYYNY

result:

ok "YYYNY"

Test #173:

score: 0
Accepted
time: 326ms
memory: 15412kb

input:

996
0 3 1 0 0 3 3 2 3 1 1 4 3 2 4 0 2 2 3 1 1 3 3 4 1 4 2 4 4 3 0 0 3 2 3 2 1 1 0 3 3 3 2 4 0 0 2 2 0 2 2 1 0 1 3 0 1 4 1 4 4 0 2 3 0 0 0 0 0 2 0 1 1 4 2 2 3 0 0 3 3 0 2 3 3 1 4 2 2 1 1 1 1 0 3 4 4 0 1 1 2 2 2 3 3 3 3 4 2 3 0 3 1 1 4 1 4 3 4 0 2 3 2 2 0 4 0 3 3 1 0 1 2 2 0 4 3 2 1 3 0 2 0 1 4 0 4 1 ...

output:

NNNNY

result:

ok "NNNNY"

Test #174:

score: 0
Accepted
time: 258ms
memory: 12056kb

input:

841
0 2 3 2 1 2 4 2 3 2 0 2 3 0 3 2 0 2 4 3 2 0 1 4 2 1 1 3 3 1 3 1 4 4 0 4 3 3 2 1 4 2 4 4 3 0 1 3 1 0 0 4 1 1 3 4 0 0 3 4 2 2 4 4 0 4 2 3 3 0 2 1 0 0 3 1 3 0 1 2 0 0 0 3 1 4 1 3 1 0 1 4 4 2 0 1 2 0 3 2 2 2 4 2 0 2 0 0 0 0 1 2 3 1 2 4 1 3 2 4 4 2 0 3 3 4 3 2 0 0 4 4 4 0 2 2 1 3 4 1 2 0 3 4 3 4 4 3 ...

output:

NNNNY

result:

ok "NNNNY"

Test #175:

score: 0
Accepted
time: 112ms
memory: 6300kb

input:

470
0 3 3 0 1 2 4 3 4 0 3 3 4 3 4 3 0 1 0 1 1 0 2 2 1 0 1 4 4 4 4 4 3 4 1 0 0 1 4 1 1 1 0 1 4 4 1 0 4 0 4 4 1 2 2 3 4 2 2 3 0 2 3 3 3 0 2 2 3 4 1 3 0 1 2 1 3 0 4 3 3 4 2 3 0 3 0 3 4 1 4 4 2 1 3 0 4 1 3 1 4 1 2 4 3 0 0 0 3 4 4 0 2 1 1 4 0 1 2 0 4 1 1 0 3 0 4 2 1 1 3 2 3 1 2 2 0 4 0 0 4 3 4 4 3 3 2 1 ...

output:

YYNYY

result:

ok "YYNYY"

Test #176:

score: 0
Accepted
time: 70ms
memory: 4848kb

input:

314
0 2 1 2 3 0 4 2 4 4 1 2 3 1 2 2 0 0 4 4 2 4 2 3 1 2 4 1 4 1 1 0 1 4 2 2 3 1 1 4 0 0 2 1 3 0 4 4 4 3 0 1 0 1 0 4 0 1 4 2 2 1 1 4 1 4 1 3 0 3 2 4 3 3 1 3 3 1 1 2 3 0 2 3 2 0 3 0 3 0 4 2 1 4 1 1 4 2 0 4 4 1 2 3 2 0 4 1 1 1 4 4 3 3 1 2 2 1 2 3 2 0 4 4 1 4 3 1 2 2 1 0 0 2 4 3 3 0 2 4 1 1 2 1 4 3 2 4 ...

output:

YNYYY

result:

ok "YNYYY"

Test #177:

score: 0
Accepted
time: 105ms
memory: 6104kb

input:

455
3 3 3 3 4 0 0 2 0 2 1 1 1 2 1 3 2 1 3 2 2 3 4 0 3 2 3 1 3 4 0 2 3 2 0 1 1 1 3 2 3 2 3 1 2 0 0 1 0 2 0 4 2 4 0 0 0 2 3 4 1 2 3 4 2 2 4 2 4 3 4 3 1 4 1 0 2 2 3 1 2 0 4 2 1 2 3 1 4 0 1 1 2 2 3 3 4 2 2 0 4 2 4 4 3 0 2 4 1 4 0 3 0 1 3 0 0 0 0 2 1 4 2 4 0 0 3 1 3 0 1 0 0 3 2 2 3 2 0 3 4 3 2 1 4 2 2 2 ...

output:

NYNYY

result:

ok "NYNYY"

Test #178:

score: 0
Accepted
time: 66ms
memory: 4688kb

input:

299
2 2 2 1 2 4 1 3 3 4 3 2 2 1 0 4 1 1 3 4 4 3 0 1 0 0 3 4 0 1 1 3 0 2 3 0 2 4 4 2 2 2 3 3 2 2 0 2 1 4 2 1 2 1 0 1 4 4 3 2 0 1 2 4 0 0 2 3 3 3 1 4 1 0 0 4 3 4 4 4 4 1 0 3 4 0 3 2 4 0 2 4 2 3 2 4 4 2 1 4 1 2 1 4 2 2 3 3 1 1 1 3 4 4 2 3 3 3 1 3 0 3 0 1 4 4 0 1 1 0 0 0 1 2 1 1 3 4 4 4 2 2 0 1 0 1 3 0 ...

output:

YYYYY

result:

ok "YYYYY"

Test #179:

score: 0
Accepted
time: 161ms
memory: 8728kb

input:

655
4 3 0 4 0 4 3 4 0 2 2 1 0 1 4 0 3 1 2 2 0 2 0 3 2 0 4 3 3 4 0 0 4 0 0 3 1 0 1 3 3 2 0 4 4 0 1 3 2 3 4 1 4 3 1 2 1 3 3 4 4 0 3 1 1 0 1 2 1 1 4 1 3 2 3 0 0 0 1 0 3 3 4 2 1 4 2 1 0 4 4 2 4 1 1 4 0 2 4 1 2 0 4 4 1 2 3 0 1 4 1 4 2 2 2 2 1 4 0 2 4 3 3 3 2 0 1 2 0 2 3 4 1 4 4 3 2 0 1 4 3 1 1 4 0 0 4 4 ...

output:

YYYYY

result:

ok "YYYYY"

Test #180:

score: 0
Accepted
time: 149ms
memory: 8540kb

input:

624
2 3 0 0 1 0 1 3 4 3 1 4 2 0 4 3 1 0 4 3 1 0 3 4 2 4 4 1 4 0 3 1 2 3 3 1 2 4 3 0 4 2 3 0 4 4 0 1 2 4 3 0 0 3 4 2 3 0 3 3 1 4 4 2 3 0 4 4 3 2 2 3 1 2 1 1 4 0 1 4 3 3 2 2 3 2 1 3 3 3 0 1 4 0 4 4 0 1 1 1 0 2 0 1 3 2 1 2 1 3 2 1 0 1 3 1 1 2 3 2 1 4 2 4 0 2 2 0 0 0 0 0 0 2 0 2 4 3 4 2 3 1 4 3 4 0 0 2 ...

output:

YYYNN

result:

ok "YYYNN"

Test #181:

score: 0
Accepted
time: 101ms
memory: 6292kb

input:

468
2 4 2 1 3 4 2 3 3 4 0 3 3 0 1 3 3 4 2 3 0 3 1 0 2 2 4 2 4 3 0 2 3 3 0 2 4 3 1 3 0 4 1 1 3 0 0 1 3 2 4 0 1 4 3 2 4 3 1 3 3 1 3 1 0 4 0 0 1 2 3 4 4 2 0 4 3 1 2 1 1 2 3 4 1 4 3 3 3 2 0 4 3 2 3 0 3 2 3 3 0 4 1 0 1 3 0 0 0 0 2 2 1 2 0 3 2 1 1 1 4 3 3 0 3 1 1 4 1 4 3 3 2 1 2 0 3 4 2 1 0 4 3 0 0 3 3 0 ...

output:

YNYYY

result:

ok "YNYYY"

Test #182:

score: 0
Accepted
time: 70ms
memory: 4788kb

input:

312
1 0 0 0 1 0 0 2 1 4 3 1 4 3 4 3 4 2 2 2 1 2 2 1 0 0 3 2 2 4 3 4 4 3 0 4 2 3 2 2 2 3 3 3 1 0 3 4 1 0 3 3 0 4 3 2 3 4 3 3 1 3 0 1 4 2 2 2 0 0 4 4 2 3 3 3 0 1 1 1 3 2 4 4 3 1 3 4 4 1 1 2 2 4 4 3 2 0 0 4 0 4 2 3 4 2 0 3 3 1 2 2 2 0 4 1 0 2 4 0 3 1 0 1 1 1 1 1 0 0 3 4 3 1 3 1 2 4 4 4 1 1 0 3 4 2 3 3 ...

output:

NYNYN

result:

ok "NYNYN"

Test #183:

score: 0
Accepted
time: 274ms
memory: 14620kb

input:

965
1 1 1 1 2 2 1 2 1 0 2 0 1 2 2 4 1 1 1 4 1 0 2 3 2 4 0 4 1 0 1 3 2 3 2 1 2 0 2 3 3 1 4 4 0 2 4 0 1 4 4 4 2 2 4 3 4 1 3 4 3 0 2 2 2 3 0 2 4 4 0 4 0 4 0 0 0 1 3 3 4 2 4 4 1 2 3 4 4 1 1 4 2 4 2 3 1 4 1 2 4 4 4 2 3 0 3 4 1 3 3 1 4 2 2 4 0 2 2 4 1 4 3 1 2 1 3 4 3 0 0 2 2 1 4 4 0 0 0 4 1 3 0 3 3 0 3 1 ...

output:

YNYNY

result:

ok "YNYNY"

Test #184:

score: 0
Accepted
time: 33ms
memory: 3804kb

input:

105
4 3 0 4 1 3 1 2 3 2 2 0 1 4 1 3 3 1 0 2 1 0 4 1 3 3 4 2 1 1 2 0 4 0 4 1 1 1 0 0 4 2 2 0 1 3 3 0 4 3 1 2 1 2 4 4 4 4 2 0 3 2 4 2 2 3 2 1 2 0 1 1 4 4 0 3 3 3 1 2 2 4 1 3 2 2 2 2 4 1 1 1 2 2 1 1 2 4 0 1 3 4 0 2 3
3 2 4 3 0 2 0 1 2 1 1 4 0 3 0 2 2 0 4 1 0 4 3 0 2 2 3 1 0 0 1 4 3 4 3 0 0 0 4 4 3 1 1 ...

output:

NNNYY

result:

ok "NNNYY"

Test #185:

score: 0
Accepted
time: 2ms
memory: 3636kb

input:

10
1 2 3 2 0 2 0 3 1 1
0 1 2 1 4 2 1 4 2 2
4 4 4 0 2 1 0 2 4 4
1 2 3 3 2 3 0 2 1 0
3 0 4 2 1 0 0 4 1 1
4 2 4 0 1 3 2 4 1 1
1 2 1 2 1 3 0 2 2 4
2 0 1 0 3 4 1 2 3 3
0 4 4 1 2 3 0 3 0 3
0 1 1 3 3 3 1 0 4 3

output:

YYYYY

result:

ok "YYYYY"

Test #186:

score: 0
Accepted
time: 5ms
memory: 3904kb

input:

10
4 1 0 4 2 3 3 3 4 1
0 3 0 4 3 4 1 1 1 1
0 3 3 1 4 3 1 0 0 0
0 1 4 2 1 1 4 0 2 1
1 0 3 1 0 2 0 3 3 4
4 0 2 0 1 4 2 0 0 2
0 3 0 3 3 2 4 1 1 1
2 0 3 1 3 2 3 0 4 4
2 0 1 2 4 1 2 2 2 2
3 2 4 2 1 0 3 4 3 2

output:

YYYYY

result:

ok "YYYYY"

Test #187:

score: 0
Accepted
time: 5ms
memory: 3892kb

input:

10
4 1 2 1 0 0 0 3 1 2
4 3 2 2 0 1 4 4 0 3
2 0 1 3 1 4 3 3 1 2
1 4 1 3 4 3 4 2 2 2
1 0 2 0 4 2 4 1 1 3
0 0 2 1 4 1 3 0 4 0
3 3 0 1 4 3 3 2 4 0
3 3 2 1 3 2 4 0 2 0
3 1 0 2 3 0 2 1 0 0
0 4 0 1 1 3 1 0 4 0

output:

YYYYY

result:

ok "YYYYY"

Test #188:

score: 0
Accepted
time: 5ms
memory: 3828kb

input:

10
2 0 0 3 3 4 4 1 3 0
1 4 1 3 2 4 3 1 1 2
4 0 0 0 4 4 0 3 1 0
3 0 3 1 0 3 4 3 4 3
1 0 2 1 4 3 4 4 4 2
1 0 1 4 3 2 4 2 1 1
1 2 3 1 4 2 2 1 0 0
0 3 3 1 3 2 1 2 3 0
0 2 3 0 1 0 0 0 4 3
2 3 0 1 0 4 2 4 1 1

output:

YYYYY

result:

ok "YYYYY"

Test #189:

score: 0
Accepted
time: 5ms
memory: 3864kb

input:

10
1 3 3 2 0 0 1 2 1 0
0 3 3 0 4 2 1 4 1 3
2 4 3 3 1 2 0 0 2 1
4 4 1 0 3 3 4 0 4 1
4 0 0 0 3 0 4 1 1 1
0 4 1 4 2 4 4 2 0 0
4 1 1 4 2 4 0 0 4 2
1 2 4 3 2 4 3 0 2 2
1 3 2 1 2 2 1 0 1 1
0 4 0 4 1 2 2 1 0 4

output:

YYYYY

result:

ok "YYYYY"

Test #190:

score: 0
Accepted
time: 5ms
memory: 3644kb

input:

10
2 3 1 1 4 2 4 2 2 1
4 3 1 1 0 1 1 2 4 1
3 3 0 0 2 3 3 1 1 3
0 1 3 2 2 1 0 2 4 2
3 1 4 4 0 1 3 4 4 1
2 3 0 1 1 1 0 2 4 1
2 1 3 0 3 4 4 2 3 2
3 2 1 3 3 4 1 0 0 2
3 2 1 1 2 1 3 0 0 4
2 0 2 3 4 1 4 3 1 4

output:

YYYYY

result:

ok "YYYYY"

Test #191:

score: 0
Accepted
time: 5ms
memory: 3896kb

input:

10
0 1 3 3 2 3 0 1 0 1
2 3 3 3 4 4 4 4 4 4
0 1 3 2 1 4 0 3 2 0
4 3 0 3 2 1 0 0 0 4
2 0 4 4 4 3 4 3 3 1
3 2 0 3 1 2 1 0 2 3
1 1 0 0 4 3 3 1 1 1
4 2 4 3 3 1 3 3 1 2
0 3 0 4 3 4 4 0 0 1
4 2 2 2 2 2 1 1 1 2

output:

YYYYY

result:

ok "YYYYY"

Test #192:

score: 0
Accepted
time: 281ms
memory: 15744kb

input:

1000
4 0 3 4 3 0 4 3 1 3 1 4 0 0 0 2 1 0 3 3 3 4 4 4 3 2 3 2 4 1 3 0 1 0 0 3 0 2 4 2 4 2 2 1 4 0 1 0 3 4 2 1 1 1 1 4 4 4 3 4 3 0 2 2 1 2 0 0 0 0 0 1 1 1 4 2 2 1 3 4 3 2 4 2 1 2 4 4 3 0 0 3 4 4 3 1 2 0 1 4 0 3 4 4 4 0 4 3 2 4 3 0 0 3 3 0 0 4 4 2 2 1 3 1 1 1 4 0 4 0 3 1 1 3 2 0 3 0 1 2 2 2 4 1 1 4 3 2...

output:

YYYYY

result:

ok "YYYYY"

Test #193:

score: 0
Accepted
time: 273ms
memory: 15708kb

input:

1000
3 3 1 2 2 3 1 4 3 1 0 4 3 4 2 2 0 3 2 2 0 2 2 0 4 3 3 4 4 2 2 4 3 4 4 4 2 2 4 0 0 0 1 0 2 2 1 1 1 3 3 0 0 2 1 2 0 4 0 2 1 4 0 2 3 2 4 4 1 4 1 1 3 0 0 4 0 3 4 3 0 3 3 2 2 2 4 1 1 4 2 2 4 1 1 2 0 4 2 3 4 4 2 3 0 4 2 2 4 2 3 2 0 2 3 0 2 4 2 0 2 0 3 2 4 2 3 2 2 4 4 2 0 4 2 4 3 4 0 3 1 4 1 4 1 3 2 0...

output:

YYYYY

result:

ok "YYYYY"

Test #194:

score: 0
Accepted
time: 277ms
memory: 15504kb

input:

1000
3 2 3 2 0 3 4 4 1 4 2 2 1 3 4 2 3 0 1 0 3 4 1 2 2 4 0 2 4 3 1 0 1 3 3 2 2 0 4 1 4 1 0 1 1 3 0 0 4 1 2 0 4 3 2 2 2 4 4 2 4 4 3 1 3 3 3 1 4 1 4 4 4 3 4 0 2 3 3 3 0 3 2 1 2 3 2 0 0 2 4 4 1 1 2 0 1 1 1 0 3 0 2 2 0 1 0 4 0 2 0 4 3 3 4 1 4 3 2 1 1 2 1 2 3 0 1 1 4 1 0 4 3 0 3 4 0 0 0 3 4 2 2 4 0 1 2 0...

output:

YYYYY

result:

ok "YYYYY"

Test #195:

score: 0
Accepted
time: 280ms
memory: 15448kb

input:

1000
1 2 1 3 1 0 2 0 3 3 2 2 3 0 0 4 2 3 2 0 3 4 0 4 1 1 1 2 0 1 2 2 3 4 2 3 2 2 1 2 3 1 0 0 4 0 0 3 1 0 3 3 4 3 1 4 3 1 3 0 3 4 1 2 3 2 1 0 3 1 0 3 2 3 4 0 0 1 1 4 3 2 1 1 2 0 4 4 4 0 0 0 1 0 0 4 3 4 4 4 3 0 4 4 2 0 4 3 0 0 0 3 2 2 0 1 2 2 3 2 2 1 1 4 0 2 2 2 2 3 2 4 1 3 0 4 2 3 4 3 0 3 0 4 0 4 3 0...

output:

YYYYY

result:

ok "YYYYY"

Test #196:

score: 0
Accepted
time: 285ms
memory: 15508kb

input:

1000
1 0 0 2 1 2 0 2 0 2 4 1 1 1 0 4 1 0 1 3 0 3 1 0 2 2 2 4 1 3 0 2 0 1 1 4 2 4 1 4 2 2 3 4 2 1 0 2 4 4 0 4 2 4 2 0 4 1 4 2 1 3 3 2 1 4 0 4 2 0 1 4 4 2 4 1 2 3 2 0 1 3 0 1 2 4 4 4 0 3 2 1 1 4 4 0 4 1 3 2 2 1 1 3 2 1 3 0 2 1 0 2 1 3 0 1 0 3 2 2 4 2 0 4 4 3 1 1 4 2 4 2 0 4 1 0 3 3 3 0 4 0 3 2 2 3 4 2...

output:

YYYYY

result:

ok "YYYYY"

Test #197:

score: 0
Accepted
time: 283ms
memory: 15524kb

input:

1000
0 1 2 4 3 0 2 3 2 2 4 2 4 3 2 0 1 3 0 2 3 2 4 1 3 3 0 1 1 4 0 3 2 4 2 3 3 3 1 2 3 1 3 0 2 1 4 0 3 0 4 3 3 1 0 1 0 3 4 4 3 3 3 3 2 4 4 0 1 2 3 4 1 3 4 2 4 4 4 0 1 0 3 0 4 0 2 3 3 4 1 0 2 4 0 3 2 0 4 3 2 2 3 2 4 4 0 0 3 2 0 4 0 2 3 3 4 2 3 0 4 0 0 1 4 1 4 4 2 1 0 3 4 0 2 2 0 4 2 2 3 0 3 1 3 0 3 3...

output:

YYYYY

result:

ok "YYYYY"

Test #198:

score: 0
Accepted
time: 270ms
memory: 15448kb

input:

1000
4 4 4 2 0 2 1 3 0 1 3 2 2 4 4 0 4 0 0 0 0 1 3 3 1 2 1 3 2 3 4 4 4 0 0 3 3 0 2 2 0 1 2 3 1 3 3 1 4 4 0 2 3 2 0 3 0 4 3 4 3 2 2 1 2 3 3 4 4 1 3 4 1 0 0 0 0 2 1 2 2 0 3 0 1 3 3 3 2 2 2 2 2 1 2 4 2 2 3 2 1 3 4 4 1 1 3 1 4 3 0 1 0 1 3 3 3 2 1 1 2 3 0 2 0 2 0 0 1 0 1 0 3 0 4 2 2 2 1 2 2 2 1 1 3 4 4 3...

output:

YYYYY

result:

ok "YYYYY"

Test #199:

score: 0
Accepted
time: 272ms
memory: 15688kb

input:

1000
4 4 1 2 4 4 4 2 2 1 0 2 3 1 1 1 3 2 3 0 3 0 1 4 0 3 2 2 2 4 0 3 0 4 0 2 3 2 2 0 0 2 3 0 4 4 4 0 3 2 1 2 1 4 4 4 1 3 4 3 4 3 4 1 1 3 2 0 0 4 3 4 0 4 4 1 2 0 4 2 1 1 1 0 0 2 0 4 1 0 4 3 1 4 3 3 3 0 2 0 0 4 1 4 2 0 3 1 4 1 4 1 2 3 4 2 0 1 2 1 3 1 3 3 0 3 1 4 3 2 3 0 4 1 4 3 2 3 1 2 1 4 2 1 2 3 0 0...

output:

YYYYY

result:

ok "YYYYY"

Test #200:

score: 0
Accepted
time: 277ms
memory: 15476kb

input:

1000
4 2 3 3 0 1 2 2 4 0 4 2 1 2 3 3 2 0 4 3 4 4 1 3 0 0 0 1 2 2 3 1 3 3 4 2 3 4 3 0 0 3 2 4 2 2 3 3 0 1 1 0 2 1 2 1 2 0 3 1 4 3 1 3 1 0 0 4 4 3 1 2 2 0 4 1 0 0 2 2 1 3 4 3 3 3 1 4 0 3 2 4 2 3 2 1 0 2 4 3 0 4 1 1 2 1 1 2 1 1 4 4 1 2 4 2 3 0 0 2 4 0 3 4 3 2 2 1 0 4 3 4 3 2 0 0 4 1 1 4 1 2 0 4 2 3 4 1...

output:

YYYYY

result:

ok "YYYYY"

Test #201:

score: 0
Accepted
time: 176ms
memory: 9772kb

input:

713
0 0 2 3 3 4 1 1 3 3 0 2 3 4 0 0 0 3 1 3 4 1 1 3 0 3 4 0 3 1 0 4 3 3 3 2 3 0 4 4 4 3 4 1 0 0 4 1 1 3 2 0 2 2 3 2 0 0 0 4 1 4 0 0 3 0 0 1 4 2 2 3 0 4 1 1 0 4 0 1 1 0 4 4 1 3 3 0 3 0 1 1 0 4 0 2 0 1 0 3 3 2 3 1 2 1 0 4 3 1 1 4 3 4 3 1 0 1 1 0 4 4 3 4 3 3 4 3 0 4 4 4 2 4 2 0 2 0 2 0 2 4 2 4 0 0 0 4 ...

output:

YYYYY

result:

ok "YYYYY"

Test #202:

score: 0
Accepted
time: 327ms
memory: 15568kb

input:

1000
1 4 0 0 3 2 3 1 2 1 3 3 4 3 4 2 1 2 4 3 2 4 1 0 0 0 1 0 0 2 3 4 4 2 0 3 2 3 1 3 2 4 0 0 1 4 4 3 4 2 3 3 2 0 3 3 3 3 2 3 1 0 4 4 0 0 0 4 1 3 2 3 3 2 1 4 2 4 0 1 0 2 1 3 0 4 0 4 4 4 3 3 3 4 2 4 0 1 2 0 4 0 4 3 4 2 4 0 1 3 4 1 0 4 0 4 2 4 0 3 1 0 3 1 2 4 4 4 3 4 3 2 4 2 0 1 2 2 0 0 1 2 0 4 3 3 3 3...

output:

YYYNY

result:

ok "YYYNY"

Test #203:

score: 0
Accepted
time: 335ms
memory: 15512kb

input:

1000
0 4 3 1 2 1 1 1 3 4 2 1 0 1 3 1 1 4 2 4 2 2 2 3 0 4 2 3 4 2 3 4 2 4 2 3 4 1 1 3 1 0 2 0 1 3 2 1 3 1 0 2 0 1 2 4 2 1 3 2 3 2 4 4 0 4 1 2 1 1 3 3 1 1 0 2 3 1 0 0 0 4 3 4 2 2 2 3 3 4 2 1 3 4 1 1 3 2 0 3 1 4 0 0 1 1 1 1 1 3 4 0 2 0 2 3 0 4 1 1 4 3 2 0 4 0 0 2 3 4 3 4 0 2 4 0 2 1 0 1 1 4 0 2 2 3 2 3...

output:

NYYYY

result:

ok "NYYYY"

Test #204:

score: 0
Accepted
time: 335ms
memory: 15712kb

input:

1000
4 4 4 0 0 1 0 3 2 2 4 0 2 2 3 4 2 4 2 3 3 2 3 0 4 3 1 1 0 1 1 2 0 0 1 0 0 1 4 2 3 4 4 1 0 0 2 0 3 0 1 0 1 1 4 2 1 3 0 2 4 1 4 1 3 1 4 3 1 1 3 1 3 1 1 4 4 2 2 4 2 2 0 0 0 2 1 0 2 3 1 0 4 0 3 3 3 4 2 4 2 2 2 0 1 4 3 2 3 2 1 1 1 0 1 4 2 2 1 0 1 3 1 2 1 1 2 2 1 1 2 3 2 1 2 2 2 2 0 1 3 4 3 1 1 1 2 0...

output:

NYYYY

result:

ok "NYYYY"

Test #205:

score: 0
Accepted
time: 329ms
memory: 15408kb

input:

1000
1 3 4 0 1 2 4 3 0 0 4 1 2 3 2 3 3 0 0 2 3 4 4 2 3 2 4 4 4 2 4 2 3 2 3 3 4 3 4 1 4 2 1 1 1 0 0 3 4 0 3 3 0 2 2 1 4 4 1 3 2 4 0 0 4 4 1 1 1 4 2 0 1 4 1 3 1 4 2 4 3 1 3 3 3 1 2 4 1 1 0 2 4 3 0 4 0 0 4 2 1 4 2 2 2 3 3 2 3 1 1 3 2 0 3 0 1 2 4 2 3 2 1 0 1 3 4 3 3 0 0 4 0 1 0 1 2 0 4 1 4 0 3 0 0 1 3 2...

output:

NYYYY

result:

ok "NYYYY"

Test #206:

score: 0
Accepted
time: 330ms
memory: 15508kb

input:

1000
4 4 2 2 0 4 2 0 0 3 3 4 2 2 0 4 2 3 4 1 1 1 0 0 1 2 1 1 2 3 3 4 2 4 4 4 4 1 4 2 3 0 2 1 1 0 3 4 3 4 0 4 4 2 1 4 4 1 4 2 0 1 0 3 4 3 3 0 1 1 2 0 3 3 0 2 2 3 1 3 1 3 2 1 3 2 4 1 0 1 3 2 0 3 4 0 2 1 3 0 3 2 0 3 1 0 0 1 3 4 4 1 2 4 0 2 2 2 0 4 0 3 3 4 2 3 4 0 3 3 3 1 4 1 4 4 0 1 2 1 0 0 4 1 2 3 0 2...

output:

YYYNY

result:

ok "YYYNY"

Test #207:

score: 0
Accepted
time: 326ms
memory: 15744kb

input:

1000
3 4 0 2 3 0 2 1 4 1 0 2 0 4 2 0 0 2 1 2 3 4 2 1 2 4 0 0 1 4 1 4 3 3 2 1 0 2 4 4 1 4 2 4 3 3 1 4 4 3 3 4 1 0 3 2 3 2 3 2 0 3 0 2 0 3 0 4 3 1 4 1 0 3 2 3 4 4 1 3 1 4 4 2 2 1 4 0 4 3 1 0 1 4 0 0 3 4 0 3 4 0 3 2 4 3 3 0 2 1 3 3 0 1 2 3 1 0 2 4 3 4 3 3 3 2 0 0 0 3 1 1 0 0 2 4 0 1 3 3 4 2 2 4 3 4 3 4...

output:

NYYYY

result:

ok "NYYYY"

Test #208:

score: 0
Accepted
time: 326ms
memory: 15444kb

input:

1000
1 0 1 3 4 3 3 3 4 4 2 4 2 0 1 3 1 2 0 1 0 2 0 4 4 4 4 3 3 1 1 0 3 0 0 0 2 1 3 1 1 1 3 4 1 3 0 3 4 3 3 3 1 4 2 1 4 2 3 1 2 2 4 1 1 2 3 4 2 0 1 3 4 3 3 0 1 4 2 3 3 0 4 0 1 1 2 2 1 1 0 3 3 2 1 0 1 1 0 2 3 0 0 1 3 1 0 2 4 3 0 2 0 2 4 0 4 1 3 1 1 3 4 4 3 0 1 3 0 2 4 2 1 2 4 0 0 0 2 3 4 1 1 3 3 4 1 0...

output:

YYNYY

result:

ok "YYNYY"

Test #209:

score: 0
Accepted
time: 332ms
memory: 15460kb

input:

1000
4 2 2 1 1 4 0 4 0 4 3 2 2 1 1 3 2 4 0 2 4 0 2 3 1 0 2 3 2 4 0 1 0 3 3 1 3 0 0 2 4 4 1 1 4 0 0 1 0 3 1 4 0 4 4 0 2 4 1 4 2 0 1 0 4 2 1 0 3 3 4 2 0 1 3 4 1 2 3 2 4 0 4 4 2 3 1 3 1 2 0 2 0 3 2 4 1 1 0 2 1 2 1 3 1 3 3 2 0 1 4 3 3 2 3 1 1 2 3 4 0 3 2 0 2 4 4 1 1 4 4 1 4 3 4 0 4 0 2 0 1 4 3 1 2 3 2 1...

output:

YYYNY

result:

ok "YYYNY"

Test #210:

score: 0
Accepted
time: 332ms
memory: 15620kb

input:

1000
2 3 4 1 1 1 0 3 1 0 2 0 3 0 4 3 1 2 3 4 2 2 0 1 1 2 4 1 1 0 0 0 3 0 0 4 3 3 0 2 2 0 1 4 0 0 3 3 0 2 3 3 2 1 3 3 1 3 1 2 1 3 1 1 3 1 1 4 3 4 2 4 3 0 3 3 2 1 3 0 0 3 4 3 0 3 3 4 1 0 4 4 1 4 3 3 3 2 3 3 0 2 3 0 2 2 3 1 3 0 0 1 0 1 4 2 4 2 1 1 0 1 2 2 2 1 4 1 3 2 3 4 0 4 2 4 4 4 0 3 3 2 4 3 0 1 4 3...

output:

YYNYY

result:

ok "YYNYY"

Test #211:

score: 0
Accepted
time: 337ms
memory: 15740kb

input:

1000
0 4 4 3 1 2 2 0 4 4 2 2 3 3 3 3 2 3 0 2 3 0 1 3 2 1 3 3 0 0 3 2 1 2 1 3 3 2 0 3 2 1 2 4 2 1 1 4 0 4 1 3 0 3 1 0 1 1 1 1 0 0 3 1 4 0 2 3 2 2 4 2 1 4 4 2 3 2 4 4 1 4 0 4 1 4 0 0 0 2 2 0 4 1 3 4 4 3 2 1 3 1 4 3 1 4 0 0 4 1 1 1 2 4 2 3 1 2 3 0 3 0 4 1 2 0 1 2 4 2 4 2 1 0 3 3 2 3 0 3 2 0 3 1 2 2 1 2...

output:

YYYYN

result:

ok "YYYYN"

Test #212:

score: 0
Accepted
time: 321ms
memory: 15516kb

input:

1000
1 4 0 0 3 2 3 1 2 1 3 3 4 3 4 2 1 2 4 3 2 4 1 0 0 0 1 0 0 2 3 4 4 2 0 3 2 3 1 3 2 4 0 0 1 4 4 3 4 2 3 3 2 0 3 3 3 3 2 3 1 0 4 4 0 0 0 4 1 3 2 3 3 2 1 4 2 4 0 1 0 2 1 3 0 4 0 4 4 4 3 3 3 4 2 4 0 1 2 0 4 0 4 3 4 2 4 0 1 3 4 1 0 4 0 4 2 4 0 3 1 0 3 1 2 4 4 4 3 4 3 2 4 2 0 1 2 2 0 0 1 2 0 4 3 3 3 3...

output:

YYYNY

result:

ok "YYYNY"

Test #213:

score: 0
Accepted
time: 328ms
memory: 15708kb

input:

1000
0 4 3 1 2 1 1 1 3 4 2 1 0 1 3 1 1 4 2 4 2 2 2 3 0 4 2 3 4 2 3 4 2 4 2 3 4 1 1 3 1 0 2 0 1 3 2 1 3 1 0 2 0 1 2 4 2 1 3 2 3 2 4 4 0 4 1 2 1 1 3 3 1 1 0 2 3 1 0 0 0 4 3 4 2 2 2 3 3 4 2 1 3 4 1 1 3 2 0 3 1 4 0 0 1 1 1 1 1 3 4 0 2 0 2 3 0 4 1 1 4 3 2 0 4 0 0 2 3 4 3 4 0 2 4 0 2 1 0 1 1 4 0 2 2 3 2 3...

output:

NYYYY

result:

ok "NYYYY"

Test #214:

score: 0
Accepted
time: 331ms
memory: 15508kb

input:

1000
4 4 4 0 0 1 0 3 2 2 4 0 2 2 3 4 2 4 2 3 3 2 3 0 4 3 1 1 0 1 1 2 0 0 1 0 0 1 4 2 3 4 4 1 0 0 2 0 3 0 1 0 1 1 4 2 1 3 0 2 4 1 4 1 3 1 4 3 1 1 3 1 3 1 1 4 4 2 2 4 2 2 0 0 0 2 1 0 2 3 1 0 4 0 3 3 3 4 2 4 2 2 2 0 1 4 3 2 3 2 1 1 1 0 1 4 2 2 1 0 1 3 1 2 1 1 2 2 1 1 2 3 2 1 2 2 2 2 0 1 3 4 3 1 1 1 2 0...

output:

NYYYY

result:

ok "NYYYY"

Test #215:

score: 0
Accepted
time: 336ms
memory: 15708kb

input:

1000
1 3 4 0 1 2 4 3 0 0 4 1 2 3 2 3 3 0 0 2 3 4 4 2 3 2 4 4 4 2 4 2 3 2 3 3 4 3 4 1 4 2 1 1 1 0 0 3 4 0 3 3 0 2 2 1 4 4 1 3 2 4 0 0 4 4 1 1 1 4 2 0 1 4 1 3 1 4 2 4 3 1 3 3 3 1 2 4 1 1 0 2 4 3 0 4 0 0 4 2 1 4 2 2 2 3 3 2 3 1 1 3 2 0 3 0 1 2 4 2 3 2 1 0 1 3 4 3 3 0 0 4 0 1 0 1 2 0 4 1 4 0 3 0 0 1 3 2...

output:

NYYYY

result:

ok "NYYYY"

Test #216:

score: 0
Accepted
time: 329ms
memory: 15512kb

input:

1000
4 4 2 2 0 4 2 0 0 3 3 4 2 2 0 4 2 3 4 1 1 1 0 0 1 2 1 1 2 3 3 4 2 4 4 4 4 1 4 2 3 0 2 1 1 0 3 4 3 4 0 4 4 2 1 4 4 1 4 2 0 1 0 3 4 3 3 0 1 1 2 0 3 3 0 2 2 3 1 3 1 3 2 1 3 2 4 1 0 1 3 2 0 3 4 0 2 1 3 0 3 2 0 3 1 0 0 1 3 4 4 1 2 4 0 2 2 2 0 4 0 3 3 4 2 3 4 0 3 3 3 1 4 1 4 4 0 1 2 1 0 0 4 1 2 3 0 2...

output:

YYYNY

result:

ok "YYYNY"

Test #217:

score: 0
Accepted
time: 325ms
memory: 15492kb

input:

1000
2 4 2 3 2 2 2 0 4 1 0 1 2 1 1 4 3 1 0 4 0 4 2 4 0 0 1 3 2 1 2 3 4 1 4 4 1 1 0 2 4 2 1 1 4 1 2 2 3 4 3 3 3 0 1 3 2 1 1 4 3 4 3 4 2 3 3 0 0 3 2 1 3 1 1 3 4 1 3 2 2 0 2 0 2 1 3 4 1 0 3 0 2 0 4 1 2 3 3 3 1 4 2 3 0 4 1 1 1 1 1 2 0 4 2 2 2 3 0 4 4 3 4 3 4 3 1 1 3 4 1 4 3 4 1 0 1 1 3 1 0 2 2 1 1 2 1 0...

output:

YYYYN

result:

ok "YYYYN"

Test #218:

score: 0
Accepted
time: 329ms
memory: 15544kb

input:

1000
0 3 4 0 4 3 0 1 0 0 1 0 0 3 0 1 0 0 4 0 2 3 0 2 4 1 3 0 2 3 3 0 3 0 1 4 2 0 2 0 3 0 0 1 1 3 2 2 0 2 1 4 3 2 2 2 1 0 2 3 3 3 1 4 3 4 2 4 2 2 0 2 2 4 3 2 4 1 1 1 3 2 3 3 4 4 1 2 3 3 4 4 4 0 0 2 4 3 3 2 4 1 4 1 2 2 3 3 4 1 4 1 1 2 0 4 2 4 2 2 1 2 2 3 0 0 2 4 4 0 1 4 3 1 0 0 0 1 2 1 3 2 2 4 4 1 0 1...

output:

YYYNY

result:

ok "YYYNY"

Test #219:

score: 0
Accepted
time: 335ms
memory: 15464kb

input:

1000
3 4 2 2 1 1 0 2 4 4 2 3 1 3 3 0 1 3 3 3 1 0 4 0 4 0 3 3 2 4 4 1 3 3 4 3 2 3 2 2 4 2 1 3 3 0 2 0 1 2 1 4 2 3 1 1 4 0 4 1 4 1 3 1 0 2 0 0 3 0 2 1 0 0 1 3 1 3 2 0 0 4 0 3 3 4 4 1 4 3 1 2 1 3 2 0 1 0 2 1 3 0 0 4 1 2 1 3 1 0 2 1 2 2 3 3 1 2 0 0 4 2 4 3 3 4 0 1 2 1 0 2 2 1 0 0 1 4 2 3 1 1 2 1 3 1 1 2...

output:

YNYYY

result:

ok "YNYYY"

Test #220:

score: 0
Accepted
time: 331ms
memory: 15528kb

input:

1000
4 4 2 0 2 3 2 2 0 1 2 0 0 2 1 3 0 3 1 3 4 3 0 2 2 3 3 4 4 2 1 2 4 3 0 3 1 2 2 1 4 4 1 1 1 3 0 2 0 1 2 4 4 1 0 3 4 3 3 1 2 4 0 3 2 1 0 0 1 2 0 3 3 3 3 0 2 3 1 4 1 4 2 0 4 3 0 3 3 1 1 0 4 4 1 4 0 1 1 4 2 1 2 1 4 4 1 2 0 0 4 1 0 2 4 1 3 4 2 1 1 0 1 1 2 0 0 0 2 3 3 4 0 3 1 4 4 3 1 1 1 2 3 0 0 3 4 3...

output:

YYNYY

result:

ok "YYNYY"

Test #221:

score: 0
Accepted
time: 329ms
memory: 15460kb

input:

1000
0 4 1 1 4 4 4 0 3 2 1 4 4 2 0 2 3 3 0 1 0 2 2 1 4 3 0 0 2 0 0 2 4 0 3 3 4 1 1 2 4 3 1 3 3 1 4 4 2 2 4 0 3 4 1 4 4 2 0 1 3 2 4 1 3 1 2 3 1 0 1 3 4 1 4 0 2 1 4 4 4 2 4 4 4 0 0 3 3 3 2 1 4 3 0 1 1 3 1 3 3 4 2 4 3 3 3 0 2 4 4 3 2 4 1 0 0 4 1 3 0 3 1 0 2 3 2 2 2 4 2 3 3 3 0 3 2 1 0 1 1 3 1 4 3 4 3 4...

output:

YYYYN

result:

ok "YYYYN"

Test #222:

score: 0
Accepted
time: 402ms
memory: 15708kb

input:

1000
3 4 0 2 3 0 2 1 4 1 0 2 0 4 2 0 0 2 1 2 3 4 2 1 2 4 0 0 1 4 1 4 3 3 2 1 0 2 4 4 1 4 2 4 3 3 1 4 4 3 3 4 1 0 3 2 3 2 3 2 0 3 0 2 0 3 0 4 3 1 4 1 0 3 2 3 4 4 1 3 1 4 4 2 2 1 4 0 4 3 1 0 1 4 0 0 3 4 0 3 4 0 3 2 4 3 3 0 2 1 3 3 0 1 2 3 1 0 2 4 3 4 3 3 3 2 0 0 0 3 1 1 0 0 2 4 0 1 3 3 4 2 2 4 3 4 3 4...

output:

NYYYY

result:

ok "NYYYY"

Test #223:

score: 0
Accepted
time: 329ms
memory: 15484kb

input:

1000
1 0 1 3 4 3 3 3 4 4 2 4 2 0 1 3 1 2 0 1 0 2 0 4 4 4 4 3 3 1 1 0 3 0 0 0 2 1 3 1 1 1 3 4 1 3 0 3 4 3 3 3 1 4 2 1 4 2 3 1 2 2 4 1 1 2 3 4 2 0 1 3 4 3 3 0 1 4 2 3 3 0 4 0 1 1 2 2 1 1 0 3 3 2 1 0 1 1 0 2 3 0 0 1 3 1 0 2 4 3 0 2 0 2 4 0 4 1 3 1 1 3 4 4 3 0 1 3 0 2 4 2 1 2 4 0 0 0 2 3 4 1 1 3 3 4 1 0...

output:

YYNYY

result:

ok "YYNYY"

Test #224:

score: 0
Accepted
time: 332ms
memory: 15500kb

input:

1000
4 2 2 1 1 4 0 4 0 4 3 2 2 1 1 3 2 4 0 2 4 0 2 3 1 0 2 3 2 4 0 1 0 3 3 1 3 0 0 2 4 4 1 1 4 0 0 1 0 3 1 4 0 4 4 0 2 4 1 4 2 0 1 0 4 2 1 0 3 3 4 2 0 1 3 4 1 2 3 2 4 0 4 4 2 3 1 3 1 2 0 2 0 3 2 4 1 1 0 2 1 2 1 3 1 3 3 2 0 1 4 3 3 2 3 1 1 2 3 4 0 3 2 0 2 4 4 1 1 4 4 1 4 3 4 0 4 0 2 0 1 4 3 1 2 3 2 1...

output:

YYYNY

result:

ok "YYYNY"

Test #225:

score: 0
Accepted
time: 332ms
memory: 15544kb

input:

1000
2 3 4 1 1 1 0 3 1 0 2 0 3 0 4 3 1 2 3 4 2 2 0 1 1 2 4 1 1 0 0 0 3 0 0 4 3 3 0 2 2 0 1 4 0 0 3 3 0 2 3 3 2 1 3 3 1 3 1 2 1 3 1 1 3 1 1 4 3 4 2 4 3 0 3 3 2 1 3 0 0 3 4 3 0 3 3 4 1 0 4 4 1 4 3 3 3 2 3 3 0 2 3 0 2 2 3 1 3 0 0 1 0 1 4 2 4 2 1 1 0 1 2 2 2 1 4 1 3 2 3 4 0 4 2 4 4 4 0 3 3 2 4 3 0 1 4 3...

output:

YYNYY

result:

ok "YYNYY"

Test #226:

score: 0
Accepted
time: 333ms
memory: 15676kb

input:

1000
0 4 4 3 1 2 2 0 4 4 2 2 3 3 3 3 2 3 0 2 3 0 1 3 2 1 3 3 0 0 3 2 1 2 1 3 3 2 0 3 2 1 2 4 2 1 1 4 0 4 1 3 0 3 1 0 1 1 1 1 0 0 3 1 4 0 2 3 2 2 4 2 1 4 4 2 3 2 4 4 1 4 0 4 1 4 0 0 0 2 2 0 4 1 3 4 4 3 2 1 3 1 4 3 1 4 0 0 4 1 1 1 2 4 2 3 1 2 3 0 3 0 4 1 2 0 1 2 4 2 4 2 1 0 3 3 2 3 0 3 2 0 3 1 2 2 1 2...

output:

YYYYN

result:

ok "YYYYN"

Test #227:

score: 0
Accepted
time: 332ms
memory: 15452kb

input:

1000
3 2 2 0 4 2 3 2 1 1 1 1 4 2 4 1 3 4 0 0 3 3 4 3 0 4 1 1 1 4 0 4 1 0 2 0 4 1 3 4 4 2 0 2 0 3 3 4 2 0 0 4 2 2 2 0 1 1 2 4 3 4 3 0 3 1 2 4 4 1 2 0 0 3 4 3 0 3 1 4 0 1 4 0 1 0 3 1 4 0 3 0 2 2 4 1 0 1 2 1 3 4 1 2 1 4 0 1 0 0 3 3 3 4 1 4 1 4 2 0 2 0 1 1 2 2 2 0 1 2 0 1 3 2 0 4 4 3 1 3 4 0 1 0 2 4 4 4...

output:

NYYYY

result:

ok "NYYYY"

Test #228:

score: 0
Accepted
time: 337ms
memory: 15508kb

input:

1000
1 1 4 1 4 4 4 2 4 0 2 2 0 1 0 4 3 0 3 2 4 0 0 1 0 4 3 4 4 1 1 4 2 2 4 0 0 4 3 1 4 3 1 0 0 3 1 2 1 2 4 4 4 1 1 3 2 0 3 3 2 2 2 0 3 4 1 3 4 3 0 4 3 2 0 3 1 0 2 4 0 1 4 3 2 3 0 2 3 2 1 0 3 3 0 1 2 1 1 4 1 0 2 3 2 1 1 3 2 0 3 2 1 3 3 2 1 0 3 0 4 2 2 0 1 1 4 1 1 2 2 4 0 3 3 3 4 2 0 3 1 2 2 3 4 1 0 1...

output:

YNYYY

result:

ok "YNYYY"

Test #229:

score: 0
Accepted
time: 328ms
memory: 15512kb

input:

1000
3 3 0 4 4 0 0 3 0 4 1 0 2 0 4 2 4 0 3 2 3 1 3 4 3 0 2 1 4 2 3 2 2 1 2 0 1 3 4 3 0 1 2 2 3 3 0 1 3 4 2 3 4 4 1 3 0 4 4 0 3 0 1 0 4 0 4 1 3 3 3 0 2 0 3 2 3 1 2 3 1 4 0 2 0 1 1 1 3 4 0 4 1 4 1 3 2 4 0 4 3 0 1 1 1 1 0 3 2 1 2 2 2 0 4 3 0 4 3 4 0 1 3 4 2 2 1 3 4 3 1 2 3 1 0 4 3 1 4 3 2 1 3 2 1 2 3 2...

output:

YYNYY

result:

ok "YYNYY"

Test #230:

score: 0
Accepted
time: 330ms
memory: 15440kb

input:

1000
1 3 0 4 0 1 2 3 0 1 1 3 3 2 2 0 0 0 3 1 0 2 2 1 3 0 4 4 3 3 4 2 0 1 3 4 0 1 0 2 4 3 4 1 0 4 3 2 3 1 3 4 3 2 0 3 4 2 0 3 4 2 0 0 2 4 0 1 3 4 3 2 0 0 0 2 1 2 2 2 2 0 3 4 1 0 1 3 3 0 4 1 0 0 0 4 3 4 0 0 1 1 1 0 4 3 4 2 3 4 3 1 4 3 0 2 1 4 4 0 4 0 0 2 4 1 1 0 4 3 1 0 3 0 4 3 3 0 4 2 3 2 3 4 3 1 0 4...

output:

YYNYY

result:

ok "YYNYY"

Test #231:

score: 0
Accepted
time: 330ms
memory: 15708kb

input:

1000
1 2 4 1 3 0 3 3 2 1 1 1 2 0 3 3 3 4 3 3 2 2 4 0 4 0 2 4 2 0 0 4 4 2 1 4 0 4 0 0 3 2 3 3 1 4 2 3 0 4 0 4 1 2 3 2 3 2 4 0 2 3 4 0 3 0 4 0 1 1 4 3 3 4 4 2 0 0 3 0 2 3 4 3 4 2 3 1 1 1 4 1 1 4 1 3 1 1 4 0 2 4 1 4 1 0 0 3 2 1 4 1 0 0 2 0 2 4 1 0 3 0 2 1 0 1 0 0 0 1 3 0 1 1 4 3 4 3 3 0 2 4 2 0 4 2 1 2...

output:

YYNYY

result:

ok "YYNYY"

Extra Test:

score: 0
Extra Test Passed