結果

問題 No.3439 [Cherry 8th Tune] どの頂点にいた頃に戻りたいのか?
コンテスト
ユーザー 👑 Kazun
提出日時 2025-11-18 00:44:43
言語 C++17
(gcc 15.2.0 + boost 1.89.0)
結果
RE  
実行時間 -
コード長 21,968 bytes
記録
記録タグの例:
初AC ショートコード 純ショートコード 純主流ショートコード 最速実行時間
コンパイル時間 6,104 ms
コンパイル使用メモリ 336,740 KB
実行使用メモリ 11,228 KB
最終ジャッジ日時 2026-01-23 21:04:55
合計ジャッジ時間 16,877 ms
ジャッジサーバーID
(参考情報)
judge2 / judge5
このコードへのチャレンジ
(要ログイン)
ファイルパターン 結果
sample RE * 2
other WA * 4 RE * 33
権限があれば一括ダウンロードができます

ソースコード

diff #
raw source code

#line 2 "/home/user/competitive_programming/library_for_cpp/template/template.hpp"

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
#line 2 "/home/user/competitive_programming/library_for_cpp/template/utility.hpp"

using ll = long long;

// a ← max(a, b) を実行する. a が更新されたら, 返り値が true.
template<typename T, typename U>
inline bool chmax(T &a, const U b){
    return (a < b ? a = b, 1: 0);
}

// a ← min(a, b) を実行する. a が更新されたら, 返り値が true.
template<typename T, typename U>
inline bool chmin(T &a, const U b){
    return (a > b ? a = b, 1: 0);
}
#line 59 "/home/user/competitive_programming/library_for_cpp/template/template.hpp"

// math
#line 2 "/home/user/competitive_programming/library_for_cpp/template/math.hpp"

// 除算に関する関数

// floor(x / y) を求める.
template<typename T, typename U>
T div_floor(T x, U y){ return (x > 0 ? x / y: (x - y + 1) / y); }

// ceil(x / y) を求める.
template<typename T, typename U>
T div_ceil(T x, U y){ return (x > 0 ? (x + y - 1) / y: x / y) ;}

// x を y で割った余りを求める.
template<typename T, typename U>
T safe_mod(T x, U y){
    T q = div_floor(x, y);
    return x - q * y ;
}

// x を y で割った商と余りを求める.
template<typename T, typename U>
pair<T, T> divmod(T x, U y){
    T q = div_floor(x, y);
    return {q, x - q * y};
}

// 四捨五入を求める.
template<typename T, typename U>
T round(T x, U y){
    T q, r;
    tie (q, r) = divmod(x, y);
    return (r >= div_ceil(y, 2)) ? q + 1 : q;
}

// 指数に関する関数

// x の y 乗を求める.
ll intpow(ll x, ll y){
    ll a = 1;
    while (y){
        if (y & 1) { a *= x; }
        x *= x;
        y >>= 1;
    }
    return a;
}

// x の y 乗を z で割った余りを求める.
ll modpow(ll x, ll y, ll z){
    ll a = 1;
    while (y){
        if (y & 1) { (a *= x) %= z; }
        (x *= x) %= z;
        y >>= 1;
    }
    return a;
}

// x の y 乗を z で割った余りを求める.
template<typename T, typename U>
T modpow(T x, U y, T z) {
    T a = 1;
    while (y) {
        if (y & 1) { (a *= x) %= z; }

        (x *= x) %= z;
        y >>= 1;
    }

    return a;
}

// vector の要素の総和を求める.
ll sum(vector<ll> &X){
    ll y = 0;
    for (auto &&x: X) { y+=x; }
    return y;
}

// vector の要素の総和を求める.
template<typename T>
T sum(vector<T> &X){
    T y = T(0);
    for (auto &&x: X) { y += x; }
    return y;
}

// a x + b y = gcd(a, b) を満たす整数の組 (a, b) に対して, (x, y, gcd(a, b)) を求める.
tuple<ll, ll, ll> Extended_Euclid(ll a, ll b) {
    ll s = 1, t = 0, u = 0, v = 1;
    while (b) {
        ll q;
        tie(q, a, b) = make_tuple(div_floor(a, b), b, safe_mod(a, b));
        tie(s, t) = make_pair(t, s - q * t);
        tie(u, v) = make_pair(v, u - q * v);
    }

    return make_tuple(s, u, a);
}

// floor(sqrt(N)) を求める (N < 0 のときは, 0 とする).
ll isqrt(const ll &N) { 
    if (N <= 0) { return 0; }

    ll x = sqrt(N);
    while ((x + 1) * (x + 1) <= N) { x++; }
    while (x * x > N) { x--; }

    return x;
}

// floor(sqrt(N)) を求める (N < 0 のときは, 0 とする).
ll floor_sqrt(const ll &N) { return isqrt(N); }

// ceil(sqrt(N)) を求める (N < 0 のときは, 0 とする).
ll ceil_sqrt(const ll &N) {
    ll x = isqrt(N);
    return x * x == N ? x : x + 1;
}
#line 62 "/home/user/competitive_programming/library_for_cpp/template/template.hpp"

// inout
#line 1 "/home/user/competitive_programming/library_for_cpp/template/inout.hpp"
// 入出力
template<class... T>
void input(T&... a){ (cin >> ... >> a); }

void print(){ cout << "\n"; }

template<class T, class... Ts>
void print(const T& a, const Ts&... b){
    cout << a;
    (cout << ... << (cout << " ", b));
    cout << "\n";
}

template<typename T, typename U>
istream &operator>>(istream &is, pair<T, U> &P){
    is >> P.first >> P.second;
    return is;
}

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

template<typename T>
vector<T> vector_input(int N, int index){
    vector<T> X(N+index);
    for (int i=index; i<index+N; i++) cin >> X[i];
    return X;
}

template<typename T>
istream &operator>>(istream &is, vector<T> &X){
    for (auto &x: X) { is >> x; }
    return is;
}

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

template<typename T>
ostream &operator<<(ostream &os, const unordered_set<T> &S){
    int i = 0;
    for (T a: S) {os << (i ? " ": "") << a; i++;}
    return os;
}

template<typename T>
ostream &operator<<(ostream &os, const set<T> &S){
    int i = 0;
    for (T a: S) { os << (i ? " ": "") << a; i++; }
    return os;
}

template<typename T>
ostream &operator<<(ostream &os, const unordered_multiset<T> &S){
    int i = 0;
    for (T a: S) { os << (i ? " ": "") << a; i++; }
    return os;
}

template<typename T>
ostream &operator<<(ostream &os, const multiset<T> &S){
    int i = 0;
    for (T a: S) { os << (i ? " ": "") << a; i++; }
    return os;
}
#line 65 "/home/user/competitive_programming/library_for_cpp/template/template.hpp"

// macro
#line 2 "/home/user/competitive_programming/library_for_cpp/template/macro.hpp"

// マクロの定義
#define all(x) x.begin(), x.end()
#define len(x) ll(x.size())
#define elif else if
#define unless(cond) if (!(cond))
#define until(cond) while (!(cond))
#define loop while (true)

// オーバーロードマクロ
#define overload2(_1, _2, name, ...) name
#define overload3(_1, _2, _3, name, ...) name
#define overload4(_1, _2, _3, _4, name, ...) name
#define overload5(_1, _2, _3, _4, _5, name, ...) name

// 繰り返し系
#define rep1(n) for (ll i = 0; i < n; i++)
#define rep2(i, n) for (ll i = 0; i < n; i++)
#define rep3(i, a, b) for (ll i = a; i < b; i++)
#define rep4(i, a, b, c) for (ll i = a; i < b; i += c)
#define rep(...) overload4(__VA_ARGS__, rep4, rep3, rep2, rep1)(__VA_ARGS__)

#define foreach1(x, a) for (auto &&x: a)
#define foreach2(x, y, a) for (auto &&[x, y]: a)
#define foreach3(x, y, z, a) for (auto &&[x, y, z]: a)
#define foreach4(x, y, z, w, a) for (auto &&[x, y, z, w]: a)
#define foreach(...) overload5(__VA_ARGS__, foreach4, foreach3, foreach2, foreach1)(__VA_ARGS__)
#line 68 "/home/user/competitive_programming/library_for_cpp/template/template.hpp"

// bitop
#line 2 "/home/user/competitive_programming/library_for_cpp/template/bitop.hpp"

// 非負整数 x の bit legnth を求める.
ll bit_length(ll x) {
    if (x == 0) { return 0; }
    return (sizeof(long) * CHAR_BIT) - __builtin_clzll(x);
}

// 非負整数 x の popcount を求める.
ll popcount(ll x) { return __builtin_popcountll(x); }

// 正の整数 x に対して, floor(log2(x)) を求める.
ll floor_log2(ll x) { return bit_length(x) - 1; }

// 正の整数 x に対して, ceil(log2(x)) を求める.
ll ceil_log2(ll x) { return bit_length(x - 1); }

// x の第 k ビットを取得する
int get_bit(ll x, int k) { return (x >> k) & 1; }

// x のビット列を取得する.
// k はビット列の長さとする.
vector<int> get_bits(ll x, int k) {
    vector<int> bits(k);
    rep(i, k) {
        bits[i] = x & 1;
        x >>= 1;
    }

    return bits;
}

// x のビット列を取得する.
vector<int> get_bits(ll x) { return get_bits(x, bit_length(x)); }
#line 2 "/home/user/competitive_programming/library_for_cpp/Algebra/modint.hpp"

#line 4 "/home/user/competitive_programming/library_for_cpp/Algebra/modint.hpp"

template<int M>
class modint {
    public:
    static constexpr int _mod = M; 
    uint64_t x;

    public:
    static int mod() { return _mod; }

    static modint raw(int v) {
        modint a;
        a.x = v;
        return a;
    }

    // 初期化
    constexpr modint(): x(0) {}
    constexpr modint(int64_t a) {
        int64_t w = (int64_t)(a) % mod();
        if (w < 0) { w += mod(); }
        x = w;
    }

    // マイナス元
    modint operator-() const { return modint(-x); }

    // 加法
    modint& operator+=(const modint &b){
        if ((x += b.x) >= mod()) x -= mod();
        return *this;
    }

    friend modint operator+(const modint &x, const modint &y) { return modint(x) += y; }

    // 減法
    modint& operator-=(const modint &b){
        if ((x += mod() - b.x) >= mod()) x -= mod();
        return *this;
    }

    friend modint operator-(const modint &x, const modint &y) { return modint(x) -= y; }

    // 乗法
    modint& operator*=(const modint &b){
        (x *= b.x) %= mod();
        return *this;
    }

    friend modint operator*(const modint &x, const modint &y) { return modint(x) *= y; }
    friend modint operator*(const int &x, const modint &y) { return modint(x) *= y; }
    friend modint operator*(const ll &x, const modint &y) { return modint(x) *= y; }

    // 除法
    modint& operator/=(const modint &b){ return (*this) *= b.inverse(); }

    friend modint operator/(const modint &x, const modint &y) { return modint(x) /= y; }

    modint inverse() const {
        int64_t s = 1, t = 0;
        int64_t a = x, b = mod();

        while (b > 0) {
            int64_t q = a / b;

            a -= q * b; swap(a, b);
            s -= q * t; swap(s, t);
        }

        assert (a == 1);

        return modint(s);
    }

    // 比較
    friend bool operator==(const modint &a, const modint &b) { return (a.x == b.x); }
    friend bool operator==(const modint &a, const int &b) { return a.x == safe_mod(b, mod()); }
    friend bool operator!=(const modint &a, const modint &b) { return (a.x != b.x); }

    // 入力
    friend istream &operator>>(istream &is, modint &a) {
        int64_t x;
        is >> x;
        a.x = safe_mod(x, mod());
        return is;
    }

    // 出力
    friend ostream &operator<<(ostream &os, const modint &a) { return os << a.x; }

    bool is_zero() const { return x == 0; }
    bool is_member(ll a) const { return x == (a % mod() + mod()) % mod(); }
};

template<int mod>
modint<mod> pow(modint<mod> x, long long n) {
    if (n < 0) { return pow(x, -n).inverse(); }

    auto res = modint<mod>(1);
    for (; n; n >>= 1) {
        if (n & 1) { res *= x; }
        x *= x;
    }

    return res;
}
#line 2 "/home/user/competitive_programming/library_for_cpp/Binary_Indexed_Tree/Binary_Indexed_Tree.hpp"

template<typename G>
class Binary_Indexed_Tree{
    private:
    int n;
    vector<G> data;
    G zero;
    function<G(G, G)> op;
    function<G(G)> neg;

    // 初期化
    public:
    Binary_Indexed_Tree() = default;

    Binary_Indexed_Tree(int n, const function<G(G, G)> op, const G zero, const function<G(G)> neg): n(n), op(op), zero(zero), neg(neg) {
        data.assign(n + 1, zero);
    }

    Binary_Indexed_Tree(const vector<G> &vec, const function<G(G, G)> op, const G zero, const function<G(G)> neg):
        Binary_Indexed_Tree(vec.size(), op, zero, neg) {
            for (int k = 1; k <= n; k++){
                data[k] = op(data[k], vec[k - 1]);
                int l = k + (k & (-k));
                if (l <= n) { data[l] = op(data[l], data[k]); }
            }
        }

    // 第 k 要素に x を左から加える.
    void add(int k, G x) {
        for (++k; k <= n; k += k & (-k)) { data[k] = op(data[k], x); }
    }

    // 第 k 要素を x に変更する.
    void update(int k, G x) {
        add(k, op(neg((*this)[k]), x));
    }

    // 右半開区間 [0, k] における総和を求める.
    G sum(int k) const {
        G total = zero;

        for (++k; k > 0; k -= k & (-k)) { total = op(total, data[k]); }

        return total;
    }

    // 右半開区間 [l, r] における総和を求める.
    G sum(int l, int r) const {
        l = max(l, 0);
        r = min(r, n - 1);

        if (l > r) { return zero; }
        else if (l == 0) { return sum(r); }
        else { return op(sum(r), neg(sum(l - 1))); }
    }

    // 第 k 要素を取得する.
    inline G operator[](int k) const { return sum(k, k); }
};

template<typename G>
Binary_Indexed_Tree<G> Group_Binary_Indexed_Tree(const vector<G> &vec, G zero){
    auto add = [](G x, G y) -> G { return x + y; };
    auto inv = [](G x) -> G { return -x; };
    return Binary_Indexed_Tree<G>(vec, add, zero, inv);
}
#line 2 "/home/user/competitive_programming/library_for_cpp/Binary_Indexed_Tree/Range_Binary_Indexed_Tree.hpp"

#line 5 "/home/user/competitive_programming/library_for_cpp/Binary_Indexed_Tree/Range_Binary_Indexed_Tree.hpp"

template<typename G>
class Range_Binary_Indexed_Tree {
    private:
    const int n;
    const function<G(G, G)> op;
    const G zero;
    const function<G(G)> neg;
    const function<G(int, G)> mul;

    Binary_Indexed_Tree<G> bit0, bit1;

    public:
    Range_Binary_Indexed_Tree(int n, const function<G(G, G)> op, const G zero, const function<G(G)> neg, const function<G(int, G)> mul): n(n), op(op), zero(zero), neg(neg), mul(mul) {
        bit0 = Binary_Indexed_Tree<G>(vector<G>(n, zero), op, zero, neg);
        bit1 = Binary_Indexed_Tree<G>(vector<G>(n, zero), op, zero, neg);
    }

    /// @brief 第 k 要素を x に更新する.
    /// @param k 更新箇所
    /// @param x 更新後の値
    inline void update(int k, G x) { bit0.add(k, op(neg(get(k)), x)); }

    /// @brief 第 k 要素に x を加算する.
    /// @param k 加算箇所
    /// @param x 加算要素
    inline void add(int k, G x) { bit0.add(k, x); }

    /// @brief 第 l 要素から第 r 要素の全てに対して x を加算する.
    /// @param l 左端
    /// @param r 右端
    /// @param x 加算要素
    void add(int l, int r, G x) {
        bit0.add(l, neg(mul(l, x)));
        bit1.add(l, x);
        if (r < n - 1) {
            bit0.add(r + 1, mul(r + 1, x));
            bit1.add(r + 1, neg(x));
        }
    }

    /// @brief 第 k 要素を取得する.
    /// @param k 取得箇所
    inline G get(int k) const { return sum(k, k); }

    /// @brief 第 0 要素から第 r 要素までの総和を求める.
    /// @param r 右端
    inline G sum(int r) const { return op(bit0.sum(r), mul(r + 1, bit1.sum(r))); }

    /// @brief 第 l 要素から第 r 要素までの総和を求める.
    /// @param l 左端
    /// @param r 右端
    G sum(int l, int r) const {
        return l > 0 ? op(sum(r), neg(sum(l - 1))) : sum(r);
    }

    inline G operator[](const int k) const { return sum(k, k); }
};
#line 2 "/home/user/competitive_programming/library_for_cpp/Counting/Combination_Calculator.hpp"

#line 4 "/home/user/competitive_programming/library_for_cpp/Counting/Combination_Calculator.hpp"

template<typename mint>
class Combination_Calculator {
    private:
    vector<mint> _fact, _fact_inv;

    void resize(const int m) {
        if (m < _fact.size()) { return; }

        int current_size = _fact.size();
        int next_size = min(max(2 * current_size, m), mint::mod());

        _fact.resize(next_size);
        _fact_inv.resize(next_size);

        for (int k = current_size; k < next_size; k++) {
            _fact[k] = k * _fact[k - 1];
        }

        _fact_inv.back() = _fact.back().inverse();

        for (int k = next_size - 2; k >= current_size; --k) {
            _fact_inv[k] = (k + 1) * _fact_inv[k + 1];
        }
    }

    public:
    /**
     * @brief コンストラクタ: 初期サイズnまで階乗・逆階乗を計算する
     * @param n 初期計算の上限
     */
    Combination_Calculator(const int n) {
        _fact.emplace_back(1); _fact.emplace_back(1);
        _fact_inv.emplace_back(1); _fact_inv.emplace_back(1);

        resize(n);
    }

    Combination_Calculator(): Combination_Calculator(0) {}

    /**
     * @brief k! を取得
     */
    mint fact(const int k) {
        resize(k);
        return _fact[k];
    }

    /**
     * @brief (k!)^(-1) を取得
     */
    mint fact_inv(const int k) {
        resize(k);
        return _fact_inv[k];
    }

    /**
     * @brief k の逆元 k^(-1) を求める
     * @param k 逆元を求めたい数
     */
    mint inv(const int k) {
        if (k <= 0) { return 0; }

        resize(k);
        return _fact_inv[k] * _fact[k - 1];
    }

    /**
     * @brief 組み合わせ nCk を計算する
     */
    mint nCr(const int n, const int r) {
        if (!(0 <= r && r <= n)) { return 0; }
        resize(n);
        return _fact[n] * _fact_inv[r] * _fact_inv[n - r];
    }

    /**
     * @brief 順列 nPk を計算する
     */
    mint nPr(const int n, const int r) {
        if (!(0 <= r && r <= n)) { return 0; }
        resize(n);
        return _fact[n] * _fact_inv[n - r];
    }

    /**
     * @brief 重複組合せ nHk を計算する
     */
    mint nHr(const int n, const int r) {
        if (n == 0 && r == 0) { return 1; }

        return nCr(n + r - 1, r);
    }

    /**
     * @brief 多項係数 (k_sum)! / (k1! * k2! * ...) を計算する
     */
    mint multinomial_coefficient(const vector<int> &ks) {
        int k_sum = 0;
        mint lower = 1;
        for (int k: ks) {
            k_sum += k;
            lower *= _fact_inv[k];
        }

        resize(k_sum);

        mint upper = _fact[k_sum];

        return upper * lower;
    }

    mint catalan(const int n) {
        if (n < 0) { return 0; }
        resize(2 * n);
        return _fact[2 * n] * _fact_inv[n + 1] * _fact_inv[n];
    }
};
#line 6 "program.cpp"

using mint = modint<998244353>;

template<typename G>
G add(const G &x, const G &y) { return x + y; }

template<typename G>
G neg(const G &x) { return -x; }

template<typename G>
G mul(const int &k, const G &x) { return k * x; }

vector<mint> solve() {
    int N, Q; cin >> N >> Q;
    string P, P_suf; cin >> P_suf;
    P = "*" + P_suf;
    vector<mint> S0(N + 1); cin >> S0;

    Combination_Calculator<mint> calc(2 * N + 10);

    P[N] = 'B';
    set<int> E{0};
    for (int i = 1; i <= N; i++) {
        if (P[i] == 'B') { E.insert(i); }
    }

    Range_Binary_Indexed_Tree<mint> A(N + 1, add<mint>, mint(0), neg<mint>, mul<mint>);
    Range_Binary_Indexed_Tree<mint> B(N + 1, add<mint>, mint(0), neg<mint>, mul<mint>);
    Binary_Indexed_Tree<mint> S(S0, add<mint>, mint(0), neg<mint>);

    for (int i = 1; i <= N; i++) {
        int l = *(--E.lower_bound(i));
        A.update(i, i - l);
    }

    ll g = 0;
    for (int i = 1; i <= N; i++) {
        if (P[i] == 'G') {
            g++;
            continue;
        }

        mint h = mint(g + 1) * mint(g + 2) * calc.inv(2 * (i + 1));
        B.add(i + 1, N, h);
        g = 0;
    }

    vector<mint> ans(Q + 1);
    for (int i = 0; i <= N; i++) {
        ans[0] += (A[i] + B[i]) * S[i];
    }

    for (int q = 1; q <= Q; q++) {
        ans[q] = ans[q - 1];
        int t; scanf("%d", &t);
        if (t == 1) {
            ll i; scanf("%lld", &i);
            if (i == N) { continue; }

            mint delta = 0;
            ll l = *(--E.lower_bound(i));
            ll r = *E.upper_bound(i);

            if (P[i] == 'G') {
                delta -= (i - l) * S.sum(i + 1, r);
                A.add(i + 1, r, -(i - l));

                ll g = r - l - 1;
                ll gl = i - l - 1;
                ll gr = g - (gl + 1);

                mint h = mint(g + 1) * mint(g + 2) * calc.inv(2 * (r + 1));
                mint hl = mint(gl + 1) * mint(gl + 2) * calc.inv(2 * (i + 1));
                mint hr = mint(gr + 1) * mint(gr + 2) * calc.inv(2 * (r + 1));

                delta -= h * S.sum(r + 1, N);
                delta += hl * S.sum(i + 1, N);
                delta += hr * S.sum(r + 1, N);

                B.add(r + 1, N, -h);
                B.add(i + 1, N, hl);
                B.add(r + 1, N, hr);

                P[i] = 'B';
                E.insert(i);
            } else if (P[i] == 'B') {
                delta += (i - l) * S.sum(i + 1, r);
                A.add(i + 1, r, (i - l));

                ll gl = i - l - 1;
                ll gr = r - i - 1;
                ll g = gl + gr + 1;

                mint h = mint(g + 1) * mint(g + 2) * calc.inv(2 * (r + 1));
                mint hl = mint(gl + 1) * mint(gl + 2) * calc.inv(2 * (i + 1));
                mint hr = mint(gr + 1) * mint(gr + 2) * calc.inv(2 * (r + 1));

                delta += h * S.sum(r + 1, N);
                delta -= hl * S.sum(i + 1, N);
                delta -= hr * S.sum(r + 1, N);

                B.add(r + 1, N, h);
                B.add(i + 1, N, -hl);
                B.add(r + 1, N, -hr);

                P[i] = 'G';
                E.erase(i);
            }
            ans[q] += delta;
        } else if (t == 2) {
            int i, _b; scanf("%d%d", &i, &_b);
            mint b = mint::raw(_b);
            ans[q] += (A[i] + B[i]) * (b - S[i]);
            S.update(i, b);
        }
    }

    ans.erase(ans.begin());
    return ans;
}

int main() {
    int T; cin >> T;
    for (int t = 1; t <= T; t++) {
        cout << solve() << endl;
    }
}
0