結果

問題 No.891 隣接3項間の漸化式
ユーザー PachicobuePachicobue
提出日時 2019-09-26 20:50:43
言語 C++17
(gcc 13.2.0 + boost 1.83.0)
結果
AC  
実行時間 2 ms / 2,000 ms
コード長 26,902 bytes
コンパイル時間 3,151 ms
コンパイル使用メモリ 229,264 KB
実行使用メモリ 4,348 KB
最終ジャッジ日時 2023-10-24 15:46:10
合計ジャッジ時間 4,470 ms
ジャッジサーバーID
(参考情報)
judge15 / judge14
このコードへのチャレンジ
(要ログイン)

テストケース

テストケース表示
入力 結果 実行時間
実行使用メモリ
testcase_00 AC 2 ms
4,348 KB
testcase_01 AC 2 ms
4,348 KB
testcase_02 AC 2 ms
4,348 KB
testcase_03 AC 2 ms
4,348 KB
testcase_04 AC 2 ms
4,348 KB
testcase_05 AC 2 ms
4,348 KB
testcase_06 AC 2 ms
4,348 KB
testcase_07 AC 2 ms
4,348 KB
testcase_08 AC 2 ms
4,348 KB
testcase_09 AC 2 ms
4,348 KB
testcase_10 AC 2 ms
4,348 KB
testcase_11 AC 2 ms
4,348 KB
testcase_12 AC 2 ms
4,348 KB
testcase_13 AC 2 ms
4,348 KB
testcase_14 AC 2 ms
4,348 KB
testcase_15 AC 2 ms
4,348 KB
testcase_16 AC 2 ms
4,348 KB
testcase_17 AC 2 ms
4,348 KB
testcase_18 AC 2 ms
4,348 KB
testcase_19 AC 2 ms
4,348 KB
testcase_20 AC 2 ms
4,348 KB
testcase_21 AC 2 ms
4,348 KB
testcase_22 AC 2 ms
4,348 KB
testcase_23 AC 2 ms
4,348 KB
testcase_24 AC 2 ms
4,348 KB
testcase_25 AC 2 ms
4,348 KB
testcase_26 AC 2 ms
4,348 KB
testcase_27 AC 2 ms
4,348 KB
testcase_28 AC 2 ms
4,348 KB
testcase_29 AC 2 ms
4,348 KB
testcase_30 AC 2 ms
4,348 KB
testcase_31 AC 1 ms
4,348 KB
testcase_32 AC 2 ms
4,348 KB
testcase_33 AC 2 ms
4,348 KB
testcase_34 AC 2 ms
4,348 KB
testcase_35 AC 2 ms
4,348 KB
testcase_36 AC 2 ms
4,348 KB
testcase_37 AC 2 ms
4,348 KB
testcase_38 AC 2 ms
4,348 KB
testcase_39 AC 2 ms
4,348 KB
testcase_40 AC 2 ms
4,348 KB
testcase_41 AC 2 ms
4,348 KB
権限があれば一括ダウンロードができます

ソースコード

diff #

#include <bits/stdc++.h>
#pragma GCC diagnostic ignored "-Wsign-compare"
#pragma GCC diagnostic ignored "-Wsign-conversion"

#define NDEBUG
using i32 = int32_t;
using i64 = int64_t;
using u32 = uint32_t;
using u64 = uint64_t;
using uint = unsigned int;
using usize = std::size_t;
using ll = long long;
using ull = unsigned long long;
using ld = long double;
template<typename T> constexpr T popcount(const T u) { return u ? static_cast<T>(__builtin_popcountll(static_cast<u64>(u))) : static_cast<T>(0); }
template<typename T> constexpr T log2p1(const T u) { return u ? static_cast<T>(64 - __builtin_clzll(static_cast<u64>(u))) : static_cast<T>(0); }
template<typename T> constexpr T msbp1(const T u) { return log2p1(u); }
template<typename T> constexpr T lsbp1(const T u) { return __builtin_ffsll(u); }
template<typename T> constexpr T clog(const T u) { return u ? log2p1(u - 1) : static_cast<T>(u); }
template<typename T> constexpr bool ispow2(const T u) { return u and (static_cast<u64>(u) & static_cast<u64>(u - 1)) == 0; }
template<typename T> constexpr T ceil2(const T u) { return static_cast<T>(1) << clog(u); }
template<typename T> constexpr T floor2(const T u) { return u == 0 ? static_cast<T>(0) : static_cast<T>(1) << (log2p1(u) - 1); }
template<typename T> constexpr bool btest(const T mask, const usize ind) { return ((static_cast<u64>(mask) >> ind) & static_cast<u64>(1)); }
template<typename T> constexpr T bcut(const T mask, const usize ind) { return ind == 0 ? static_cast<T>(0) : static_cast<T>((static_cast<u64>(mask) << (64 - ind)) >> (64 - ind)); }
template<typename T> bool chmin(T& a, const T& b) { return (a > b ? a = b, true : false); }
template<typename T> bool chmax(T& a, const T& b) { return (a < b ? a = b, true : false); }
constexpr unsigned int mod                  = 1000000007;
template<typename T> constexpr T inf_v      = std::numeric_limits<T>::max() / 4;
template<typename Real> constexpr Real pi_v = Real{3.141592653589793238462643383279502884};
template<typename T>
T read()
{
    T v;
    return std::cin >> v, v;
}
template<typename T>
std::vector<T> read_vec(const std::size_t size)
{
    std::vector<T> v(size);
    for (auto& e : v) { std::cin >> e; }
    return v;
}
template<typename... Types>
auto read_vals() { return std::tuple<std::decay_t<Types>...>{read<Types>()...}; }
#define SHOW(...) static_cast<void>(0)
template<typename T>
std::vector<T> make_v(const std::size_t size, T v) { return std::vector<T>(size, v); }
template<class... Args>
auto make_v(const std::size_t size, Args... args) { return std::vector<decltype(make_v(args...))>(size, make_v(args...)); }


template<typename Real>
struct complex
{
    using value_type = Real;
    complex() : real{Real{0}}, imag{Real{0}} {}
    complex(const complex&) = default;
    complex(const Real& theta) : real(std::cos(theta)), imag(std::sin(theta)) {}
    complex(const Real& r, const Real& i) : real{r}, imag{i} {}
    ~complex() = default;
    friend complex operator+(const complex& c) { return c; }
    friend complex operator-(const complex& c) { return complex{-c.real, -c.imag}; }
    friend complex operator+(const complex& c1, const complex& c2) { return complex{c1.real + c2.real, c1.imag + c2.imag}; }
    friend complex operator-(const complex& c1, const complex& c2) { return complex{c1.real - c2.real, c1.imag - c2.imag}; }
    friend complex operator*(const complex& c1, const complex& c2) { return complex{c1.real * c2.real - c1.imag * c2.imag, c1.real * c2.imag + c1.imag * c2.real}; }
    friend complex operator*(const complex& c, const Real& r) { return complex{c.real * r, c.imag * r}; }
    friend complex operator/(complex& c1, complex& c2) { c1* c2.conj() / c2.norm(); }
    friend bool operator==(const complex& c1, const complex& c2) { return c1.real == c2.real and c1.imag == c2.imag; }
    friend bool operator!=(const complex& c1, const complex& c2) { return not(c1 == c2); }
    friend complex& operator+=(complex& c1, const complex& c2) { return c1.real += c2.real, c1.imag += c2.imag, c1; }
    friend complex& operator-=(complex& c1, const complex& c2) { return c1.real += c2.real, c1.imag += c2.imag, c1; }
    friend complex& operator*=(complex& c1, const complex& c2) { return c1 = c1 * c2; }
    friend complex& operator*=(complex& c, const Real& r) { return c = c * r; }
    friend complex& operator/=(complex& c1, const complex& c2) { return c1 = c1 / c2; }
    complex conj() const { return complex{real, -imag}; }
    Real norm() const { return real * real + imag * imag; }
    Real abs() const { return std::sqrt(norm()); }
    Real arg() const { return std::atan2(imag, real); }
    friend std::ostream& operator<<(std::ostream& os, const complex& c) { return os << c.real << "+" << c.imag << "i"; }
    Real real, imag;
};


template<typename T> T gcd(const T& a, const T& b) { return (a > b ? gcd(b, a) : a == 0 ? b : gcd(b % a, a)); }
template<typename T> T lcm(const T& a, const T& b) { return a / gcd(a, b) * b; }
template<typename T>
constexpr std::pair<T, T> extgcd(const T a, const T b)
{
    if (b == 0) { return std::pair<T, T>{1, 0}; }
    const auto g = gcd(a, b), da = std::abs(b) / g;
    const auto p = extgcd(b, a % b);
    const auto x = (da + p.second % da) % da, y = (g - a * x) / b;
    return {x, y};
}
template<typename T>
constexpr T inverse(const T a, const T mod) { return extgcd(a, mod).first; }
template<uint mod_value, bool dynamic = false>
class modint_base
{
public:
    template<typename UInt = uint>
    static std::enable_if_t<dynamic, const UInt> mod() { return mod_ref(); }
    template<typename UInt = uint>
    static constexpr std::enable_if_t<not dynamic, const UInt> mod() { return mod_value; }
    template<typename UInt = uint>
    static void set_mod(const std::enable_if_t<dynamic, const UInt> mod) { mod_ref() = mod, inv_ref() = {1, 1}; }
    modint_base() : v{0} {}
    modint_base(const ll val) : v{norm(static_cast<uint>(val % static_cast<ll>(mod()) + static_cast<ll>(mod())))} {}
    modint_base(const modint_base& n) : v{n()} {}
    explicit operator bool() const { return v != 0; }
    bool operator!() const { return not static_cast<bool>(*this); }
    modint_base& operator=(const modint_base& m) { return v = m(), (*this); }
    modint_base& operator=(const ll val) { return v = norm(uint(val % static_cast<ll>(mod()) + static_cast<ll>(mod()))), (*this); }
    friend modint_base operator+(const modint_base& m) { return m; }
    friend modint_base operator-(const modint_base& m) { return make(norm(mod() - m.v)); }
    friend modint_base operator+(const modint_base& m1, const modint_base& m2) { return make(norm(m1.v + m2.v)); }
    friend modint_base operator-(const modint_base& m1, const modint_base& m2) { return make(norm(m1.v + mod() - m2.v)); }
    friend modint_base operator*(const modint_base& m1, const modint_base& m2) { return make(static_cast<uint>(static_cast<ll>(m1.v) * static_cast<ll>(m2.v) % static_cast<ll>(mod()))); }
    friend modint_base operator/(const modint_base& m1, const modint_base& m2) { return m1 * inv(m2.v); }
    friend modint_base operator+(const modint_base& m, const ll val) { return modint_base{static_cast<ll>(m.v) + val}; }
    friend modint_base operator-(const modint_base& m, const ll val) { return modint_base{static_cast<ll>(m.v) - val}; }
    friend modint_base operator*(const modint_base& m, const ll val) { return modint_base{static_cast<ll>(m.v) * (val % static_cast<ll>(mod()))}; }
    friend modint_base operator/(const modint_base& m, const ll val) { return modint_base{static_cast<ll>(m.v) * inv(val)}; }
    friend modint_base operator+(const ll val, const modint_base& m) { return modint_base{static_cast<ll>(m.v) + val}; }
    friend modint_base operator-(const ll val, const modint_base& m) { return modint_base{-static_cast<ll>(m.v) + val}; }
    friend modint_base operator*(const ll val, const modint_base& m) { return modint_base{static_cast<ll>(m.v) * (val % static_cast<ll>(mod()))}; }
    friend modint_base operator/(const ll val, const modint_base& m) { return modint_base{val * inv(static_cast<ll>(m.v))}; }
    friend modint_base& operator+=(modint_base& m1, const modint_base& m2) { return m1 = m1 + m2; }
    friend modint_base& operator-=(modint_base& m1, const modint_base& m2) { return m1 = m1 - m2; }
    friend modint_base& operator*=(modint_base& m1, const modint_base& m2) { return m1 = m1 * m2; }
    friend modint_base& operator/=(modint_base& m1, const modint_base& m2) { return m1 = m1 / m2; }
    friend modint_base& operator+=(modint_base& m, const ll val) { return m = m + val; }
    friend modint_base& operator-=(modint_base& m, const ll val) { return m = m - val; }
    friend modint_base& operator*=(modint_base& m, const ll val) { return m = m * val; }
    friend modint_base& operator/=(modint_base& m, const ll val) { return m = m / val; }
    friend modint_base operator^(const modint_base& m, const ll n) { return power(m.v, n); }
    friend modint_base& operator^=(modint_base& m, const ll n) { return m = m ^ n; }
    friend bool operator==(const modint_base& m1, const modint_base& m2) { return m1.v == m2.v; }
    friend bool operator!=(const modint_base& m1, const modint_base& m2) { return not(m1 == m2); }
    friend bool operator==(const modint_base& m, const ll val) { return m.v == norm(static_cast<uint>(static_cast<ll>(mod()) + val % static_cast<ll>(mod()))); }
    friend bool operator!=(const modint_base& m, const ll val) { return not(m == val); }
    friend bool operator==(const ll val, const modint_base& m) { return m.v == norm(static_cast<uint>(static_cast<ll>(mod()) + val % static_cast<ll>(mod()))); }
    friend bool operator!=(const ll val, const modint_base& m) { return not(m == val); }
    friend std::istream& operator>>(std::istream& is, modint_base& m)
    {
        ll v;
        return is >> v, m = v, is;
    }
    friend std::ostream& operator<<(std::ostream& os, const modint_base& m) { return os << m(); }
    uint operator()() const { return v; }
    static modint_base small_inv(const usize n)
    {
        auto& in = inv_ref();
        if (n < in.size()) { return in[n]; }
        for (usize i = in.size(); i <= n; i++) { in.push_back(-in[modint_base::mod() % i] * (modint_base::mod() / i)); }
        return in.back();
    }

private:
    template<typename UInt = uint>
    static std::enable_if_t<dynamic, UInt&> mod_ref()
    {
        static UInt mod = 0;
        return mod;
    }
    static uint norm(const uint x) { return x < mod() ? x : x - mod(); }
    static modint_base make(const uint x)
    {
        modint_base m;
        return m.v = x, m;
    }
    static modint_base power(modint_base x, ull n)
    {
        modint_base ans = 1;
        for (; n; n >>= 1, x *= x) {
            if (n & 1) { ans *= x; }
        }
        return ans;
    }
    static modint_base inv(const ll v) { return v < 1000000 ? small_inv(static_cast<usize>(v)) : modint_base{inverse(v, static_cast<ll>(mod()))}; }
    static std::vector<modint_base>& inv_ref()
    {
        static std::vector<modint_base> in{1, 1};
        return in;
    }
    uint v;
};
template<uint mod>
using modint = modint_base<mod, false>;
template<uint id>
using dynamic_modint = modint_base<id, true>;
template<typename Real = double>
class fft
{
private:
    static constexpr usize depth = 30;
    static constexpr Real pi     = pi_v<Real>;
    static void transform(std::vector<complex<Real>>& a, const usize lg, const bool rev)
    {
        static std::vector<complex<Real>> root[depth];
        const usize sz = a.size();
        assert((1UL << lg) == sz);
        if (root[lg].empty()) {
            root[lg].reserve(sz), root[lg].resize(sz);
            for (usize i = 0; i < sz; i++) { root[lg][i] = complex<Real>(pi * Real(2 * i) / Real(sz)); }
        }
        std::vector<complex<Real>> tmp(sz);
        for (usize w = (sz >> 1); w > 0; w >>= 1) {
            for (usize y = 0; y < (sz >> 1); y += w) {
                const complex<Real> r = rev ? root[lg][y].conj() : root[lg][y];
                for (usize x = 0; x < w; x++) {
                    const auto u = a[y << 1 | x], v = a[y << 1 | x | w] * r;
                    tmp[y | x] = u + v, tmp[y | x | (sz >> 1)] = u - v;
                }
            }
            std::swap(tmp, a);
        }
    }

public:
    using value_type = Real;
    fft()            = delete;
    template<typename T = ll, usize division = 2, typename I = int>
    static std::vector<T> convolute(const std::vector<I>& a, const std::vector<I>& b)
    {
        constexpr usize bitnum = (depth + division - 1) / division;
        const usize need = a.size() + b.size() - 1, lg = clog(need), sz = 1UL << lg;
        std::vector<complex<value_type>> x[division], y[division], tmp(sz);
        for (usize i = 0; i < division; i++) {
            x[i].reserve(sz), x[i].resize(sz), y[i].reserve(sz), y[i].resize(sz);
            std::fill(tmp.begin() + std::min(a.size(), b.size()), tmp.end(), complex<value_type>{});
            for (usize j = 0; j < a.size(); j++) { tmp[j].real = value_type((a[j] >> (bitnum * i)) & ((1 << bitnum) - 1)); }
            for (usize j = 0; j < b.size(); j++) { tmp[j].imag = value_type((b[j] >> (bitnum * i)) & ((1 << bitnum) - 1)); }
            transform(tmp, lg, false);
            for (usize j = 0; j < sz; j++) { tmp[j] *= value_type(0.5); }
            for (usize j = 0; j < sz; j++) {
                const usize k = j == 0 ? 0UL : sz - j;
                x[i][j] = complex<value_type>{tmp[j].real + tmp[k].real, tmp[j].imag - tmp[k].imag}, y[i][j] = complex<value_type>{tmp[j].imag + tmp[k].imag, -tmp[j].real + tmp[k].real};
            }
        }
        std::vector<complex<value_type>> z[division];
        for (usize i = 0; i < division; i++) { z[i].reserve(sz), z[i].resize(sz); }
        for (usize a = 0; a < division; a++) {
            for (usize b = 0; b < division; b++) {
                for (usize i = 0; i < sz; i++) {
                    if (a + b < division) {
                        z[a + b][i] += x[a][i] * y[b][i];
                    } else {
                        z[a + b - division][i] += x[a][i] * y[b][i] * complex<value_type>(0, 1);
                    }
                }
            }
        }
        for (usize i = 0; i < division; i++) { transform(z[i], lg, true); }
        std::vector<T> ans(need);
        T base = 1;
        for (usize k = 0; k < 2 * division - 1; k++, base *= (1LL << bitnum)) {
            for (usize i = 0; i < need; i++) {
                if (k < division) {
                    ans[i] += base * T(std::round(z[k][i].real / value_type(sz)));
                } else {
                    ans[i] += base * T(std::round(z[k - division][i].imag / value_type(sz)));
                }
            }
        }
        return ans;
    }
    template<uint mod, bool dynamic = false, usize division = 2>
    static std::vector<modint_base<mod, dynamic>> convolute(const std::vector<modint_base<mod, dynamic>>& a, const std::vector<modint_base<mod, dynamic>>& b)
    {
        using mint             = modint_base<mod, dynamic>;
        constexpr usize bitnum = (depth + division - 1) / division;
        const usize need = a.size() + b.size() - 1, lg = clog(need), sz = 1UL << lg;
        std::vector<complex<value_type>> x[division], y[division], tmp(sz);
        for (usize i = 0; i < division; i++) {
            x[i].reserve(sz), x[i].resize(sz), y[i].reserve(sz), y[i].resize(sz);
            std::fill(tmp.begin() + std::min(a.size(), b.size()), tmp.end(), complex<value_type>{});
            for (usize j = 0; j < a.size(); j++) { tmp[j].real = value_type((a[j]() >> (bitnum * i)) & ((1 << bitnum) - 1)); }
            for (usize j = 0; j < b.size(); j++) { tmp[j].imag = value_type((b[j]() >> (bitnum * i)) & ((1 << bitnum) - 1)); }
            transform(tmp, lg, false);
            for (usize j = 0; j < sz; j++) { tmp[j] *= value_type(0.5); }
            for (usize j = 0; j < sz; j++) {
                const usize k = j == 0 ? 0UL : sz - j;
                x[i][j] = complex<value_type>{tmp[j].real + tmp[k].real, tmp[j].imag - tmp[k].imag}, y[i][j] = complex<value_type>{tmp[j].imag + tmp[k].imag, -tmp[j].real + tmp[k].real};
            }
        }
        std::vector<complex<value_type>> z[division];
        for (usize i = 0; i < division; i++) { z[i].reserve(sz), z[i].resize(sz); }
        for (usize a = 0; a < division; a++) {
            for (usize b = 0; b < division; b++) {
                for (usize i = 0; i < sz; i++) {
                    if (a + b < division) {
                        z[a + b][i] += x[a][i] * y[b][i];
                    } else {
                        z[a + b - division][i] += x[a][i] * y[b][i] * complex<value_type>(0, 1);
                    }
                }
            }
        }
        for (usize i = 0; i < division; i++) { transform(z[i], lg, true); }
        std::vector<mint> ans(need);
        mint base = 1;
        for (usize k = 0; k < 2 * division - 1; k++, base *= (1LL << bitnum)) {
            for (usize i = 0; i < need; i++) {
                if (k < division) {
                    ans[i] += int((base * ll(std::round(z[k][i].real / value_type(sz))))());
                } else {
                    ans[i] += int((base * ll(std::round(z[k - division][i].imag / value_type(sz))))());
                }
            }
        }
        return ans;
    }
};

template<uint mod = 924844033, uint root = 5>
class ntt
{
private:
    using value_type             = modint<mod>;
    static constexpr usize depth = 30;
    static void transform(std::vector<value_type>& a, const usize lg, const bool rev)
    {
        const usize N = a.size();
        assert(1UL << lg == N);
        static std::vector<value_type> R[depth];
        if (R[lg].empty()) {
            R[lg].reserve(N), R[lg].resize(N, value_type(1));
            const value_type r = value_type(root) ^ ((mod - 1) / N);
            for (usize i = 1; i < N; i++) { R[lg][i] = R[lg][i - 1] * r; }
        }
        std::vector<value_type> tmp(N);
        for (usize w = (N >> 1); w > 0; w >>= 1) {
            for (usize y = 0; y < (N >> 1); y += w) {
                const value_type r = rev ? R[lg][y == 0 ? 0 : N - y] : R[lg][y];
                for (usize x = 0; x < w; x++) {
                    const auto u = a[y << 1 | x], v = a[y << 1 | x | w]() * r;
                    tmp[y | x] = u + v, tmp[y | x | (N >> 1)] = u - v;
                }
            }
            std::swap(tmp, a);
        }
        if (rev) {
            for (usize i = 0; i < N; i++) { a[i] /= value_type(N); }
        }
    }

public:
    ntt() = delete;
    static std::vector<value_type> convolute(const std::vector<value_type>& a, const std::vector<value_type>& b)
    {
        const usize need = a.size() + b.size() - 1, lg = clog(need), sz = 1UL << lg;
        std::vector<value_type> A(sz, 0), B(sz, 0);
        for (usize i = 0; i < a.size(); i++) { A[i] = a[i](); }
        for (usize i = 0; i < b.size(); i++) { B[i] = b[i](); }
        transform(A, lg, false), transform(B, lg, false);
        for (usize i = 0; i < sz; i++) { A[i] *= B[i]; }
        transform(A, lg, true);
        std::vector<value_type> ans(need);
        for (usize i = 0; i < need; i++) { ans[i] = int(A[i]()); }
        return ans;
    }
};
template<uint mod, uint root, bool dynamic, uint fft_division>
class poly_base
{
public:
    using value_type = modint_base<mod, dynamic>;
    poly_base() : v(0) {}
    poly_base(const value_type& r) : v{r} { shrink(); }
    poly_base(const std::vector<value_type>& v) : v{v} { shrink(); }
    poly_base(const std::initializer_list<value_type>&& list) : v{list} { shrink(); }
    std::vector<value_type> operator()() const { return v; }
    value_type& operator[](const usize i) { return v[i]; }
    const value_type& operator[](const usize i) const { return v[i]; }
    value_type at(const usize i) const { return i < size() ? v[i] : value_type(0); }
    friend poly_base operator+(const poly_base& p) { return p; }
    friend poly_base operator-(const poly_base& p)
    {
        std::vector<value_type> ans = p.v;
        for (auto& e : ans) { e = -e; }
        return poly_base(ans);
    }
    friend poly_base operator+(const poly_base& p, const poly_base& q)
    {
        const usize sz = std::max(p.size(), q.size());
        std::vector<value_type> ans(sz);
        for (usize i = 0; i < sz; i++) { ans[i] = p.at(i) + q.at(i); }
        return poly_base(ans);
    }
    friend poly_base operator-(const poly_base& p, const poly_base& q)
    {
        const usize sz = std::max(p.size(), q.size());
        std::vector<value_type> ans(sz);
        for (usize i = 0; i < sz; i++) { ans[i] = p.at(i) - q.at(i); }
        return poly_base(ans);
    }
    friend poly_base operator*(const poly_base& p, const poly_base& q) { return p.size() <= 300 or q.size() <= 300 ? naive_multiply(p, q) : fft_multiply(p, q); }
    friend poly_base operator*(const poly_base& p, const value_type& r)
    {
        std::vector<value_type> ans = p.v;
        for (auto& e : ans) { e *= r; }
        return poly_base(ans);
    }
    friend poly_base operator/(const poly_base& p, const value_type& r)
    {
        std::vector<value_type> ans = p.v;
        for (auto& e : ans) { e /= r; }
        return poly_base(ans);
    }
    friend poly_base operator>>(const poly_base& p, const usize s) { return p.divide_by_power(s); }
    friend poly_base operator<<(const poly_base& p, const usize s) { return p.multiply_power(s); }
    friend poly_base operator/(const poly_base& p, const poly_base& q) { return p.div(q); }
    friend poly_base operator%(const poly_base& p, const poly_base& q) { return p.rem(q); }
    friend poly_base& operator+=(poly_base& p, const poly_base& q) { return p = p + q; }
    friend poly_base& operator-=(poly_base& p, const poly_base& q) { return p = p - q; }
    friend poly_base& operator*=(poly_base& p, const poly_base& q) { return p = p * q; }
    friend poly_base& operator*=(poly_base& p, const value_type& r) { return p = p * r; }
    friend poly_base& operator/=(poly_base& p, const value_type& r) { return p = p / r; }
    friend poly_base& operator>>=(poly_base& p, const usize s) { return p = (p >> s); }
    friend poly_base& operator<<=(poly_base& p, const usize s) { return p = (p << s); }
    friend poly_base& operator/=(poly_base& p, const poly_base& q) { return p = p / q; }
    friend poly_base& operator%=(poly_base& p, const poly_base& q) { return p = p % q; }
    poly_base multiply_power(const usize s) const
    {
        const usize sz = size();
        if (sz == 0) { return poly_base(); }
        std::vector<value_type> ans(sz + s, 0);
        for (usize i = 0; i < sz; i++) { ans[i + s] = v[i]; }
        return poly_base(ans);
    }
    poly_base divide_by_power(const usize s) const
    {
        const usize N = size();
        if (N <= s) { return poly_base(); }
        std::vector<value_type> ans(N - s);
        for (usize i = 0; i < N - s; i++) { ans[i] = v[i + s]; }
        return poly_base(ans);
    }
    poly_base rem_by_power(const usize k) const { return size() <= k ? *this : poly_base(std::vector<value_type>(v.begin(), v.begin() + k)); }
    poly_base inverse(const usize k) const  // p(x)q(x)=1 (mod x^{2^k})
    {
        poly_base q{value_type(1) / v[0]};
        const auto T = poly_base{2};
        for (usize i = 1, j = 0; j < k; j++, i *= 2) { q = (q * (T - rem_by_power(2 * i) * q)).rem_by_power(2 * i); }
        return q;
    }
    template<typename Int>
    static poly_base rem_of_power(const Int k, const poly_base& p)  // x^k (mod p(x))
    {
        const usize B = p.size() * 2 - 1;
        const auto q  = p.pseudo_inv(B);
        poly_base ans{1};
        const usize D = log2p1<usize>(k);
        for (usize i = 0; i < D; i++) {
            if (k & (static_cast<Int>(1) << (D - i - 1))) { ans = (ans.multiply_power(1)).rem(p, q, B); }
            if (D - i - 1) { ans = (ans * ans).rem(p, q, B); }
        }
        return ans;
    }
    usize size() const { return v.size(); }
    friend std::ostream& operator<<(std::ostream& os, const poly_base& p)
    {
        if (p.size() == 0) { return os << "0"; }
        for (usize i = 0; i < p.size(); i++) { os << (i != 0 ? "+" : "") << p[i] << (i != 0 ? i == 1 ? "X" : "X^" + std::to_string(i) : ""); }
        return os;
    }

private:
    static std::vector<value_type> naive_convolute(const std::vector<value_type>& a, const std::vector<value_type>& b)
    {
        std::vector<value_type> ans(a.size() + b.size() - 1, 0);
        for (usize i = 0; i < a.size(); i++) {
            for (usize j = 0; j < b.size(); j++) { ans[i + j] += a[i] * b[j]; }
        }
        return ans;
    }
    static poly_base naive_multiply(const poly_base& p, const poly_base& q) { return p.size() == 0 or q.size() == 0 ? poly_base{} : poly_base{naive_convolute(p(), q())}; }
    template<typename Poly = poly_base>
    static std::enable_if_t<root == 0, Poly> fft_multiply(const poly_base& p, const poly_base& q) { return p.size() == 0 or q.size() == 0 ? poly_base() : poly_base{fft<double>::convolute<mod, dynamic, fft_division>(p(), q())}; }
    template<typename Poly = poly_base>
    static std::enable_if_t<root != 0, Poly> fft_multiply(const poly_base& p, const poly_base& q) { return p.size() == 0 or q.size() == 0 ? poly_base() : poly_base{ntt<mod, root>::convolute(p(), q())}; }
    poly_base rev(const usize l) const
    {
        std::vector<value_type> ans = v;
        ans.resize(l), std::reverse(ans.begin(), ans.end());
        return poly_base(ans);
    }
    poly_base div(const poly_base& q) const
    {
        assert(q.size() > 0);
        if (size() < q.size()) { return poly_base(); }
        const usize N = size();
        const auto iq = q.pseudoInv(N);
        return (*this * iq).divide_by_power(N - 1);
    }
    poly_base rem(const poly_base& q) const { return *this - div(q) * q; }
    poly_base rem(const poly_base& q, const poly_base& iq, const usize B) { return *this - q * ((*this * iq).divide_by_power(B - 1)); }
    void shrink()
    {
        for (; not v.empty() and v.back() == 0; v.pop_back()) {}
    }
    poly_base pseudo_inv(const usize B) const
    {
        const usize N = size();
        return rev(N).inverse(B + 2 > N ? clog(B - N + 2) : 0).rev(B + 1 - N);
    }
    std::vector<value_type> v;
};
template<uint mod, uint fft_division = 2>
using poly = poly_base<mod, 0, false, fft_division>;
template<uint mod, uint fft_division = 2>
using dynamic_poly = poly_base<mod, 0, true, fft_division>;
template<uint mod = 924844033, uint root = 5>
using ntt_poly = poly_base<mod, root, false, 0>;
int main()
{
    using mint   = modint<mod>;
    const auto a = read<mint>(), b = read<mint>();
    const auto n = read<ll>();
    poly<mod> p{-b, -a, 1};
    const auto r = poly<mod>::rem_of_power(n, p);
    std::cout << r.at(1) << std::endl;
    return 0;
}
0