content
stringlengths 5
1.03M
| input_ids
sequencelengths 4
823k
| ratio_char_token
float64 0.4
12.5
| token_count
int64 4
823k
|
---|---|---|---|
# Called in the OrdinaryDiffEQ.__init; All `OrdinaryDiffEqAlgorithm`s have one
function OrdinaryDiffEq.initialize!(integ, cache::GaussianODEFilterCache)
if integ.opts.dense && !integ.alg.smooth
error("To use `dense=true` you need to set `smooth=true`!")
elseif !integ.opts.dense && integ.alg.smooth
@warn "If you set dense=false for efficiency, you might also want to set smooth=false."
end
if !integ.opts.save_everystep && integ.alg.smooth
error("If you do not save all values, you do not need to smooth!")
end
@assert integ.saveiter == 1
integ.kshortsize = 1
resize!(integ.k, integ.kshortsize)
integ.k[1] = integ.u
# Update the initial state to the known (given or computed with AD) initial values
initial_update!(integ, cache, integ.alg.initialization)
# These are necessary since the solution object is not 100% initialized by default
OrdinaryDiffEq.copyat_or_push!(integ.sol.x_filt, integ.saveiter, cache.x)
OrdinaryDiffEq.copyat_or_push!(
integ.sol.pu,
integ.saveiter,
mul!(cache.pu_tmp, cache.SolProj, cache.x),
)
return nothing
end
"""Perform a step
Not necessarily successful! For that, see `step!(integ)`.
Basically consists of the following steps
- Coordinate change / Predonditioning
- Prediction step
- Measurement: Evaluate f and Jf; Build z, S, H
- Calibration; Adjust prediction / measurement covs if the diffusion model "dynamic"
- Update step
- Error estimation
- Undo the coordinate change / Predonditioning
"""
function OrdinaryDiffEq.perform_step!(
integ,
cache::GaussianODEFilterCache,
repeat_step=false,
)
@unpack t, dt = integ
@unpack d, SolProj = integ.cache
@unpack x, x_pred, u_pred, x_filt, u_filt, err_tmp = integ.cache
@unpack x_tmp, x_tmp2 = integ.cache
@unpack A, Q, Ah, Qh = integ.cache
make_preconditioners!(cache, dt)
@unpack P, PI = integ.cache
tnew = t + dt
# Build the correct matrices
@. Ah = PI.diag .* A .* P.diag'
X_A_Xt!(Qh, Q, PI)
if isdynamic(cache.diffusionmodel) # Calibrate, then predict cov
# Predict
predict_mean!(x_pred, x, Ah)
mul!(view(u_pred, :), SolProj, x_pred.μ)
# Measure
evaluate_ode!(integ, x_pred, tnew)
# Estimate diffusion
cache.local_diffusion, cache.global_diffusion =
estimate_diffusion(cache.diffusionmodel, integ)
# Adjust prediction and measurement
predict_cov!(x_pred, x, Ah, Qh, cache.C1, cache.global_diffusion)
# Compute measurement covariance only now
compute_measurement_covariance!(cache)
else
predict_mean!(x_pred, x, Ah)
predict_cov!(x_pred, x, Ah, Qh, cache.C1)
mul!(view(u_pred, :), SolProj, x_pred.μ)
evaluate_ode!(integ, x_pred, tnew)
compute_measurement_covariance!(cache)
cache.local_diffusion, cache.global_diffusion =
estimate_diffusion(cache.diffusionmodel, integ)
end
# Likelihood
# cache.log_likelihood = logpdf(cache.measurement, zeros(d))
# Update
x_filt = update!(integ, x_pred)
# Estimate error for adaptive steps - can already be done before filtering
if integ.opts.adaptive
err_est_unscaled = estimate_errors(cache)
if integ.f isa DynamicalODEFunction # second-order ODE
DiffEqBase.calculate_residuals!(
err_tmp,
dt * err_est_unscaled,
integ.u[1, :],
u_pred[1, :],
integ.opts.abstol,
integ.opts.reltol,
integ.opts.internalnorm,
t,
)
else # regular first-order ODE
DiffEqBase.calculate_residuals!(
err_tmp,
dt * err_est_unscaled,
integ.u,
u_pred,
integ.opts.abstol,
integ.opts.reltol,
integ.opts.internalnorm,
t,
)
end
integ.EEst = integ.opts.internalnorm(err_tmp, t) # scalar
end
# If the step gets rejected, we don't even need to perform an update!
reject = integ.opts.adaptive && integ.EEst >= one(integ.EEst)
if !reject
# Save into u_filt and integ.u
mul!(view(u_filt, :), SolProj, x_filt.μ)
integ.u .= u_filt
# Advance the state here
copy!(integ.cache.x, integ.cache.x_filt)
integ.sol.log_likelihood += integ.cache.log_likelihood
end
end
function evaluate_ode!(
integ::OrdinaryDiffEq.ODEIntegrator{<:AbstractEK},
x_pred,
t,
second_order::Val{false},
)
@unpack f, p, dt, alg = integ
@unpack u_pred, du, ddu, measurement, R, H = integ.cache
@assert iszero(R)
@unpack E0, E1, E2 = integ.cache
z, S = measurement.μ, measurement.Σ
# Mean
_eval_f!(du, u_pred, p, t, f)
integ.destats.nf += 1
# z .= MM*E1*x_pred.μ .- du
if f.mass_matrix == I
H .= E1
elseif f.mass_matrix isa UniformScaling
H .= f.mass_matrix.λ .* E1
else
_matmul!(H, f.mass_matrix, E1)
end
_matmul!(z, H, x_pred.μ)
z .-= du[:]
# If EK1, evaluate the Jacobian and adjust H
if alg isa EK1 || alg isa IEKS
u_lin =
(alg isa IEKS && !isnothing(alg.linearize_at)) ? alg.linearize_at(t).μ : u_pred
# Jacobian is computed either with the given jac, or ForwardDiff
if !isnothing(f.jac)
_eval_f_jac!(ddu, u_lin, p, t, f)
elseif isinplace(f)
ForwardDiff.jacobian!(ddu, (du, u) -> f(du, u, p, t), du, u_lin)
integ.destats.nf += 1
else
ddu .= ForwardDiff.jacobian(u -> f(u, p, t), u_lin)
integ.destats.nf += 1
end
integ.destats.njacs += 1
# _matmul!(H, f.mass_matrix, E1) # This is already the case (see above)
_matmul!(H, ddu, E0, -1.0, 1.0)
end
return nothing
end
function evaluate_ode!(
integ::OrdinaryDiffEq.ODEIntegrator{<:EK1FDB},
x_pred,
t,
second_order::Val{false},
)
@unpack f, p, dt, alg = integ
@unpack d, u_pred, du, ddu, measurement, R, H = integ.cache
@assert iszero(R)
@unpack E0, E1, E2 = integ.cache
z, S = measurement.μ, measurement.Σ
(f.mass_matrix != I) && error("EK1FDB does not support mass-matrices right now")
# Mean
_eval_f!(du, u_pred, p, t, f)
integ.destats.nf += 1
# z .= MM*E1*x_pred.μ .- du
H1, H2 = view(H, 1:d, :), view(H, d+1:2d, :)
z1, z2 = view(z, 1:d), view(z, d+1:2d)
H1 .= E1
_matmul!(z1, H1, x_pred.μ)
z1 .-= @view du[:]
# If EK1, evaluate the Jacobian and adjust H
u_lin = u_pred
if !isnothing(f.jac)
_eval_f_jac!(ddu, u_lin, p, t, f)
elseif isinplace(f)
ForwardDiff.jacobian!(ddu, (du, u) -> f(du, u, p, t), du, u_lin)
integ.destats.nf += 1
else
ddu .= ForwardDiff.jacobian(u -> f(u, p, t), u_lin)
integ.destats.nf += 1
end
integ.destats.njacs += 1
_matmul!(H1, ddu, E0, -1.0, 1.0)
z2 .= (E2 * x_pred.μ .- ddu * du)
if integ.alg.jac_quality == 1
# EK0-type approach
H2 .= E2
elseif integ.alg.jac_quality == 2
H2 .= E2 - ddu * ddu * E0
elseif integ.alg.jac_quality == 3
_z2(m) = begin
u_pred = E0 * m
du = zeros(eltype(m), d)
ddu = zeros(eltype(m), d, d)
_eval_f!(du, u_pred, p, t, f)
if !isnothing(f.jac)
_eval_f_jac!(ddu, u_pred, p, t, f)
elseif isinplace(f)
ForwardDiff.jacobian!(ddu, (du, u) -> f(du, u, p, t), du, u_pred)
# integ.destats.nf += 1
else
ddu .= ForwardDiff.jacobian(u -> f(u, p, t), u_pred)
# integ.destats.nf += 1
end
# integ.destats.njacs += 1
return (E2 * m .- ddu * du)
end
H2 .= ForwardDiff.jacobian(_z2, x_pred.μ)
else
error("EK1FDB's `jac_quality` has to be in [1,2,3]")
end
return nothing
end
function evaluate_ode!(
integ::OrdinaryDiffEq.ODEIntegrator{<:AbstractEK},
x_pred,
t,
second_order::Val{true},
)
@unpack f, p, dt, alg = integ
@unpack d, u_pred, du, ddu, measurement, R, H = integ.cache
@assert iszero(R)
du2 = du
@unpack E0, E1, E2 = integ.cache
z, S = measurement.μ, measurement.Σ
# Mean
# _u_pred = E0 * x_pred.μ
# _du_pred = E1 * x_pred.μ
if isinplace(f)
f.f1(du2, view(u_pred, 1:d), view(u_pred, d+1:2d), p, t)
else
du2 .= f.f1(view(u_pred, 1:d), view(u_pred, d+1:2d), p, t)
end
integ.destats.nf += 1
_matmul!(z, E2, x_pred.μ)
z .-= @view du2[:]
# Cov
if alg isa EK1
(alg isa IEKS) && error("IEKS is currently not supported for SecondOrderODEProbems")
if isinplace(f)
H .= E2
J = ddu
ForwardDiff.jacobian!(
J,
(du2, du_u) -> f.f1(du2, view(du_u, 1:d), view(du_u, d+1:2d), p, t),
du2,
u_pred,
)
integ.destats.nf += 1
integ.destats.njacs += 1
_matmul!(H, J, integ.cache.SolProj, -1.0, 1.0)
else
J = ForwardDiff.jacobian(
(du_u) -> f.f1(view(du_u, 1:d), view(du_u, d+1:2d), p, t),
u_pred,
)
integ.destats.nf += 1
integ.destats.njacs += 1
H .= E2 .- J * integ.cache.SolProj
end
end
return measurement
end
evaluate_ode!(integ, x_pred, t) =
evaluate_ode!(integ, x_pred, t, Val(integ.f isa DynamicalODEFunction))
# The following functions are just there to handle both IIP and OOP easily
_eval_f!(du, u, p, t, f::AbstractODEFunction{true}) = f(du, u, p, t)
_eval_f!(du, u, p, t, f::AbstractODEFunction{false}) = (du .= f(u, p, t))
_eval_f_jac!(ddu, u, p, t, f::AbstractODEFunction{true}) = f.jac(ddu, u, p, t)
_eval_f_jac!(ddu, u, p, t, f::AbstractODEFunction{false}) = (ddu .= f.jac(u, p, t))
compute_measurement_covariance!(cache) =
X_A_Xt!(cache.measurement.Σ, cache.x_pred.Σ, cache.H)
function update!(integ, prediction)
@unpack measurement, H, R, x_filt = integ.cache
@unpack K1, K2, x_tmp2, m_tmp = integ.cache
update!(x_filt, prediction, measurement, H, K1, x_tmp2.Σ.mat, m_tmp)
return x_filt
end
function smooth_all!(integ)
integ.sol.x_smooth = copy(integ.sol.x_filt)
@unpack A, Q = integ.cache
@unpack x_smooth, t, diffusions = integ.sol
@unpack x_tmp, x_tmp2 = integ.cache
x = x_smooth
for i in length(x)-1:-1:1
dt = t[i+1] - t[i]
if iszero(dt)
copy!(x[i], x[i+1])
continue
end
make_preconditioners!(integ.cache, dt)
P, PI = integ.cache.P, integ.cache.PI
mul!(x_tmp, P, x[i])
mul!(x_tmp2, P, x[i+1])
smooth!(x_tmp, x_tmp2, A, Q, integ, diffusions[i])
mul!(x[i], PI, x_tmp)
end
end
function estimate_errors(cache::GaussianODEFilterCache)
@unpack local_diffusion, Qh, H, d = cache
if local_diffusion isa Real && isinf(local_diffusion)
return Inf
end
L = cache.m_tmp.Σ.squareroot
if local_diffusion isa Diagonal
_matmul!(L, H, sqrt.(local_diffusion) * Qh.squareroot)
error_estimate = sqrt.(diag(L * L'))
return view(error_estimate, 1:d)
elseif local_diffusion isa Number
_matmul!(L, H, Qh.squareroot)
# error_estimate = local_diffusion .* diag(L*L')
@tullio error_estimate[i] := L[i, j] * L[i, j]
error_estimate .*= local_diffusion
# @info "it's small anyways I guess?" error_estimate cache.measurement.μ .^ 2
# error_estimate .+= cache.measurement.μ .^ 2
error_estimate .= sqrt.(error_estimate)
return view(error_estimate, 1:d)
end
end
| [
2,
34099,
287,
262,
14230,
3219,
28813,
36,
48,
13,
834,
15003,
26,
1439,
4600,
35422,
3219,
28813,
36,
80,
2348,
42289,
63,
82,
423,
530,
198,
8818,
14230,
3219,
28813,
36,
80,
13,
36733,
1096,
0,
7,
18908,
11,
12940,
3712,
35389,
31562,
16820,
22417,
30562,
8,
198,
220,
220,
220,
611,
4132,
13,
404,
912,
13,
67,
1072,
11405,
5145,
18908,
13,
14016,
13,
5796,
5226,
198,
220,
220,
220,
220,
220,
220,
220,
4049,
7203,
2514,
779,
4600,
67,
1072,
28,
7942,
63,
345,
761,
284,
900,
4600,
5796,
5226,
28,
7942,
63,
2474,
8,
198,
220,
220,
220,
2073,
361,
5145,
18908,
13,
404,
912,
13,
67,
1072,
11405,
4132,
13,
14016,
13,
5796,
5226,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
40539,
366,
1532,
345,
900,
15715,
28,
9562,
329,
9332,
11,
345,
1244,
635,
765,
284,
900,
7209,
28,
9562,
526,
198,
220,
220,
220,
886,
198,
220,
220,
220,
611,
5145,
18908,
13,
404,
912,
13,
21928,
62,
16833,
9662,
11405,
4132,
13,
14016,
13,
5796,
5226,
198,
220,
220,
220,
220,
220,
220,
220,
4049,
7203,
1532,
345,
466,
407,
3613,
477,
3815,
11,
345,
466,
407,
761,
284,
7209,
2474,
8,
198,
220,
220,
220,
886,
198,
220,
220,
220,
2488,
30493,
4132,
13,
21928,
2676,
6624,
352,
628,
220,
220,
220,
4132,
13,
50133,
2096,
1096,
796,
352,
198,
220,
220,
220,
47558,
0,
7,
18908,
13,
74,
11,
4132,
13,
50133,
2096,
1096,
8,
198,
220,
220,
220,
4132,
13,
74,
58,
16,
60,
796,
4132,
13,
84,
628,
220,
220,
220,
1303,
10133,
262,
4238,
1181,
284,
262,
1900,
357,
35569,
393,
29231,
351,
5984,
8,
4238,
3815,
198,
220,
220,
220,
4238,
62,
19119,
0,
7,
18908,
11,
12940,
11,
4132,
13,
14016,
13,
36733,
1634,
8,
628,
220,
220,
220,
1303,
2312,
389,
3306,
1201,
262,
4610,
2134,
318,
407,
1802,
4,
23224,
416,
4277,
198,
220,
220,
220,
14230,
3219,
28813,
36,
80,
13,
30073,
265,
62,
273,
62,
14689,
0,
7,
18908,
13,
34453,
13,
87,
62,
69,
2326,
11,
4132,
13,
21928,
2676,
11,
12940,
13,
87,
8,
198,
220,
220,
220,
14230,
3219,
28813,
36,
80,
13,
30073,
265,
62,
273,
62,
14689,
0,
7,
198,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
34453,
13,
19944,
11,
198,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
21928,
2676,
11,
198,
220,
220,
220,
220,
220,
220,
220,
35971,
0,
7,
23870,
13,
19944,
62,
22065,
11,
12940,
13,
36949,
2964,
73,
11,
12940,
13,
87,
828,
198,
220,
220,
220,
1267,
198,
220,
220,
220,
1441,
2147,
198,
437,
198,
198,
37811,
5990,
687,
257,
2239,
198,
198,
3673,
6646,
4388,
0,
1114,
326,
11,
766,
4600,
9662,
0,
7,
18908,
8,
44646,
198,
198,
31524,
10874,
286,
262,
1708,
4831,
198,
12,
22819,
4559,
1487,
1220,
14322,
623,
653,
278,
198,
12,
46690,
2239,
198,
12,
24291,
434,
25,
26439,
4985,
277,
290,
449,
69,
26,
10934,
1976,
11,
311,
11,
367,
198,
12,
2199,
571,
1358,
26,
20292,
17724,
1220,
15558,
39849,
82,
611,
262,
44258,
2746,
366,
67,
28995,
1,
198,
12,
10133,
2239,
198,
12,
13047,
31850,
198,
12,
13794,
78,
262,
20435,
1487,
1220,
14322,
623,
653,
278,
198,
37811,
198,
8818,
14230,
3219,
28813,
36,
80,
13,
525,
687,
62,
9662,
0,
7,
198,
220,
220,
220,
4132,
11,
198,
220,
220,
220,
12940,
3712,
35389,
31562,
16820,
22417,
30562,
11,
198,
220,
220,
220,
9585,
62,
9662,
28,
9562,
11,
198,
8,
198,
220,
220,
220,
2488,
403,
8002,
256,
11,
288,
83,
796,
4132,
198,
220,
220,
220,
2488,
403,
8002,
288,
11,
4294,
2964,
73,
796,
4132,
13,
23870,
198,
220,
220,
220,
2488,
403,
8002,
2124,
11,
2124,
62,
28764,
11,
334,
62,
28764,
11,
2124,
62,
69,
2326,
11,
334,
62,
69,
2326,
11,
11454,
62,
22065,
796,
4132,
13,
23870,
198,
220,
220,
220,
2488,
403,
8002,
2124,
62,
22065,
11,
2124,
62,
22065,
17,
796,
4132,
13,
23870,
198,
220,
220,
220,
2488,
403,
8002,
317,
11,
1195,
11,
7900,
11,
1195,
71,
796,
4132,
13,
23870,
628,
220,
220,
220,
787,
62,
3866,
31448,
364,
0,
7,
23870,
11,
288,
83,
8,
198,
220,
220,
220,
2488,
403,
8002,
350,
11,
30434,
796,
4132,
13,
23870,
628,
220,
220,
220,
256,
3605,
796,
256,
1343,
288,
83,
628,
220,
220,
220,
1303,
10934,
262,
3376,
2603,
45977,
198,
220,
220,
220,
2488,
13,
7900,
796,
30434,
13,
10989,
363,
764,
9,
317,
764,
9,
350,
13,
10989,
363,
6,
198,
220,
220,
220,
1395,
62,
32,
62,
55,
83,
0,
7,
48,
71,
11,
1195,
11,
30434,
8,
628,
220,
220,
220,
611,
318,
67,
28995,
7,
23870,
13,
26069,
4241,
19849,
8,
220,
1303,
2199,
2889,
378,
11,
788,
4331,
39849,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
49461,
198,
220,
220,
220,
220,
220,
220,
220,
4331,
62,
32604,
0,
7,
87,
62,
28764,
11,
2124,
11,
7900,
8,
198,
220,
220,
220,
220,
220,
220,
220,
35971,
0,
7,
1177,
7,
84,
62,
28764,
11,
1058,
828,
4294,
2964,
73,
11,
2124,
62,
28764,
13,
34703,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
24291,
198,
220,
220,
220,
220,
220,
220,
220,
13446,
62,
1098,
0,
7,
18908,
11,
2124,
62,
28764,
11,
256,
3605,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
10062,
1920,
44258,
198,
220,
220,
220,
220,
220,
220,
220,
12940,
13,
12001,
62,
26069,
4241,
11,
12940,
13,
20541,
62,
26069,
4241,
796,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
8636,
62,
26069,
4241,
7,
23870,
13,
26069,
4241,
19849,
11,
4132,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
20292,
17724,
290,
15558,
198,
220,
220,
220,
220,
220,
220,
220,
4331,
62,
66,
709,
0,
7,
87,
62,
28764,
11,
2124,
11,
7900,
11,
1195,
71,
11,
12940,
13,
34,
16,
11,
12940,
13,
20541,
62,
26069,
4241,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
3082,
1133,
15558,
44829,
590,
691,
783,
198,
220,
220,
220,
220,
220,
220,
220,
24061,
62,
1326,
5015,
434,
62,
66,
709,
2743,
590,
0,
7,
23870,
8,
628,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
4331,
62,
32604,
0,
7,
87,
62,
28764,
11,
2124,
11,
7900,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4331,
62,
66,
709,
0,
7,
87,
62,
28764,
11,
2124,
11,
7900,
11,
1195,
71,
11,
12940,
13,
34,
16,
8,
198,
220,
220,
220,
220,
220,
220,
220,
35971,
0,
7,
1177,
7,
84,
62,
28764,
11,
1058,
828,
4294,
2964,
73,
11,
2124,
62,
28764,
13,
34703,
8,
198,
220,
220,
220,
220,
220,
220,
220,
13446,
62,
1098,
0,
7,
18908,
11,
2124,
62,
28764,
11,
256,
3605,
8,
198,
220,
220,
220,
220,
220,
220,
220,
24061,
62,
1326,
5015,
434,
62,
66,
709,
2743,
590,
0,
7,
23870,
8,
198,
220,
220,
220,
220,
220,
220,
220,
12940,
13,
12001,
62,
26069,
4241,
11,
12940,
13,
20541,
62,
26069,
4241,
796,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
8636,
62,
26069,
4241,
7,
23870,
13,
26069,
4241,
19849,
11,
4132,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
4525,
11935,
198,
220,
220,
220,
1303,
12940,
13,
6404,
62,
2339,
11935,
796,
2604,
12315,
7,
23870,
13,
1326,
5015,
434,
11,
1976,
27498,
7,
67,
4008,
628,
220,
220,
220,
1303,
10133,
198,
220,
220,
220,
2124,
62,
69,
2326,
796,
4296,
0,
7,
18908,
11,
2124,
62,
28764,
8,
628,
220,
220,
220,
1303,
10062,
1920,
4049,
329,
29605,
4831,
532,
460,
1541,
307,
1760,
878,
25431,
198,
220,
220,
220,
611,
4132,
13,
404,
912,
13,
42552,
425,
198,
220,
220,
220,
220,
220,
220,
220,
11454,
62,
395,
62,
403,
1416,
3021,
796,
8636,
62,
48277,
7,
23870,
8,
198,
220,
220,
220,
220,
220,
220,
220,
611,
4132,
13,
69,
318,
64,
14970,
605,
16820,
22203,
1303,
1218,
12,
2875,
440,
7206,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10631,
36,
80,
14881,
13,
9948,
3129,
378,
62,
411,
312,
723,
82,
0,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
11454,
62,
22065,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
83,
1635,
11454,
62,
395,
62,
403,
1416,
3021,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
84,
58,
16,
11,
1058,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
62,
28764,
58,
16,
11,
1058,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
404,
912,
13,
397,
301,
349,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
404,
912,
13,
2411,
83,
349,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
404,
912,
13,
32538,
27237,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
256,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1267,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
1303,
3218,
717,
12,
2875,
440,
7206,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10631,
36,
80,
14881,
13,
9948,
3129,
378,
62,
411,
312,
723,
82,
0,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
11454,
62,
22065,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
83,
1635,
11454,
62,
395,
62,
403,
1416,
3021,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
84,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
62,
28764,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
404,
912,
13,
397,
301,
349,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
404,
912,
13,
2411,
83,
349,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
404,
912,
13,
32538,
27237,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
256,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1267,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
6500,
301,
796,
4132,
13,
404,
912,
13,
32538,
27237,
7,
8056,
62,
22065,
11,
256,
8,
1303,
16578,
283,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
1002,
262,
2239,
3011,
8606,
11,
356,
836,
470,
772,
761,
284,
1620,
281,
4296,
0,
198,
220,
220,
220,
4968,
796,
4132,
13,
404,
912,
13,
42552,
425,
11405,
4132,
13,
6500,
301,
18189,
530,
7,
18908,
13,
6500,
301,
8,
198,
220,
220,
220,
611,
5145,
260,
752,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
12793,
656,
334,
62,
69,
2326,
290,
4132,
13,
84,
198,
220,
220,
220,
220,
220,
220,
220,
35971,
0,
7,
1177,
7,
84,
62,
69,
2326,
11,
1058,
828,
4294,
2964,
73,
11,
2124,
62,
69,
2326,
13,
34703,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
84,
764,
28,
334,
62,
69,
2326,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
25170,
262,
1181,
994,
198,
220,
220,
220,
220,
220,
220,
220,
4866,
0,
7,
18908,
13,
23870,
13,
87,
11,
4132,
13,
23870,
13,
87,
62,
69,
2326,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
34453,
13,
6404,
62,
2339,
11935,
15853,
4132,
13,
23870,
13,
6404,
62,
2339,
11935,
198,
220,
220,
220,
886,
198,
437,
198,
198,
8818,
13446,
62,
1098,
0,
7,
198,
220,
220,
220,
4132,
3712,
35422,
3219,
28813,
36,
80,
13,
16820,
34500,
12392,
90,
27,
25,
23839,
36,
42,
5512,
198,
220,
220,
220,
2124,
62,
28764,
11,
198,
220,
220,
220,
256,
11,
198,
220,
220,
220,
1218,
62,
2875,
3712,
7762,
90,
9562,
5512,
198,
8,
198,
220,
220,
220,
2488,
403,
8002,
277,
11,
279,
11,
288,
83,
11,
435,
70,
796,
4132,
198,
220,
220,
220,
2488,
403,
8002,
334,
62,
28764,
11,
7043,
11,
288,
646,
11,
15558,
11,
371,
11,
367,
796,
4132,
13,
23870,
198,
220,
220,
220,
2488,
30493,
318,
22570,
7,
49,
8,
628,
220,
220,
220,
2488,
403,
8002,
412,
15,
11,
412,
16,
11,
412,
17,
796,
4132,
13,
23870,
628,
220,
220,
220,
1976,
11,
311,
796,
15558,
13,
34703,
11,
15558,
13,
138,
96,
628,
220,
220,
220,
1303,
22728,
198,
220,
220,
220,
4808,
18206,
62,
69,
0,
7,
646,
11,
334,
62,
28764,
11,
279,
11,
256,
11,
277,
8,
198,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
69,
15853,
352,
198,
220,
220,
220,
1303,
1976,
764,
28,
20806,
9,
36,
16,
9,
87,
62,
28764,
13,
34703,
764,
12,
7043,
198,
220,
220,
220,
611,
277,
13,
22208,
62,
6759,
8609,
6624,
314,
198,
220,
220,
220,
220,
220,
220,
220,
367,
764,
28,
412,
16,
198,
220,
220,
220,
2073,
361,
277,
13,
22208,
62,
6759,
8609,
318,
64,
35712,
3351,
4272,
198,
220,
220,
220,
220,
220,
220,
220,
367,
764,
28,
277,
13,
22208,
62,
6759,
8609,
13,
39377,
764,
9,
412,
16,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
6759,
76,
377,
0,
7,
39,
11,
277,
13,
22208,
62,
6759,
8609,
11,
412,
16,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
4808,
6759,
76,
377,
0,
7,
89,
11,
367,
11,
2124,
62,
28764,
13,
34703,
8,
198,
220,
220,
220,
1976,
764,
12,
28,
7043,
58,
47715,
628,
220,
220,
220,
1303,
1002,
412,
42,
16,
11,
13446,
262,
12806,
666,
290,
4532,
367,
198,
220,
220,
220,
611,
435,
70,
318,
64,
412,
42,
16,
8614,
435,
70,
318,
64,
28157,
27015,
198,
220,
220,
220,
220,
220,
220,
220,
334,
62,
2815,
796,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
14016,
318,
64,
28157,
27015,
11405,
5145,
271,
22366,
7,
14016,
13,
29127,
1096,
62,
265,
4008,
5633,
435,
70,
13,
29127,
1096,
62,
265,
7,
83,
737,
34703,
1058,
334,
62,
28764,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
12806,
666,
318,
29231,
2035,
351,
262,
1813,
474,
330,
11,
393,
19530,
28813,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
22366,
7,
69,
13,
30482,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4808,
18206,
62,
69,
62,
30482,
0,
7,
67,
646,
11,
334,
62,
2815,
11,
279,
11,
256,
11,
277,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
361,
318,
259,
5372,
7,
69,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
19530,
28813,
13,
30482,
672,
666,
0,
7,
67,
646,
11,
357,
646,
11,
334,
8,
4613,
277,
7,
646,
11,
334,
11,
279,
11,
256,
828,
7043,
11,
334,
62,
2815,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
69,
15853,
352,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
646,
764,
28,
19530,
28813,
13,
30482,
672,
666,
7,
84,
4613,
277,
7,
84,
11,
279,
11,
256,
828,
334,
62,
2815,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
69,
15853,
352,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
73,
16436,
15853,
352,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
4808,
6759,
76,
377,
0,
7,
39,
11,
277,
13,
22208,
62,
6759,
8609,
11,
412,
16,
8,
1303,
770,
318,
1541,
262,
1339,
357,
3826,
2029,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
6759,
76,
377,
0,
7,
39,
11,
288,
646,
11,
412,
15,
11,
532,
16,
13,
15,
11,
352,
13,
15,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
2147,
198,
437,
198,
198,
8818,
13446,
62,
1098,
0,
7,
198,
220,
220,
220,
4132,
3712,
35422,
3219,
28813,
36,
80,
13,
16820,
34500,
12392,
90,
27,
25,
36,
42,
16,
37,
11012,
5512,
198,
220,
220,
220,
2124,
62,
28764,
11,
198,
220,
220,
220,
256,
11,
198,
220,
220,
220,
1218,
62,
2875,
3712,
7762,
90,
9562,
5512,
198,
8,
198,
220,
220,
220,
2488,
403,
8002,
277,
11,
279,
11,
288,
83,
11,
435,
70,
796,
4132,
198,
220,
220,
220,
2488,
403,
8002,
288,
11,
334,
62,
28764,
11,
7043,
11,
288,
646,
11,
15558,
11,
371,
11,
367,
796,
4132,
13,
23870,
198,
220,
220,
220,
2488,
30493,
318,
22570,
7,
49,
8,
628,
220,
220,
220,
2488,
403,
8002,
412,
15,
11,
412,
16,
11,
412,
17,
796,
4132,
13,
23870,
628,
220,
220,
220,
1976,
11,
311,
796,
15558,
13,
34703,
11,
15558,
13,
138,
96,
628,
220,
220,
220,
357,
69,
13,
22208,
62,
6759,
8609,
14512,
314,
8,
11405,
4049,
7203,
36,
42,
16,
37,
11012,
857,
407,
1104,
2347,
12,
6759,
45977,
826,
783,
4943,
628,
220,
220,
220,
1303,
22728,
198,
220,
220,
220,
4808,
18206,
62,
69,
0,
7,
646,
11,
334,
62,
28764,
11,
279,
11,
256,
11,
277,
8,
198,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
69,
15853,
352,
198,
220,
220,
220,
1303,
1976,
764,
28,
20806,
9,
36,
16,
9,
87,
62,
28764,
13,
34703,
764,
12,
7043,
198,
220,
220,
220,
367,
16,
11,
367,
17,
796,
1570,
7,
39,
11,
352,
25,
67,
11,
1058,
828,
1570,
7,
39,
11,
288,
10,
16,
25,
17,
67,
11,
14373,
198,
220,
220,
220,
1976,
16,
11,
1976,
17,
796,
1570,
7,
89,
11,
352,
25,
67,
828,
1570,
7,
89,
11,
288,
10,
16,
25,
17,
67,
8,
628,
220,
220,
220,
367,
16,
764,
28,
412,
16,
198,
220,
220,
220,
4808,
6759,
76,
377,
0,
7,
89,
16,
11,
367,
16,
11,
2124,
62,
28764,
13,
34703,
8,
198,
220,
220,
220,
1976,
16,
764,
12,
28,
2488,
1177,
7043,
58,
47715,
628,
220,
220,
220,
1303,
1002,
412,
42,
16,
11,
13446,
262,
12806,
666,
290,
4532,
367,
198,
220,
220,
220,
334,
62,
2815,
796,
334,
62,
28764,
198,
220,
220,
220,
611,
5145,
271,
22366,
7,
69,
13,
30482,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
18206,
62,
69,
62,
30482,
0,
7,
67,
646,
11,
334,
62,
2815,
11,
279,
11,
256,
11,
277,
8,
198,
220,
220,
220,
2073,
361,
318,
259,
5372,
7,
69,
8,
198,
220,
220,
220,
220,
220,
220,
220,
19530,
28813,
13,
30482,
672,
666,
0,
7,
67,
646,
11,
357,
646,
11,
334,
8,
4613,
277,
7,
646,
11,
334,
11,
279,
11,
256,
828,
7043,
11,
334,
62,
2815,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
69,
15853,
352,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
288,
646,
764,
28,
19530,
28813,
13,
30482,
672,
666,
7,
84,
4613,
277,
7,
84,
11,
279,
11,
256,
828,
334,
62,
2815,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
69,
15853,
352,
198,
220,
220,
220,
886,
198,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
73,
16436,
15853,
352,
198,
220,
220,
220,
4808,
6759,
76,
377,
0,
7,
39,
16,
11,
288,
646,
11,
412,
15,
11,
532,
16,
13,
15,
11,
352,
13,
15,
8,
628,
220,
220,
220,
1976,
17,
764,
28,
357,
36,
17,
1635,
2124,
62,
28764,
13,
34703,
764,
12,
288,
646,
1635,
7043,
8,
198,
220,
220,
220,
611,
4132,
13,
14016,
13,
30482,
62,
13237,
6624,
352,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
412,
42,
15,
12,
4906,
3164,
198,
220,
220,
220,
220,
220,
220,
220,
367,
17,
764,
28,
412,
17,
198,
220,
220,
220,
2073,
361,
4132,
13,
14016,
13,
30482,
62,
13237,
6624,
362,
198,
220,
220,
220,
220,
220,
220,
220,
367,
17,
764,
28,
412,
17,
532,
288,
646,
1635,
288,
646,
1635,
412,
15,
198,
220,
220,
220,
2073,
361,
4132,
13,
14016,
13,
30482,
62,
13237,
6624,
513,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
89,
17,
7,
76,
8,
796,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
62,
28764,
796,
412,
15,
1635,
285,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
7043,
796,
1976,
27498,
7,
417,
4906,
7,
76,
828,
288,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
646,
796,
1976,
27498,
7,
417,
4906,
7,
76,
828,
288,
11,
288,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4808,
18206,
62,
69,
0,
7,
646,
11,
334,
62,
28764,
11,
279,
11,
256,
11,
277,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
22366,
7,
69,
13,
30482,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4808,
18206,
62,
69,
62,
30482,
0,
7,
67,
646,
11,
334,
62,
28764,
11,
279,
11,
256,
11,
277,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
361,
318,
259,
5372,
7,
69,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
19530,
28813,
13,
30482,
672,
666,
0,
7,
67,
646,
11,
357,
646,
11,
334,
8,
4613,
277,
7,
646,
11,
334,
11,
279,
11,
256,
828,
7043,
11,
334,
62,
28764,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
4132,
13,
16520,
1381,
13,
77,
69,
15853,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
646,
764,
28,
19530,
28813,
13,
30482,
672,
666,
7,
84,
4613,
277,
7,
84,
11,
279,
11,
256,
828,
334,
62,
28764,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
4132,
13,
16520,
1381,
13,
77,
69,
15853,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
4132,
13,
16520,
1381,
13,
77,
73,
16436,
15853,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
36,
17,
1635,
285,
764,
12,
288,
646,
1635,
7043,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
367,
17,
764,
28,
19530,
28813,
13,
30482,
672,
666,
28264,
89,
17,
11,
2124,
62,
28764,
13,
34703,
8,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
4049,
7203,
36,
42,
16,
37,
11012,
338,
4600,
30482,
62,
13237,
63,
468,
284,
307,
287,
685,
16,
11,
17,
11,
18,
60,
4943,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
2147,
198,
437,
198,
198,
8818,
13446,
62,
1098,
0,
7,
198,
220,
220,
220,
4132,
3712,
35422,
3219,
28813,
36,
80,
13,
16820,
34500,
12392,
90,
27,
25,
23839,
36,
42,
5512,
198,
220,
220,
220,
2124,
62,
28764,
11,
198,
220,
220,
220,
256,
11,
198,
220,
220,
220,
1218,
62,
2875,
3712,
7762,
90,
7942,
5512,
198,
8,
198,
220,
220,
220,
2488,
403,
8002,
277,
11,
279,
11,
288,
83,
11,
435,
70,
796,
4132,
198,
220,
220,
220,
2488,
403,
8002,
288,
11,
334,
62,
28764,
11,
7043,
11,
288,
646,
11,
15558,
11,
371,
11,
367,
796,
4132,
13,
23870,
198,
220,
220,
220,
2488,
30493,
318,
22570,
7,
49,
8,
198,
220,
220,
220,
7043,
17,
796,
7043,
628,
220,
220,
220,
2488,
403,
8002,
412,
15,
11,
412,
16,
11,
412,
17,
796,
4132,
13,
23870,
628,
220,
220,
220,
1976,
11,
311,
796,
15558,
13,
34703,
11,
15558,
13,
138,
96,
628,
220,
220,
220,
1303,
22728,
198,
220,
220,
220,
1303,
4808,
84,
62,
28764,
796,
412,
15,
1635,
2124,
62,
28764,
13,
34703,
198,
220,
220,
220,
1303,
4808,
646,
62,
28764,
796,
412,
16,
1635,
2124,
62,
28764,
13,
34703,
198,
220,
220,
220,
611,
318,
259,
5372,
7,
69,
8,
198,
220,
220,
220,
220,
220,
220,
220,
277,
13,
69,
16,
7,
646,
17,
11,
1570,
7,
84,
62,
28764,
11,
352,
25,
67,
828,
1570,
7,
84,
62,
28764,
11,
288,
10,
16,
25,
17,
67,
828,
279,
11,
256,
8,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
7043,
17,
764,
28,
277,
13,
69,
16,
7,
1177,
7,
84,
62,
28764,
11,
352,
25,
67,
828,
1570,
7,
84,
62,
28764,
11,
288,
10,
16,
25,
17,
67,
828,
279,
11,
256,
8,
198,
220,
220,
220,
886,
198,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
69,
15853,
352,
198,
220,
220,
220,
4808,
6759,
76,
377,
0,
7,
89,
11,
412,
17,
11,
2124,
62,
28764,
13,
34703,
8,
198,
220,
220,
220,
1976,
764,
12,
28,
2488,
1177,
7043,
17,
58,
47715,
628,
220,
220,
220,
1303,
39751,
198,
220,
220,
220,
611,
435,
70,
318,
64,
412,
42,
16,
198,
220,
220,
220,
220,
220,
220,
220,
357,
14016,
318,
64,
28157,
27015,
8,
11405,
4049,
7203,
10008,
27015,
318,
3058,
407,
4855,
329,
5498,
18743,
16820,
2964,
65,
5232,
4943,
628,
220,
220,
220,
220,
220,
220,
220,
611,
318,
259,
5372,
7,
69,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
367,
764,
28,
412,
17,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
449,
796,
288,
646,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
19530,
28813,
13,
30482,
672,
666,
0,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
449,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
646,
17,
11,
7043,
62,
84,
8,
4613,
277,
13,
69,
16,
7,
646,
17,
11,
1570,
7,
646,
62,
84,
11,
352,
25,
67,
828,
1570,
7,
646,
62,
84,
11,
288,
10,
16,
25,
17,
67,
828,
279,
11,
256,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
7043,
17,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
62,
28764,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1267,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
69,
15853,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
73,
16436,
15853,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4808,
6759,
76,
377,
0,
7,
39,
11,
449,
11,
4132,
13,
23870,
13,
36949,
2964,
73,
11,
532,
16,
13,
15,
11,
352,
13,
15,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
449,
796,
19530,
28813,
13,
30482,
672,
666,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
646,
62,
84,
8,
4613,
277,
13,
69,
16,
7,
1177,
7,
646,
62,
84,
11,
352,
25,
67,
828,
1570,
7,
646,
62,
84,
11,
288,
10,
16,
25,
17,
67,
828,
279,
11,
256,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
62,
28764,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1267,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
69,
15853,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4132,
13,
16520,
1381,
13,
77,
73,
16436,
15853,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
367,
764,
28,
412,
17,
764,
12,
449,
1635,
4132,
13,
23870,
13,
36949,
2964,
73,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
15558,
198,
437,
198,
49786,
62,
1098,
0,
7,
18908,
11,
2124,
62,
28764,
11,
256,
8,
796,
198,
220,
220,
220,
13446,
62,
1098,
0,
7,
18908,
11,
2124,
62,
28764,
11,
256,
11,
3254,
7,
18908,
13,
69,
318,
64,
14970,
605,
16820,
22203,
4008,
198,
198,
2,
383,
1708,
5499,
389,
655,
612,
284,
5412,
1111,
2873,
47,
290,
440,
3185,
3538,
198,
62,
18206,
62,
69,
0,
7,
646,
11,
334,
11,
279,
11,
256,
11,
277,
3712,
23839,
16820,
22203,
90,
7942,
30072,
796,
277,
7,
646,
11,
334,
11,
279,
11,
256,
8,
198,
62,
18206,
62,
69,
0,
7,
646,
11,
334,
11,
279,
11,
256,
11,
277,
3712,
23839,
16820,
22203,
90,
9562,
30072,
796,
357,
646,
764,
28,
277,
7,
84,
11,
279,
11,
256,
4008,
198,
62,
18206,
62,
69,
62,
30482,
0,
7,
67,
646,
11,
334,
11,
279,
11,
256,
11,
277,
3712,
23839,
16820,
22203,
90,
7942,
30072,
796,
277,
13,
30482,
7,
67,
646,
11,
334,
11,
279,
11,
256,
8,
198,
62,
18206,
62,
69,
62,
30482,
0,
7,
67,
646,
11,
334,
11,
279,
11,
256,
11,
277,
3712,
23839,
16820,
22203,
90,
9562,
30072,
796,
357,
67,
646,
764,
28,
277,
13,
30482,
7,
84,
11,
279,
11,
256,
4008,
198,
198,
5589,
1133,
62,
1326,
5015,
434,
62,
66,
709,
2743,
590,
0,
7,
23870,
8,
796,
198,
220,
220,
220,
1395,
62,
32,
62,
55,
83,
0,
7,
23870,
13,
1326,
5015,
434,
13,
138,
96,
11,
12940,
13,
87,
62,
28764,
13,
138,
96,
11,
12940,
13,
39,
8,
198,
198,
8818,
4296,
0,
7,
18908,
11,
17724,
8,
198,
220,
220,
220,
2488,
403,
8002,
15558,
11,
367,
11,
371,
11,
2124,
62,
69,
2326,
796,
4132,
13,
23870,
198,
220,
220,
220,
2488,
403,
8002,
509,
16,
11,
509,
17,
11,
2124,
62,
22065,
17,
11,
285,
62,
22065,
796,
4132,
13,
23870,
198,
220,
220,
220,
4296,
0,
7,
87,
62,
69,
2326,
11,
17724,
11,
15558,
11,
367,
11,
509,
16,
11,
2124,
62,
22065,
17,
13,
138,
96,
13,
6759,
11,
285,
62,
22065,
8,
198,
220,
220,
220,
1441,
2124,
62,
69,
2326,
198,
437,
198,
198,
8818,
7209,
62,
439,
0,
7,
18908,
8,
198,
220,
220,
220,
4132,
13,
34453,
13,
87,
62,
5796,
5226,
796,
4866,
7,
18908,
13,
34453,
13,
87,
62,
69,
2326,
8,
628,
220,
220,
220,
2488,
403,
8002,
317,
11,
1195,
796,
4132,
13,
23870,
198,
220,
220,
220,
2488,
403,
8002,
2124,
62,
5796,
5226,
11,
256,
11,
814,
15880,
796,
4132,
13,
34453,
198,
220,
220,
220,
2488,
403,
8002,
2124,
62,
22065,
11,
2124,
62,
22065,
17,
796,
4132,
13,
23870,
198,
220,
220,
220,
2124,
796,
2124,
62,
5796,
5226,
628,
220,
220,
220,
329,
1312,
287,
4129,
7,
87,
13219,
16,
21912,
16,
25,
16,
198,
220,
220,
220,
220,
220,
220,
220,
288,
83,
796,
256,
58,
72,
10,
16,
60,
532,
256,
58,
72,
60,
198,
220,
220,
220,
220,
220,
220,
220,
611,
318,
22570,
7,
28664,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4866,
0,
7,
87,
58,
72,
4357,
2124,
58,
72,
10,
16,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2555,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
787,
62,
3866,
31448,
364,
0,
7,
18908,
13,
23870,
11,
288,
83,
8,
198,
220,
220,
220,
220,
220,
220,
220,
350,
11,
30434,
796,
4132,
13,
23870,
13,
47,
11,
4132,
13,
23870,
13,
11901,
628,
220,
220,
220,
220,
220,
220,
220,
35971,
0,
7,
87,
62,
22065,
11,
350,
11,
2124,
58,
72,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
35971,
0,
7,
87,
62,
22065,
17,
11,
350,
11,
2124,
58,
72,
10,
16,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
7209,
0,
7,
87,
62,
22065,
11,
2124,
62,
22065,
17,
11,
317,
11,
1195,
11,
4132,
11,
814,
15880,
58,
72,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
35971,
0,
7,
87,
58,
72,
4357,
30434,
11,
2124,
62,
22065,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
8818,
8636,
62,
48277,
7,
23870,
3712,
35389,
31562,
16820,
22417,
30562,
8,
198,
220,
220,
220,
2488,
403,
8002,
1957,
62,
26069,
4241,
11,
1195,
71,
11,
367,
11,
288,
796,
12940,
628,
220,
220,
220,
611,
1957,
62,
26069,
4241,
318,
64,
6416,
11405,
318,
10745,
7,
12001,
62,
26069,
4241,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
4806,
198,
220,
220,
220,
886,
628,
220,
220,
220,
406,
796,
12940,
13,
76,
62,
22065,
13,
138,
96,
13,
23415,
15763,
628,
220,
220,
220,
611,
1957,
62,
26069,
4241,
318,
64,
6031,
27923,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
6759,
76,
377,
0,
7,
43,
11,
367,
11,
19862,
17034,
12195,
12001,
62,
26069,
4241,
8,
1635,
1195,
71,
13,
23415,
15763,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4049,
62,
395,
1920,
796,
19862,
17034,
12195,
10989,
363,
7,
43,
1635,
406,
6,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
1570,
7,
18224,
62,
395,
1920,
11,
352,
25,
67,
8,
628,
220,
220,
220,
2073,
361,
1957,
62,
26069,
4241,
318,
64,
7913,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
6759,
76,
377,
0,
7,
43,
11,
367,
11,
1195,
71,
13,
23415,
15763,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
4049,
62,
395,
1920,
796,
1957,
62,
26069,
4241,
764,
9,
2566,
363,
7,
43,
9,
43,
11537,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
83,
724,
952,
4049,
62,
395,
1920,
58,
72,
60,
19039,
406,
58,
72,
11,
474,
60,
1635,
406,
58,
72,
11,
474,
60,
198,
220,
220,
220,
220,
220,
220,
220,
4049,
62,
395,
1920,
764,
9,
28,
1957,
62,
26069,
4241,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
2488,
10951,
366,
270,
338,
1402,
32845,
314,
4724,
1701,
4049,
62,
395,
1920,
12940,
13,
1326,
5015,
434,
13,
34703,
764,
61,
362,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
4049,
62,
395,
1920,
764,
47932,
12940,
13,
1326,
5015,
434,
13,
34703,
764,
61,
362,
628,
220,
220,
220,
220,
220,
220,
220,
4049,
62,
395,
1920,
764,
28,
19862,
17034,
12195,
18224,
62,
395,
1920,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
1570,
7,
18224,
62,
395,
1920,
11,
352,
25,
67,
8,
198,
220,
220,
220,
886,
198,
437,
198
] | 1.97438 | 6,050 |
module Day07
using Statistics
import ..data_dir # from parent module
input = read(joinpath(data_dir, "day07"), String)
export part1, part2
"""
The total fuel required to align all crab submarines to `target`
This function accepts an optional `fuel_cost_function` which calculates the fuel
required to move a crab submarine from one location to another. This function
should act on non-negative integer values (ie. absolute difference). The default
is the `identity` function, in which the distance between the two locations is
also the fuel cost.
"""
function fuel_to_align(
positions::Vector{Int64},
target::Integer,
fuel_cost_function::Function = identity
)
absolute_movements = abs.(positions .- target)
fuel_costs = fuel_cost_function.(absolute_movements)
sum(fuel_costs)
end
"""
I'm calling this `brute_force` since it inelegantly searches the entire solution
space for a minimum cost. If this function isn't good enough for part 2 I can
look for leaner search strategies (starting from median position maybe?).
Starting with the assumption that the optimal position must be somewhere between
the minimum and maximum positions, we can check each possible position between
the two to determine the minimum fuel consumption.
"""
function brute_force(positions::Vector{Int64}, fuel_cost_function::Function = identity)
minimum_fuel = Inf
for position = minimum(positions):maximum(positions)
required_fuel = fuel_to_align(positions, position, fuel_cost_function)
minimum_fuel = min(required_fuel, minimum_fuel)
end
Integer(minimum_fuel)
end
function part1(input = input)
positions = [parse(Int64, position) for position in split(input, ",")]
brute_force(positions)
end
"""
I think this is an appropriate name? We're summing an arithmetic sequence.
"""
arithmetic_fuel_cost(movement::Int64) = movement * (movement + 1) / 2
function part2(input = input)
positions = [parse(Int64, position) for position in split(input, ",")]
brute_force(positions, arithmetic_fuel_cost)
end
end # module
| [
21412,
3596,
2998,
198,
198,
3500,
14370,
198,
198,
11748,
11485,
7890,
62,
15908,
1303,
422,
2560,
8265,
198,
15414,
796,
1100,
7,
22179,
6978,
7,
7890,
62,
15908,
11,
366,
820,
2998,
12340,
10903,
8,
198,
198,
39344,
636,
16,
11,
636,
17,
198,
198,
37811,
198,
464,
2472,
5252,
2672,
284,
10548,
477,
32202,
34031,
284,
4600,
16793,
63,
198,
1212,
2163,
18178,
281,
11902,
4600,
25802,
62,
15805,
62,
8818,
63,
543,
43707,
262,
5252,
198,
35827,
284,
1445,
257,
32202,
24927,
422,
530,
4067,
284,
1194,
13,
770,
2163,
220,
198,
21754,
719,
319,
1729,
12,
31591,
18253,
3815,
357,
494,
13,
4112,
3580,
737,
383,
4277,
198,
271,
262,
4600,
738,
414,
63,
2163,
11,
287,
543,
262,
5253,
1022,
262,
734,
7064,
318,
198,
14508,
262,
5252,
1575,
13,
198,
37811,
198,
8818,
5252,
62,
1462,
62,
31494,
7,
198,
220,
220,
220,
6116,
3712,
38469,
90,
5317,
2414,
5512,
198,
220,
220,
220,
2496,
3712,
46541,
11,
198,
220,
220,
220,
5252,
62,
15805,
62,
8818,
3712,
22203,
796,
5369,
198,
8,
198,
220,
220,
220,
4112,
62,
21084,
902,
796,
2352,
12195,
1930,
1756,
764,
12,
2496,
8,
198,
220,
220,
220,
5252,
62,
15805,
82,
796,
5252,
62,
15805,
62,
8818,
12195,
48546,
62,
21084,
902,
8,
198,
220,
220,
220,
2160,
7,
25802,
62,
15805,
82,
8,
198,
437,
198,
198,
37811,
198,
40,
1101,
4585,
428,
4600,
1671,
1133,
62,
3174,
63,
1201,
340,
287,
68,
1455,
3875,
15455,
262,
2104,
4610,
198,
13200,
329,
257,
5288,
1575,
13,
1002,
428,
2163,
2125,
470,
922,
1576,
329,
636,
362,
314,
460,
198,
5460,
329,
10904,
263,
2989,
10064,
357,
38690,
422,
14288,
2292,
3863,
29865,
198,
198,
22851,
351,
262,
13196,
326,
262,
16586,
2292,
1276,
307,
7382,
1022,
198,
1169,
5288,
290,
5415,
6116,
11,
356,
460,
2198,
1123,
1744,
2292,
1022,
220,
198,
1169,
734,
284,
5004,
262,
5288,
5252,
7327,
13,
198,
37811,
198,
8818,
33908,
62,
3174,
7,
1930,
1756,
3712,
38469,
90,
5317,
2414,
5512,
5252,
62,
15805,
62,
8818,
3712,
22203,
796,
5369,
8,
198,
220,
220,
220,
5288,
62,
25802,
796,
4806,
198,
220,
220,
220,
329,
2292,
796,
5288,
7,
1930,
1756,
2599,
47033,
7,
1930,
1756,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2672,
62,
25802,
796,
5252,
62,
1462,
62,
31494,
7,
1930,
1756,
11,
2292,
11,
5252,
62,
15805,
62,
8818,
8,
198,
220,
220,
220,
220,
220,
220,
220,
5288,
62,
25802,
796,
949,
7,
35827,
62,
25802,
11,
5288,
62,
25802,
8,
198,
220,
220,
220,
886,
198,
220,
220,
220,
34142,
7,
39504,
62,
25802,
8,
198,
437,
198,
198,
8818,
636,
16,
7,
15414,
796,
5128,
8,
198,
220,
220,
220,
6116,
796,
685,
29572,
7,
5317,
2414,
11,
2292,
8,
329,
2292,
287,
6626,
7,
15414,
11,
366,
553,
15437,
198,
220,
220,
220,
33908,
62,
3174,
7,
1930,
1756,
8,
198,
437,
198,
198,
37811,
198,
40,
892,
428,
318,
281,
5035,
1438,
30,
775,
821,
2160,
2229,
281,
34768,
8379,
13,
198,
37811,
198,
283,
29848,
62,
25802,
62,
15805,
7,
21084,
434,
3712,
5317,
2414,
8,
796,
3356,
1635,
357,
21084,
434,
1343,
352,
8,
1220,
362,
198,
198,
8818,
636,
17,
7,
15414,
796,
5128,
8,
198,
220,
220,
220,
6116,
796,
685,
29572,
7,
5317,
2414,
11,
2292,
8,
329,
2292,
287,
6626,
7,
15414,
11,
366,
553,
15437,
198,
220,
220,
220,
33908,
62,
3174,
7,
1930,
1756,
11,
34768,
62,
25802,
62,
15805,
8,
198,
437,
198,
198,
437,
1303,
8265,
198
] | 3.459866 | 598 |
module juliaAllotter
using CSV
using LinearAlgebra
using Statistics
using JLD
include("core.jl")
import Random
Random.seed!(2^13 - 1)
courseFile = "data/courseFile.csv"
studentsFile = "data/studentsFile.csv"
choiceIndices = [0, 1, 2, 3, 4, 5]
choiceWeights = [10, 1, 2, 3, 4, 5]
costWeights = [-1.0, 1.0, 1.0]
iterations = 4900
coursesDF = CSV.read(courseFile)
studentsDF = CSV.read(studentsFile)
courseCount = length(coursesDF[:, 1])
studentCount = length(studentsDF[:, 1])
cpiArray = Array(studentsDF.CPI)
times = Array(coursesDF.CourseNeeds)
choiceIdx = makeArray(studentCount, studentsDF, courseCount, coursesDF, choiceIndices)
choiceWeights = makeArray(studentCount, studentsDF, courseCount, coursesDF, choiceWeights)
initialAllotment = allotment(studentCount, courseCount, times, Matrix{Float64}(I, studentCount, studentCount))
initialAllotment = squeezeAllotment(initialAllotment)
choiceGoodnessOld, cpiGoodnessOld = calcGoodness(initialAllotment, choiceWeights, cpiArray)
finalAllottment, utility = runMCMC(initialAllotment, iterations, studentCount, courseCount, costWeights, choiceIdx, choiceWeights, studentsDF, cpiArray, times)
choiceGoodnessNew, cpiGoodnessNew = calcGoodness(finalAllottment, choiceWeights, cpiArray)
writePerformance(finalAllottment, choiceGoodnessOld, cpiGoodnessOld, choiceGoodnessNew, cpiGoodnessNew, utility)
end # module | [
21412,
474,
43640,
3237,
313,
353,
198,
198,
3500,
44189,
198,
3500,
44800,
2348,
29230,
198,
3500,
14370,
198,
3500,
449,
11163,
198,
17256,
7203,
7295,
13,
20362,
4943,
198,
198,
11748,
14534,
198,
29531,
13,
28826,
0,
7,
17,
61,
1485,
532,
352,
8,
198,
198,
17319,
8979,
796,
366,
7890,
14,
17319,
8979,
13,
40664,
1,
198,
19149,
658,
8979,
796,
366,
7890,
14,
19149,
658,
8979,
13,
40664,
1,
198,
25541,
5497,
1063,
796,
685,
15,
11,
352,
11,
362,
11,
513,
11,
604,
11,
642,
60,
198,
25541,
1135,
2337,
796,
685,
940,
11,
352,
11,
362,
11,
513,
11,
604,
11,
642,
60,
198,
15805,
1135,
2337,
796,
25915,
16,
13,
15,
11,
352,
13,
15,
11,
352,
13,
15,
60,
198,
2676,
602,
796,
5125,
405,
198,
198,
66,
39975,
8068,
796,
44189,
13,
961,
7,
17319,
8979,
8,
198,
19149,
658,
8068,
796,
44189,
13,
961,
7,
19149,
658,
8979,
8,
198,
198,
17319,
12332,
796,
4129,
7,
66,
39975,
8068,
58,
45299,
352,
12962,
198,
50139,
12332,
796,
4129,
7,
19149,
658,
8068,
58,
45299,
352,
12962,
198,
13155,
72,
19182,
796,
15690,
7,
19149,
658,
8068,
13,
8697,
40,
8,
198,
22355,
796,
15690,
7,
66,
39975,
8068,
13,
49046,
23037,
82,
8,
198,
198,
25541,
7390,
87,
796,
787,
19182,
7,
50139,
12332,
11,
2444,
8068,
11,
1781,
12332,
11,
10902,
8068,
11,
3572,
5497,
1063,
8,
198,
25541,
1135,
2337,
796,
787,
19182,
7,
50139,
12332,
11,
2444,
8068,
11,
1781,
12332,
11,
10902,
8068,
11,
3572,
1135,
2337,
8,
198,
198,
36733,
3237,
313,
434,
796,
47405,
434,
7,
50139,
12332,
11,
1781,
12332,
11,
1661,
11,
24936,
90,
43879,
2414,
92,
7,
40,
11,
3710,
12332,
11,
3710,
12332,
4008,
198,
36733,
3237,
313,
434,
796,
21229,
3237,
313,
434,
7,
36733,
3237,
313,
434,
8,
198,
198,
25541,
10248,
1108,
19620,
11,
269,
14415,
10248,
1108,
19620,
796,
42302,
10248,
1108,
7,
36733,
3237,
313,
434,
11,
3572,
1135,
2337,
11,
269,
14415,
19182,
8,
198,
198,
20311,
3237,
1252,
434,
11,
10361,
796,
1057,
9655,
9655,
7,
36733,
3237,
313,
434,
11,
34820,
11,
3710,
12332,
11,
1781,
12332,
11,
1575,
1135,
2337,
11,
3572,
7390,
87,
11,
3572,
1135,
2337,
11,
2444,
8068,
11,
269,
14415,
19182,
11,
1661,
8,
198,
25541,
10248,
1108,
3791,
11,
269,
14415,
10248,
1108,
3791,
796,
42302,
10248,
1108,
7,
20311,
3237,
1252,
434,
11,
3572,
1135,
2337,
11,
269,
14415,
19182,
8,
198,
198,
13564,
32273,
7,
20311,
3237,
1252,
434,
11,
3572,
10248,
1108,
19620,
11,
269,
14415,
10248,
1108,
19620,
11,
3572,
10248,
1108,
3791,
11,
269,
14415,
10248,
1108,
3791,
11,
10361,
8,
198,
198,
437,
1303,
8265
] | 3.011013 | 454 |
struct PolicyValueRewardTest <: TrainingTest
idx::Integer
state::AbstractEnvState
image::AbstractImage
actions::Vector{<:Integer}
value::Float32
action::Integer
reward::Float32
end
mutable struct PolicyValueRewardTests <: TrainingTests
tests::Vector{PolicyValueRewardTest}
images::AbstractArray{Float32, 4}
actual_value::AbstractArray{Float32, 2}
actual_reward::AbstractArray{Float32, 2}
period::Int
warmup::Int
function PolicyValueRewardTests(tests; period=1, warmup=0)
new(
tests,
tensorize(get_image.(tests)),
Flux.unsqueeze(get_value.(tests), 1),
Flux.unsqueeze(get_reward.(tests), 1),
period,
warmup,
)
end
end
function gettestfn(tests::PolicyValueRewardTests)
function fn(n::Network)
initial_output = initialinferencefn(tests)(n)
acc, fails = getpolicyacc(tests, initial_output)
value_mse = getvaluemse(tests, initial_output)
recurrent_output = recurrentinferencefn(tests, initial_output)(n)
reward_mse = getrewardmse(tests, recurrent_output)
acc, fails, value_mse, reward_mse
end
end
struct PolicyValueRewardTestsSVG
tests::PolicyValueRewardTests
end
svg(x::PolicyValueRewardTests) = PolicyValueRewardTestsSVG(x)
function Base.show(io::IO, m::MIME"image/svg+xml", x::PolicyValueRewardTestsSVG)
num_tests = length(x.tests)
range = 1:(min(10, num_tests))
subset = 1:num_tests
subset_indices = subset[range]
svgbatch = [gridsvg(x.tests[i]) for i in subset_indices]
Base.show(io, m, GridSVG(svgbatch, main_title="RVP Tests"))
end | [
7249,
7820,
11395,
48123,
14402,
1279,
25,
13614,
14402,
198,
220,
220,
220,
4686,
87,
3712,
46541,
198,
220,
220,
220,
1181,
3712,
23839,
4834,
85,
9012,
198,
220,
220,
220,
2939,
3712,
23839,
5159,
198,
220,
220,
220,
4028,
3712,
38469,
90,
27,
25,
46541,
92,
198,
220,
220,
220,
1988,
3712,
43879,
2624,
198,
220,
220,
220,
2223,
3712,
46541,
198,
220,
220,
220,
6721,
3712,
43879,
2624,
198,
437,
198,
198,
76,
18187,
2878,
7820,
11395,
48123,
51,
3558,
1279,
25,
13614,
51,
3558,
198,
220,
220,
220,
5254,
3712,
38469,
90,
36727,
11395,
48123,
14402,
92,
198,
220,
220,
220,
4263,
3712,
23839,
19182,
90,
43879,
2624,
11,
604,
92,
198,
220,
220,
220,
4036,
62,
8367,
3712,
23839,
19182,
90,
43879,
2624,
11,
362,
92,
198,
220,
220,
220,
4036,
62,
260,
904,
3712,
23839,
19182,
90,
43879,
2624,
11,
362,
92,
198,
220,
220,
220,
2278,
3712,
5317,
198,
220,
220,
220,
5814,
929,
3712,
5317,
198,
220,
220,
220,
2163,
7820,
11395,
48123,
51,
3558,
7,
41989,
26,
2278,
28,
16,
11,
5814,
929,
28,
15,
8,
198,
220,
220,
220,
220,
220,
220,
220,
649,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5254,
11,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
11192,
273,
1096,
7,
1136,
62,
9060,
12195,
41989,
36911,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1610,
2821,
13,
13271,
421,
1453,
2736,
7,
1136,
62,
8367,
12195,
41989,
828,
352,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1610,
2821,
13,
13271,
421,
1453,
2736,
7,
1136,
62,
260,
904,
12195,
41989,
828,
352,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2278,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5814,
929,
11,
198,
220,
220,
220,
220,
220,
220,
220,
1267,
198,
220,
220,
220,
886,
198,
437,
198,
198,
8818,
651,
9288,
22184,
7,
41989,
3712,
36727,
11395,
48123,
51,
3558,
8,
198,
220,
220,
220,
2163,
24714,
7,
77,
3712,
26245,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4238,
62,
22915,
796,
4238,
259,
4288,
22184,
7,
41989,
5769,
77,
8,
198,
220,
220,
220,
220,
220,
220,
220,
697,
11,
10143,
796,
651,
30586,
4134,
7,
41989,
11,
4238,
62,
22915,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1988,
62,
76,
325,
796,
651,
2100,
84,
368,
325,
7,
41989,
11,
4238,
62,
22915,
8,
198,
220,
220,
220,
220,
220,
220,
220,
42465,
62,
22915,
796,
42465,
259,
4288,
22184,
7,
41989,
11,
4238,
62,
22915,
5769,
77,
8,
198,
220,
220,
220,
220,
220,
220,
220,
6721,
62,
76,
325,
796,
651,
260,
904,
76,
325,
7,
41989,
11,
42465,
62,
22915,
8,
198,
220,
220,
220,
220,
220,
220,
220,
697,
11,
10143,
11,
1988,
62,
76,
325,
11,
6721,
62,
76,
325,
198,
220,
220,
220,
886,
198,
437,
198,
198,
7249,
7820,
11395,
48123,
51,
3558,
50,
43490,
198,
220,
220,
220,
5254,
3712,
36727,
11395,
48123,
51,
3558,
198,
437,
198,
21370,
70,
7,
87,
3712,
36727,
11395,
48123,
51,
3558,
8,
796,
7820,
11395,
48123,
51,
3558,
50,
43490,
7,
87,
8,
198,
198,
8818,
7308,
13,
12860,
7,
952,
3712,
9399,
11,
285,
3712,
44,
12789,
1,
9060,
14,
21370,
70,
10,
19875,
1600,
2124,
3712,
36727,
11395,
48123,
51,
3558,
50,
43490,
8,
198,
220,
220,
220,
997,
62,
41989,
796,
4129,
7,
87,
13,
41989,
8,
198,
220,
220,
220,
2837,
796,
352,
37498,
1084,
7,
940,
11,
997,
62,
41989,
4008,
198,
220,
220,
220,
24637,
796,
352,
25,
22510,
62,
41989,
198,
220,
220,
220,
24637,
62,
521,
1063,
796,
24637,
58,
9521,
60,
198,
220,
220,
220,
38487,
22296,
963,
796,
685,
2164,
2340,
45119,
7,
87,
13,
41989,
58,
72,
12962,
329,
1312,
287,
24637,
62,
521,
1063,
60,
198,
220,
220,
220,
7308,
13,
12860,
7,
952,
11,
285,
11,
24846,
50,
43490,
7,
21370,
22296,
963,
11,
1388,
62,
7839,
2625,
49,
8859,
30307,
48774,
198,
437
] | 2.401439 | 695 |
include("ToricVarieties.jl")
######################
# 1: The Julia type for ToricDivisors
######################
struct toric_divisor
GapToricDivisor::GapObj
end
export toric_divisor
######################
# 2: Generic constructors
######################
function create_divisor( coeffs::Vector{Int}, v::toric_variety )
# create the divisor
gap_coeffs = GapObj( coeffs )
gap_divisor = GAP.Globals.CreateDivisor( gap_coeffs, v.GapToricVariety )
# wrap and return
return toric_divisor( gap_divisor )
end
export create_divisor
function divisor_of_character( character::Vector{Int}, v::toric_variety )
# create the divisor
gap_character = GapObj( character )
gap_divisor = GAP.Globals.DivisorOfCharacter( gap_character, v.GapToricVariety )
# wrap and return
return toric_divisor( gap_divisor )
end
export divisor_of_character
function divisor_of_class( v::toric_variety, class::Vector{Int} )
# create the divisor
gap_class = GapObj( class )
gap_divisor = GAP.Globals.DivisorOfGivenClass( v.GapToricVariety, gap_class )
# wrap and return
return toric_divisor( gap_divisor )
end
export divisor_of_class
######################
# 3: Properties
######################
function is_cartier( d::toric_divisor )
return GAP.Globals.IsCartier( d.GapToricDivisor )::Bool
end
export is_cartier
function is_principal( d::toric_divisor )
return GAP.Globals.IsPrincipal( d.GapToricDivisor )::Bool
end
export is_principal
function is_primedivisor( d::toric_divisor )
return GAP.Globals.IsPrimedivisor( d.GapToricDivisor )::Bool
end
export is_primedivisor
function is_basepoint_free( d::toric_divisor )
return GAP.Globals.IsBasepointFree( d.GapToricDivisor )::Bool
end
export is_basepoint_free
function is_ample( d::toric_divisor )
return GAP.Globals.IsAmple( d.GapToricDivisor )::Bool
end
export is_ample
function is_very_ample( d::toric_divisor )
if ! is_ample( d )
@warn "Can (current) only tell for ample toric divisors if they are very ample."
return "fail"
end
return GAP.Globals.IsVeryAmple( d.GapToricDivisor )::Bool
end
export is_very_ample
function is_numerically_effective( d::toric_divisor )
return GAP.Globals.IsNumericallyEffective( d.GapToricDivisor )::Bool
end
export is_numerically_effective
| [
17256,
7203,
51,
8146,
19852,
9545,
13,
20362,
4943,
628,
198,
14468,
4242,
2235,
198,
2,
352,
25,
383,
22300,
2099,
329,
4022,
291,
24095,
271,
669,
198,
14468,
4242,
2235,
198,
198,
7249,
7332,
291,
62,
7146,
271,
273,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
33899,
51,
8146,
24095,
271,
273,
3712,
38,
499,
49201,
198,
437,
198,
39344,
7332,
291,
62,
7146,
271,
273,
198,
198,
14468,
4242,
2235,
198,
2,
362,
25,
42044,
5678,
669,
198,
14468,
4242,
2235,
198,
198,
8818,
2251,
62,
7146,
271,
273,
7,
763,
14822,
82,
3712,
38469,
90,
5317,
5512,
410,
3712,
83,
8146,
62,
7785,
1905,
1267,
198,
220,
220,
220,
1303,
2251,
262,
2659,
271,
273,
198,
220,
220,
220,
7625,
62,
1073,
14822,
82,
796,
33899,
49201,
7,
763,
14822,
82,
1267,
198,
220,
220,
220,
7625,
62,
7146,
271,
273,
796,
402,
2969,
13,
9861,
672,
874,
13,
16447,
24095,
271,
273,
7,
7625,
62,
1073,
14822,
82,
11,
410,
13,
38,
499,
51,
8146,
19852,
1905,
1267,
198,
220,
220,
220,
220,
198,
220,
220,
220,
1303,
14441,
290,
1441,
198,
220,
220,
220,
1441,
7332,
291,
62,
7146,
271,
273,
7,
7625,
62,
7146,
271,
273,
1267,
198,
437,
198,
39344,
2251,
62,
7146,
271,
273,
198,
198,
8818,
2659,
271,
273,
62,
1659,
62,
22769,
7,
2095,
3712,
38469,
90,
5317,
5512,
410,
3712,
83,
8146,
62,
7785,
1905,
1267,
198,
220,
220,
220,
1303,
2251,
262,
2659,
271,
273,
198,
220,
220,
220,
7625,
62,
22769,
796,
33899,
49201,
7,
2095,
1267,
198,
220,
220,
220,
7625,
62,
7146,
271,
273,
796,
402,
2969,
13,
9861,
672,
874,
13,
24095,
271,
273,
5189,
27275,
7,
7625,
62,
22769,
11,
410,
13,
38,
499,
51,
8146,
19852,
1905,
1267,
198,
220,
220,
220,
220,
198,
220,
220,
220,
1303,
14441,
290,
1441,
198,
220,
220,
220,
1441,
7332,
291,
62,
7146,
271,
273,
7,
7625,
62,
7146,
271,
273,
1267,
198,
437,
198,
39344,
2659,
271,
273,
62,
1659,
62,
22769,
198,
198,
8818,
2659,
271,
273,
62,
1659,
62,
4871,
7,
410,
3712,
83,
8146,
62,
7785,
1905,
11,
1398,
3712,
38469,
90,
5317,
92,
1267,
198,
220,
220,
220,
1303,
2251,
262,
2659,
271,
273,
198,
220,
220,
220,
7625,
62,
4871,
796,
33899,
49201,
7,
1398,
1267,
198,
220,
220,
220,
7625,
62,
7146,
271,
273,
796,
402,
2969,
13,
9861,
672,
874,
13,
24095,
271,
273,
5189,
15056,
9487,
7,
410,
13,
38,
499,
51,
8146,
19852,
1905,
11,
7625,
62,
4871,
1267,
198,
220,
220,
220,
220,
198,
220,
220,
220,
1303,
14441,
290,
1441,
198,
220,
220,
220,
1441,
7332,
291,
62,
7146,
271,
273,
7,
7625,
62,
7146,
271,
273,
1267,
198,
437,
198,
39344,
2659,
271,
273,
62,
1659,
62,
4871,
628,
198,
14468,
4242,
2235,
198,
2,
513,
25,
24946,
198,
14468,
4242,
2235,
198,
198,
8818,
318,
62,
26674,
959,
7,
288,
3712,
83,
8146,
62,
7146,
271,
273,
1267,
198,
220,
220,
220,
1441,
402,
2969,
13,
9861,
672,
874,
13,
3792,
43476,
959,
7,
288,
13,
38,
499,
51,
8146,
24095,
271,
273,
1267,
3712,
33,
970,
198,
437,
198,
39344,
318,
62,
26674,
959,
628,
198,
8818,
318,
62,
1050,
1939,
8521,
7,
288,
3712,
83,
8146,
62,
7146,
271,
273,
1267,
198,
220,
220,
220,
1441,
402,
2969,
13,
9861,
672,
874,
13,
3792,
42904,
8521,
7,
288,
13,
38,
499,
51,
8146,
24095,
271,
273,
1267,
3712,
33,
970,
198,
437,
198,
39344,
318,
62,
1050,
1939,
8521,
628,
198,
8818,
318,
62,
19795,
276,
452,
271,
273,
7,
288,
3712,
83,
8146,
62,
7146,
271,
273,
1267,
198,
220,
220,
220,
1441,
402,
2969,
13,
9861,
672,
874,
13,
3792,
23828,
276,
452,
271,
273,
7,
288,
13,
38,
499,
51,
8146,
24095,
271,
273,
1267,
3712,
33,
970,
198,
437,
198,
39344,
318,
62,
19795,
276,
452,
271,
273,
628,
198,
8818,
318,
62,
12093,
538,
1563,
62,
5787,
7,
288,
3712,
83,
8146,
62,
7146,
271,
273,
1267,
198,
220,
220,
220,
1441,
402,
2969,
13,
9861,
672,
874,
13,
3792,
15522,
538,
1563,
11146,
7,
288,
13,
38,
499,
51,
8146,
24095,
271,
273,
1267,
3712,
33,
970,
198,
437,
198,
39344,
318,
62,
12093,
538,
1563,
62,
5787,
628,
198,
8818,
318,
62,
1403,
7,
288,
3712,
83,
8146,
62,
7146,
271,
273,
1267,
198,
220,
220,
220,
1441,
402,
2969,
13,
9861,
672,
874,
13,
3792,
5840,
1154,
7,
288,
13,
38,
499,
51,
8146,
24095,
271,
273,
1267,
3712,
33,
970,
198,
437,
198,
39344,
318,
62,
1403,
628,
198,
8818,
318,
62,
548,
62,
1403,
7,
288,
3712,
83,
8146,
62,
7146,
271,
273,
1267,
198,
220,
220,
220,
611,
5145,
318,
62,
1403,
7,
288,
1267,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
40539,
366,
6090,
357,
14421,
8,
691,
1560,
329,
23933,
7332,
291,
2659,
271,
669,
611,
484,
389,
845,
23933,
526,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
366,
32165,
1,
198,
220,
220,
220,
886,
198,
220,
220,
220,
220,
198,
220,
220,
220,
1441,
402,
2969,
13,
9861,
672,
874,
13,
3792,
16371,
5840,
1154,
7,
288,
13,
38,
499,
51,
8146,
24095,
271,
273,
1267,
3712,
33,
970,
198,
437,
198,
39344,
318,
62,
548,
62,
1403,
628,
198,
8818,
318,
62,
77,
6975,
1146,
62,
16803,
7,
288,
3712,
83,
8146,
62,
7146,
271,
273,
1267,
198,
220,
220,
220,
1441,
402,
2969,
13,
9861,
672,
874,
13,
3792,
45,
6975,
1146,
44831,
7,
288,
13,
38,
499,
51,
8146,
24095,
271,
273,
1267,
3712,
33,
970,
198,
437,
198,
39344,
318,
62,
77,
6975,
1146,
62,
16803,
198
] | 2.462827 | 955 |
@testset "Spaces" begin
Qx, x = PolynomialRing(FlintQQ, "x")
K, a = NumberField(x^2 - 2, "a1")
Kt, t = K["t"]
E, b = NumberField(t^2 + 3)
F = GF(3)
Hecke.change_base_ring(::Hecke.NfRel, ::Hecke.gfp_mat) = error("asd")
@test_throws ErrorException hermitian_space(E, F[1 2; 2 1])
Hecke.change_base_ring(::Hecke.NfRel, x::Hecke.gfp_mat) = x
@test_throws ErrorException hermitian_space(E, F[1 2; 2 1])
V = @inferred hermitian_space(E, FlintQQ[1 2; 2 1])
@test V isa Hecke.HermSpace
end
| [
31,
9288,
2617,
366,
4561,
2114,
1,
2221,
198,
220,
1195,
87,
11,
2124,
796,
12280,
26601,
498,
39687,
7,
7414,
600,
48,
48,
11,
366,
87,
4943,
198,
220,
509,
11,
257,
796,
7913,
15878,
7,
87,
61,
17,
532,
362,
11,
366,
64,
16,
4943,
198,
220,
509,
83,
11,
256,
796,
509,
14692,
83,
8973,
628,
220,
412,
11,
275,
796,
7913,
15878,
7,
83,
61,
17,
1343,
513,
8,
628,
220,
376,
796,
34977,
7,
18,
8,
628,
220,
679,
66,
365,
13,
3803,
62,
8692,
62,
1806,
7,
3712,
39,
721,
365,
13,
45,
69,
6892,
11,
7904,
39,
721,
365,
13,
70,
46428,
62,
6759,
8,
796,
4049,
7203,
292,
67,
4943,
198,
220,
2488,
9288,
62,
400,
8516,
13047,
16922,
607,
2781,
666,
62,
13200,
7,
36,
11,
376,
58,
16,
362,
26,
362,
352,
12962,
628,
220,
679,
66,
365,
13,
3803,
62,
8692,
62,
1806,
7,
3712,
39,
721,
365,
13,
45,
69,
6892,
11,
2124,
3712,
39,
721,
365,
13,
70,
46428,
62,
6759,
8,
796,
2124,
198,
220,
2488,
9288,
62,
400,
8516,
13047,
16922,
607,
2781,
666,
62,
13200,
7,
36,
11,
376,
58,
16,
362,
26,
362,
352,
12962,
628,
220,
569,
796,
2488,
259,
18186,
607,
2781,
666,
62,
13200,
7,
36,
11,
21660,
48,
48,
58,
16,
362,
26,
362,
352,
12962,
198,
220,
2488,
9288,
569,
318,
64,
679,
66,
365,
13,
48523,
14106,
198,
437,
198
] | 2.09465 | 243 |
using JuMP, EAGO
m = Model()
EAGO.register_eago_operators!(m)
@variable(m, -1 <= x[i=1:3] <= 1)
@variable(m, -3.428579430434188 <= q <= 8.991868736935128)
add_NL_constraint(m, :(gelu(0.758903986598098 + 0.8106379052679875*gelu(0.47487042435595583 + 0.4488775132618512*gelu(0.1716391672055586 + 0.7301849089692007*gelu(0.33202390613731003 + -0.8931954910636541*$(x[1]) + 0.7142724585602056*$(x[2]) + -0.28852147983722487*$(x[3])) + 0.6276077641275091*gelu(-0.8935890604396688 + -0.29936605585485676*$(x[1]) + -0.5391102865466948*$(x[2]) + 0.8633503800224367*$(x[3]))) + 0.015398554931854491*gelu(0.8366427516313624 + 0.8654420505988725*gelu(0.33202390613731003 + -0.8931954910636541*$(x[1]) + 0.7142724585602056*$(x[2]) + -0.28852147983722487*$(x[3])) + -0.07448940361379819*gelu(-0.8935890604396688 + -0.29936605585485676*$(x[1]) + -0.5391102865466948*$(x[2]) + 0.8633503800224367*$(x[3])))) + -0.6668215058198093*gelu(0.8216722410540171 + 0.5667551555087149*gelu(0.1716391672055586 + 0.7301849089692007*gelu(0.33202390613731003 + -0.8931954910636541*$(x[1]) + 0.7142724585602056*$(x[2]) + -0.28852147983722487*$(x[3])) + 0.6276077641275091*gelu(-0.8935890604396688 + -0.29936605585485676*$(x[1]) + -0.5391102865466948*$(x[2]) + 0.8633503800224367*$(x[3]))) + 0.5912184082121308*gelu(0.8366427516313624 + 0.8654420505988725*gelu(0.33202390613731003 + -0.8931954910636541*$(x[1]) + 0.7142724585602056*$(x[2]) + -0.28852147983722487*$(x[3])) + -0.07448940361379819*gelu(-0.8935890604396688 + -0.29936605585485676*$(x[1]) + -0.5391102865466948*$(x[2]) + 0.8633503800224367*$(x[3]))))) + gelu(-0.09143860592972564 + 0.3407854070498746*gelu(0.47487042435595583 + 0.4488775132618512*gelu(0.1716391672055586 + 0.7301849089692007*gelu(0.33202390613731003 + -0.8931954910636541*$(x[1]) + 0.7142724585602056*$(x[2]) + -0.28852147983722487*$(x[3])) + 0.6276077641275091*gelu(-0.8935890604396688 + -0.29936605585485676*$(x[1]) + -0.5391102865466948*$(x[2]) + 0.8633503800224367*$(x[3]))) + 0.015398554931854491*gelu(0.8366427516313624 + 0.8654420505988725*gelu(0.33202390613731003 + -0.8931954910636541*$(x[1]) + 0.7142724585602056*$(x[2]) + -0.28852147983722487*$(x[3])) + -0.07448940361379819*gelu(-0.8935890604396688 + -0.29936605585485676*$(x[1]) + -0.5391102865466948*$(x[2]) + 0.8633503800224367*$(x[3])))) + 0.24612879529032217*gelu(0.8216722410540171 + 0.5667551555087149*gelu(0.1716391672055586 + 0.7301849089692007*gelu(0.33202390613731003 + -0.8931954910636541*$(x[1]) + 0.7142724585602056*$(x[2]) + -0.28852147983722487*$(x[3])) + 0.6276077641275091*gelu(-0.8935890604396688 + -0.29936605585485676*$(x[1]) + -0.5391102865466948*$(x[2]) + 0.8633503800224367*$(x[3]))) + 0.5912184082121308*gelu(0.8366427516313624 + 0.8654420505988725*gelu(0.33202390613731003 + -0.8931954910636541*$(x[1]) + 0.7142724585602056*$(x[2]) + -0.28852147983722487*$(x[3])) + -0.07448940361379819*gelu(-0.8935890604396688 + -0.29936605585485676*$(x[1]) + -0.5391102865466948*$(x[2]) + 0.8633503800224367*$(x[3]))))) - $q <= 0.0))
@objective(m, Min, q)
return m
| [
3500,
12585,
7378,
11,
412,
4760,
46,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
285,
796,
9104,
3419,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
412,
4760,
46,
13,
30238,
62,
68,
3839,
62,
3575,
2024,
0,
7,
76,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
45286,
7,
76,
11,
532,
16,
19841,
2124,
58,
72,
28,
16,
25,
18,
60,
19841,
352,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
45286,
7,
76,
11,
532,
18,
13,
40173,
3553,
5824,
21288,
2682,
20356,
19841,
10662,
19841,
807,
13,
2079,
1507,
39925,
30803,
2327,
12762,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
751,
62,
32572,
62,
1102,
2536,
2913,
7,
76,
11,
36147,
25280,
84,
7,
15,
13,
38569,
3829,
31952,
36445,
1795,
4089,
1343,
657,
13,
23,
15801,
29088,
2713,
2075,
3720,
31360,
9,
25280,
84,
7,
15,
13,
2857,
2780,
32869,
1731,
2327,
3270,
2816,
5999,
1343,
657,
13,
2598,
3459,
34483,
1485,
2075,
21652,
1065,
9,
25280,
84,
7,
15,
13,
1558,
1433,
2670,
21940,
1238,
2816,
29796,
1343,
657,
13,
4790,
29159,
2920,
2919,
38819,
12726,
9,
25280,
84,
7,
15,
13,
2091,
1238,
23516,
3312,
1485,
4790,
3064,
18,
1343,
532,
15,
13,
49682,
22186,
2920,
15801,
24760,
3901,
9,
3,
7,
87,
58,
16,
12962,
1343,
657,
13,
45722,
1983,
1731,
3365,
34135,
1238,
3980,
9,
3,
7,
87,
58,
17,
12962,
1343,
532,
15,
13,
25270,
4309,
1415,
43240,
2718,
24137,
5774,
9,
3,
7,
87,
58,
18,
60,
4008,
1343,
657,
13,
49856,
1899,
3324,
2414,
1065,
15426,
6420,
9,
25280,
84,
32590,
15,
13,
4531,
31128,
3829,
31916,
2670,
2791,
3459,
1343,
532,
15,
13,
22579,
2623,
1899,
2816,
5332,
32642,
42548,
9,
3,
7,
87,
58,
16,
12962,
1343,
532,
15,
13,
20,
2670,
11442,
2078,
39111,
36657,
2780,
9,
3,
7,
87,
58,
17,
12962,
1343,
657,
13,
4521,
2091,
1120,
2548,
21601,
1731,
27824,
9,
3,
7,
87,
58,
18,
60,
22305,
1343,
657,
13,
25150,
31952,
2816,
43134,
21652,
2598,
6420,
9,
25280,
84,
7,
15,
13,
23,
2623,
2414,
23195,
24136,
20809,
1731,
1343,
657,
13,
23,
2996,
2598,
1238,
1120,
3270,
3459,
45151,
9,
25280,
84,
7,
15,
13,
2091,
1238,
23516,
3312,
1485,
4790,
3064,
18,
1343,
532,
15,
13,
49682,
22186,
2920,
15801,
24760,
3901,
9,
3,
7,
87,
58,
16,
12962,
1343,
657,
13,
45722,
1983,
1731,
3365,
34135,
1238,
3980,
9,
3,
7,
87,
58,
17,
12962,
1343,
532,
15,
13,
25270,
4309,
1415,
43240,
2718,
24137,
5774,
9,
3,
7,
87,
58,
18,
60,
4008,
1343,
532,
15,
13,
2998,
2598,
4531,
1821,
2623,
1485,
43240,
1129,
9,
25280,
84,
32590,
15,
13,
4531,
31128,
3829,
31916,
2670,
2791,
3459,
1343,
532,
15,
13,
22579,
2623,
1899,
2816,
5332,
32642,
42548,
9,
3,
7,
87,
58,
16,
12962,
1343,
532,
15,
13,
20,
2670,
11442,
2078,
39111,
36657,
2780,
9,
3,
7,
87,
58,
17,
12962,
1343,
657,
13,
4521,
2091,
1120,
2548,
21601,
1731,
27824,
9,
3,
7,
87,
58,
18,
60,
35514,
1343,
532,
15,
13,
2791,
3104,
2481,
1120,
3365,
23664,
6052,
9,
25280,
84,
7,
15,
13,
6469,
1433,
4761,
1731,
940,
4051,
486,
4869,
1343,
657,
13,
20,
2791,
38172,
18742,
1120,
5774,
19442,
9,
25280,
84,
7,
15,
13,
1558,
1433,
2670,
21940,
1238,
2816,
29796,
1343,
657,
13,
4790,
29159,
2920,
2919,
38819,
12726,
9,
25280,
84,
7,
15,
13,
2091,
1238,
23516,
3312,
1485,
4790,
3064,
18,
1343,
532,
15,
13,
49682,
22186,
2920,
15801,
24760,
3901,
9,
3,
7,
87,
58,
16,
12962,
1343,
657,
13,
45722,
1983,
1731,
3365,
34135,
1238,
3980,
9,
3,
7,
87,
58,
17,
12962,
1343,
532,
15,
13,
25270,
4309,
1415,
43240,
2718,
24137,
5774,
9,
3,
7,
87,
58,
18,
60,
4008,
1343,
657,
13,
49856,
1899,
3324,
2414,
1065,
15426,
6420,
9,
25280,
84,
32590,
15,
13,
4531,
31128,
3829,
31916,
2670,
2791,
3459,
1343,
532,
15,
13,
22579,
2623,
1899,
2816,
5332,
32642,
42548,
9,
3,
7,
87,
58,
16,
12962,
1343,
532,
15,
13,
20,
2670,
11442,
2078,
39111,
36657,
2780,
9,
3,
7,
87,
58,
17,
12962,
1343,
657,
13,
4521,
2091,
1120,
2548,
21601,
1731,
27824,
9,
3,
7,
87,
58,
18,
60,
22305,
1343,
657,
13,
3270,
1065,
1507,
1821,
6469,
1065,
12952,
23,
9,
25280,
84,
7,
15,
13,
23,
2623,
2414,
23195,
24136,
20809,
1731,
1343,
657,
13,
23,
2996,
2598,
1238,
1120,
3270,
3459,
45151,
9,
25280,
84,
7,
15,
13,
2091,
1238,
23516,
3312,
1485,
4790,
3064,
18,
1343,
532,
15,
13,
49682,
22186,
2920,
15801,
24760,
3901,
9,
3,
7,
87,
58,
16,
12962,
1343,
657,
13,
45722,
1983,
1731,
3365,
34135,
1238,
3980,
9,
3,
7,
87,
58,
17,
12962,
1343,
532,
15,
13,
25270,
4309,
1415,
43240,
2718,
24137,
5774,
9,
3,
7,
87,
58,
18,
60,
4008,
1343,
532,
15,
13,
2998,
2598,
4531,
1821,
2623,
1485,
43240,
1129,
9,
25280,
84,
32590,
15,
13,
4531,
31128,
3829,
31916,
2670,
2791,
3459,
1343,
532,
15,
13,
22579,
2623,
1899,
2816,
5332,
32642,
42548,
9,
3,
7,
87,
58,
16,
12962,
1343,
532,
15,
13,
20,
2670,
11442,
2078,
39111,
36657,
2780,
9,
3,
7,
87,
58,
17,
12962,
1343,
657,
13,
4521,
2091,
1120,
2548,
21601,
1731,
27824,
9,
3,
7,
87,
58,
18,
60,
4008,
22305,
1343,
20383,
84,
32590,
15,
13,
2931,
1415,
2548,
1899,
3270,
26561,
1495,
2414,
1343,
657,
13,
23601,
3695,
35005,
2154,
2920,
5774,
3510,
9,
25280,
84,
7,
15,
13,
2857,
2780,
32869,
1731,
2327,
3270,
2816,
5999,
1343,
657,
13,
2598,
3459,
34483,
1485,
2075,
21652,
1065,
9,
25280,
84,
7,
15,
13,
1558,
1433,
2670,
21940,
1238,
2816,
29796,
1343,
657,
13,
4790,
29159,
2920,
2919,
38819,
12726,
9,
25280,
84,
7,
15,
13,
2091,
1238,
23516,
3312,
1485,
4790,
3064,
18,
1343,
532,
15,
13,
49682,
22186,
2920,
15801,
24760,
3901,
9,
3,
7,
87,
58,
16,
12962,
1343,
657,
13,
45722,
1983,
1731,
3365,
34135,
1238,
3980,
9,
3,
7,
87,
58,
17,
12962,
1343,
532,
15,
13,
25270,
4309,
1415,
43240,
2718,
24137,
5774,
9,
3,
7,
87,
58,
18,
60,
4008,
1343,
657,
13,
49856,
1899,
3324,
2414,
1065,
15426,
6420,
9,
25280,
84,
32590,
15,
13,
4531,
31128,
3829,
31916,
2670,
2791,
3459,
1343,
532,
15,
13,
22579,
2623,
1899,
2816,
5332,
32642,
42548,
9,
3,
7,
87,
58,
16,
12962,
1343,
532,
15,
13,
20,
2670,
11442,
2078,
39111,
36657,
2780,
9,
3,
7,
87,
58,
17,
12962,
1343,
657,
13,
4521,
2091,
1120,
2548,
21601,
1731,
27824,
9,
3,
7,
87,
58,
18,
60,
22305,
1343,
657,
13,
25150,
31952,
2816,
43134,
21652,
2598,
6420,
9,
25280,
84,
7,
15,
13,
23,
2623,
2414,
23195,
24136,
20809,
1731,
1343,
657,
13,
23,
2996,
2598,
1238,
1120,
3270,
3459,
45151,
9,
25280,
84,
7,
15,
13,
2091,
1238,
23516,
3312,
1485,
4790,
3064,
18,
1343,
532,
15,
13,
49682,
22186,
2920,
15801,
24760,
3901,
9,
3,
7,
87,
58,
16,
12962,
1343,
657,
13,
45722,
1983,
1731,
3365,
34135,
1238,
3980,
9,
3,
7,
87,
58,
17,
12962,
1343,
532,
15,
13,
25270,
4309,
1415,
43240,
2718,
24137,
5774,
9,
3,
7,
87,
58,
18,
60,
4008,
1343,
532,
15,
13,
2998,
2598,
4531,
1821,
2623,
1485,
43240,
1129,
9,
25280,
84,
32590,
15,
13,
4531,
31128,
3829,
31916,
2670,
2791,
3459,
1343,
532,
15,
13,
22579,
2623,
1899,
2816,
5332,
32642,
42548,
9,
3,
7,
87,
58,
16,
12962,
1343,
532,
15,
13,
20,
2670,
11442,
2078,
39111,
36657,
2780,
9,
3,
7,
87,
58,
17,
12962,
1343,
657,
13,
4521,
2091,
1120,
2548,
21601,
1731,
27824,
9,
3,
7,
87,
58,
18,
60,
35514,
1343,
657,
13,
26912,
12762,
41544,
1959,
3070,
1828,
1558,
9,
25280,
84,
7,
15,
13,
6469,
1433,
4761,
1731,
940,
4051,
486,
4869,
1343,
657,
13,
20,
2791,
38172,
18742,
1120,
5774,
19442,
9,
25280,
84,
7,
15,
13,
1558,
1433,
2670,
21940,
1238,
2816,
29796,
1343,
657,
13,
4790,
29159,
2920,
2919,
38819,
12726,
9,
25280,
84,
7,
15,
13,
2091,
1238,
23516,
3312,
1485,
4790,
3064,
18,
1343,
532,
15,
13,
49682,
22186,
2920,
15801,
24760,
3901,
9,
3,
7,
87,
58,
16,
12962,
1343,
657,
13,
45722,
1983,
1731,
3365,
34135,
1238,
3980,
9,
3,
7,
87,
58,
17,
12962,
1343,
532,
15,
13,
25270,
4309,
1415,
43240,
2718,
24137,
5774,
9,
3,
7,
87,
58,
18,
60,
4008,
1343,
657,
13,
49856,
1899,
3324,
2414,
1065,
15426,
6420,
9,
25280,
84,
32590,
15,
13,
4531,
31128,
3829,
31916,
2670,
2791,
3459,
1343,
532,
15,
13,
22579,
2623,
1899,
2816,
5332,
32642,
42548,
9,
3,
7,
87,
58,
16,
12962,
1343,
532,
15,
13,
20,
2670,
11442,
2078,
39111,
36657,
2780,
9,
3,
7,
87,
58,
17,
12962,
1343,
657,
13,
4521,
2091,
1120,
2548,
21601,
1731,
27824,
9,
3,
7,
87,
58,
18,
60,
22305,
1343,
657,
13,
3270,
1065,
1507,
1821,
6469,
1065,
12952,
23,
9,
25280,
84,
7,
15,
13,
23,
2623,
2414,
23195,
24136,
20809,
1731,
1343,
657,
13,
23,
2996,
2598,
1238,
1120,
3270,
3459,
45151,
9,
25280,
84,
7,
15,
13,
2091,
1238,
23516,
3312,
1485,
4790,
3064,
18,
1343,
532,
15,
13,
49682,
22186,
2920,
15801,
24760,
3901,
9,
3,
7,
87,
58,
16,
12962,
1343,
657,
13,
45722,
1983,
1731,
3365,
34135,
1238,
3980,
9,
3,
7,
87,
58,
17,
12962,
1343,
532,
15,
13,
25270,
4309,
1415,
43240,
2718,
24137,
5774,
9,
3,
7,
87,
58,
18,
60,
4008,
1343,
532,
15,
13,
2998,
2598,
4531,
1821,
2623,
1485,
43240,
1129,
9,
25280,
84,
32590,
15,
13,
4531,
31128,
3829,
31916,
2670,
2791,
3459,
1343,
532,
15,
13,
22579,
2623,
1899,
2816,
5332,
32642,
42548,
9,
3,
7,
87,
58,
16,
12962,
1343,
532,
15,
13,
20,
2670,
11442,
2078,
39111,
36657,
2780,
9,
3,
7,
87,
58,
17,
12962,
1343,
657,
13,
4521,
2091,
1120,
2548,
21601,
1731,
27824,
9,
3,
7,
87,
58,
18,
60,
4008,
22305,
532,
720,
80,
19841,
657,
13,
15,
4008,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
15252,
425,
7,
76,
11,
1855,
11,
10662,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
285,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220
] | 1.764286 | 1,820 |
"""
Nghttp2 Julia bindings.
"""
"""
Items:
[x] add basic unit test, server, client
[x] unit test to submit_response with payload > 16 KB
[ ] verify trailers are sent at the end with request is send with multiple packages
[ ] add unit test with invalid response
[x] return an error if failure occurs in Http2Stream
[ ] nghttp2_on_stream_close_callback, close stream on error
[ ] ensure sessions are destroyed
[x] submit request should return correct stream
[x] create a new request stream
- nghttp2_xxx functions returns error code, except _new functions.
session reading loop
read and dispatch
single Http2Session
read()
multiple entries from read stream
until it is available
Multiple Http2Streams are reading from a single Http2Session.
┌─────────────────┐
│Http2Stream::read│─ ─ ─
└─────────────────┘ │ session.read_lock
┌─────────────────┐ ─ ─ ▶ ╔════╗ ┌─────────────┐
│Http2Stream::read│───────────────╣Lock╠─────▶│Session::read│
└─────────────────┘ ─ ─ ▶ ╚════╝ └─────────────┘
┌─────────────────┐ │
│Http2Stream::read│─ ─ ─
└─────────────────┘
"""
module Nghttp2
export Http2ClientSession, Http2ServerSession, Http2Stream, Http2ProtocolError
export send, recv, try_recv, submit_request, submit_response, read, eof, bytesavailable, close, isopen
export nghttp2_version
using nghttp2_jll
using BitFlags
using Sockets
const Option{T} = Union{Nothing,T} where {T}
"""
Error codes used by Nghttp2 library.
"""
@enum(Nghttp2Error::Int32,
# Invalid argument passed.
NGHTTP2_ERR_INVALID_ARGUMENT = -501,
# Out of buffer space.
NGHTTP2_ERR_BUFFER_ERROR = -502,
# The specified protocol version is not supported.
NGHTTP2_ERR_UNSUPPORTED_VERSION = -503,
# Used as a return value from nghttp2_send_callback, nghttp2_recv_callback and nghttp2_send_data_callback to indicate that the operation would block.
NGHTTP2_ERR_WOULDBLOCK = -504,
# General protocol error.
NGHTTP2_ERR_PROTO = -505,
# The frame is invalid.
NGHTTP2_ERR_INVALID_FRAME = -506,
# The peer performed a shutdown on the connection.
NGHTTP2_ERR_EOF = -507,
# Used as a return value from nghttp2_data_source_read_callback() to indicate that data transfer is postponed. See nghttp2_data_source_read_callback() for details.
NGHTTP2_ERR_DEFERRED = -508,
# Stream ID has reached the maximum value. Therefore no stream ID is available.
NGHTTP2_ERR_STREAM_ID_NOT_AVAILABLE = -509,
# The stream is already closed; or the stream ID is invalid.
NGHTTP2_ERR_STREAM_CLOSED = -510,
# RST_STREAM has been added to the outbound queue. The stream is in closing state.
NGHTTP2_ERR_STREAM_CLOSING = -511,
# The transmission is not allowed for this stream (e.g., a frame with END_STREAM flag set has already sent).
NGHTTP2_ERR_STREAM_SHUT_WR = -512,
# The stream ID is invalid.
NGHTTP2_ERR_INVALID_STREAM_ID = -513,
# The state of the stream is not valid (e.g., DATA cannot be sent to the stream if response HEADERS has not been sent).
NGHTTP2_ERR_INVALID_STREAM_STATE = -514,
# Another DATA frame has already been deferred.
NGHTTP2_ERR_DEFERRED_DATA_EXIST = -515,
# Starting new stream is not allowed (e.g., GOAWAY has been sent and/or received).
NGHTTP2_ERR_START_STREAM_NOT_ALLOWED = -516,
# GOAWAY has already been sent.
NGHTTP2_ERR_GOAWAY_ALREADY_SENT = -517,
# The received frame contains the invalid header block.
NGHTTP2_ERR_INVALID_HEADER_BLOCK = -518,
# Indicates that the context is not suitable to perform the requested operation.
NGHTTP2_ERR_INVALID_STATE = -519,
# The user callback function failed due to the temporal error.
NGHTTP2_ERR_TEMPORAL_CALLBACK_FAILURE = -521,
# The length of the frame is invalid, either too large or too small.
NGHTTP2_ERR_FRAME_SIZE_ERROR = -522,
# Header block inflate/deflate error.
NGHTTP2_ERR_HEADER_COMP = -523,
# Flow control error.
NGHTTP2_ERR_FLOW_CONTROL = -524,
# Insufficient buffer size given to function.
NGHTTP2_ERR_INSUFF_BUFSIZE = -525,
# Callback was paused by the application.
NGHTTP2_ERR_PAUSE = -526,
# There are too many in-flight SETTING frame and no more transmission of SETTINGS is allowed.
NGHTTP2_ERR_TOO_MANY_INFLIGHT_SETTINGS = -527,
# The server push is disabled.
NGHTTP2_ERR_PUSH_DISABLED = -528,
# DATA or HEADERS frame for a given stream has been already submitted and has not been fully processed yet.
NGHTTP2_ERR_DATA_EXIST = -529,
# The current session is closing due to a connection error or nghttp2_session_terminate_session() is called.
NGHTTP2_ERR_SESSION_CLOSING = -530,
# Invalid HTTP header field was received and stream is going to be closed.
NGHTTP2_ERR_HTTP_HEADER = -531,
# Violation in HTTP messaging rule.
NGHTTP2_ERR_HTTP_MESSAGING = -532,
# Stream was refused.
NGHTTP2_ERR_REFUSED_STREAM = -533,
# Unexpected internal error, but recovered.
NGHTTP2_ERR_INTERNAL = -534,
# Indicates that a processing was canceled.
NGHTTP2_ERR_CANCEL = -535,
# When a local endpoint expects to receive SETTINGS frame, it receives an other type of frame.
NGHTTP2_ERR_SETTINGS_EXPECTED = -536,
# When a local endpoint receives too many settings entries in a single SETTINGS frame.
NGHTTP2_ERR_TOO_MANY_SETTINGS = -537,
# The errors < nghttp2_error.NGHTTP2_ERR_FATAL mean that the library is under unexpected condition and processing was terminated.
NGHTTP2_ERR_FATAL = -900,
# Out of memory. This is a fatal error.
NGHTTP2_ERR_NOMEM = -901,
# The user callback function failed. This is a fatal error.
NGHTTP2_ERR_CALLBACK_FAILURE = -902,
# Invalid client magic (see NGHTTP2_CLIENT_MAGIC) was received and further processing is not possible.
NGHTTP2_ERR_BAD_CLIENT_MAGIC = -903,
# Possible flooding by peer was detected in this HTTP/2 session.
NGHTTP2_ERR_FLOODED = -904)
"""
The frame types in HTTP/2 specification.
"""
@enum(Nghttp2FrameType::UInt8,
# The DATA frame.
NGHTTP2_DATA = 0,
# The HEADERS frame.
NGHTTP2_HEADERS = 0x01,
# The PRIORITY frame.
NGHTTP2_PRIORITY = 0x02,
# The RST_STREAM frame.
NGHTTP2_RST_STREAM = 0x03,
# The SETTINGS frame.
NGHTTP2_SETTINGS = 0x04,
# The PUSH_PROMISE frame.
NGHTTP2_PUSH_PROMISE = 0x05,
# The PING frame.
NGHTTP2_PING = 0x06,
# The GOAWAY frame.
NGHTTP2_GOAWAY = 0x07,
# The WINDOW_UPDATE frame.
NGHTTP2_WINDOW_UPDATE = 0x08,
# The CONTINUATION frame. This frame type won't be passed to any
# callbacks because the library processes this frame type and its
# preceding HEADERS/PUSH_PROMISE as a single frame.
NGHTTP2_CONTINUATION = 0x09,
# The ALTSVC frame, which is defined in `RFC 7383
# <https://tools.ietf.org/html/rfc7838#section-4>`_.
NGHTTP2_ALTSVC = 0x0a,
# The ORIGIN frame, which is defined by `RFC 8336
# <https://tools.ietf.org/html/rfc8336>`_.
NGHTTP2_ORIGIN = 0x0c)
"""
The category of HEADERS, which indicates the role of the frame. In
HTTP/2 spec, request, response, push response and other arbitrary
headers (e.g., trailer fields) are all called just HEADERS. To
give the application the role of incoming HEADERS frame, we define
several categories.
"""
@enum(Nghttp2FrameHeadersCategory::UInt32,
# The HEADERS frame is opening new stream, which is analogous to SYN_STREAM in SPDY.
NGHTTP2_HCAT_REQUEST = 0,
# The HEADERS frame is the first response headers, which is
# analogous to SYN_REPLY in SPDY.
NGHTTP2_HCAT_RESPONSE = 1,
# The HEADERS frame is the first headers sent against reserved stream.
NGHTTP2_HCAT_PUSH_RESPONSE = 2,
# The HEADERS frame which does not apply for the above categories,
# which is analogous to HEADERS in SPDY. If non-final response
# (e.g., status 1xx) is used, final response HEADERS frame will be
# categorized here.
NGHTTP2_HCAT_HEADERS = 3)
"""
The flags for HTTP/2 frames.
This enum defines all flags for all frames.
"""
@enum(Nghttp2FrameFlags::UInt8,
# No flag set.
NGHTTP2_FLAG_NONE = 0,
# The END_STREAM flag.
# The ACK flag.
NGHTTP2_FLAG_END_STREAM = 0x01,
# The END_HEADERS flag.
NGHTTP2_FLAG_END_HEADERS = 0x04,
# The PADDED flag.
NGHTTP2_FLAG_PADDED = 0x08,
# The PRIORITY flag.
NGHTTP2_FLAG_PRIORITY = 0x20)
const NGHTTP2_FLAG_ACK = NGHTTP2_FLAG_END_STREAM
"""
The status codes for the RST_STREAM and GOAWAY frames.
"""
@enum(Nghttp2ErrorCode::UInt32,
# No errors.
NGHTTP2_NO_ERROR = 0x0,
# PROTOCOL_ERROR.
NGHTTP2_PROTOCOL_ERROR = 0x1,
# INTERNAL_ERROR.
NGHTTP2_INTERNAL_ERROR = 0x2,
# FLOW_CONTROL_ERROR.
NGHTTP2_FLOW_CONTROL_ERROR = 0x3,
# SETTINGS_TIMEOUT.
NGHTTP2_SETTINGS_TIMEOUT = 0x4,
# STREAM_CLOSED.
NGHTTP2_STREAM_CLOSED = 0x5,
# FRAME_SIZE_ERROR.
NGHTTP2_FRAME_SIZE_ERROR = 0x6,
# REFUSED_STREAM.
NGHTTP2_REFUSED_STREAM = 0x7,
# CANCEL.
NGHTTP2_CANCEL = 0x8,
# COMPRESSION_ERROR.
NGHTTP2_COMPRESSION_ERROR = 0x9,
#CONNECT_ERROR.
NGHTTP2_CONNECT_ERROR = 0xa,
# ENHANCE_YOUR_CALM.
NGHTTP2_ENHANCE_YOUR_CALM = 0xb,
# INADEQUATE_SECURITY.
NGHTTP2_INADEQUATE_SECURITY = 0xc,
# HTTP_1_1_REQUIRED.
NGHTTP2_HTTP_1_1_REQUIRED = 0xd)
"""
The flags for header field name/value pair.
"""
@enum(Nghttp2NvFlags::UInt8,
# No flag set.
NGHTTP2_NV_FLAG_NONE = 0,
# Indicates that this name/value pair must not be indexed ("Literal
# Header Field never Indexed" representation must be used in HPACK
# encoding). Other implementation calls this bit as "sensitive".
NGHTTP2_NV_FLAG_NO_INDEX = 0x01,
# This flag is set solely by application. If this flag is set, the
# library does not make a copy of header field name. This could
# improve performance.
NGHTTP2_NV_FLAG_NO_COPY_NAME = 0x02,
# This flag is set solely by application. If this flag is set, the
# library does not make a copy of header field value. This could
# improve performance.
NGHTTP2_NV_FLAG_NO_COPY_VALUE = 0x04)
"""
The SETTINGS ID.
"""
@enum(Nghttp2SettingsId::UInt32,
# SETTINGS_HEADER_TABLE_SIZE
NGHTTP2_SETTINGS_HEADER_TABLE_SIZE = 0x01,
# SETTINGS_ENABLE_PUSH, client only option.
NGHTTP2_SETTINGS_ENABLE_PUSH = 0x02,
# SETTINGS_MAX_CONCURRENT_STREAMS
NGHTTP2_SETTINGS_MAX_CONCURRENT_STREAMS = 0x03,
# SETTINGS_INITIAL_WINDOW_SIZE
NGHTTP2_SETTINGS_INITIAL_WINDOW_SIZE = 0x04,
# SETTINGS_MAX_FRAME_SIZE
NGHTTP2_SETTINGS_MAX_FRAME_SIZE = 0x05,
# SETTINGS_MAX_HEADER_LIST_SIZE
NGHTTP2_SETTINGS_MAX_HEADER_LIST_SIZE = 0x06)
"""
The flags used to set in |data_flags| output parameter in :type:`nghttp2_data_source_read_callback`.
"""
@bitflag Nghttp2DataFlags::UInt32 begin
# No flag set.
NGHTTP2_DATA_FLAG_NONE = 0
# Indicates EOF was sensed.
NGHTTP2_DATA_FLAG_EOF = 0x01
# Indicates that END_STREAM flag must not be set even if
# NGHTTP2_DATA_FLAG_EOF is set. Usually this flag is used to send
# trailer fields with `nghttp2_submit_request()` or
# `nghttp2_submit_response()`.
NGHTTP2_DATA_FLAG_NO_END_STREAM = 0x02
# Indicates that application will send complete DATA frame in
# :type:`nghttp2_send_data_callback`.
NGHTTP2_DATA_FLAG_NO_COPY = 0x04
end
"""
The SETTINGS ID/Value pair.
"""
struct SettingsEntry
settings_id::Nghttp2SettingsId
value::UInt32
end
const DEFAULT_SERVER_SETTINGS = Vector{SettingsEntry}(
[
SettingsEntry(NGHTTP2_SETTINGS_MAX_CONCURRENT_STREAMS, 100)
])
const DEFAULT_CLIENT_SETTINGS = Vector{SettingsEntry}(
[
SettingsEntry(NGHTTP2_SETTINGS_MAX_CONCURRENT_STREAMS, 100),
SettingsEntry(NGHTTP2_SETTINGS_ENABLE_PUSH, 1),
])
"""
The name/value pair, which mainly used to represent header fields.
It creates a copy of the strings using malloc.
String pointers can be safely passed to C function.
"""
struct NVPair
name::Ptr{Cchar}
value::Ptr{Cchar}
namelen::Csize_t
valuelen::Csize_t
flags::UInt8
NVPair(nothing) = new(C_NULL, C_NULL, 0, 0, UInt8(0))
NVPair(nv_pair::Pair{String,String}) = NVPair(nv_pair.first, nv_pair.second, UInt8(0))
function NVPair(name::String, value::String, flags::UInt8)
name_len = length(name)
value_len = length(value)
# Reserve 2 bytes for the string terminator
name_ptr = Ptr{UInt8}(Libc.calloc(name_len + value_len + 2, 1))
value_ptr = name_ptr + name_len + 1
GC.@preserve name unsafe_copyto!(name_ptr, pointer(name), name_len)
GC.@preserve value unsafe_copyto!(value_ptr, pointer(value), value_len)
return nv_pair = new(name_ptr, value_ptr, name_len, value_len, flags)
end
end
free(nv_pair::NVPair) = Libc.free(nv_pair.name)
"""
Helper functions to convert vector of string pairs to vector of NVPair.
"""
const NVPairs = Vector{NVPair}
const StringPairs = Vector{Pair{String,String}}
function convert_to_nvpairs(input::StringPairs)
nv_pairs = NVPairs()
foreach(pair -> push!(nv_pairs, NVPair(pair)), input)
finalizer(free, nv_pairs)
return nv_pairs
end
free(nv_pairs::NVPairs) =
for i in 1:length(nv_pairs)
free(nv_pairs[i])
nv_pairs[i] = NVPair(nothing)
end
"""
Nghttp2 library options.
"""
mutable struct Nghttp2Option
ptr::Ptr{Cvoid}
"""
Creates an instance of Nghttp2Options.
"""
function Nghttp2Option()::Nghttp2Option
nghttp2_option = new(C_NULL)
result = ccall(
(:nghttp2_option_new, libnghttp2),
Cint,
(Ref{Nghttp2Option},),
nghttp2_option)
if result != 0
throw(Http2ProtocolError(Nghttp2Error(result)))
end
finalizer(free, nghttp2_option)
return nghttp2_option
end
end
function free(nghttp2_option::Nghttp2Option)
ccall(
(:nghttp2_option_del, libnghttp2),
Cvoid,
(Nghttp2Option,),
nghttp2_option)
nghttp2_option.ptr = C_NULL
return nothing
end
mutable struct Nghttp2Session
ptr::Ptr{Cvoid}
end
mutable struct Nghttp2Frame
ptr::Ptr{Cvoid}
end
"""
The frame header.
"""
struct Nghttp2FrameHeader
# The length field of this frame, excluding frame header.
length::Csize_t
# The stream identifier (aka, stream ID)
stream_id::Int32
# The type of this frame. See `nghttp2_frame_type`.
type::Nghttp2FrameType
# The flags.
flags::UInt8
# Reserved bit in frame header. Currently, this is always set to 0
# and application should not expect something useful in here.
reserved::UInt8
end
"""
The structure to specify stream dependency.
"""
struct Nghttp2PrioritySpec
# The stream ID of the stream to depend on. Specifying 0 makes stream not depend any other stream.
stream_id::Int32
# The weight of this dependency.
weight::Int32
# Nonzero means exclusive dependency.
exclusive::UInt8
end
"""
The HEADERS frame.
"""
struct Nghttp2HeadersFrame
# The frame header.
frame_header::Nghttp2FrameHeader
# The length of the padding in this frame. This includes PAD_HIGH and PAD_LOW.
pad_len::Csize_t
# The priority specification
pri_spec::Nghttp2PrioritySpec
# The name/value pairs.
nva::Ptr{Cvoid}
# The number of name/value pairs in |nva|.
nvlen::Csize_t
# The category of this HEADERS frame.
cat::Nghttp2FrameHeadersCategory
end
"""
Nghttp2 library information.
"""
struct Nghttp2Info
age::Cint
version_num::Cint
version_str::Cstring
proto_str::Cstring
end
mutable struct DataSource
send_stream::IO
trailer::NVPairs
end
mutable struct DataProvider
data_source::Ptr{DataSource}
read_callback::Ptr{Cvoid}
end
"""
Http2ProtocolError.
"""
mutable struct Http2ProtocolError <: Exception
lib_error_code::Nghttp2Error
msg::String
Http2ProtocolError(lib_error_code::Nghttp2Error, msg::String) = new(lib_error_code, msg)
function Http2ProtocolError(lib_error_code::Nghttp2Error)
str_error = ccall(
(:nghttp2_strerror, libnghttp2),
Cstring,
(Nghttp2Error,),
lib_error_code)
return new(lib_error_code, unsafe_string(str_error))
end
end
abstract type AbstractSession end
"""
Library definition.
"""
mutable struct Http2Stream <: IO
session::AbstractSession
stream_id::Int32
buffer::IOBuffer
headers::Dict{String,String}
lock::ReentrantLock
eof::Bool
Http2Stream(session::AbstractSession, stream_id::Int32) =
return new(
session,
stream_id,
PipeBuffer(),
Dict{String,String}(),
ReentrantLock(),
false)
end
"""
Tests whether an HTTP2 stream is at end-of-file.
"""
function Base.eof(http2_stream::Http2Stream)::Bool
lock(http2_stream.lock) do
return http2_stream.eof && eof(http2_stream.buffer)
end
end
"""
Returns number of bytes available for reading before a read from this stream will block.
"""
function Base.bytesavailable(http2_stream::Http2Stream)
lock(http2_stream.lock) do
return bytesavailable(http2_stream.buffer)
end
end
"""
Determines whether the underlying session IO is not yet closed. Even if the stream is closed, it may still have data to read in its buffer; use eof to check for the ability to read data.
"""
function Base.isopen(http2_stream::Http2Stream)
return isopen(http2_stream.session.io)
end
"""
Ensures there are requested number of bytes in the Http2Stream.
"""
function ensure_in_buffer(http2_stream::Http2Stream, nb::Integer)
should_read = true
# Process HTTP2 stack until there is no more available data in HTTP2 stream.
while should_read
lock(http2_stream.lock) do
if bytesavailable(http2_stream.buffer) >= nb || http2_stream.eof
should_read = false
end
end
if should_read && internal_read!(http2_stream.session)
continue
end
# Read failed
break
end
# Throw exception if session is in error state.
if has_error(http2_stream.session)
throw(http2_stream.session.exception)
end
end
"""
Reads available data from the HTTP2 stream.
"""
function Base.read(http2_stream::Http2Stream)::Vector{UInt8}
ensure_in_buffer(http2_stream, 1)
lock(http2_stream.lock) do
result_buffer = read(http2_stream.buffer)
return result_buffer
end
end
"""
Reads at most nb bytes from from the HTTP2 stream.
"""
function Base.read(http2_stream::Http2Stream, nb::Integer)::Vector{UInt8}
ensure_in_buffer(http2_stream, nb)
lock(http2_stream.lock) do
if bytesavailable(http2_stream.buffer) < nb
throw(EOFError())
end
result_buffer = read(http2_stream.buffer, nb)
return result_buffer
end
end
function Base.read(http2_stream::Http2Stream, ::Type{UInt8})::UInt8
return read(http2_stream, Core.sizeof(UInt8))[begin + 0]
end
function Base.unsafe_read(http2_stream::Http2Stream, p::Ptr{UInt8}, nb::UInt)
ensure_in_buffer(http2_stream, nb)
lock(http2_stream.lock) do
if bytesavailable(http2_stream.buffer) < nb
throw(EOFError())
end
result_buffer = read(http2_stream.buffer, nb)
GC.@preserve result_buffer unsafe_copyto!(p, pointer(result_buffer), nb)
end
end
"""
Writes the data to the Http2 stream.
"""
function Base.write(http2_stream::Http2Stream, out_buffer::Vector{UInt8})
lock(http2_stream.lock) do
# Write the data to the steam.
return write(http2_stream.buffer, out_buffer)
end
end
"""
Internal HTTP2 session.
"""
mutable struct Session <: AbstractSession
io::IO
nghttp2_session::Nghttp2Session
recv_streams::Dict{Int32,Http2Stream}
recv_streams_id::Set{Int32}
exception::Option{Exception}
lock::ReentrantLock
read_lock::ReentrantLock
function Session(io::IO, nghttp2_session::Nghttp2Session)
return new(
io,
nghttp2_session,
Dict{Int32,Http2Stream}(),
Set{Int32}(),
nothing,
ReentrantLock(),
ReentrantLock())
end
end
"""
Retrieves the Session object from the nghttp2_session data.
The Session object must be pinned.
"""
function session_from_data(user_data::Ptr{Cvoid})::Session
session::Session = unsafe_pointer_to_objref(user_data)
return session
end
"""
Sets the session object in Nghttp2Session structure.
The Session object must be pinned.
"""
function session_set_data(session::Session)
return ccall(
(:nghttp2_session_set_user_data, libnghttp2),
Cvoid,
(Nghttp2Session, Ptr{Cvoid}),
session.nghttp2_session,
pointer_from_objref(session))
end
function nghttp2_option_set_no_auto_window_update(nghttp2_option::Nghttp2Option, value::Cint)
return ccall(
(:nghttp2_option_set_no_auto_window_update, libnghttp2),
Cvoid,
(Nghttp2Option, Cint),
nghttp2_option,
value)
end
"""
Session callbacks.
"""
mutable struct Nghttp2SessionCallbacks
ptr::Ptr{Cvoid}
function Nghttp2SessionCallbacks()::Nghttp2SessionCallbacks
callbacks = new(C_NULL)
result = ccall(
(:nghttp2_session_callbacks_new, libnghttp2),
Cint,
(Ref{Nghttp2SessionCallbacks},),
callbacks)
if (result != 0)
throw(Http2ProtocolError(Nghttp2Error(result)))
end
finalizer(free, callbacks)
ccall(
(:nghttp2_session_callbacks_set_on_frame_recv_callback, libnghttp2),
Cvoid,
(Nghttp2SessionCallbacks, Ptr{Cvoid}),
callbacks,
NGHTTP2_CALLBACKS.x.on_frame_recv_callback_ptr)
ccall(
(:nghttp2_session_callbacks_set_recv_callback, libnghttp2),
Cvoid,
(Nghttp2SessionCallbacks, Ptr{Cvoid}),
callbacks,
NGHTTP2_CALLBACKS.x.on_recv_callback_ptr)
ccall(
(:nghttp2_session_callbacks_set_on_begin_headers_callback, libnghttp2),
Cvoid,
(Nghttp2SessionCallbacks, Ptr{Cvoid}),
callbacks,
NGHTTP2_CALLBACKS.x.on_begin_headers_callback_ptr)
ccall(
(:nghttp2_session_callbacks_set_on_header_callback, libnghttp2),
Cvoid,
(Nghttp2SessionCallbacks, Ptr{Cvoid}),
callbacks,
NGHTTP2_CALLBACKS.x.on_header_recv_callback_ptr)
ccall(
(:nghttp2_session_callbacks_set_on_data_chunk_recv_callback, libnghttp2),
Cvoid,
(Nghttp2SessionCallbacks, Ptr{Cvoid}),
callbacks,
NGHTTP2_CALLBACKS.x.on_data_chunk_recv_callback_ptr)
ccall(
(:nghttp2_session_callbacks_set_send_callback, libnghttp2),
Cvoid,
(Nghttp2SessionCallbacks, Ptr{Cvoid}),
callbacks,
NGHTTP2_CALLBACKS.x.on_send_callback_ptr)
ccall(
(:nghttp2_session_callbacks_set_error_callback2, libnghttp2),
Cvoid,
(Nghttp2SessionCallbacks, Ptr{Cvoid}),
callbacks,
NGHTTP2_CALLBACKS.x.on_error_callback_ptr)
ccall(
(:nghttp2_session_callbacks_set_on_stream_close_callback, libnghttp2),
Cvoid,
(Nghttp2SessionCallbacks, Ptr{Cvoid}),
callbacks,
NGHTTP2_CALLBACKS.x.on_stream_close_callback_ptr)
return callbacks
end
end
function free(nghttp2_callbacks::Nghttp2SessionCallbacks)
ccall(
(:nghttp2_session_callbacks_del, libnghttp2),
Cvoid,
(Nghttp2SessionCallbacks,),
nghttp2_callbacks)
nghttp2_callbacks.ptr = C_NULL
return nothing
end
"""
Server session.
Creates a new server session and stores the session object in the lookup dictionary.
"""
function server_session_new(io::IO)::Session
nghttp2_session::Nghttp2Session = Nghttp2Session(C_NULL)
nghttp2_session_callbacks = Nghttp2SessionCallbacks()
result = ccall(
(:nghttp2_session_server_new, libnghttp2),
Cint,
(Ref{Nghttp2Session}, Nghttp2SessionCallbacks, Ptr{Cvoid}),
nghttp2_session,
nghttp2_session_callbacks,
C_NULL)
if (result != 0)
throw(Http2ProtocolError(Nghttp2Error(result)))
end
finalizer(free, nghttp2_session)
session = Session(io, nghttp2_session)
finalize(nghttp2_session_callbacks)
return session
end
"""
Client session.
Creates a new client session.
"""
function client_session_new(io::IO)::Session
nghttp2_session::Nghttp2Session = Nghttp2Session(C_NULL)
nghttp2_session_callbacks = Nghttp2SessionCallbacks()
result = ccall(
(:nghttp2_session_client_new, libnghttp2),
Cint,
(Ref{Nghttp2Session}, Nghttp2SessionCallbacks, Ptr{Cvoid}),
nghttp2_session,
nghttp2_session_callbacks,
C_NULL)
if (result != 0)
throw(Http2ProtocolError(Nghttp2Error(result)))
end
finalizer(free, nghttp2_session)
session = Session(io, nghttp2_session)
finalize(nghttp2_session_callbacks)
return session
end
"""
Nghttp2Session.
"""
function is_nghttp2_server_session(nghttp2_session::Nghttp2Session)::Bool
result = ccall(
(:nghttp2_session_check_server_session, libnghttp2),
Cint,
(Nghttp2Session,),
nghttp2_session)
return result != 0
end
function free(nghttp2_session::Nghttp2Session)
ccall(
(:nghttp2_session_del, libnghttp2),
Cvoid,
(Nghttp2Session,),
nghttp2_session)
nghttp2_session.ptr = C_NULL
return nothing
end
function nghttp2_session_terminate_session(nghttp2_session::Nghttp2Session, error_code::UInt32)
return ccall(
(:nghttp2_session_terminate_session, libnghttp2),
Cint,
(Nghttp2Session, UInt32),
nghttp2_session, error_code)
end
function nghttp2_submit_shutdown_notice(nghttp2_session::Nghttp2Session)
return ccall(
(:nghttp2_submit_shutdown_notice, libnghttp2),
Cint,
(Nghttp2Session,),
nghttp2_session)
end
function nghttp2_session_send(nghttp2_session::Nghttp2Session)
return ccall(
(:nghttp2_session_send, libnghttp2),
Cint,
(Nghttp2Session,),
nghttp2_session)
end
function nghttp2_session_submit_settings(nghttp2_session::Nghttp2Session, settings::Vector{SettingsEntry})
return ccall(
(:nghttp2_submit_settings, libnghttp2),
Cint,
(Nghttp2Session, UInt8, Ptr{Cvoid}, Csize_t),
nghttp2_session,
NGHTTP2_FLAG_NONE,
pointer(settings),
length(settings))
end
function nghttp2_submit_goaway(nghttp2_session::Nghttp2Session)
return ccall(
(:nghttp2_submit_goaway, libnghttp2),
Cint,
(Nghttp2Session, UInt8, Cint, UInt32, Ptr{Cvoid}, Csize_t),
nghttp2_session,
NGHTTP2_FLAG_NONE,
0,
NGHTTP2_NO_ERROR,
C_NULL, 0)
end
function nghttp2_session_mem_recv(nghttp2_session::Nghttp2Session, input_data::Vector{UInt8})
return ccall(
(:nghttp2_session_mem_recv, libnghttp2),
Cssize_t,
(Nghttp2Session, Ptr{UInt8}, Csize_t),
nghttp2_session,
input_data,
length(input_data))
end
function nghttp2_session_recv(nghttp2_session::Nghttp2Session)
return ccall(
(:nghttp2_session_recv, libnghttp2),
Cint,
(Nghttp2Session,),
nghttp2_session)
end
function nghttp2_submit_window_update(nghttp2_session::Nghttp2Session, stream_id::Int32, window_size_increment::Int32)
return ccall(
(:nghttp2_submit_window_update, libnghttp2),
Cint,
(Nghttp2Session, UInt8, Cint, Cint),
nghttp2_session,
NGHTTP2_FLAG_NONE,
stream_id,
window_size_increment)
end
"""
Errors.
"""
nghttp2_error_to_string(error::Nghttp2Error) =
unsafe_string(
ccall(
(:nghttp2_strerror, libnghttp2),
Cstring,
(Cint,),
error))
nghttp2_version() =
unsafe_load(
ccall(
(:nghttp2_version, libnghttp2),
Ptr{Nghttp2Info},
(Cint,),
0))
function Base.show(io::IO, nghttp2_info::Nghttp2Info)
return println(
io,
"""NGHttp2 lib: $(nghttp2_info.version_num)
path: $(libnghttp2)
version: $(unsafe_string(nghttp2_info.version_str))
protocol: $(unsafe_string(nghttp2_info.proto_str))""")
end
function Base.show(io::IO, nghttp2_frame_header::Nghttp2FrameHeader)
return println(
io,
"""Frame:
length: $(nghttp2_frame_header.length)
stream_id: $(nghttp2_frame_header.stream_id)
type: $(Nghttp2FrameType(nghttp2_frame_header.type))
flags: $(nghttp2_frame_header.flags)""")
end
function Base.show(io::IO, nv_pair::NVPair)
local nv_pair_str::String
if (nv_pair.name == C_NULL)
nv_pair_str = "nothing"
else
nv_pair_str = "NVPair: { name: '$(unsafe_string(nv_pair.name)) $(nv_pair.name)', value: '$(unsafe_string(nv_pair.value)) $(nv_pair.value)' }"
end
return println(io, "NVPair: { $nv_pair_str }")
end
"""
Callback implementation.
"""
function on_recv_callback(
nghttp2_session::Nghttp2Session,
buf::Ptr{UInt8},
len::Csize_t,
flags::Cint,
user_data::Ptr{Cvoid})::Cssize_t
# Get the server session object.
session = session_from_data(user_data)
result::Cssize_t = 0
return result
end
function on_frame_recv_callback(nghttp2_session::Nghttp2Session, frame::Nghttp2Frame, user_data::Ptr{Cvoid})::Cint
# Get the server session object.
session = session_from_data(user_data)
frame_header = unsafe_load(Ptr{Nghttp2FrameHeader}(frame.ptr))
stream_id = frame_header.stream_id
last_frame = stream_id != 0 && frame_header.flags & UInt8(NGHTTP2_FLAG_END_STREAM) != 0
if last_frame
# Last frame in the stream detected, mark the stream as EOF.
local http2_stream::Http2Stream
lock(session.lock) do
return http2_stream = session.recv_streams[frame_header.stream_id]
end
lock(http2_stream.lock) do
return http2_stream.eof = true
end
end
result::Cint = 0
return result
end
function on_begin_headers_callback(nghttp2_session::Nghttp2Session, frame::Nghttp2Frame, user_data::Ptr{Cvoid})::Cint
# Get the server session object.
session = session_from_data(user_data)
frame_header = unsafe_load(Ptr{Nghttp2FrameHeader}(frame.ptr))
# Create a new stream.
lock(session.lock) do
if !haskey(session.recv_streams, frame_header.stream_id)
session.recv_streams[frame_header.stream_id] = Http2Stream(session, frame_header.stream_id)
push!(session.recv_streams_id, frame_header.stream_id)
end
end
result::Cint = 0
return result
end
function on_header_recv_callback(
nghttp2_session::Nghttp2Session,
frame::Nghttp2Frame,
name::Ptr{UInt8},
namelen::Csize_t,
value::Ptr{UInt8},
valuelen::Csize_t,
flags::UInt8,
user_data::Ptr{Cvoid})::Cint
# Get the server session object.
session = session_from_data(user_data)
frame_header = unsafe_load(Ptr{Nghttp2FrameHeader}(frame.ptr))
# Copy from received buffer to the local data.
header_name = Vector{UInt8}(undef, namelen)
GC.@preserve header_name unsafe_copyto!(pointer(header_name), name, namelen)
header_value = Vector{UInt8}(undef, valuelen)
GC.@preserve header_value unsafe_copyto!(pointer(header_value), value, valuelen)
# Store the header in the session stream.
local recv_stream::Http2Stream
lock(session.lock) do
return recv_stream = session.recv_streams[frame_header.stream_id]
end
lock(recv_stream.lock) do
return recv_stream.headers[String(header_name)] = String(header_value)
end
result::Cint = 0
return result
end
function on_data_chunk_recv_callback(
nghttp2_session::Nghttp2Session,
flags::UInt8,
stream_id::Cint,
buf::Ptr{UInt8},
len::Csize_t,
user_data::Ptr{Cvoid})::Cint
# Get the server session object.
session = session_from_data(user_data)
# Copy from received buffer to the local data.
data = Vector{UInt8}(undef, len)
GC.@preserve data unsafe_copyto!(pointer(data), buf, len)
# Write received data to the received stream buffer.
local http2_stream::Http2Stream
lock(session.lock) do
return http2_stream = session.recv_streams[stream_id]
end
write(http2_stream, data)
result::Cint = 0
return result
end
function on_send_callback(
nghttp2_session::Nghttp2Session,
data::Ptr{UInt8},
length::Csize_t,
flags::Cint,
user_data::Ptr{Cvoid})::Csize_t
# Get the server session object.
session = session_from_data(user_data)
# Copy send data to the buffer.
out_buffer = Vector{UInt8}(undef, length)
GC.@preserve out_buffer unsafe_copyto!(pointer(out_buffer), data, length)
try
write(session.io, out_buffer)
catch ex
lock(session.lock) do
return session.exception = ex
end
return Int(NGHTTP2_ERR_CALLBACK_FAILURE) % Csize_t
end
return length
end
function on_error_callback(
nghttp2_session::Nghttp2Session,
lib_error_code::Cint,
msg::Ptr{UInt8},
len::Csize_t,
user_data::Ptr{Cvoid})::Cint
# Get the server session object.
session = session_from_data(user_data)
println("on_error_callback session:$(session.nghttp2_session) nghtt2_error_code: $(lib_error_code)")
# Create HTTP2 error object, include Nghttp2 error.
http2_protocol_error = Http2ProtocolError(Nghttp2Error(lib_error_code), unsafe_string(msg))
lock(session.lock) do
return session.exception = http2_protocol_error
end
@show session.exception
result::Cint = 0
return result
end
function on_data_source_read_callback(
nghttp2_session::Nghttp2Session,
stream_id::Cint,
buf::Ptr{UInt8},
buf_length::Csize_t,
data_flags::Ptr{UInt32},
data_source::Ptr{Ptr{IOBuffer}},
user_data::Ptr{Cvoid})::Cssize_t
# Get DataSource object.
data_source = unsafe_load(data_source)
data_source = unsafe_pointer_to_objref(data_source)
# TODO on_data_source_read_callback here
in_buffer = read(data_source.send_stream, buf_length)
in_length = length(in_buffer)
GC.@preserve in_buffer unsafe_copyto!(buf, pointer(in_buffer), in_length)
source_stream_eof = eof(data_source.send_stream)
source_has_trailer = source_stream_eof && length(data_source.trailer) != 0
send_data_flags::Nghttp2DataFlags = NGHTTP2_DATA_FLAG_NONE
if source_stream_eof
send_data_flags |= NGHTTP2_DATA_FLAG_EOF
end
if source_has_trailer
send_data_flags |= NGHTTP2_DATA_FLAG_NO_END_STREAM
# Submit the trailer.
result = ccall(
(:nghttp2_submit_trailer, libnghttp2),
Cint,
(Nghttp2Session, Int32, Ptr{Cvoid}, Csize_t),
nghttp2_session,
stream_id,
pointer(data_source.trailer),
length(data_source.trailer))
end
unsafe_store!(data_flags, UInt32(send_data_flags))
result::Cssize_t = in_length
return result
end
function on_stream_close_callback(
nghttp2_session::Nghttp2Session,
stream_id::Cint,
error_code::UInt32,
user_data::Ptr{Cvoid})::Cint
# Get the server session object.
session = session_from_data(user_data)
result::Cint = 0
return result
end
"""
Nghttp2 callbacks.
"""
struct Nghttp2Callbacks
on_recv_callback_ptr::Ptr{Nothing}
on_frame_recv_callback_ptr::Ptr{Nothing}
on_begin_headers_callback_ptr::Ptr{Nothing}
on_header_recv_callback_ptr::Ptr{Nothing}
on_data_chunk_recv_callback_ptr::Ptr{Nothing}
on_send_callback_ptr::Ptr{Nothing}
on_error_callback_ptr::Ptr{Nothing}
on_data_source_read_callback_ptr::Ptr{Nothing}
on_stream_close_callback_ptr::Ptr{Nothing}
function Nghttp2Callbacks()
on_recv_callback_ptr = @cfunction on_recv_callback Cssize_t (
Nghttp2Session,
Ptr{UInt8},
Csize_t,
Cint,
Ptr{Cvoid})
on_frame_recv_callback_ptr = @cfunction on_frame_recv_callback Cint (
Nghttp2Session,
Nghttp2Frame,
Ptr{Cvoid})
on_begin_headers_callback_ptr = @cfunction on_begin_headers_callback Cint (
Nghttp2Session,
Nghttp2Frame,
Ptr{Cvoid})
on_header_recv_callback_ptr = @cfunction on_header_recv_callback Cint (
Nghttp2Session,
Nghttp2Frame,
Ptr{UInt8},
Csize_t,
Ptr{UInt8},
Csize_t,
UInt8,
Ptr{Cvoid})
on_data_chunk_recv_callback_ptr = @cfunction on_data_chunk_recv_callback Cint (
Nghttp2Session,
UInt8,
Cint,
Ptr{UInt8},
Csize_t,
Ptr{Cvoid})
on_send_callback_ptr = @cfunction on_send_callback Csize_t (
Nghttp2Session,
Ptr{UInt8},
Csize_t,
Cint,
Ptr{Cvoid})
on_error_callback_ptr = @cfunction on_error_callback Cint (
Nghttp2Session,
Cint,
Ptr{UInt8},
Csize_t,
Ptr{Cvoid})
on_data_source_read_callback_ptr = @cfunction on_data_source_read_callback Cssize_t (
Nghttp2Session,
Cint,
Ptr{UInt8},
Csize_t,
Ptr{UInt32},
Ptr{Ptr{IOBuffer}},
Ptr{Cvoid})
on_stream_close_callback_ptr = @cfunction on_stream_close_callback Cint (
Nghttp2Session,
Cint,
UInt32,
Ptr{Cvoid})
return new(
on_recv_callback_ptr,
on_frame_recv_callback_ptr,
on_begin_headers_callback_ptr,
on_header_recv_callback_ptr,
on_data_chunk_recv_callback_ptr,
on_send_callback_ptr,
on_error_callback_ptr,
on_data_source_read_callback_ptr,
on_stream_close_callback_ptr)
end
end
"""
HTTP2 session.
"""
function submit_settings(session::Session, settings::Vector{SettingsEntry})
GC.@preserve session begin
session_set_data(session)
result = nghttp2_session_submit_settings(session.nghttp2_session, settings)
if result != 0
throw(Http2ProtocolError(Nghttp2Error(result)))
end
result = nghttp2_session_send(session.nghttp2_session)
if result != 0
throw(Http2ProtocolError(Nghttp2Error(result)))
end
end
end
"""
Returns true, if session is in error state.
"""
function has_error(session::Session)::Bool
lock(session.lock) do
return !isnothing(session.exception)
end
end
function set_error(session::Session, http2_protocol_error::Http2ProtocolError)
lock(session.lock) do
if !isnothing(session.exception)
session.exception = http2_protocol_error
end
end
end
"""
Reads from the session input IO and sends it to HTTP2 stack.
Returns true if there is more data available.
Ensure only one task is reading from the session.
"""
function internal_read!(session::Session)::Bool
# Return if there are errors.
if has_error(session)
return false
end
lock(session.read_lock) do
if bytesavailable(session.io) != 0 || (isreadable(session.io) && !eof(session.io))
available_bytes = bytesavailable(session.io)
input_data = read(session.io, available_bytes)
GC.@preserve session begin
session_set_data(session)
result = nghttp2_session_mem_recv(session.nghttp2_session, input_data)
if result < 0
set_error(session, Http2ProtocolError(Nghttp2Error(result)))
end
result = nghttp2_session_send(session.nghttp2_session)
if result < 0
set_error(session, Http2ProtocolError(Nghttp2Error(result)))
end
end
return true
end
end
return false
end
"""
Receives next Http2Stream from the session.
"""
function Sockets.recv(session::Session)::Option{Http2Stream}
should_read = true
while should_read
lock(session.lock) do
# Throw exception if errors occurred.
if !isnothing(session.exception)
throw(session.exception)
end
# Break, if there is no data available in the session's IO and
# there are no more HTTP2 streams to return.
if !isempty(session.recv_streams_id) || eof(session.io)
should_read = false
end
end
if should_read
# Process received data through the HTTP2 stack.
internal_read!(session)
continue
end
break
end
lock(session.lock) do
# If available, return a new HTTP2 stream.
if !isempty(session.recv_streams_id)
recv_stream_id = pop!(session.recv_streams_id)
recv_stream = session.recv_streams[recv_stream_id]
return recv_stream
end
eof(session.io)
return nothing
end
end
"""
Receives expected Http2Stream from the session.
"""
function Sockets.recv(session::Session, stream_id::Int32)::Option{Http2Stream}
should_read = true
while should_read
lock(session.lock) do
# Throw exception if errors occurred.
if !isnothing(session.exception)
throw(session.exception)
end
# Break, if there is no data available in the session's IO and there are no more HTTP2 streams to return.
if stream_id in session.recv_streams_id || !isreadable(session.io) || eof(session.io)
should_read = false
end
end
if should_read
# Process received data through the HTTP2 stack.
internal_read!(session)
continue
end
break
end
lock(session.lock) do
# If available, return a new HTTP2 stream.
if stream_id in session.recv_streams_id
delete!(session.recv_streams_id, stream_id)
recv_stream = session.recv_streams[stream_id]
return recv_stream
end
if isempty(session.recv_streams_id)
eof(session.io)
end
return nothing
end
end
"""
Returns available Http2Streams.
If there are no active Http2Streams, returns nothing.
"""
function try_recv(session::Session)::Option{Http2Stream}
lock(session.lock) do
# Throw exception if errors occurred.
if !isnothing(session.exception)
throw(session.exception)
end
# If available, return Http2Stream.
if !isempty(session.recv_streams_id)
recv_stream_id = pop!(session.recv_streams_id)
recv_stream = session.recv_streams[recv_stream_id]
return recv_stream
end
return nothing
end
end
"""
Sends the data in IO stream via HTTP2 session.
"""
function send(
session::Session,
stream_id::Int32,
send_buffer::IO,
header::StringPairs=StringPairs(),
trailer::StringPairs=StringPairs())
headers::NVPairs = convert_to_nvpairs(header)
trailers::NVPairs = convert_to_nvpairs(trailer)
GC.@preserve session send_buffer headers trailers begin
session_set_data(session)
data_source = DataSource(send_buffer, trailers)
GC.@preserve data_source begin
data_provider = DataProvider(
pointer_from_objref(data_source),
NGHTTP2_CALLBACKS.x.on_data_source_read_callback_ptr)
GC.@preserve data_provider begin
# send headers, data, and trailers
result = ccall(
(:nghttp2_submit_response, libnghttp2),
Cint,
(Nghttp2Session, Int32, Ptr{Cvoid}, Csize_t, Ptr{Cvoid}),
session.nghttp2_session,
stream_id,
pointer(headers),
length(headers),
pointer_from_objref(data_provider))
if result < 0
set_error(session, Http2ProtocolError(Nghttp2Error(result)))
end
result = nghttp2_session_send(session.nghttp2_session)
if result < 0
set_error(session, Http2ProtocolError(Nghttp2Error(result)))
end
while !eof(send_buffer) && !has_error(session)
internal_read!(session)
end
end
end
end
# Release headers and trailers after sending the frame.
finalize(headers)
finalize(trailers)
# Throw if error occurred.
if has_error(session)
throw(session.exception)
end
end
function send(session::Session, send_buffer::IO, header::StringPairs=StringPairs(), trailer::StringPairs=StringPairs())
headers::NVPairs = convert_to_nvpairs(header)
trailers::NVPairs = convert_to_nvpairs(trailer)
GC.@preserve session send_buffer headers trailers begin
session_set_data(session)
data_source = DataSource(send_buffer, trailers)
GC.@preserve data_source begin
data_provider = DataProvider(
pointer_from_objref(data_source),
NGHTTP2_CALLBACKS.x.on_data_source_read_callback_ptr)
GC.@preserve data_provider begin
# send headers, data, and trailers
stream_id = ccall(
(:nghttp2_submit_request, libnghttp2),
Cint,
(Nghttp2Session, Ptr{Cvoid}, Ptr{Cvoid}, Csize_t, Ptr{Cvoid}),
session.nghttp2_session,
C_NULL,
pointer(headers),
length(headers),
pointer_from_objref(data_provider))
if stream_id < 0
throw(Http2ProtocolError(Nghttp2Error(stream_id)))
end
result = nghttp2_session_send(session.nghttp2_session)
if result < 0
set_error(session, Http2ProtocolError(Nghttp2Error(result)))
end
while !eof(send_buffer) && !has_error(session)
internal_read!(session)
end
end
end
end
# Release headers and trailers after sending the frame.
finalize(headers)
finalize(trailers)
# Throw if error occurred.
if has_error(session)
throw(session.exception)
end
return stream_id
end
function is_server_session(session::Session)::Bool
return is_nghttp2_server_session(session.nghttp2_session)
end
"""
Public API.
Wrapper classes around Http2Session.
"""
"""
Http2 client session.
"""
struct Http2ClientSession
session::Session
end
function open(io::IO)::Http2ClientSession
session = client_session_new(io)
result = submit_settings(session, DEFAULT_CLIENT_SETTINGS)
return Http2ClientSession(session)
end
"""
Submit a request.
"""
function submit_request(http2_client_session::Http2ClientSession, io::IO)
return submit_request(http2_client_session, io, StringPairs(), StringPairs())
end
function submit_request(http2_client_session::Http2ClientSession, io::IO, header::StringPairs)
return submit_request(http2_client_session, io, header, StringPairs())
end
function submit_request(
http2_client_session::Http2ClientSession,
io::IO,
header::StringPairs,
trailer::StringPairs)::Option{Http2Stream}
# Send the request.
response_stream_id = send(http2_client_session.session, io, header, trailer)
response_stream = recv(http2_client_session.session, response_stream_id)
return response_stream
end
"""
Http2 server session.
"""
struct Http2ServerSession
session::Session
end
function from_accepted(io::IO)::Http2ServerSession
session = server_session_new(io)
result = submit_settings(session, DEFAULT_SERVER_SETTINGS)
return Http2ServerSession(session)
end
function Sockets.recv(http2_server_session::Http2ServerSession)
return recv(http2_server_session.session)
end
function Base.close(http2_server_session::Http2ServerSession)
result = nghttp2_submit_shutdown_notice(http2_server_session.session.nghttp2_session)
if result != 0
throw(Http2ProtocolError(Nghttp2Error(result)))
end
result = nghttp2_session_send(http2_server_session.session.nghttp2_session)
if result != 0
throw(Http2ProtocolError(Nghttp2Error(result)))
end
result = nghttp2_submit_goaway(http2_server_session.session.nghttp2_session)
if result != 0
throw(Http2ProtocolError(Nghttp2Error(result)))
end
result = nghttp2_session_send(http2_server_session.session.nghttp2_session)
if result != 0
throw(Http2ProtocolError(Nghttp2Error(result)))
end
return close(http2_server_session.session.io)
end
"""
Http2 stream.
"""
function submit_response(
http2_stream::Http2Stream,
io::IO,
header::StringPairs=StringPairs(),
trailer::StringPairs=StringPairs())
return send(
http2_stream.session,
http2_stream.stream_id,
io,
header,
trailer)
end
"""
Runme.
"""
const NGHTTP2_CALLBACKS = Ref{Nghttp2Callbacks}()
"""
Initialize the module.
"""
function __init__()
println("$(@__MODULE__)::__init")
NGHTTP2_CALLBACKS.x = Nghttp2Callbacks()
return nothing
end
end # module Nghttp2
| [
37811,
198,
220,
220,
220,
399,
456,
29281,
17,
22300,
34111,
13,
198,
37811,
198,
198,
37811,
198,
220,
220,
220,
17230,
25,
198,
58,
87,
60,
751,
4096,
4326,
1332,
11,
4382,
11,
5456,
198,
58,
87,
60,
4326,
1332,
284,
9199,
62,
26209,
351,
21437,
1875,
1467,
14204,
198,
58,
2361,
11767,
33122,
389,
1908,
379,
262,
886,
351,
2581,
318,
3758,
351,
3294,
10392,
198,
58,
2361,
751,
4326,
1332,
351,
12515,
2882,
198,
58,
87,
60,
1441,
281,
4049,
611,
5287,
8833,
287,
367,
29281,
17,
12124,
198,
58,
2361,
299,
456,
29281,
17,
62,
261,
62,
5532,
62,
19836,
62,
47423,
11,
1969,
4269,
319,
4049,
198,
58,
2361,
4155,
10991,
389,
6572,
198,
58,
87,
60,
9199,
2581,
815,
1441,
3376,
4269,
198,
58,
87,
60,
2251,
257,
649,
2581,
4269,
628,
220,
220,
220,
532,
299,
456,
29281,
17,
62,
31811,
5499,
5860,
4049,
2438,
11,
2845,
4808,
3605,
5499,
13,
628,
220,
220,
220,
220,
220,
220,
220,
6246,
3555,
9052,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1100,
290,
27965,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2060,
367,
29281,
17,
36044,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1100,
3419,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3294,
12784,
422,
1100,
4269,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1566,
340,
318,
1695,
628,
220,
220,
220,
20401,
367,
29281,
17,
12124,
82,
389,
3555,
422,
257,
2060,
367,
29281,
17,
36044,
13,
628,
220,
220,
220,
220,
220,
220,
220,
13305,
234,
28542,
28542,
7280,
6552,
238,
198,
220,
220,
220,
220,
220,
220,
220,
19421,
43481,
17,
12124,
3712,
961,
6552,
224,
7280,
13305,
222,
13305,
222,
198,
220,
220,
220,
220,
220,
220,
220,
13305,
242,
28542,
28542,
7280,
6552,
246,
220,
220,
220,
220,
19421,
220,
220,
220,
220,
220,
220,
220,
6246,
13,
961,
62,
5354,
198,
220,
220,
220,
220,
220,
220,
220,
13305,
234,
28542,
28542,
7280,
6552,
238,
220,
220,
220,
220,
220,
13305,
222,
13305,
222,
11019,
114,
220,
220,
220,
2343,
243,
242,
31732,
31732,
22880,
245,
220,
220,
220,
220,
220,
13305,
234,
28542,
16068,
7280,
6552,
238,
198,
220,
220,
220,
220,
220,
220,
220,
19421,
43481,
17,
12124,
3712,
961,
6552,
224,
28542,
16068,
8418,
7280,
22880,
96,
25392,
22880,
254,
16068,
7280,
5008,
114,
6552,
224,
36044,
3712,
961,
6552,
224,
198,
220,
220,
220,
220,
220,
220,
220,
13305,
242,
28542,
28542,
7280,
6552,
246,
220,
220,
220,
220,
220,
13305,
222,
13305,
222,
11019,
114,
220,
220,
220,
2343,
243,
248,
31732,
31732,
22880,
251,
220,
220,
220,
220,
220,
13305,
242,
28542,
16068,
7280,
6552,
246,
198,
220,
220,
220,
220,
220,
220,
220,
13305,
234,
28542,
28542,
7280,
6552,
238,
220,
220,
220,
220,
19421,
198,
220,
220,
220,
220,
220,
220,
220,
19421,
43481,
17,
12124,
3712,
961,
6552,
224,
7280,
13305,
222,
13305,
222,
198,
220,
220,
220,
220,
220,
220,
220,
13305,
242,
28542,
28542,
7280,
6552,
246,
198,
198,
37811,
198,
198,
21412,
399,
456,
29281,
17,
198,
198,
39344,
367,
29281,
17,
11792,
36044,
11,
367,
29281,
17,
10697,
36044,
11,
367,
29281,
17,
12124,
11,
367,
29281,
17,
19703,
4668,
12331,
198,
39344,
3758,
11,
664,
85,
11,
1949,
62,
8344,
85,
11,
9199,
62,
25927,
11,
9199,
62,
26209,
11,
1100,
11,
304,
1659,
11,
9881,
15182,
11,
1969,
11,
318,
9654,
198,
39344,
299,
456,
29281,
17,
62,
9641,
198,
198,
3500,
299,
456,
29281,
17,
62,
73,
297,
198,
3500,
4722,
40053,
198,
3500,
311,
11603,
198,
198,
9979,
16018,
90,
51,
92,
796,
4479,
90,
18465,
11,
51,
92,
810,
1391,
51,
92,
198,
198,
37811,
198,
220,
220,
220,
13047,
12416,
973,
416,
399,
456,
29281,
17,
5888,
13,
198,
37811,
198,
31,
44709,
7,
45,
456,
29281,
17,
12331,
3712,
5317,
2624,
11,
198,
220,
220,
220,
1303,
17665,
4578,
3804,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
1268,
23428,
2389,
62,
1503,
38,
5883,
3525,
796,
532,
33548,
11,
198,
220,
220,
220,
1303,
3806,
286,
11876,
2272,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
19499,
45746,
62,
24908,
796,
532,
35126,
11,
198,
220,
220,
220,
1303,
383,
7368,
8435,
2196,
318,
407,
4855,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
4944,
40331,
15490,
1961,
62,
43717,
796,
532,
31938,
11,
198,
220,
220,
220,
1303,
16718,
355,
257,
1441,
1988,
422,
299,
456,
29281,
17,
62,
21280,
62,
47423,
11,
299,
456,
29281,
17,
62,
8344,
85,
62,
47423,
290,
299,
456,
29281,
17,
62,
21280,
62,
7890,
62,
47423,
284,
7603,
326,
262,
4905,
561,
2512,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
54,
24010,
9148,
11290,
796,
532,
33580,
11,
198,
220,
220,
220,
1303,
3611,
8435,
4049,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
4805,
26631,
796,
532,
31654,
11,
198,
220,
220,
220,
1303,
383,
5739,
318,
12515,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
1268,
23428,
2389,
62,
10913,
10067,
796,
532,
35638,
11,
198,
220,
220,
220,
1303,
383,
12720,
6157,
257,
18325,
319,
262,
4637,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
4720,
37,
796,
532,
35378,
11,
198,
220,
220,
220,
1303,
16718,
355,
257,
1441,
1988,
422,
299,
456,
29281,
17,
62,
7890,
62,
10459,
62,
961,
62,
47423,
3419,
284,
7603,
326,
1366,
4351,
318,
33922,
13,
4091,
299,
456,
29281,
17,
62,
7890,
62,
10459,
62,
961,
62,
47423,
3419,
329,
3307,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
7206,
24302,
22083,
796,
532,
33042,
11,
198,
220,
220,
220,
1303,
13860,
4522,
468,
4251,
262,
5415,
1988,
13,
8447,
645,
4269,
4522,
318,
1695,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
2257,
32235,
62,
2389,
62,
11929,
62,
10116,
32,
4146,
17534,
796,
532,
29022,
11,
198,
220,
220,
220,
1303,
383,
4269,
318,
1541,
4838,
26,
393,
262,
4269,
4522,
318,
12515,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
2257,
32235,
62,
5097,
48751,
796,
532,
33690,
11,
198,
220,
220,
220,
1303,
371,
2257,
62,
2257,
32235,
468,
587,
2087,
284,
262,
503,
7784,
16834,
13,
383,
4269,
318,
287,
9605,
1181,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
2257,
32235,
62,
5097,
2640,
2751,
796,
532,
41647,
11,
198,
220,
220,
220,
1303,
383,
11478,
318,
407,
3142,
329,
428,
4269,
357,
68,
13,
70,
1539,
257,
5739,
351,
23578,
62,
2257,
32235,
6056,
900,
468,
1541,
1908,
737,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
2257,
32235,
62,
9693,
3843,
62,
18564,
796,
532,
25836,
11,
198,
220,
220,
220,
1303,
383,
4269,
4522,
318,
12515,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
1268,
23428,
2389,
62,
2257,
32235,
62,
2389,
796,
532,
48645,
11,
198,
220,
220,
220,
1303,
383,
1181,
286,
262,
4269,
318,
407,
4938,
357,
68,
13,
70,
1539,
42865,
2314,
307,
1908,
284,
262,
4269,
611,
2882,
39837,
4877,
468,
407,
587,
1908,
737,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
1268,
23428,
2389,
62,
2257,
32235,
62,
44724,
796,
532,
47396,
11,
198,
220,
220,
220,
1303,
6023,
42865,
5739,
468,
1541,
587,
28651,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
7206,
24302,
22083,
62,
26947,
62,
6369,
8808,
796,
532,
45969,
11,
198,
220,
220,
220,
1303,
17962,
649,
4269,
318,
407,
3142,
357,
68,
13,
70,
1539,
10351,
12298,
4792,
468,
587,
1908,
290,
14,
273,
2722,
737,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
2257,
7227,
62,
2257,
32235,
62,
11929,
62,
7036,
3913,
1961,
796,
532,
47493,
11,
198,
220,
220,
220,
1303,
10351,
12298,
4792,
468,
1541,
587,
1908,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
11230,
12298,
4792,
62,
1847,
15675,
56,
62,
50,
3525,
796,
532,
48170,
11,
198,
220,
220,
220,
1303,
383,
2722,
5739,
4909,
262,
12515,
13639,
2512,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
1268,
23428,
2389,
62,
37682,
1137,
62,
9148,
11290,
796,
532,
44085,
11,
198,
220,
220,
220,
1303,
1423,
16856,
326,
262,
4732,
318,
407,
11080,
284,
1620,
262,
9167,
4905,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
1268,
23428,
2389,
62,
44724,
796,
532,
47785,
11,
198,
220,
220,
220,
1303,
383,
2836,
23838,
2163,
4054,
2233,
284,
262,
21964,
4049,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
51,
39494,
1581,
1847,
62,
34,
7036,
31098,
62,
7708,
4146,
11335,
796,
532,
20,
2481,
11,
198,
220,
220,
220,
1303,
383,
4129,
286,
262,
5739,
318,
12515,
11,
2035,
1165,
1588,
393,
1165,
1402,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
10913,
10067,
62,
33489,
62,
24908,
796,
532,
49542,
11,
198,
220,
220,
220,
1303,
48900,
2512,
1167,
17660,
14,
4299,
17660,
4049,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
37682,
1137,
62,
9858,
47,
796,
532,
49803,
11,
198,
220,
220,
220,
1303,
27782,
1630,
4049,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
3697,
3913,
62,
10943,
5446,
3535,
796,
532,
48057,
11,
198,
220,
220,
220,
1303,
7088,
15267,
11876,
2546,
1813,
284,
2163,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
1268,
12564,
5777,
62,
19499,
10652,
35400,
796,
532,
39088,
11,
198,
220,
220,
220,
1303,
4889,
1891,
373,
24487,
416,
262,
3586,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
4537,
19108,
796,
532,
48531,
11,
198,
220,
220,
220,
1303,
1318,
389,
1165,
867,
287,
12,
22560,
25823,
48996,
5739,
290,
645,
517,
11478,
286,
25823,
51,
20754,
318,
3142,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
51,
6684,
62,
10725,
56,
62,
1268,
3697,
9947,
62,
28480,
51,
20754,
796,
532,
20,
1983,
11,
198,
220,
220,
220,
1303,
383,
4382,
4574,
318,
10058,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
47,
27143,
62,
26288,
6242,
30465,
796,
532,
49351,
11,
198,
220,
220,
220,
1303,
42865,
393,
39837,
4877,
5739,
329,
257,
1813,
4269,
468,
587,
1541,
8948,
290,
468,
407,
587,
3938,
13686,
1865,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
26947,
62,
6369,
8808,
796,
532,
49721,
11,
198,
220,
220,
220,
1303,
383,
1459,
6246,
318,
9605,
2233,
284,
257,
4637,
4049,
393,
299,
456,
29281,
17,
62,
29891,
62,
23705,
378,
62,
29891,
3419,
318,
1444,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
50,
47621,
62,
5097,
2640,
2751,
796,
532,
38612,
11,
198,
220,
220,
220,
1303,
17665,
14626,
13639,
2214,
373,
2722,
290,
4269,
318,
1016,
284,
307,
4838,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
40717,
62,
37682,
1137,
796,
532,
20,
3132,
11,
198,
220,
220,
220,
1303,
13085,
341,
287,
14626,
19925,
3896,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
40717,
62,
44,
1546,
4090,
38,
2751,
796,
532,
20,
2624,
11,
198,
220,
220,
220,
1303,
13860,
373,
6520,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
31688,
2937,
1961,
62,
2257,
32235,
796,
532,
44994,
11,
198,
220,
220,
220,
1303,
471,
42072,
5387,
4049,
11,
475,
11911,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
1268,
31800,
1847,
796,
532,
20,
2682,
11,
198,
220,
220,
220,
1303,
1423,
16856,
326,
257,
7587,
373,
19994,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
34,
20940,
3698,
796,
532,
44465,
11,
198,
220,
220,
220,
1303,
1649,
257,
1957,
36123,
13423,
284,
3328,
25823,
51,
20754,
5739,
11,
340,
11583,
281,
584,
2099,
286,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
28480,
51,
20754,
62,
49864,
9782,
1961,
796,
532,
44468,
11,
198,
220,
220,
220,
1303,
1649,
257,
1957,
36123,
11583,
1165,
867,
6460,
12784,
287,
257,
2060,
25823,
51,
20754,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
51,
6684,
62,
10725,
56,
62,
28480,
51,
20754,
796,
532,
46096,
11,
198,
220,
220,
220,
1303,
383,
8563,
1279,
299,
456,
29281,
17,
62,
18224,
13,
10503,
40717,
17,
62,
1137,
49,
62,
37,
1404,
1847,
1612,
326,
262,
5888,
318,
739,
10059,
4006,
290,
7587,
373,
23083,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
37,
1404,
1847,
796,
532,
12865,
11,
198,
220,
220,
220,
1303,
3806,
286,
4088,
13,
770,
318,
257,
10800,
4049,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
45,
2662,
3620,
796,
532,
46815,
11,
198,
220,
220,
220,
1303,
383,
2836,
23838,
2163,
4054,
13,
770,
318,
257,
10800,
4049,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
34,
7036,
31098,
62,
7708,
4146,
11335,
796,
532,
24,
2999,
11,
198,
220,
220,
220,
1303,
17665,
5456,
5536,
357,
3826,
39058,
40717,
17,
62,
5097,
28495,
62,
45820,
2149,
8,
373,
2722,
290,
2252,
7587,
318,
407,
1744,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
33,
2885,
62,
5097,
28495,
62,
45820,
2149,
796,
532,
24,
3070,
11,
198,
220,
220,
220,
1303,
33671,
17448,
416,
12720,
373,
12326,
287,
428,
14626,
14,
17,
6246,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1137,
49,
62,
3697,
22808,
1961,
796,
532,
24,
3023,
8,
198,
198,
37811,
198,
220,
220,
220,
383,
5739,
3858,
287,
14626,
14,
17,
20855,
13,
198,
37811,
198,
31,
44709,
7,
45,
456,
29281,
17,
19778,
6030,
3712,
52,
5317,
23,
11,
198,
220,
220,
220,
1303,
383,
42865,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
26947,
796,
657,
11,
198,
220,
220,
220,
1303,
383,
39837,
4877,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
37682,
4877,
796,
657,
87,
486,
11,
198,
220,
220,
220,
1303,
383,
4810,
41254,
9050,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
4805,
41254,
9050,
796,
657,
87,
2999,
11,
198,
220,
220,
220,
1303,
383,
371,
2257,
62,
2257,
32235,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
49,
2257,
62,
2257,
32235,
796,
657,
87,
3070,
11,
198,
220,
220,
220,
1303,
383,
25823,
51,
20754,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
28480,
51,
20754,
796,
657,
87,
3023,
11,
198,
220,
220,
220,
1303,
383,
350,
27143,
62,
4805,
2662,
24352,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
47,
27143,
62,
4805,
2662,
24352,
796,
657,
87,
2713,
11,
198,
220,
220,
220,
1303,
383,
350,
2751,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
47,
2751,
796,
657,
87,
3312,
11,
198,
220,
220,
220,
1303,
383,
10351,
12298,
4792,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
11230,
12298,
4792,
796,
657,
87,
2998,
11,
198,
220,
220,
220,
1303,
383,
370,
12115,
3913,
62,
16977,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
28929,
3913,
62,
16977,
796,
657,
87,
2919,
11,
198,
220,
220,
220,
1303,
383,
43659,
52,
6234,
5739,
13,
220,
770,
5739,
2099,
1839,
470,
307,
3804,
284,
597,
198,
220,
220,
220,
1303,
869,
10146,
780,
262,
5888,
7767,
428,
5739,
2099,
290,
663,
198,
220,
220,
220,
1303,
18148,
39837,
4877,
14,
47,
27143,
62,
4805,
2662,
24352,
355,
257,
2060,
5739,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
37815,
1268,
52,
6234,
796,
657,
87,
2931,
11,
198,
220,
220,
220,
1303,
383,
8355,
4694,
15922,
5739,
11,
543,
318,
5447,
287,
4600,
41150,
767,
34741,
198,
220,
220,
220,
1303,
1279,
5450,
1378,
31391,
13,
1155,
69,
13,
2398,
14,
6494,
14,
81,
16072,
3695,
2548,
2,
5458,
12,
19,
29,
63,
44807,
198,
220,
220,
220,
39058,
40717,
17,
62,
1847,
4694,
15922,
796,
657,
87,
15,
64,
11,
198,
220,
220,
220,
1303,
383,
43901,
1268,
5739,
11,
543,
318,
5447,
416,
4600,
41150,
807,
29211,
198,
220,
220,
220,
1303,
1279,
5450,
1378,
31391,
13,
1155,
69,
13,
2398,
14,
6494,
14,
81,
16072,
23,
29211,
29,
63,
44807,
198,
220,
220,
220,
39058,
40717,
17,
62,
1581,
3528,
1268,
796,
657,
87,
15,
66,
8,
198,
198,
37811,
198,
220,
220,
220,
383,
6536,
286,
39837,
4877,
11,
543,
9217,
262,
2597,
286,
262,
5739,
13,
220,
554,
198,
220,
220,
220,
14626,
14,
17,
1020,
11,
2581,
11,
2882,
11,
4574,
2882,
290,
584,
14977,
198,
220,
220,
220,
24697,
357,
68,
13,
70,
1539,
12268,
7032,
8,
389,
477,
1444,
655,
39837,
4877,
13,
220,
1675,
198,
220,
220,
220,
1577,
262,
3586,
262,
2597,
286,
15619,
39837,
4877,
5739,
11,
356,
8160,
198,
220,
220,
220,
1811,
9376,
13,
198,
37811,
198,
31,
44709,
7,
45,
456,
29281,
17,
19778,
13847,
364,
27313,
3712,
52,
5317,
2624,
11,
198,
220,
220,
220,
1303,
383,
39837,
4877,
5739,
318,
4756,
649,
4269,
11,
543,
318,
34657,
284,
19704,
45,
62,
2257,
32235,
287,
30628,
56,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
16045,
1404,
62,
2200,
35780,
796,
657,
11,
198,
220,
220,
220,
1303,
383,
39837,
4877,
5739,
318,
262,
717,
2882,
24697,
11,
543,
318,
198,
220,
220,
220,
1303,
34657,
284,
19704,
45,
62,
2200,
6489,
56,
287,
30628,
56,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
16045,
1404,
62,
19535,
47,
1340,
5188,
796,
352,
11,
198,
220,
220,
220,
1303,
383,
39837,
4877,
5739,
318,
262,
717,
24697,
1908,
1028,
10395,
4269,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
16045,
1404,
62,
47,
27143,
62,
19535,
47,
1340,
5188,
796,
362,
11,
198,
220,
220,
220,
1303,
383,
39837,
4877,
5739,
543,
857,
407,
4174,
329,
262,
2029,
9376,
11,
198,
220,
220,
220,
1303,
543,
318,
34657,
284,
39837,
4877,
287,
30628,
56,
13,
220,
1002,
1729,
12,
20311,
2882,
198,
220,
220,
220,
1303,
357,
68,
13,
70,
1539,
3722,
352,
5324,
8,
318,
973,
11,
2457,
2882,
39837,
4877,
5739,
481,
307,
198,
220,
220,
220,
1303,
37661,
994,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
16045,
1404,
62,
37682,
4877,
796,
513,
8,
198,
198,
37811,
198,
220,
220,
220,
383,
9701,
329,
14626,
14,
17,
13431,
13,
198,
220,
220,
220,
770,
33829,
15738,
477,
9701,
329,
477,
13431,
13,
198,
37811,
198,
31,
44709,
7,
45,
456,
29281,
17,
19778,
40053,
3712,
52,
5317,
23,
11,
198,
220,
220,
220,
1303,
1400,
6056,
900,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
38948,
62,
45,
11651,
796,
657,
11,
198,
220,
220,
220,
1303,
383,
23578,
62,
2257,
32235,
6056,
13,
198,
220,
220,
220,
1303,
383,
7125,
42,
6056,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
38948,
62,
10619,
62,
2257,
32235,
796,
657,
87,
486,
11,
198,
220,
220,
220,
1303,
383,
23578,
62,
37682,
4877,
6056,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
38948,
62,
10619,
62,
37682,
4877,
796,
657,
87,
3023,
11,
198,
220,
220,
220,
1303,
383,
350,
29266,
1961,
6056,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
38948,
62,
47,
29266,
1961,
796,
657,
87,
2919,
11,
198,
220,
220,
220,
1303,
383,
4810,
41254,
9050,
6056,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
38948,
62,
4805,
41254,
9050,
796,
657,
87,
1238,
8,
198,
198,
9979,
39058,
40717,
17,
62,
38948,
62,
8120,
796,
39058,
40717,
17,
62,
38948,
62,
10619,
62,
2257,
32235,
198,
198,
37811,
198,
220,
220,
220,
383,
3722,
12416,
329,
262,
371,
2257,
62,
2257,
32235,
290,
10351,
12298,
4792,
13431,
13,
198,
37811,
198,
31,
44709,
7,
45,
456,
29281,
17,
12331,
10669,
3712,
52,
5317,
2624,
11,
198,
220,
220,
220,
1303,
1400,
8563,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
15285,
62,
24908,
796,
657,
87,
15,
11,
198,
220,
220,
220,
1303,
48006,
4503,
3535,
62,
24908,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
4805,
2394,
4503,
3535,
62,
24908,
796,
657,
87,
16,
11,
198,
220,
220,
220,
1303,
23255,
45,
1847,
62,
24908,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1268,
31800,
1847,
62,
24908,
796,
657,
87,
17,
11,
198,
220,
220,
220,
1303,
9977,
3913,
62,
10943,
5446,
3535,
62,
24908,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
3697,
3913,
62,
10943,
5446,
3535,
62,
24908,
796,
657,
87,
18,
11,
198,
220,
220,
220,
1303,
25823,
51,
20754,
62,
34694,
12425,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
28480,
51,
20754,
62,
34694,
12425,
796,
657,
87,
19,
11,
198,
220,
220,
220,
1303,
3563,
32235,
62,
5097,
48751,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
2257,
32235,
62,
5097,
48751,
796,
657,
87,
20,
11,
198,
220,
220,
220,
1303,
8782,
10067,
62,
33489,
62,
24908,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
10913,
10067,
62,
33489,
62,
24908,
796,
657,
87,
21,
11,
198,
220,
220,
220,
1303,
4526,
37,
2937,
1961,
62,
2257,
32235,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
31688,
2937,
1961,
62,
2257,
32235,
796,
657,
87,
22,
11,
198,
220,
220,
220,
1303,
15628,
34,
3698,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
34,
20940,
3698,
796,
657,
87,
23,
11,
198,
220,
220,
220,
1303,
9440,
32761,
2849,
62,
24908,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
9858,
32761,
2849,
62,
24908,
796,
657,
87,
24,
11,
198,
220,
220,
220,
1303,
10943,
48842,
62,
24908,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
10943,
48842,
62,
24908,
796,
657,
27865,
11,
198,
220,
220,
220,
1303,
12964,
39,
19240,
62,
56,
11698,
62,
34,
1847,
44,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1677,
39,
19240,
62,
56,
11698,
62,
34,
1847,
44,
796,
657,
30894,
11,
198,
220,
220,
220,
1303,
3268,
19266,
10917,
6158,
62,
23683,
4261,
9050,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
1268,
19266,
10917,
6158,
62,
23683,
4261,
9050,
796,
657,
25306,
11,
198,
220,
220,
220,
1303,
14626,
62,
16,
62,
16,
62,
2200,
10917,
37819,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
40717,
62,
16,
62,
16,
62,
2200,
10917,
37819,
796,
657,
24954,
8,
198,
198,
37811,
198,
220,
220,
220,
383,
9701,
329,
13639,
2214,
1438,
14,
8367,
5166,
13,
198,
37811,
198,
31,
44709,
7,
45,
456,
29281,
17,
45,
85,
40053,
3712,
52,
5317,
23,
11,
198,
220,
220,
220,
1303,
1400,
6056,
900,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
27159,
62,
38948,
62,
45,
11651,
796,
657,
11,
198,
220,
220,
220,
1303,
1423,
16856,
326,
428,
1438,
14,
8367,
5166,
1276,
407,
307,
41497,
5855,
43,
270,
1691,
198,
220,
220,
220,
1303,
48900,
7663,
1239,
12901,
276,
1,
10552,
1276,
307,
973,
287,
6574,
8120,
198,
220,
220,
220,
1303,
21004,
737,
220,
3819,
7822,
3848,
428,
1643,
355,
366,
30176,
1911,
198,
220,
220,
220,
39058,
40717,
17,
62,
27159,
62,
38948,
62,
15285,
62,
12115,
6369,
796,
657,
87,
486,
11,
198,
220,
220,
220,
1303,
770,
6056,
318,
900,
9944,
416,
3586,
13,
220,
1002,
428,
6056,
318,
900,
11,
262,
198,
220,
220,
220,
1303,
5888,
857,
407,
787,
257,
4866,
286,
13639,
2214,
1438,
13,
220,
770,
714,
198,
220,
220,
220,
1303,
2987,
2854,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
27159,
62,
38948,
62,
15285,
62,
34,
3185,
56,
62,
20608,
796,
657,
87,
2999,
11,
198,
220,
220,
220,
1303,
770,
6056,
318,
900,
9944,
416,
3586,
13,
220,
1002,
428,
6056,
318,
900,
11,
262,
198,
220,
220,
220,
1303,
5888,
857,
407,
787,
257,
4866,
286,
13639,
2214,
1988,
13,
220,
770,
714,
198,
220,
220,
220,
1303,
2987,
2854,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
27159,
62,
38948,
62,
15285,
62,
34,
3185,
56,
62,
39488,
796,
657,
87,
3023,
8,
198,
198,
37811,
198,
220,
220,
220,
383,
25823,
51,
20754,
4522,
13,
198,
37811,
198,
31,
44709,
7,
45,
456,
29281,
17,
26232,
7390,
3712,
52,
5317,
2624,
11,
198,
220,
220,
220,
1303,
25823,
51,
20754,
62,
37682,
1137,
62,
38148,
62,
33489,
198,
220,
220,
220,
39058,
40717,
17,
62,
28480,
51,
20754,
62,
37682,
1137,
62,
38148,
62,
33489,
796,
657,
87,
486,
11,
198,
220,
220,
220,
1303,
25823,
51,
20754,
62,
1677,
17534,
62,
47,
27143,
11,
5456,
691,
3038,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
28480,
51,
20754,
62,
1677,
17534,
62,
47,
27143,
796,
657,
87,
2999,
11,
198,
220,
220,
220,
1303,
25823,
51,
20754,
62,
22921,
62,
10943,
34,
39237,
62,
2257,
32235,
50,
198,
220,
220,
220,
39058,
40717,
17,
62,
28480,
51,
20754,
62,
22921,
62,
10943,
34,
39237,
62,
2257,
32235,
50,
796,
657,
87,
3070,
11,
198,
220,
220,
220,
1303,
25823,
51,
20754,
62,
1268,
2043,
12576,
62,
28929,
3913,
62,
33489,
198,
220,
220,
220,
39058,
40717,
17,
62,
28480,
51,
20754,
62,
1268,
2043,
12576,
62,
28929,
3913,
62,
33489,
796,
657,
87,
3023,
11,
198,
220,
220,
220,
1303,
25823,
51,
20754,
62,
22921,
62,
10913,
10067,
62,
33489,
198,
220,
220,
220,
39058,
40717,
17,
62,
28480,
51,
20754,
62,
22921,
62,
10913,
10067,
62,
33489,
796,
657,
87,
2713,
11,
198,
220,
220,
220,
1303,
25823,
51,
20754,
62,
22921,
62,
37682,
1137,
62,
45849,
62,
33489,
198,
220,
220,
220,
39058,
40717,
17,
62,
28480,
51,
20754,
62,
22921,
62,
37682,
1137,
62,
45849,
62,
33489,
796,
657,
87,
3312,
8,
198,
198,
37811,
198,
220,
220,
220,
383,
9701,
973,
284,
900,
287,
930,
7890,
62,
33152,
91,
5072,
11507,
287,
1058,
4906,
25,
63,
77,
456,
29281,
17,
62,
7890,
62,
10459,
62,
961,
62,
47423,
44646,
198,
37811,
198,
31,
2545,
32109,
399,
456,
29281,
17,
6601,
40053,
3712,
52,
5317,
2624,
2221,
198,
220,
220,
220,
1303,
1400,
6056,
900,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
26947,
62,
38948,
62,
45,
11651,
796,
657,
198,
220,
220,
220,
1303,
1423,
16856,
412,
19238,
373,
39243,
13,
198,
220,
220,
220,
39058,
40717,
17,
62,
26947,
62,
38948,
62,
4720,
37,
796,
657,
87,
486,
198,
220,
220,
220,
1303,
1423,
16856,
326,
23578,
62,
2257,
32235,
6056,
1276,
407,
307,
900,
772,
611,
198,
220,
220,
220,
1303,
39058,
40717,
17,
62,
26947,
62,
38948,
62,
4720,
37,
318,
900,
13,
220,
19672,
428,
6056,
318,
973,
284,
3758,
198,
220,
220,
220,
1303,
12268,
7032,
351,
4600,
77,
456,
29281,
17,
62,
46002,
62,
25927,
3419,
63,
393,
198,
220,
220,
220,
1303,
4600,
77,
456,
29281,
17,
62,
46002,
62,
26209,
3419,
44646,
198,
220,
220,
220,
39058,
40717,
17,
62,
26947,
62,
38948,
62,
15285,
62,
10619,
62,
2257,
32235,
796,
657,
87,
2999,
198,
220,
220,
220,
1303,
1423,
16856,
326,
3586,
481,
3758,
1844,
42865,
5739,
287,
198,
220,
220,
220,
1303,
1058,
4906,
25,
63,
77,
456,
29281,
17,
62,
21280,
62,
7890,
62,
47423,
44646,
198,
220,
220,
220,
39058,
40717,
17,
62,
26947,
62,
38948,
62,
15285,
62,
34,
3185,
56,
796,
657,
87,
3023,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
383,
25823,
51,
20754,
4522,
14,
11395,
5166,
13,
198,
37811,
198,
7249,
16163,
30150,
198,
220,
220,
220,
6460,
62,
312,
3712,
45,
456,
29281,
17,
26232,
7390,
198,
220,
220,
220,
1988,
3712,
52,
5317,
2624,
198,
437,
198,
198,
9979,
5550,
38865,
62,
35009,
5959,
62,
28480,
51,
20754,
796,
20650,
90,
26232,
30150,
92,
7,
198,
58,
198,
220,
220,
220,
16163,
30150,
7,
10503,
40717,
17,
62,
28480,
51,
20754,
62,
22921,
62,
10943,
34,
39237,
62,
2257,
32235,
50,
11,
1802,
8,
198,
12962,
198,
198,
9979,
5550,
38865,
62,
5097,
28495,
62,
28480,
51,
20754,
796,
20650,
90,
26232,
30150,
92,
7,
198,
58,
198,
220,
220,
220,
16163,
30150,
7,
10503,
40717,
17,
62,
28480,
51,
20754,
62,
22921,
62,
10943,
34,
39237,
62,
2257,
32235,
50,
11,
1802,
828,
198,
220,
220,
220,
16163,
30150,
7,
10503,
40717,
17,
62,
28480,
51,
20754,
62,
1677,
17534,
62,
47,
27143,
11,
352,
828,
198,
12962,
198,
198,
37811,
198,
220,
220,
220,
383,
1438,
14,
8367,
5166,
11,
543,
8384,
973,
284,
2380,
13639,
7032,
13,
198,
220,
220,
220,
632,
8075,
257,
4866,
286,
262,
13042,
1262,
17374,
420,
13,
198,
220,
220,
220,
10903,
32007,
460,
307,
11512,
3804,
284,
327,
2163,
13,
198,
37811,
198,
7249,
399,
8859,
958,
198,
220,
220,
220,
1438,
3712,
46745,
90,
34,
10641,
92,
198,
220,
220,
220,
1988,
3712,
46745,
90,
34,
10641,
92,
198,
220,
220,
220,
299,
17983,
268,
3712,
34,
7857,
62,
83,
198,
220,
220,
220,
1188,
2731,
268,
3712,
34,
7857,
62,
83,
198,
220,
220,
220,
9701,
3712,
52,
5317,
23,
628,
220,
220,
220,
399,
8859,
958,
7,
22366,
8,
796,
649,
7,
34,
62,
33991,
11,
327,
62,
33991,
11,
657,
11,
657,
11,
471,
5317,
23,
7,
15,
4008,
628,
220,
220,
220,
399,
8859,
958,
7,
48005,
62,
24874,
3712,
47,
958,
90,
10100,
11,
10100,
30072,
796,
399,
8859,
958,
7,
48005,
62,
24874,
13,
11085,
11,
299,
85,
62,
24874,
13,
12227,
11,
471,
5317,
23,
7,
15,
4008,
628,
220,
220,
220,
2163,
399,
8859,
958,
7,
3672,
3712,
10100,
11,
1988,
3712,
10100,
11,
9701,
3712,
52,
5317,
23,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1438,
62,
11925,
796,
4129,
7,
3672,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1988,
62,
11925,
796,
4129,
7,
8367,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
12224,
362,
9881,
329,
262,
4731,
5651,
1352,
198,
220,
220,
220,
220,
220,
220,
220,
1438,
62,
20692,
796,
350,
2213,
90,
52,
5317,
23,
92,
7,
25835,
66,
13,
13345,
420,
7,
3672,
62,
11925,
1343,
1988,
62,
11925,
1343,
362,
11,
352,
4008,
628,
220,
220,
220,
220,
220,
220,
220,
1988,
62,
20692,
796,
1438,
62,
20692,
1343,
1438,
62,
11925,
1343,
352,
628,
220,
220,
220,
220,
220,
220,
220,
20145,
13,
31,
18302,
3760,
1438,
21596,
62,
30073,
1462,
0,
7,
3672,
62,
20692,
11,
17562,
7,
3672,
828,
1438,
62,
11925,
8,
198,
220,
220,
220,
220,
220,
220,
220,
20145,
13,
31,
18302,
3760,
1988,
21596,
62,
30073,
1462,
0,
7,
8367,
62,
20692,
11,
17562,
7,
8367,
828,
1988,
62,
11925,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1441,
299,
85,
62,
24874,
796,
649,
7,
3672,
62,
20692,
11,
1988,
62,
20692,
11,
1438,
62,
11925,
11,
1988,
62,
11925,
11,
9701,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
5787,
7,
48005,
62,
24874,
3712,
45,
8859,
958,
8,
796,
7980,
66,
13,
5787,
7,
48005,
62,
24874,
13,
3672,
8,
198,
198,
37811,
198,
220,
220,
220,
5053,
525,
5499,
284,
10385,
15879,
286,
4731,
14729,
284,
15879,
286,
399,
8859,
958,
13,
198,
37811,
198,
9979,
399,
8859,
3468,
796,
20650,
90,
45,
8859,
958,
92,
198,
198,
9979,
10903,
47,
3468,
796,
20650,
90,
47,
958,
90,
10100,
11,
10100,
11709,
198,
198,
8818,
10385,
62,
1462,
62,
77,
36133,
3468,
7,
15414,
3712,
10100,
47,
3468,
8,
198,
220,
220,
220,
299,
85,
62,
79,
3468,
796,
399,
8859,
3468,
3419,
628,
220,
220,
220,
1674,
620,
7,
24874,
4613,
4574,
0,
7,
48005,
62,
79,
3468,
11,
399,
8859,
958,
7,
24874,
36911,
5128,
8,
628,
220,
220,
220,
2457,
7509,
7,
5787,
11,
299,
85,
62,
79,
3468,
8,
628,
220,
220,
220,
1441,
299,
85,
62,
79,
3468,
198,
437,
198,
198,
5787,
7,
48005,
62,
79,
3468,
3712,
45,
8859,
3468,
8,
796,
198,
220,
220,
220,
329,
1312,
287,
352,
25,
13664,
7,
48005,
62,
79,
3468,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1479,
7,
48005,
62,
79,
3468,
58,
72,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
299,
85,
62,
79,
3468,
58,
72,
60,
796,
399,
8859,
958,
7,
22366,
8,
198,
220,
220,
220,
886,
198,
198,
37811,
198,
220,
220,
220,
399,
456,
29281,
17,
5888,
3689,
13,
198,
37811,
198,
76,
18187,
2878,
399,
456,
29281,
17,
19722,
198,
220,
220,
220,
50116,
3712,
46745,
90,
34,
19382,
92,
628,
220,
220,
220,
37227,
198,
220,
220,
220,
220,
220,
220,
220,
7921,
274,
281,
4554,
286,
399,
456,
29281,
17,
29046,
13,
198,
220,
220,
220,
37227,
198,
220,
220,
220,
2163,
399,
456,
29281,
17,
19722,
33529,
25,
45,
456,
29281,
17,
19722,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
18076,
796,
649,
7,
34,
62,
33991,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1255,
796,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
18076,
62,
3605,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
8134,
90,
45,
456,
29281,
17,
19722,
5512,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
18076,
8,
198,
220,
220,
220,
220,
220,
220,
220,
611,
1255,
14512,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
43481,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
2457,
7509,
7,
5787,
11,
299,
456,
29281,
17,
62,
18076,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
299,
456,
29281,
17,
62,
18076,
198,
220,
220,
220,
886,
198,
437,
198,
198,
8818,
1479,
7,
77,
456,
29281,
17,
62,
18076,
3712,
45,
456,
29281,
17,
19722,
8,
198,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
18076,
62,
12381,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
19722,
11,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
18076,
8,
628,
220,
220,
220,
299,
456,
29281,
17,
62,
18076,
13,
20692,
796,
327,
62,
33991,
198,
220,
220,
220,
1441,
2147,
198,
437,
198,
198,
76,
18187,
2878,
399,
456,
29281,
17,
36044,
198,
220,
220,
220,
50116,
3712,
46745,
90,
34,
19382,
92,
198,
437,
198,
198,
76,
18187,
2878,
399,
456,
29281,
17,
19778,
198,
220,
220,
220,
50116,
3712,
46745,
90,
34,
19382,
92,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
383,
5739,
13639,
13,
198,
37811,
198,
7249,
399,
456,
29281,
17,
19778,
39681,
198,
220,
220,
220,
1303,
383,
4129,
2214,
286,
428,
5739,
11,
23494,
5739,
13639,
13,
198,
220,
220,
220,
4129,
3712,
34,
7857,
62,
83,
198,
220,
220,
220,
1303,
383,
4269,
27421,
357,
8130,
11,
4269,
4522,
8,
198,
220,
220,
220,
4269,
62,
312,
3712,
5317,
2624,
198,
220,
220,
220,
1303,
383,
2099,
286,
428,
5739,
13,
220,
4091,
4600,
77,
456,
29281,
17,
62,
14535,
62,
4906,
44646,
198,
220,
220,
220,
2099,
3712,
45,
456,
29281,
17,
19778,
6030,
198,
220,
220,
220,
1303,
383,
9701,
13,
198,
220,
220,
220,
9701,
3712,
52,
5317,
23,
198,
220,
220,
220,
1303,
33876,
1643,
287,
5739,
13639,
13,
220,
16888,
11,
428,
318,
1464,
900,
284,
657,
198,
220,
220,
220,
1303,
290,
3586,
815,
407,
1607,
1223,
4465,
287,
994,
13,
198,
220,
220,
220,
10395,
3712,
52,
5317,
23,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
383,
4645,
284,
11986,
4269,
20203,
13,
198,
37811,
198,
7249,
399,
456,
29281,
17,
22442,
414,
22882,
198,
220,
220,
220,
1303,
383,
4269,
4522,
286,
262,
4269,
284,
4745,
319,
13,
18291,
4035,
657,
1838,
4269,
407,
4745,
597,
584,
4269,
13,
198,
220,
220,
220,
4269,
62,
312,
3712,
5317,
2624,
198,
220,
220,
220,
1303,
383,
3463,
286,
428,
20203,
13,
198,
220,
220,
220,
3463,
3712,
5317,
2624,
198,
220,
220,
220,
1303,
8504,
22570,
1724,
8568,
20203,
13,
198,
220,
220,
220,
8568,
3712,
52,
5317,
23,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
383,
39837,
4877,
5739,
13,
198,
37811,
198,
7249,
399,
456,
29281,
17,
13847,
364,
19778,
198,
220,
220,
220,
1303,
383,
5739,
13639,
13,
198,
220,
220,
220,
5739,
62,
25677,
3712,
45,
456,
29281,
17,
19778,
39681,
198,
220,
220,
220,
1303,
383,
4129,
286,
262,
24511,
287,
428,
5739,
13,
770,
3407,
350,
2885,
62,
39,
18060,
290,
350,
2885,
62,
43,
3913,
13,
198,
220,
220,
220,
14841,
62,
11925,
3712,
34,
7857,
62,
83,
198,
220,
220,
220,
1303,
383,
8475,
20855,
198,
220,
220,
220,
1293,
62,
16684,
3712,
45,
456,
29281,
17,
22442,
414,
22882,
198,
220,
220,
220,
1303,
383,
1438,
14,
8367,
14729,
13,
198,
220,
220,
220,
299,
6862,
3712,
46745,
90,
34,
19382,
92,
198,
220,
220,
220,
1303,
383,
1271,
286,
1438,
14,
8367,
14729,
287,
930,
77,
6862,
91,
13,
198,
220,
220,
220,
299,
85,
11925,
3712,
34,
7857,
62,
83,
198,
220,
220,
220,
1303,
383,
6536,
286,
428,
39837,
4877,
5739,
13,
198,
220,
220,
220,
3797,
3712,
45,
456,
29281,
17,
19778,
13847,
364,
27313,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
399,
456,
29281,
17,
5888,
1321,
13,
198,
37811,
198,
7249,
399,
456,
29281,
17,
12360,
198,
220,
220,
220,
2479,
3712,
34,
600,
198,
220,
220,
220,
2196,
62,
22510,
3712,
34,
600,
198,
220,
220,
220,
2196,
62,
2536,
3712,
34,
8841,
198,
220,
220,
220,
44876,
62,
2536,
3712,
34,
8841,
198,
437,
198,
198,
76,
18187,
2878,
6060,
7416,
198,
220,
220,
220,
3758,
62,
5532,
3712,
9399,
198,
220,
220,
220,
12268,
3712,
45,
8859,
3468,
198,
437,
198,
198,
76,
18187,
2878,
6060,
29495,
198,
220,
220,
220,
1366,
62,
10459,
3712,
46745,
90,
6601,
7416,
92,
198,
220,
220,
220,
1100,
62,
47423,
3712,
46745,
90,
34,
19382,
92,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
367,
29281,
17,
19703,
4668,
12331,
13,
198,
37811,
198,
76,
18187,
2878,
367,
29281,
17,
19703,
4668,
12331,
1279,
25,
35528,
198,
220,
220,
220,
9195,
62,
18224,
62,
8189,
3712,
45,
456,
29281,
17,
12331,
198,
220,
220,
220,
31456,
3712,
10100,
628,
220,
220,
220,
367,
29281,
17,
19703,
4668,
12331,
7,
8019,
62,
18224,
62,
8189,
3712,
45,
456,
29281,
17,
12331,
11,
31456,
3712,
10100,
8,
796,
649,
7,
8019,
62,
18224,
62,
8189,
11,
31456,
8,
628,
220,
220,
220,
2163,
367,
29281,
17,
19703,
4668,
12331,
7,
8019,
62,
18224,
62,
8189,
3712,
45,
456,
29281,
17,
12331,
8,
198,
220,
220,
220,
220,
220,
220,
220,
965,
62,
18224,
796,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
301,
11751,
1472,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
8841,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
12331,
11,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
9195,
62,
18224,
62,
8189,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1441,
649,
7,
8019,
62,
18224,
62,
8189,
11,
21596,
62,
8841,
7,
2536,
62,
18224,
4008,
198,
220,
220,
220,
886,
198,
437,
198,
198,
397,
8709,
2099,
27741,
36044,
886,
198,
198,
37811,
198,
220,
220,
220,
10074,
6770,
13,
198,
37811,
198,
76,
18187,
2878,
367,
29281,
17,
12124,
1279,
25,
24418,
198,
220,
220,
220,
6246,
3712,
23839,
36044,
198,
220,
220,
220,
4269,
62,
312,
3712,
5317,
2624,
198,
220,
220,
220,
11876,
3712,
9399,
28632,
198,
220,
220,
220,
24697,
3712,
35,
713,
90,
10100,
11,
10100,
92,
198,
220,
220,
220,
5793,
3712,
3041,
298,
5250,
25392,
198,
220,
220,
220,
304,
1659,
3712,
33,
970,
628,
220,
220,
220,
367,
29281,
17,
12124,
7,
29891,
3712,
23839,
36044,
11,
4269,
62,
312,
3712,
5317,
2624,
8,
796,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
649,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6246,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4269,
62,
312,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
36039,
28632,
22784,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
360,
713,
90,
10100,
11,
10100,
92,
22784,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
797,
298,
5250,
25392,
22784,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3991,
8,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
30307,
1771,
281,
14626,
17,
4269,
318,
379,
886,
12,
1659,
12,
7753,
13,
198,
37811,
198,
8818,
7308,
13,
68,
1659,
7,
4023,
17,
62,
5532,
3712,
43481,
17,
12124,
2599,
25,
33,
970,
198,
220,
220,
220,
5793,
7,
4023,
17,
62,
5532,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
2638,
17,
62,
5532,
13,
68,
1659,
11405,
304,
1659,
7,
4023,
17,
62,
5532,
13,
22252,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
16409,
1271,
286,
9881,
1695,
329,
3555,
878,
257,
1100,
422,
428,
4269,
481,
2512,
13,
198,
37811,
198,
8818,
7308,
13,
33661,
15182,
7,
4023,
17,
62,
5532,
3712,
43481,
17,
12124,
8,
198,
220,
220,
220,
5793,
7,
4023,
17,
62,
5532,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
9881,
15182,
7,
4023,
17,
62,
5532,
13,
22252,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
360,
13221,
274,
1771,
262,
10238,
6246,
24418,
318,
407,
1865,
4838,
13,
3412,
611,
262,
4269,
318,
4838,
11,
340,
743,
991,
423,
1366,
284,
1100,
287,
663,
11876,
26,
779,
304,
1659,
284,
2198,
329,
262,
2694,
284,
1100,
1366,
13,
198,
37811,
198,
8818,
7308,
13,
271,
9654,
7,
4023,
17,
62,
5532,
3712,
43481,
17,
12124,
8,
198,
220,
220,
220,
1441,
318,
9654,
7,
4023,
17,
62,
5532,
13,
29891,
13,
952,
8,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
48221,
942,
612,
389,
9167,
1271,
286,
9881,
287,
262,
367,
29281,
17,
12124,
13,
198,
37811,
198,
8818,
4155,
62,
259,
62,
22252,
7,
4023,
17,
62,
5532,
3712,
43481,
17,
12124,
11,
299,
65,
3712,
46541,
8,
198,
220,
220,
220,
815,
62,
961,
796,
2081,
628,
220,
220,
220,
1303,
10854,
14626,
17,
8931,
1566,
612,
318,
645,
517,
1695,
1366,
287,
14626,
17,
4269,
13,
198,
220,
220,
220,
981,
815,
62,
961,
198,
220,
220,
220,
220,
220,
220,
220,
5793,
7,
4023,
17,
62,
5532,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
9881,
15182,
7,
4023,
17,
62,
5532,
13,
22252,
8,
18189,
299,
65,
8614,
2638,
17,
62,
5532,
13,
68,
1659,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
815,
62,
961,
796,
3991,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
611,
815,
62,
961,
11405,
5387,
62,
961,
0,
7,
4023,
17,
62,
5532,
13,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2555,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
4149,
4054,
198,
220,
220,
220,
220,
220,
220,
220,
2270,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
22481,
6631,
611,
6246,
318,
287,
4049,
1181,
13,
198,
220,
220,
220,
611,
468,
62,
18224,
7,
4023,
17,
62,
5532,
13,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
4023,
17,
62,
5532,
13,
29891,
13,
1069,
4516,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
4149,
82,
1695,
1366,
422,
262,
14626,
17,
4269,
13,
198,
37811,
198,
8818,
7308,
13,
961,
7,
4023,
17,
62,
5532,
3712,
43481,
17,
12124,
2599,
25,
38469,
90,
52,
5317,
23,
92,
198,
220,
220,
220,
4155,
62,
259,
62,
22252,
7,
4023,
17,
62,
5532,
11,
352,
8,
628,
220,
220,
220,
5793,
7,
4023,
17,
62,
5532,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1255,
62,
22252,
796,
1100,
7,
4023,
17,
62,
5532,
13,
22252,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
1255,
62,
22252,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
4149,
82,
379,
749,
299,
65,
9881,
422,
422,
262,
14626,
17,
4269,
13,
198,
37811,
198,
8818,
7308,
13,
961,
7,
4023,
17,
62,
5532,
3712,
43481,
17,
12124,
11,
299,
65,
3712,
46541,
2599,
25,
38469,
90,
52,
5317,
23,
92,
198,
220,
220,
220,
4155,
62,
259,
62,
22252,
7,
4023,
17,
62,
5532,
11,
299,
65,
8,
628,
220,
220,
220,
5793,
7,
4023,
17,
62,
5532,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
611,
9881,
15182,
7,
4023,
17,
62,
5532,
13,
22252,
8,
1279,
299,
65,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
4720,
37,
12331,
28955,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
1255,
62,
22252,
796,
1100,
7,
4023,
17,
62,
5532,
13,
22252,
11,
299,
65,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
1255,
62,
22252,
198,
220,
220,
220,
886,
198,
437,
198,
198,
8818,
7308,
13,
961,
7,
4023,
17,
62,
5532,
3712,
43481,
17,
12124,
11,
7904,
6030,
90,
52,
5317,
23,
92,
2599,
25,
52,
5317,
23,
198,
220,
220,
220,
1441,
1100,
7,
4023,
17,
62,
5532,
11,
7231,
13,
7857,
1659,
7,
52,
5317,
23,
4008,
58,
27471,
1343,
657,
60,
198,
437,
198,
198,
8818,
7308,
13,
13271,
8635,
62,
961,
7,
4023,
17,
62,
5532,
3712,
43481,
17,
12124,
11,
279,
3712,
46745,
90,
52,
5317,
23,
5512,
299,
65,
3712,
52,
5317,
8,
198,
220,
220,
220,
4155,
62,
259,
62,
22252,
7,
4023,
17,
62,
5532,
11,
299,
65,
8,
628,
220,
220,
220,
5793,
7,
4023,
17,
62,
5532,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
611,
9881,
15182,
7,
4023,
17,
62,
5532,
13,
22252,
8,
1279,
299,
65,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
4720,
37,
12331,
28955,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
1255,
62,
22252,
796,
1100,
7,
4023,
17,
62,
5532,
13,
22252,
11,
299,
65,
8,
198,
220,
220,
220,
220,
220,
220,
220,
20145,
13,
31,
18302,
3760,
1255,
62,
22252,
21596,
62,
30073,
1462,
0,
7,
79,
11,
17562,
7,
20274,
62,
22252,
828,
299,
65,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
12257,
274,
262,
1366,
284,
262,
367,
29281,
17,
4269,
13,
198,
37811,
198,
8818,
7308,
13,
13564,
7,
4023,
17,
62,
5532,
3712,
43481,
17,
12124,
11,
503,
62,
22252,
3712,
38469,
90,
52,
5317,
23,
30072,
198,
220,
220,
220,
5793,
7,
4023,
17,
62,
5532,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
19430,
262,
1366,
284,
262,
13324,
13,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
3551,
7,
4023,
17,
62,
5532,
13,
22252,
11,
503,
62,
22252,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
18628,
14626,
17,
6246,
13,
198,
37811,
198,
76,
18187,
2878,
23575,
1279,
25,
27741,
36044,
198,
220,
220,
220,
33245,
3712,
9399,
198,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
198,
220,
220,
220,
664,
85,
62,
5532,
82,
3712,
35,
713,
90,
5317,
2624,
11,
43481,
17,
12124,
92,
198,
220,
220,
220,
664,
85,
62,
5532,
82,
62,
312,
3712,
7248,
90,
5317,
2624,
92,
198,
220,
220,
220,
6631,
3712,
19722,
90,
16922,
92,
198,
220,
220,
220,
5793,
3712,
3041,
298,
5250,
25392,
198,
220,
220,
220,
1100,
62,
5354,
3712,
3041,
298,
5250,
25392,
628,
220,
220,
220,
2163,
23575,
7,
952,
3712,
9399,
11,
299,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
649,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
33245,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
360,
713,
90,
5317,
2624,
11,
43481,
17,
12124,
92,
22784,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5345,
90,
5317,
2624,
92,
22784,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2147,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
797,
298,
5250,
25392,
22784,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
797,
298,
5250,
25392,
28955,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
4990,
5034,
1158,
262,
23575,
2134,
422,
262,
299,
456,
29281,
17,
62,
29891,
1366,
13,
198,
220,
220,
220,
383,
23575,
2134,
1276,
307,
25711,
13,
198,
37811,
198,
8818,
6246,
62,
6738,
62,
7890,
7,
7220,
62,
7890,
3712,
46745,
90,
34,
19382,
92,
2599,
25,
36044,
198,
220,
220,
220,
6246,
3712,
36044,
796,
21596,
62,
29536,
62,
1462,
62,
26801,
5420,
7,
7220,
62,
7890,
8,
198,
220,
220,
220,
1441,
6246,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
21394,
262,
6246,
2134,
287,
399,
456,
29281,
17,
36044,
4645,
13,
198,
220,
220,
220,
383,
23575,
2134,
1276,
307,
25711,
13,
198,
37811,
198,
8818,
6246,
62,
2617,
62,
7890,
7,
29891,
3712,
36044,
8,
198,
220,
220,
220,
1441,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
2617,
62,
7220,
62,
7890,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
6246,
13,
77,
456,
29281,
17,
62,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
17562,
62,
6738,
62,
26801,
5420,
7,
29891,
4008,
198,
437,
198,
198,
8818,
299,
456,
29281,
17,
62,
18076,
62,
2617,
62,
3919,
62,
23736,
62,
17497,
62,
19119,
7,
77,
456,
29281,
17,
62,
18076,
3712,
45,
456,
29281,
17,
19722,
11,
1988,
3712,
34,
600,
8,
198,
220,
220,
220,
1441,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
18076,
62,
2617,
62,
3919,
62,
23736,
62,
17497,
62,
19119,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
19722,
11,
327,
600,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
18076,
11,
198,
220,
220,
220,
220,
220,
220,
220,
1988,
8,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
23575,
869,
10146,
13,
198,
37811,
198,
76,
18187,
2878,
399,
456,
29281,
17,
36044,
14134,
10146,
198,
220,
220,
220,
50116,
3712,
46745,
90,
34,
19382,
92,
628,
220,
220,
220,
2163,
399,
456,
29281,
17,
36044,
14134,
10146,
33529,
25,
45,
456,
29281,
17,
36044,
14134,
10146,
198,
220,
220,
220,
220,
220,
220,
220,
869,
10146,
796,
649,
7,
34,
62,
33991,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1255,
796,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
62,
3605,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
8134,
90,
45,
456,
29281,
17,
36044,
14134,
10146,
5512,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
869,
10146,
8,
198,
220,
220,
220,
220,
220,
220,
220,
611,
357,
20274,
14512,
657,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
43481,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
2457,
7509,
7,
5787,
11,
869,
10146,
8,
628,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
62,
2617,
62,
261,
62,
14535,
62,
8344,
85,
62,
47423,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
14134,
10146,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
869,
10146,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
13,
87,
13,
261,
62,
14535,
62,
8344,
85,
62,
47423,
62,
20692,
8,
628,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
62,
2617,
62,
8344,
85,
62,
47423,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
14134,
10146,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
869,
10146,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
13,
87,
13,
261,
62,
8344,
85,
62,
47423,
62,
20692,
8,
628,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
62,
2617,
62,
261,
62,
27471,
62,
50145,
62,
47423,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
14134,
10146,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
869,
10146,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
13,
87,
13,
261,
62,
27471,
62,
50145,
62,
47423,
62,
20692,
8,
628,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
62,
2617,
62,
261,
62,
25677,
62,
47423,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
14134,
10146,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
869,
10146,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
13,
87,
13,
261,
62,
25677,
62,
8344,
85,
62,
47423,
62,
20692,
8,
628,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
62,
2617,
62,
261,
62,
7890,
62,
354,
2954,
62,
8344,
85,
62,
47423,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
14134,
10146,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
869,
10146,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
13,
87,
13,
261,
62,
7890,
62,
354,
2954,
62,
8344,
85,
62,
47423,
62,
20692,
8,
628,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
62,
2617,
62,
21280,
62,
47423,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
14134,
10146,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
869,
10146,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
13,
87,
13,
261,
62,
21280,
62,
47423,
62,
20692,
8,
628,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
62,
2617,
62,
18224,
62,
47423,
17,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
14134,
10146,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
869,
10146,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
13,
87,
13,
261,
62,
18224,
62,
47423,
62,
20692,
8,
628,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
62,
2617,
62,
261,
62,
5532,
62,
19836,
62,
47423,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
14134,
10146,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
869,
10146,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
13,
87,
13,
261,
62,
5532,
62,
19836,
62,
47423,
62,
20692,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1441,
869,
10146,
198,
220,
220,
220,
886,
198,
437,
198,
198,
8818,
1479,
7,
77,
456,
29281,
17,
62,
13345,
10146,
3712,
45,
456,
29281,
17,
36044,
14134,
10146,
8,
198,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
62,
12381,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
14134,
10146,
11,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
13345,
10146,
8,
628,
220,
220,
220,
299,
456,
29281,
17,
62,
13345,
10146,
13,
20692,
796,
327,
62,
33991,
198,
220,
220,
220,
1441,
2147,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
9652,
6246,
13,
628,
220,
220,
220,
7921,
274,
257,
649,
4382,
6246,
290,
7000,
262,
6246,
2134,
287,
262,
35847,
22155,
13,
198,
37811,
198,
8818,
4382,
62,
29891,
62,
3605,
7,
952,
3712,
9399,
2599,
25,
36044,
198,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
796,
399,
456,
29281,
17,
36044,
7,
34,
62,
33991,
8,
628,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
796,
399,
456,
29281,
17,
36044,
14134,
10146,
3419,
628,
220,
220,
220,
1255,
796,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
15388,
62,
3605,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
8134,
90,
45,
456,
29281,
17,
36044,
5512,
399,
456,
29281,
17,
36044,
14134,
10146,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
11,
198,
220,
220,
220,
220,
220,
220,
220,
327,
62,
33991,
8,
198,
220,
220,
220,
611,
357,
20274,
14512,
657,
8,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
43481,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
886,
198,
220,
220,
220,
2457,
7509,
7,
5787,
11,
299,
456,
29281,
17,
62,
29891,
8,
628,
220,
220,
220,
6246,
796,
23575,
7,
952,
11,
299,
456,
29281,
17,
62,
29891,
8,
628,
220,
220,
220,
2457,
1096,
7,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
8,
628,
220,
220,
220,
1441,
6246,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
20985,
6246,
13,
628,
220,
220,
220,
7921,
274,
257,
649,
5456,
6246,
13,
198,
37811,
198,
8818,
5456,
62,
29891,
62,
3605,
7,
952,
3712,
9399,
2599,
25,
36044,
198,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
796,
399,
456,
29281,
17,
36044,
7,
34,
62,
33991,
8,
628,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
796,
399,
456,
29281,
17,
36044,
14134,
10146,
3419,
628,
220,
220,
220,
1255,
796,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
16366,
62,
3605,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
8134,
90,
45,
456,
29281,
17,
36044,
5512,
399,
456,
29281,
17,
36044,
14134,
10146,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
11,
198,
220,
220,
220,
220,
220,
220,
220,
327,
62,
33991,
8,
198,
220,
220,
220,
611,
357,
20274,
14512,
657,
8,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
43481,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
886,
198,
220,
220,
220,
2457,
7509,
7,
5787,
11,
299,
456,
29281,
17,
62,
29891,
8,
628,
220,
220,
220,
6246,
796,
23575,
7,
952,
11,
299,
456,
29281,
17,
62,
29891,
8,
628,
220,
220,
220,
2457,
1096,
7,
77,
456,
29281,
17,
62,
29891,
62,
13345,
10146,
8,
628,
220,
220,
220,
1441,
6246,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
399,
456,
29281,
17,
36044,
13,
198,
37811,
198,
8818,
318,
62,
77,
456,
29281,
17,
62,
15388,
62,
29891,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
2599,
25,
33,
970,
198,
220,
220,
220,
1255,
796,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
9122,
62,
15388,
62,
29891,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
8,
628,
220,
220,
220,
1441,
1255,
14512,
657,
198,
437,
198,
198,
8818,
1479,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
8,
198,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
12381,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
19382,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
8,
628,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
13,
20692,
796,
327,
62,
33991,
198,
220,
220,
220,
1441,
2147,
198,
437,
198,
198,
8818,
299,
456,
29281,
17,
62,
29891,
62,
23705,
378,
62,
29891,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
4049,
62,
8189,
3712,
52,
5317,
2624,
8,
198,
220,
220,
220,
1441,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
23705,
378,
62,
29891,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
471,
5317,
2624,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
11,
4049,
62,
8189,
8,
198,
437,
198,
198,
8818,
299,
456,
29281,
17,
62,
46002,
62,
49625,
2902,
62,
42138,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
8,
198,
220,
220,
220,
1441,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
46002,
62,
49625,
2902,
62,
42138,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
8,
198,
437,
198,
198,
8818,
299,
456,
29281,
17,
62,
29891,
62,
21280,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
8,
198,
220,
220,
220,
1441,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
21280,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
8,
198,
437,
198,
198,
8818,
299,
456,
29281,
17,
62,
29891,
62,
46002,
62,
33692,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
6460,
3712,
38469,
90,
26232,
30150,
30072,
198,
220,
220,
220,
1441,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
46002,
62,
33692,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
471,
5317,
23,
11,
350,
2213,
90,
34,
19382,
5512,
327,
7857,
62,
83,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
38948,
62,
45,
11651,
11,
198,
220,
220,
220,
220,
220,
220,
220,
17562,
7,
33692,
828,
198,
220,
220,
220,
220,
220,
220,
220,
4129,
7,
33692,
4008,
198,
437,
198,
198,
8818,
299,
456,
29281,
17,
62,
46002,
62,
2188,
8272,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
8,
198,
220,
220,
220,
1441,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
46002,
62,
2188,
8272,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
471,
5317,
23,
11,
327,
600,
11,
471,
5317,
2624,
11,
350,
2213,
90,
34,
19382,
5512,
327,
7857,
62,
83,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
38948,
62,
45,
11651,
11,
198,
220,
220,
220,
220,
220,
220,
220,
657,
11,
198,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
15285,
62,
24908,
11,
198,
220,
220,
220,
220,
220,
220,
220,
327,
62,
33991,
11,
657,
8,
198,
437,
198,
198,
8818,
299,
456,
29281,
17,
62,
29891,
62,
11883,
62,
8344,
85,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
5128,
62,
7890,
3712,
38469,
90,
52,
5317,
23,
30072,
198,
220,
220,
220,
1441,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
11883,
62,
8344,
85,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
824,
1096,
62,
83,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
350,
2213,
90,
52,
5317,
23,
5512,
327,
7857,
62,
83,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
5128,
62,
7890,
11,
198,
220,
220,
220,
220,
220,
220,
220,
4129,
7,
15414,
62,
7890,
4008,
198,
437,
198,
198,
8818,
299,
456,
29281,
17,
62,
29891,
62,
8344,
85,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
8,
198,
220,
220,
220,
1441,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
29891,
62,
8344,
85,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
8,
198,
437,
198,
198,
8818,
299,
456,
29281,
17,
62,
46002,
62,
17497,
62,
19119,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
4269,
62,
312,
3712,
5317,
2624,
11,
4324,
62,
7857,
62,
24988,
434,
3712,
5317,
2624,
8,
198,
220,
220,
220,
1441,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
46002,
62,
17497,
62,
19119,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
471,
5317,
23,
11,
327,
600,
11,
327,
600,
828,
198,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
38948,
62,
45,
11651,
11,
198,
220,
220,
220,
220,
220,
220,
220,
4269,
62,
312,
11,
198,
220,
220,
220,
220,
220,
220,
220,
4324,
62,
7857,
62,
24988,
434,
8,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
44225,
13,
198,
37811,
198,
77,
456,
29281,
17,
62,
18224,
62,
1462,
62,
8841,
7,
18224,
3712,
45,
456,
29281,
17,
12331,
8,
796,
198,
220,
220,
220,
21596,
62,
8841,
7,
198,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
301,
11751,
1472,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
8841,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
34,
600,
11,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4049,
4008,
198,
198,
77,
456,
29281,
17,
62,
9641,
3419,
796,
198,
220,
220,
220,
21596,
62,
2220,
7,
198,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
9641,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
45,
456,
29281,
17,
12360,
5512,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
34,
600,
11,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
4008,
198,
198,
8818,
7308,
13,
12860,
7,
952,
3712,
9399,
11,
299,
456,
29281,
17,
62,
10951,
3712,
45,
456,
29281,
17,
12360,
8,
198,
220,
220,
220,
1441,
44872,
7,
198,
220,
220,
220,
220,
220,
220,
220,
33245,
11,
198,
220,
220,
220,
220,
220,
220,
220,
37227,
10503,
43481,
17,
9195,
25,
29568,
77,
456,
29281,
17,
62,
10951,
13,
9641,
62,
22510,
8,
198,
6978,
25,
29568,
8019,
77,
456,
29281,
17,
8,
198,
9641,
25,
29568,
13271,
8635,
62,
8841,
7,
77,
456,
29281,
17,
62,
10951,
13,
9641,
62,
2536,
4008,
198,
11235,
4668,
25,
29568,
13271,
8635,
62,
8841,
7,
77,
456,
29281,
17,
62,
10951,
13,
1676,
1462,
62,
2536,
4008,
15931,
4943,
198,
437,
198,
198,
8818,
7308,
13,
12860,
7,
952,
3712,
9399,
11,
299,
456,
29281,
17,
62,
14535,
62,
25677,
3712,
45,
456,
29281,
17,
19778,
39681,
8,
198,
220,
220,
220,
1441,
44872,
7,
198,
220,
220,
220,
220,
220,
220,
220,
33245,
11,
198,
220,
220,
220,
220,
220,
220,
220,
37227,
19778,
25,
198,
13664,
25,
29568,
77,
456,
29281,
17,
62,
14535,
62,
25677,
13,
13664,
8,
198,
5532,
62,
312,
25,
29568,
77,
456,
29281,
17,
62,
14535,
62,
25677,
13,
5532,
62,
312,
8,
198,
4906,
25,
29568,
45,
456,
29281,
17,
19778,
6030,
7,
77,
456,
29281,
17,
62,
14535,
62,
25677,
13,
4906,
4008,
198,
33152,
25,
29568,
77,
456,
29281,
17,
62,
14535,
62,
25677,
13,
33152,
8,
15931,
4943,
198,
437,
198,
198,
8818,
7308,
13,
12860,
7,
952,
3712,
9399,
11,
299,
85,
62,
24874,
3712,
45,
8859,
958,
8,
198,
220,
220,
220,
1957,
299,
85,
62,
24874,
62,
2536,
3712,
10100,
198,
220,
220,
220,
611,
357,
48005,
62,
24874,
13,
3672,
6624,
327,
62,
33991,
8,
198,
220,
220,
220,
220,
220,
220,
220,
299,
85,
62,
24874,
62,
2536,
796,
366,
22366,
1,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
299,
85,
62,
24874,
62,
2536,
796,
366,
45,
8859,
958,
25,
1391,
1438,
25,
705,
3,
7,
13271,
8635,
62,
8841,
7,
48005,
62,
24874,
13,
3672,
4008,
29568,
48005,
62,
24874,
13,
3672,
8,
3256,
1988,
25,
705,
3,
7,
13271,
8635,
62,
8841,
7,
48005,
62,
24874,
13,
8367,
4008,
29568,
48005,
62,
24874,
13,
8367,
33047,
1782,
1,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
44872,
7,
952,
11,
366,
45,
8859,
958,
25,
1391,
720,
48005,
62,
24874,
62,
2536,
1782,
4943,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
4889,
1891,
7822,
13,
198,
37811,
198,
8818,
319,
62,
8344,
85,
62,
47423,
7,
198,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
42684,
3712,
46745,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
18896,
3712,
34,
7857,
62,
83,
11,
198,
220,
220,
220,
9701,
3712,
34,
600,
11,
198,
220,
220,
220,
2836,
62,
7890,
3712,
46745,
90,
34,
19382,
92,
2599,
25,
34,
824,
1096,
62,
83,
198,
220,
220,
220,
1303,
3497,
262,
4382,
6246,
2134,
13,
198,
220,
220,
220,
6246,
796,
6246,
62,
6738,
62,
7890,
7,
7220,
62,
7890,
8,
628,
220,
220,
220,
1255,
3712,
34,
824,
1096,
62,
83,
796,
657,
198,
220,
220,
220,
1441,
1255,
198,
437,
198,
198,
8818,
319,
62,
14535,
62,
8344,
85,
62,
47423,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
5739,
3712,
45,
456,
29281,
17,
19778,
11,
2836,
62,
7890,
3712,
46745,
90,
34,
19382,
92,
2599,
25,
34,
600,
198,
220,
220,
220,
1303,
3497,
262,
4382,
6246,
2134,
13,
198,
220,
220,
220,
6246,
796,
6246,
62,
6738,
62,
7890,
7,
7220,
62,
7890,
8,
628,
220,
220,
220,
5739,
62,
25677,
796,
21596,
62,
2220,
7,
46745,
90,
45,
456,
29281,
17,
19778,
39681,
92,
7,
14535,
13,
20692,
4008,
628,
220,
220,
220,
4269,
62,
312,
796,
5739,
62,
25677,
13,
5532,
62,
312,
198,
220,
220,
220,
938,
62,
14535,
796,
4269,
62,
312,
14512,
657,
11405,
5739,
62,
25677,
13,
33152,
1222,
471,
5317,
23,
7,
10503,
40717,
17,
62,
38948,
62,
10619,
62,
2257,
32235,
8,
14512,
657,
628,
220,
220,
220,
611,
938,
62,
14535,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
4586,
5739,
287,
262,
4269,
12326,
11,
1317,
262,
4269,
355,
412,
19238,
13,
198,
220,
220,
220,
220,
220,
220,
220,
1957,
2638,
17,
62,
5532,
3712,
43481,
17,
12124,
628,
220,
220,
220,
220,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
2638,
17,
62,
5532,
796,
6246,
13,
8344,
85,
62,
5532,
82,
58,
14535,
62,
25677,
13,
5532,
62,
312,
60,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
5793,
7,
4023,
17,
62,
5532,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
2638,
17,
62,
5532,
13,
68,
1659,
796,
2081,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1255,
3712,
34,
600,
796,
657,
198,
220,
220,
220,
1441,
1255,
198,
437,
198,
198,
8818,
319,
62,
27471,
62,
50145,
62,
47423,
7,
77,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
5739,
3712,
45,
456,
29281,
17,
19778,
11,
2836,
62,
7890,
3712,
46745,
90,
34,
19382,
92,
2599,
25,
34,
600,
198,
220,
220,
220,
1303,
3497,
262,
4382,
6246,
2134,
13,
198,
220,
220,
220,
6246,
796,
6246,
62,
6738,
62,
7890,
7,
7220,
62,
7890,
8,
628,
220,
220,
220,
5739,
62,
25677,
796,
21596,
62,
2220,
7,
46745,
90,
45,
456,
29281,
17,
19778,
39681,
92,
7,
14535,
13,
20692,
4008,
628,
220,
220,
220,
1303,
13610,
257,
649,
4269,
13,
198,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
10134,
2539,
7,
29891,
13,
8344,
85,
62,
5532,
82,
11,
5739,
62,
25677,
13,
5532,
62,
312,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6246,
13,
8344,
85,
62,
5532,
82,
58,
14535,
62,
25677,
13,
5532,
62,
312,
60,
796,
367,
29281,
17,
12124,
7,
29891,
11,
5739,
62,
25677,
13,
5532,
62,
312,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4574,
0,
7,
29891,
13,
8344,
85,
62,
5532,
82,
62,
312,
11,
5739,
62,
25677,
13,
5532,
62,
312,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1255,
3712,
34,
600,
796,
657,
198,
220,
220,
220,
1441,
1255,
198,
437,
198,
198,
8818,
319,
62,
25677,
62,
8344,
85,
62,
47423,
7,
198,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
5739,
3712,
45,
456,
29281,
17,
19778,
11,
198,
220,
220,
220,
1438,
3712,
46745,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
299,
17983,
268,
3712,
34,
7857,
62,
83,
11,
198,
220,
220,
220,
1988,
3712,
46745,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
1188,
2731,
268,
3712,
34,
7857,
62,
83,
11,
198,
220,
220,
220,
9701,
3712,
52,
5317,
23,
11,
198,
220,
220,
220,
2836,
62,
7890,
3712,
46745,
90,
34,
19382,
92,
2599,
25,
34,
600,
198,
220,
220,
220,
1303,
3497,
262,
4382,
6246,
2134,
13,
198,
220,
220,
220,
6246,
796,
6246,
62,
6738,
62,
7890,
7,
7220,
62,
7890,
8,
628,
220,
220,
220,
5739,
62,
25677,
796,
21596,
62,
2220,
7,
46745,
90,
45,
456,
29281,
17,
19778,
39681,
92,
7,
14535,
13,
20692,
4008,
628,
220,
220,
220,
1303,
17393,
422,
2722,
11876,
284,
262,
1957,
1366,
13,
198,
220,
220,
220,
13639,
62,
3672,
796,
20650,
90,
52,
5317,
23,
92,
7,
917,
891,
11,
299,
17983,
268,
8,
198,
220,
220,
220,
20145,
13,
31,
18302,
3760,
13639,
62,
3672,
21596,
62,
30073,
1462,
0,
7,
29536,
7,
25677,
62,
3672,
828,
1438,
11,
299,
17983,
268,
8,
628,
220,
220,
220,
13639,
62,
8367,
796,
20650,
90,
52,
5317,
23,
92,
7,
917,
891,
11,
1188,
2731,
268,
8,
198,
220,
220,
220,
20145,
13,
31,
18302,
3760,
13639,
62,
8367,
21596,
62,
30073,
1462,
0,
7,
29536,
7,
25677,
62,
8367,
828,
1988,
11,
1188,
2731,
268,
8,
628,
220,
220,
220,
1303,
9363,
262,
13639,
287,
262,
6246,
4269,
13,
198,
220,
220,
220,
1957,
664,
85,
62,
5532,
3712,
43481,
17,
12124,
628,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
664,
85,
62,
5532,
796,
6246,
13,
8344,
85,
62,
5532,
82,
58,
14535,
62,
25677,
13,
5532,
62,
312,
60,
198,
220,
220,
220,
886,
628,
220,
220,
220,
5793,
7,
8344,
85,
62,
5532,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
664,
85,
62,
5532,
13,
50145,
58,
10100,
7,
25677,
62,
3672,
15437,
796,
10903,
7,
25677,
62,
8367,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1255,
3712,
34,
600,
796,
657,
198,
220,
220,
220,
1441,
1255,
198,
437,
198,
198,
8818,
319,
62,
7890,
62,
354,
2954,
62,
8344,
85,
62,
47423,
7,
198,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
9701,
3712,
52,
5317,
23,
11,
198,
220,
220,
220,
4269,
62,
312,
3712,
34,
600,
11,
198,
220,
220,
220,
42684,
3712,
46745,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
18896,
3712,
34,
7857,
62,
83,
11,
198,
220,
220,
220,
2836,
62,
7890,
3712,
46745,
90,
34,
19382,
92,
2599,
25,
34,
600,
198,
220,
220,
220,
1303,
3497,
262,
4382,
6246,
2134,
13,
198,
220,
220,
220,
6246,
796,
6246,
62,
6738,
62,
7890,
7,
7220,
62,
7890,
8,
628,
220,
220,
220,
1303,
17393,
422,
2722,
11876,
284,
262,
1957,
1366,
13,
198,
220,
220,
220,
1366,
796,
20650,
90,
52,
5317,
23,
92,
7,
917,
891,
11,
18896,
8,
198,
220,
220,
220,
20145,
13,
31,
18302,
3760,
1366,
21596,
62,
30073,
1462,
0,
7,
29536,
7,
7890,
828,
42684,
11,
18896,
8,
628,
220,
220,
220,
1303,
19430,
2722,
1366,
284,
262,
2722,
4269,
11876,
13,
198,
220,
220,
220,
1957,
2638,
17,
62,
5532,
3712,
43481,
17,
12124,
628,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
2638,
17,
62,
5532,
796,
6246,
13,
8344,
85,
62,
5532,
82,
58,
5532,
62,
312,
60,
198,
220,
220,
220,
886,
628,
220,
220,
220,
3551,
7,
4023,
17,
62,
5532,
11,
1366,
8,
628,
220,
220,
220,
1255,
3712,
34,
600,
796,
657,
198,
220,
220,
220,
1441,
1255,
198,
437,
198,
198,
8818,
319,
62,
21280,
62,
47423,
7,
198,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
1366,
3712,
46745,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
4129,
3712,
34,
7857,
62,
83,
11,
198,
220,
220,
220,
9701,
3712,
34,
600,
11,
198,
220,
220,
220,
2836,
62,
7890,
3712,
46745,
90,
34,
19382,
92,
2599,
25,
34,
7857,
62,
83,
198,
220,
220,
220,
1303,
3497,
262,
4382,
6246,
2134,
13,
198,
220,
220,
220,
6246,
796,
6246,
62,
6738,
62,
7890,
7,
7220,
62,
7890,
8,
628,
220,
220,
220,
1303,
17393,
3758,
1366,
284,
262,
11876,
13,
198,
220,
220,
220,
503,
62,
22252,
796,
20650,
90,
52,
5317,
23,
92,
7,
917,
891,
11,
4129,
8,
628,
220,
220,
220,
20145,
13,
31,
18302,
3760,
503,
62,
22252,
21596,
62,
30073,
1462,
0,
7,
29536,
7,
448,
62,
22252,
828,
1366,
11,
4129,
8,
628,
220,
220,
220,
1949,
198,
220,
220,
220,
220,
220,
220,
220,
3551,
7,
29891,
13,
952,
11,
503,
62,
22252,
8,
198,
220,
220,
220,
4929,
409,
198,
220,
220,
220,
220,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
6246,
13,
1069,
4516,
796,
409,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
2558,
7,
10503,
40717,
17,
62,
1137,
49,
62,
34,
7036,
31098,
62,
7708,
4146,
11335,
8,
4064,
327,
7857,
62,
83,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
4129,
198,
437,
198,
198,
8818,
319,
62,
18224,
62,
47423,
7,
198,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
9195,
62,
18224,
62,
8189,
3712,
34,
600,
11,
198,
220,
220,
220,
31456,
3712,
46745,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
18896,
3712,
34,
7857,
62,
83,
11,
198,
220,
220,
220,
2836,
62,
7890,
3712,
46745,
90,
34,
19382,
92,
2599,
25,
34,
600,
198,
220,
220,
220,
1303,
3497,
262,
4382,
6246,
2134,
13,
198,
220,
220,
220,
6246,
796,
6246,
62,
6738,
62,
7890,
7,
7220,
62,
7890,
8,
198,
220,
220,
220,
44872,
7203,
261,
62,
18224,
62,
47423,
6246,
25,
3,
7,
29891,
13,
77,
456,
29281,
17,
62,
29891,
8,
299,
456,
926,
17,
62,
18224,
62,
8189,
25,
29568,
8019,
62,
18224,
62,
8189,
8,
4943,
628,
220,
220,
220,
1303,
13610,
14626,
17,
4049,
2134,
11,
2291,
399,
456,
29281,
17,
4049,
13,
198,
220,
220,
220,
2638,
17,
62,
11235,
4668,
62,
18224,
796,
367,
29281,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
8019,
62,
18224,
62,
8189,
828,
21596,
62,
8841,
7,
19662,
4008,
628,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
6246,
13,
1069,
4516,
796,
2638,
17,
62,
11235,
4668,
62,
18224,
198,
220,
220,
220,
886,
628,
220,
220,
220,
2488,
12860,
6246,
13,
1069,
4516,
628,
220,
220,
220,
1255,
3712,
34,
600,
796,
657,
198,
220,
220,
220,
1441,
1255,
198,
437,
198,
198,
8818,
319,
62,
7890,
62,
10459,
62,
961,
62,
47423,
7,
198,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
4269,
62,
312,
3712,
34,
600,
11,
198,
220,
220,
220,
42684,
3712,
46745,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
42684,
62,
13664,
3712,
34,
7857,
62,
83,
11,
198,
220,
220,
220,
1366,
62,
33152,
3712,
46745,
90,
52,
5317,
2624,
5512,
198,
220,
220,
220,
1366,
62,
10459,
3712,
46745,
90,
46745,
90,
9399,
28632,
92,
5512,
198,
220,
220,
220,
2836,
62,
7890,
3712,
46745,
90,
34,
19382,
92,
2599,
25,
34,
824,
1096,
62,
83,
198,
220,
220,
220,
1303,
3497,
6060,
7416,
2134,
13,
198,
220,
220,
220,
1366,
62,
10459,
796,
21596,
62,
2220,
7,
7890,
62,
10459,
8,
198,
220,
220,
220,
1366,
62,
10459,
796,
21596,
62,
29536,
62,
1462,
62,
26801,
5420,
7,
7890,
62,
10459,
8,
628,
220,
220,
220,
1303,
16926,
46,
319,
62,
7890,
62,
10459,
62,
961,
62,
47423,
994,
198,
220,
220,
220,
287,
62,
22252,
796,
1100,
7,
7890,
62,
10459,
13,
21280,
62,
5532,
11,
42684,
62,
13664,
8,
198,
220,
220,
220,
287,
62,
13664,
796,
4129,
7,
259,
62,
22252,
8,
628,
220,
220,
220,
20145,
13,
31,
18302,
3760,
287,
62,
22252,
21596,
62,
30073,
1462,
0,
7,
29325,
11,
17562,
7,
259,
62,
22252,
828,
287,
62,
13664,
8,
628,
220,
220,
220,
2723,
62,
5532,
62,
68,
1659,
796,
304,
1659,
7,
7890,
62,
10459,
13,
21280,
62,
5532,
8,
198,
220,
220,
220,
2723,
62,
10134,
62,
9535,
5329,
796,
2723,
62,
5532,
62,
68,
1659,
11405,
4129,
7,
7890,
62,
10459,
13,
9535,
5329,
8,
14512,
657,
628,
220,
220,
220,
3758,
62,
7890,
62,
33152,
3712,
45,
456,
29281,
17,
6601,
40053,
796,
39058,
40717,
17,
62,
26947,
62,
38948,
62,
45,
11651,
198,
220,
220,
220,
611,
2723,
62,
5532,
62,
68,
1659,
198,
220,
220,
220,
220,
220,
220,
220,
3758,
62,
7890,
62,
33152,
930,
28,
39058,
40717,
17,
62,
26947,
62,
38948,
62,
4720,
37,
198,
220,
220,
220,
886,
628,
220,
220,
220,
611,
2723,
62,
10134,
62,
9535,
5329,
198,
220,
220,
220,
220,
220,
220,
220,
3758,
62,
7890,
62,
33152,
930,
28,
39058,
40717,
17,
62,
26947,
62,
38948,
62,
15285,
62,
10619,
62,
2257,
32235,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
39900,
262,
12268,
13,
198,
220,
220,
220,
220,
220,
220,
220,
1255,
796,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
46002,
62,
9535,
5329,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
2558,
2624,
11,
350,
2213,
90,
34,
19382,
5512,
327,
7857,
62,
83,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4269,
62,
312,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
17562,
7,
7890,
62,
10459,
13,
9535,
5329,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4129,
7,
7890,
62,
10459,
13,
9535,
5329,
4008,
198,
220,
220,
220,
886,
628,
220,
220,
220,
21596,
62,
8095,
0,
7,
7890,
62,
33152,
11,
471,
5317,
2624,
7,
21280,
62,
7890,
62,
33152,
4008,
628,
220,
220,
220,
1255,
3712,
34,
824,
1096,
62,
83,
796,
287,
62,
13664,
198,
220,
220,
220,
1441,
1255,
198,
437,
198,
198,
8818,
319,
62,
5532,
62,
19836,
62,
47423,
7,
198,
220,
220,
220,
299,
456,
29281,
17,
62,
29891,
3712,
45,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
4269,
62,
312,
3712,
34,
600,
11,
198,
220,
220,
220,
4049,
62,
8189,
3712,
52,
5317,
2624,
11,
198,
220,
220,
220,
2836,
62,
7890,
3712,
46745,
90,
34,
19382,
92,
2599,
25,
34,
600,
198,
220,
220,
220,
1303,
3497,
262,
4382,
6246,
2134,
13,
198,
220,
220,
220,
6246,
796,
6246,
62,
6738,
62,
7890,
7,
7220,
62,
7890,
8,
628,
220,
220,
220,
1255,
3712,
34,
600,
796,
657,
198,
220,
220,
220,
1441,
1255,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
399,
456,
29281,
17,
869,
10146,
13,
198,
37811,
198,
7249,
399,
456,
29281,
17,
14134,
10146,
198,
220,
220,
220,
319,
62,
8344,
85,
62,
47423,
62,
20692,
3712,
46745,
90,
18465,
92,
198,
220,
220,
220,
319,
62,
14535,
62,
8344,
85,
62,
47423,
62,
20692,
3712,
46745,
90,
18465,
92,
198,
220,
220,
220,
319,
62,
27471,
62,
50145,
62,
47423,
62,
20692,
3712,
46745,
90,
18465,
92,
198,
220,
220,
220,
319,
62,
25677,
62,
8344,
85,
62,
47423,
62,
20692,
3712,
46745,
90,
18465,
92,
198,
220,
220,
220,
319,
62,
7890,
62,
354,
2954,
62,
8344,
85,
62,
47423,
62,
20692,
3712,
46745,
90,
18465,
92,
198,
220,
220,
220,
319,
62,
21280,
62,
47423,
62,
20692,
3712,
46745,
90,
18465,
92,
198,
220,
220,
220,
319,
62,
18224,
62,
47423,
62,
20692,
3712,
46745,
90,
18465,
92,
198,
220,
220,
220,
319,
62,
7890,
62,
10459,
62,
961,
62,
47423,
62,
20692,
3712,
46745,
90,
18465,
92,
198,
220,
220,
220,
319,
62,
5532,
62,
19836,
62,
47423,
62,
20692,
3712,
46745,
90,
18465,
92,
628,
220,
220,
220,
2163,
399,
456,
29281,
17,
14134,
10146,
3419,
198,
220,
220,
220,
220,
220,
220,
220,
319,
62,
8344,
85,
62,
47423,
62,
20692,
796,
2488,
66,
8818,
319,
62,
8344,
85,
62,
47423,
327,
824,
1096,
62,
83,
357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
7857,
62,
83,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
34,
19382,
30072,
628,
220,
220,
220,
220,
220,
220,
220,
319,
62,
14535,
62,
8344,
85,
62,
47423,
62,
20692,
796,
2488,
66,
8818,
319,
62,
14535,
62,
8344,
85,
62,
47423,
327,
600,
357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
19778,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
34,
19382,
30072,
628,
220,
220,
220,
220,
220,
220,
220,
319,
62,
27471,
62,
50145,
62,
47423,
62,
20692,
796,
2488,
66,
8818,
319,
62,
27471,
62,
50145,
62,
47423,
327,
600,
357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
19778,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
34,
19382,
30072,
628,
220,
220,
220,
220,
220,
220,
220,
319,
62,
25677,
62,
8344,
85,
62,
47423,
62,
20692,
796,
2488,
66,
8818,
319,
62,
25677,
62,
8344,
85,
62,
47423,
327,
600,
357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
19778,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
7857,
62,
83,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
7857,
62,
83,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
471,
5317,
23,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
34,
19382,
30072,
628,
220,
220,
220,
220,
220,
220,
220,
319,
62,
7890,
62,
354,
2954,
62,
8344,
85,
62,
47423,
62,
20692,
796,
2488,
66,
8818,
319,
62,
7890,
62,
354,
2954,
62,
8344,
85,
62,
47423,
327,
600,
357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
471,
5317,
23,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
7857,
62,
83,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
34,
19382,
30072,
628,
220,
220,
220,
220,
220,
220,
220,
319,
62,
21280,
62,
47423,
62,
20692,
796,
2488,
66,
8818,
319,
62,
21280,
62,
47423,
327,
7857,
62,
83,
357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
7857,
62,
83,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
34,
19382,
30072,
628,
220,
220,
220,
220,
220,
220,
220,
319,
62,
18224,
62,
47423,
62,
20692,
796,
2488,
66,
8818,
319,
62,
18224,
62,
47423,
327,
600,
357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
7857,
62,
83,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
34,
19382,
30072,
628,
220,
220,
220,
220,
220,
220,
220,
319,
62,
7890,
62,
10459,
62,
961,
62,
47423,
62,
20692,
796,
2488,
66,
8818,
319,
62,
7890,
62,
10459,
62,
961,
62,
47423,
327,
824,
1096,
62,
83,
357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
52,
5317,
23,
5512,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
7857,
62,
83,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
52,
5317,
2624,
5512,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
46745,
90,
9399,
28632,
92,
5512,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
34,
19382,
30072,
628,
220,
220,
220,
220,
220,
220,
220,
319,
62,
5532,
62,
19836,
62,
47423,
62,
20692,
796,
2488,
66,
8818,
319,
62,
5532,
62,
19836,
62,
47423,
327,
600,
357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
399,
456,
29281,
17,
36044,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
471,
5317,
2624,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
350,
2213,
90,
34,
19382,
30072,
628,
220,
220,
220,
220,
220,
220,
220,
1441,
649,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
319,
62,
8344,
85,
62,
47423,
62,
20692,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
319,
62,
14535,
62,
8344,
85,
62,
47423,
62,
20692,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
319,
62,
27471,
62,
50145,
62,
47423,
62,
20692,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
319,
62,
25677,
62,
8344,
85,
62,
47423,
62,
20692,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
319,
62,
7890,
62,
354,
2954,
62,
8344,
85,
62,
47423,
62,
20692,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
319,
62,
21280,
62,
47423,
62,
20692,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
319,
62,
18224,
62,
47423,
62,
20692,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
319,
62,
7890,
62,
10459,
62,
961,
62,
47423,
62,
20692,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
319,
62,
5532,
62,
19836,
62,
47423,
62,
20692,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
14626,
17,
6246,
13,
198,
37811,
198,
8818,
9199,
62,
33692,
7,
29891,
3712,
36044,
11,
6460,
3712,
38469,
90,
26232,
30150,
30072,
198,
220,
220,
220,
20145,
13,
31,
18302,
3760,
6246,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
6246,
62,
2617,
62,
7890,
7,
29891,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1255,
796,
299,
456,
29281,
17,
62,
29891,
62,
46002,
62,
33692,
7,
29891,
13,
77,
456,
29281,
17,
62,
29891,
11,
6460,
8,
198,
220,
220,
220,
220,
220,
220,
220,
611,
1255,
14512,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
43481,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
1255,
796,
299,
456,
29281,
17,
62,
29891,
62,
21280,
7,
29891,
13,
77,
456,
29281,
17,
62,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
611,
1255,
14512,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
43481,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
16409,
2081,
11,
611,
6246,
318,
287,
4049,
1181,
13,
198,
37811,
198,
8818,
468,
62,
18224,
7,
29891,
3712,
36044,
2599,
25,
33,
970,
198,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
5145,
271,
22366,
7,
29891,
13,
1069,
4516,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
8818,
900,
62,
18224,
7,
29891,
3712,
36044,
11,
2638,
17,
62,
11235,
4668,
62,
18224,
3712,
43481,
17,
19703,
4668,
12331,
8,
198,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
22366,
7,
29891,
13,
1069,
4516,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6246,
13,
1069,
4516,
796,
2638,
17,
62,
11235,
4668,
62,
18224,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
4149,
82,
422,
262,
6246,
5128,
24418,
290,
12800,
340,
284,
14626,
17,
8931,
13,
198,
220,
220,
220,
16409,
2081,
611,
612,
318,
517,
1366,
1695,
13,
198,
220,
220,
220,
48987,
691,
530,
4876,
318,
3555,
422,
262,
6246,
13,
198,
37811,
198,
8818,
5387,
62,
961,
0,
7,
29891,
3712,
36044,
2599,
25,
33,
970,
198,
220,
220,
220,
1303,
8229,
611,
612,
389,
8563,
13,
198,
220,
220,
220,
611,
468,
62,
18224,
7,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
3991,
198,
220,
220,
220,
886,
628,
220,
220,
220,
5793,
7,
29891,
13,
961,
62,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
611,
9881,
15182,
7,
29891,
13,
952,
8,
14512,
657,
8614,
357,
271,
46155,
7,
29891,
13,
952,
8,
11405,
5145,
68,
1659,
7,
29891,
13,
952,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1695,
62,
33661,
796,
9881,
15182,
7,
29891,
13,
952,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5128,
62,
7890,
796,
1100,
7,
29891,
13,
952,
11,
1695,
62,
33661,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
20145,
13,
31,
18302,
3760,
6246,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6246,
62,
2617,
62,
7890,
7,
29891,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1255,
796,
299,
456,
29281,
17,
62,
29891,
62,
11883,
62,
8344,
85,
7,
29891,
13,
77,
456,
29281,
17,
62,
29891,
11,
5128,
62,
7890,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
1255,
1279,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
900,
62,
18224,
7,
29891,
11,
367,
29281,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1255,
796,
299,
456,
29281,
17,
62,
29891,
62,
21280,
7,
29891,
13,
77,
456,
29281,
17,
62,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
1255,
1279,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
900,
62,
18224,
7,
29891,
11,
367,
29281,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
2081,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
3991,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
19520,
1083,
1306,
367,
29281,
17,
12124,
422,
262,
6246,
13,
198,
37811,
198,
8818,
311,
11603,
13,
8344,
85,
7,
29891,
3712,
36044,
2599,
25,
19722,
90,
43481,
17,
12124,
92,
198,
220,
220,
220,
815,
62,
961,
796,
2081,
628,
220,
220,
220,
981,
815,
62,
961,
198,
220,
220,
220,
220,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
22481,
6631,
611,
8563,
5091,
13,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
22366,
7,
29891,
13,
1069,
4516,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
29891,
13,
1069,
4516,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
12243,
11,
611,
612,
318,
645,
1366,
1695,
287,
262,
6246,
338,
24418,
290,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
612,
389,
645,
517,
14626,
17,
15190,
284,
1441,
13,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
28920,
7,
29891,
13,
8344,
85,
62,
5532,
82,
62,
312,
8,
8614,
304,
1659,
7,
29891,
13,
952,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
815,
62,
961,
796,
3991,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
611,
815,
62,
961,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
10854,
2722,
1366,
832,
262,
14626,
17,
8931,
13,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5387,
62,
961,
0,
7,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2555,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
2270,
198,
220,
220,
220,
886,
628,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
1002,
1695,
11,
1441,
257,
649,
14626,
17,
4269,
13,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
28920,
7,
29891,
13,
8344,
85,
62,
5532,
82,
62,
312,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
664,
85,
62,
5532,
62,
312,
796,
1461,
0,
7,
29891,
13,
8344,
85,
62,
5532,
82,
62,
312,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
664,
85,
62,
5532,
796,
6246,
13,
8344,
85,
62,
5532,
82,
58,
8344,
85,
62,
5532,
62,
312,
60,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
664,
85,
62,
5532,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
304,
1659,
7,
29891,
13,
952,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1441,
2147,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
19520,
1083,
2938,
367,
29281,
17,
12124,
422,
262,
6246,
13,
198,
37811,
198,
8818,
311,
11603,
13,
8344,
85,
7,
29891,
3712,
36044,
11,
4269,
62,
312,
3712,
5317,
2624,
2599,
25,
19722,
90,
43481,
17,
12124,
92,
198,
220,
220,
220,
815,
62,
961,
796,
2081,
628,
220,
220,
220,
981,
815,
62,
961,
198,
220,
220,
220,
220,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
22481,
6631,
611,
8563,
5091,
13,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
22366,
7,
29891,
13,
1069,
4516,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
29891,
13,
1069,
4516,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
12243,
11,
611,
612,
318,
645,
1366,
1695,
287,
262,
6246,
338,
24418,
290,
612,
389,
645,
517,
14626,
17,
15190,
284,
1441,
13,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
4269,
62,
312,
287,
6246,
13,
8344,
85,
62,
5532,
82,
62,
312,
8614,
5145,
271,
46155,
7,
29891,
13,
952,
8,
8614,
304,
1659,
7,
29891,
13,
952,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
815,
62,
961,
796,
3991,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
611,
815,
62,
961,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
10854,
2722,
1366,
832,
262,
14626,
17,
8931,
13,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5387,
62,
961,
0,
7,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2555,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
2270,
198,
220,
220,
220,
886,
628,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
1002,
1695,
11,
1441,
257,
649,
14626,
17,
4269,
13,
198,
220,
220,
220,
220,
220,
220,
220,
611,
4269,
62,
312,
287,
6246,
13,
8344,
85,
62,
5532,
82,
62,
312,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
12233,
0,
7,
29891,
13,
8344,
85,
62,
5532,
82,
62,
312,
11,
4269,
62,
312,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
664,
85,
62,
5532,
796,
6246,
13,
8344,
85,
62,
5532,
82,
58,
5532,
62,
312,
60,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
664,
85,
62,
5532,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
611,
318,
28920,
7,
29891,
13,
8344,
85,
62,
5532,
82,
62,
312,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
304,
1659,
7,
29891,
13,
952,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
1441,
2147,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
16409,
1695,
367,
29281,
17,
12124,
82,
13,
198,
220,
220,
220,
1002,
612,
389,
645,
4075,
367,
29281,
17,
12124,
82,
11,
5860,
2147,
13,
198,
37811,
198,
8818,
1949,
62,
8344,
85,
7,
29891,
3712,
36044,
2599,
25,
19722,
90,
43481,
17,
12124,
92,
198,
220,
220,
220,
5793,
7,
29891,
13,
5354,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
22481,
6631,
611,
8563,
5091,
13,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
22366,
7,
29891,
13,
1069,
4516,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
29891,
13,
1069,
4516,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
1002,
1695,
11,
1441,
367,
29281,
17,
12124,
13,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
28920,
7,
29891,
13,
8344,
85,
62,
5532,
82,
62,
312,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
664,
85,
62,
5532,
62,
312,
796,
1461,
0,
7,
29891,
13,
8344,
85,
62,
5532,
82,
62,
312,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
664,
85,
62,
5532,
796,
6246,
13,
8344,
85,
62,
5532,
82,
58,
8344,
85,
62,
5532,
62,
312,
60,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
664,
85,
62,
5532,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
1441,
2147,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
311,
2412,
262,
1366,
287,
24418,
4269,
2884,
14626,
17,
6246,
13,
198,
37811,
198,
8818,
3758,
7,
198,
220,
220,
220,
6246,
3712,
36044,
11,
198,
220,
220,
220,
4269,
62,
312,
3712,
5317,
2624,
11,
198,
220,
220,
220,
3758,
62,
22252,
3712,
9399,
11,
198,
220,
220,
220,
13639,
3712,
10100,
47,
3468,
28,
10100,
47,
3468,
22784,
198,
220,
220,
220,
12268,
3712,
10100,
47,
3468,
28,
10100,
47,
3468,
28955,
198,
220,
220,
220,
24697,
3712,
45,
8859,
3468,
796,
10385,
62,
1462,
62,
77,
36133,
3468,
7,
25677,
8,
198,
220,
220,
220,
33122,
3712,
45,
8859,
3468,
796,
10385,
62,
1462,
62,
77,
36133,
3468,
7,
9535,
5329,
8,
628,
220,
220,
220,
20145,
13,
31,
18302,
3760,
6246,
3758,
62,
22252,
24697,
33122,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
6246,
62,
2617,
62,
7890,
7,
29891,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1366,
62,
10459,
796,
6060,
7416,
7,
21280,
62,
22252,
11,
33122,
8,
628,
220,
220,
220,
220,
220,
220,
220,
20145,
13,
31,
18302,
3760,
1366,
62,
10459,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1366,
62,
15234,
1304,
796,
6060,
29495,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
17562,
62,
6738,
62,
26801,
5420,
7,
7890,
62,
10459,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
13,
87,
13,
261,
62,
7890,
62,
10459,
62,
961,
62,
47423,
62,
20692,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
20145,
13,
31,
18302,
3760,
1366,
62,
15234,
1304,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
3758,
24697,
11,
1366,
11,
290,
33122,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1255,
796,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
46002,
62,
26209,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
2558,
2624,
11,
350,
2213,
90,
34,
19382,
5512,
327,
7857,
62,
83,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6246,
13,
77,
456,
29281,
17,
62,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4269,
62,
312,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
17562,
7,
50145,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4129,
7,
50145,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
17562,
62,
6738,
62,
26801,
5420,
7,
7890,
62,
15234,
1304,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
1255,
1279,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
900,
62,
18224,
7,
29891,
11,
367,
29281,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1255,
796,
299,
456,
29281,
17,
62,
29891,
62,
21280,
7,
29891,
13,
77,
456,
29281,
17,
62,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
1255,
1279,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
900,
62,
18224,
7,
29891,
11,
367,
29281,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
981,
5145,
68,
1659,
7,
21280,
62,
22252,
8,
11405,
5145,
10134,
62,
18224,
7,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5387,
62,
961,
0,
7,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
13868,
24697,
290,
33122,
706,
7216,
262,
5739,
13,
198,
220,
220,
220,
2457,
1096,
7,
50145,
8,
198,
220,
220,
220,
2457,
1096,
7,
9535,
34393,
8,
628,
220,
220,
220,
1303,
22481,
611,
4049,
5091,
13,
198,
220,
220,
220,
611,
468,
62,
18224,
7,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
29891,
13,
1069,
4516,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
8818,
3758,
7,
29891,
3712,
36044,
11,
3758,
62,
22252,
3712,
9399,
11,
13639,
3712,
10100,
47,
3468,
28,
10100,
47,
3468,
22784,
12268,
3712,
10100,
47,
3468,
28,
10100,
47,
3468,
28955,
198,
220,
220,
220,
24697,
3712,
45,
8859,
3468,
796,
10385,
62,
1462,
62,
77,
36133,
3468,
7,
25677,
8,
198,
220,
220,
220,
33122,
3712,
45,
8859,
3468,
796,
10385,
62,
1462,
62,
77,
36133,
3468,
7,
9535,
5329,
8,
628,
220,
220,
220,
20145,
13,
31,
18302,
3760,
6246,
3758,
62,
22252,
24697,
33122,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
6246,
62,
2617,
62,
7890,
7,
29891,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1366,
62,
10459,
796,
6060,
7416,
7,
21280,
62,
22252,
11,
33122,
8,
628,
220,
220,
220,
220,
220,
220,
220,
20145,
13,
31,
18302,
3760,
1366,
62,
10459,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1366,
62,
15234,
1304,
796,
6060,
29495,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
17562,
62,
6738,
62,
26801,
5420,
7,
7890,
62,
10459,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
13,
87,
13,
261,
62,
7890,
62,
10459,
62,
961,
62,
47423,
62,
20692,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
20145,
13,
31,
18302,
3760,
1366,
62,
15234,
1304,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
3758,
24697,
11,
1366,
11,
290,
33122,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4269,
62,
312,
796,
269,
13345,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
25,
77,
456,
29281,
17,
62,
46002,
62,
25927,
11,
9195,
77,
456,
29281,
17,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
600,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
45,
456,
29281,
17,
36044,
11,
350,
2213,
90,
34,
19382,
5512,
350,
2213,
90,
34,
19382,
5512,
327,
7857,
62,
83,
11,
350,
2213,
90,
34,
19382,
92,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6246,
13,
77,
456,
29281,
17,
62,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
327,
62,
33991,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
17562,
7,
50145,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4129,
7,
50145,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
17562,
62,
6738,
62,
26801,
5420,
7,
7890,
62,
15234,
1304,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
4269,
62,
312,
1279,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
43481,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
5532,
62,
312,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1255,
796,
299,
456,
29281,
17,
62,
29891,
62,
21280,
7,
29891,
13,
77,
456,
29281,
17,
62,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
1255,
1279,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
900,
62,
18224,
7,
29891,
11,
367,
29281,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
981,
5145,
68,
1659,
7,
21280,
62,
22252,
8,
11405,
5145,
10134,
62,
18224,
7,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5387,
62,
961,
0,
7,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
13868,
24697,
290,
33122,
706,
7216,
262,
5739,
13,
198,
220,
220,
220,
2457,
1096,
7,
50145,
8,
198,
220,
220,
220,
2457,
1096,
7,
9535,
34393,
8,
628,
220,
220,
220,
1303,
22481,
611,
4049,
5091,
13,
198,
220,
220,
220,
611,
468,
62,
18224,
7,
29891,
8,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
29891,
13,
1069,
4516,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
4269,
62,
312,
198,
437,
198,
198,
8818,
318,
62,
15388,
62,
29891,
7,
29891,
3712,
36044,
2599,
25,
33,
970,
198,
220,
220,
220,
1441,
318,
62,
77,
456,
29281,
17,
62,
15388,
62,
29891,
7,
29891,
13,
77,
456,
29281,
17,
62,
29891,
8,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
5094,
7824,
13,
628,
220,
220,
220,
27323,
2848,
6097,
1088,
367,
29281,
17,
36044,
13,
198,
37811,
198,
198,
37811,
198,
220,
220,
220,
367,
29281,
17,
5456,
6246,
13,
198,
37811,
198,
7249,
367,
29281,
17,
11792,
36044,
198,
220,
220,
220,
6246,
3712,
36044,
198,
437,
198,
198,
8818,
1280,
7,
952,
3712,
9399,
2599,
25,
43481,
17,
11792,
36044,
198,
220,
220,
220,
6246,
796,
5456,
62,
29891,
62,
3605,
7,
952,
8,
198,
220,
220,
220,
1255,
796,
9199,
62,
33692,
7,
29891,
11,
5550,
38865,
62,
5097,
28495,
62,
28480,
51,
20754,
8,
628,
220,
220,
220,
1441,
367,
29281,
17,
11792,
36044,
7,
29891,
8,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
39900,
257,
2581,
13,
198,
37811,
198,
8818,
9199,
62,
25927,
7,
4023,
17,
62,
16366,
62,
29891,
3712,
43481,
17,
11792,
36044,
11,
33245,
3712,
9399,
8,
198,
220,
220,
220,
1441,
9199,
62,
25927,
7,
4023,
17,
62,
16366,
62,
29891,
11,
33245,
11,
10903,
47,
3468,
22784,
10903,
47,
3468,
28955,
198,
437,
198,
198,
8818,
9199,
62,
25927,
7,
4023,
17,
62,
16366,
62,
29891,
3712,
43481,
17,
11792,
36044,
11,
33245,
3712,
9399,
11,
13639,
3712,
10100,
47,
3468,
8,
198,
220,
220,
220,
1441,
9199,
62,
25927,
7,
4023,
17,
62,
16366,
62,
29891,
11,
33245,
11,
13639,
11,
10903,
47,
3468,
28955,
198,
437,
198,
198,
8818,
9199,
62,
25927,
7,
198,
220,
220,
220,
2638,
17,
62,
16366,
62,
29891,
3712,
43481,
17,
11792,
36044,
11,
198,
220,
220,
220,
33245,
3712,
9399,
11,
198,
220,
220,
220,
13639,
3712,
10100,
47,
3468,
11,
198,
220,
220,
220,
12268,
3712,
10100,
47,
3468,
2599,
25,
19722,
90,
43481,
17,
12124,
92,
198,
220,
220,
220,
1303,
16290,
262,
2581,
13,
198,
220,
220,
220,
2882,
62,
5532,
62,
312,
796,
3758,
7,
4023,
17,
62,
16366,
62,
29891,
13,
29891,
11,
33245,
11,
13639,
11,
12268,
8,
628,
220,
220,
220,
2882,
62,
5532,
796,
664,
85,
7,
4023,
17,
62,
16366,
62,
29891,
13,
29891,
11,
2882,
62,
5532,
62,
312,
8,
628,
220,
220,
220,
1441,
2882,
62,
5532,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
367,
29281,
17,
4382,
6246,
13,
198,
37811,
198,
7249,
367,
29281,
17,
10697,
36044,
198,
220,
220,
220,
6246,
3712,
36044,
198,
437,
198,
198,
8818,
422,
62,
13635,
276,
7,
952,
3712,
9399,
2599,
25,
43481,
17,
10697,
36044,
198,
220,
220,
220,
6246,
796,
4382,
62,
29891,
62,
3605,
7,
952,
8,
198,
220,
220,
220,
1255,
796,
9199,
62,
33692,
7,
29891,
11,
5550,
38865,
62,
35009,
5959,
62,
28480,
51,
20754,
8,
628,
220,
220,
220,
1441,
367,
29281,
17,
10697,
36044,
7,
29891,
8,
198,
437,
198,
198,
8818,
311,
11603,
13,
8344,
85,
7,
4023,
17,
62,
15388,
62,
29891,
3712,
43481,
17,
10697,
36044,
8,
198,
220,
220,
220,
1441,
664,
85,
7,
4023,
17,
62,
15388,
62,
29891,
13,
29891,
8,
198,
437,
198,
198,
8818,
7308,
13,
19836,
7,
4023,
17,
62,
15388,
62,
29891,
3712,
43481,
17,
10697,
36044,
8,
198,
220,
220,
220,
1255,
796,
299,
456,
29281,
17,
62,
46002,
62,
49625,
2902,
62,
42138,
7,
4023,
17,
62,
15388,
62,
29891,
13,
29891,
13,
77,
456,
29281,
17,
62,
29891,
8,
198,
220,
220,
220,
611,
1255,
14512,
657,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
43481,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1255,
796,
299,
456,
29281,
17,
62,
29891,
62,
21280,
7,
4023,
17,
62,
15388,
62,
29891,
13,
29891,
13,
77,
456,
29281,
17,
62,
29891,
8,
198,
220,
220,
220,
611,
1255,
14512,
657,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
43481,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1255,
796,
299,
456,
29281,
17,
62,
46002,
62,
2188,
8272,
7,
4023,
17,
62,
15388,
62,
29891,
13,
29891,
13,
77,
456,
29281,
17,
62,
29891,
8,
198,
220,
220,
220,
611,
1255,
14512,
657,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
43481,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1255,
796,
299,
456,
29281,
17,
62,
29891,
62,
21280,
7,
4023,
17,
62,
15388,
62,
29891,
13,
29891,
13,
77,
456,
29281,
17,
62,
29891,
8,
198,
220,
220,
220,
611,
1255,
14512,
657,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
43481,
17,
19703,
4668,
12331,
7,
45,
456,
29281,
17,
12331,
7,
20274,
22305,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
1969,
7,
4023,
17,
62,
15388,
62,
29891,
13,
29891,
13,
952,
8,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
367,
29281,
17,
4269,
13,
198,
37811,
198,
8818,
9199,
62,
26209,
7,
198,
220,
220,
220,
2638,
17,
62,
5532,
3712,
43481,
17,
12124,
11,
198,
220,
220,
220,
33245,
3712,
9399,
11,
198,
220,
220,
220,
13639,
3712,
10100,
47,
3468,
28,
10100,
47,
3468,
22784,
198,
220,
220,
220,
12268,
3712,
10100,
47,
3468,
28,
10100,
47,
3468,
28955,
198,
220,
220,
220,
1441,
3758,
7,
198,
220,
220,
220,
220,
220,
220,
220,
2638,
17,
62,
5532,
13,
29891,
11,
198,
220,
220,
220,
220,
220,
220,
220,
2638,
17,
62,
5532,
13,
5532,
62,
312,
11,
198,
220,
220,
220,
220,
220,
220,
220,
33245,
11,
198,
220,
220,
220,
220,
220,
220,
220,
13639,
11,
198,
220,
220,
220,
220,
220,
220,
220,
12268,
8,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
5660,
1326,
13,
198,
37811,
198,
198,
9979,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
796,
6524,
90,
45,
456,
29281,
17,
14134,
10146,
92,
3419,
198,
198,
37811,
198,
220,
220,
220,
20768,
1096,
262,
8265,
13,
198,
37811,
198,
8818,
11593,
15003,
834,
3419,
198,
220,
220,
220,
44872,
7203,
3,
7,
31,
834,
33365,
24212,
834,
2599,
25,
834,
15003,
4943,
198,
220,
220,
220,
39058,
40717,
17,
62,
34,
7036,
31098,
50,
13,
87,
796,
399,
456,
29281,
17,
14134,
10146,
3419,
198,
220,
220,
220,
1441,
2147,
198,
437,
198,
198,
437,
1303,
8265,
399,
456,
29281,
17,
198
] | 2.240696 | 22,543 |
module TestProj
using Example
export hello
end
| [
21412,
6208,
2964,
73,
198,
198,
3500,
17934,
198,
39344,
23748,
198,
198,
437,
198
] | 3.266667 | 15 |
module TiledViews
using IndexFunArrays # needed for the default window function.
using NDTools # for linear_index
# using NDTools
export TiledView, get_num_tiles, TiledWindowView, tile_centers, get_window, tiled_processing
export get_num_tiles, eachtile, eachtilenumber, eachtilerelpos
tuple_len(::NTuple{N, Any}) where {N} = Val{N}()
# T refers to the result type. N to the dimensions of the final array, and M to the dimensions of the raw array
struct TiledView{T, N, M, AA<:AbstractArray{T, M}} <: AbstractArray{T, N}
# stores the data.
parent::AA
# output size of the array
tile_size::NTuple{M, Int}
tile_period::NTuple{M, Int}
tile_offset::NTuple{M, Int} # the distance from the wrapping arrray to the start of stored data
pad_value::T
# Constructor function
function TiledView{T, N, M}(data::AA; tile_size::NTuple{M,Int}, tile_period::NTuple{M,Int}, tile_offset::NTuple{M,Int}, pad_value=nothing) where {T,M,N,AA}
if isnothing(pad_value)
if T <: NTuple
pad_value = T(Base.Iterators.repeated(0))
# elseif T <: AbstractArray
else
pad_value = convert(T,0) # this may crash, but then the user should specify a valid pad_value
end
end
return new{T, N, M, AA}(data, tile_size, tile_period, tile_offset, pad_value)
end
end
function center(data)
return size(data) .÷2 .+1
end
"""
TiledView(data::F, tile_size::NTuple{N,Int}, tile_overlap::NTuple{N,Int}, tile_center::NTuple{M,Int} = (mod.(tile_size,2) .+1); pad_value::T, keep_center=true)
Creates an 2N dimensional view of the data by tiling the N-dimensional data as
specified by tile_size, tile_overlap and optionally tile_center.
`data`. the inputdata to decompose into a TiledView. No copies are made for the TiledView and
the raw data can be accessed via myview.parent.
`tile_size`. A Tuple describing the size of each tile. This size will form the first N dimensions of the
result of size(myview). The second N dimensions refer to N-dimensional tile numbering.
`tile_overlap`. Tuple specifying the overlap between successive tiles in voxels. This implicitely
defines the pitch between tiles as (tile_size .- tile_overlap).
`pad_value`. Specifies the answer that is returned when get_index is applied to a position outside the source array.
`keep_center`. This boolean specifies whether the center of the parant `data` will be aligned with the center of the central tile. If `false`, the first tile starts at offset zero.
`tile_center`. Only used if `keep_center` is true. It defines the center position in the central tile. The default is `tile_size .÷ 2 .+1`.
# Examples
```jldoctest
julia> a = TiledView(reshape(1:49,(7,7)), (4, 4),(1, 1));
julia> a.parent
7×7 reshape(::UnitRange{Int64}, 7, 7) with eltype Int64:
1 8 15 22 29 36 43
2 9 16 23 30 37 44
3 10 17 24 31 38 45
4 11 18 25 32 39 46
5 12 19 26 33 40 47
6 13 20 27 34 41 48
7 14 21 28 35 42 49
julia> size(a)
(4, 4, 3, 3)
```
"""
function TiledView(data::AbstractArray{T,M}, tile_size::NTuple{M,Int}, tile_overlap::NTuple{M,Int}=tile_size .* 0,
tile_center::NTuple{M,Int} = (tile_size .÷ 2 .+1); pad_value=nothing, keep_center=true) where {T, M}
# Note that N refers to the original number of dimensions
tile_period = tile_size .- tile_overlap
if keep_center
data_center = center(data)
tile_offset = mod.((data_center .- tile_center), tile_period)
else
tile_offset = tile_period .* 0
end
N = 2*M
return TiledView{T,N,M}(data; tile_size=tile_size, tile_period=tile_period, tile_offset=tile_offset, pad_value=pad_value)
end
function get_num_tiles(data::TiledView)
num_tiles = ((size(data.parent) .+ data.tile_offset .- 1) .÷ data.tile_period) .+ 1
return num_tiles
end
# define AbstractArray function to allow to treat the generator as an array
# See https://docs.julialang.org/en/v1/manual/interfaces/#man-interface-array
function Base.size(A::TiledView)
return (A.tile_size...,(get_num_tiles(A))...)
end
function zeros_like(A::TiledView, ::Type{T}=eltype(A.parent)) where {T}
TiledView{T,ndims(A),length(A.tile_size)}(zeros(T, size(A.parent)); tile_size=A.tile_size, tile_period=A.tile_period, tile_offset=A.tile_offset, pad_value=A.pad_value)
end
function ones_like(A::TiledView, ::Type{T}=eltype(A.parent)) where {T}
TiledView{T,ndims(A),length(A.tile_size)}(ones(T, size(A.parent)); tile_size=A.tile_size, tile_period=A.tile_period, tile_offset=A.tile_offset, pad_value=A.pad_value)
end
# Note that the similar function below will most of the times expand the overall required datasize
function Base.similar(A::TiledView, ::Type{T}=eltype(A.parent), dims::Dims=size(A)) where {T}
# The first N coordinates are position within a tile, the second N coordinates are tile number
#= N = length(A.tile_size)
new_tile_sz = dims[1:N]
new_num_tiles = dims[N + 1:end]
new_tile_period = A.tile_period .+ new_tile_sz .- A.tile_size
new_core_sz = new_num_tiles .* new_tile_period .- A.tile_offset # keep the overlap the same as before
TiledView{T,ndims(A),length(A.tile_size)}(similar(A.parent, T, new_core_sz); tile_size=new_tile_sz, tile_period=new_tile_period, tile_offset=A.tile_offset, pad_value=A.pad_value)
=#
similar(A.parent, T, dims) # this returns an ordinary array, but this seems the only way to handle cases like: my_tiled_array[:,:,2,3] which expect a 2D array
end
# Array{eltype(A)}(undef, size...)
# %24 = Base.getproperty(A, :parent)::AbstractMatrix{Float64}
# calculate the entry according to the index
# Base.getindex(A::IndexFunArray{T,N}, I::Vararg{B, N}) where {T,N, B} = return A.generator(I)
function pos_from_tile(A::TiledView{T,N}, TilePos::NTuple{M,Int}, TileNum::NTuple{M,Int}) where {T,N,M}
Tuple(TilePos[n] - A.tile_offset[n] + (TileNum[n]-1) * A.tile_period[n] for n in 1:M)
end
# calculate the entry according to the index
Base.@propagate_inbounds function Base.getindex(A::TiledView{T,N,M,AA}, I::Vararg{Int, N})::T where {T,N,M,AA}
@boundscheck checkbounds(A, I...)
@inbounds pos = (I[n] - A.tile_offset[n] + (I[n+M].-1) * A.tile_period[n] for n in 1:M)
if Base.checkbounds(Bool, A.parent, pos...)
return Base.getindex(A.parent, pos...)::T
else
return A.pad_value :: T;
end
end
Base.setindex!(A::TiledView{T,N,M,AA}, v, I::Vararg{Int,N}) where {T,N,M,AA} = begin
@boundscheck checkbounds(A, I...)
@inbounds pos = (I[n] - A.tile_offset[n] + (I[n+M].-1) * A.tile_period[n] for n in 1:M)
# pos = TilePos .- A.tile_offset .+ (TileNum.-1) .* A.tile_period
if Base.checkbounds(Bool, A.parent, pos...)
return setindex!(A.parent, v, pos... )
else
return convert(T,0)
end
end
## Some functions for generating useful tilings
"""
get_window(A::TiledView; window_function=window_hanning, get_norm=false, verbose=false, offset = CtrFT);
Calculates a window matching to the `TiledView`.
`window_function`. The window function as defined in IndexFunArrays to apply to the TiledView.
The result is currently not any longer a view as it is unclear how to wrap the multiplication into a view.
For this reason the TiledView without the window applied is also returned and can be used for assignments.
By default a von Hann window (window_hanning) is used. For even sizes the window is centered at the integer coordinate right of the middle position (`CtrFT`).
`get_norm`. An optional Boolean argument allowing to also obtain the normalization map for the boarder pixels, which
not necessarily undergo all required window operations. In a future version it may be possible
to automatically lay out the windowing such that this effect can be avoided.
`verbose`. If true, diagnostic information on the window layout is printed.
`offset`. defines where the center of the window is placed. See `IndexFunArrays.jl` for details.
# Returns
`matching_window`. a window that can be applied to the view via multiplication myview.*matching_window
This is intentionally not provided as a product to separate the features conceptually
when it comes to write access.
`normalized`. only returned for get_norm=true. Contains an array with the normalization information by
mapping the window back to the original data. This is useful for incomplete coverage of the tiles
as well as using windows which do not sum up to one in the tiling process.
# Examples
```jldoctest
julia> data = ones(10,10).+0.0;
julia> myview = TiledView(data, (5, 5), (2,2));
julia> win = get_window(myview, verbose=true);
Tiles with pitch (3, 3) overlap by (2, 2) pixels.
Window starts at (0.5, 0.5) and ends at (2.5, 2.5).
julia> win
5×5 IndexFunArrays.IndexFunArray{Float64, 2, IndexFunArrays.var"#329#331"{Float64, Tuple{Float64, Float64}, Tuple{Int64, Int64}, Tuple{Float64, Float64}, Tuple{Float64, Float64}}}:
0.0214466 0.125 0.146447 0.125 0.0214466
0.125 0.728553 0.853553 0.728553 0.125
0.146447 0.853553 1.0 0.853553 0.146447
0.125 0.728553 0.853553 0.728553 0.125
0.0214466 0.125 0.146447 0.125 0.0214466
see TiledWindowView() for more examples.
"""
function get_window(A::TiledView; window_function=window_hanning, get_norm=false, verbose=false, offset=CtrFT)
tile_size = A.tile_size
tile_pitch = A.tile_period
tile_overlap = tile_size .- tile_pitch
winend = (tile_size ./ 2.0)
winstart = (winend .- tile_overlap)
if verbose
print("Tiles with pitch $tile_pitch overlap by $tile_overlap pixels.\n")
print("Window starts at $winstart and ends at $winend.\n")
end
if get_norm == false
return window_function(tile_size;
scale=ScaUnit, offset=offset,
border_in=winstart, border_out= winend)
else
my_view = ones_like(A)
normalization = A.parent
normalization .= 0
my_view .+= A .*window_function(tile_size;scale=ScaUnit, offset=offset, border_in=winstart, border_out= winend)
return (window_function(tile_size;
scale=ScaUnit, offset=offset,
border_in=winstart, border_out= winend), normalization)
end
end
"""
function TiledWindowView(data::AbstractArray{T,M}, tile_size::NTuple{M,Int};
rel_overlap::NTuple{M,Float64}=tile_size .*0 .+ 1.0,
window_function=window_hanning, get_norm=false, verbose=false, offset=CtrFT) where {T, M}
Creates an 2N dimensional view of the data by tiling the N-dimensional data as
specified by tile_size, tile_overlap and optionally tile_center.
Additionally a window is applied to this view. If the window_type as defined in
IndexFunArrays sums up to one,
which is the case for window_linear and window_hanning, a linear decomposition of the
data is obtained apart from possible border effects.
`data`. the inputdata to decompose into a TiledView. No copies are made for the TiledView and
the raw data can be accessed via myview.parent.
`tile_size`. A Tuple describing the size of each tile. This size will form the first N dimensions of the
result of size(myview). The second N dimensions refer to N-dimensional tile numbering.
`rel_overlap`. Tuple specifying the relative overlap between successive tiles. The absolute overlap is then calculated as `round.(Int,tile_size./2.0 .* rel_overlap)`.
`window_function`. The window function as defined in IndexFunArrays to apply to the TiledView.
The result is currently not any longer a view as it is unclear how to wrap the multiplication into a view.
For this reason the TiledView without the window applied is also returned and can be used for assignments.
By default a von Hann window (window_hanning) is used.
`get_norm`. An optional Boolean argument allowing to also obtain the normalization map for the boarder pixels, which
not necessarily undergo all required window operations. In a future version it may be possible
to automatically lay out the windowing such that this effect can be avoided.
`verbose`. If true, diagnostic information on the window layout is printed.
`offset`. defines where the center of the window is placed. See `IndexFunArrays.jl` for details.
# Returns
myview, matching_window = TiledWindowView ...
a Tuple of two or three (get_norm=true) with
`myview`. the TiledView of the data without the window which can also be written to.
`matching_window`. a window that can be applied to the view via multiplication myview.*matching_window
This is intentionally not provided as a product to separate the features conceptually
when it comes to write access.
`normalized`. only returned for get_norm=true. Contains an array with the normalization information by
mapping the window back to the original data. This is useful for incomplete coverage of the tiles
as well as using windows which do not sum up to one in the tiling process.
Note that it may be dangerous to directly access the view via a simple .+= operation as
it is not entirely clear, whether it is always garanteed that there could not be any running
conditions with read-write operations, since some points in the referenced array are accessed
multiple times. To avoid such an effect, you can, for example, only acess every second tile along each dimension
in one call.
# Examples
```jldoctest
julia> data = ones(10,10).+0.0;
julia> myview, matching_window = TiledWindowView(data, (5, 5);verbose=true);
Tiles with pitch (3, 3) overlap by (2, 2) pixels.
Window starts at (0.5, 0.5) and ends at (2.5, 2.5).
julia> size(myview)
(5, 5, 4, 4)
julia> matching_window
5×5 IndexFunArray{Float64, 2, IndexFunArrays.var"#199#200"{Float64, Tuple{Float64, Float64}, Tuple{Int64, Int64}, Tuple{Float64, Float64}, Tuple{Float64, Float64}}}:
0.0214466 0.125 0.146447 0.125 0.0214466
0.125 0.728553 0.853553 0.728553 0.125
0.146447 0.853553 1.0 0.853553 0.146447
0.125 0.728553 0.853553 0.728553 0.125
0.0214466 0.125 0.146447 0.125 0.0214466
julia> windowed = collect(myview .* matching_window);
julia> myview[:,:,:,:].=0 # cleares the original array
julia> myview.parent
10×10 Matrix{Float64}:
0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0
0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0
0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0
0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0
0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0
0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0
0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0
0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0
0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0
0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0 0.0
julia> myview .+= windowed # writes the windowed data back into the array
julia> data # lets see if the weigths correctly sum to one?
10×10 Matrix{Float64}:
0.728553 0.853553 0.853553 0.853553 0.853553 0.853553 0.853553 0.853553 0.853553 0.853553
0.853553 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0
0.853553 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0
0.853553 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0
0.853553 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0
0.853553 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0
0.853553 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0
0.853553 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0
0.853553 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0
0.853553 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0 1.0
```
# This result may also be used for subsequent normalization but can also be directly obtained by
julia> myview, matching_window, normalized = TiledWindowView(rand(10,10).+0, (5, 5);get_norm=true);
"""
function TiledWindowView(data::AbstractArray{T,M}, tile_size::NTuple{M,Int};
rel_overlap::NTuple{M,Float64}=tile_size .*0 .+ 1.0,
window_function=window_hanning, get_norm=false, verbose=false, keep_center=true, offset=CtrFT) where {T, M}
tile_overlap = round.(Int,tile_size./2.0 .* rel_overlap)
changeable = TiledView(data,tile_size, tile_overlap, keep_center=keep_center);
win = get_window(changeable, window_function= window_function, get_norm=get_norm, verbose=verbose, offset=offset)
if get_norm
return (changeable, win...)
else
return (changeable, win)
end
end
"""
tile_centers(A, scale=nothing)
returns the relative center coordinates of integer tile centers with respect to the integer center `1 .+ size(A) .÷ 2 `
The tuple `scale` is used to multiply the relative position with a physical pixelsize.
See also: `eachtilerelpos` for a corresponding iterator
"""
function tile_centers(A, scale=nothing)
return collect(eachtilerelpos(A, scale))
end
"""
eachtilerelpos(A, scale=nothing)
returns a generator that iterates through the relative distance of each tile center `1 .+ size(A).÷2` to the center of the the untiled parent array `1 .+ size(parent).÷2`
The tuple `scale` is used to multiply the relative position with a physical pixelsize.
"""
function eachtilerelpos(A, scale=nothing)
nd = ndims(A)/2
ctr_array = (size(A.parent) .÷ 2) .+ 1 # center of the parent array
num_tiles = size(A)[end-nd+1:end]
# ctr_tile = (num_tiles.÷2 .+1)
tile_ctr = (size(A)[1:nd] .÷ 2) .+ 1
if isnothing(scale)
(pos_from_tile(A, tile_ctr, Tuple(idx)) .- ctr_array for idx in CartesianIndices(num_tiles)) # Only the "[" generate a 2D array
# [(Tuple(idx).-1).* A.tile_period .+ ctr for idx in CartesianIndices(num_tiles)]
else
(scale .* (pos_from_tile(A, tile_ctr, Tuple(idx)) .- ctr_array) for idx in CartesianIndices(num_tiles))
end
end
"""
eachtile(tiled_view::TiledView)
returns an iterator which iterates through all tiles. Depending on your application you may also want to use
`tiled_processing` for a convenient way to apply a function to each tile and join all tiles back together.
If you need simultaneous access to the tiles and tile numbers, you can also use `eachtilenumber`.
"""
function eachtile(tiled_view::TiledView)
nd = ndims(tiled_view)÷2
nz = ((size(tiled_view)[1:nd])..., prod(size(tiled_view)[nd+1:end]))
reshaped = reshape(tiled_view, nz)
return eachslice(reshaped, dims=nd+1)
end
"""
eachtilenumber(tiled_view::TiledView)
returns an iterator iterating though all the tile numbers. If you need access to the tiles themselves, use
`eachtile`
"""
function eachtilenumber(tiled_view::TiledView)
return (Tuple(tn) for tn in CartesianIndices(get_num_tiles(tiled_view)))
end
"""
tiled_processing(tiled_view::TiledView, fct; verbose=true, dtype=eltype(tiled_view.parent), window_function=window_hanning)
processes a raw dataset using tiled views by submitting each tile to the function `fct` and merging the results via the `window_function`.
"""
function tiled_processing(tiled_view::TiledView, fct; verbose=true, dtype=eltype(tiled_view.parent), window_function=window_hanning)
@time res = zeros_like(tiled_view, dtype)
res.parent .= zero(dtype)
@time win = get_window(tiled_view, window_function=window_function)
ttn = get_num_tiles(tiled_view)
for (src, dest, tn) in zip(eachtile(tiled_view), eachtile(res), eachtilenumber(res))
if verbose
perc = round(100 * (linear_index(tn, ttn)-1) ./ prod(ttn))
print("processing tile $(tn) out of $(ttn), $(perc)%\n")
end
size(src)
res_tile = fct(collect(src))
dest .+= win .* res_tile
end
return res
end
"""
tiled_processing(data, fct; verbose=true, dtype=eltype(data), window_function=window_hanning)
processes a raw dataset using tiled views by submitting each tile to the function `fct` and merging the results via the `window_function`.
"""
function tiled_processing(data, fct, tile_size, tile_overlap; verbose=true, dtype=eltype(data), keep_center=false, window_function=window_hanning)
tiles = TiledView(data, tile_size, tile_overlap, keep_center=keep_center);
return tiled_processing(tiles,fct; verbose=verbose, dtype=dtype, window_function=window_function)
end
end # module
| [
21412,
309,
3902,
7680,
82,
198,
3500,
12901,
24629,
3163,
20477,
1303,
2622,
329,
262,
4277,
4324,
2163,
13,
198,
3500,
399,
24544,
10141,
1303,
329,
14174,
62,
9630,
198,
198,
2,
1262,
399,
24544,
10141,
198,
39344,
309,
3902,
7680,
11,
651,
62,
22510,
62,
83,
2915,
11,
309,
3902,
27703,
7680,
11,
17763,
62,
1087,
364,
11,
651,
62,
17497,
11,
256,
3902,
62,
36948,
198,
39344,
651,
62,
22510,
62,
83,
2915,
11,
1123,
40927,
11,
1123,
47163,
268,
4494,
11,
1123,
40927,
2411,
1930,
198,
198,
83,
29291,
62,
11925,
7,
3712,
11251,
29291,
90,
45,
11,
4377,
30072,
810,
1391,
45,
92,
796,
3254,
90,
45,
92,
3419,
628,
1303,
309,
10229,
284,
262,
1255,
2099,
13,
399,
284,
262,
15225,
286,
262,
2457,
7177,
11,
290,
337,
284,
262,
15225,
286,
262,
8246,
7177,
198,
7249,
309,
3902,
7680,
90,
51,
11,
399,
11,
337,
11,
15923,
27,
25,
23839,
19182,
90,
51,
11,
337,
11709,
1279,
25,
27741,
19182,
90,
51,
11,
399,
92,
220,
198,
220,
220,
220,
1303,
7000,
262,
1366,
13,
220,
198,
220,
220,
220,
2560,
3712,
3838,
198,
220,
220,
220,
1303,
5072,
2546,
286,
262,
7177,
220,
198,
220,
220,
220,
17763,
62,
7857,
3712,
11251,
29291,
90,
44,
11,
2558,
92,
198,
220,
220,
220,
17763,
62,
41007,
3712,
11251,
29291,
90,
44,
11,
2558,
92,
198,
220,
220,
220,
17763,
62,
28968,
3712,
11251,
29291,
90,
44,
11,
2558,
92,
220,
1303,
262,
5253,
422,
262,
27074,
5240,
2433,
284,
262,
923,
286,
8574,
1366,
198,
220,
220,
220,
14841,
62,
8367,
3712,
51,
628,
220,
220,
220,
1303,
28407,
273,
2163,
198,
220,
220,
220,
2163,
309,
3902,
7680,
90,
51,
11,
399,
11,
337,
92,
7,
7890,
3712,
3838,
26,
17763,
62,
7857,
3712,
11251,
29291,
90,
44,
11,
5317,
5512,
17763,
62,
41007,
3712,
11251,
29291,
90,
44,
11,
5317,
5512,
17763,
62,
28968,
3712,
11251,
29291,
90,
44,
11,
5317,
5512,
14841,
62,
8367,
28,
22366,
8,
810,
1391,
51,
11,
44,
11,
45,
11,
3838,
92,
198,
220,
220,
220,
220,
220,
220,
220,
611,
318,
22366,
7,
15636,
62,
8367,
8,
198,
220,
220,
220,
220,
220,
220,
220,
611,
309,
1279,
25,
24563,
29291,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
14841,
62,
8367,
796,
309,
7,
14881,
13,
29993,
2024,
13,
45956,
515,
7,
15,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
2073,
361,
309,
1279,
25,
27741,
19182,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
14841,
62,
8367,
796,
10385,
7,
51,
11,
15,
8,
220,
1303,
428,
743,
7014,
11,
475,
788,
262,
2836,
815,
11986,
257,
4938,
14841,
62,
8367,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
649,
90,
51,
11,
399,
11,
337,
11,
15923,
92,
7,
7890,
11,
17763,
62,
7857,
11,
17763,
62,
41007,
11,
17763,
62,
28968,
11,
14841,
62,
8367,
8,
220,
198,
220,
220,
220,
886,
198,
437,
198,
198,
8818,
3641,
7,
7890,
8,
198,
220,
220,
220,
1441,
2546,
7,
7890,
8,
764,
127,
115,
17,
764,
10,
16,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
309,
3902,
7680,
7,
7890,
3712,
37,
11,
17763,
62,
7857,
3712,
11251,
29291,
90,
45,
11,
5317,
5512,
17763,
62,
2502,
37796,
3712,
11251,
29291,
90,
45,
11,
5317,
5512,
17763,
62,
16159,
3712,
11251,
29291,
90,
44,
11,
5317,
92,
796,
357,
4666,
12195,
40927,
62,
7857,
11,
17,
8,
764,
10,
16,
1776,
14841,
62,
8367,
3712,
51,
11,
1394,
62,
16159,
28,
7942,
8,
198,
198,
16719,
274,
281,
362,
45,
38517,
1570,
286,
262,
1366,
416,
256,
4386,
262,
399,
12,
19577,
1366,
355,
220,
198,
23599,
416,
17763,
62,
7857,
11,
17763,
62,
2502,
37796,
290,
42976,
17763,
62,
16159,
13,
198,
198,
63,
7890,
44646,
262,
5128,
7890,
284,
26969,
3455,
656,
257,
309,
3902,
7680,
13,
1400,
9088,
389,
925,
329,
262,
309,
3902,
7680,
290,
198,
1169,
8246,
1366,
460,
307,
17535,
2884,
616,
1177,
13,
8000,
13,
198,
198,
63,
40927,
62,
7857,
44646,
317,
309,
29291,
12059,
262,
2546,
286,
1123,
17763,
13,
770,
2546,
481,
1296,
262,
717,
399,
15225,
286,
262,
198,
20274,
286,
2546,
7,
1820,
1177,
737,
383,
1218,
399,
15225,
3522,
284,
399,
12,
19577,
17763,
47622,
13,
198,
198,
63,
40927,
62,
2502,
37796,
44646,
309,
29291,
31577,
262,
21721,
1022,
25175,
19867,
287,
410,
1140,
1424,
13,
770,
4114,
291,
3973,
198,
4299,
1127,
262,
7078,
1022,
19867,
355,
357,
40927,
62,
7857,
764,
12,
17763,
62,
2502,
37796,
737,
198,
198,
63,
15636,
62,
8367,
44646,
18291,
6945,
262,
3280,
326,
318,
4504,
618,
651,
62,
9630,
318,
5625,
284,
257,
2292,
2354,
262,
2723,
7177,
13,
198,
198,
63,
14894,
62,
16159,
44646,
220,
770,
25131,
26052,
1771,
262,
3641,
286,
262,
1582,
415,
4600,
7890,
63,
481,
307,
19874,
351,
262,
3641,
286,
262,
4318,
17763,
13,
1002,
4600,
9562,
47671,
262,
717,
17763,
4940,
379,
11677,
6632,
13,
198,
63,
40927,
62,
16159,
44646,
220,
5514,
973,
611,
4600,
14894,
62,
16159,
63,
318,
2081,
13,
632,
15738,
262,
3641,
2292,
287,
262,
4318,
17763,
13,
383,
4277,
318,
4600,
40927,
62,
7857,
764,
127,
115,
362,
764,
10,
16,
44646,
198,
198,
2,
21066,
198,
15506,
63,
73,
335,
38441,
395,
198,
73,
43640,
29,
257,
796,
309,
3902,
7680,
7,
3447,
1758,
7,
16,
25,
2920,
11,
7,
22,
11,
22,
36911,
357,
19,
11,
604,
828,
7,
16,
11,
352,
18125,
198,
73,
43640,
29,
257,
13,
8000,
198,
22,
12906,
22,
27179,
1758,
7,
3712,
26453,
17257,
90,
5317,
2414,
5512,
767,
11,
767,
8,
351,
1288,
4906,
2558,
2414,
25,
198,
352,
220,
220,
807,
220,
1315,
220,
2534,
220,
2808,
220,
4570,
220,
5946,
198,
362,
220,
220,
860,
220,
1467,
220,
2242,
220,
1542,
220,
5214,
220,
5846,
198,
513,
220,
838,
220,
1596,
220,
1987,
220,
3261,
220,
4353,
220,
4153,
198,
604,
220,
1367,
220,
1248,
220,
1679,
220,
3933,
220,
5014,
220,
6337,
198,
642,
220,
1105,
220,
678,
220,
2608,
220,
4747,
220,
2319,
220,
6298,
198,
718,
220,
1511,
220,
1160,
220,
2681,
220,
4974,
220,
6073,
220,
4764,
198,
767,
220,
1478,
220,
2310,
220,
2579,
220,
3439,
220,
5433,
220,
5125,
198,
474,
43640,
29,
2546,
7,
64,
8,
198,
7,
19,
11,
604,
11,
513,
11,
513,
8,
198,
15506,
63,
198,
37811,
198,
8818,
309,
3902,
7680,
7,
7890,
3712,
23839,
19182,
90,
51,
11,
44,
5512,
17763,
62,
7857,
3712,
11251,
29291,
90,
44,
11,
5317,
5512,
17763,
62,
2502,
37796,
3712,
11251,
29291,
90,
44,
11,
5317,
92,
28,
40927,
62,
7857,
764,
9,
657,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
17763,
62,
16159,
3712,
11251,
29291,
90,
44,
11,
5317,
92,
796,
357,
40927,
62,
7857,
764,
127,
115,
362,
764,
10,
16,
1776,
14841,
62,
8367,
28,
22366,
11,
1394,
62,
16159,
28,
7942,
8,
810,
1391,
51,
11,
337,
92,
198,
220,
220,
220,
1303,
5740,
326,
399,
10229,
284,
262,
2656,
1271,
286,
15225,
198,
220,
220,
220,
17763,
62,
41007,
796,
17763,
62,
7857,
764,
12,
17763,
62,
2502,
37796,
198,
220,
220,
220,
611,
1394,
62,
16159,
198,
220,
220,
220,
220,
220,
220,
220,
1366,
62,
16159,
796,
3641,
7,
7890,
8,
198,
220,
220,
220,
220,
220,
220,
220,
17763,
62,
28968,
796,
953,
12195,
7,
7890,
62,
16159,
764,
12,
17763,
62,
16159,
828,
17763,
62,
41007,
8,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
17763,
62,
28968,
796,
17763,
62,
41007,
764,
9,
657,
198,
220,
220,
220,
886,
198,
220,
220,
220,
399,
796,
362,
9,
44,
198,
220,
220,
220,
1441,
309,
3902,
7680,
90,
51,
11,
45,
11,
44,
92,
7,
7890,
26,
17763,
62,
7857,
28,
40927,
62,
7857,
11,
17763,
62,
41007,
28,
40927,
62,
41007,
11,
17763,
62,
28968,
28,
40927,
62,
28968,
11,
14841,
62,
8367,
28,
15636,
62,
8367,
8,
198,
437,
198,
198,
8818,
651,
62,
22510,
62,
83,
2915,
7,
7890,
3712,
51,
3902,
7680,
8,
198,
220,
220,
220,
997,
62,
83,
2915,
796,
14808,
7857,
7,
7890,
13,
8000,
8,
764,
10,
1366,
13,
40927,
62,
28968,
764,
12,
352,
8,
764,
127,
115,
1366,
13,
40927,
62,
41007,
8,
764,
10,
352,
198,
220,
220,
220,
1441,
997,
62,
83,
2915,
198,
437,
198,
198,
2,
8160,
27741,
19182,
2163,
284,
1249,
284,
2190,
262,
17301,
355,
281,
7177,
198,
2,
4091,
3740,
1378,
31628,
13,
73,
377,
498,
648,
13,
2398,
14,
268,
14,
85,
16,
14,
805,
723,
14,
3849,
32186,
31113,
805,
12,
39994,
12,
18747,
198,
8818,
7308,
13,
7857,
7,
32,
3712,
51,
3902,
7680,
8,
198,
220,
220,
220,
1441,
357,
32,
13,
40927,
62,
7857,
986,
11,
7,
1136,
62,
22510,
62,
83,
2915,
7,
32,
4008,
23029,
198,
437,
198,
198,
8818,
1976,
27498,
62,
2339,
7,
32,
3712,
51,
3902,
7680,
11,
7904,
6030,
90,
51,
92,
28,
417,
4906,
7,
32,
13,
8000,
4008,
810,
1391,
51,
92,
198,
220,
220,
220,
309,
3902,
7680,
90,
51,
11,
358,
12078,
7,
32,
828,
13664,
7,
32,
13,
40927,
62,
7857,
38165,
7,
9107,
418,
7,
51,
11,
2546,
7,
32,
13,
8000,
18125,
17763,
62,
7857,
28,
32,
13,
40927,
62,
7857,
11,
17763,
62,
41007,
28,
32,
13,
40927,
62,
41007,
11,
17763,
62,
28968,
28,
32,
13,
40927,
62,
28968,
11,
14841,
62,
8367,
28,
32,
13,
15636,
62,
8367,
8,
220,
198,
437,
198,
198,
8818,
3392,
62,
2339,
7,
32,
3712,
51,
3902,
7680,
11,
7904,
6030,
90,
51,
92,
28,
417,
4906,
7,
32,
13,
8000,
4008,
810,
1391,
51,
92,
198,
220,
220,
220,
309,
3902,
7680,
90,
51,
11,
358,
12078,
7,
32,
828,
13664,
7,
32,
13,
40927,
62,
7857,
38165,
7,
1952,
7,
51,
11,
2546,
7,
32,
13,
8000,
18125,
17763,
62,
7857,
28,
32,
13,
40927,
62,
7857,
11,
17763,
62,
41007,
28,
32,
13,
40927,
62,
41007,
11,
17763,
62,
28968,
28,
32,
13,
40927,
62,
28968,
11,
14841,
62,
8367,
28,
32,
13,
15636,
62,
8367,
8,
220,
198,
437,
198,
198,
2,
5740,
326,
262,
2092,
2163,
2174,
481,
749,
286,
262,
1661,
4292,
262,
4045,
2672,
19395,
1096,
198,
8818,
7308,
13,
38610,
7,
32,
3712,
51,
3902,
7680,
11,
7904,
6030,
90,
51,
92,
28,
417,
4906,
7,
32,
13,
8000,
828,
5391,
82,
3712,
35,
12078,
28,
7857,
7,
32,
4008,
810,
1391,
51,
92,
198,
220,
220,
220,
1303,
383,
717,
399,
22715,
389,
2292,
1626,
257,
17763,
11,
262,
1218,
399,
22715,
389,
17763,
1271,
198,
220,
220,
220,
1303,
28,
399,
796,
4129,
7,
32,
13,
40927,
62,
7857,
8,
198,
220,
220,
220,
649,
62,
40927,
62,
82,
89,
796,
5391,
82,
58,
16,
25,
45,
60,
198,
220,
220,
220,
649,
62,
22510,
62,
83,
2915,
796,
5391,
82,
58,
45,
1343,
352,
25,
437,
60,
198,
220,
220,
220,
649,
62,
40927,
62,
41007,
796,
317,
13,
40927,
62,
41007,
764,
10,
649,
62,
40927,
62,
82,
89,
764,
12,
317,
13,
40927,
62,
7857,
220,
198,
220,
220,
220,
649,
62,
7295,
62,
82,
89,
796,
649,
62,
22510,
62,
83,
2915,
764,
9,
649,
62,
40927,
62,
41007,
764,
12,
317,
13,
40927,
62,
28968,
220,
1303,
1394,
262,
21721,
262,
976,
355,
878,
198,
220,
220,
220,
309,
3902,
7680,
90,
51,
11,
358,
12078,
7,
32,
828,
13664,
7,
32,
13,
40927,
62,
7857,
38165,
7,
38610,
7,
32,
13,
8000,
11,
309,
11,
649,
62,
7295,
62,
82,
89,
1776,
17763,
62,
7857,
28,
3605,
62,
40927,
62,
82,
89,
11,
17763,
62,
41007,
28,
3605,
62,
40927,
62,
41007,
11,
17763,
62,
28968,
28,
32,
13,
40927,
62,
28968,
11,
14841,
62,
8367,
28,
32,
13,
15636,
62,
8367,
8,
220,
198,
220,
220,
220,
796,
2,
220,
198,
220,
220,
220,
2092,
7,
32,
13,
8000,
11,
309,
11,
5391,
82,
8,
1303,
428,
5860,
281,
8850,
7177,
11,
475,
428,
2331,
262,
691,
835,
284,
5412,
2663,
588,
25,
616,
62,
83,
3902,
62,
18747,
58,
45299,
45299,
17,
11,
18,
60,
543,
1607,
257,
362,
35,
7177,
198,
437,
198,
2,
15690,
90,
417,
4906,
7,
32,
38165,
7,
917,
891,
11,
2546,
23029,
220,
198,
198,
2,
4064,
1731,
796,
7308,
13,
1136,
26745,
7,
32,
11,
1058,
8000,
2599,
25,
23839,
46912,
90,
43879,
2414,
92,
198,
198,
2,
15284,
262,
5726,
1864,
284,
262,
6376,
198,
2,
7308,
13,
1136,
9630,
7,
32,
3712,
15732,
24629,
19182,
90,
51,
11,
45,
5512,
314,
3712,
19852,
853,
90,
33,
11,
399,
30072,
810,
1391,
51,
11,
45,
11,
347,
92,
796,
1441,
317,
13,
8612,
1352,
7,
40,
8,
198,
198,
8818,
1426,
62,
6738,
62,
40927,
7,
32,
3712,
51,
3902,
7680,
90,
51,
11,
45,
5512,
47870,
21604,
3712,
11251,
29291,
90,
44,
11,
5317,
5512,
47870,
33111,
3712,
11251,
29291,
90,
44,
11,
5317,
30072,
810,
1391,
51,
11,
45,
11,
44,
92,
198,
220,
220,
220,
309,
29291,
7,
35103,
21604,
58,
77,
60,
532,
317,
13,
40927,
62,
28968,
58,
77,
60,
1343,
357,
35103,
33111,
58,
77,
45297,
16,
8,
1635,
317,
13,
40927,
62,
41007,
58,
77,
60,
220,
329,
299,
287,
352,
25,
44,
8,
198,
437,
198,
198,
2,
15284,
262,
5726,
1864,
284,
262,
6376,
198,
14881,
13,
31,
22930,
37861,
62,
259,
65,
3733,
2163,
7308,
13,
1136,
9630,
7,
32,
3712,
51,
3902,
7680,
90,
51,
11,
45,
11,
44,
11,
3838,
5512,
314,
3712,
19852,
853,
90,
5317,
11,
399,
92,
2599,
25,
51,
810,
1391,
51,
11,
45,
11,
44,
11,
3838,
92,
198,
220,
220,
220,
2488,
7784,
15952,
694,
2198,
65,
3733,
7,
32,
11,
314,
23029,
198,
220,
220,
220,
2488,
259,
65,
3733,
1426,
796,
357,
40,
58,
77,
60,
532,
317,
13,
40927,
62,
28968,
58,
77,
60,
1343,
357,
40,
58,
77,
10,
44,
4083,
12,
16,
8,
1635,
317,
13,
40927,
62,
41007,
58,
77,
60,
220,
329,
299,
287,
352,
25,
44,
8,
198,
220,
220,
220,
611,
7308,
13,
9122,
65,
3733,
7,
33,
970,
11,
317,
13,
8000,
11,
1426,
23029,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
7308,
13,
1136,
9630,
7,
32,
13,
8000,
11,
1426,
986,
2599,
25,
51,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
317,
13,
15636,
62,
8367,
7904,
309,
26,
220,
198,
220,
220,
220,
886,
198,
437,
198,
198,
14881,
13,
2617,
9630,
0,
7,
32,
3712,
51,
3902,
7680,
90,
51,
11,
45,
11,
44,
11,
3838,
5512,
410,
11,
314,
3712,
19852,
853,
90,
5317,
11,
45,
30072,
810,
1391,
51,
11,
45,
11,
44,
11,
3838,
92,
796,
2221,
220,
198,
220,
220,
220,
2488,
7784,
15952,
694,
2198,
65,
3733,
7,
32,
11,
314,
23029,
198,
220,
220,
220,
2488,
259,
65,
3733,
1426,
796,
357,
40,
58,
77,
60,
532,
317,
13,
40927,
62,
28968,
58,
77,
60,
1343,
357,
40,
58,
77,
10,
44,
4083,
12,
16,
8,
1635,
317,
13,
40927,
62,
41007,
58,
77,
60,
220,
329,
299,
287,
352,
25,
44,
8,
198,
220,
220,
220,
1303,
1426,
796,
47870,
21604,
764,
12,
317,
13,
40927,
62,
28968,
764,
10,
357,
35103,
33111,
7874,
16,
8,
764,
9,
317,
13,
40927,
62,
41007,
220,
198,
220,
220,
220,
611,
7308,
13,
9122,
65,
3733,
7,
33,
970,
11,
317,
13,
8000,
11,
1426,
23029,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
900,
9630,
0,
7,
32,
13,
8000,
11,
410,
11,
1426,
986,
1267,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
10385,
7,
51,
11,
15,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
2235,
2773,
5499,
329,
15453,
4465,
21502,
654,
198,
198,
37811,
198,
220,
220,
220,
651,
62,
17497,
7,
32,
3712,
51,
3902,
7680,
26,
4324,
62,
8818,
28,
17497,
62,
7637,
768,
11,
651,
62,
27237,
28,
9562,
11,
15942,
577,
28,
9562,
11,
11677,
796,
327,
2213,
9792,
1776,
198,
198,
9771,
3129,
689,
257,
4324,
12336,
284,
262,
4600,
51,
3902,
7680,
44646,
198,
198,
63,
17497,
62,
8818,
44646,
383,
4324,
2163,
355,
5447,
287,
12901,
24629,
3163,
20477,
284,
4174,
284,
262,
309,
3902,
7680,
13,
198,
464,
1255,
318,
3058,
407,
597,
2392,
257,
1570,
355,
340,
318,
10061,
703,
284,
14441,
262,
48473,
656,
257,
1570,
13,
198,
1890,
428,
1738,
262,
309,
3902,
7680,
1231,
262,
4324,
5625,
318,
635,
4504,
290,
460,
307,
973,
329,
25815,
13,
198,
3886,
4277,
257,
18042,
14353,
4324,
357,
17497,
62,
7637,
768,
8,
318,
973,
13,
1114,
772,
10620,
262,
4324,
318,
19254,
379,
262,
18253,
20435,
826,
286,
262,
3504,
2292,
357,
63,
34,
2213,
9792,
63,
737,
198,
198,
63,
1136,
62,
27237,
44646,
1052,
11902,
41146,
4578,
5086,
284,
635,
7330,
262,
3487,
1634,
3975,
329,
262,
3096,
263,
17848,
11,
543,
198,
1662,
6646,
17777,
477,
2672,
4324,
4560,
13,
554,
257,
2003,
2196,
340,
743,
307,
1744,
198,
1462,
6338,
3830,
503,
262,
4324,
278,
884,
326,
428,
1245,
460,
307,
13941,
13,
198,
198,
63,
19011,
577,
44646,
1002,
2081,
11,
23584,
1321,
319,
262,
4324,
12461,
318,
10398,
13,
198,
198,
63,
28968,
44646,
15738,
810,
262,
3641,
286,
262,
4324,
318,
4624,
13,
4091,
4600,
15732,
24629,
3163,
20477,
13,
20362,
63,
329,
3307,
13,
198,
198,
2,
16409,
198,
63,
15699,
278,
62,
17497,
44646,
257,
4324,
326,
460,
307,
5625,
284,
262,
1570,
2884,
48473,
616,
1177,
15885,
15699,
278,
62,
17497,
198,
1212,
318,
16464,
407,
2810,
355,
257,
1720,
284,
4553,
262,
3033,
3721,
935,
198,
12518,
340,
2058,
284,
3551,
1895,
13,
198,
198,
63,
11265,
1143,
44646,
691,
4504,
329,
651,
62,
27237,
28,
7942,
13,
49850,
281,
7177,
351,
262,
3487,
1634,
1321,
416,
198,
76,
5912,
262,
4324,
736,
284,
262,
2656,
1366,
13,
770,
318,
4465,
329,
17503,
5197,
286,
262,
19867,
220,
198,
292,
880,
355,
1262,
9168,
543,
466,
407,
2160,
510,
284,
530,
287,
262,
256,
4386,
1429,
13,
198,
198,
2,
21066,
198,
15506,
63,
73,
335,
38441,
395,
198,
73,
43640,
29,
1366,
796,
3392,
7,
940,
11,
940,
737,
10,
15,
13,
15,
26,
198,
73,
43640,
29,
616,
1177,
796,
309,
3902,
7680,
7,
7890,
11,
357,
20,
11,
642,
828,
357,
17,
11,
17,
18125,
198,
73,
43640,
29,
1592,
796,
651,
62,
17497,
7,
1820,
1177,
11,
15942,
577,
28,
7942,
1776,
198,
51,
2915,
351,
7078,
357,
18,
11,
513,
8,
21721,
416,
357,
17,
11,
362,
8,
17848,
13,
198,
27703,
4940,
379,
357,
15,
13,
20,
11,
657,
13,
20,
8,
290,
5645,
379,
357,
17,
13,
20,
11,
362,
13,
20,
737,
198,
198,
73,
43640,
29,
1592,
198,
20,
12906,
20,
12901,
24629,
3163,
20477,
13,
15732,
24629,
19182,
90,
43879,
2414,
11,
362,
11,
12901,
24629,
3163,
20477,
13,
7785,
1,
2,
37967,
2,
31697,
1,
90,
43879,
2414,
11,
309,
29291,
90,
43879,
2414,
11,
48436,
2414,
5512,
309,
29291,
90,
5317,
2414,
11,
2558,
2414,
5512,
309,
29291,
90,
43879,
2414,
11,
48436,
2414,
5512,
309,
29291,
90,
43879,
2414,
11,
48436,
2414,
11709,
38362,
198,
657,
13,
2999,
18444,
2791,
220,
657,
13,
11623,
220,
220,
220,
220,
657,
13,
1415,
2414,
2857,
220,
657,
13,
11623,
220,
220,
220,
220,
657,
13,
2999,
18444,
2791,
198,
657,
13,
11623,
220,
220,
220,
220,
220,
657,
13,
48524,
48096,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
48524,
48096,
220,
657,
13,
11623,
198,
657,
13,
1415,
2414,
2857,
220,
220,
657,
13,
5332,
2327,
4310,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
1415,
2414,
2857,
198,
657,
13,
11623,
220,
220,
220,
220,
220,
657,
13,
48524,
48096,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
48524,
48096,
220,
657,
13,
11623,
198,
657,
13,
2999,
18444,
2791,
220,
657,
13,
11623,
220,
220,
220,
220,
657,
13,
1415,
2414,
2857,
220,
657,
13,
11623,
220,
220,
220,
220,
657,
13,
2999,
18444,
2791,
628,
766,
309,
3902,
27703,
7680,
3419,
329,
517,
6096,
13,
198,
37811,
198,
8818,
651,
62,
17497,
7,
32,
3712,
51,
3902,
7680,
26,
4324,
62,
8818,
28,
17497,
62,
7637,
768,
11,
651,
62,
27237,
28,
9562,
11,
15942,
577,
28,
9562,
11,
11677,
28,
34,
2213,
9792,
8,
198,
220,
220,
220,
17763,
62,
7857,
796,
317,
13,
40927,
62,
7857,
198,
220,
220,
220,
17763,
62,
79,
2007,
796,
317,
13,
40927,
62,
41007,
198,
220,
220,
220,
17763,
62,
2502,
37796,
796,
17763,
62,
7857,
764,
12,
17763,
62,
79,
2007,
628,
220,
220,
220,
1592,
437,
796,
357,
40927,
62,
7857,
24457,
362,
13,
15,
8,
198,
220,
220,
220,
1592,
9688,
796,
357,
5404,
437,
764,
12,
17763,
62,
2502,
37796,
8,
198,
220,
220,
220,
611,
15942,
577,
198,
220,
220,
220,
220,
220,
220,
220,
3601,
7203,
51,
2915,
351,
7078,
720,
40927,
62,
79,
2007,
21721,
416,
720,
40927,
62,
2502,
37796,
17848,
13,
59,
77,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
3601,
7203,
27703,
4940,
379,
720,
5404,
9688,
290,
5645,
379,
720,
5404,
437,
13,
59,
77,
4943,
198,
220,
220,
220,
886,
198,
220,
220,
220,
611,
651,
62,
27237,
6624,
3991,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
4324,
62,
8818,
7,
40927,
62,
7857,
26,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5046,
28,
3351,
64,
26453,
11,
11677,
28,
28968,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4865,
62,
259,
28,
5404,
9688,
11,
4865,
62,
448,
28,
1592,
437,
8,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
616,
62,
1177,
796,
3392,
62,
2339,
7,
32,
8,
198,
220,
220,
220,
220,
220,
220,
220,
3487,
1634,
796,
317,
13,
8000,
198,
220,
220,
220,
220,
220,
220,
220,
3487,
1634,
764,
28,
657,
198,
220,
220,
220,
220,
220,
220,
220,
616,
62,
1177,
764,
47932,
317,
764,
9,
17497,
62,
8818,
7,
40927,
62,
7857,
26,
9888,
28,
3351,
64,
26453,
11,
11677,
28,
28968,
11,
4865,
62,
259,
28,
5404,
9688,
11,
4865,
62,
448,
28,
1592,
437,
8,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
17497,
62,
8818,
7,
40927,
62,
7857,
26,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5046,
28,
3351,
64,
26453,
11,
11677,
28,
28968,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4865,
62,
259,
28,
5404,
9688,
11,
4865,
62,
448,
28,
1592,
437,
828,
3487,
1634,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
8818,
309,
3902,
27703,
7680,
7,
7890,
3712,
23839,
19182,
90,
51,
11,
44,
5512,
17763,
62,
7857,
3712,
11251,
29291,
90,
44,
11,
5317,
19629,
198,
220,
220,
220,
823,
62,
2502,
37796,
3712,
11251,
29291,
90,
44,
11,
43879,
2414,
92,
28,
40927,
62,
7857,
764,
9,
15,
764,
10,
352,
13,
15,
11,
198,
220,
220,
220,
4324,
62,
8818,
28,
17497,
62,
7637,
768,
11,
651,
62,
27237,
28,
9562,
11,
15942,
577,
28,
9562,
11,
11677,
28,
34,
2213,
9792,
8,
810,
1391,
51,
11,
337,
92,
198,
198,
16719,
274,
281,
362,
45,
38517,
1570,
286,
262,
1366,
416,
256,
4386,
262,
399,
12,
19577,
1366,
355,
220,
198,
23599,
416,
17763,
62,
7857,
11,
17763,
62,
2502,
37796,
290,
42976,
17763,
62,
16159,
13,
198,
23216,
257,
4324,
318,
5625,
284,
428,
1570,
13,
1002,
262,
4324,
62,
4906,
355,
5447,
287,
198,
15732,
24629,
3163,
20477,
21784,
510,
284,
530,
11,
198,
4758,
318,
262,
1339,
329,
4324,
62,
29127,
290,
4324,
62,
7637,
768,
11,
257,
14174,
26969,
9150,
286,
262,
198,
7890,
318,
6492,
5475,
422,
1744,
4865,
3048,
13,
198,
63,
7890,
44646,
262,
5128,
7890,
284,
26969,
3455,
656,
257,
309,
3902,
7680,
13,
1400,
9088,
389,
925,
329,
262,
309,
3902,
7680,
290,
198,
1169,
8246,
1366,
460,
307,
17535,
2884,
616,
1177,
13,
8000,
13,
198,
198,
63,
40927,
62,
7857,
44646,
317,
309,
29291,
12059,
262,
2546,
286,
1123,
17763,
13,
770,
2546,
481,
1296,
262,
717,
399,
15225,
286,
262,
198,
20274,
286,
2546,
7,
1820,
1177,
737,
383,
1218,
399,
15225,
3522,
284,
399,
12,
19577,
17763,
47622,
13,
198,
198,
63,
2411,
62,
2502,
37796,
44646,
309,
29291,
31577,
262,
3585,
21721,
1022,
25175,
19867,
13,
383,
4112,
21721,
318,
788,
10488,
355,
4600,
744,
12195,
5317,
11,
40927,
62,
7857,
19571,
17,
13,
15,
764,
9,
823,
62,
2502,
37796,
8,
44646,
198,
198,
63,
17497,
62,
8818,
44646,
383,
4324,
2163,
355,
5447,
287,
12901,
24629,
3163,
20477,
284,
4174,
284,
262,
309,
3902,
7680,
13,
198,
464,
1255,
318,
3058,
407,
597,
2392,
257,
1570,
355,
340,
318,
10061,
703,
284,
14441,
262,
48473,
656,
257,
1570,
13,
198,
1890,
428,
1738,
262,
309,
3902,
7680,
1231,
262,
4324,
5625,
318,
635,
4504,
290,
460,
307,
973,
329,
25815,
13,
198,
3886,
4277,
257,
18042,
14353,
4324,
357,
17497,
62,
7637,
768,
8,
318,
973,
13,
198,
198,
63,
1136,
62,
27237,
44646,
1052,
11902,
41146,
4578,
5086,
284,
635,
7330,
262,
3487,
1634,
3975,
329,
262,
3096,
263,
17848,
11,
543,
198,
1662,
6646,
17777,
477,
2672,
4324,
4560,
13,
554,
257,
2003,
2196,
340,
743,
307,
1744,
198,
1462,
6338,
3830,
503,
262,
4324,
278,
884,
326,
428,
1245,
460,
307,
13941,
13,
198,
198,
63,
19011,
577,
44646,
1002,
2081,
11,
23584,
1321,
319,
262,
4324,
12461,
318,
10398,
13,
198,
198,
63,
28968,
44646,
15738,
810,
262,
3641,
286,
262,
4324,
318,
4624,
13,
4091,
4600,
15732,
24629,
3163,
20477,
13,
20362,
63,
329,
3307,
13,
198,
198,
2,
16409,
198,
1820,
1177,
11,
12336,
62,
17497,
796,
309,
3902,
27703,
7680,
2644,
198,
64,
309,
29291,
286,
734,
393,
1115,
357,
1136,
62,
27237,
28,
7942,
8,
351,
198,
198,
63,
1820,
1177,
44646,
262,
309,
3902,
7680,
286,
262,
1366,
1231,
262,
4324,
543,
460,
635,
307,
3194,
284,
13,
198,
198,
63,
15699,
278,
62,
17497,
44646,
257,
4324,
326,
460,
307,
5625,
284,
262,
1570,
2884,
48473,
616,
1177,
15885,
15699,
278,
62,
17497,
198,
1212,
318,
16464,
407,
2810,
355,
257,
1720,
284,
4553,
262,
3033,
3721,
935,
198,
12518,
340,
2058,
284,
3551,
1895,
13,
198,
198,
63,
11265,
1143,
44646,
691,
4504,
329,
651,
62,
27237,
28,
7942,
13,
49850,
281,
7177,
351,
262,
3487,
1634,
1321,
416,
198,
76,
5912,
262,
4324,
736,
284,
262,
2656,
1366,
13,
770,
318,
4465,
329,
17503,
5197,
286,
262,
19867,
220,
198,
292,
880,
355,
1262,
9168,
543,
466,
407,
2160,
510,
284,
530,
287,
262,
256,
4386,
1429,
13,
198,
198,
6425,
326,
340,
743,
307,
4923,
284,
3264,
1895,
262,
1570,
2884,
257,
2829,
764,
47932,
4905,
355,
198,
270,
318,
407,
5000,
1598,
11,
1771,
340,
318,
1464,
308,
4741,
2308,
326,
612,
714,
407,
307,
597,
2491,
198,
17561,
1756,
351,
1100,
12,
13564,
4560,
11,
1201,
617,
2173,
287,
262,
20717,
7177,
389,
17535,
198,
48101,
1661,
13,
1675,
3368,
884,
281,
1245,
11,
345,
460,
11,
329,
1672,
11,
691,
257,
919,
790,
1218,
17763,
1863,
1123,
15793,
198,
259,
530,
869,
13,
198,
2,
21066,
198,
15506,
63,
73,
335,
38441,
395,
198,
73,
43640,
29,
1366,
796,
3392,
7,
940,
11,
940,
737,
10,
15,
13,
15,
26,
198,
73,
43640,
29,
616,
1177,
11,
12336,
62,
17497,
796,
309,
3902,
27703,
7680,
7,
7890,
11,
357,
20,
11,
642,
1776,
19011,
577,
28,
7942,
1776,
198,
51,
2915,
351,
7078,
357,
18,
11,
513,
8,
21721,
416,
357,
17,
11,
362,
8,
17848,
13,
198,
27703,
4940,
379,
357,
15,
13,
20,
11,
657,
13,
20,
8,
290,
5645,
379,
357,
17,
13,
20,
11,
362,
13,
20,
737,
198,
73,
43640,
29,
2546,
7,
1820,
1177,
8,
198,
7,
20,
11,
642,
11,
604,
11,
604,
8,
198,
73,
43640,
29,
12336,
62,
17497,
198,
20,
12906,
20,
12901,
24629,
19182,
90,
43879,
2414,
11,
362,
11,
12901,
24629,
3163,
20477,
13,
7785,
1,
2,
19104,
2,
2167,
1,
90,
43879,
2414,
11,
309,
29291,
90,
43879,
2414,
11,
48436,
2414,
5512,
309,
29291,
90,
5317,
2414,
11,
2558,
2414,
5512,
309,
29291,
90,
43879,
2414,
11,
48436,
2414,
5512,
309,
29291,
90,
43879,
2414,
11,
48436,
2414,
11709,
38362,
198,
657,
13,
2999,
18444,
2791,
220,
657,
13,
11623,
220,
220,
220,
220,
657,
13,
1415,
2414,
2857,
220,
657,
13,
11623,
220,
220,
220,
220,
657,
13,
2999,
18444,
2791,
198,
657,
13,
11623,
220,
220,
220,
220,
220,
657,
13,
48524,
48096,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
48524,
48096,
220,
657,
13,
11623,
198,
657,
13,
1415,
2414,
2857,
220,
220,
657,
13,
5332,
2327,
4310,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
1415,
2414,
2857,
198,
657,
13,
11623,
220,
220,
220,
220,
220,
657,
13,
48524,
48096,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
48524,
48096,
220,
657,
13,
11623,
198,
657,
13,
2999,
18444,
2791,
220,
657,
13,
11623,
220,
220,
220,
220,
657,
13,
1415,
2414,
2857,
220,
657,
13,
11623,
220,
220,
220,
220,
657,
13,
2999,
18444,
2791,
198,
73,
43640,
29,
4324,
276,
796,
2824,
7,
1820,
1177,
764,
9,
12336,
62,
17497,
1776,
198,
73,
43640,
29,
616,
1177,
58,
45299,
45299,
45299,
25,
4083,
28,
15,
220,
1303,
1190,
3565,
262,
2656,
7177,
198,
73,
43640,
29,
616,
1177,
13,
8000,
198,
940,
12906,
940,
24936,
90,
43879,
2414,
38362,
198,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
198,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
198,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
198,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
198,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
198,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
198,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
198,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
198,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
198,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
220,
657,
13,
15,
198,
73,
43640,
29,
616,
1177,
764,
47932,
4324,
276,
220,
1303,
6797,
262,
4324,
276,
1366,
736,
656,
262,
7177,
198,
73,
43640,
29,
1366,
1303,
8781,
766,
611,
262,
356,
328,
9998,
9380,
2160,
284,
530,
30,
198,
940,
12906,
940,
24936,
90,
43879,
2414,
38362,
198,
657,
13,
48524,
48096,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
5332,
2327,
4310,
220,
657,
13,
5332,
2327,
4310,
198,
657,
13,
5332,
2327,
4310,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
198,
657,
13,
5332,
2327,
4310,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
198,
657,
13,
5332,
2327,
4310,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
198,
657,
13,
5332,
2327,
4310,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
198,
657,
13,
5332,
2327,
4310,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
198,
657,
13,
5332,
2327,
4310,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
198,
657,
13,
5332,
2327,
4310,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
198,
657,
13,
5332,
2327,
4310,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
198,
657,
13,
5332,
2327,
4310,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
352,
13,
15,
198,
15506,
63,
198,
2,
770,
1255,
743,
635,
307,
973,
329,
8840,
3487,
1634,
475,
460,
635,
307,
3264,
6492,
416,
198,
73,
43640,
29,
616,
1177,
11,
12336,
62,
17497,
11,
39279,
796,
309,
3902,
27703,
7680,
7,
25192,
7,
940,
11,
940,
737,
10,
15,
11,
357,
20,
11,
642,
1776,
1136,
62,
27237,
28,
7942,
1776,
198,
37811,
198,
8818,
309,
3902,
27703,
7680,
7,
7890,
3712,
23839,
19182,
90,
51,
11,
44,
5512,
17763,
62,
7857,
3712,
11251,
29291,
90,
44,
11,
5317,
19629,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
823,
62,
2502,
37796,
3712,
11251,
29291,
90,
44,
11,
43879,
2414,
92,
28,
40927,
62,
7857,
764,
9,
15,
764,
10,
352,
13,
15,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4324,
62,
8818,
28,
17497,
62,
7637,
768,
11,
651,
62,
27237,
28,
9562,
11,
15942,
577,
28,
9562,
11,
1394,
62,
16159,
28,
7942,
11,
11677,
28,
34,
2213,
9792,
8,
810,
1391,
51,
11,
337,
92,
198,
220,
220,
220,
17763,
62,
2502,
37796,
796,
2835,
12195,
5317,
11,
40927,
62,
7857,
19571,
17,
13,
15,
764,
9,
823,
62,
2502,
37796,
8,
198,
220,
220,
220,
1487,
540,
796,
309,
3902,
7680,
7,
7890,
11,
40927,
62,
7857,
11,
17763,
62,
2502,
37796,
11,
1394,
62,
16159,
28,
14894,
62,
16159,
1776,
198,
220,
220,
220,
1592,
796,
651,
62,
17497,
7,
3803,
540,
11,
4324,
62,
8818,
28,
4324,
62,
8818,
11,
651,
62,
27237,
28,
1136,
62,
27237,
11,
15942,
577,
28,
19011,
577,
11,
11677,
28,
28968,
8,
198,
220,
220,
220,
611,
651,
62,
27237,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
3803,
540,
11,
1592,
23029,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
3803,
540,
11,
1592,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
17763,
62,
1087,
364,
7,
32,
11,
5046,
28,
22366,
8,
198,
220,
220,
220,
5860,
262,
3585,
3641,
22715,
286,
18253,
17763,
10399,
351,
2461,
284,
262,
18253,
3641,
4600,
16,
764,
10,
2546,
7,
32,
8,
764,
127,
115,
362,
4600,
220,
198,
220,
220,
220,
383,
46545,
4600,
9888,
63,
318,
973,
284,
29162,
262,
3585,
2292,
351,
257,
3518,
17848,
1096,
13,
198,
220,
220,
220,
4091,
635,
25,
4600,
68,
19725,
576,
2411,
1930,
63,
329,
257,
11188,
41313,
198,
37811,
198,
8818,
17763,
62,
1087,
364,
7,
32,
11,
5046,
28,
22366,
8,
198,
220,
220,
220,
1441,
2824,
7,
68,
19725,
576,
2411,
1930,
7,
32,
11,
5046,
4008,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
1123,
40927,
2411,
1930,
7,
32,
11,
5046,
28,
22366,
8,
198,
220,
220,
220,
5860,
257,
17301,
326,
11629,
689,
832,
262,
3585,
5253,
286,
1123,
17763,
3641,
4600,
16,
764,
10,
2546,
7,
32,
737,
127,
115,
17,
63,
284,
262,
3641,
286,
262,
262,
1566,
276,
2560,
7177,
4600,
16,
764,
10,
2546,
7,
8000,
737,
127,
115,
17,
63,
220,
198,
220,
220,
220,
383,
46545,
4600,
9888,
63,
318,
973,
284,
29162,
262,
3585,
2292,
351,
257,
3518,
17848,
1096,
13,
198,
37811,
198,
8818,
1123,
40927,
2411,
1930,
7,
32,
11,
5046,
28,
22366,
8,
198,
220,
220,
220,
299,
67,
796,
299,
67,
12078,
7,
32,
20679,
17,
198,
220,
220,
220,
269,
2213,
62,
18747,
796,
357,
7857,
7,
32,
13,
8000,
8,
764,
127,
115,
362,
8,
764,
10,
352,
1303,
3641,
286,
262,
2560,
7177,
198,
220,
220,
220,
997,
62,
83,
2915,
796,
2546,
7,
32,
38381,
437,
12,
358,
10,
16,
25,
437,
60,
198,
220,
220,
220,
1303,
269,
2213,
62,
40927,
796,
357,
22510,
62,
83,
2915,
13,
127,
115,
17,
764,
10,
16,
8,
198,
220,
220,
220,
17763,
62,
24087,
796,
357,
7857,
7,
32,
38381,
16,
25,
358,
60,
764,
127,
115,
362,
8,
764,
10,
352,
198,
220,
220,
220,
611,
318,
22366,
7,
9888,
8,
198,
220,
220,
220,
220,
220,
220,
220,
357,
1930,
62,
6738,
62,
40927,
7,
32,
11,
17763,
62,
24087,
11,
309,
29291,
7,
312,
87,
4008,
764,
12,
269,
2213,
62,
18747,
329,
4686,
87,
287,
13690,
35610,
5497,
1063,
7,
22510,
62,
83,
2915,
4008,
220,
1303,
5514,
262,
12878,
1,
7716,
257,
362,
35,
7177,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
47527,
51,
29291,
7,
312,
87,
737,
12,
16,
737,
9,
317,
13,
40927,
62,
41007,
764,
10,
269,
2213,
329,
4686,
87,
287,
13690,
35610,
5497,
1063,
7,
22510,
62,
83,
2915,
15437,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
357,
9888,
764,
9,
357,
1930,
62,
6738,
62,
40927,
7,
32,
11,
17763,
62,
24087,
11,
309,
29291,
7,
312,
87,
4008,
764,
12,
269,
2213,
62,
18747,
8,
329,
4686,
87,
287,
13690,
35610,
5497,
1063,
7,
22510,
62,
83,
2915,
4008,
198,
220,
220,
220,
886,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
1123,
40927,
7,
83,
3902,
62,
1177,
3712,
51,
3902,
7680,
8,
198,
220,
220,
220,
5860,
281,
41313,
543,
11629,
689,
832,
477,
19867,
13,
23591,
319,
534,
3586,
345,
743,
635,
765,
284,
779,
198,
220,
220,
220,
4600,
83,
3902,
62,
36948,
63,
329,
257,
11282,
835,
284,
4174,
257,
2163,
284,
1123,
17763,
290,
4654,
477,
19867,
736,
1978,
13,
198,
220,
220,
220,
1002,
345,
761,
29526,
1895,
284,
262,
19867,
290,
17763,
3146,
11,
345,
460,
635,
779,
4600,
68,
19725,
346,
268,
4494,
44646,
198,
37811,
198,
8818,
1123,
40927,
7,
83,
3902,
62,
1177,
3712,
51,
3902,
7680,
8,
198,
220,
220,
220,
299,
67,
796,
299,
67,
12078,
7,
83,
3902,
62,
1177,
8,
127,
115,
17,
198,
220,
220,
220,
299,
89,
796,
14808,
7857,
7,
83,
3902,
62,
1177,
38381,
16,
25,
358,
12962,
986,
11,
40426,
7,
7857,
7,
83,
3902,
62,
1177,
38381,
358,
10,
16,
25,
437,
60,
4008,
198,
220,
220,
220,
27179,
5813,
796,
27179,
1758,
7,
83,
3902,
62,
1177,
11,
299,
89,
8,
198,
220,
220,
220,
1441,
1123,
48369,
7,
3447,
5813,
11,
5391,
82,
28,
358,
10,
16,
8,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
1123,
47163,
268,
4494,
7,
83,
3902,
62,
1177,
3712,
51,
3902,
7680,
8,
198,
220,
220,
220,
5860,
281,
41313,
11629,
803,
996,
477,
262,
17763,
3146,
13,
1002,
345,
761,
1895,
284,
262,
19867,
2405,
11,
779,
220,
198,
220,
220,
220,
4600,
68,
19725,
576,
63,
198,
37811,
198,
8818,
1123,
47163,
268,
4494,
7,
83,
3902,
62,
1177,
3712,
51,
3902,
7680,
8,
198,
220,
220,
220,
1441,
357,
51,
29291,
7,
34106,
8,
329,
256,
77,
287,
13690,
35610,
5497,
1063,
7,
1136,
62,
22510,
62,
83,
2915,
7,
83,
3902,
62,
1177,
22305,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
256,
3902,
62,
36948,
7,
83,
3902,
62,
1177,
3712,
51,
3902,
7680,
11,
277,
310,
26,
15942,
577,
28,
7942,
11,
288,
4906,
28,
417,
4906,
7,
83,
3902,
62,
1177,
13,
8000,
828,
4324,
62,
8818,
28,
17497,
62,
7637,
768,
8,
198,
220,
220,
220,
7767,
257,
8246,
27039,
1262,
256,
3902,
5009,
416,
24353,
1123,
17763,
284,
262,
2163,
4600,
69,
310,
63,
290,
35981,
262,
2482,
2884,
262,
4600,
17497,
62,
8818,
44646,
198,
37811,
198,
8818,
256,
3902,
62,
36948,
7,
83,
3902,
62,
1177,
3712,
51,
3902,
7680,
11,
277,
310,
26,
15942,
577,
28,
7942,
11,
288,
4906,
28,
417,
4906,
7,
83,
3902,
62,
1177,
13,
8000,
828,
4324,
62,
8818,
28,
17497,
62,
7637,
768,
8,
198,
220,
220,
220,
2488,
2435,
581,
796,
1976,
27498,
62,
2339,
7,
83,
3902,
62,
1177,
11,
288,
4906,
8,
198,
220,
220,
220,
581,
13,
8000,
764,
28,
6632,
7,
67,
4906,
8,
198,
220,
220,
220,
2488,
2435,
1592,
796,
651,
62,
17497,
7,
83,
3902,
62,
1177,
11,
4324,
62,
8818,
28,
17497,
62,
8818,
8,
198,
220,
220,
220,
256,
34106,
796,
651,
62,
22510,
62,
83,
2915,
7,
83,
3902,
62,
1177,
8,
198,
220,
220,
220,
329,
357,
10677,
11,
2244,
11,
256,
77,
8,
287,
19974,
7,
68,
19725,
576,
7,
83,
3902,
62,
1177,
828,
1123,
40927,
7,
411,
828,
1123,
47163,
268,
4494,
7,
411,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
611,
15942,
577,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
583,
66,
796,
2835,
7,
3064,
1635,
357,
29127,
62,
9630,
7,
34106,
11,
256,
34106,
13219,
16,
8,
24457,
40426,
7,
926,
77,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3601,
7203,
36948,
17763,
29568,
34106,
8,
503,
286,
29568,
926,
77,
828,
29568,
525,
66,
8,
4,
59,
77,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
2546,
7,
10677,
8,
198,
220,
220,
220,
220,
220,
220,
220,
581,
62,
40927,
796,
277,
310,
7,
33327,
7,
10677,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
2244,
764,
47932,
1592,
764,
9,
581,
62,
40927,
198,
220,
220,
220,
886,
220,
198,
220,
220,
220,
1441,
581,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
256,
3902,
62,
36948,
7,
7890,
11,
277,
310,
26,
15942,
577,
28,
7942,
11,
288,
4906,
28,
417,
4906,
7,
7890,
828,
4324,
62,
8818,
28,
17497,
62,
7637,
768,
8,
198,
220,
220,
220,
7767,
257,
8246,
27039,
1262,
256,
3902,
5009,
416,
24353,
1123,
17763,
284,
262,
2163,
4600,
69,
310,
63,
290,
35981,
262,
2482,
2884,
262,
4600,
17497,
62,
8818,
44646,
198,
37811,
198,
8818,
256,
3902,
62,
36948,
7,
7890,
11,
277,
310,
11,
17763,
62,
7857,
11,
17763,
62,
2502,
37796,
26,
15942,
577,
28,
7942,
11,
288,
4906,
28,
417,
4906,
7,
7890,
828,
1394,
62,
16159,
28,
9562,
11,
4324,
62,
8818,
28,
17497,
62,
7637,
768,
8,
198,
220,
220,
220,
19867,
796,
309,
3902,
7680,
7,
7890,
11,
17763,
62,
7857,
11,
17763,
62,
2502,
37796,
11,
1394,
62,
16159,
28,
14894,
62,
16159,
1776,
198,
220,
220,
220,
1441,
256,
3902,
62,
36948,
7,
83,
2915,
11,
69,
310,
26,
15942,
577,
28,
19011,
577,
11,
288,
4906,
28,
67,
4906,
11,
4324,
62,
8818,
28,
17497,
62,
8818,
8,
198,
437,
198,
198,
437,
1303,
8265,
198
] | 2.520674 | 8,126 |
@everywhere function extForm(td, ωd, inheritData, baseProb, τ, Δt, T, fData, bData, dData, pDistr,coneBool = false)
# extensive formulation could not have variable/constraint names
# inheritData: [1]: sp, [2]: w, [3]: u (only contains the information for the linking time period)
println("========= Disruption time $(td), scenario $(ωd) modeling =========");
# precalculate data
Rdict = Dict();
Xdict = Dict();
for k in fData.brList
Rdict[k] = fData.g[k]/(fData.g[k]^2 + fData.b[k]^2);
Xdict[k] = -fData.b[k]/(fData.g[k]^2 + fData.b[k]^2);
end
Ω = [ω for ω in keys(pDistr.ωDistrn)];
Bparams = Dict();
for t in td:T
# create B parameters
for k in fData.brList
# if the line is disrupted and it is within disruption time
if (((k[1],k[2]) == ωd)|((k[2],k[1]) == ωd))&(t <= td + τ)
Bparams[k,t] = 0;
else
Bparams[k,t] = 1;
end
end
for i in fData.genIDList
if (i == ωd)&(t <= td + τ)
Bparams[i,t] = 0;
else
Bparams[i,t] = 1;
end
end
end
# set up the variables
spDict = Dict();
sqDict = Dict();
for i in fData.genIDList
for t in (td - 1):T
spDict[i,t] = @variable(mExt, lowerbound = fData.Pmin[i], upperbound = fData.Pmax[i], basename="sp_$(td)_$(i)_$(t)");
sqDict[i,t] = @variable(mExt, lowerbound = fData.Qmin[i], upperbound = fData.Qmax[i], basename="sq_$(td)_$(i)_$(t)");
end
end
sphatsum = Dict();
for t in td:T
for i in fData.IDList
sphatsum[i,t] = @expression(mExt,0.0);
if i in keys(fData.LocRev)
for j in fData.LocRev[i]
sphatsum[i,t] += spDict[j,t];
end
end
end
end
sqhatsum = Dict();
for t in td:T
for i in fData.IDList
sqhatsum[i,t] = @expression(mExt,0.0);
if i in keys(fData.LocRev)
for j in fData.LocRev[i]
sqhatsum[i,t] += sqDict[j,t];
end
end
end
end
pDict = Dict();
qDict = Dict();
vDict = Dict();
wDict = Dict();
yDict = Dict();
zpDict = Dict();
zqDict = Dict();
lppDict = Dict();
lqpDict = Dict();
lpmDict = Dict();
lqmDict = Dict();
uDict = Dict();
fsDict = Dict();
for k in fData.brList
for t in td:T
pDict[k,t] = @variable(mExt, basename="p_$(td)_$(k)_$(t)");
qDict[k,t] = @variable(mExt, basename="q_$(td)_$(k)_$(t)");
end
end
for i in fData.IDList
for t in td:T
vDict[i,t] = @variable(mExt, lowerbound = fData.Vmin[i]^2, upperbound = fData.Vmax[i]^2, basename="v_$td");
lppDict[i,t] = @variable(mExt, lowerbound = 0, basename="lpp_$(td)_$(i)_$(t)");
lqpDict[i,t] = @variable(mExt, lowerbound = 0, basename="lqp_$(td)_$(i)_$(t)");
lpmDict[i,t] = @variable(mExt, lowerbound = 0, basename="lpm_$(td)_$(i)_$(t)");
lqmDict[i,t] = @variable(mExt, lowerbound = 0, basename="lqm_$(td)_$(i)_$(t)");
end
end
for i in bData.IDList
wDict[i,td - 1] = @variable(mExt, lowerbound = 0, upperbound = bData.cap[i], basename="w_$(td)_$(i)_$(td - 1)");
uDict[i] = @variable(mExt, lowerbound = 0, upperbound = bData.uCap[i], basename="u_$(td)_$(i)");
for t in td:T
wDict[i,t] = @variable(mExt, lowerbound = 0, upperbound = bData.cap[i], basename="w_$(td)_$(i)_$(t)");
yDict[i,t] = @variable(mExt, basename="y_$(td)_$(i)_$(t)");
zpDict[i,t] = @variable(mExt, basename="zp_$(td)_$(i)_$(t)");
zqDict[i,t] = @variable(mExt, basename="zq_$(td)_$(i)_$(t)");
end
end
# set up the constraints
for i in fData.IDList
for t in td:T
@constraint(mExt, sum(zpDict[b,t] for b in bData.IDList if bData.Loc[b] == i) + lppDict[i,t] - lpmDict[i,t] +
sphatsum[i,t] - dData.pd[i][t] == sum(pDict[k,t] for k in fData.branchDict1[i]));
@constraint(mExt, sum(zqDict[b,t] for b in bData.IDList if bData.Loc[b] == i) + lqpDict[i,t] - lqmDict[i,t] +
sqhatsum[i,t] - dData.qd[i][t] == sum(qDict[k,t] for k in fData.branchDict1[i]));
end
end
for i in fData.genIDList
if td != 1
@constraint(mExt, spDict[i,td - 1] == inheritData[1][i]);
end
for t in td:T
if (t != 1)&(Bparams[i,t] == 1)
@constraint(mExt, spDict[i,t] - spDict[i,t - 1] <= fData.RU[i]);
@constraint(mExt, spDict[i,t] - spDict[i,t - 1] >= fData.RD[i]);
end
if Bparams[i,t] == 0
@constraint(mExt, spDict[i,t] == 0);
@constraint(mExt, sqDict[i,t] == 0);
end
end
end
for k in fData.brList
for t in td:T
@constraint(mExt, pDict[k,t] == -pDict[(k[2],k[1],k[3]),t]);
@constraint(mExt, qDict[k,t] == -qDict[(k[2],k[1],k[3]),t]);
if Bparams[k,t] == 1
if coneBool
@constraint(mExt, norm([pDict[k,t],qDict[k,t]]) <= fData.rateA[k]);
else
@constraint(mExt, pDict[k,t]^2 + qDict[k,t]^2 <= fData.rateA[k]^2);
end
@constraint(mExt, vDict[k[2],t] == vDict[k[1],t] - 2*(Rdict[k]*pDict[k,t] + Xdict[k]*qDict[k,t]));
else
@constraint(mExt, pDict[k,t] == 0);
@constraint(mExt, qDict[k,t] == 0);
end
end
end
for i in bData.IDList
if td != 1
@constraint(mExt, uDict[i] == inheritData[3][i]);
end
@constraint(mExt, wDict[i,td - 1] == inheritData[2][i]);
for t in td:T
@constraint(mExt, wDict[i,t] == wDict[i,t - 1] - yDict[i,t]*Δt);
if coneBool
@constraint(mExt, norm([zpDict[i,t],zqDict[i,t]]) <= uDict[i]);
else
@constraint(mExt, zpDict[i,t]^2 + zqDict[i,t]^2 <= uDict[i]^2);
end
for l in 1:length(bData.ηα[i])
@constraint(mExt, zpDict[i,t] <= bData.ηα[i][l]*yDict[i,t] + bData.ηβ[i][l]);
end
@constraint(mExt, wDict[i,t] <= bData.cap[i]);
end
end
# recursion through the possible scenario
tList = sort([t for t in keys(pDistr.tDistrn)]);
objExpr = getobjective(mExt);
if td == 1
objExpr += sum(bData.cost[i]*uDict[i] for i in bData.IDList);
# only the first pass will execute this
end
for tp in tList
if td == 1
if td + tp > T
# if the next disruption is over the time horizon
dExpr = fData.cz*sum(sum(lppDict[i,t] + lqpDict[i,t] + lpmDict[i,t] + lqmDict[i,t] for i in fData.IDList) for t in td:T);
for t in td:T
for i in fData.genIDList
# add generator cost
if fData.cp[i].n == 3
if coneBool
fsDict[i,t] = @variable(mExt, lowerbound = 0, basename = "fs_$(td)_$(i)_$(t)");
dExpr += fData.cp[i].params[1]*fsDict[i,t] + fData.cp[i].params[2]*spDict[i,t];
@constraint(mExt, norm([spDict[i,t],fsDict[i,t] - 1/4]) <= fsDict[i,t] + 1/4);
else
dExpr += fData.cp[i].params[1]*(spDict[i,t]^2) + fData.cp[i].params[2]*spDict[i,t];
end
elseif fData.cp[i].n == 2
dExpr += fData.cp[i].params[1]*spDict[i,t];
end
end
end
objExpr += baseProb*pDistr.tDistrn[tp]*dExpr;
@objective(mExt, Min, objExpr);
else
# if not
dExpr = fData.cz*sum(sum(lppDict[i,t] + lqpDict[i,t] + lpmDict[i,t] + lqmDict[i,t] for i in fData.IDList) for t in td:(td + tp - 1));
for t in td:(td + tp - 1)
for i in fData.genIDList
# add generator cost
if fData.cp[i].n == 3
if coneBool
fsDict[i,t] = @variable(mExt, lowerbound = 0, basename = "fs_$(td)_$(i)_$(t)");
dExpr += fData.cp[i].params[1]*fsDict[i,t] + fData.cp[i].params[2]*spDict[i,t];
@constraint(mExt, norm([spDict[i,t],fsDict[i,t] - 1/4]) <= fsDict[i,t] + 1/4);
else
dExpr += fData.cp[i].params[1]*(spDict[i,t]^2) + fData.cp[i].params[2]*spDict[i,t];
end
elseif fData.cp[i].n == 2
dExpr += fData.cp[i].params[1]*spDict[i,t];
end
end
end
for ω in Ω
objExpr += baseProb*pDistr.tDistrn[tp]*pDistr.ωDistrn[ω]*dExpr;
spInherit = Dict();
wInherit = Dict();
uInherit = Dict();
for i in fData.genIDList
spInherit[i] = spDict[i,td + tp - 1];
end
for i in bData.IDList
wInherit[i] = wDict[i,td + tp - 1];
uInherit[i] = uDict[i];
end
inheritData = [spInherit,wInherit,uInherit];
@objective(mExt, Min, objExpr);
# println("=========================",1," ",td," ",tp,"=========================");
# println(mExt.obj);
global mExt = extForm(td + tp, ω, inheritData, baseProb*pDistr.tDistrn[tp]*pDistr.ωDistrn[ω], τ, Δt, T, fData, bData, dData, pDistr, coneBool);
# println("=========================",11," ",td," ",tp,"=========================");
# println(mExt.obj);
objExpr = getobjective(mExt);
end
end
else
if td + τ + tp > T
# if the next disruption is over the time horizon
# add to the objective function
dExpr = fData.cz*sum(sum(lppDict[i,t] + lqpDict[i,t] + lpmDict[i,t] + lqmDict[i,t] for i in fData.IDList) for t in td:T);
for t in td:T
for i in fData.genIDList
# add generator cost
if fData.cp[i].n == 3
if coneBool
fsDict[i,t] = @variable(mExt, lowerbound = 0, basename = "fs_$(td)_$(i)_$(t)");
dExpr += fData.cp[i].params[1]*fsDict[i,t] + fData.cp[i].params[2]*spDict[i,t];
@constraint(mExt, norm([spDict[i,t],fsDict[i,t] - 1/4]) <= fsDict[i,t] + 1/4);
else
dExpr += fData.cp[i].params[1]*(spDict[i,t]^2) + fData.cp[i].params[2]*spDict[i,t];
end
elseif fData.cp[i].n == 2
dExpr += fData.cp[i].params[1]*spDict[i,t];
end
end
end
objExpr += baseProb*pDistr.tDistrn[tp]*dExpr;
@objective(mExt, Min, objExpr);
else
# if not
# add the current part to the objective function
# recursion to the next disruption
dExpr = fData.cz*sum(sum(lppDict[i,t] + lqpDict[i,t] + lpmDict[i,t] + lqmDict[i,t] for i in fData.IDList) for t in td:(td + tp + τ - 1));
for t in td:(td + tp + τ - 1)
for i in fData.genIDList
# add generator cost
if fData.cp[i].n == 3
if coneBool
fsDict[i,t] = @variable(mExt, lowerbound = 0, basename = "fs_$(td)_$(i)_$(t)");
dExpr += fData.cp[i].params[1]*fsDict[i,t] + fData.cp[i].params[2]*spDict[i,t];
@constraint(mExt, norm([spDict[i,t],fsDict[i,t] - 1/4]) <= fsDict[i,t] + 1/4);
else
dExpr += fData.cp[i].params[1]*(spDict[i,t]^2) + fData.cp[i].params[2]*spDict[i,t];
end
elseif fData.cp[i].n == 2
dExpr += fData.cp[i].params[1]*spDict[i,t];
end
end
end
for ω in Ω
objExpr += baseProb*pDistr.tDistrn[tp]*pDistr.ωDistrn[ω]*dExpr;
spInherit = Dict();
wInherit = Dict();
uInherit = Dict();
for i in fData.genIDList
spInherit[i] = spDict[i,td + tp + τ - 1];
end
for i in bData.IDList
wInherit[i] = wDict[i,td + tp + τ - 1];
uInherit[i] = uDict[i];
end
inheritData = [spInherit,wInherit,uInherit];
@objective(mExt, Min, objExpr);
# println("=========================",2," ",td," ",tp,"=========================");
# println(mExt.obj);
global mExt = extForm(td + tp + τ, ω, inheritData, baseProb*pDistr.tDistrn[tp]*pDistr.ωDistrn[ω], τ, Δt, T, fData, bData, dData, pDistr, coneBool);
# println("=========================",22," ",td," ",tp,"=========================");
# println(mExt.obj);
objExpr = getobjective(mExt);
end
end
end
end
return mExt;
end
| [
31,
16833,
3003,
2163,
1070,
8479,
7,
8671,
11,
18074,
231,
67,
11,
16955,
6601,
11,
2779,
2964,
65,
11,
46651,
11,
37455,
83,
11,
309,
11,
277,
6601,
11,
275,
6601,
11,
288,
6601,
11,
279,
20344,
81,
11,
49180,
33,
970,
796,
3991,
8,
198,
220,
220,
220,
1303,
7667,
31760,
714,
407,
423,
7885,
14,
1102,
2536,
2913,
3891,
198,
220,
220,
220,
1303,
16955,
6601,
25,
685,
16,
5974,
599,
11,
685,
17,
5974,
266,
11,
685,
18,
5974,
334,
357,
8807,
4909,
262,
1321,
329,
262,
17795,
640,
2278,
8,
628,
220,
220,
220,
44872,
7203,
2559,
28,
3167,
6417,
640,
29568,
8671,
828,
8883,
29568,
49535,
67,
8,
21128,
796,
2559,
15341,
198,
220,
220,
220,
1303,
3718,
282,
3129,
378,
1366,
198,
220,
220,
220,
371,
11600,
796,
360,
713,
9783,
198,
220,
220,
220,
1395,
11600,
796,
360,
713,
9783,
198,
220,
220,
220,
329,
479,
287,
277,
6601,
13,
1671,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
371,
11600,
58,
74,
60,
796,
277,
6601,
13,
70,
58,
74,
60,
29006,
69,
6601,
13,
70,
58,
74,
60,
61,
17,
1343,
277,
6601,
13,
65,
58,
74,
60,
61,
17,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
1395,
11600,
58,
74,
60,
796,
532,
69,
6601,
13,
65,
58,
74,
60,
29006,
69,
6601,
13,
70,
58,
74,
60,
61,
17,
1343,
277,
6601,
13,
65,
58,
74,
60,
61,
17,
1776,
198,
220,
220,
220,
886,
198,
220,
220,
220,
7377,
102,
796,
685,
49535,
329,
18074,
231,
287,
8251,
7,
79,
20344,
81,
13,
49535,
20344,
35906,
8,
11208,
198,
220,
220,
220,
347,
37266,
796,
360,
713,
9783,
198,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
2251,
347,
10007,
198,
220,
220,
220,
220,
220,
220,
220,
329,
479,
287,
277,
6601,
13,
1671,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
611,
262,
1627,
318,
30067,
290,
340,
318,
1626,
19911,
640,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
14808,
7,
74,
58,
16,
4357,
74,
58,
17,
12962,
6624,
18074,
231,
67,
14726,
19510,
74,
58,
17,
4357,
74,
58,
16,
12962,
6624,
18074,
231,
67,
4008,
5,
7,
83,
19841,
41560,
1343,
46651,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
347,
37266,
58,
74,
11,
83,
60,
796,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
347,
37266,
58,
74,
11,
83,
60,
796,
352,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
5235,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
357,
72,
6624,
18074,
231,
67,
8,
5,
7,
83,
19841,
41560,
1343,
46651,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
347,
37266,
58,
72,
11,
83,
60,
796,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
347,
37266,
58,
72,
11,
83,
60,
796,
352,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
900,
510,
262,
9633,
198,
220,
220,
220,
599,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
19862,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
5235,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
357,
8671,
532,
352,
2599,
51,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
599,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
277,
6601,
13,
47,
1084,
58,
72,
4357,
220,
6727,
7784,
796,
277,
6601,
13,
47,
9806,
58,
72,
4357,
1615,
12453,
2625,
2777,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
19862,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
277,
6601,
13,
48,
1084,
58,
72,
4357,
220,
6727,
7784,
796,
277,
6601,
13,
48,
9806,
58,
72,
4357,
1615,
12453,
2625,
31166,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
599,
71,
1381,
388,
796,
360,
713,
9783,
198,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
599,
71,
1381,
388,
58,
72,
11,
83,
60,
796,
2488,
38011,
7,
76,
11627,
11,
15,
13,
15,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
1312,
287,
8251,
7,
69,
6601,
13,
33711,
18009,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
474,
287,
277,
6601,
13,
33711,
18009,
58,
72,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
599,
71,
1381,
388,
58,
72,
11,
83,
60,
15853,
599,
35,
713,
58,
73,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
19862,
71,
1381,
388,
796,
360,
713,
9783,
198,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
19862,
71,
1381,
388,
58,
72,
11,
83,
60,
796,
2488,
38011,
7,
76,
11627,
11,
15,
13,
15,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
1312,
287,
8251,
7,
69,
6601,
13,
33711,
18009,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
474,
287,
277,
6601,
13,
33711,
18009,
58,
72,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
19862,
71,
1381,
388,
58,
72,
11,
83,
60,
15853,
19862,
35,
713,
58,
73,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
279,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
10662,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
410,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
266,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
331,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
1976,
79,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
1976,
80,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
300,
381,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
300,
80,
79,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
300,
4426,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
300,
80,
76,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
334,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
43458,
35,
713,
796,
360,
713,
9783,
198,
220,
220,
220,
329,
479,
287,
277,
6601,
13,
1671,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
279,
35,
713,
58,
74,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
1615,
12453,
2625,
79,
62,
3,
7,
8671,
8,
62,
3,
7,
74,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10662,
35,
713,
58,
74,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
1615,
12453,
2625,
80,
62,
3,
7,
8671,
8,
62,
3,
7,
74,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
410,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
277,
6601,
13,
53,
1084,
58,
72,
60,
61,
17,
11,
6727,
7784,
796,
277,
6601,
13,
53,
9806,
58,
72,
60,
61,
17,
11,
1615,
12453,
2625,
85,
62,
3,
8671,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
300,
381,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
657,
11,
1615,
12453,
2625,
75,
381,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
300,
80,
79,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
657,
11,
1615,
12453,
2625,
75,
80,
79,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
300,
4426,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
657,
11,
1615,
12453,
2625,
75,
4426,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
300,
80,
76,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
657,
11,
1615,
12453,
2625,
75,
80,
76,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
329,
1312,
287,
275,
6601,
13,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
266,
35,
713,
58,
72,
11,
8671,
532,
352,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
657,
11,
6727,
7784,
796,
275,
6601,
13,
11128,
58,
72,
4357,
1615,
12453,
2625,
86,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
8671,
532,
352,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
334,
35,
713,
58,
72,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
657,
11,
6727,
7784,
796,
275,
6601,
13,
84,
15610,
58,
72,
4357,
1615,
12453,
2625,
84,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
266,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
657,
11,
6727,
7784,
796,
275,
6601,
13,
11128,
58,
72,
4357,
1615,
12453,
2625,
86,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
331,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
1615,
12453,
2625,
88,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
79,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
1615,
12453,
2625,
89,
79,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
80,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
1615,
12453,
2625,
89,
80,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
900,
510,
262,
17778,
198,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
2160,
7,
89,
79,
35,
713,
58,
65,
11,
83,
60,
329,
275,
287,
275,
6601,
13,
2389,
8053,
611,
275,
6601,
13,
33711,
58,
65,
60,
6624,
1312,
8,
1343,
300,
381,
35,
713,
58,
72,
11,
83,
60,
532,
300,
4426,
35,
713,
58,
72,
11,
83,
60,
1343,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
599,
71,
1381,
388,
58,
72,
11,
83,
60,
532,
288,
6601,
13,
30094,
58,
72,
7131,
83,
60,
6624,
2160,
7,
79,
35,
713,
58,
74,
11,
83,
60,
329,
479,
287,
277,
6601,
13,
1671,
3702,
35,
713,
16,
58,
72,
12962,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
2160,
7,
89,
80,
35,
713,
58,
65,
11,
83,
60,
329,
275,
287,
275,
6601,
13,
2389,
8053,
611,
275,
6601,
13,
33711,
58,
65,
60,
6624,
1312,
8,
1343,
300,
80,
79,
35,
713,
58,
72,
11,
83,
60,
532,
300,
80,
76,
35,
713,
58,
72,
11,
83,
60,
1343,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
19862,
71,
1381,
388,
58,
72,
11,
83,
60,
532,
288,
6601,
13,
80,
67,
58,
72,
7131,
83,
60,
6624,
2160,
7,
80,
35,
713,
58,
74,
11,
83,
60,
329,
479,
287,
277,
6601,
13,
1671,
3702,
35,
713,
16,
58,
72,
12962,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
5235,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
611,
41560,
14512,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
599,
35,
713,
58,
72,
11,
8671,
532,
352,
60,
6624,
16955,
6601,
58,
16,
7131,
72,
36563,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
357,
83,
14512,
352,
8,
5,
7,
33,
37266,
58,
72,
11,
83,
60,
6624,
352,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
599,
35,
713,
58,
72,
11,
83,
60,
532,
599,
35,
713,
58,
72,
11,
83,
532,
352,
60,
19841,
277,
6601,
13,
49,
52,
58,
72,
36563,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
599,
35,
713,
58,
72,
11,
83,
60,
532,
599,
35,
713,
58,
72,
11,
83,
532,
352,
60,
18189,
277,
6601,
13,
35257,
58,
72,
36563,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
347,
37266,
58,
72,
11,
83,
60,
6624,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
599,
35,
713,
58,
72,
11,
83,
60,
6624,
657,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
19862,
35,
713,
58,
72,
11,
83,
60,
6624,
657,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
329,
479,
287,
277,
6601,
13,
1671,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
279,
35,
713,
58,
74,
11,
83,
60,
6624,
532,
79,
35,
713,
58,
7,
74,
58,
17,
4357,
74,
58,
16,
4357,
74,
58,
18,
46570,
83,
36563,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
10662,
35,
713,
58,
74,
11,
83,
60,
6624,
532,
80,
35,
713,
58,
7,
74,
58,
17,
4357,
74,
58,
16,
4357,
74,
58,
18,
46570,
83,
36563,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
347,
37266,
58,
74,
11,
83,
60,
6624,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
27763,
33,
970,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
2593,
26933,
79,
35,
713,
58,
74,
11,
83,
4357,
80,
35,
713,
58,
74,
11,
83,
11907,
8,
19841,
277,
6601,
13,
4873,
32,
58,
74,
36563,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
279,
35,
713,
58,
74,
11,
83,
60,
61,
17,
1343,
10662,
35,
713,
58,
74,
11,
83,
60,
61,
17,
19841,
277,
6601,
13,
4873,
32,
58,
74,
60,
61,
17,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
410,
35,
713,
58,
74,
58,
17,
4357,
83,
60,
6624,
410,
35,
713,
58,
74,
58,
16,
4357,
83,
60,
532,
362,
9,
7,
49,
11600,
58,
74,
60,
9,
79,
35,
713,
58,
74,
11,
83,
60,
1343,
1395,
11600,
58,
74,
60,
9,
80,
35,
713,
58,
74,
11,
83,
12962,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
279,
35,
713,
58,
74,
11,
83,
60,
6624,
657,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
10662,
35,
713,
58,
74,
11,
83,
60,
6624,
657,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
329,
1312,
287,
275,
6601,
13,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
611,
41560,
14512,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
334,
35,
713,
58,
72,
60,
6624,
16955,
6601,
58,
18,
7131,
72,
36563,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
266,
35,
713,
58,
72,
11,
8671,
532,
352,
60,
6624,
16955,
6601,
58,
17,
7131,
72,
36563,
198,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
266,
35,
713,
58,
72,
11,
83,
60,
6624,
266,
35,
713,
58,
72,
11,
83,
532,
352,
60,
532,
331,
35,
713,
58,
72,
11,
83,
60,
9,
138,
242,
83,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
27763,
33,
970,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
2593,
26933,
89,
79,
35,
713,
58,
72,
11,
83,
4357,
89,
80,
35,
713,
58,
72,
11,
83,
11907,
8,
19841,
334,
35,
713,
58,
72,
36563,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
1976,
79,
35,
713,
58,
72,
11,
83,
60,
61,
17,
1343,
1976,
80,
35,
713,
58,
72,
11,
83,
60,
61,
17,
19841,
334,
35,
713,
58,
72,
60,
61,
17,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
300,
287,
352,
25,
13664,
7,
65,
6601,
13,
138,
115,
17394,
58,
72,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
1976,
79,
35,
713,
58,
72,
11,
83,
60,
19841,
275,
6601,
13,
138,
115,
17394,
58,
72,
7131,
75,
60,
9,
88,
35,
713,
58,
72,
11,
83,
60,
1343,
275,
6601,
13,
138,
115,
26638,
58,
72,
7131,
75,
36563,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
266,
35,
713,
58,
72,
11,
83,
60,
19841,
275,
6601,
13,
11128,
58,
72,
36563,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
664,
24197,
832,
262,
1744,
8883,
198,
220,
220,
220,
256,
8053,
796,
3297,
26933,
83,
329,
256,
287,
8251,
7,
79,
20344,
81,
13,
83,
20344,
35906,
15437,
1776,
198,
220,
220,
220,
26181,
3109,
1050,
796,
651,
15252,
425,
7,
76,
11627,
1776,
198,
220,
220,
220,
611,
41560,
6624,
352,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
3109,
1050,
15853,
2160,
7,
65,
6601,
13,
15805,
58,
72,
60,
9,
84,
35,
713,
58,
72,
60,
329,
1312,
287,
275,
6601,
13,
2389,
8053,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
691,
262,
717,
1208,
481,
12260,
428,
198,
220,
220,
220,
886,
198,
220,
220,
220,
329,
256,
79,
287,
256,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
611,
41560,
6624,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
41560,
1343,
256,
79,
1875,
309,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
611,
262,
1306,
19911,
318,
625,
262,
640,
17810,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
796,
277,
6601,
13,
26691,
9,
16345,
7,
16345,
7,
75,
381,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
80,
79,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
4426,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
80,
76,
35,
713,
58,
72,
11,
83,
60,
329,
1312,
287,
277,
6601,
13,
2389,
8053,
8,
329,
256,
287,
41560,
25,
51,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
5235,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
751,
17301,
1575,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
277,
6601,
13,
13155,
58,
72,
4083,
77,
6624,
513,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
27763,
33,
970,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
43458,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
657,
11,
1615,
12453,
796,
366,
9501,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
9501,
35,
713,
58,
72,
11,
83,
60,
1343,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
17,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
2593,
26933,
2777,
35,
713,
58,
72,
11,
83,
4357,
9501,
35,
713,
58,
72,
11,
83,
60,
532,
352,
14,
19,
12962,
19841,
43458,
35,
713,
58,
72,
11,
83,
60,
1343,
352,
14,
19,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
7,
2777,
35,
713,
58,
72,
11,
83,
60,
61,
17,
8,
1343,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
17,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
361,
277,
6601,
13,
13155,
58,
72,
4083,
77,
6624,
362,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
26181,
3109,
1050,
15853,
2779,
2964,
65,
9,
79,
20344,
81,
13,
83,
20344,
35906,
58,
34788,
60,
9,
67,
3109,
1050,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
15252,
425,
7,
76,
11627,
11,
1855,
11,
26181,
3109,
1050,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
611,
407,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
796,
277,
6601,
13,
26691,
9,
16345,
7,
16345,
7,
75,
381,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
80,
79,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
4426,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
80,
76,
35,
713,
58,
72,
11,
83,
60,
329,
1312,
287,
277,
6601,
13,
2389,
8053,
8,
329,
256,
287,
41560,
37498,
8671,
1343,
256,
79,
532,
352,
18125,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
41560,
37498,
8671,
1343,
256,
79,
532,
352,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
5235,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
751,
17301,
1575,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
277,
6601,
13,
13155,
58,
72,
4083,
77,
6624,
513,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
27763,
33,
970,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
43458,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
657,
11,
1615,
12453,
796,
366,
9501,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
9501,
35,
713,
58,
72,
11,
83,
60,
1343,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
17,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
2593,
26933,
2777,
35,
713,
58,
72,
11,
83,
4357,
9501,
35,
713,
58,
72,
11,
83,
60,
532,
352,
14,
19,
12962,
19841,
43458,
35,
713,
58,
72,
11,
83,
60,
1343,
352,
14,
19,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
7,
2777,
35,
713,
58,
72,
11,
83,
60,
61,
17,
8,
1343,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
17,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
361,
277,
6601,
13,
13155,
58,
72,
4083,
77,
6624,
362,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
18074,
231,
287,
7377,
102,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
26181,
3109,
1050,
15853,
2779,
2964,
65,
9,
79,
20344,
81,
13,
83,
20344,
35906,
58,
34788,
60,
9,
79,
20344,
81,
13,
49535,
20344,
35906,
58,
49535,
60,
9,
67,
3109,
1050,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
599,
818,
372,
270,
796,
360,
713,
9783,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
266,
818,
372,
270,
796,
360,
713,
9783,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
818,
372,
270,
796,
360,
713,
9783,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
5235,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
599,
818,
372,
270,
58,
72,
60,
796,
599,
35,
713,
58,
72,
11,
8671,
1343,
256,
79,
532,
352,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
275,
6601,
13,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
266,
818,
372,
270,
58,
72,
60,
796,
266,
35,
713,
58,
72,
11,
8671,
1343,
256,
79,
532,
352,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
818,
372,
270,
58,
72,
60,
796,
334,
35,
713,
58,
72,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
16955,
6601,
796,
685,
2777,
818,
372,
270,
11,
86,
818,
372,
270,
11,
84,
818,
372,
270,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
15252,
425,
7,
76,
11627,
11,
1855,
11,
26181,
3109,
1050,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
44872,
7203,
4770,
2559,
28,
1600,
16,
553,
33172,
8671,
553,
33172,
34788,
553,
4770,
2559,
2625,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
44872,
7,
76,
11627,
13,
26801,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3298,
285,
11627,
796,
1070,
8479,
7,
8671,
1343,
256,
79,
11,
18074,
231,
11,
16955,
6601,
11,
2779,
2964,
65,
9,
79,
20344,
81,
13,
83,
20344,
35906,
58,
34788,
60,
9,
79,
20344,
81,
13,
49535,
20344,
35906,
58,
49535,
4357,
46651,
11,
37455,
83,
11,
309,
11,
277,
6601,
11,
275,
6601,
11,
288,
6601,
11,
279,
20344,
81,
11,
27763,
33,
970,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
44872,
7203,
4770,
2559,
28,
1600,
1157,
553,
33172,
8671,
553,
33172,
34788,
553,
4770,
2559,
2625,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
44872,
7,
76,
11627,
13,
26801,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
26181,
3109,
1050,
796,
651,
15252,
425,
7,
76,
11627,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
41560,
1343,
46651,
1343,
256,
79,
1875,
309,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
611,
262,
1306,
19911,
318,
625,
262,
640,
17810,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
751,
284,
262,
9432,
2163,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
796,
277,
6601,
13,
26691,
9,
16345,
7,
16345,
7,
75,
381,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
80,
79,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
4426,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
80,
76,
35,
713,
58,
72,
11,
83,
60,
329,
1312,
287,
277,
6601,
13,
2389,
8053,
8,
329,
256,
287,
41560,
25,
51,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
41560,
25,
51,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
5235,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
751,
17301,
1575,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
277,
6601,
13,
13155,
58,
72,
4083,
77,
6624,
513,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
27763,
33,
970,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
43458,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
657,
11,
1615,
12453,
796,
366,
9501,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
9501,
35,
713,
58,
72,
11,
83,
60,
1343,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
17,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
2593,
26933,
2777,
35,
713,
58,
72,
11,
83,
4357,
9501,
35,
713,
58,
72,
11,
83,
60,
532,
352,
14,
19,
12962,
19841,
43458,
35,
713,
58,
72,
11,
83,
60,
1343,
352,
14,
19,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
7,
2777,
35,
713,
58,
72,
11,
83,
60,
61,
17,
8,
1343,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
17,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
361,
277,
6601,
13,
13155,
58,
72,
4083,
77,
6624,
362,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
26181,
3109,
1050,
15853,
2779,
2964,
65,
9,
79,
20344,
81,
13,
83,
20344,
35906,
58,
34788,
60,
9,
67,
3109,
1050,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
15252,
425,
7,
76,
11627,
11,
1855,
11,
26181,
3109,
1050,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
611,
407,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
751,
262,
1459,
636,
284,
262,
9432,
2163,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
664,
24197,
284,
262,
1306,
19911,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
796,
277,
6601,
13,
26691,
9,
16345,
7,
16345,
7,
75,
381,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
80,
79,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
4426,
35,
713,
58,
72,
11,
83,
60,
1343,
300,
80,
76,
35,
713,
58,
72,
11,
83,
60,
329,
1312,
287,
277,
6601,
13,
2389,
8053,
8,
329,
256,
287,
41560,
37498,
8671,
1343,
256,
79,
1343,
46651,
532,
352,
18125,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
256,
287,
41560,
37498,
8671,
1343,
256,
79,
1343,
46651,
532,
352,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
5235,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
751,
17301,
1575,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
277,
6601,
13,
13155,
58,
72,
4083,
77,
6624,
513,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
27763,
33,
970,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
43458,
35,
713,
58,
72,
11,
83,
60,
796,
2488,
45286,
7,
76,
11627,
11,
2793,
7784,
796,
657,
11,
1615,
12453,
796,
366,
9501,
62,
3,
7,
8671,
8,
62,
3,
7,
72,
8,
62,
3,
7,
83,
8,
15341,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
9501,
35,
713,
58,
72,
11,
83,
60,
1343,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
17,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
1102,
2536,
2913,
7,
76,
11627,
11,
2593,
26933,
2777,
35,
713,
58,
72,
11,
83,
4357,
9501,
35,
713,
58,
72,
11,
83,
60,
532,
352,
14,
19,
12962,
19841,
43458,
35,
713,
58,
72,
11,
83,
60,
1343,
352,
14,
19,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
7,
2777,
35,
713,
58,
72,
11,
83,
60,
61,
17,
8,
1343,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
17,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
361,
277,
6601,
13,
13155,
58,
72,
4083,
77,
6624,
362,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
3109,
1050,
15853,
277,
6601,
13,
13155,
58,
72,
4083,
37266,
58,
16,
60,
9,
2777,
35,
713,
58,
72,
11,
83,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
18074,
231,
287,
7377,
102,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
26181,
3109,
1050,
15853,
2779,
2964,
65,
9,
79,
20344,
81,
13,
83,
20344,
35906,
58,
34788,
60,
9,
79,
20344,
81,
13,
49535,
20344,
35906,
58,
49535,
60,
9,
67,
3109,
1050,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
599,
818,
372,
270,
796,
360,
713,
9783,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
266,
818,
372,
270,
796,
360,
713,
9783,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
818,
372,
270,
796,
360,
713,
9783,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
277,
6601,
13,
5235,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
599,
818,
372,
270,
58,
72,
60,
796,
599,
35,
713,
58,
72,
11,
8671,
1343,
256,
79,
1343,
46651,
532,
352,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
275,
6601,
13,
2389,
8053,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
266,
818,
372,
270,
58,
72,
60,
796,
266,
35,
713,
58,
72,
11,
8671,
1343,
256,
79,
1343,
46651,
532,
352,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
818,
372,
270,
58,
72,
60,
796,
334,
35,
713,
58,
72,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
16955,
6601,
796,
685,
2777,
818,
372,
270,
11,
86,
818,
372,
270,
11,
84,
818,
372,
270,
11208,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
15252,
425,
7,
76,
11627,
11,
1855,
11,
26181,
3109,
1050,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
44872,
7203,
4770,
2559,
28,
1600,
17,
553,
33172,
8671,
553,
33172,
34788,
553,
4770,
2559,
2625,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
44872,
7,
76,
11627,
13,
26801,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3298,
285,
11627,
796,
1070,
8479,
7,
8671,
1343,
256,
79,
1343,
46651,
11,
18074,
231,
11,
16955,
6601,
11,
2779,
2964,
65,
9,
79,
20344,
81,
13,
83,
20344,
35906,
58,
34788,
60,
9,
79,
20344,
81,
13,
49535,
20344,
35906,
58,
49535,
4357,
46651,
11,
37455,
83,
11,
309,
11,
277,
6601,
11,
275,
6601,
11,
288,
6601,
11,
279,
20344,
81,
11,
27763,
33,
970,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
44872,
7203,
4770,
2559,
28,
1600,
1828,
553,
33172,
8671,
553,
33172,
34788,
553,
4770,
2559,
2625,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
44872,
7,
76,
11627,
13,
26801,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
26181,
3109,
1050,
796,
651,
15252,
425,
7,
76,
11627,
1776,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
285,
11627,
26,
198,
437,
198
] | 1.588136 | 8,901 |
# \file
# \brief Callbacks, Attributes and Attribute Values definitions.
# Avoid using these definitions. Use the strings instead.
#
# See Copyright Notice in iup.h
#
# Deprecated definitions #
# Avoid using these definitions. Use the strings instead. #
# Define __IUPDEF_H to avoid the inclusion of this header #
constant RUN = "RUN"
constant ENGLISH = "ENGLISH"
constant PORTUGUESE = "PORTUGUESE"
constant SBH = "SBH"
constant SBV = "SBV"
##########################################################################
# Callbacks #
##########################################################################
constant DEFAULT_ACTION = "DEFAULT_ACTION"
constant IDLE_ACTION = "IDLE_ACTION"
constant ACTION = "ACTION"
constant GETFOCUS_CB = "GETFOCUS_CB"
constant KILLFOCUS_CB = "KILLFOCUS_CB"
constant K_ANY = "K_ANY"
constant KEYPRESS_CB = "KEYPRESS_CB"
constant HELP_CB = "HELP_CB"
constant SCROLL_CB = "SCROLL_CB"
constant RESIZE_CB = "RESIZE_CB"
constant MOTION_CB = "MOTION_CB"
constant BUTTON_CB = "BUTTON_CB"
constant ENTERWINDOW_CB = "ENTERWINDOW_CB"
constant LEAVEWINDOW_CB = "LEAVEWINDOW_CB"
constant WHEEL_CB = "WHEEL_CB"
constant MASK_CB = "MASK_CB"
constant OPEN_CB = "OPEN_CB"
constant HIGHLIGHT_CB = "HIGHLIGHT_CB"
constant MENUCLOSE_CB = "MENUCLOSE_CB"
constant MAP_CB = "MAP_CB"
constant CLOSE_CB = "CLOSE_CB"
constant SHOW_CB = "SHOW_CB"
constant DROPFILES_CB = "DROPFILES_CB"
constant WOM_CB = "WOM_CB"
##########################################################################
# Attributes #
##########################################################################
constant DIRECTION = "DIRECTION"
constant ACTIVE = "ACTIVE"
constant BGCOLOR = "BGCOLOR"
constant FRAMECOLOR = "FRAMECOLOR"
constant FGCOLOR = "FGCOLOR"
constant COLOR = "COLOR"
constant WID = "WID"
constant SIZE = "SIZE"
constant RASTERSIZE = "RASTERSIZE"
constant TITLE = "TITLE"
constant VALUE = "VALUE"
constant VISIBLE = "VISIBLE"
constant FONT = "FONT"
constant TIP = "TIP"
constant EXPAND = "EXPAND"
constant SEPARATOR = "SEPARATOR"
constant HOTSPOT = "HOTSPOT"
constant HEIGHT = "HEIGHT"
constant WIDTH = "WIDTH"
constant KEY = "KEY"
constant MULTIPLE = "MULTIPLE"
constant DROPDOWN = "DROPDOWN"
constant VISIBLE_ITEMS = "VISIBLE_ITEMS"
constant MARGIN = "MARGIN"
constant GAP = "GAP"
constant ALIGNMENT = "ALIGNMENT"
constant IMAGE = "IMAGE"
constant IMINACTIVE = "IMINACTIVE"
constant IMPRESS = "IMPRESS"
constant WIN_SAVEBITS = "WIN_SAVEBITS"
constant NC = "NC"
constant MASK = "MASK"
constant APPEND = "APPEND"
constant BORDER = "BORDER"
constant CARET = "CARET"
constant SELECTION = "SELECTION"
constant SELECTEDTEXT = "SELECTEDTEXT"
constant INSERT = "INSERT"
constant CONID = "CONID"
constant CURSOR = "CURSOR"
constant ICON = "ICON"
constant MENUBOX = "MENUBOX"
constant MINBOX = "MINBOX"
constant MAXBOX = "MAXBOX"
constant RESIZE = "RESIZE"
constant MENU = "MENU"
constant STARTFOCUS = "STARTFOCUS"
constant PARENTDIALOG = "PARENTDIALOG"
constant SHRINK = "SHRINK"
constant DEFAULTENTER = "DEFAULTENTER"
constant DEFAULTESC = "DEFAULTESC"
constant X = "X"
constant Y = "Y"
constant TOOLBOX = "TOOLBOX"
constant CONTROL = "CONTROL"
constant READONLY = "READONLY"
constant SCROLLBAR = "SCROLLBAR"
constant POSY = "POSY"
constant POSX = "POSX"
constant DX = "DX"
constant DY = "DY"
constant XMAX = "XMAX"
constant XMIN = "XMIN"
constant YMAX = "YMAX"
constant YMIN = "YMIN"
constant RED = "255 0 0"
constant GREEN = "0 255 0"
constant BLUE = "0 0 255"
constant MIN = "MIN"
constant MAX = "MAX"
constant TIME = "TIME"
constant DRAG = "DRAG"
constant DROP = "DROP"
constant REPAINT = "REPAINT"
constant TOPMOST = "TOPMOST"
constant CLIPCHILDREN = "CLIPCHILDREN"
constant DIALOGTYPE = "DIALOGTYPE"
constant FILE = "FILE"
constant MULTIPLEFILES = "MULTIPLEFILES"
constant FILTER = "FILTER"
constant FILTERUSED = "FILTERUSED"
constant FILTERINFO = "FILTERINFO"
constant EXTFILTER = "EXTFILTER"
constant DIRECTORY = "DIRECTORY"
constant ALLOWNEW = "ALLOWNEW"
constant NOOVERWRITEPROMPT = "NOOVERWRITEPROMPT"
constant NOCHANGEDIR = "NOCHANGEDIR"
constant FILEEXIST = "FILEEXIST"
constant STATUS = "STATUS"
constant LOCKLOOP = "LOCKLOOP"
constant SYSTEM = "SYSTEM"
constant DRIVER = "DRIVER"
constant SCREENSIZE = "SCREENSIZE"
constant SYSTEMLANGUAGE = "SYSTEMLANGUAGE"
constant COMPUTERNAME = "COMPUTERNAME"
constant USERNAME = "USERNAME"
constant OPEN = "OPEN"
constant SAVE = "SAVE"
constant DIR = "DIR"
constant HORIZONTAL = "HORIZONTAL"
constant VERTICAL = "VERTICAL"
##########################################################################
# Attribute Values #
##########################################################################
constant YES = "YES"
constant NO = "NO"
constant ON = "ON"
constant OFF = "OFF"
constant ACENTER = "ACENTER"
constant ALEFT = "ALEFT"
constant ARIGHT = "ARIGHT"
constant ATOP = "ATOP"
constant ABOTTOM = "ABOTTOM"
constant NORTH = "NORTH"
constant SOUTH = "SOUTH"
constant WEST = "WEST"
constant EAST = "EAST"
constant NE = "NE"
constant SE = "SE"
constant NW = "NW"
constant SW = "SW"
constant FULLSCREEN = "FULLSCREEN"
constant FULL = "FULL"
constant HALF = "HALF"
constant THIRD = "THIRD"
constant QUARTER = "QUARTER"
constant EIGHTH = "EIGHTH"
constant ARROW = "ARROW"
constant BUSY = "BUSY"
constant RESIZE_N = "RESIZE_N"
constant RESIZE_S = "RESIZE_S"
constant RESIZE_E = "RESIZE_E"
constant RESIZE_W = "RESIZE_W"
constant RESIZE_NE = "RESIZE_NE"
constant RESIZE_NW = "RESIZE_NW"
constant RESIZE_SE = "RESIZE_SE"
constant RESIZE_SW = "RESIZE_SW"
constant MOVE = "MOVE"
constant HAND = "HAND"
constant NONE = "NONE"
constant IUP = "IUP"
constant CROSS = "CROSS"
constant PEN = "PEN"
constant TEXT = "TEXT"
constant RESIZE_C = "RESIZE_C"
constant OPENHAND = "OPENHAND"
###################
# Fonts #
###################
constant HELVETICA_NORMAL_8 = "HELVETICA_NORMAL_8"
constant HELVETICA_ITALIC_8 = "HELVETICA_ITALIC_8"
constant HELVETICA_BOLD_8 = "HELVETICA_BOLD_8"
constant HELVETICA_NORMAL_10 = "HELVETICA_NORMAL_10"
constant HELVETICA_ITALIC_10 = "HELVETICA_ITALIC_10"
constant HELVETICA_BOLD_10 = "HELVETICA_BOLD_10"
constant HELVETICA_NORMAL_12 = "HELVETICA_NORMAL_12"
constant HELVETICA_ITALIC_12 = "HELVETICA_ITALIC_12"
constant HELVETICA_BOLD_12 = "HELVETICA_BOLD_12"
constant HELVETICA_NORMAL_14 = "HELVETICA_NORMAL_14"
constant HELVETICA_ITALIC_14 = "HELVETICA_ITALIC_14"
constant HELVETICA_BOLD_14 = "HELVETICA_BOLD_14"
constant COURIER_NORMAL_8 = "COURIER_NORMAL_8"
constant COURIER_ITALIC_8 = "COURIER_ITALIC_8"
constant COURIER_BOLD_8 = "COURIER_BOLD_8"
constant COURIER_NORMAL_10 = "COURIER_NORMAL_10"
constant COURIER_ITALIC_10 = "COURIER_ITALIC_10"
constant COURIER_BOLD_10 = "COURIER_BOLD_10"
constant COURIER_NORMAL_12 = "COURIER_NORMAL_12"
constant COURIER_ITALIC_12 = "COURIER_ITALIC_12"
constant COURIER_BOLD_12 = "COURIER_BOLD_12"
constant COURIER_NORMAL_14 = "COURIER_NORMAL_14"
constant COURIER_ITALIC_14 = "COURIER_ITALIC_14"
constant COURIER_BOLD_14 = "COURIER_BOLD_14"
constant TIMES_NORMAL_8 = "TIMES_NORMAL_8"
constant TIMES_ITALIC_8 = "TIMES_ITALIC_8"
constant TIMES_BOLD_8 = "TIMES_BOLD_8"
constant TIMES_NORMAL_10 = "TIMES_NORMAL_10"
constant TIMES_ITALIC_10 = "TIMES_ITALIC_10"
constant TIMES_BOLD_10 = "TIMES_BOLD_10"
constant TIMES_NORMAL_12 = "TIMES_NORMAL_12"
constant TIMES_ITALIC_12 = "TIMES_ITALIC_12"
constant TIMES_BOLD_12 = "TIMES_BOLD_12"
constant TIMES_NORMAL_14 = "TIMES_NORMAL_14"
constant TIMES_ITALIC_14 = "TIMES_ITALIC_14"
constant TIMES_BOLD_14 = "TIMES_BOLD_14"
##########################################################################
# Keys #
##########################################################################
constant K_exclam = "K_exclam"
constant K_quotedbl = "K_quotedbl"
constant K_numbersign = "K_numbersign"
constant K_dollar = "K_dollar"
constant K_percent = "K_percent"
constant K_ampersand = "K_ampersand"
constant K_quoteright = "K_quoteright"
constant K_parentleft = "K_parentleft"
constant K_parentright = "K_parentright"
constant K_asterisk = "K_asterisk"
constant K_plus = "K_plus"
constant K_comma = "K_comma"
constant K_minus = "K_minus"
constant K_period = "K_period"
constant K_slash = "K_slash"
constant K_0 = "K_0"
constant K_1 = "K_1"
constant K_2 = "K_2"
constant K_3 = "K_3"
constant K_4 = "K_4"
constant K_5 = "K_5"
constant K_6 = "K_6"
constant K_7 = "K_7"
constant K_8 = "K_8"
constant K_9 = "K_9"
constant K_colon = "K_colon"
constant K_semicolon = "K_semicolon "
constant K_less = "K_less"
constant K_equal = "K_equal"
constant K_greater = "K_greater"
constant K_question = "K_question"
constant K_at = "K_at"
constant K_A = "K_A"
constant K_B = "K_B"
constant K_C = "K_C"
constant K_D = "K_D"
constant K_E = "K_E"
constant K_F = "K_F"
constant K_G = "K_G"
constant K_H = "K_H"
constant K_I = "K_I"
constant K_J = "K_J"
constant K_K = "K_K"
constant K_L = "K_L"
constant K_M = "K_M"
constant K_N = "K_N"
constant K_O = "K_O"
constant K_P = "K_P"
constant K_Q = "K_Q"
constant K_R = "K_R"
constant K_S = "K_S"
constant K_T = "K_T"
constant K_U = "K_U"
constant K_V = "K_V"
constant K_W = "K_W"
constant K_X = "K_X"
constant K_Y = "K_Y"
constant K_Z = "K_Z"
constant K_bracketleft = "K_bracketleft"
constant K_backslash = "K_backslash"
constant K_bracketright = "K_bracketright"
constant K_circum = "K_circum"
constant K_underscore = "K_underscore"
constant K_quoteleft = "K_quoteleft"
constant K_a = "K_a"
constant K_b = "K_b"
constant K_c = "K_c"
constant K_d = "K_d"
constant K_e = "K_e"
constant K_f = "K_f"
constant K_g = "K_g"
constant K_h = "K_h"
constant K_i = "K_i"
constant K_j = "K_j"
constant K_k = "K_k"
constant K_l = "K_l"
constant K_m = "K_m"
constant K_n = "K_n"
constant K_o = "K_o"
constant K_p = "K_p"
constant K_q = "K_q"
constant K_r = "K_r"
constant K_s = "K_s"
constant K_t = "K_t"
constant K_u = "K_u"
constant K_v = "K_v"
constant K_w = "K_w"
constant K_x = "K_x"
constant K_y = "K_y"
constant K_z = "K_z"
constant K_braceleft = "K_braceleft"
constant K_bar = "K_bar"
constant K_braceright = "K_braceright"
constant K_tilde = "K_tilde"
constant K_cA = "K_cA"
constant K_cB = "K_cB"
constant K_cC = "K_cC"
constant K_cD = "K_cD"
constant K_cE = "K_cE"
constant K_cF = "K_cF"
constant K_cG = "K_cG"
constant K_cJ = "K_cJ"
constant K_cK = "K_cK"
constant K_cL = "K_cL"
constant K_cN = "K_cN"
constant K_cO = "K_cO"
constant K_cP = "K_cP"
constant K_cQ = "K_cQ"
constant K_cR = "K_cR"
constant K_cS = "K_cS"
constant K_cT = "K_cT"
constant K_cU = "K_cU"
constant K_cV = "K_cV"
constant K_cW = "K_cW"
constant K_cX = "K_cX"
constant K_cY = "K_cY"
constant K_cZ = "K_cZ"
constant K_mA = "K_mA"
constant K_mB = "K_mB"
constant K_mC = "K_mC"
constant K_mD = "K_mD"
constant K_mE = "K_mE"
constant K_mF = "K_mF"
constant K_mG = "K_mG"
constant K_mH = "K_mH"
constant K_mI = "K_mI"
constant K_mJ = "K_mJ"
constant K_mK = "K_mK"
constant K_mL = "K_mL"
constant K_mM = "K_mM"
constant K_mN = "K_mN"
constant K_mO = "K_mO"
constant K_mP = "K_mP"
constant K_mQ = "K_mQ"
constant K_mR = "K_mR"
constant K_mS = "K_mS"
constant K_mT = "K_mT"
constant K_mU = "K_mU"
constant K_mV = "K_mV"
constant K_mW = "K_mW"
constant K_mX = "K_mX"
constant K_mY = "K_mY"
constant K_mZ = "K_mZ"
constant K_BS = "K_BS"
constant K_TAB = "K_TAB"
constant K_CR = "K_CR"
constant K_SP = "K_SP"
constant K_ESC = "K_ESC"
constant K_sCR = "K_sCR"
constant K_sTAB = "K_sTAB"
constant K_cTAB = "K_cTAB"
constant K_mTAB = "K_mTAB"
constant K_HOME = "K_HOME"
constant K_UP = "K_UP"
constant K_PGUP = "K_PGUP"
constant K_LEFT = "K_LEFT"
constant K_RIGHT = "K_RIGHT"
constant K_END = "K_END"
constant K_DOWN = "K_DOWN"
constant K_PGDN = "K_PGDN"
constant K_MIDDLE = "K_MIDDLE"
constant K_INS = "K_INS"
constant K_DEL = "K_DEL"
constant K_sHOME = "K_sHOME"
constant K_sUP = "K_sUP"
constant K_sPGUP = "K_sPGUP"
constant K_sLEFT = "K_sLEFT"
constant K_sRIGHT = "K_sRIGHT"
constant K_sEND = "K_sEND"
constant K_sDOWN = "K_sDOWN"
constant K_sPGDN = "K_sPGDN"
constant K_cHOME = "K_cHOME"
constant K_cPGUP = "K_cPGUP"
constant K_cLEFT = "K_cLEFT"
constant K_cRIGHT = "K_cRIGHT"
constant K_cEND = "K_cEND"
constant K_cPGDN = "K_cPGDN"
constant K_cUP = "K_cUP"
constant K_cDOWN = "K_cDOWN"
constant K_cMIDDLE = "K_cMIDDLE"
constant K_cINS = "K_cINS"
constant K_cDEL = "K_cDEL"
constant K_mHOME = "K_mHOME"
constant K_mPGUP = "K_mPGUP"
constant K_mLEFT = "K_mLEFT"
constant K_mRIGHT = "K_mRIGHT"
constant K_mEND = "K_mEND"
constant K_mPGDN = "K_mPGDN"
constant K_mUP = "K_mUP"
constant K_mDOWN = "K_mDOWN"
constant K_mINS = "K_mINS"
constant K_mDEL = "K_mDEL"
constant K_F1 = "K_F1"
constant K_F2 = "K_F2"
constant K_F3 = "K_F3"
constant K_F4 = "K_F4"
constant K_F5 = "K_F5"
constant K_F6 = "K_F6"
constant K_F7 = "K_F7"
constant K_F8 = "K_F8"
constant K_F9 = "K_F9"
constant K_F10 = "K_F10"
constant K_F11 = "K_F11"
constant K_F12 = "K_F12"
constant K_sF1 = "K_sF1"
constant K_sF2 = "K_sF2"
constant K_sF3 = "K_sF3"
constant K_sF4 = "K_sF4"
constant K_sF5 = "K_sF5"
constant K_sF6 = "K_sF6"
constant K_sF7 = "K_sF7"
constant K_sF8 = "K_sF8"
constant K_sF9 = "K_sF9"
constant K_sF10 = "K_sF10"
constant K_sF11 = "K_sF11"
constant K_sF12 = "K_sF12"
constant K_cF1 = "K_cF1"
constant K_cF2 = "K_cF2"
constant K_cF3 = "K_cF3"
constant K_cF4 = "K_cF4"
constant K_cF5 = "K_cF5"
constant K_cF6 = "K_cF6"
constant K_cF7 = "K_cF7"
constant K_cF8 = "K_cF8"
constant K_cF9 = "K_cF9"
constant K_cF10 = "K_cF10"
constant K_cF11 = "K_cF11"
constant K_cF12 = "K_cF12"
constant K_mF1 = "K_mF1"
constant K_mF2 = "K_mF2"
constant K_mF3 = "K_mF3"
constant K_mF4 = "K_mF4"
constant K_mF5 = "K_mF5"
constant K_mF6 = "K_mF6"
constant K_mF7 = "K_mF7"
constant K_mF8 = "K_mF8"
constant K_mF9 = "K_mF9"
constant K_mF10 = "K_mF10"
constant K_m1 = "K_m1"
constant K_m2 = "K_m2"
constant K_m3 = "K_m3"
constant K_m4 = "K_m4"
constant K_m5 = "K_m5"
constant K_m6 = "K_m6"
constant K_m7 = "K_m7"
constant K_m8 = "K_m8"
constant K_m9 = "K_m9"
constant K_m0 = "K_m0"
##############
# Colorbar #
##############
constant NUM_PARTS = "NUM_PARTS"
constant NUM_CELLS = "NUM_CELLS"
constant CELL = "CELL"
constant PREVIEW_SIZE = "PREVIEW_SIZE"
constant SHOW_PREVIEW = "SHOW_PREVIEW"
constant SHOW_SECONDARY = "SHOW_SECONDARY"
constant PRIMARY_CELL = "PRIMARY_CELL"
constant SECONDARY_CELL = "SECONDARY_CELL"
constant ORIENTATION = "ORIENTATION"
constant SQUARED = "SQUARED"
constant SHADOWED = "SHADOWED"
constant BUFFERIZE = "BUFFERIZE"
constant TRANSPARENCY = "TRANSPARENCY"
constant CELL_CB = "CELL_CB"
constant EXTENDED_CB = "EXTENDED_CB"
constant SELECT_CB = "SELECT_CB"
constant SWITCH_CB = "SWITCH_CB"
constant VERTICAL = "VERTICAL"
constant HORIZONTAL = "HORIZONTAL"
##############
# Cells #
##############
constant ALL = "ALL"
constant BOXED = "BOXED"
constant CLIPPED = "CLIPPED"
constant TRANSPARENT = "TRANSPARENT"
constant NON_SCROLLABLE_LINES = "NON_SCROLLABLE_LINES"
constant NON_SCROLLABLE_COLS = "NON_SCROLLABLE_COLS"
constant ORIGIN = "ORIGIN"
constant NO_COLOR = "NO_COLOR"
constant FIRST_LINE = "FIRST_LINE"
constant FIRST_COL = "FIRST_COL"
constant DOUBLE_BUFFER = "DOUBLE_BUFFER"
constant LIMITS = "LIMITS"
constant CANVAS = "CANVAS"
constant IMAGE_CANVAS = "IMAGE_CANVAS"
constant FULL_VISIBLE = "FULL_VISIBLE"
constant MOUSECLICK_CB = "MOUSECLICK_CB"
constant MOUSEMOTION_CB = "MOUSEMOTION_CB"
constant DRAW_CB = "DRAW_CB"
constant WIDTH_CB = "WIDTH_CB"
constant HEIGHT_CB = "HEIGHT_CB"
constant NLINES_CB = "NLINES_CB"
constant NCOLS_CB = "NCOLS_CB"
constant HSPAN_CB = "HSPAN_CB"
constant VSPAN_CB = "VSPAN_CB"
constant SCROLLING_CB = "SCROLLING_CB"
###################
# ColorBrowser #
###################
constant RGB = "RGB"
constant CHANGE_CB = "CHANGE_CB"
constant DRAG_CB = "DRAG_CB"
###################
# Val #
###################
constant ICTL_MOUSEMOVE_CB = "MOUSEMOVE_CB"
constant ICTL_BUTTON_PRESS_CB = "BUTTON_PRESS_CB"
constant ICTL_BUTTON_RELEASE_CB = "BUTTON_RELEASE_CB"
constant ICTL_HORIZONTAL = "HORIZONTAL"
constant ICTL_VERTICAL = "VERTICAL"
constant ICTL_SHOWTICKS = "SHOWTICKS"
###################
# Tabs #
###################
constant ICTL_TOP = "TOP"
constant ICTL_BOTTOM = "BOTTOM"
constant ICTL_LEFT = "LEFT"
constant ICTL_RIGHT = "RIGHT"
constant ICTL_TABTYPE = "TABTYPE"
constant ICTL_TABTITLE = "TABTITLE"
constant ICTL_TABSIZE = "TABSIZE"
constant ICTL_TABCHANGE_CB = "TABCHANGE_CB"
constant ICTL_FONT = "FONT"
constant ICTL_FONT_ACTIVE = "FONT_ACTIVE"
constant ICTL_FONT_INACTIVE = "FONT_INACTIVE"
###################
# Gauge #
###################
constant ICTL_SHOW_TEXT = "SHOW_TEXT"
constant ICTL_DASHED = "DASHED"
constant ICTL_MARGIN = "MARGIN"
constant ICTL_TEXT = "TEXT"
###################
# Dial #
###################
constant ICTL_DENSITY = "DENSITY"
constant ICTL_HORIZONTAL = "HORIZONTAL"
constant ICTL_VERTICAL = "VERTICAL"
constant ICTL_CIRCULAR = "CIRCULAR"
constant ICTL_UNIT = "UNIT"
###################
# Matrix #
###################
constant ENTERITEM_CB = "ENTERITEM_CB"
constant LEAVEITEM_CB = "LEAVEITEM_CB"
constant EDITION_CB = "EDITION_CB"
constant CLICK_CB = "CLICK_CB"
constant DROP_CB = "DROP_CB"
constant DROPSELECT_CB = "DROPSELECT_CB"
constant DROPCHECK_CB = "DROPCHECK_CB"
constant SCROLL_CB = "SCROLL_CB"
constant VALUE_CB = "VALUE_CB"
constant VALUE_EDIT_CB = "VALUE_EDIT_CB"
constant FIELD_CB = "FIELD_CB"
constant RESIZEMATRIX = "RESIZEMATRIX"
constant ADDLIN = "ADDLIN"
constant ADDCOL = "ADDCOL"
constant DELLIN = "DELLIN"
constant DELCOL = "DELCOL"
constant NUMLIN = "NUMLIN"
constant NUMCOL = "NUMCOL"
constant NUMLIN_VISIBLE = "NUMLIN_VISIBLE"
constant NUMCOL_VISIBLE = "NUMCOL_VISIBLE"
constant MARKED = "MARKED"
constant WIDTHDEF = "WIDTHDEF"
constant HEIGHTDEF = "HEIGHTDEF"
constant AREA = "AREA"
constant MARK_MODE = "MARK_MODE"
constant LIN = "LIN"
constant COL = "COL"
constant LINCOL = "LINCOL"
constant CELL = "CELL"
constant EDIT_MODE = "EDIT_MODE"
constant FOCUS_CELL = "FOCUS_CELL"
constant ORIGIN = "ORIGIN"
constant REDRAW = "REDRAW"
constant PREVIOUSVALUE = "PREVIOUSVALUE"
constant MOUSEMOVE_CB = "MOUSEMOVE_CB"
###################
# Tree #
###################
constant ADDLEAF = "ADDLEAF"
constant ADDBRANCH = "ADDBRANCH"
constant DELNODE = "DELNODE"
constant IMAGELEAF = "IMAGELEAF"
constant IMAGEBRANCHCOLLAPSED = "IMAGEBRANCHCOLLAPSED"
constant IMAGEBRANCHEXPANDED = "IMAGEBRANCHEXPANDED"
constant IMAGEEXPANDED = "IMAGEEXPANDED"
constant KIND = "KIND"
constant PARENT = "PARENT"
constant DEPTH = "DEPTH"
constant MARKED = "MARKED"
constant ADDEXPANDED = "ADDEXPANDED"
constant CTRL = "CTRL"
constant SHIFT = "SHIFT"
constant STATE = "STATE"
constant STARTING = "STARTING"
constant LEAF = "LEAF"
constant BRANCH = "BRANCH"
constant SELECTED = "SELECTED"
constant CHILDREN = "CHILDREN"
constant MARKED = "MARKED"
constant ROOT = "ROOT"
constant LAST = "LAST"
constant PGUP = "PGUP"
constant PGDN = "PGDN"
constant NEXT = "NEXT"
constant PREVIOUS = "PREVIOUS"
constant INVERT = "INVERT"
constant BLOCK = "BLOCK"
constant CLEARALL = "CLEARALL"
constant MARKALL = "MARKALL"
constant INVERTALL = "INVERTALL"
constant REDRAW = "REDRAW"
constant COLLAPSED = "COLLAPSED"
constant EXPANDED = "EXPANDED"
constant SELECTION_CB = "SELECTION_CB"
constant BRANCHOPEN_CB = "BRANCHOPEN_CB"
constant BRANCHCLOSE_CB = "BRANCHCLOSE_CB"
constant RIGHTCLICK_CB = "RIGHTCLICK_CB"
constant EXECUTELEAF_CB = "EXECUTELEAF_CB"
constant RENAMENODE_CB = "RENAMENODE_CB"
constant IMGLEAF = "IMGLEAF"
constant IMGCOLLAPSED = "IMGCOLLAPSED"
constant IMGEXPANDED = "IMGEXPANDED"
constant IMGBLANK = "IMGBLANK"
constant IMGPAPER = "IMGPAPER"
| [
2,
3467,
7753,
198,
2,
3467,
65,
3796,
4889,
10146,
11,
49213,
290,
3460,
4163,
27068,
17336,
13,
198,
2,
24390,
1262,
777,
17336,
13,
5765,
262,
13042,
2427,
13,
198,
2,
198,
2,
4091,
15069,
17641,
287,
1312,
929,
13,
71,
198,
2,
628,
198,
2,
220,
2129,
31023,
17336,
220,
1303,
198,
2,
220,
24390,
1262,
777,
17336,
13,
5765,
262,
13042,
2427,
13,
220,
1303,
198,
2,
220,
2896,
500,
11593,
44958,
5760,
25425,
62,
39,
284,
3368,
262,
14900,
286,
428,
13639,
220,
1303,
198,
198,
9979,
415,
32494,
796,
366,
49,
4944,
1,
198,
9979,
415,
12964,
8763,
18422,
796,
366,
1677,
8763,
18422,
1,
198,
9979,
415,
350,
9863,
7340,
52,
33635,
796,
366,
15490,
7340,
52,
33635,
1,
198,
9979,
415,
18056,
39,
796,
366,
16811,
39,
1,
198,
9979,
415,
18056,
53,
796,
366,
16811,
53,
1,
198,
198,
29113,
29113,
7804,
2235,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4889,
10146,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
198,
29113,
29113,
7804,
2235,
198,
198,
9979,
415,
5550,
38865,
62,
44710,
796,
366,
7206,
38865,
62,
44710,
1,
198,
9979,
415,
4522,
2538,
62,
44710,
796,
366,
2389,
2538,
62,
44710,
1,
198,
198,
9979,
415,
40282,
796,
366,
44710,
1,
198,
9979,
415,
17151,
37,
4503,
2937,
62,
23199,
796,
366,
18851,
37,
4503,
2937,
62,
23199,
1,
198,
9979,
415,
45257,
37,
4503,
2937,
62,
23199,
796,
366,
42,
8267,
37,
4503,
2937,
62,
23199,
1,
198,
9979,
415,
509,
62,
31827,
796,
366,
42,
62,
31827,
1,
198,
9979,
415,
35374,
32761,
62,
23199,
796,
366,
20373,
32761,
62,
23199,
1,
198,
9979,
415,
49944,
62,
23199,
796,
366,
39,
3698,
47,
62,
23199,
1,
198,
198,
9979,
415,
6374,
13252,
3069,
62,
23199,
796,
366,
6173,
13252,
3069,
62,
23199,
1,
198,
9979,
415,
15731,
35400,
62,
23199,
796,
366,
19535,
35400,
62,
23199,
1,
198,
9979,
415,
42982,
2849,
62,
23199,
796,
366,
44,
2394,
2849,
62,
23199,
1,
198,
9979,
415,
21728,
11357,
62,
23199,
796,
366,
47526,
11357,
62,
23199,
1,
198,
9979,
415,
46962,
28929,
3913,
62,
23199,
796,
366,
3525,
1137,
28929,
3913,
62,
23199,
1,
198,
9979,
415,
12509,
32,
6089,
28929,
3913,
62,
23199,
796,
366,
2538,
32,
6089,
28929,
3913,
62,
23199,
1,
198,
9979,
415,
7655,
36,
3698,
62,
23199,
796,
366,
12418,
36,
3698,
62,
23199,
1,
198,
198,
9979,
415,
32337,
42,
62,
23199,
796,
366,
31180,
42,
62,
23199,
1,
198,
9979,
415,
38303,
62,
23199,
796,
366,
3185,
1677,
62,
23199,
1,
198,
9979,
415,
367,
3528,
6581,
9947,
62,
23199,
796,
366,
39,
3528,
6581,
9947,
62,
23199,
1,
198,
9979,
415,
41597,
52,
32737,
62,
23199,
796,
366,
49275,
52,
32737,
62,
23199,
1,
198,
198,
9979,
415,
34645,
62,
23199,
796,
366,
33767,
62,
23199,
1,
198,
9979,
415,
7852,
14058,
62,
23199,
796,
366,
32737,
62,
23199,
1,
198,
9979,
415,
37041,
62,
23199,
796,
366,
9693,
3913,
62,
23199,
1,
198,
198,
9979,
415,
10560,
3185,
46700,
1546,
62,
23199,
796,
366,
7707,
3185,
46700,
1546,
62,
23199,
1,
198,
9979,
415,
45386,
62,
23199,
796,
366,
54,
2662,
62,
23199,
1,
198,
198,
29113,
29113,
7804,
2235,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
49213,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
198,
29113,
29113,
7804,
2235,
198,
198,
9979,
415,
42242,
2849,
796,
366,
17931,
23988,
2849,
1,
198,
9979,
415,
11741,
9306,
796,
366,
10659,
9306,
1,
198,
9979,
415,
347,
15916,
3535,
1581,
796,
366,
33,
15916,
3535,
1581,
1,
198,
9979,
415,
8782,
2390,
2943,
3535,
1581,
796,
366,
10913,
2390,
2943,
3535,
1581,
1,
198,
9979,
415,
376,
15916,
3535,
1581,
796,
366,
37,
15916,
3535,
1581,
1,
198,
9979,
415,
20444,
1581,
796,
366,
46786,
1,
198,
9979,
415,
370,
2389,
796,
366,
54,
2389,
1,
198,
9979,
415,
311,
35400,
796,
366,
33489,
1,
198,
9979,
415,
371,
11262,
4877,
35400,
796,
366,
49,
11262,
4877,
35400,
1,
198,
9979,
415,
37977,
2538,
796,
366,
49560,
2538,
1,
198,
9979,
415,
26173,
8924,
796,
366,
39488,
1,
198,
9979,
415,
50035,
34563,
796,
366,
29817,
34563,
1,
198,
9979,
415,
376,
35830,
796,
366,
37,
35830,
1,
198,
9979,
415,
309,
4061,
796,
366,
51,
4061,
1,
198,
9979,
415,
25703,
6981,
796,
366,
49864,
6981,
1,
198,
9979,
415,
7946,
27082,
25633,
796,
366,
5188,
27082,
25633,
1,
198,
198,
9979,
415,
44607,
4303,
2394,
796,
366,
39,
2394,
4303,
2394,
1,
198,
9979,
415,
11179,
9947,
796,
366,
13909,
9947,
1,
198,
9979,
415,
370,
2389,
4221,
796,
366,
54,
2389,
4221,
1,
198,
198,
9979,
415,
35374,
796,
366,
20373,
1,
198,
198,
9979,
415,
337,
16724,
4061,
2538,
796,
366,
44,
16724,
4061,
2538,
1,
198,
9979,
415,
10560,
3185,
41925,
796,
366,
7707,
3185,
41925,
1,
198,
9979,
415,
50035,
34563,
62,
2043,
39201,
796,
366,
29817,
34563,
62,
2043,
39201,
1,
198,
198,
9979,
415,
18805,
38,
1268,
796,
366,
40569,
38,
1268,
1,
198,
9979,
415,
402,
2969,
796,
366,
38,
2969,
1,
198,
9979,
415,
8355,
16284,
10979,
796,
366,
1847,
16284,
10979,
1,
198,
198,
9979,
415,
8959,
11879,
796,
366,
3955,
11879,
1,
198,
9979,
415,
8959,
1268,
10659,
9306,
796,
366,
3955,
1268,
10659,
9306,
1,
198,
9979,
415,
8959,
32761,
796,
366,
3955,
32761,
1,
198,
9979,
415,
25779,
62,
4090,
6089,
26094,
50,
796,
366,
37620,
62,
4090,
6089,
26094,
50,
1,
198,
198,
9979,
415,
8823,
796,
366,
7792,
1,
198,
9979,
415,
32337,
42,
796,
366,
31180,
42,
1,
198,
198,
9979,
415,
43504,
10619,
796,
366,
24805,
10619,
1,
198,
9979,
415,
347,
12532,
1137,
796,
366,
33,
12532,
1137,
1,
198,
198,
9979,
415,
17368,
2767,
796,
366,
20034,
2767,
1,
198,
9979,
415,
33493,
2849,
796,
366,
46506,
2849,
1,
198,
9979,
415,
33493,
1961,
32541,
796,
366,
46506,
1961,
32541,
1,
198,
9979,
415,
29194,
17395,
796,
366,
20913,
17395,
1,
198,
198,
9979,
415,
7102,
2389,
796,
366,
10943,
2389,
1,
198,
9979,
415,
327,
4261,
50,
1581,
796,
366,
34,
4261,
50,
1581,
1,
198,
198,
9979,
415,
314,
10943,
796,
366,
2149,
1340,
1,
198,
9979,
415,
41597,
52,
39758,
796,
366,
49275,
52,
39758,
1,
198,
9979,
415,
20625,
39758,
796,
366,
23678,
39758,
1,
198,
9979,
415,
25882,
39758,
796,
366,
22921,
39758,
1,
198,
9979,
415,
15731,
35400,
796,
366,
19535,
35400,
1,
198,
9979,
415,
41597,
52,
796,
366,
49275,
52,
1,
198,
9979,
415,
33303,
37,
4503,
2937,
796,
366,
2257,
7227,
37,
4503,
2937,
1,
198,
9979,
415,
29463,
3525,
35,
12576,
7730,
796,
366,
27082,
3525,
35,
12576,
7730,
1,
198,
9979,
415,
6006,
49,
17248,
796,
366,
9693,
49,
17248,
1,
198,
9979,
415,
5550,
38865,
3525,
1137,
796,
366,
7206,
38865,
3525,
1137,
1,
198,
9979,
415,
5550,
38865,
1546,
34,
796,
366,
7206,
38865,
1546,
34,
1,
198,
9979,
415,
1395,
796,
366,
55,
1,
198,
9979,
415,
575,
796,
366,
56,
1,
198,
9979,
415,
5390,
3535,
39758,
796,
366,
10468,
3535,
39758,
1,
198,
9979,
415,
49833,
796,
366,
10943,
5446,
3535,
1,
198,
9979,
415,
20832,
1340,
11319,
796,
366,
15675,
1340,
11319,
1,
198,
198,
9979,
415,
6374,
13252,
3069,
33,
1503,
796,
366,
6173,
13252,
3069,
33,
1503,
1,
198,
9979,
415,
28069,
56,
796,
366,
37997,
56,
1,
198,
9979,
415,
28069,
55,
796,
366,
37997,
55,
1,
198,
9979,
415,
19393,
796,
366,
36227,
1,
198,
9979,
415,
360,
56,
796,
366,
35,
56,
1,
198,
9979,
415,
1395,
22921,
796,
366,
55,
22921,
1,
198,
9979,
415,
1395,
23678,
796,
366,
55,
23678,
1,
198,
9979,
415,
575,
22921,
796,
366,
56,
22921,
1,
198,
9979,
415,
575,
23678,
796,
366,
56,
23678,
1,
198,
198,
9979,
415,
23848,
796,
366,
13381,
657,
657,
1,
198,
9979,
415,
47606,
796,
366,
15,
14280,
657,
1,
198,
9979,
415,
9878,
8924,
796,
366,
15,
657,
14280,
1,
198,
198,
9979,
415,
20625,
796,
366,
23678,
1,
198,
9979,
415,
25882,
796,
366,
22921,
1,
198,
198,
9979,
415,
20460,
796,
366,
34694,
1,
198,
9979,
415,
44779,
796,
366,
35,
33202,
1,
198,
9979,
415,
10560,
3185,
796,
366,
7707,
3185,
1,
198,
9979,
415,
4526,
4537,
12394,
796,
366,
2200,
4537,
12394,
1,
198,
9979,
415,
28662,
44,
10892,
796,
366,
35222,
44,
10892,
1,
198,
9979,
415,
7852,
4061,
3398,
4146,
7707,
1677,
796,
366,
5097,
4061,
3398,
4146,
7707,
1677,
1,
198,
198,
9979,
415,
360,
12576,
7730,
25216,
796,
366,
35,
12576,
7730,
25216,
1,
198,
9979,
415,
45811,
796,
366,
25664,
1,
198,
9979,
415,
337,
16724,
4061,
2538,
46700,
1546,
796,
366,
44,
16724,
4061,
2538,
46700,
1546,
1,
198,
9979,
415,
34020,
5781,
796,
366,
46700,
5781,
1,
198,
9979,
415,
34020,
5781,
2937,
1961,
796,
366,
46700,
5781,
2937,
1961,
1,
198,
9979,
415,
34020,
5781,
10778,
796,
366,
46700,
5781,
10778,
1,
198,
9979,
415,
7788,
10234,
4146,
5781,
796,
366,
6369,
10234,
4146,
5781,
1,
198,
9979,
415,
42242,
15513,
796,
366,
17931,
23988,
15513,
1,
198,
9979,
415,
11096,
3913,
13965,
796,
366,
7036,
3913,
13965,
1,
198,
9979,
415,
399,
6684,
5959,
18564,
12709,
4805,
2662,
11571,
796,
366,
45,
6684,
5959,
18564,
12709,
4805,
2662,
11571,
1,
198,
9979,
415,
8005,
3398,
15567,
1961,
4663,
796,
366,
15285,
3398,
15567,
1961,
4663,
1,
198,
9979,
415,
45811,
6369,
8808,
796,
366,
25664,
6369,
8808,
1,
198,
9979,
415,
15486,
2937,
796,
366,
35744,
2937,
1,
198,
198,
9979,
415,
406,
11290,
21982,
3185,
796,
366,
36840,
21982,
3185,
1,
198,
9979,
415,
36230,
796,
366,
23060,
25361,
1,
198,
9979,
415,
10560,
38757,
796,
366,
7707,
38757,
1,
198,
9979,
415,
6374,
2200,
1677,
33489,
796,
366,
6173,
2200,
1677,
33489,
1,
198,
9979,
415,
36230,
43,
15567,
52,
11879,
796,
366,
23060,
25361,
43,
15567,
52,
11879,
1,
198,
9979,
415,
24301,
3843,
1137,
20608,
796,
366,
9858,
30076,
1137,
20608,
1,
198,
9979,
415,
1294,
1137,
20608,
796,
366,
29904,
20608,
1,
198,
198,
9979,
415,
38303,
796,
366,
3185,
1677,
1,
198,
9979,
415,
14719,
6089,
796,
366,
4090,
6089,
1,
198,
9979,
415,
360,
4663,
796,
366,
34720,
1,
198,
198,
9979,
415,
48345,
14887,
35830,
1847,
796,
366,
39,
1581,
14887,
35830,
1847,
1,
198,
9979,
415,
569,
17395,
20151,
796,
366,
15858,
20151,
1,
198,
198,
29113,
29113,
7804,
2235,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3460,
4163,
27068,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
198,
29113,
29113,
7804,
2235,
198,
198,
9979,
415,
21560,
796,
366,
43335,
1,
198,
9979,
415,
8005,
796,
366,
15285,
1,
198,
9979,
415,
6177,
796,
366,
1340,
1,
198,
9979,
415,
18562,
796,
366,
27977,
1,
198,
198,
9979,
415,
7125,
3525,
1137,
796,
366,
2246,
3525,
1137,
1,
198,
9979,
415,
32318,
9792,
796,
366,
21358,
9792,
1,
198,
9979,
415,
5923,
9947,
796,
366,
1503,
9947,
1,
198,
9979,
415,
5161,
3185,
796,
366,
1404,
3185,
1,
198,
9979,
415,
9564,
29089,
2662,
796,
366,
6242,
29089,
2662,
1,
198,
198,
9979,
415,
25273,
4221,
796,
366,
35510,
4221,
1,
198,
9979,
415,
30065,
4221,
796,
366,
50,
2606,
4221,
1,
198,
9979,
415,
370,
6465,
796,
366,
54,
6465,
1,
198,
9979,
415,
412,
11262,
796,
366,
36,
11262,
1,
198,
9979,
415,
10635,
796,
366,
12161,
1,
198,
9979,
415,
7946,
796,
366,
5188,
1,
198,
9979,
415,
21966,
796,
366,
27605,
1,
198,
9979,
415,
12672,
796,
366,
17887,
1,
198,
198,
9979,
415,
34958,
6173,
2200,
1677,
796,
366,
37,
9994,
6173,
2200,
1677,
1,
198,
9979,
415,
34958,
796,
366,
37,
9994,
1,
198,
9979,
415,
42968,
37,
796,
366,
39,
1847,
37,
1,
198,
9979,
415,
2320,
46833,
796,
366,
4221,
46833,
1,
198,
9979,
415,
19604,
1503,
5781,
796,
366,
10917,
1503,
5781,
1,
198,
9979,
415,
412,
18060,
4221,
796,
366,
36,
18060,
4221,
1,
198,
198,
9979,
415,
5923,
49,
3913,
796,
366,
26465,
3913,
1,
198,
9979,
415,
43949,
56,
796,
366,
45346,
56,
1,
198,
9979,
415,
15731,
35400,
62,
45,
796,
366,
19535,
35400,
62,
45,
1,
198,
9979,
415,
15731,
35400,
62,
50,
796,
366,
19535,
35400,
62,
50,
1,
198,
9979,
415,
15731,
35400,
62,
36,
796,
366,
19535,
35400,
62,
36,
1,
198,
9979,
415,
15731,
35400,
62,
54,
796,
366,
19535,
35400,
62,
54,
1,
198,
9979,
415,
15731,
35400,
62,
12161,
796,
366,
19535,
35400,
62,
12161,
1,
198,
9979,
415,
15731,
35400,
62,
27605,
796,
366,
19535,
35400,
62,
27605,
1,
198,
9979,
415,
15731,
35400,
62,
5188,
796,
366,
19535,
35400,
62,
5188,
1,
198,
9979,
415,
15731,
35400,
62,
17887,
796,
366,
19535,
35400,
62,
17887,
1,
198,
9979,
415,
13070,
6089,
796,
366,
11770,
6089,
1,
198,
9979,
415,
367,
6981,
796,
366,
39,
6981,
1,
198,
9979,
415,
399,
11651,
796,
366,
45,
11651,
1,
198,
9979,
415,
314,
8577,
796,
366,
40,
8577,
1,
198,
9979,
415,
8740,
18420,
796,
366,
9419,
18420,
1,
198,
9979,
415,
350,
1677,
796,
366,
47,
1677,
1,
198,
9979,
415,
40383,
796,
366,
32541,
1,
198,
9979,
415,
15731,
35400,
62,
34,
796,
366,
19535,
35400,
62,
34,
1,
198,
9979,
415,
38303,
39,
6981,
796,
366,
3185,
1677,
39,
6981,
1,
198,
198,
14468,
21017,
198,
2,
220,
24060,
82,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
198,
14468,
21017,
198,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
35510,
42126,
62,
23,
796,
366,
39,
3698,
53,
2767,
25241,
62,
35510,
42126,
62,
23,
1,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
40579,
2149,
62,
23,
796,
366,
39,
3698,
53,
2767,
25241,
62,
40579,
2149,
62,
23,
1,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
33,
15173,
62,
23,
796,
366,
39,
3698,
53,
2767,
25241,
62,
33,
15173,
62,
23,
1,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
35510,
42126,
62,
940,
796,
366,
39,
3698,
53,
2767,
25241,
62,
35510,
42126,
62,
940,
1,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
40579,
2149,
62,
940,
796,
366,
39,
3698,
53,
2767,
25241,
62,
40579,
2149,
62,
940,
1,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
33,
15173,
62,
940,
796,
366,
39,
3698,
53,
2767,
25241,
62,
33,
15173,
62,
940,
1,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
35510,
42126,
62,
1065,
796,
366,
39,
3698,
53,
2767,
25241,
62,
35510,
42126,
62,
1065,
1,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
40579,
2149,
62,
1065,
796,
366,
39,
3698,
53,
2767,
25241,
62,
40579,
2149,
62,
1065,
1,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
33,
15173,
62,
1065,
796,
366,
39,
3698,
53,
2767,
25241,
62,
33,
15173,
62,
1065,
1,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
35510,
42126,
62,
1415,
796,
366,
39,
3698,
53,
2767,
25241,
62,
35510,
42126,
62,
1415,
1,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
40579,
2149,
62,
1415,
796,
366,
39,
3698,
53,
2767,
25241,
62,
40579,
2149,
62,
1415,
1,
198,
9979,
415,
36255,
53,
2767,
25241,
62,
33,
15173,
62,
1415,
796,
366,
39,
3698,
53,
2767,
25241,
62,
33,
15173,
62,
1415,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
35510,
42126,
62,
23,
796,
366,
34,
2606,
7112,
1137,
62,
35510,
42126,
62,
23,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
40579,
2149,
62,
23,
796,
366,
34,
2606,
7112,
1137,
62,
40579,
2149,
62,
23,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
33,
15173,
62,
23,
796,
366,
34,
2606,
7112,
1137,
62,
33,
15173,
62,
23,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
35510,
42126,
62,
940,
796,
366,
34,
2606,
7112,
1137,
62,
35510,
42126,
62,
940,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
40579,
2149,
62,
940,
796,
366,
34,
2606,
7112,
1137,
62,
40579,
2149,
62,
940,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
33,
15173,
62,
940,
796,
366,
34,
2606,
7112,
1137,
62,
33,
15173,
62,
940,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
35510,
42126,
62,
1065,
796,
366,
34,
2606,
7112,
1137,
62,
35510,
42126,
62,
1065,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
40579,
2149,
62,
1065,
796,
366,
34,
2606,
7112,
1137,
62,
40579,
2149,
62,
1065,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
33,
15173,
62,
1065,
796,
366,
34,
2606,
7112,
1137,
62,
33,
15173,
62,
1065,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
35510,
42126,
62,
1415,
796,
366,
34,
2606,
7112,
1137,
62,
35510,
42126,
62,
1415,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
40579,
2149,
62,
1415,
796,
366,
34,
2606,
7112,
1137,
62,
40579,
2149,
62,
1415,
1,
198,
9979,
415,
327,
2606,
7112,
1137,
62,
33,
15173,
62,
1415,
796,
366,
34,
2606,
7112,
1137,
62,
33,
15173,
62,
1415,
1,
198,
9979,
415,
31742,
1546,
62,
35510,
42126,
62,
23,
796,
366,
51,
3955,
1546,
62,
35510,
42126,
62,
23,
1,
198,
9979,
415,
31742,
1546,
62,
40579,
2149,
62,
23,
796,
366,
51,
3955,
1546,
62,
40579,
2149,
62,
23,
1,
198,
9979,
415,
31742,
1546,
62,
33,
15173,
62,
23,
796,
366,
51,
3955,
1546,
62,
33,
15173,
62,
23,
1,
198,
9979,
415,
31742,
1546,
62,
35510,
42126,
62,
940,
796,
366,
51,
3955,
1546,
62,
35510,
42126,
62,
940,
1,
198,
9979,
415,
31742,
1546,
62,
40579,
2149,
62,
940,
796,
366,
51,
3955,
1546,
62,
40579,
2149,
62,
940,
1,
198,
9979,
415,
31742,
1546,
62,
33,
15173,
62,
940,
796,
366,
51,
3955,
1546,
62,
33,
15173,
62,
940,
1,
198,
9979,
415,
31742,
1546,
62,
35510,
42126,
62,
1065,
796,
366,
51,
3955,
1546,
62,
35510,
42126,
62,
1065,
1,
198,
9979,
415,
31742,
1546,
62,
40579,
2149,
62,
1065,
796,
366,
51,
3955,
1546,
62,
40579,
2149,
62,
1065,
1,
198,
9979,
415,
31742,
1546,
62,
33,
15173,
62,
1065,
796,
366,
51,
3955,
1546,
62,
33,
15173,
62,
1065,
1,
198,
9979,
415,
31742,
1546,
62,
35510,
42126,
62,
1415,
796,
366,
51,
3955,
1546,
62,
35510,
42126,
62,
1415,
1,
198,
9979,
415,
31742,
1546,
62,
40579,
2149,
62,
1415,
796,
366,
51,
3955,
1546,
62,
40579,
2149,
62,
1415,
1,
198,
9979,
415,
31742,
1546,
62,
33,
15173,
62,
1415,
796,
366,
51,
3955,
1546,
62,
33,
15173,
62,
1415,
1,
198,
198,
29113,
29113,
7804,
2235,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
26363,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
198,
29113,
29113,
7804,
2235,
198,
198,
9979,
415,
509,
62,
1069,
565,
321,
796,
366,
42,
62,
1069,
565,
321,
1,
198,
9979,
415,
509,
62,
421,
5191,
2436,
796,
366,
42,
62,
421,
5191,
2436,
1,
198,
9979,
415,
509,
62,
77,
17024,
570,
796,
366,
42,
62,
77,
17024,
570,
1,
198,
9979,
415,
509,
62,
22569,
796,
366,
42,
62,
22569,
1,
198,
9979,
415,
509,
62,
25067,
796,
366,
42,
62,
25067,
1,
198,
9979,
415,
509,
62,
696,
364,
392,
796,
366,
42,
62,
696,
364,
392,
1,
198,
9979,
415,
509,
62,
421,
19543,
432,
796,
366,
42,
62,
421,
19543,
432,
1,
198,
9979,
415,
509,
62,
8000,
9464,
796,
366,
42,
62,
8000,
9464,
1,
198,
9979,
415,
509,
62,
8000,
3506,
796,
366,
42,
62,
8000,
3506,
1,
198,
9979,
415,
509,
62,
1603,
1984,
796,
366,
42,
62,
1603,
1984,
1,
198,
9979,
415,
509,
62,
9541,
796,
366,
42,
62,
9541,
1,
198,
9979,
415,
509,
62,
785,
2611,
796,
366,
42,
62,
785,
2611,
1,
198,
9979,
415,
509,
62,
40191,
796,
366,
42,
62,
40191,
1,
198,
9979,
415,
509,
62,
41007,
796,
366,
42,
62,
41007,
1,
198,
9979,
415,
509,
62,
6649,
1077,
796,
366,
42,
62,
6649,
1077,
1,
198,
9979,
415,
509,
62,
15,
796,
366,
42,
62,
15,
1,
198,
9979,
415,
509,
62,
16,
796,
366,
42,
62,
16,
1,
198,
9979,
415,
509,
62,
17,
796,
366,
42,
62,
17,
1,
198,
9979,
415,
509,
62,
18,
796,
366,
42,
62,
18,
1,
198,
9979,
415,
509,
62,
19,
796,
366,
42,
62,
19,
1,
198,
9979,
415,
509,
62,
20,
796,
366,
42,
62,
20,
1,
198,
9979,
415,
509,
62,
21,
796,
366,
42,
62,
21,
1,
198,
9979,
415,
509,
62,
22,
796,
366,
42,
62,
22,
1,
198,
9979,
415,
509,
62,
23,
796,
366,
42,
62,
23,
1,
198,
9979,
415,
509,
62,
24,
796,
366,
42,
62,
24,
1,
198,
9979,
415,
509,
62,
4033,
261,
796,
366,
42,
62,
4033,
261,
1,
198,
9979,
415,
509,
62,
325,
9383,
43645,
796,
366,
42,
62,
325,
9383,
43645,
366,
198,
9979,
415,
509,
62,
1203,
796,
366,
42,
62,
1203,
1,
198,
9979,
415,
509,
62,
40496,
796,
366,
42,
62,
40496,
1,
198,
9979,
415,
509,
62,
18223,
263,
796,
366,
42,
62,
18223,
263,
1,
198,
9979,
415,
509,
62,
25652,
796,
366,
42,
62,
25652,
1,
198,
9979,
415,
509,
62,
265,
796,
366,
42,
62,
265,
1,
198,
9979,
415,
509,
62,
32,
796,
366,
42,
62,
32,
1,
198,
9979,
415,
509,
62,
33,
796,
366,
42,
62,
33,
1,
198,
9979,
415,
509,
62,
34,
796,
366,
42,
62,
34,
1,
198,
9979,
415,
509,
62,
35,
796,
366,
42,
62,
35,
1,
198,
9979,
415,
509,
62,
36,
796,
366,
42,
62,
36,
1,
198,
9979,
415,
509,
62,
37,
796,
366,
42,
62,
37,
1,
198,
9979,
415,
509,
62,
38,
796,
366,
42,
62,
38,
1,
198,
9979,
415,
509,
62,
39,
796,
366,
42,
62,
39,
1,
198,
9979,
415,
509,
62,
40,
796,
366,
42,
62,
40,
1,
198,
9979,
415,
509,
62,
41,
796,
366,
42,
62,
41,
1,
198,
9979,
415,
509,
62,
42,
796,
366,
42,
62,
42,
1,
198,
9979,
415,
509,
62,
43,
796,
366,
42,
62,
43,
1,
198,
9979,
415,
509,
62,
44,
796,
366,
42,
62,
44,
1,
198,
9979,
415,
509,
62,
45,
796,
366,
42,
62,
45,
1,
198,
9979,
415,
509,
62,
46,
796,
366,
42,
62,
46,
1,
198,
9979,
415,
509,
62,
47,
796,
366,
42,
62,
47,
1,
198,
9979,
415,
509,
62,
48,
796,
366,
42,
62,
48,
1,
198,
9979,
415,
509,
62,
49,
796,
366,
42,
62,
49,
1,
198,
9979,
415,
509,
62,
50,
796,
366,
42,
62,
50,
1,
198,
9979,
415,
509,
62,
51,
796,
366,
42,
62,
51,
1,
198,
9979,
415,
509,
62,
52,
796,
366,
42,
62,
52,
1,
198,
9979,
415,
509,
62,
53,
796,
366,
42,
62,
53,
1,
198,
9979,
415,
509,
62,
54,
796,
366,
42,
62,
54,
1,
198,
9979,
415,
509,
62,
55,
796,
366,
42,
62,
55,
1,
198,
9979,
415,
509,
62,
56,
796,
366,
42,
62,
56,
1,
198,
9979,
415,
509,
62,
57,
796,
366,
42,
62,
57,
1,
198,
9979,
415,
509,
62,
1671,
8317,
9464,
796,
366,
42,
62,
1671,
8317,
9464,
1,
198,
9979,
415,
509,
62,
1891,
6649,
1077,
796,
366,
42,
62,
1891,
6649,
1077,
1,
198,
9979,
415,
509,
62,
1671,
8317,
3506,
796,
366,
42,
62,
1671,
8317,
3506,
1,
198,
9979,
415,
509,
62,
21170,
388,
796,
366,
42,
62,
21170,
388,
1,
198,
9979,
415,
509,
62,
41116,
7295,
796,
366,
42,
62,
41116,
7295,
1,
198,
9979,
415,
509,
62,
22708,
9464,
796,
366,
42,
62,
22708,
9464,
1,
198,
9979,
415,
509,
62,
64,
796,
366,
42,
62,
64,
1,
198,
9979,
415,
509,
62,
65,
796,
366,
42,
62,
65,
1,
198,
9979,
415,
509,
62,
66,
796,
366,
42,
62,
66,
1,
198,
9979,
415,
509,
62,
67,
796,
366,
42,
62,
67,
1,
198,
9979,
415,
509,
62,
68,
796,
366,
42,
62,
68,
1,
198,
9979,
415,
509,
62,
69,
796,
366,
42,
62,
69,
1,
198,
9979,
415,
509,
62,
70,
796,
366,
42,
62,
70,
1,
198,
9979,
415,
509,
62,
71,
796,
366,
42,
62,
71,
1,
198,
9979,
415,
509,
62,
72,
796,
366,
42,
62,
72,
1,
198,
9979,
415,
509,
62,
73,
796,
366,
42,
62,
73,
1,
198,
9979,
415,
509,
62,
74,
796,
366,
42,
62,
74,
1,
198,
9979,
415,
509,
62,
75,
796,
366,
42,
62,
75,
1,
198,
9979,
415,
509,
62,
76,
796,
366,
42,
62,
76,
1,
198,
9979,
415,
509,
62,
77,
796,
366,
42,
62,
77,
1,
198,
9979,
415,
509,
62,
78,
796,
366,
42,
62,
78,
1,
198,
9979,
415,
509,
62,
79,
796,
366,
42,
62,
79,
1,
198,
9979,
415,
509,
62,
80,
796,
366,
42,
62,
80,
1,
198,
9979,
415,
509,
62,
81,
796,
366,
42,
62,
81,
1,
198,
9979,
415,
509,
62,
82,
796,
366,
42,
62,
82,
1,
198,
9979,
415,
509,
62,
83,
796,
366,
42,
62,
83,
1,
198,
9979,
415,
509,
62,
84,
796,
366,
42,
62,
84,
1,
198,
9979,
415,
509,
62,
85,
796,
366,
42,
62,
85,
1,
198,
9979,
415,
509,
62,
86,
796,
366,
42,
62,
86,
1,
198,
9979,
415,
509,
62,
87,
796,
366,
42,
62,
87,
1,
198,
9979,
415,
509,
62,
88,
796,
366,
42,
62,
88,
1,
198,
9979,
415,
509,
62,
89,
796,
366,
42,
62,
89,
1,
198,
9979,
415,
509,
62,
46565,
9464,
796,
366,
42,
62,
46565,
9464,
1,
198,
9979,
415,
509,
62,
5657,
796,
366,
42,
62,
5657,
1,
198,
9979,
415,
509,
62,
1671,
11736,
432,
796,
366,
42,
62,
1671,
11736,
432,
1,
198,
9979,
415,
509,
62,
83,
44725,
796,
366,
42,
62,
83,
44725,
1,
198,
198,
9979,
415,
509,
62,
66,
32,
796,
366,
42,
62,
66,
32,
1,
198,
9979,
415,
509,
62,
66,
33,
796,
366,
42,
62,
66,
33,
1,
198,
9979,
415,
509,
62,
66,
34,
796,
366,
42,
62,
66,
34,
1,
198,
9979,
415,
509,
62,
66,
35,
796,
366,
42,
62,
66,
35,
1,
198,
9979,
415,
509,
62,
66,
36,
796,
366,
42,
62,
66,
36,
1,
198,
9979,
415,
509,
62,
66,
37,
796,
366,
42,
62,
66,
37,
1,
198,
9979,
415,
509,
62,
66,
38,
796,
366,
42,
62,
66,
38,
1,
198,
9979,
415,
509,
62,
66,
41,
796,
366,
42,
62,
66,
41,
1,
198,
9979,
415,
509,
62,
66,
42,
796,
366,
42,
62,
66,
42,
1,
198,
9979,
415,
509,
62,
66,
43,
796,
366,
42,
62,
66,
43,
1,
198,
9979,
415,
509,
62,
66,
45,
796,
366,
42,
62,
66,
45,
1,
198,
9979,
415,
509,
62,
66,
46,
796,
366,
42,
62,
66,
46,
1,
198,
9979,
415,
509,
62,
66,
47,
796,
366,
42,
62,
66,
47,
1,
198,
9979,
415,
509,
62,
66,
48,
796,
366,
42,
62,
66,
48,
1,
198,
9979,
415,
509,
62,
66,
49,
796,
366,
42,
62,
66,
49,
1,
198,
9979,
415,
509,
62,
66,
50,
796,
366,
42,
62,
66,
50,
1,
198,
9979,
415,
509,
62,
66,
51,
796,
366,
42,
62,
66,
51,
1,
198,
9979,
415,
509,
62,
66,
52,
796,
366,
42,
62,
66,
52,
1,
198,
9979,
415,
509,
62,
66,
53,
796,
366,
42,
62,
66,
53,
1,
198,
9979,
415,
509,
62,
66,
54,
796,
366,
42,
62,
66,
54,
1,
198,
9979,
415,
509,
62,
66,
55,
796,
366,
42,
62,
66,
55,
1,
198,
9979,
415,
509,
62,
66,
56,
796,
366,
42,
62,
66,
56,
1,
198,
9979,
415,
509,
62,
66,
57,
796,
366,
42,
62,
66,
57,
1,
198,
9979,
415,
509,
62,
42646,
796,
366,
42,
62,
42646,
1,
198,
9979,
415,
509,
62,
76,
33,
796,
366,
42,
62,
76,
33,
1,
198,
9979,
415,
509,
62,
76,
34,
796,
366,
42,
62,
76,
34,
1,
198,
9979,
415,
509,
62,
76,
35,
796,
366,
42,
62,
76,
35,
1,
198,
9979,
415,
509,
62,
76,
36,
796,
366,
42,
62,
76,
36,
1,
198,
9979,
415,
509,
62,
76,
37,
796,
366,
42,
62,
76,
37,
1,
198,
9979,
415,
509,
62,
76,
38,
796,
366,
42,
62,
76,
38,
1,
198,
9979,
415,
509,
62,
76,
39,
796,
366,
42,
62,
76,
39,
1,
198,
9979,
415,
509,
62,
76,
40,
796,
366,
42,
62,
76,
40,
1,
198,
9979,
415,
509,
62,
76,
41,
796,
366,
42,
62,
76,
41,
1,
198,
9979,
415,
509,
62,
76,
42,
796,
366,
42,
62,
76,
42,
1,
198,
9979,
415,
509,
62,
32087,
796,
366,
42,
62,
32087,
1,
198,
9979,
415,
509,
62,
76,
44,
796,
366,
42,
62,
76,
44,
1,
198,
9979,
415,
509,
62,
76,
45,
796,
366,
42,
62,
76,
45,
1,
198,
9979,
415,
509,
62,
76,
46,
796,
366,
42,
62,
76,
46,
1,
198,
9979,
415,
509,
62,
76,
47,
796,
366,
42,
62,
76,
47,
1,
198,
9979,
415,
509,
62,
76,
48,
796,
366,
42,
62,
76,
48,
1,
198,
9979,
415,
509,
62,
76,
49,
796,
366,
42,
62,
76,
49,
1,
198,
9979,
415,
509,
62,
76,
50,
796,
366,
42,
62,
76,
50,
1,
198,
9979,
415,
509,
62,
76,
51,
796,
366,
42,
62,
76,
51,
1,
198,
9979,
415,
509,
62,
76,
52,
796,
366,
42,
62,
76,
52,
1,
198,
9979,
415,
509,
62,
76,
53,
796,
366,
42,
62,
76,
53,
1,
198,
9979,
415,
509,
62,
76,
54,
796,
366,
42,
62,
76,
54,
1,
198,
9979,
415,
509,
62,
76,
55,
796,
366,
42,
62,
76,
55,
1,
198,
9979,
415,
509,
62,
76,
56,
796,
366,
42,
62,
76,
56,
1,
198,
9979,
415,
509,
62,
76,
57,
796,
366,
42,
62,
76,
57,
1,
198,
9979,
415,
509,
62,
4462,
796,
366,
42,
62,
4462,
1,
198,
9979,
415,
509,
62,
5603,
33,
796,
366,
42,
62,
5603,
33,
1,
198,
9979,
415,
509,
62,
9419,
796,
366,
42,
62,
9419,
1,
198,
9979,
415,
509,
62,
4303,
796,
366,
42,
62,
4303,
1,
198,
9979,
415,
509,
62,
1546,
34,
796,
366,
42,
62,
1546,
34,
1,
198,
9979,
415,
509,
62,
82,
9419,
796,
366,
42,
62,
82,
9419,
1,
198,
9979,
415,
509,
62,
82,
5603,
33,
796,
366,
42,
62,
82,
5603,
33,
1,
198,
9979,
415,
509,
62,
66,
5603,
33,
796,
366,
42,
62,
66,
5603,
33,
1,
198,
9979,
415,
509,
62,
76,
5603,
33,
796,
366,
42,
62,
76,
5603,
33,
1,
198,
9979,
415,
509,
62,
39069,
796,
366,
42,
62,
39069,
1,
198,
9979,
415,
509,
62,
8577,
796,
366,
42,
62,
8577,
1,
198,
9979,
415,
509,
62,
6968,
8577,
796,
366,
42,
62,
6968,
8577,
1,
198,
9979,
415,
509,
62,
2538,
9792,
796,
366,
42,
62,
2538,
9792,
1,
198,
9979,
415,
509,
62,
49,
9947,
796,
366,
42,
62,
49,
9947,
1,
198,
9979,
415,
509,
62,
10619,
796,
366,
42,
62,
10619,
1,
198,
9979,
415,
509,
62,
41925,
796,
366,
42,
62,
41925,
1,
198,
9979,
415,
509,
62,
6968,
35504,
796,
366,
42,
62,
6968,
35504,
1,
198,
9979,
415,
509,
62,
44,
2389,
35,
2538,
796,
366,
42,
62,
44,
2389,
35,
2538,
1,
198,
9979,
415,
509,
62,
20913,
796,
366,
42,
62,
20913,
1,
198,
9979,
415,
509,
62,
35,
3698,
796,
366,
42,
62,
35,
3698,
1,
198,
9979,
415,
509,
62,
82,
39069,
796,
366,
42,
62,
82,
39069,
1,
198,
9979,
415,
509,
62,
82,
8577,
796,
366,
42,
62,
82,
8577,
1,
198,
9979,
415,
509,
62,
82,
6968,
8577,
796,
366,
42,
62,
82,
6968,
8577,
1,
198,
9979,
415,
509,
62,
82,
2538,
9792,
796,
366,
42,
62,
82,
2538,
9792,
1,
198,
9979,
415,
509,
62,
82,
49,
9947,
796,
366,
42,
62,
82,
49,
9947,
1,
198,
9979,
415,
509,
62,
82,
10619,
796,
366,
42,
62,
82,
10619,
1,
198,
9979,
415,
509,
62,
82,
41925,
796,
366,
42,
62,
82,
41925,
1,
198,
9979,
415,
509,
62,
82,
6968,
35504,
796,
366,
42,
62,
82,
6968,
35504,
1,
198,
9979,
415,
509,
62,
66,
39069,
796,
366,
42,
62,
66,
39069,
1,
198,
9979,
415,
509,
62,
66,
6968,
8577,
796,
366,
42,
62,
66,
6968,
8577,
1,
198,
9979,
415,
509,
62,
66,
2538,
9792,
796,
366,
42,
62,
66,
2538,
9792,
1,
198,
9979,
415,
509,
62,
66,
49,
9947,
796,
366,
42,
62,
66,
49,
9947,
1,
198,
9979,
415,
509,
62,
66,
10619,
796,
366,
42,
62,
66,
10619,
1,
198,
9979,
415,
509,
62,
66,
6968,
35504,
796,
366,
42,
62,
66,
6968,
35504,
1,
198,
9979,
415,
509,
62,
66,
8577,
796,
366,
42,
62,
66,
8577,
1,
198,
9979,
415,
509,
62,
66,
41925,
796,
366,
42,
62,
66,
41925,
1,
198,
9979,
415,
509,
62,
66,
44,
2389,
35,
2538,
796,
366,
42,
62,
66,
44,
2389,
35,
2538,
1,
198,
9979,
415,
509,
62,
66,
20913,
796,
366,
42,
62,
66,
20913,
1,
198,
9979,
415,
509,
62,
66,
35,
3698,
796,
366,
42,
62,
66,
35,
3698,
1,
198,
9979,
415,
509,
62,
76,
39069,
796,
366,
42,
62,
76,
39069,
1,
198,
9979,
415,
509,
62,
76,
6968,
8577,
796,
366,
42,
62,
76,
6968,
8577,
1,
198,
9979,
415,
509,
62,
76,
2538,
9792,
796,
366,
42,
62,
76,
2538,
9792,
1,
198,
9979,
415,
509,
62,
76,
49,
9947,
796,
366,
42,
62,
76,
49,
9947,
1,
198,
9979,
415,
509,
62,
76,
10619,
796,
366,
42,
62,
76,
10619,
1,
198,
9979,
415,
509,
62,
76,
6968,
35504,
796,
366,
42,
62,
76,
6968,
35504,
1,
198,
9979,
415,
509,
62,
76,
8577,
796,
366,
42,
62,
76,
8577,
1,
198,
9979,
415,
509,
62,
76,
41925,
796,
366,
42,
62,
76,
41925,
1,
198,
9979,
415,
509,
62,
76,
20913,
796,
366,
42,
62,
76,
20913,
1,
198,
9979,
415,
509,
62,
76,
35,
3698,
796,
366,
42,
62,
76,
35,
3698,
1,
198,
9979,
415,
509,
62,
37,
16,
796,
366,
42,
62,
37,
16,
1,
198,
9979,
415,
509,
62,
37,
17,
796,
366,
42,
62,
37,
17,
1,
198,
9979,
415,
509,
62,
37,
18,
796,
366,
42,
62,
37,
18,
1,
198,
9979,
415,
509,
62,
37,
19,
796,
366,
42,
62,
37,
19,
1,
198,
9979,
415,
509,
62,
37,
20,
796,
366,
42,
62,
37,
20,
1,
198,
9979,
415,
509,
62,
37,
21,
796,
366,
42,
62,
37,
21,
1,
198,
9979,
415,
509,
62,
37,
22,
796,
366,
42,
62,
37,
22,
1,
198,
9979,
415,
509,
62,
37,
23,
796,
366,
42,
62,
37,
23,
1,
198,
9979,
415,
509,
62,
37,
24,
796,
366,
42,
62,
37,
24,
1,
198,
9979,
415,
509,
62,
37,
940,
796,
366,
42,
62,
37,
940,
1,
198,
9979,
415,
509,
62,
37,
1157,
796,
366,
42,
62,
37,
1157,
1,
198,
9979,
415,
509,
62,
37,
1065,
796,
366,
42,
62,
37,
1065,
1,
198,
9979,
415,
509,
62,
82,
37,
16,
796,
366,
42,
62,
82,
37,
16,
1,
198,
9979,
415,
509,
62,
82,
37,
17,
796,
366,
42,
62,
82,
37,
17,
1,
198,
9979,
415,
509,
62,
82,
37,
18,
796,
366,
42,
62,
82,
37,
18,
1,
198,
9979,
415,
509,
62,
82,
37,
19,
796,
366,
42,
62,
82,
37,
19,
1,
198,
9979,
415,
509,
62,
82,
37,
20,
796,
366,
42,
62,
82,
37,
20,
1,
198,
9979,
415,
509,
62,
82,
37,
21,
796,
366,
42,
62,
82,
37,
21,
1,
198,
9979,
415,
509,
62,
82,
37,
22,
796,
366,
42,
62,
82,
37,
22,
1,
198,
9979,
415,
509,
62,
82,
37,
23,
796,
366,
42,
62,
82,
37,
23,
1,
198,
9979,
415,
509,
62,
82,
37,
24,
796,
366,
42,
62,
82,
37,
24,
1,
198,
9979,
415,
509,
62,
82,
37,
940,
796,
366,
42,
62,
82,
37,
940,
1,
198,
9979,
415,
509,
62,
82,
37,
1157,
796,
366,
42,
62,
82,
37,
1157,
1,
198,
9979,
415,
509,
62,
82,
37,
1065,
796,
366,
42,
62,
82,
37,
1065,
1,
198,
9979,
415,
509,
62,
66,
37,
16,
796,
366,
42,
62,
66,
37,
16,
1,
198,
9979,
415,
509,
62,
66,
37,
17,
796,
366,
42,
62,
66,
37,
17,
1,
198,
9979,
415,
509,
62,
66,
37,
18,
796,
366,
42,
62,
66,
37,
18,
1,
198,
9979,
415,
509,
62,
66,
37,
19,
796,
366,
42,
62,
66,
37,
19,
1,
198,
9979,
415,
509,
62,
66,
37,
20,
796,
366,
42,
62,
66,
37,
20,
1,
198,
9979,
415,
509,
62,
66,
37,
21,
796,
366,
42,
62,
66,
37,
21,
1,
198,
9979,
415,
509,
62,
66,
37,
22,
796,
366,
42,
62,
66,
37,
22,
1,
198,
9979,
415,
509,
62,
66,
37,
23,
796,
366,
42,
62,
66,
37,
23,
1,
198,
9979,
415,
509,
62,
66,
37,
24,
796,
366,
42,
62,
66,
37,
24,
1,
198,
9979,
415,
509,
62,
66,
37,
940,
796,
366,
42,
62,
66,
37,
940,
1,
198,
9979,
415,
509,
62,
66,
37,
1157,
796,
366,
42,
62,
66,
37,
1157,
1,
198,
9979,
415,
509,
62,
66,
37,
1065,
796,
366,
42,
62,
66,
37,
1065,
1,
198,
9979,
415,
509,
62,
76,
37,
16,
796,
366,
42,
62,
76,
37,
16,
1,
198,
9979,
415,
509,
62,
76,
37,
17,
796,
366,
42,
62,
76,
37,
17,
1,
198,
9979,
415,
509,
62,
76,
37,
18,
796,
366,
42,
62,
76,
37,
18,
1,
198,
9979,
415,
509,
62,
76,
37,
19,
796,
366,
42,
62,
76,
37,
19,
1,
198,
9979,
415,
509,
62,
76,
37,
20,
796,
366,
42,
62,
76,
37,
20,
1,
198,
9979,
415,
509,
62,
76,
37,
21,
796,
366,
42,
62,
76,
37,
21,
1,
198,
9979,
415,
509,
62,
76,
37,
22,
796,
366,
42,
62,
76,
37,
22,
1,
198,
9979,
415,
509,
62,
76,
37,
23,
796,
366,
42,
62,
76,
37,
23,
1,
198,
9979,
415,
509,
62,
76,
37,
24,
796,
366,
42,
62,
76,
37,
24,
1,
198,
9979,
415,
509,
62,
76,
37,
940,
796,
366,
42,
62,
76,
37,
940,
1,
198,
9979,
415,
509,
62,
76,
16,
796,
366,
42,
62,
76,
16,
1,
198,
9979,
415,
509,
62,
76,
17,
796,
366,
42,
62,
76,
17,
1,
198,
9979,
415,
509,
62,
76,
18,
796,
366,
42,
62,
76,
18,
1,
198,
9979,
415,
509,
62,
76,
19,
796,
366,
42,
62,
76,
19,
1,
198,
9979,
415,
509,
62,
76,
20,
796,
366,
42,
62,
76,
20,
1,
198,
9979,
415,
509,
62,
76,
21,
796,
366,
42,
62,
76,
21,
1,
198,
9979,
415,
509,
62,
76,
22,
796,
366,
42,
62,
76,
22,
1,
198,
9979,
415,
509,
62,
76,
23,
796,
366,
42,
62,
76,
23,
1,
198,
9979,
415,
509,
62,
76,
24,
796,
366,
42,
62,
76,
24,
1,
198,
9979,
415,
509,
62,
76,
15,
796,
366,
42,
62,
76,
15,
1,
198,
198,
7804,
4242,
2235,
198,
2,
220,
5315,
5657,
220,
1303,
198,
7804,
4242,
2235,
198,
198,
9979,
415,
36871,
62,
27082,
4694,
796,
366,
41359,
62,
27082,
4694,
1,
198,
9979,
415,
36871,
62,
5222,
3069,
50,
796,
366,
41359,
62,
5222,
3069,
50,
1,
198,
9979,
415,
18671,
3069,
796,
366,
5222,
3069,
1,
198,
9979,
415,
22814,
28206,
62,
33489,
796,
366,
46437,
28206,
62,
33489,
1,
198,
9979,
415,
37041,
62,
46437,
28206,
796,
366,
9693,
3913,
62,
46437,
28206,
1,
198,
9979,
415,
37041,
62,
23683,
18672,
13153,
796,
366,
9693,
3913,
62,
23683,
18672,
13153,
1,
198,
9979,
415,
4810,
3955,
13153,
62,
5222,
3069,
796,
366,
4805,
3955,
13153,
62,
5222,
3069,
1,
198,
9979,
415,
10729,
18672,
13153,
62,
5222,
3069,
796,
366,
23683,
18672,
13153,
62,
5222,
3069,
1,
198,
9979,
415,
6375,
28495,
6234,
796,
366,
1581,
28495,
6234,
1,
198,
9979,
415,
45880,
1503,
1961,
796,
366,
50,
10917,
1503,
1961,
1,
198,
9979,
415,
6006,
2885,
3913,
1961,
796,
366,
9693,
2885,
3913,
1961,
1,
198,
9979,
415,
20571,
45746,
35400,
796,
366,
19499,
45746,
35400,
1,
198,
9979,
415,
48213,
4303,
1503,
45155,
796,
366,
5446,
1565,
4303,
1503,
45155,
1,
198,
9979,
415,
18671,
3069,
62,
23199,
796,
366,
5222,
3069,
62,
23199,
1,
198,
9979,
415,
27489,
49361,
62,
23199,
796,
366,
13918,
49361,
62,
23199,
1,
198,
9979,
415,
33493,
62,
23199,
796,
366,
46506,
62,
23199,
1,
198,
9979,
415,
12672,
31949,
62,
23199,
796,
366,
17887,
31949,
62,
23199,
1,
198,
9979,
415,
569,
17395,
20151,
796,
366,
15858,
20151,
1,
198,
9979,
415,
48345,
14887,
35830,
1847,
796,
366,
39,
1581,
14887,
35830,
1847,
1,
198,
198,
7804,
4242,
2235,
198,
2,
220,
39794,
220,
220,
220,
220,
1303,
198,
7804,
4242,
2235,
198,
198,
9979,
415,
11096,
796,
366,
7036,
1,
198,
9979,
415,
45216,
1961,
796,
366,
39758,
1961,
1,
198,
9979,
415,
7852,
31444,
1961,
796,
366,
5097,
31444,
1961,
1,
198,
9979,
415,
48213,
4303,
1503,
3525,
796,
366,
5446,
1565,
4303,
1503,
3525,
1,
198,
9979,
415,
44521,
62,
6173,
13252,
3069,
17534,
62,
34509,
1546,
796,
366,
45,
1340,
62,
6173,
13252,
3069,
17534,
62,
34509,
1546,
1,
198,
9979,
415,
44521,
62,
6173,
13252,
3069,
17534,
62,
25154,
50,
796,
366,
45,
1340,
62,
6173,
13252,
3069,
17534,
62,
25154,
50,
1,
198,
9979,
415,
43901,
1268,
796,
366,
1581,
3528,
1268,
1,
198,
9979,
415,
8005,
62,
46786,
796,
366,
15285,
62,
46786,
1,
198,
9979,
415,
31328,
62,
24027,
796,
366,
39776,
2257,
62,
24027,
1,
198,
9979,
415,
31328,
62,
25154,
796,
366,
39776,
2257,
62,
25154,
1,
198,
9979,
415,
360,
2606,
19146,
62,
19499,
45746,
796,
366,
35,
2606,
19146,
62,
19499,
45746,
1,
198,
9979,
415,
27564,
29722,
796,
366,
43,
3955,
29722,
1,
198,
9979,
415,
15628,
53,
1921,
796,
366,
44565,
53,
1921,
1,
198,
9979,
415,
8959,
11879,
62,
44565,
53,
1921,
796,
366,
3955,
11879,
62,
44565,
53,
1921,
1,
198,
9979,
415,
34958,
62,
29817,
34563,
796,
366,
37,
9994,
62,
29817,
34563,
1,
198,
9979,
415,
337,
20958,
2943,
43,
11860,
62,
23199,
796,
366,
44,
20958,
2943,
43,
11860,
62,
23199,
1,
198,
9979,
415,
337,
20958,
3620,
2394,
2849,
62,
23199,
796,
366,
44,
20958,
3620,
2394,
2849,
62,
23199,
1,
198,
9979,
415,
360,
20530,
62,
23199,
796,
366,
35,
20530,
62,
23199,
1,
198,
9979,
415,
370,
2389,
4221,
62,
23199,
796,
366,
54,
2389,
4221,
62,
23199,
1,
198,
9979,
415,
11179,
9947,
62,
23199,
796,
366,
13909,
9947,
62,
23199,
1,
198,
9979,
415,
22879,
1268,
1546,
62,
23199,
796,
366,
32572,
1268,
1546,
62,
23199,
1,
198,
9979,
415,
8823,
3535,
50,
62,
23199,
796,
366,
7792,
3535,
50,
62,
23199,
1,
198,
9979,
415,
367,
4303,
1565,
62,
23199,
796,
366,
39,
4303,
1565,
62,
23199,
1,
198,
9979,
415,
569,
4303,
1565,
62,
23199,
796,
366,
53,
4303,
1565,
62,
23199,
1,
198,
9979,
415,
6374,
13252,
3069,
2751,
62,
23199,
796,
366,
6173,
13252,
3069,
2751,
62,
23199,
1,
198,
198,
14468,
21017,
198,
2,
220,
5315,
46532,
220,
220,
1303,
198,
14468,
21017,
198,
198,
9979,
415,
25228,
796,
366,
36982,
1,
198,
9979,
415,
5870,
27746,
62,
23199,
796,
366,
3398,
27746,
62,
23199,
1,
198,
9979,
415,
44779,
62,
23199,
796,
366,
35,
33202,
62,
23199,
1,
198,
198,
14468,
21017,
198,
2,
220,
3254,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
198,
14468,
21017,
198,
198,
9979,
415,
314,
4177,
43,
62,
44,
20958,
3620,
46,
6089,
62,
23199,
796,
366,
44,
20958,
3620,
46,
6089,
62,
23199,
1,
198,
9979,
415,
314,
4177,
43,
62,
47526,
11357,
62,
32761,
62,
23199,
796,
366,
47526,
11357,
62,
32761,
62,
23199,
1,
198,
9979,
415,
314,
4177,
43,
62,
47526,
11357,
62,
2200,
22781,
62,
23199,
796,
366,
47526,
11357,
62,
2200,
22781,
62,
23199,
1,
198,
9979,
415,
314,
4177,
43,
62,
39,
1581,
14887,
35830,
1847,
796,
366,
39,
1581,
14887,
35830,
1847,
1,
198,
9979,
415,
314,
4177,
43,
62,
15858,
20151,
796,
366,
15858,
20151,
1,
198,
9979,
415,
314,
4177,
43,
62,
9693,
3913,
51,
11860,
50,
796,
366,
9693,
3913,
51,
11860,
50,
1,
198,
198,
14468,
21017,
198,
2,
220,
309,
8937,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
198,
14468,
21017,
198,
198,
9979,
415,
314,
4177,
43,
62,
35222,
796,
366,
35222,
1,
198,
9979,
415,
314,
4177,
43,
62,
33,
29089,
2662,
796,
366,
33,
29089,
2662,
1,
198,
9979,
415,
314,
4177,
43,
62,
2538,
9792,
796,
366,
2538,
9792,
1,
198,
9979,
415,
314,
4177,
43,
62,
49,
9947,
796,
366,
49,
9947,
1,
198,
9979,
415,
314,
4177,
43,
62,
5603,
33,
25216,
796,
366,
5603,
33,
25216,
1,
198,
9979,
415,
314,
4177,
43,
62,
5603,
19313,
2043,
2538,
796,
366,
5603,
19313,
2043,
2538,
1,
198,
9979,
415,
314,
4177,
43,
62,
5603,
4462,
35400,
796,
366,
5603,
4462,
35400,
1,
198,
9979,
415,
314,
4177,
43,
62,
5603,
2749,
39,
27746,
62,
23199,
796,
366,
5603,
2749,
39,
27746,
62,
23199,
1,
198,
9979,
415,
314,
4177,
43,
62,
37,
35830,
796,
366,
37,
35830,
1,
198,
9979,
415,
314,
4177,
43,
62,
37,
35830,
62,
10659,
9306,
796,
366,
37,
35830,
62,
10659,
9306,
1,
198,
9979,
415,
314,
4177,
43,
62,
37,
35830,
62,
1268,
10659,
9306,
796,
366,
37,
35830,
62,
1268,
10659,
9306,
1,
198,
198,
14468,
21017,
198,
2,
220,
35094,
469,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
198,
14468,
21017,
198,
198,
9979,
415,
314,
4177,
43,
62,
9693,
3913,
62,
32541,
796,
366,
9693,
3913,
62,
32541,
1,
198,
9979,
415,
314,
4177,
43,
62,
35,
11211,
1961,
796,
366,
35,
11211,
1961,
1,
198,
9979,
415,
314,
4177,
43,
62,
40569,
38,
1268,
796,
366,
40569,
38,
1268,
1,
198,
9979,
415,
314,
4177,
43,
62,
32541,
796,
366,
32541,
1,
198,
198,
14468,
21017,
198,
2,
220,
21269,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
198,
14468,
21017,
198,
198,
9979,
415,
314,
4177,
43,
62,
35,
16938,
9050,
796,
366,
35,
16938,
9050,
1,
198,
9979,
415,
314,
4177,
43,
62,
39,
1581,
14887,
35830,
1847,
796,
366,
39,
1581,
14887,
35830,
1847,
1,
198,
9979,
415,
314,
4177,
43,
62,
15858,
20151,
796,
366,
15858,
20151,
1,
198,
9979,
415,
314,
4177,
43,
62,
34,
49060,
37232,
796,
366,
34,
49060,
37232,
1,
198,
9979,
415,
314,
4177,
43,
62,
4944,
2043,
796,
366,
4944,
2043,
1,
198,
198,
14468,
21017,
198,
2,
220,
24936,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
198,
14468,
21017,
198,
198,
9979,
415,
46962,
2043,
3620,
62,
23199,
796,
366,
3525,
1137,
2043,
3620,
62,
23199,
1,
198,
9979,
415,
12509,
32,
6089,
2043,
3620,
62,
23199,
796,
366,
2538,
32,
6089,
2043,
3620,
62,
23199,
1,
198,
9979,
415,
39219,
62,
23199,
796,
366,
1961,
17941,
62,
23199,
1,
198,
9979,
415,
49583,
62,
23199,
796,
366,
5097,
11860,
62,
23199,
1,
198,
9979,
415,
10560,
3185,
62,
23199,
796,
366,
7707,
3185,
62,
23199,
1,
198,
9979,
415,
10560,
3185,
46506,
62,
23199,
796,
366,
7707,
3185,
46506,
62,
23199,
1,
198,
9979,
415,
10560,
3185,
50084,
62,
23199,
796,
366,
7707,
3185,
50084,
62,
23199,
1,
198,
9979,
415,
6374,
13252,
3069,
62,
23199,
796,
366,
6173,
13252,
3069,
62,
23199,
1,
198,
9979,
415,
26173,
8924,
62,
23199,
796,
366,
39488,
62,
23199,
1,
198,
9979,
415,
26173,
8924,
62,
24706,
62,
23199,
796,
366,
39488,
62,
24706,
62,
23199,
1,
198,
9979,
415,
18930,
24639,
62,
23199,
796,
366,
44603,
62,
23199,
1,
198,
9979,
415,
15731,
14887,
3620,
1404,
7112,
55,
796,
366,
19535,
14887,
3620,
1404,
7112,
55,
1,
198,
9979,
415,
5984,
19260,
1268,
796,
366,
2885,
19260,
1268,
1,
198,
9979,
415,
5984,
9697,
3535,
796,
366,
2885,
9697,
3535,
1,
198,
9979,
415,
5550,
3069,
1268,
796,
366,
7206,
3069,
1268,
1,
198,
9979,
415,
28163,
25154,
796,
366,
35,
3698,
25154,
1,
198,
9979,
415,
399,
52,
5805,
1268,
796,
366,
45,
52,
5805,
1268,
1,
198,
9979,
415,
36871,
25154,
796,
366,
41359,
25154,
1,
198,
9979,
415,
399,
52,
5805,
1268,
62,
29817,
34563,
796,
366,
45,
52,
5805,
1268,
62,
29817,
34563,
1,
198,
9979,
415,
36871,
25154,
62,
29817,
34563,
796,
366,
41359,
25154,
62,
29817,
34563,
1,
198,
9979,
415,
39641,
1961,
796,
366,
44,
14175,
1961,
1,
198,
9979,
415,
370,
2389,
4221,
32988,
796,
366,
54,
2389,
4221,
32988,
1,
198,
9979,
415,
11179,
9947,
32988,
796,
366,
13909,
9947,
32988,
1,
198,
9979,
415,
15986,
32,
796,
366,
12203,
32,
1,
198,
9979,
415,
39641,
62,
49058,
796,
366,
44,
14175,
62,
49058,
1,
198,
9979,
415,
43277,
796,
366,
34509,
1,
198,
9979,
415,
20444,
796,
366,
25154,
1,
198,
9979,
415,
43277,
25154,
796,
366,
34509,
25154,
1,
198,
9979,
415,
18671,
3069,
796,
366,
5222,
3069,
1,
198,
9979,
415,
48483,
62,
49058,
796,
366,
24706,
62,
49058,
1,
198,
9979,
415,
376,
4503,
2937,
62,
5222,
3069,
796,
366,
37,
4503,
2937,
62,
5222,
3069,
1,
198,
9979,
415,
43901,
1268,
796,
366,
1581,
3528,
1268,
1,
198,
9979,
415,
23848,
20530,
796,
366,
22083,
20530,
1,
198,
9979,
415,
22814,
12861,
20958,
39488,
796,
366,
46437,
12861,
20958,
39488,
1,
198,
9979,
415,
337,
20958,
3620,
46,
6089,
62,
23199,
796,
366,
44,
20958,
3620,
46,
6089,
62,
23199,
1,
198,
198,
14468,
21017,
198,
2,
220,
12200,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
198,
14468,
21017,
198,
198,
9979,
415,
27841,
2538,
8579,
796,
366,
29266,
2538,
8579,
1,
198,
9979,
415,
5984,
11012,
49,
1565,
3398,
796,
366,
2885,
11012,
49,
1565,
3398,
1,
198,
9979,
415,
28163,
45,
16820,
796,
366,
35,
3698,
45,
16820,
1,
198,
9979,
415,
8959,
11879,
2538,
8579,
796,
366,
3955,
11879,
2538,
8579,
1,
198,
9979,
415,
8959,
11879,
11473,
1565,
3398,
8220,
3069,
44580,
1961,
796,
366,
3955,
11879,
11473,
1565,
3398,
8220,
3069,
44580,
1961,
1,
198,
9979,
415,
8959,
11879,
11473,
1565,
3398,
49864,
6981,
1961,
796,
366,
3955,
11879,
11473,
1565,
3398,
49864,
6981,
1961,
1,
198,
9979,
415,
8959,
11879,
49864,
6981,
1961,
796,
366,
3955,
11879,
49864,
6981,
1961,
1,
198,
9979,
415,
509,
12115,
796,
366,
42,
12115,
1,
198,
9979,
415,
29463,
3525,
796,
366,
27082,
3525,
1,
198,
9979,
415,
5550,
47,
4221,
796,
366,
46162,
4221,
1,
198,
9979,
415,
39641,
1961,
796,
366,
44,
14175,
1961,
1,
198,
9979,
415,
27841,
49864,
6981,
1961,
796,
366,
29266,
49864,
6981,
1961,
1,
198,
9979,
415,
45249,
796,
366,
4177,
7836,
1,
198,
9979,
415,
6006,
32297,
796,
366,
9693,
32297,
1,
198,
9979,
415,
35454,
796,
366,
44724,
1,
198,
9979,
415,
33303,
2751,
796,
366,
2257,
7227,
2751,
1,
198,
9979,
415,
12509,
8579,
796,
366,
2538,
8579,
1,
198,
9979,
415,
11177,
1565,
3398,
796,
366,
11473,
1565,
3398,
1,
198,
9979,
415,
33493,
1961,
796,
366,
46506,
1961,
1,
198,
9979,
415,
5870,
4146,
7707,
1677,
796,
366,
3398,
4146,
7707,
1677,
1,
198,
9979,
415,
39641,
1961,
796,
366,
44,
14175,
1961,
1,
198,
9979,
415,
15107,
2394,
796,
366,
13252,
2394,
1,
198,
9979,
415,
41894,
796,
366,
43,
11262,
1,
198,
9979,
415,
23842,
8577,
796,
366,
6968,
8577,
1,
198,
9979,
415,
23842,
35504,
796,
366,
6968,
35504,
1,
198,
9979,
415,
39726,
796,
366,
45,
13918,
1,
198,
9979,
415,
22814,
12861,
20958,
796,
366,
46437,
12861,
20958,
1,
198,
9979,
415,
3268,
15858,
796,
366,
1268,
15858,
1,
198,
9979,
415,
9878,
11290,
796,
366,
9148,
11290,
1,
198,
9979,
415,
30301,
1503,
7036,
796,
366,
29931,
1503,
7036,
1,
198,
9979,
415,
39641,
7036,
796,
366,
44,
14175,
7036,
1,
198,
9979,
415,
3268,
15858,
7036,
796,
366,
1268,
15858,
7036,
1,
198,
9979,
415,
23848,
20530,
796,
366,
22083,
20530,
1,
198,
9979,
415,
7375,
3069,
44580,
1961,
796,
366,
8220,
3069,
44580,
1961,
1,
198,
9979,
415,
25703,
6981,
1961,
796,
366,
49864,
6981,
1961,
1,
198,
9979,
415,
33493,
2849,
62,
23199,
796,
366,
46506,
2849,
62,
23199,
1,
198,
9979,
415,
11177,
1565,
3398,
3185,
1677,
62,
23199,
796,
366,
11473,
1565,
3398,
3185,
1677,
62,
23199,
1,
198,
9979,
415,
11177,
1565,
3398,
32737,
62,
23199,
796,
366,
11473,
1565,
3398,
32737,
62,
23199,
1,
198,
9979,
415,
371,
18060,
4825,
43,
11860,
62,
23199,
796,
366,
49,
18060,
4825,
43,
11860,
62,
23199,
1,
198,
9979,
415,
7788,
2943,
37780,
2538,
8579,
62,
23199,
796,
366,
6369,
2943,
37780,
2538,
8579,
62,
23199,
1,
198,
9979,
415,
371,
1677,
2390,
1677,
16820,
62,
23199,
796,
366,
49,
1677,
2390,
1677,
16820,
62,
23199,
1,
198,
9979,
415,
8959,
38,
2538,
8579,
796,
366,
3955,
38,
2538,
8579,
1,
198,
9979,
415,
8959,
38,
8220,
3069,
44580,
1961,
796,
366,
3955,
38,
8220,
3069,
44580,
1961,
1,
198,
9979,
415,
8959,
38,
49864,
6981,
1961,
796,
366,
3955,
38,
49864,
6981,
1961,
1,
198,
9979,
415,
8959,
4579,
43,
15154,
796,
366,
3955,
4579,
43,
15154,
1,
198,
9979,
415,
8959,
16960,
2969,
1137,
796,
366,
3955,
16960,
2969,
1137,
1,
198
] | 2.157975 | 9,166 |
##########################################################################
# Basic functionality for doing MPS calculations with OBC #
##########################################################################
using LinearAlgebra
using Arpack
# Define sites as 3 legged tensors filled with elements of some type
Site{T} = Array{T,3}
# An MPS is an array of Sites of a certain type
MPS{T} = Vector{Site{T}}
# Define operators as 4 legged tensors filled with elements of some type
Operator{T} = Array{T,4}
# A MPO is an array of Operators
MPO{T} = Vector{Operator{T}}
"""
random_mps_obc(N::Int, D::Int, d, tensortype::Type{T}=ComplexF64)::MPS{T} where T
Function to generate a random MPS with OBC
N: Number of sites
D: Bond dimension
d: Vector of physical dimensions, if a single integer dimension is given, it is assumed that all physical dimensions are the same, if varying dimensions are wanted a vector of integers of length N has to be supplied
The convention for the 3 index tensors is that the first two are the virtual ones, the last one is the physical one
3
|
1--A--2
"""
function random_mps_obc(N::Int, D::Int, d, tensortype::Type{T} = ComplexF64)::MPS{T} where {T}
# Ensure the the system size is at least two
@assert(N > 1)
# Initialize
mps = Array{Site{T}}(undef, N)
if isa(d, Number)
# Single number, I assume all dimensions are the same
dim = d * ones(Int64, N)
else
# Make sure that the input is really a vector as julia distinguishes between nx1 matrices and column vectors
dim = vec(d)
# Make sure input is valid
@assert(length(dim) == N)
end
# Left boundary tensor (row vector)
mps[1] = rand(tensortype, 1, D, dim[1])
# Right boundary tensor (column vector)
mps[N] = rand(tensortype, D, 1, dim[N])
# Tensors in between
for i = 2:N-1
mps[i] = rand(tensortype, D, D, dim[i])
end
return mps
end
"""
basis_state_obc(configuration::Vector{<:Int}, d::Int=2)::MPS
Prepare the a product state corresponding |configuration> on N sites where configuration is an Array containing N elements from 1 to d. Each site is then initialized in the dth canonical basis state
"""
function basis_state_obc(configuration::Vector{<:Int}, d::Int = 2)::MPS{Float64}
# Some error checking
if any(x -> (x < 1 || x > d), configuration)
throw(ArgumentError("configuration must contain integer elements in the range from 1 to d, got d=$(repr(d)), configuration=$(repr(configuration))"))
end
# Generate the MPS
N = length(configuration)
psi = MPS{Float64}(undef, N)
tensors = Vector{Array{Float64,3}}(undef, d)
for i = 1:d
tmp = zeros(Float64, 1, 1, d)
tmp[1, 1, i] = 1.0
tensors[i] = tmp
end
for i = 1:N
psi[i] = tensors[configuration[i]]
end
return psi
end
"""
calculate_overlap(mps1::MPS,mps2::MPS)::Number
Given two mps, compute the overlap <mps1|mps2>.
"""
function calculate_overlap(mps1::MPS, mps2::MPS)::Number
# Make sure, that the two MPS have the same length
N1 = length(mps1)
N2 = length(mps2)
@assert(N1 == N2)
# Now compute ther overlap
overlap = ones(Float64, 1, 1)
for i = 1:N1
overlap = contract_tensors(overlap, [2], mps2[i], [1])
overlap = contract_tensors(conj(mps1[i]), [1; 3], overlap, [1; 3])
end
return overlap[1]
end
"""
expectation_value(mps::MPS, mpo::MPO)::Number
Given a MPS and a MPO compute the expectation value <mps|mpo|mps>.
"""
function expectation_value(mps::MPS, mpo::MPO)::Number
# Make sure, that the two MPS have the same length
N1 = length(mps)
N2 = length(mpo)
@assert(N1 == N2)
# Contract zipper like
val = ones(Float64, 1, 1, 1)
for i = 1:N1
val = contract_tensors(val, [1], conj(mps[i]), [1])
val = contract_tensors(val, [1; 4], mpo[i], [1; 3])
val = contract_tensors(val, [1; 4], mps[i], [1; 3])
end
return val[1]
end
"""
gaugeMPS(mps::MPS{T}, direction::Symbol=:right, normalize::Bool=false)::MPS{T}
Function to bring an MPS with OBC in canonical form
direction: tells, whether it will be left or right canonical gauge
If normalize is set to true, the resulting state will be normalized.
"""
function gaugeMPS(mps::MPS{T}, direction::Symbol = :right, normalize::Bool = false)::MPS{T} where {T}
mps_gauged = deepcopy(mps)
gaugeMPS!(mps_gauged, direction, normalize)
return mps_gauged
end
"""
gaugeMPS!(mps::MPS,direction::Dir=right,)
Bring an MPS with OBC in canonical form. Direction tells, whether it will be left or right canonical gauge If normalize is set to true, the resulting state will be
normalized. This function overwrites the input MPS with its gauged version
"""
function gaugeMPS!(mps::MPS, direction::Symbol = :right, normalize::Bool = false)
# Check that we got a meaningful direction
if (direction != :left && direction != :right)
throw(ArgumentError("direction must be :left or :right, got $(repr(direction))"))
end
# Start gauging
N = length(mps)
if (direction == :left)
# Case that I want left canonical gauge
M = mps[1]
for i = 1:N-1
mps[i], res = gauge_site(M, direction)
M = contract_tensors(res, [2], mps[i+1], [1])
if (i == (N - 1))
if (normalize)
mps[N], _ = gauge_site(M, direction)
else
mps[N] = M
end
end
end
else
# Case that I want right canonical gauge
M = mps[N]
for i = N:-1:2
mps[i], res = gauge_site(M, direction)
M = contract_tensors(mps[i-1], [2], res, [1], [1; 3; 2])
if (i == 2)
if (normalize)
mps[1], _ = gauge_site(M, direction)
else
mps[1] = M
end
end
end
end
end
"""
gauge_site(A::Site{T}, direction::Dir)::Tuple{Site{T},Matrix{T}} where T
Bring a single tensor A of an MPS with OBC in canonical form
direction tells, whether it will be left or right normalized
The new tensor is M, the residual matrix which has to be multiplied
in the next tensor is stored in res
"""
function gauge_site(A::Site{T}, direction::Symbol)::Tuple{Site{T},Matrix{T}} where {T}
if (direction == :left)
Dl, Dr, d = size(A)
M = permutedims(A, [3 1 2])
M = reshape(M, (d * Dl, Dr))
U, S, V = svd(M)
dsv = length(S)
U = reshape(U, (d, Dl, dsv))
M = permutedims(U, [2 3 1])
res = Matrix(Diagonal(S)) * V'
return M, res
else
Dl, Dr, d = size(A)
M = permutedims(A, [1 3 2])
M = reshape(M, (Dl, Dr * d))
U, S, V = svd(M)
dsv = length(S)
V = V'
V = reshape(V, (dsv, d, Dr))
M = permutedims(V, [1 3 2])
res = U * Matrix(Diagonal(S))
return M, res
end
end
"""
contract_virtual_indices(mps::MPS)::Vector{<:Number}
Given an MPS contract the virtual indices such that one obtains a dense vector. The indices are ordered such that they are compatible with the standard Julia kronecker product.
Warning: the object constructed will have exponential memory requirements in terms of the number of sites, use with care!
"""
function contract_virtual_indices(mps::MPS)::Vector{<:Number}
N = length(mps)
# Since we deal with open boundary conditions, we drop the dummy indices one on the left (right) boundary for the first (last) tensor manually. We start from the right to have the physical indices in the order compatible with Julia's kronecker product
res = mps[N][:, 1, :]
for i = N-1:-1:2
res = contract_tensors(res, [ndims(res) - 1], mps[i], [2])
end
res = contract_tensors(res, [ndims(res) - 1], mps[1][1, :, :], [1])
# Now reshape the result accordingly
res = reshape(res, prod(size(res)))
return res
end
"""
contract_virtual_indices(mps::MPO)::Matrix{<:Number}
Given an MPO contract the virtual indices such that one obtains a dense matrix. The indices are ordered such that they are compatible with the standard Julia kronecker product.
Warning: the object constructed will have exponential memory requirements in terms of the number of sites, use with care!
"""
function contract_virtual_indices(mpo::MPO)::Matrix{<:Number}
N = length(mpo)
# Since we deal with open boundary conditions, we drop the dummy indices one on the left (right) boundary for the first (last) tensor manually. We start from the right to have the physical indices in the order compatible with Julia's kronecker product
res = mpo[N][:, 1, :, :]
for i = N-1:-1:2
res = contract_tensors(res, [ndims(res) - 2], mpo[i], [2])
end
res = contract_tensors(res, [ndims(res) - 2], mpo[1][1, :, :, :], [1])
# Reshuffle the indices to be compatible with Julia's standard kronecker product
res = permutedims(res, [collect(1:2:ndims(res)); collect(2:2:ndims(res))])
# Now reshape the result accordingly
dims = size(res)
dr = prod(dims[1:N])
dc = prod(dims[N+1:end])
res = reshape(res, (dr, dc))
return res
end
"""
find_groundstate(H::Array{Operator},D::Int64,acc::Float64,max_sweeps::Int64=-1)
Given a Hamiltonian MPO H, find an MPS approximation for its ground state with bond
dimension D converged to a relative accuracy acc. If a positive number for max_sweeps
is given, the maximum amount of iterations is limited to max_sweeps
"""
function find_groundstate(H::Vector{Operator{T}}, D::Int64, d::Int64, acc::Float64, max_sweeps::Int64) where {T}
N = length(H)
# Get the physical dimensions from the Hamiltonian
d = Vector{Int64}(undef, length(H))
for i = 1:length(H)
d[i] = size(H[i], 3)
end
# Random MPS to start the calculation with
mps = random_mps_obc(N, D, d)
# Put it in right canonical gauge
gaugeMPS!(mps, :right)
# Precalculate the partial contractions
LR = setup_R(H, mps)
# Now start the sweeping
num_of_sweeps = 0
E0 = 0
Eold = 1E5
while (true)
num_of_sweeps = num_of_sweeps + 1
println("Sweep number ", num_of_sweeps)
# From left to right starting by 1 up to N-1
E_local = 0
res = 0
for i = 1:N-1
Left = LR[i]
Right = LR[i+1]
E_local, M = solve_eigenvalue_problem(Left, Right, H[i])
mps[i], _ = gauge_site(M, :left)
LR[i+1] = update_left(Left, mps[i], mps[i], H[i])
end
# From left to right starting by 1 up to N-1
for i = N:-1:2
Left = LR[i]
Right = LR[i+1]
E_local, M = solve_eigenvalue_problem(Left, Right, H[i])
mps[i], res = gauge_site(M, :right)
LR[i] = update_right(Right, mps[i], mps[i], H[i])
end
# Check convergence criterion
if (abs((Eold - E_local) / Eold) < acc)
E0 = E_local
# Restore normalisation (permutation is needed to bring the indices back into right order after contracting)
mps[1] = contract_tensors(mps[1], [2], res, [1], [1; 3; 2])
println("Convergence to desired accuracy achieved")
break
elseif (max_sweeps > 0 && num_of_sweeps >= max_sweeps)
E0 = E_local
# Restore normalisation (permutation is needed to bring the indices back into right order after contracting)
mps[1] = contract_tensors(mps[1], [2], res, [1], [1; 3; 2])
warn("Reached maximum number of iterations before convergence to desired accuracy")
break
end
Eold = E_local
end
return E0, mps, num_of_sweeps
end
"""
getHeff(Left,Right,W::Operator)
Construct the effective Hamiltonian
"""
function getHeff(Left, Right, W::Operator)
Htemp = contract_tensors(W, [2], Right, [2])
Htemp = contract_tensors(Left, [2], Htemp, [1])
Htemp = permutedims(Htemp, [1; 5; 3; 2; 6; 4])
dim1, dim2, dim3, dim4, dim5, dim6 = size(Htemp)
Heff = reshape(Htemp, (dim1 * dim2 * dim3, dim4 * dim5 * dim6))
return Heff
end
"""
solve_eigenvalue_problem(Left,Right,W)
Function to construct and solve the eigenvalue problem which arises on each site for the effective Hamiltonian
"""
function solve_eigenvalue_problem(Left, Right, W)
Htemp = contract_tensors(W, [2], Right, [2])
Htemp = contract_tensors(Left, [2], Htemp, [1])
Htemp = permutedims(Htemp, [1; 5; 3; 2; 6; 4])
dim1, dim2, dim3, dim4, dim5, dim6 = size(Htemp)
Heff = reshape(Htemp, (dim1 * dim2 * dim3, dim4 * dim5 * dim6))
E_local, M = eigs(Heff, nev = 1, which = :SR)
M = reshape(M, (dim1, dim5, dim3))
return real(E_local[1]), M
end
"""
setup_R(H::MPO{T1},mps::MPS{T2}) where {T1,T2}
Function to calculate the partial contractions needed to form the effective Hamiltonian
"""
function setup_R(H::MPO{T1}, mps::MPS{T2}) where {T1,T2}
N = length(H)
Tres = Base.return_types(*, (T1, T2))[1]
LR = Vector{Array{Tres,3}}(undef, N + 1)
# We need only N-1 partial contractions, however, we set the edges to dummy values 1 that we can recursively compute every contraction resuing the previous ones
LR[1] = ones(Tres, 1, 1, 1)
LR[N+1] = ones(Tres, 1, 1, 1)
# Now compute the partial contractions starting from the right (as I start sweeping on the left in the ground state search)
for i = N:-1:2
tmp = contract_tensors(LR[i+1], [3], mps[i], [2])
tmp = contract_tensors(H[i], [2; 4], tmp, [2; 4])
LR[i] = contract_tensors(conj(mps[i]), [2; 3], tmp, [3; 2])
end
return LR
end
"""
update_left(LR, M_left::Site, M_right::Site, W::Operator)
Function to perform an update the partial contractions required for iterative ground state search starting from the left stored in LR
"""
function update_left(LR, M_left::Site, M_right::Site, W::Operator)
res = contract_tensors(LR, [3], M_right, [1])
res = contract_tensors(W, [1; 4], res, [2; 4])
res = contract_tensors(conj(M_left), [1; 3], res, [3; 2])
return res
end
"""
update_right(LR, M_left::Site, M_right::Site, W::Operator)
Function to perform an update the partial contractions required for iterative ground state search starting from the right stored in LR
"""
function update_right(LR, M_left::Site, M_right::Site, W::Operator)
res = contract_tensors(LR, [3], M_right, [2])
res = contract_tensors(W, [2; 4], res, [2; 4])
res = contract_tensors(conj(M_left), [2; 3], res, [3; 2])
return res
end
"""
apply_operator(operator::MPO{T1}, mps::MPS{T2})::MPS where {T1,T2}
Apply an operator given as MPO to an MPS. The resulting MPS will have a bond dimension that is the product of the bond dimensions of the MPS and the MPO.
"""
function apply_operator(operator::MPO{T1}, mps::MPS{T2})::MPS where {T1,T2}
N1 = length(mps)
N2 = length(operator)
@assert(N1 == N2)
# Generate a new MPO of the correct type
Tres = Base.return_types(*, (T1, T2))[1]
res = MPS{Tres}(undef, N1)
# Apply the MPO to the MPS and generate new MPS
for i = 1:N1
temp = contract_tensors(operator[i], [4], mps[i], [3])
temp = permutedims(temp, (1, 4, 2, 5, 3))
dim1, dim2, dim3, dim4, dim5 = size(temp)
res[i] = reshape(temp, (dim1 * dim2, dim3 * dim4, dim5))
end
return res
end
"""
apply_operator!(operator::MPO{T1}, mps::MPS{T2})::MPS where {T1,T2}
Apply an operator given as MPO to an MPS. The resulting MPS will have a bond dimension that is the product of the bond dimensions of the MPS and the MPO. The input will be overwritten by the result. This requires that the type of the elements of the input MPS is able to accomodate the result of multiplying the MPO tensors into the MPS tensors (e.g. applying a complex MPO to a real MPS cannot be done inpalce as the result will be complex)
"""
function apply_operator!(operator::MPO, mps::MPS)
N1 = length(mps)
N2 = length(operator)
@assert(N1 == N2)
# Contract the tensors for each site
for i = 1:N1
temp = contract_tensors(operator[i], [4], mps[i], [3])
temp = permutedims(temp, (1, 4, 2, 5, 3))
dim1, dim2, dim3, dim4, dim5 = size(temp)
mps[i] = reshape(temp, (dim1 * dim2, dim3 * dim4, dim5))
end
end
"""
apply_operator(op1::MPO{T1}, op2::MPO{T2})::MPO where {T1,T2}
Multiply two MPOs together to get an expression for op2 * op1 in MPO form. The resulting MPS will have a bond dimension that is the product of the bond dimensions of both MPOs.
"""
function apply_operator(op1::MPO{T1}, op2::MPO{T2})::MPO where {T1,T2}
N1 = length(op1)
N2 = length(op2)
@assert(N1 == N2)
# Generate a new MPS of the correct type
Tres = Base.return_types(*, (T1, T2))[1]
res = MPO{Tres}(undef, N1)
# Contract the tensors for each site
for i = 1:N1
temp = contract_tensors(op2[i], [4], op1[i], [3])
temp = permutedims(temp, (1, 4, 2, 5, 3, 6))
dim1, dim2, dim3, dim4, dim5, dim6 = size(temp)
res[i] = reshape(temp, (dim1 * dim2, dim3 * dim4, dim5, dim6))
end
return res
end
"""
sum_states(mps1::MPS{T1}, mps2::MPS{T2})::MPS where {T1,T2}
Add two MPSs together to get an expression for mps1 + mps2 in MPS form. The resulting MPS will have a bond dimension that is the sum of the bond dimensions of both MPOs.
"""
function sum_states(mps1::MPS{T1}, mps2::MPS{T2})::MPS where {T1,T2}
N1 = length(mps1)
N2 = length(mps2)
@assert(N1 == N2)
# Generate a new MPO of the correct type
Tres = Base.return_types(+, (T1, T2))[1]
res = MPS{Tres}(undef, N1)
# The first site needs special treatment
tensor1 = mps1[1]
tensor2 = mps2[1]
_, Dr1, d1 = size(tensor1)
_, Dr2, d2 = size(tensor2)
new_tensor = zeros(Tres, 1, Dr1 + Dr2, d1)
for r = 1:d1
new_tensor[1, :, r] = [tensor1[1:1, :, r] tensor2[1:1, :, r]]
end
res[1] = new_tensor
# The tensors in between
for i = 2:N1-1
tensor1 = mps1[i]
tensor2 = mps2[i]
Dl1, Dr1, d1 = size(tensor1)
Dl2, Dr2, d2 = size(tensor2)
new_tensor = zeros(Tres, Dl1 + Dl2, Dr1 + Dr2, d1)
for r = 1:d1
new_tensor[1:Dl1, 1:Dr1, r] = tensor1[:, :, r]
new_tensor[Dl1+1:end, Dr1+1:end, r] = tensor2[:, :, r]
end
res[i] = new_tensor
end
# The last site needs special treatment
tensor1 = mps1[N1]
tensor2 = mps2[N1]
Dl1, _, d1 = size(tensor1)
Dl2, _, d2 = size(tensor2)
new_tensor = zeros(Tres, Dl1 + Dl2, 1, d1)
for r = 1:d1
new_tensor[:, 1, r] = [tensor1[:, 1, r]; tensor2[:, 1, r]]
end
res[N1] = new_tensor
return res
end
"""
sum_operators(op1::MPO{T1}, op2::MPO{T2})::MPO where {T1,T2}
Add two MPOs together to get an expression for op2 + op1 in MPO form. The resulting MPO will have a bond dimension that is the sum of the bond dimensions of both MPOs.
"""
function sum_operators(op1::MPO{T1}, op2::MPO{T2})::MPO where {T1,T2}
N1 = length(op1)
N2 = length(op2)
@assert(N1 == N2)
# Generate a new MPO of the correct type
Tres = Base.return_types(+, (T1, T2))[1]
res = MPO{Tres}(undef, N1)
# The first site needs special treatment
tensor1 = op1[1]
tensor2 = op2[1]
_, Dr1, dr1, dc1 = size(tensor1)
_, Dr2, dr2, dc2 = size(tensor2)
new_tensor = zeros(Tres, 1, Dr1 + Dr2, dr1, dc1)
for r = 1:dr1
for c = 1:dc1
new_tensor[1, :, r, c] = [tensor1[1:1, :, r, c] tensor2[1:1, :, r, c]]
end
end
res[1] = new_tensor
# The tensors in between
for i = 2:N1-1
tensor1 = op1[i]
tensor2 = op2[i]
Dl1, Dr1, dr1, dc1 = size(tensor1)
Dl2, Dr2, dr2, dc2 = size(tensor2)
new_tensor = zeros(Tres, Dl1 + Dl2, Dr1 + Dr2, dr1, dc1)
for r = 1:dr1
for c = 1:dc1
new_tensor[1:Dl1, 1:Dr1, r, c] = tensor1[:, :, r, c]
new_tensor[Dl1+1:end, Dr1+1:end, r, c] = tensor2[:, :, r, c]
end
end
res[i] = new_tensor
end
# The last site needs special treatment
tensor1 = op1[N1]
tensor2 = op2[N1]
Dl1, _, dr1, dc1 = size(tensor1)
Dl2, _, dr2, dc2 = size(tensor2)
new_tensor = zeros(Tres, Dl1 + Dl2, 1, dr1, dc1)
for r = 1:dr1
for c = 1:dc1
new_tensor[:, 1, r, c] = [tensor1[:, 1, r, c]; tensor2[:, 1, r, c]]
end
end
res[N1] = new_tensor
return res
end
"""
compute_entropy(mps::MPS, n:Int)::Float64
Compute the von Neumann along for the bipartion of the sites into two subsets A={1,...,n} and B={n+1,...,N} where N is the length of the MPS. If n<=0 is supplied, a bipartion of into A. For the result to make sense, mps has to be a normalized quantum state.
"""
function compute_entropy(mps::MPS{T}, n::Int = 0)::Float64 where {T}
# Extact the length and check if the given position is reasonable
N = length(mps)
@assert(n <= N)
# The entropy of the entire state is simply zero since it is a pure state, so nothing to compute
if n == N
return 0.0
end
# In case a value n<=0 is given, we assume the bipartion is taken in the center
if n <= 0
n = Int(round(N / 2))
end
# Get a copy of the input
mps_loc = deepcopy(mps)
# Put the sites left to n into left canonical gauge
M = mps_loc[1]
for i = 1:n
mps_loc[i], res = gauge_site(M, :left)
M = contract_tensors(res, [2], mps_loc[i+1], [1])
end
mps_loc[n+1] = M
# Now start contracting from the right boundary to obtain the reduced density operator
rdm = ones(T, 1, 1)
for i = N:-1:n+1
rdm = contract_tensors(rdm, [2], mps_loc[i], [2])
rdm = contract_tensors(conj(mps_loc[i]), [2; 3], rdm, [1; 3])
end
# Now diagonalize the reduced density matrix and compute the entropy
ev = real(eigvals(rdm))
# Eigenvalues that are numerically zero sometimes become -1E-16, to prevent problems with the logarithm we filter them
ev = filter(x -> x > 0.0, ev)
# The von Neumann entropy for the reduced density operator
entropy = -sum(ev .* log2.(ev))
return entropy
end
"""
sample_from_mps!(mps::MPS, gauge_input::Bool=true)::Vector{Int64}
Generate a sample from the probability distribution of basis states defined by the MPS following A. Ferris, G. Vidal, PRB 85 165146 (2021). If the flag gague_input is set to true, the input MPS will be put in right canoncial gauge and normalized, which is a requirement for the algorithm to work. In case one is sure that the MPS is already properly gauged and normalized the gauging step can be spared by setting the flag to false. In this case the input will stay untouched.
"""
function sample_from_mps!(mps::MPS, gauge_input::Bool = true)::Vector{Int64}
# Extact the length and check if the given position is reasonable
N = length(mps)
res = zeros(Int64, N)
# Put the state into right canonical gauge and make sure it is normalized
if gauge_input
gaugeMPS!(mps, :right, true)
end
# Now sample from the MPS
A = 0
p = 0.0
M = mps[1][1, :, :]
for i = 1:N
d = size(M, 2)
pacc = 0
r = rand()
for l = 1:d
# Prepare the basis state
basis_state = zeros(d)
basis_state[l] = 1.0
# Contract it into the physical index of the tensor
A = contract_tensors(M, [2], basis_state, [1])
# Determine the probability for the basis vector e_l
p = contract_tensors(conj(A), [1], A, [1])
pacc += real(p[1])
if r < pacc
res[i] = l
break
end
end
if i < N
# Contract the result into the next tensor
M = contract_tensors(1 / sqrt(real(p[1])) * A, [1], mps[i+1], [1])
end
end
return res
end
"""
sample_from_mps(mps::MPS)::Vector{Int64}
Generate a sample from the probability distribution of basis states defined by the MPS following A. Ferris, G. Vidal, PRB 85 165146 (2021).
"""
function sample_from_mps(mps::MPS)::Vector{Int64}
return sample_from_mps!(deepcopy(mps))
end
"""
svd_compress_mps(mps::MPS, Dmax::Int,, tol::Real = 0.0)::MPS
Compress a given MPS applying an a singular value decomposition at each bond. If Dmax > 0 is supplied (and simultaneously tol = 0.0), a maximum of Dmax singular values is kept, thus truncating the MPS to one with maximum bond dimension Dmax. If tol > 0 is given (and simultaneously Dmax = 0) then all singular values > tol are kept. If both are specified then at most Dmax singular values > tol are kept.
"""
function svd_compress_mps(mps::MPS, Dmax::Int, tol::Real = 0.0)::MPS
# One of the two parameters has to be larger than zero
@assert((Dmax > 0) || (tol > 0))
# Extract the length and prepare a result
N = length(mps)
res = deepcopy(mps)
# Gauge in both directions that redundant dimensions at the boundaries are removed
gaugeMPS!(res, :left)
gaugeMPS!(res, :right)
Dnew = 0
for i = 1:N-1
# Check if the given bond dimension is larger than Dmax
if size(res[i], 2) > Dmax
Dl1, _, d1 = size(res[i])
_, Dr2, d2 = size(res[i+1])
tmp = contract_tensors(res[i], [2], res[i+1], [1])
tmp = reshape(tmp, (Dl1 * d1, Dr2 * d2))
U, S, V = svd(tmp)
M = diagm(S) * V'
# Now truncate
if Dmax > 0 && tol == 0.0
U = U[:, 1:Dmax]
M = M[1:Dmax, :]
Dnew = Dmax
else
ind = findall(x -> x > tol, S)
if Dmax > 0 && length(ind) > Dmax
ind = ind[1:Dmax]
end
U = U[:, ind]
M = M[ind, :]
Dnew = length(ind)
end
# Reshape and set new tensors
res[i] = permutedims(reshape(U, (Dl1, d1, Dnew)), (1, 3, 2))
res[i+1] = reshape(M, (Dnew, Dr2, d2))
end
end
return res
end
"""
decompose_into_mpo(M::Matrix{T}, d::Vector{Int}) where T <:Number
Given a many-body operator in form of a dense matrix, decompose it into an MPO. It is assumed that the many-body operator follows the index convention of Julia's built-in kronecker product. The vector d specifies the local dimensions of the Hilbert space.
# Examples
Decomposing a simple two-site operator made up from sum of Pauli terms into MPO form.
```julia-repl
julia> Id = [1.0 0; 0.0 1.0]
julia> X = [0.0 1.0; 1.0 0.0]
julia> Z = [1.0 0.0; 0.0 -1.0]
julia> H = kron(X,X) + kron(Id,Z) + kron(Z,Id)
julia> mpo = decompose_into_mpo(H, 2)
```
"""
function decompose_into_mpo(M::Matrix{T}, d::Vector{Int})::MPO{T} where {T<:Number}
N = length(d)
dim = prod(d)
if size(M) != (prod(d), prod(d))
throw(ArgumentError("matrix not compatible with specified local dimensions, got size(M)=$(repr(size(M))), d=$(repr(d))"))
end
# The MPO holding the result
res = MPO{T}(undef, N)
# Reshape the matrix and rearrange the indices, such that the row and column index for each site are adjacent and add dummy indices 1 at the boundaries
A = reshape(M, (1, reverse(d)..., reverse(d)..., 1))
ind = collect(Iterators.flatten(zip(collect(N:-1:1), collect(2N:-1:N+1))))
A = permutedims(A, (1, ind .+ 1..., 2 * length(d) + 2))
# Now split it into tensors using an SVD
Dl = 1
for i = 1:N-1
# Take the first three indices together
dims = size(A)
A = reshape(A, (prod(dims[1:3]), prod(dims[4:end])))
# SVD the matrix representation
U, S, V = svd(A)
A = diagm(S) * V'
Dr = size(U, 2)
# Extract the tensor and the remaining part
U = reshape(U, (Dl, d[i], d[i], Dr))
res[i] = permutedims(U, (1, 4, 2, 3))
A = reshape(A, (Dr, dims[4:end]...))
Dl = Dr
end
res[N] = permutedims(A, (1, 4, 2, 3))
return res
end
"""
decompose_into_mpo(M::Matrix{T}, d::Int) where T <:Number
Simplified interface to the more general method assuming that all local dimensions are equal to d.
"""
function decompose_into_mpo(M::Matrix{T}, d::Int)::MPO{T} where {T<:Number}
dl, dr = size(M)
if dl != dr
throw(ArgumentError("local dimensions must all be the same, obtained a matrix with dimensions $(repr((dl,dr)))"))
end
N = Int(round(log(d, dl)))
return decompose_into_mpo(M, d * ones(Int64, N))
end | [
29113,
29113,
7804,
2235,
198,
2,
220,
220,
220,
197,
26416,
11244,
329,
1804,
337,
3705,
16765,
351,
440,
2749,
220,
220,
220,
220,
220,
197,
2,
198,
29113,
29113,
7804,
2235,
198,
3500,
44800,
2348,
29230,
198,
3500,
943,
8002,
198,
198,
2,
2896,
500,
5043,
355,
513,
443,
11178,
11192,
669,
5901,
351,
4847,
286,
617,
2099,
198,
29123,
90,
51,
92,
796,
15690,
90,
51,
11,
18,
92,
198,
2,
1052,
337,
3705,
318,
281,
7177,
286,
37034,
286,
257,
1728,
2099,
198,
44,
3705,
90,
51,
92,
796,
20650,
90,
29123,
90,
51,
11709,
198,
2,
2896,
500,
12879,
355,
604,
443,
11178,
11192,
669,
5901,
351,
4847,
286,
617,
2099,
198,
18843,
1352,
90,
51,
92,
796,
15690,
90,
51,
11,
19,
92,
198,
2,
317,
4904,
46,
318,
281,
7177,
286,
6564,
2024,
198,
7378,
46,
90,
51,
92,
796,
20650,
90,
18843,
1352,
90,
51,
11709,
198,
198,
37811,
198,
220,
220,
220,
4738,
62,
76,
862,
62,
672,
66,
7,
45,
3712,
5317,
11,
360,
3712,
5317,
11,
288,
11,
11192,
419,
2981,
3712,
6030,
90,
51,
92,
28,
5377,
11141,
37,
2414,
2599,
25,
44,
3705,
90,
51,
92,
810,
309,
198,
220,
220,
220,
220,
198,
22203,
284,
7716,
257,
4738,
337,
3705,
351,
440,
2749,
198,
45,
25,
7913,
286,
5043,
198,
35,
25,
12812,
15793,
198,
67,
25,
20650,
286,
3518,
15225,
11,
611,
257,
2060,
18253,
15793,
318,
1813,
11,
340,
318,
9672,
326,
477,
3518,
15225,
389,
262,
976,
11,
611,
15874,
15225,
389,
2227,
257,
15879,
286,
37014,
286,
4129,
399,
468,
284,
307,
14275,
198,
464,
9831,
329,
262,
513,
6376,
11192,
669,
318,
326,
262,
717,
734,
389,
262,
7166,
3392,
11,
262,
938,
530,
318,
262,
3518,
530,
198,
220,
220,
513,
198,
220,
220,
930,
198,
16,
438,
32,
438,
17,
198,
37811,
198,
8818,
4738,
62,
76,
862,
62,
672,
66,
7,
45,
3712,
5317,
11,
360,
3712,
5317,
11,
288,
11,
11192,
419,
2981,
3712,
6030,
90,
51,
92,
796,
19157,
37,
2414,
2599,
25,
44,
3705,
90,
51,
92,
810,
1391,
51,
92,
198,
220,
220,
220,
1303,
48987,
262,
262,
1080,
2546,
318,
379,
1551,
734,
198,
220,
220,
220,
2488,
30493,
7,
45,
1875,
352,
8,
628,
220,
220,
220,
1303,
20768,
1096,
198,
220,
220,
220,
285,
862,
796,
15690,
90,
29123,
90,
51,
11709,
7,
917,
891,
11,
399,
8,
628,
220,
220,
220,
611,
318,
64,
7,
67,
11,
7913,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
14206,
1271,
11,
314,
7048,
477,
15225,
389,
262,
976,
198,
220,
220,
220,
220,
220,
220,
220,
5391,
796,
288,
1635,
3392,
7,
5317,
2414,
11,
399,
8,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
6889,
1654,
326,
262,
5128,
318,
1107,
257,
15879,
355,
474,
43640,
45482,
1022,
299,
87,
16,
2603,
45977,
290,
5721,
30104,
198,
220,
220,
220,
220,
220,
220,
220,
5391,
796,
43030,
7,
67,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
6889,
1654,
5128,
318,
4938,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
30493,
7,
13664,
7,
27740,
8,
6624,
399,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
9578,
18645,
11192,
273,
357,
808,
15879,
8,
198,
220,
220,
220,
285,
862,
58,
16,
60,
796,
43720,
7,
83,
641,
419,
2981,
11,
352,
11,
360,
11,
5391,
58,
16,
12962,
628,
220,
220,
220,
1303,
6498,
18645,
11192,
273,
357,
28665,
15879,
8,
198,
220,
220,
220,
285,
862,
58,
45,
60,
796,
43720,
7,
83,
641,
419,
2981,
11,
360,
11,
352,
11,
5391,
58,
45,
12962,
628,
220,
220,
220,
1303,
40280,
669,
287,
1022,
198,
220,
220,
220,
329,
1312,
796,
362,
25,
45,
12,
16,
198,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
72,
60,
796,
43720,
7,
83,
641,
419,
2981,
11,
360,
11,
360,
11,
5391,
58,
72,
12962,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
285,
862,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
4308,
62,
5219,
62,
672,
66,
7,
11250,
3924,
3712,
38469,
90,
27,
25,
5317,
5512,
288,
3712,
5317,
28,
17,
2599,
25,
44,
3705,
198,
198,
37534,
533,
262,
257,
1720,
1181,
11188,
930,
11250,
3924,
29,
319,
399,
5043,
810,
8398,
318,
281,
15690,
7268,
399,
4847,
422,
352,
284,
288,
13,
5501,
2524,
318,
788,
23224,
287,
262,
288,
400,
40091,
4308,
1181,
198,
37811,
198,
8818,
4308,
62,
5219,
62,
672,
66,
7,
11250,
3924,
3712,
38469,
90,
27,
25,
5317,
5512,
288,
3712,
5317,
796,
362,
2599,
25,
44,
3705,
90,
43879,
2414,
92,
198,
220,
220,
220,
1303,
2773,
4049,
10627,
198,
220,
220,
220,
611,
597,
7,
87,
4613,
357,
87,
1279,
352,
8614,
2124,
1875,
288,
828,
8398,
8,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
28100,
1713,
12331,
7203,
11250,
3924,
1276,
3994,
18253,
4847,
287,
262,
2837,
422,
352,
284,
288,
11,
1392,
288,
43641,
7,
260,
1050,
7,
67,
36911,
8398,
43641,
7,
260,
1050,
7,
11250,
3924,
4008,
48774,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1303,
2980,
378,
262,
337,
3705,
198,
220,
220,
220,
399,
796,
4129,
7,
11250,
3924,
8,
198,
220,
220,
220,
46231,
796,
337,
3705,
90,
43879,
2414,
92,
7,
917,
891,
11,
399,
8,
198,
220,
220,
220,
11192,
669,
796,
20650,
90,
19182,
90,
43879,
2414,
11,
18,
11709,
7,
917,
891,
11,
288,
8,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
67,
198,
220,
220,
220,
220,
220,
220,
220,
45218,
796,
1976,
27498,
7,
43879,
2414,
11,
352,
11,
352,
11,
288,
8,
198,
220,
220,
220,
220,
220,
220,
220,
45218,
58,
16,
11,
352,
11,
1312,
60,
796,
352,
13,
15,
198,
220,
220,
220,
220,
220,
220,
220,
11192,
669,
58,
72,
60,
796,
45218,
198,
220,
220,
220,
886,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
45,
198,
220,
220,
220,
220,
220,
220,
220,
46231,
58,
72,
60,
796,
11192,
669,
58,
11250,
3924,
58,
72,
11907,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
46231,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
15284,
62,
2502,
37796,
7,
76,
862,
16,
3712,
44,
3705,
11,
76,
862,
17,
3712,
44,
3705,
2599,
25,
15057,
198,
198,
15056,
734,
285,
862,
11,
24061,
262,
21721,
1279,
76,
862,
16,
91,
76,
862,
17,
28401,
198,
37811,
198,
8818,
15284,
62,
2502,
37796,
7,
76,
862,
16,
3712,
44,
3705,
11,
285,
862,
17,
3712,
44,
3705,
2599,
25,
15057,
198,
220,
220,
220,
1303,
6889,
1654,
11,
326,
262,
734,
337,
3705,
423,
262,
976,
4129,
198,
220,
220,
220,
399,
16,
796,
4129,
7,
76,
862,
16,
8,
198,
220,
220,
220,
399,
17,
796,
4129,
7,
76,
862,
17,
8,
198,
220,
220,
220,
2488,
30493,
7,
45,
16,
6624,
399,
17,
8,
628,
220,
220,
220,
1303,
2735,
24061,
10811,
21721,
198,
220,
220,
220,
21721,
796,
3392,
7,
43879,
2414,
11,
352,
11,
352,
8,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
45,
16,
198,
220,
220,
220,
220,
220,
220,
220,
21721,
796,
2775,
62,
83,
641,
669,
7,
2502,
37796,
11,
685,
17,
4357,
285,
862,
17,
58,
72,
4357,
685,
16,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
21721,
796,
2775,
62,
83,
641,
669,
7,
1102,
73,
7,
76,
862,
16,
58,
72,
46570,
685,
16,
26,
513,
4357,
21721,
11,
685,
16,
26,
513,
12962,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
21721,
58,
16,
60,
198,
437,
628,
198,
37811,
198,
220,
220,
17507,
62,
8367,
7,
76,
862,
3712,
44,
3705,
11,
285,
7501,
3712,
7378,
46,
2599,
25,
15057,
198,
220,
220,
220,
198,
15056,
257,
337,
3705,
290,
257,
4904,
46,
24061,
262,
17507,
1988,
1279,
76,
862,
91,
3149,
78,
91,
76,
862,
28401,
198,
37811,
198,
8818,
17507,
62,
8367,
7,
76,
862,
3712,
44,
3705,
11,
285,
7501,
3712,
7378,
46,
2599,
25,
15057,
198,
220,
220,
220,
1303,
6889,
1654,
11,
326,
262,
734,
337,
3705,
423,
262,
976,
4129,
198,
220,
220,
220,
399,
16,
796,
4129,
7,
76,
862,
8,
198,
220,
220,
220,
399,
17,
796,
4129,
7,
3149,
78,
8,
198,
220,
220,
220,
2488,
30493,
7,
45,
16,
6624,
399,
17,
8,
628,
220,
220,
220,
1303,
17453,
48992,
588,
198,
220,
220,
220,
1188,
796,
3392,
7,
43879,
2414,
11,
352,
11,
352,
11,
352,
8,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
45,
16,
198,
220,
220,
220,
220,
220,
220,
220,
1188,
796,
2775,
62,
83,
641,
669,
7,
2100,
11,
685,
16,
4357,
11644,
7,
76,
862,
58,
72,
46570,
685,
16,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
1188,
796,
2775,
62,
83,
641,
669,
7,
2100,
11,
685,
16,
26,
604,
4357,
285,
7501,
58,
72,
4357,
685,
16,
26,
513,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
1188,
796,
2775,
62,
83,
641,
669,
7,
2100,
11,
685,
16,
26,
604,
4357,
285,
862,
58,
72,
4357,
685,
16,
26,
513,
12962,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
1188,
58,
16,
60,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
18266,
44,
3705,
7,
76,
862,
3712,
44,
3705,
90,
51,
5512,
4571,
3712,
13940,
23650,
28,
25,
3506,
11,
3487,
1096,
3712,
33,
970,
28,
9562,
2599,
25,
44,
3705,
90,
51,
92,
198,
220,
220,
220,
220,
198,
22203,
284,
2222,
281,
337,
3705,
351,
440,
2749,
287,
40091,
1296,
198,
37295,
25,
4952,
11,
1771,
340,
481,
307,
1364,
393,
826,
40091,
18266,
198,
1532,
3487,
1096,
318,
900,
284,
2081,
11,
262,
7186,
1181,
481,
307,
39279,
13,
198,
37811,
198,
8818,
18266,
44,
3705,
7,
76,
862,
3712,
44,
3705,
90,
51,
5512,
4571,
3712,
13940,
23650,
796,
1058,
3506,
11,
3487,
1096,
3712,
33,
970,
796,
3991,
2599,
25,
44,
3705,
90,
51,
92,
810,
1391,
51,
92,
198,
220,
220,
220,
285,
862,
62,
70,
559,
2004,
796,
2769,
30073,
7,
76,
862,
8,
198,
220,
220,
220,
18266,
44,
3705,
0,
7,
76,
862,
62,
70,
559,
2004,
11,
4571,
11,
3487,
1096,
8,
198,
220,
220,
220,
1441,
285,
862,
62,
70,
559,
2004,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
18266,
44,
3705,
0,
7,
76,
862,
3712,
44,
3705,
11,
37295,
3712,
35277,
28,
3506,
35751,
198,
220,
220,
220,
220,
198,
31416,
281,
337,
3705,
351,
440,
2749,
287,
40091,
1296,
13,
41837,
4952,
11,
1771,
340,
481,
307,
1364,
393,
826,
40091,
18266,
1002,
3487,
1096,
318,
900,
284,
2081,
11,
262,
7186,
1181,
481,
307,
198,
11265,
1143,
13,
770,
2163,
6993,
23156,
262,
5128,
337,
3705,
351,
663,
14885,
2004,
2196,
198,
37811,
198,
8818,
18266,
44,
3705,
0,
7,
76,
862,
3712,
44,
3705,
11,
4571,
3712,
13940,
23650,
796,
1058,
3506,
11,
3487,
1096,
3712,
33,
970,
796,
3991,
8,
198,
220,
220,
220,
1303,
6822,
326,
356,
1392,
257,
11570,
4571,
198,
220,
220,
220,
611,
357,
37295,
14512,
1058,
9464,
11405,
4571,
14512,
1058,
3506,
8,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
28100,
1713,
12331,
7203,
37295,
1276,
307,
1058,
9464,
393,
1058,
3506,
11,
1392,
29568,
260,
1050,
7,
37295,
4008,
48774,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1303,
7253,
14885,
2667,
198,
220,
220,
220,
399,
796,
4129,
7,
76,
862,
8,
198,
220,
220,
220,
611,
357,
37295,
6624,
1058,
9464,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
8913,
326,
314,
765,
1364,
40091,
18266,
198,
220,
220,
220,
220,
220,
220,
220,
337,
796,
285,
862,
58,
16,
60,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
796,
352,
25,
45,
12,
16,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
72,
4357,
581,
796,
18266,
62,
15654,
7,
44,
11,
4571,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
337,
796,
2775,
62,
83,
641,
669,
7,
411,
11,
685,
17,
4357,
285,
862,
58,
72,
10,
16,
4357,
685,
16,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
357,
72,
6624,
357,
45,
532,
352,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
357,
11265,
1096,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
45,
4357,
4808,
796,
18266,
62,
15654,
7,
44,
11,
4571,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
45,
60,
796,
337,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
8913,
326,
314,
765,
826,
40091,
18266,
198,
220,
220,
220,
220,
220,
220,
220,
337,
796,
285,
862,
58,
45,
60,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
796,
399,
21912,
16,
25,
17,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
72,
4357,
581,
796,
18266,
62,
15654,
7,
44,
11,
4571,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
337,
796,
2775,
62,
83,
641,
669,
7,
76,
862,
58,
72,
12,
16,
4357,
685,
17,
4357,
581,
11,
685,
16,
4357,
685,
16,
26,
513,
26,
362,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
357,
72,
6624,
362,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
357,
11265,
1096,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
16,
4357,
4808,
796,
18266,
62,
15654,
7,
44,
11,
4571,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
16,
60,
796,
337,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
18266,
62,
15654,
7,
32,
3712,
29123,
90,
51,
5512,
4571,
3712,
35277,
2599,
25,
51,
29291,
90,
29123,
90,
51,
5512,
46912,
90,
51,
11709,
810,
309,
198,
198,
31416,
257,
2060,
11192,
273,
317,
286,
281,
337,
3705,
351,
440,
2749,
287,
40091,
1296,
198,
37295,
4952,
11,
1771,
340,
481,
307,
1364,
393,
826,
39279,
198,
464,
649,
11192,
273,
318,
337,
11,
262,
29598,
17593,
543,
468,
284,
307,
33096,
220,
198,
259,
262,
1306,
11192,
273,
318,
8574,
287,
581,
198,
37811,
198,
8818,
18266,
62,
15654,
7,
32,
3712,
29123,
90,
51,
5512,
4571,
3712,
13940,
23650,
2599,
25,
51,
29291,
90,
29123,
90,
51,
5512,
46912,
90,
51,
11709,
810,
1391,
51,
92,
198,
220,
220,
220,
611,
357,
37295,
6624,
1058,
9464,
8,
198,
220,
220,
220,
220,
220,
220,
220,
360,
75,
11,
1583,
11,
288,
796,
2546,
7,
32,
8,
198,
220,
220,
220,
220,
220,
220,
220,
337,
796,
9943,
7241,
12078,
7,
32,
11,
685,
18,
352,
362,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
337,
796,
27179,
1758,
7,
44,
11,
357,
67,
1635,
360,
75,
11,
1583,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
471,
11,
311,
11,
569,
796,
264,
20306,
7,
44,
8,
198,
220,
220,
220,
220,
220,
220,
220,
288,
21370,
796,
4129,
7,
50,
8,
198,
220,
220,
220,
220,
220,
220,
220,
471,
796,
27179,
1758,
7,
52,
11,
357,
67,
11,
360,
75,
11,
288,
21370,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
337,
796,
9943,
7241,
12078,
7,
52,
11,
685,
17,
513,
352,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
581,
796,
24936,
7,
18683,
27923,
7,
50,
4008,
1635,
569,
6,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
337,
11,
581,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
360,
75,
11,
1583,
11,
288,
796,
2546,
7,
32,
8,
198,
220,
220,
220,
220,
220,
220,
220,
337,
796,
9943,
7241,
12078,
7,
32,
11,
685,
16,
513,
362,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
337,
796,
27179,
1758,
7,
44,
11,
357,
35,
75,
11,
1583,
1635,
288,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
471,
11,
311,
11,
569,
796,
264,
20306,
7,
44,
8,
198,
220,
220,
220,
220,
220,
220,
220,
288,
21370,
796,
4129,
7,
50,
8,
198,
220,
220,
220,
220,
220,
220,
220,
569,
796,
569,
6,
198,
220,
220,
220,
220,
220,
220,
220,
569,
796,
27179,
1758,
7,
53,
11,
357,
9310,
85,
11,
288,
11,
1583,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
337,
796,
9943,
7241,
12078,
7,
53,
11,
685,
16,
513,
362,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
581,
796,
471,
1635,
24936,
7,
18683,
27923,
7,
50,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
337,
11,
581,
198,
220,
220,
220,
886,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
2775,
62,
32844,
62,
521,
1063,
7,
76,
862,
3712,
44,
3705,
2599,
25,
38469,
90,
27,
25,
15057,
92,
198,
198,
15056,
281,
337,
3705,
2775,
262,
7166,
36525,
884,
326,
530,
909,
12143,
257,
15715,
15879,
13,
383,
36525,
389,
6149,
884,
326,
484,
389,
11670,
351,
262,
3210,
22300,
479,
33171,
15280,
1720,
13,
198,
198,
20361,
25,
262,
2134,
12006,
481,
423,
39682,
4088,
5359,
287,
2846,
286,
262,
1271,
286,
5043,
11,
779,
351,
1337,
0,
198,
37811,
198,
8818,
2775,
62,
32844,
62,
521,
1063,
7,
76,
862,
3712,
44,
3705,
2599,
25,
38469,
90,
27,
25,
15057,
92,
198,
220,
220,
220,
399,
796,
4129,
7,
76,
862,
8,
628,
220,
220,
220,
1303,
4619,
356,
1730,
351,
1280,
18645,
3403,
11,
356,
4268,
262,
31548,
36525,
530,
319,
262,
1364,
357,
3506,
8,
18645,
329,
262,
717,
357,
12957,
8,
11192,
273,
14500,
13,
775,
923,
422,
262,
826,
284,
423,
262,
3518,
36525,
287,
262,
1502,
11670,
351,
22300,
338,
479,
33171,
15280,
1720,
198,
220,
220,
220,
581,
796,
285,
862,
58,
45,
7131,
45299,
352,
11,
1058,
60,
198,
220,
220,
220,
329,
1312,
796,
399,
12,
16,
21912,
16,
25,
17,
198,
220,
220,
220,
220,
220,
220,
220,
581,
796,
2775,
62,
83,
641,
669,
7,
411,
11,
685,
358,
12078,
7,
411,
8,
532,
352,
4357,
285,
862,
58,
72,
4357,
685,
17,
12962,
198,
220,
220,
220,
886,
198,
220,
220,
220,
581,
796,
2775,
62,
83,
641,
669,
7,
411,
11,
685,
358,
12078,
7,
411,
8,
532,
352,
4357,
285,
862,
58,
16,
7131,
16,
11,
1058,
11,
1058,
4357,
685,
16,
12962,
628,
220,
220,
220,
1303,
2735,
27179,
1758,
262,
1255,
16062,
198,
220,
220,
220,
581,
796,
27179,
1758,
7,
411,
11,
40426,
7,
7857,
7,
411,
22305,
628,
220,
220,
220,
1441,
581,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
2775,
62,
32844,
62,
521,
1063,
7,
76,
862,
3712,
7378,
46,
2599,
25,
46912,
90,
27,
25,
15057,
92,
198,
198,
15056,
281,
4904,
46,
2775,
262,
7166,
36525,
884,
326,
530,
909,
12143,
257,
15715,
17593,
13,
383,
36525,
389,
6149,
884,
326,
484,
389,
11670,
351,
262,
3210,
22300,
479,
33171,
15280,
1720,
13,
198,
198,
20361,
25,
262,
2134,
12006,
481,
423,
39682,
4088,
5359,
287,
2846,
286,
262,
1271,
286,
5043,
11,
779,
351,
1337,
0,
198,
37811,
198,
8818,
2775,
62,
32844,
62,
521,
1063,
7,
3149,
78,
3712,
7378,
46,
2599,
25,
46912,
90,
27,
25,
15057,
92,
198,
220,
220,
220,
399,
796,
4129,
7,
3149,
78,
8,
628,
220,
220,
220,
1303,
4619,
356,
1730,
351,
1280,
18645,
3403,
11,
356,
4268,
262,
31548,
36525,
530,
319,
262,
1364,
357,
3506,
8,
18645,
329,
262,
717,
357,
12957,
8,
11192,
273,
14500,
13,
775,
923,
422,
262,
826,
284,
423,
262,
3518,
36525,
287,
262,
1502,
11670,
351,
22300,
338,
479,
33171,
15280,
1720,
198,
220,
220,
220,
581,
796,
285,
7501,
58,
45,
7131,
45299,
352,
11,
1058,
11,
1058,
60,
198,
220,
220,
220,
329,
1312,
796,
399,
12,
16,
21912,
16,
25,
17,
198,
220,
220,
220,
220,
220,
220,
220,
581,
796,
2775,
62,
83,
641,
669,
7,
411,
11,
685,
358,
12078,
7,
411,
8,
532,
362,
4357,
285,
7501,
58,
72,
4357,
685,
17,
12962,
198,
220,
220,
220,
886,
198,
220,
220,
220,
581,
796,
2775,
62,
83,
641,
669,
7,
411,
11,
685,
358,
12078,
7,
411,
8,
532,
362,
4357,
285,
7501,
58,
16,
7131,
16,
11,
1058,
11,
1058,
11,
1058,
4357,
685,
16,
12962,
628,
220,
220,
220,
1303,
1874,
71,
18137,
262,
36525,
284,
307,
11670,
351,
22300,
338,
3210,
479,
33171,
15280,
1720,
198,
220,
220,
220,
581,
796,
9943,
7241,
12078,
7,
411,
11,
685,
33327,
7,
16,
25,
17,
25,
358,
12078,
7,
411,
18125,
2824,
7,
17,
25,
17,
25,
358,
12078,
7,
411,
4008,
12962,
628,
220,
220,
220,
1303,
2735,
27179,
1758,
262,
1255,
16062,
198,
220,
220,
220,
5391,
82,
796,
2546,
7,
411,
8,
198,
220,
220,
220,
1553,
796,
40426,
7,
67,
12078,
58,
16,
25,
45,
12962,
198,
220,
220,
220,
30736,
796,
40426,
7,
67,
12078,
58,
45,
10,
16,
25,
437,
12962,
198,
220,
220,
220,
581,
796,
27179,
1758,
7,
411,
11,
357,
7109,
11,
30736,
4008,
628,
220,
220,
220,
1441,
581,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
1064,
62,
2833,
5219,
7,
39,
3712,
19182,
90,
18843,
1352,
5512,
35,
3712,
5317,
2414,
11,
4134,
3712,
43879,
2414,
11,
9806,
62,
46280,
25386,
3712,
5317,
2414,
10779,
16,
8,
198,
198,
15056,
257,
11582,
666,
4904,
46,
367,
11,
1064,
281,
337,
3705,
40874,
329,
663,
2323,
1181,
351,
6314,
220,
198,
46156,
360,
6718,
2004,
284,
257,
3585,
9922,
697,
13,
1002,
257,
3967,
1271,
329,
3509,
62,
46280,
25386,
198,
271,
1813,
11,
262,
5415,
2033,
286,
34820,
318,
3614,
284,
3509,
62,
46280,
25386,
198,
37811,
198,
8818,
1064,
62,
2833,
5219,
7,
39,
3712,
38469,
90,
18843,
1352,
90,
51,
92,
5512,
360,
3712,
5317,
2414,
11,
288,
3712,
5317,
2414,
11,
697,
3712,
43879,
2414,
11,
3509,
62,
46280,
25386,
3712,
5317,
2414,
8,
810,
1391,
51,
92,
198,
220,
220,
220,
399,
796,
4129,
7,
39,
8,
628,
220,
220,
220,
1303,
3497,
262,
3518,
15225,
422,
262,
11582,
666,
198,
220,
220,
220,
288,
796,
20650,
90,
5317,
2414,
92,
7,
917,
891,
11,
4129,
7,
39,
4008,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
13664,
7,
39,
8,
198,
220,
220,
220,
220,
220,
220,
220,
288,
58,
72,
60,
796,
2546,
7,
39,
58,
72,
4357,
513,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
14534,
337,
3705,
284,
923,
262,
17952,
351,
198,
220,
220,
220,
285,
862,
796,
4738,
62,
76,
862,
62,
672,
66,
7,
45,
11,
360,
11,
288,
8,
628,
220,
220,
220,
1303,
5930,
340,
287,
826,
40091,
18266,
198,
220,
220,
220,
18266,
44,
3705,
0,
7,
76,
862,
11,
1058,
3506,
8,
198,
220,
220,
220,
1303,
3771,
9948,
3129,
378,
262,
13027,
2775,
507,
198,
220,
220,
220,
37491,
796,
9058,
62,
49,
7,
39,
11,
285,
862,
8,
628,
220,
220,
220,
1303,
2735,
923,
262,
18404,
198,
220,
220,
220,
997,
62,
1659,
62,
46280,
25386,
796,
657,
198,
220,
220,
220,
412,
15,
796,
657,
198,
220,
220,
220,
412,
727,
796,
352,
36,
20,
198,
220,
220,
220,
981,
357,
7942,
8,
198,
220,
220,
220,
220,
220,
220,
220,
997,
62,
1659,
62,
46280,
25386,
796,
997,
62,
1659,
62,
46280,
25386,
1343,
352,
198,
220,
220,
220,
220,
220,
220,
220,
44872,
7203,
40783,
538,
1271,
33172,
997,
62,
1659,
62,
46280,
25386,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
3574,
1364,
284,
826,
3599,
416,
352,
510,
284,
399,
12,
16,
198,
220,
220,
220,
220,
220,
220,
220,
412,
62,
12001,
796,
657,
198,
220,
220,
220,
220,
220,
220,
220,
581,
796,
657,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
796,
352,
25,
45,
12,
16,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
9578,
796,
37491,
58,
72,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6498,
796,
37491,
58,
72,
10,
16,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
412,
62,
12001,
11,
337,
796,
8494,
62,
68,
9324,
8367,
62,
45573,
7,
18819,
11,
6498,
11,
367,
58,
72,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
72,
4357,
4808,
796,
18266,
62,
15654,
7,
44,
11,
1058,
9464,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
37491,
58,
72,
10,
16,
60,
796,
4296,
62,
9464,
7,
18819,
11,
285,
862,
58,
72,
4357,
285,
862,
58,
72,
4357,
367,
58,
72,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
3574,
1364,
284,
826,
3599,
416,
352,
510,
284,
399,
12,
16,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
796,
399,
21912,
16,
25,
17,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
9578,
796,
37491,
58,
72,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6498,
796,
37491,
58,
72,
10,
16,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
412,
62,
12001,
11,
337,
796,
8494,
62,
68,
9324,
8367,
62,
45573,
7,
18819,
11,
6498,
11,
367,
58,
72,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
72,
4357,
581,
796,
18266,
62,
15654,
7,
44,
11,
1058,
3506,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
37491,
58,
72,
60,
796,
4296,
62,
3506,
7,
11028,
11,
285,
862,
58,
72,
4357,
285,
862,
58,
72,
4357,
367,
58,
72,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
6822,
40826,
34054,
198,
220,
220,
220,
220,
220,
220,
220,
611,
357,
8937,
19510,
36,
727,
532,
412,
62,
12001,
8,
1220,
412,
727,
8,
1279,
697,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
412,
15,
796,
412,
62,
12001,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
42019,
3487,
5612,
357,
16321,
7094,
318,
2622,
284,
2222,
262,
36525,
736,
656,
826,
1502,
706,
29148,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
16,
60,
796,
2775,
62,
83,
641,
669,
7,
76,
862,
58,
16,
4357,
685,
17,
4357,
581,
11,
685,
16,
4357,
685,
16,
26,
513,
26,
362,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
44872,
7203,
3103,
332,
12745,
284,
10348,
9922,
8793,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2270,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
361,
357,
9806,
62,
46280,
25386,
1875,
657,
11405,
997,
62,
1659,
62,
46280,
25386,
18189,
3509,
62,
46280,
25386,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
412,
15,
796,
412,
62,
12001,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
42019,
3487,
5612,
357,
16321,
7094,
318,
2622,
284,
2222,
262,
36525,
736,
656,
826,
1502,
706,
29148,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
16,
60,
796,
2775,
62,
83,
641,
669,
7,
76,
862,
58,
16,
4357,
685,
17,
4357,
581,
11,
685,
16,
4357,
685,
16,
26,
513,
26,
362,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
9828,
7203,
3041,
2317,
5415,
1271,
286,
34820,
878,
40826,
284,
10348,
9922,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2270,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
412,
727,
796,
412,
62,
12001,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
412,
15,
11,
285,
862,
11,
997,
62,
1659,
62,
46280,
25386,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
651,
1544,
487,
7,
18819,
11,
11028,
11,
54,
3712,
18843,
1352,
8,
198,
220,
220,
220,
220,
198,
42316,
262,
4050,
11582,
666,
198,
37811,
198,
8818,
651,
1544,
487,
7,
18819,
11,
6498,
11,
370,
3712,
18843,
1352,
8,
198,
220,
220,
220,
367,
29510,
796,
2775,
62,
83,
641,
669,
7,
54,
11,
685,
17,
4357,
6498,
11,
685,
17,
12962,
198,
220,
220,
220,
367,
29510,
796,
2775,
62,
83,
641,
669,
7,
18819,
11,
685,
17,
4357,
367,
29510,
11,
685,
16,
12962,
198,
220,
220,
220,
367,
29510,
796,
9943,
7241,
12078,
7,
39,
29510,
11,
685,
16,
26,
642,
26,
513,
26,
362,
26,
718,
26,
604,
12962,
198,
220,
220,
220,
5391,
16,
11,
5391,
17,
11,
5391,
18,
11,
5391,
19,
11,
5391,
20,
11,
5391,
21,
796,
2546,
7,
39,
29510,
8,
198,
220,
220,
220,
679,
487,
796,
27179,
1758,
7,
39,
29510,
11,
357,
27740,
16,
1635,
5391,
17,
1635,
5391,
18,
11,
5391,
19,
1635,
5391,
20,
1635,
5391,
21,
4008,
628,
220,
220,
220,
1441,
679,
487,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
8494,
62,
68,
9324,
8367,
62,
45573,
7,
18819,
11,
11028,
11,
54,
8,
198,
220,
220,
220,
220,
198,
22203,
284,
5678,
290,
8494,
262,
304,
9324,
8367,
1917,
543,
22068,
319,
1123,
2524,
329,
262,
4050,
11582,
666,
198,
37811,
198,
8818,
8494,
62,
68,
9324,
8367,
62,
45573,
7,
18819,
11,
6498,
11,
370,
8,
198,
220,
220,
220,
367,
29510,
796,
2775,
62,
83,
641,
669,
7,
54,
11,
685,
17,
4357,
6498,
11,
685,
17,
12962,
198,
220,
220,
220,
367,
29510,
796,
2775,
62,
83,
641,
669,
7,
18819,
11,
685,
17,
4357,
367,
29510,
11,
685,
16,
12962,
198,
220,
220,
220,
367,
29510,
796,
9943,
7241,
12078,
7,
39,
29510,
11,
685,
16,
26,
642,
26,
513,
26,
362,
26,
718,
26,
604,
12962,
198,
220,
220,
220,
5391,
16,
11,
5391,
17,
11,
5391,
18,
11,
5391,
19,
11,
5391,
20,
11,
5391,
21,
796,
2546,
7,
39,
29510,
8,
198,
220,
220,
220,
679,
487,
796,
27179,
1758,
7,
39,
29510,
11,
357,
27740,
16,
1635,
5391,
17,
1635,
5391,
18,
11,
5391,
19,
1635,
5391,
20,
1635,
5391,
21,
4008,
628,
220,
220,
220,
412,
62,
12001,
11,
337,
796,
304,
9235,
7,
1544,
487,
11,
497,
85,
796,
352,
11,
543,
796,
1058,
12562,
8,
198,
220,
220,
220,
337,
796,
27179,
1758,
7,
44,
11,
357,
27740,
16,
11,
5391,
20,
11,
5391,
18,
4008,
628,
220,
220,
220,
1441,
1103,
7,
36,
62,
12001,
58,
16,
46570,
337,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
9058,
62,
49,
7,
39,
3712,
7378,
46,
90,
51,
16,
5512,
76,
862,
3712,
44,
3705,
90,
51,
17,
30072,
810,
1391,
51,
16,
11,
51,
17,
92,
198,
220,
220,
220,
220,
198,
22203,
284,
15284,
262,
13027,
2775,
507,
2622,
284,
1296,
262,
4050,
11582,
666,
198,
37811,
198,
8818,
9058,
62,
49,
7,
39,
3712,
7378,
46,
90,
51,
16,
5512,
285,
862,
3712,
44,
3705,
90,
51,
17,
30072,
810,
1391,
51,
16,
11,
51,
17,
92,
198,
220,
220,
220,
399,
796,
4129,
7,
39,
8,
198,
220,
220,
220,
309,
411,
796,
7308,
13,
7783,
62,
19199,
7,
25666,
357,
51,
16,
11,
309,
17,
4008,
58,
16,
60,
198,
220,
220,
220,
37491,
796,
20650,
90,
19182,
90,
51,
411,
11,
18,
11709,
7,
917,
891,
11,
399,
1343,
352,
8,
628,
220,
220,
220,
1303,
775,
761,
691,
399,
12,
16,
13027,
2775,
507,
11,
2158,
11,
356,
900,
262,
13015,
284,
31548,
3815,
352,
326,
356,
460,
664,
1834,
2280,
24061,
790,
36246,
581,
4250,
262,
2180,
3392,
198,
220,
220,
220,
37491,
58,
16,
60,
796,
3392,
7,
51,
411,
11,
352,
11,
352,
11,
352,
8,
198,
220,
220,
220,
37491,
58,
45,
10,
16,
60,
796,
3392,
7,
51,
411,
11,
352,
11,
352,
11,
352,
8,
628,
220,
220,
220,
1303,
2735,
24061,
262,
13027,
2775,
507,
3599,
422,
262,
826,
357,
292,
314,
923,
18404,
319,
262,
1364,
287,
262,
2323,
1181,
2989,
8,
198,
220,
220,
220,
329,
1312,
796,
399,
21912,
16,
25,
17,
198,
220,
220,
220,
220,
220,
220,
220,
45218,
796,
2775,
62,
83,
641,
669,
7,
35972,
58,
72,
10,
16,
4357,
685,
18,
4357,
285,
862,
58,
72,
4357,
685,
17,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
45218,
796,
2775,
62,
83,
641,
669,
7,
39,
58,
72,
4357,
685,
17,
26,
604,
4357,
45218,
11,
685,
17,
26,
604,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
37491,
58,
72,
60,
796,
2775,
62,
83,
641,
669,
7,
1102,
73,
7,
76,
862,
58,
72,
46570,
685,
17,
26,
513,
4357,
45218,
11,
685,
18,
26,
362,
12962,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1441,
37491,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
4296,
62,
9464,
7,
35972,
11,
337,
62,
9464,
3712,
29123,
11,
337,
62,
3506,
3712,
29123,
11,
370,
3712,
18843,
1352,
8,
198,
220,
220,
220,
220,
198,
22203,
284,
1620,
281,
4296,
262,
13027,
2775,
507,
2672,
329,
11629,
876,
2323,
1181,
2989,
3599,
422,
262,
1364,
8574,
287,
37491,
220,
198,
37811,
198,
8818,
4296,
62,
9464,
7,
35972,
11,
337,
62,
9464,
3712,
29123,
11,
337,
62,
3506,
3712,
29123,
11,
370,
3712,
18843,
1352,
8,
198,
220,
220,
220,
581,
796,
2775,
62,
83,
641,
669,
7,
35972,
11,
685,
18,
4357,
337,
62,
3506,
11,
685,
16,
12962,
198,
220,
220,
220,
581,
796,
2775,
62,
83,
641,
669,
7,
54,
11,
685,
16,
26,
604,
4357,
581,
11,
685,
17,
26,
604,
12962,
198,
220,
220,
220,
581,
796,
2775,
62,
83,
641,
669,
7,
1102,
73,
7,
44,
62,
9464,
828,
685,
16,
26,
513,
4357,
581,
11,
685,
18,
26,
362,
12962,
628,
220,
220,
220,
1441,
581,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
4296,
62,
3506,
7,
35972,
11,
337,
62,
9464,
3712,
29123,
11,
337,
62,
3506,
3712,
29123,
11,
370,
3712,
18843,
1352,
8,
198,
198,
22203,
284,
1620,
281,
4296,
262,
13027,
2775,
507,
2672,
329,
11629,
876,
2323,
1181,
2989,
3599,
422,
262,
826,
8574,
287,
37491,
220,
198,
37811,
198,
8818,
4296,
62,
3506,
7,
35972,
11,
337,
62,
9464,
3712,
29123,
11,
337,
62,
3506,
3712,
29123,
11,
370,
3712,
18843,
1352,
8,
198,
220,
220,
220,
581,
796,
2775,
62,
83,
641,
669,
7,
35972,
11,
685,
18,
4357,
337,
62,
3506,
11,
685,
17,
12962,
198,
220,
220,
220,
581,
796,
2775,
62,
83,
641,
669,
7,
54,
11,
685,
17,
26,
604,
4357,
581,
11,
685,
17,
26,
604,
12962,
198,
220,
220,
220,
581,
796,
2775,
62,
83,
641,
669,
7,
1102,
73,
7,
44,
62,
9464,
828,
685,
17,
26,
513,
4357,
581,
11,
685,
18,
26,
362,
12962,
628,
220,
220,
220,
1441,
581,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
4174,
62,
46616,
7,
46616,
3712,
7378,
46,
90,
51,
16,
5512,
285,
862,
3712,
44,
3705,
90,
51,
17,
92,
2599,
25,
44,
3705,
810,
1391,
51,
16,
11,
51,
17,
92,
198,
220,
220,
220,
220,
198,
44836,
281,
10088,
1813,
355,
4904,
46,
284,
281,
337,
3705,
13,
383,
7186,
337,
3705,
481,
423,
257,
6314,
15793,
326,
318,
262,
1720,
286,
262,
6314,
15225,
286,
262,
337,
3705,
290,
262,
4904,
46,
13,
198,
37811,
198,
8818,
4174,
62,
46616,
7,
46616,
3712,
7378,
46,
90,
51,
16,
5512,
285,
862,
3712,
44,
3705,
90,
51,
17,
92,
2599,
25,
44,
3705,
810,
1391,
51,
16,
11,
51,
17,
92,
198,
220,
220,
220,
399,
16,
796,
4129,
7,
76,
862,
8,
198,
220,
220,
220,
399,
17,
796,
4129,
7,
46616,
8,
198,
220,
220,
220,
2488,
30493,
7,
45,
16,
6624,
399,
17,
8,
628,
220,
220,
220,
1303,
2980,
378,
257,
649,
4904,
46,
286,
262,
3376,
2099,
198,
220,
220,
220,
309,
411,
796,
7308,
13,
7783,
62,
19199,
7,
25666,
357,
51,
16,
11,
309,
17,
4008,
58,
16,
60,
198,
220,
220,
220,
581,
796,
337,
3705,
90,
51,
411,
92,
7,
917,
891,
11,
399,
16,
8,
628,
220,
220,
220,
1303,
27967,
262,
4904,
46,
284,
262,
337,
3705,
290,
7716,
649,
337,
3705,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
45,
16,
198,
220,
220,
220,
220,
220,
220,
220,
20218,
796,
2775,
62,
83,
641,
669,
7,
46616,
58,
72,
4357,
685,
19,
4357,
285,
862,
58,
72,
4357,
685,
18,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
20218,
796,
9943,
7241,
12078,
7,
29510,
11,
357,
16,
11,
604,
11,
362,
11,
642,
11,
513,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
5391,
16,
11,
5391,
17,
11,
5391,
18,
11,
5391,
19,
11,
5391,
20,
796,
2546,
7,
29510,
8,
198,
220,
220,
220,
220,
220,
220,
220,
581,
58,
72,
60,
796,
27179,
1758,
7,
29510,
11,
357,
27740,
16,
1635,
5391,
17,
11,
5391,
18,
1635,
5391,
19,
11,
5391,
20,
4008,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
581,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
4174,
62,
46616,
0,
7,
46616,
3712,
7378,
46,
90,
51,
16,
5512,
285,
862,
3712,
44,
3705,
90,
51,
17,
92,
2599,
25,
44,
3705,
810,
1391,
51,
16,
11,
51,
17,
92,
198,
220,
220,
220,
220,
198,
44836,
281,
10088,
1813,
355,
4904,
46,
284,
281,
337,
3705,
13,
383,
7186,
337,
3705,
481,
423,
257,
6314,
15793,
326,
318,
262,
1720,
286,
262,
6314,
15225,
286,
262,
337,
3705,
290,
262,
4904,
46,
13,
383,
5128,
481,
307,
6993,
9108,
416,
262,
1255,
13,
770,
4433,
326,
262,
2099,
286,
262,
4847,
286,
262,
5128,
337,
3705,
318,
1498,
284,
697,
296,
375,
378,
262,
1255,
286,
48816,
262,
4904,
46,
11192,
669,
656,
262,
337,
3705,
11192,
669,
357,
68,
13,
70,
13,
11524,
257,
3716,
4904,
46,
284,
257,
1103,
337,
3705,
2314,
307,
1760,
287,
18596,
344,
355,
262,
1255,
481,
307,
3716,
8,
198,
37811,
198,
8818,
4174,
62,
46616,
0,
7,
46616,
3712,
7378,
46,
11,
285,
862,
3712,
44,
3705,
8,
198,
220,
220,
220,
399,
16,
796,
4129,
7,
76,
862,
8,
198,
220,
220,
220,
399,
17,
796,
4129,
7,
46616,
8,
198,
220,
220,
220,
2488,
30493,
7,
45,
16,
6624,
399,
17,
8,
628,
220,
220,
220,
1303,
17453,
262,
11192,
669,
329,
1123,
2524,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
45,
16,
198,
220,
220,
220,
220,
220,
220,
220,
20218,
796,
2775,
62,
83,
641,
669,
7,
46616,
58,
72,
4357,
685,
19,
4357,
285,
862,
58,
72,
4357,
685,
18,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
20218,
796,
9943,
7241,
12078,
7,
29510,
11,
357,
16,
11,
604,
11,
362,
11,
642,
11,
513,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
5391,
16,
11,
5391,
17,
11,
5391,
18,
11,
5391,
19,
11,
5391,
20,
796,
2546,
7,
29510,
8,
198,
220,
220,
220,
220,
220,
220,
220,
285,
862,
58,
72,
60,
796,
27179,
1758,
7,
29510,
11,
357,
27740,
16,
1635,
5391,
17,
11,
5391,
18,
1635,
5391,
19,
11,
5391,
20,
4008,
198,
220,
220,
220,
886,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
4174,
62,
46616,
7,
404,
16,
3712,
7378,
46,
90,
51,
16,
5512,
1034,
17,
3712,
7378,
46,
90,
51,
17,
92,
2599,
25,
7378,
46,
810,
1391,
51,
16,
11,
51,
17,
92,
198,
220,
220,
220,
220,
198,
15205,
541,
306,
734,
4904,
16748,
1978,
284,
651,
281,
5408,
329,
1034,
17,
1635,
1034,
16,
287,
4904,
46,
1296,
13,
383,
7186,
337,
3705,
481,
423,
257,
6314,
15793,
326,
318,
262,
1720,
286,
262,
6314,
15225,
286,
1111,
4904,
16748,
13,
198,
37811,
198,
8818,
4174,
62,
46616,
7,
404,
16,
3712,
7378,
46,
90,
51,
16,
5512,
1034,
17,
3712,
7378,
46,
90,
51,
17,
92,
2599,
25,
7378,
46,
810,
1391,
51,
16,
11,
51,
17,
92,
198,
220,
220,
220,
399,
16,
796,
4129,
7,
404,
16,
8,
198,
220,
220,
220,
399,
17,
796,
4129,
7,
404,
17,
8,
198,
220,
220,
220,
2488,
30493,
7,
45,
16,
6624,
399,
17,
8,
628,
220,
220,
220,
1303,
2980,
378,
257,
649,
337,
3705,
286,
262,
3376,
2099,
198,
220,
220,
220,
309,
411,
796,
7308,
13,
7783,
62,
19199,
7,
25666,
357,
51,
16,
11,
309,
17,
4008,
58,
16,
60,
198,
220,
220,
220,
581,
796,
4904,
46,
90,
51,
411,
92,
7,
917,
891,
11,
399,
16,
8,
628,
220,
220,
220,
1303,
17453,
262,
11192,
669,
329,
1123,
2524,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
45,
16,
198,
220,
220,
220,
220,
220,
220,
220,
20218,
796,
2775,
62,
83,
641,
669,
7,
404,
17,
58,
72,
4357,
685,
19,
4357,
1034,
16,
58,
72,
4357,
685,
18,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
20218,
796,
9943,
7241,
12078,
7,
29510,
11,
357,
16,
11,
604,
11,
362,
11,
642,
11,
513,
11,
718,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
5391,
16,
11,
5391,
17,
11,
5391,
18,
11,
5391,
19,
11,
5391,
20,
11,
5391,
21,
796,
2546,
7,
29510,
8,
198,
220,
220,
220,
220,
220,
220,
220,
581,
58,
72,
60,
796,
27179,
1758,
7,
29510,
11,
357,
27740,
16,
1635,
5391,
17,
11,
5391,
18,
1635,
5391,
19,
11,
5391,
20,
11,
5391,
21,
4008,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
581,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
2160,
62,
27219,
7,
76,
862,
16,
3712,
44,
3705,
90,
51,
16,
5512,
285,
862,
17,
3712,
44,
3705,
90,
51,
17,
92,
2599,
25,
44,
3705,
810,
1391,
51,
16,
11,
51,
17,
92,
198,
220,
220,
220,
220,
198,
4550,
734,
337,
3705,
82,
1978,
284,
651,
281,
5408,
329,
285,
862,
16,
1343,
285,
862,
17,
287,
337,
3705,
1296,
13,
383,
7186,
337,
3705,
481,
423,
257,
6314,
15793,
326,
318,
262,
2160,
286,
262,
6314,
15225,
286,
1111,
4904,
16748,
13,
198,
37811,
198,
8818,
2160,
62,
27219,
7,
76,
862,
16,
3712,
44,
3705,
90,
51,
16,
5512,
285,
862,
17,
3712,
44,
3705,
90,
51,
17,
92,
2599,
25,
44,
3705,
810,
1391,
51,
16,
11,
51,
17,
92,
198,
220,
220,
220,
399,
16,
796,
4129,
7,
76,
862,
16,
8,
198,
220,
220,
220,
399,
17,
796,
4129,
7,
76,
862,
17,
8,
198,
220,
220,
220,
2488,
30493,
7,
45,
16,
6624,
399,
17,
8,
628,
220,
220,
220,
1303,
2980,
378,
257,
649,
4904,
46,
286,
262,
3376,
2099,
198,
220,
220,
220,
309,
411,
796,
7308,
13,
7783,
62,
19199,
7,
28200,
357,
51,
16,
11,
309,
17,
4008,
58,
16,
60,
198,
220,
220,
220,
581,
796,
337,
3705,
90,
51,
411,
92,
7,
917,
891,
11,
399,
16,
8,
628,
220,
220,
220,
1303,
383,
717,
2524,
2476,
2041,
3513,
198,
220,
220,
220,
11192,
273,
16,
796,
285,
862,
16,
58,
16,
60,
198,
220,
220,
220,
11192,
273,
17,
796,
285,
862,
17,
58,
16,
60,
198,
220,
220,
220,
4808,
11,
1583,
16,
11,
288,
16,
796,
2546,
7,
83,
22854,
16,
8,
198,
220,
220,
220,
4808,
11,
1583,
17,
11,
288,
17,
796,
2546,
7,
83,
22854,
17,
8,
198,
220,
220,
220,
649,
62,
83,
22854,
796,
1976,
27498,
7,
51,
411,
11,
352,
11,
1583,
16,
1343,
1583,
17,
11,
288,
16,
8,
198,
220,
220,
220,
329,
374,
796,
352,
25,
67,
16,
198,
220,
220,
220,
220,
220,
220,
220,
649,
62,
83,
22854,
58,
16,
11,
1058,
11,
374,
60,
796,
685,
83,
22854,
16,
58,
16,
25,
16,
11,
1058,
11,
374,
60,
11192,
273,
17,
58,
16,
25,
16,
11,
1058,
11,
374,
11907,
198,
220,
220,
220,
886,
198,
220,
220,
220,
581,
58,
16,
60,
796,
649,
62,
83,
22854,
198,
220,
220,
220,
1303,
383,
11192,
669,
287,
1022,
198,
220,
220,
220,
329,
1312,
796,
362,
25,
45,
16,
12,
16,
198,
220,
220,
220,
220,
220,
220,
220,
11192,
273,
16,
796,
285,
862,
16,
58,
72,
60,
198,
220,
220,
220,
220,
220,
220,
220,
11192,
273,
17,
796,
285,
862,
17,
58,
72,
60,
198,
220,
220,
220,
220,
220,
220,
220,
360,
75,
16,
11,
1583,
16,
11,
288,
16,
796,
2546,
7,
83,
22854,
16,
8,
198,
220,
220,
220,
220,
220,
220,
220,
360,
75,
17,
11,
1583,
17,
11,
288,
17,
796,
2546,
7,
83,
22854,
17,
8,
198,
220,
220,
220,
220,
220,
220,
220,
649,
62,
83,
22854,
796,
1976,
27498,
7,
51,
411,
11,
360,
75,
16,
1343,
360,
75,
17,
11,
1583,
16,
1343,
1583,
17,
11,
288,
16,
8,
198,
220,
220,
220,
220,
220,
220,
220,
329,
374,
796,
352,
25,
67,
16,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
649,
62,
83,
22854,
58,
16,
25,
35,
75,
16,
11,
352,
25,
6187,
16,
11,
374,
60,
796,
11192,
273,
16,
58,
45299,
1058,
11,
374,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
649,
62,
83,
22854,
58,
35,
75,
16,
10,
16,
25,
437,
11,
1583,
16,
10,
16,
25,
437,
11,
374,
60,
796,
11192,
273,
17,
58,
45299,
1058,
11,
374,
60,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
581,
58,
72,
60,
796,
649,
62,
83,
22854,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1303,
383,
938,
2524,
2476,
2041,
3513,
198,
220,
220,
220,
11192,
273,
16,
796,
285,
862,
16,
58,
45,
16,
60,
198,
220,
220,
220,
11192,
273,
17,
796,
285,
862,
17,
58,
45,
16,
60,
198,
220,
220,
220,
360,
75,
16,
11,
4808,
11,
288,
16,
796,
2546,
7,
83,
22854,
16,
8,
198,
220,
220,
220,
360,
75,
17,
11,
4808,
11,
288,
17,
796,
2546,
7,
83,
22854,
17,
8,
198,
220,
220,
220,
649,
62,
83,
22854,
796,
1976,
27498,
7,
51,
411,
11,
360,
75,
16,
1343,
360,
75,
17,
11,
352,
11,
288,
16,
8,
198,
220,
220,
220,
329,
374,
796,
352,
25,
67,
16,
198,
220,
220,
220,
220,
220,
220,
220,
649,
62,
83,
22854,
58,
45299,
352,
11,
374,
60,
796,
685,
83,
22854,
16,
58,
45299,
352,
11,
374,
11208,
11192,
273,
17,
58,
45299,
352,
11,
374,
11907,
198,
220,
220,
220,
886,
198,
220,
220,
220,
581,
58,
45,
16,
60,
796,
649,
62,
83,
22854,
628,
220,
220,
220,
1441,
581,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
2160,
62,
3575,
2024,
7,
404,
16,
3712,
7378,
46,
90,
51,
16,
5512,
1034,
17,
3712,
7378,
46,
90,
51,
17,
92,
2599,
25,
7378,
46,
810,
1391,
51,
16,
11,
51,
17,
92,
198,
220,
220,
220,
220,
198,
4550,
734,
4904,
16748,
1978,
284,
651,
281,
5408,
329,
1034,
17,
1343,
1034,
16,
287,
4904,
46,
1296,
13,
383,
7186,
4904,
46,
481,
423,
257,
6314,
15793,
326,
318,
262,
2160,
286,
262,
6314,
15225,
286,
1111,
4904,
16748,
13,
198,
37811,
198,
8818,
2160,
62,
3575,
2024,
7,
404,
16,
3712,
7378,
46,
90,
51,
16,
5512,
1034,
17,
3712,
7378,
46,
90,
51,
17,
92,
2599,
25,
7378,
46,
810,
1391,
51,
16,
11,
51,
17,
92,
198,
220,
220,
220,
399,
16,
796,
4129,
7,
404,
16,
8,
198,
220,
220,
220,
399,
17,
796,
4129,
7,
404,
17,
8,
198,
220,
220,
220,
2488,
30493,
7,
45,
16,
6624,
399,
17,
8,
628,
220,
220,
220,
1303,
2980,
378,
257,
649,
4904,
46,
286,
262,
3376,
2099,
198,
220,
220,
220,
309,
411,
796,
7308,
13,
7783,
62,
19199,
7,
28200,
357,
51,
16,
11,
309,
17,
4008,
58,
16,
60,
198,
220,
220,
220,
581,
796,
4904,
46,
90,
51,
411,
92,
7,
917,
891,
11,
399,
16,
8,
628,
220,
220,
220,
1303,
383,
717,
2524,
2476,
2041,
3513,
198,
220,
220,
220,
11192,
273,
16,
796,
1034,
16,
58,
16,
60,
198,
220,
220,
220,
11192,
273,
17,
796,
1034,
17,
58,
16,
60,
198,
220,
220,
220,
4808,
11,
1583,
16,
11,
1553,
16,
11,
30736,
16,
796,
2546,
7,
83,
22854,
16,
8,
198,
220,
220,
220,
4808,
11,
1583,
17,
11,
1553,
17,
11,
30736,
17,
796,
2546,
7,
83,
22854,
17,
8,
198,
220,
220,
220,
649,
62,
83,
22854,
796,
1976,
27498,
7,
51,
411,
11,
352,
11,
1583,
16,
1343,
1583,
17,
11,
1553,
16,
11,
30736,
16,
8,
198,
220,
220,
220,
329,
374,
796,
352,
25,
7109,
16,
198,
220,
220,
220,
220,
220,
220,
220,
329,
269,
796,
352,
25,
17896,
16,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
649,
62,
83,
22854,
58,
16,
11,
1058,
11,
374,
11,
269,
60,
796,
685,
83,
22854,
16,
58,
16,
25,
16,
11,
1058,
11,
374,
11,
269,
60,
11192,
273,
17,
58,
16,
25,
16,
11,
1058,
11,
374,
11,
269,
11907,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
581,
58,
16,
60,
796,
649,
62,
83,
22854,
198,
220,
220,
220,
1303,
383,
11192,
669,
287,
1022,
198,
220,
220,
220,
329,
1312,
796,
362,
25,
45,
16,
12,
16,
198,
220,
220,
220,
220,
220,
220,
220,
11192,
273,
16,
796,
1034,
16,
58,
72,
60,
198,
220,
220,
220,
220,
220,
220,
220,
11192,
273,
17,
796,
1034,
17,
58,
72,
60,
198,
220,
220,
220,
220,
220,
220,
220,
360,
75,
16,
11,
1583,
16,
11,
1553,
16,
11,
30736,
16,
796,
2546,
7,
83,
22854,
16,
8,
198,
220,
220,
220,
220,
220,
220,
220,
360,
75,
17,
11,
1583,
17,
11,
1553,
17,
11,
30736,
17,
796,
2546,
7,
83,
22854,
17,
8,
198,
220,
220,
220,
220,
220,
220,
220,
649,
62,
83,
22854,
796,
1976,
27498,
7,
51,
411,
11,
360,
75,
16,
1343,
360,
75,
17,
11,
1583,
16,
1343,
1583,
17,
11,
1553,
16,
11,
30736,
16,
8,
198,
220,
220,
220,
220,
220,
220,
220,
329,
374,
796,
352,
25,
7109,
16,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
269,
796,
352,
25,
17896,
16,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
649,
62,
83,
22854,
58,
16,
25,
35,
75,
16,
11,
352,
25,
6187,
16,
11,
374,
11,
269,
60,
796,
11192,
273,
16,
58,
45299,
1058,
11,
374,
11,
269,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
649,
62,
83,
22854,
58,
35,
75,
16,
10,
16,
25,
437,
11,
1583,
16,
10,
16,
25,
437,
11,
374,
11,
269,
60,
796,
11192,
273,
17,
58,
45299,
1058,
11,
374,
11,
269,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
581,
58,
72,
60,
796,
649,
62,
83,
22854,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1303,
383,
938,
2524,
2476,
2041,
3513,
198,
220,
220,
220,
11192,
273,
16,
796,
1034,
16,
58,
45,
16,
60,
198,
220,
220,
220,
11192,
273,
17,
796,
1034,
17,
58,
45,
16,
60,
198,
220,
220,
220,
360,
75,
16,
11,
4808,
11,
1553,
16,
11,
30736,
16,
796,
2546,
7,
83,
22854,
16,
8,
198,
220,
220,
220,
360,
75,
17,
11,
4808,
11,
1553,
17,
11,
30736,
17,
796,
2546,
7,
83,
22854,
17,
8,
198,
220,
220,
220,
649,
62,
83,
22854,
796,
1976,
27498,
7,
51,
411,
11,
360,
75,
16,
1343,
360,
75,
17,
11,
352,
11,
1553,
16,
11,
30736,
16,
8,
198,
220,
220,
220,
329,
374,
796,
352,
25,
7109,
16,
198,
220,
220,
220,
220,
220,
220,
220,
329,
269,
796,
352,
25,
17896,
16,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
649,
62,
83,
22854,
58,
45299,
352,
11,
374,
11,
269,
60,
796,
685,
83,
22854,
16,
58,
45299,
352,
11,
374,
11,
269,
11208,
11192,
273,
17,
58,
45299,
352,
11,
374,
11,
269,
11907,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
581,
58,
45,
16,
60,
796,
649,
62,
83,
22854,
628,
220,
220,
220,
1441,
581,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
24061,
62,
298,
28338,
7,
76,
862,
3712,
44,
3705,
11,
299,
25,
5317,
2599,
25,
43879,
2414,
198,
198,
7293,
1133,
262,
18042,
3169,
40062,
1863,
329,
262,
14141,
433,
295,
286,
262,
5043,
656,
734,
6352,
1039,
317,
34758,
16,
42303,
11,
77,
92,
290,
347,
34758,
77,
10,
16,
42303,
11,
45,
92,
810,
399,
318,
262,
4129,
286,
262,
337,
3705,
13,
1002,
299,
27,
28,
15,
318,
14275,
11,
257,
14141,
433,
295,
286,
656,
317,
13,
1114,
262,
1255,
284,
787,
2565,
11,
285,
862,
468,
284,
307,
257,
39279,
14821,
1181,
13,
198,
37811,
198,
8818,
24061,
62,
298,
28338,
7,
76,
862,
3712,
44,
3705,
90,
51,
5512,
299,
3712,
5317,
796,
657,
2599,
25,
43879,
2414,
810,
1391,
51,
92,
198,
220,
220,
220,
1303,
5683,
529,
262,
4129,
290,
2198,
611,
262,
1813,
2292,
318,
6397,
198,
220,
220,
220,
399,
796,
4129,
7,
76,
862,
8,
198,
220,
220,
220,
2488,
30493,
7,
77,
19841,
399,
8,
628,
220,
220,
220,
1303,
383,
40709,
286,
262,
2104,
1181,
318,
2391,
6632,
1201,
340,
318,
257,
5899,
1181,
11,
523,
2147,
284,
24061,
198,
220,
220,
220,
611,
299,
6624,
399,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
657,
13,
15,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
554,
1339,
257,
1988,
299,
27,
28,
15,
318,
1813,
11,
356,
7048,
262,
14141,
433,
295,
318,
2077,
287,
262,
3641,
198,
220,
220,
220,
611,
299,
19841,
657,
198,
220,
220,
220,
220,
220,
220,
220,
299,
796,
2558,
7,
744,
7,
45,
1220,
362,
4008,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
3497,
257,
4866,
286,
262,
5128,
198,
220,
220,
220,
285,
862,
62,
17946,
796,
2769,
30073,
7,
76,
862,
8,
628,
220,
220,
220,
1303,
5930,
262,
5043,
1364,
284,
299,
656,
1364,
40091,
18266,
220,
220,
220,
220,
198,
220,
220,
220,
337,
796,
285,
862,
62,
17946,
58,
16,
60,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
77,
198,
220,
220,
220,
220,
220,
220,
220,
285,
862,
62,
17946,
58,
72,
4357,
581,
796,
18266,
62,
15654,
7,
44,
11,
1058,
9464,
8,
198,
220,
220,
220,
220,
220,
220,
220,
337,
796,
2775,
62,
83,
641,
669,
7,
411,
11,
685,
17,
4357,
285,
862,
62,
17946,
58,
72,
10,
16,
4357,
685,
16,
12962,
198,
220,
220,
220,
886,
198,
220,
220,
220,
285,
862,
62,
17946,
58,
77,
10,
16,
60,
796,
337,
628,
220,
220,
220,
1303,
2735,
923,
29148,
422,
262,
826,
18645,
284,
7330,
262,
5322,
12109,
10088,
220,
198,
220,
220,
220,
374,
36020,
796,
3392,
7,
51,
11,
352,
11,
352,
8,
198,
220,
220,
220,
329,
1312,
796,
399,
21912,
16,
25,
77,
10,
16,
198,
220,
220,
220,
220,
220,
220,
220,
374,
36020,
796,
2775,
62,
83,
641,
669,
7,
4372,
76,
11,
685,
17,
4357,
285,
862,
62,
17946,
58,
72,
4357,
685,
17,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
374,
36020,
796,
2775,
62,
83,
641,
669,
7,
1102,
73,
7,
76,
862,
62,
17946,
58,
72,
46570,
685,
17,
26,
513,
4357,
374,
36020,
11,
685,
16,
26,
513,
12962,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
2735,
40039,
1096,
262,
5322,
12109,
17593,
290,
24061,
262,
40709,
220,
220,
220,
220,
198,
220,
220,
220,
819,
796,
1103,
7,
68,
328,
12786,
7,
4372,
76,
4008,
198,
220,
220,
220,
1303,
412,
9324,
27160,
326,
389,
5470,
1146,
6632,
3360,
1716,
532,
16,
36,
12,
1433,
11,
284,
2948,
2761,
351,
262,
2604,
283,
342,
76,
356,
8106,
606,
198,
220,
220,
220,
819,
796,
8106,
7,
87,
4613,
2124,
1875,
657,
13,
15,
11,
819,
8,
198,
220,
220,
220,
1303,
383,
18042,
3169,
40062,
40709,
329,
262,
5322,
12109,
10088,
198,
220,
220,
220,
40709,
796,
532,
16345,
7,
1990,
764,
9,
2604,
17,
12195,
1990,
4008,
628,
220,
220,
220,
1441,
40709,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
6291,
62,
6738,
62,
76,
862,
0,
7,
76,
862,
3712,
44,
3705,
11,
18266,
62,
15414,
3712,
33,
970,
28,
7942,
2599,
25,
38469,
90,
5317,
2414,
92,
198,
198,
8645,
378,
257,
6291,
422,
262,
12867,
6082,
286,
4308,
2585,
5447,
416,
262,
337,
3705,
1708,
317,
13,
12880,
2442,
11,
402,
13,
569,
11624,
11,
4810,
33,
7600,
21409,
20964,
357,
1238,
2481,
737,
1002,
262,
6056,
308,
2064,
62,
15414,
318,
900,
284,
2081,
11,
262,
5128,
337,
3705,
481,
307,
1234,
287,
826,
18061,
2413,
18266,
290,
39279,
11,
543,
318,
257,
9079,
329,
262,
11862,
284,
670,
13,
554,
1339,
530,
318,
1654,
326,
262,
337,
3705,
318,
1541,
6105,
14885,
2004,
290,
39279,
262,
14885,
2667,
2239,
460,
307,
31348,
416,
4634,
262,
6056,
284,
3991,
13,
554,
428,
1339,
262,
5128,
481,
2652,
36519,
13,
198,
37811,
198,
8818,
6291,
62,
6738,
62,
76,
862,
0,
7,
76,
862,
3712,
44,
3705,
11,
18266,
62,
15414,
3712,
33,
970,
796,
2081,
2599,
25,
38469,
90,
5317,
2414,
92,
198,
220,
220,
220,
1303,
5683,
529,
262,
4129,
290,
2198,
611,
262,
1813,
2292,
318,
6397,
198,
220,
220,
220,
399,
796,
4129,
7,
76,
862,
8,
198,
220,
220,
220,
581,
796,
1976,
27498,
7,
5317,
2414,
11,
399,
8,
628,
220,
220,
220,
1303,
5930,
262,
1181,
656,
826,
40091,
18266,
290,
787,
1654,
340,
318,
39279,
198,
220,
220,
220,
611,
18266,
62,
15414,
198,
220,
220,
220,
220,
220,
220,
220,
18266,
44,
3705,
0,
7,
76,
862,
11,
1058,
3506,
11,
2081,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
2735,
6291,
422,
262,
337,
3705,
198,
220,
220,
220,
317,
796,
657,
198,
220,
220,
220,
279,
796,
657,
13,
15,
198,
220,
220,
220,
337,
796,
285,
862,
58,
16,
7131,
16,
11,
1058,
11,
1058,
60,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
45,
198,
220,
220,
220,
220,
220,
220,
220,
288,
796,
2546,
7,
44,
11,
362,
8,
198,
220,
220,
220,
220,
220,
220,
220,
279,
4134,
796,
657,
198,
220,
220,
220,
220,
220,
220,
220,
374,
796,
43720,
3419,
198,
220,
220,
220,
220,
220,
220,
220,
329,
300,
796,
352,
25,
67,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
43426,
262,
4308,
1181,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4308,
62,
5219,
796,
1976,
27498,
7,
67,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4308,
62,
5219,
58,
75,
60,
796,
352,
13,
15,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
17453,
340,
656,
262,
3518,
6376,
286,
262,
11192,
273,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
317,
796,
2775,
62,
83,
641,
669,
7,
44,
11,
685,
17,
4357,
4308,
62,
5219,
11,
685,
16,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
45559,
3810,
262,
12867,
329,
262,
4308,
15879,
304,
62,
75,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
279,
796,
2775,
62,
83,
641,
669,
7,
1102,
73,
7,
32,
828,
685,
16,
4357,
317,
11,
685,
16,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
279,
4134,
15853,
1103,
7,
79,
58,
16,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
374,
1279,
279,
4134,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
581,
58,
72,
60,
796,
300,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2270,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
611,
1312,
1279,
399,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
17453,
262,
1255,
656,
262,
1306,
11192,
273,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
337,
796,
2775,
62,
83,
641,
669,
7,
16,
1220,
19862,
17034,
7,
5305,
7,
79,
58,
16,
60,
4008,
1635,
317,
11,
685,
16,
4357,
285,
862,
58,
72,
10,
16,
4357,
685,
16,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
581,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
6291,
62,
6738,
62,
76,
862,
7,
76,
862,
3712,
44,
3705,
2599,
25,
38469,
90,
5317,
2414,
92,
198,
198,
8645,
378,
257,
6291,
422,
262,
12867,
6082,
286,
4308,
2585,
5447,
416,
262,
337,
3705,
1708,
317,
13,
12880,
2442,
11,
402,
13,
569,
11624,
11,
4810,
33,
7600,
21409,
20964,
357,
1238,
2481,
737,
220,
198,
37811,
198,
8818,
6291,
62,
6738,
62,
76,
862,
7,
76,
862,
3712,
44,
3705,
2599,
25,
38469,
90,
5317,
2414,
92,
198,
220,
220,
220,
1441,
6291,
62,
6738,
62,
76,
862,
0,
7,
22089,
30073,
7,
76,
862,
4008,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
264,
20306,
62,
5589,
601,
62,
76,
862,
7,
76,
862,
3712,
44,
3705,
11,
360,
9806,
3712,
5317,
9832,
284,
75,
3712,
15633,
796,
657,
13,
15,
2599,
25,
44,
3705,
198,
198,
7293,
601,
257,
1813,
337,
3705,
11524,
281,
257,
18032,
1988,
26969,
9150,
379,
1123,
6314,
13,
1002,
360,
9806,
1875,
657,
318,
14275,
357,
392,
11640,
284,
75,
796,
657,
13,
15,
828,
257,
5415,
286,
360,
9806,
18032,
3815,
318,
4030,
11,
4145,
40122,
803,
262,
337,
3705,
284,
530,
351,
5415,
6314,
15793,
360,
9806,
13,
1002,
284,
75,
1875,
657,
318,
1813,
357,
392,
11640,
360,
9806,
796,
657,
8,
788,
477,
18032,
3815,
1875,
284,
75,
389,
4030,
13,
1002,
1111,
389,
7368,
788,
379,
749,
360,
9806,
18032,
3815,
1875,
284,
75,
389,
4030,
13,
198,
37811,
198,
8818,
264,
20306,
62,
5589,
601,
62,
76,
862,
7,
76,
862,
3712,
44,
3705,
11,
360,
9806,
3712,
5317,
11,
284,
75,
3712,
15633,
796,
657,
13,
15,
2599,
25,
44,
3705,
198,
220,
220,
220,
1303,
1881,
286,
262,
734,
10007,
468,
284,
307,
4025,
621,
6632,
198,
220,
220,
220,
2488,
30493,
19510,
35,
9806,
1875,
657,
8,
8614,
357,
83,
349,
1875,
657,
4008,
198,
220,
220,
220,
1303,
29677,
262,
4129,
290,
8335,
257,
1255,
198,
220,
220,
220,
399,
796,
4129,
7,
76,
862,
8,
198,
220,
220,
220,
581,
796,
2769,
30073,
7,
76,
862,
8,
198,
220,
220,
220,
1303,
35094,
469,
287,
1111,
11678,
326,
30806,
15225,
379,
262,
13215,
389,
4615,
198,
220,
220,
220,
18266,
44,
3705,
0,
7,
411,
11,
1058,
9464,
8,
198,
220,
220,
220,
18266,
44,
3705,
0,
7,
411,
11,
1058,
3506,
8,
198,
220,
220,
220,
360,
3605,
796,
657,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
45,
12,
16,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
6822,
611,
262,
1813,
6314,
15793,
318,
4025,
621,
360,
9806,
198,
220,
220,
220,
220,
220,
220,
220,
611,
2546,
7,
411,
58,
72,
4357,
362,
8,
1875,
360,
9806,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
360,
75,
16,
11,
4808,
11,
288,
16,
796,
2546,
7,
411,
58,
72,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4808,
11,
1583,
17,
11,
288,
17,
796,
2546,
7,
411,
58,
72,
10,
16,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
45218,
796,
2775,
62,
83,
641,
669,
7,
411,
58,
72,
4357,
685,
17,
4357,
581,
58,
72,
10,
16,
4357,
685,
16,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
45218,
796,
27179,
1758,
7,
22065,
11,
357,
35,
75,
16,
1635,
288,
16,
11,
1583,
17,
1635,
288,
17,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
471,
11,
311,
11,
569,
796,
264,
20306,
7,
22065,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
337,
796,
2566,
363,
76,
7,
50,
8,
1635,
569,
6,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
2735,
40122,
378,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
360,
9806,
1875,
657,
11405,
284,
75,
6624,
657,
13,
15,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
471,
796,
471,
58,
45299,
352,
25,
35,
9806,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
337,
796,
337,
58,
16,
25,
35,
9806,
11,
1058,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
360,
3605,
796,
360,
9806,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
773,
796,
1064,
439,
7,
87,
4613,
2124,
1875,
284,
75,
11,
311,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
360,
9806,
1875,
657,
11405,
4129,
7,
521,
8,
1875,
360,
9806,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
773,
796,
773,
58,
16,
25,
35,
9806,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
471,
796,
471,
58,
45299,
773,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
337,
796,
337,
58,
521,
11,
1058,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
360,
3605,
796,
4129,
7,
521,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
1874,
71,
1758,
290,
900,
649,
11192,
669,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
581,
58,
72,
60,
796,
9943,
7241,
12078,
7,
3447,
1758,
7,
52,
11,
357,
35,
75,
16,
11,
288,
16,
11,
360,
3605,
36911,
357,
16,
11,
513,
11,
362,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
581,
58,
72,
10,
16,
60,
796,
27179,
1758,
7,
44,
11,
357,
35,
3605,
11,
1583,
17,
11,
288,
17,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
581,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
26969,
3455,
62,
20424,
62,
3149,
78,
7,
44,
3712,
46912,
90,
51,
5512,
288,
3712,
38469,
90,
5317,
30072,
810,
309,
1279,
25,
15057,
198,
198,
15056,
257,
867,
12,
2618,
10088,
287,
1296,
286,
257,
15715,
17593,
11,
26969,
3455,
340,
656,
281,
4904,
46,
13,
632,
318,
9672,
326,
262,
867,
12,
2618,
10088,
5679,
262,
6376,
9831,
286,
22300,
338,
3170,
12,
259,
479,
33171,
15280,
1720,
13,
383,
15879,
288,
26052,
262,
1957,
15225,
286,
262,
47718,
2272,
13,
220,
198,
198,
2,
21066,
198,
10707,
296,
32927,
257,
2829,
734,
12,
15654,
10088,
925,
510,
422,
2160,
286,
3362,
72,
2846,
656,
4904,
46,
1296,
13,
198,
15506,
63,
73,
43640,
12,
35666,
198,
73,
43640,
29,
220,
5121,
796,
685,
16,
13,
15,
657,
26,
657,
13,
15,
352,
13,
15,
60,
198,
73,
43640,
29,
220,
1395,
796,
685,
15,
13,
15,
352,
13,
15,
26,
352,
13,
15,
657,
13,
15,
60,
198,
73,
43640,
29,
220,
1168,
796,
685,
16,
13,
15,
657,
13,
15,
26,
657,
13,
15,
532,
16,
13,
15,
60,
198,
73,
43640,
29,
220,
367,
796,
479,
1313,
7,
55,
11,
55,
8,
1343,
479,
1313,
7,
7390,
11,
57,
8,
1343,
479,
1313,
7,
57,
11,
7390,
8,
198,
73,
43640,
29,
220,
285,
7501,
796,
26969,
3455,
62,
20424,
62,
3149,
78,
7,
39,
11,
362,
8,
198,
15506,
63,
198,
37811,
198,
8818,
26969,
3455,
62,
20424,
62,
3149,
78,
7,
44,
3712,
46912,
90,
51,
5512,
288,
3712,
38469,
90,
5317,
92,
2599,
25,
7378,
46,
90,
51,
92,
810,
1391,
51,
27,
25,
15057,
92,
198,
220,
220,
220,
399,
796,
4129,
7,
67,
8,
198,
220,
220,
220,
5391,
796,
40426,
7,
67,
8,
198,
220,
220,
220,
611,
2546,
7,
44,
8,
14512,
357,
1676,
67,
7,
67,
828,
40426,
7,
67,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
28100,
1713,
12331,
7203,
6759,
8609,
407,
11670,
351,
7368,
1957,
15225,
11,
1392,
2546,
7,
44,
8,
43641,
7,
260,
1050,
7,
7857,
7,
44,
4008,
828,
288,
43641,
7,
260,
1050,
7,
67,
4008,
48774,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1303,
383,
4904,
46,
4769,
262,
1255,
198,
220,
220,
220,
581,
796,
4904,
46,
90,
51,
92,
7,
917,
891,
11,
399,
8,
198,
220,
220,
220,
1303,
1874,
71,
1758,
262,
17593,
290,
37825,
858,
262,
36525,
11,
884,
326,
262,
5752,
290,
5721,
6376,
329,
1123,
2524,
389,
15909,
290,
751,
31548,
36525,
352,
379,
262,
13215,
220,
220,
220,
220,
198,
220,
220,
220,
317,
796,
27179,
1758,
7,
44,
11,
357,
16,
11,
9575,
7,
67,
26513,
11,
9575,
7,
67,
26513,
11,
352,
4008,
198,
220,
220,
220,
773,
796,
2824,
7,
29993,
2024,
13,
2704,
41769,
7,
13344,
7,
33327,
7,
45,
21912,
16,
25,
16,
828,
2824,
7,
17,
45,
21912,
16,
25,
45,
10,
16,
35514,
198,
220,
220,
220,
317,
796,
9943,
7241,
12078,
7,
32,
11,
357,
16,
11,
773,
764,
10,
352,
986,
11,
362,
1635,
4129,
7,
67,
8,
1343,
362,
4008,
198,
220,
220,
220,
1303,
2735,
6626,
340,
656,
11192,
669,
1262,
281,
311,
8898,
198,
220,
220,
220,
360,
75,
796,
352,
198,
220,
220,
220,
329,
1312,
796,
352,
25,
45,
12,
16,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
7214,
262,
717,
1115,
36525,
1978,
198,
220,
220,
220,
220,
220,
220,
220,
5391,
82,
796,
2546,
7,
32,
8,
198,
220,
220,
220,
220,
220,
220,
220,
317,
796,
27179,
1758,
7,
32,
11,
357,
1676,
67,
7,
67,
12078,
58,
16,
25,
18,
46570,
40426,
7,
67,
12078,
58,
19,
25,
437,
60,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
311,
8898,
262,
17593,
10552,
198,
220,
220,
220,
220,
220,
220,
220,
471,
11,
311,
11,
569,
796,
264,
20306,
7,
32,
8,
198,
220,
220,
220,
220,
220,
220,
220,
317,
796,
2566,
363,
76,
7,
50,
8,
1635,
569,
6,
198,
220,
220,
220,
220,
220,
220,
220,
1583,
796,
2546,
7,
52,
11,
362,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
29677,
262,
11192,
273,
290,
262,
5637,
636,
198,
220,
220,
220,
220,
220,
220,
220,
471,
796,
27179,
1758,
7,
52,
11,
357,
35,
75,
11,
288,
58,
72,
4357,
288,
58,
72,
4357,
1583,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
581,
58,
72,
60,
796,
9943,
7241,
12078,
7,
52,
11,
357,
16,
11,
604,
11,
362,
11,
513,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
317,
796,
27179,
1758,
7,
32,
11,
357,
6187,
11,
5391,
82,
58,
19,
25,
437,
60,
986,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
360,
75,
796,
1583,
198,
220,
220,
220,
886,
198,
220,
220,
220,
581,
58,
45,
60,
796,
9943,
7241,
12078,
7,
32,
11,
357,
16,
11,
604,
11,
362,
11,
513,
4008,
628,
220,
220,
220,
1441,
581,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
26969,
3455,
62,
20424,
62,
3149,
78,
7,
44,
3712,
46912,
90,
51,
5512,
288,
3712,
5317,
8,
810,
309,
1279,
25,
15057,
198,
198,
8890,
489,
1431,
7071,
284,
262,
517,
2276,
2446,
13148,
326,
477,
1957,
15225,
389,
4961,
284,
288,
13,
198,
37811,
198,
8818,
26969,
3455,
62,
20424,
62,
3149,
78,
7,
44,
3712,
46912,
90,
51,
5512,
288,
3712,
5317,
2599,
25,
7378,
46,
90,
51,
92,
810,
1391,
51,
27,
25,
15057,
92,
198,
220,
220,
220,
288,
75,
11,
1553,
796,
2546,
7,
44,
8,
198,
220,
220,
220,
611,
288,
75,
14512,
1553,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
28100,
1713,
12331,
7203,
12001,
15225,
1276,
477,
307,
262,
976,
11,
6492,
257,
17593,
351,
15225,
29568,
260,
1050,
19510,
25404,
11,
7109,
4008,
16725,
4008,
198,
220,
220,
220,
886,
198,
220,
220,
220,
399,
796,
2558,
7,
744,
7,
6404,
7,
67,
11,
288,
75,
22305,
198,
220,
220,
220,
1441,
26969,
3455,
62,
20424,
62,
3149,
78,
7,
44,
11,
288,
1635,
3392,
7,
5317,
2414,
11,
399,
4008,
198,
437
] | 2.277107 | 12,663 |
module FisherySim
using Distributions
using TweedieDistributions
using StatsBase
using LinearAlgebra
using Random
using PDMats
using Arpack
using NeutralLandscapes
import Base:
rand,
+, -, *,
step,
sum,
getindex, setindex!,
size, length, eachindex,
copy
import StatsBase:
sample,
cov
import Distributions:
location
include("fisherydomain.jl")
export
AbstractFisheryDomain,
DiscreteFisheryDomain,
GriddedFisheryDomain,
size,
length,
eachindex,
sample
include("covkernels.jl")
export
AbstractCovarianceKernel,
ExpCov,
Matérn32Cov,
Matern32Cov,
AR1,
cov
# include("matrixlognormal.jl")
# export
# MatrixLogNormal,
# location
include("domaindistributions.jl")
export
AbstractDomainDistribution,
DomainDistribution,
MultiDomainDistribution,
BlendedDomainDistribution,
ClassifiedDomainDistribution,
domain,
getindex,
length
include("habitat.jl")
export
Habitat,
getindex,
length,
HabitatPreference
include("bathymetry.jl")
export
BathymetryModel,
Bathymetry,
rand
include("pop_dynamics.jl")
export
PopulationDynamicsModel,
PopState,
Schaefer,
PellaTomlinson,
StochasticProduction,
vecstate,
step,
sum,
setindex!,
copy
include("movement.jl")
export
MovementModel,
eqdist,
MovementRate
include("targeting.jl")
export
AbstractTargetingBehavior,
RandomTargeting,
FixedTargeting,
AbstractPreferentialTargeting,
PreferentialTargeting,
DynamicPreferentialTargeting,
target,
reset!
include("catchability.jl")
export
AbstractCatchability,
Catchability,
DensityDependentCatchability,
HabitatCatchability,
*
include("vessels.jl")
export
Vessel,
Catch,
CPUE,
+, -,
fish!,
getindex,
Fleet,
vessels
include("simulation.jl")
export
simulate
end # module
| [
21412,
14388,
88,
8890,
198,
198,
3500,
46567,
507,
198,
3500,
24205,
276,
494,
20344,
2455,
507,
198,
3500,
20595,
14881,
198,
3500,
44800,
2348,
29230,
198,
3500,
14534,
198,
3500,
14340,
44,
1381,
198,
3500,
943,
8002,
198,
3500,
25627,
22342,
1416,
7916,
198,
198,
11748,
7308,
25,
198,
220,
220,
220,
43720,
11,
198,
220,
220,
220,
1343,
11,
532,
11,
1635,
11,
198,
220,
220,
220,
2239,
11,
198,
220,
220,
220,
2160,
11,
198,
220,
220,
220,
651,
9630,
11,
900,
9630,
28265,
198,
220,
220,
220,
2546,
11,
4129,
11,
1123,
9630,
11,
198,
220,
220,
220,
4866,
198,
11748,
20595,
14881,
25,
198,
220,
220,
220,
6291,
11,
198,
220,
220,
220,
39849,
198,
11748,
46567,
507,
25,
198,
220,
220,
220,
4067,
198,
198,
17256,
7203,
69,
4828,
88,
27830,
13,
20362,
4943,
198,
39344,
198,
220,
220,
220,
27741,
37,
4828,
88,
43961,
11,
198,
220,
220,
220,
8444,
8374,
37,
4828,
88,
43961,
11,
198,
220,
220,
220,
1902,
1638,
276,
37,
4828,
88,
43961,
11,
198,
220,
220,
220,
2546,
11,
198,
220,
220,
220,
4129,
11,
198,
220,
220,
220,
1123,
9630,
11,
198,
220,
220,
220,
6291,
198,
198,
17256,
7203,
66,
709,
74,
44930,
13,
20362,
4943,
198,
39344,
198,
220,
220,
220,
27741,
34,
709,
2743,
590,
42,
7948,
11,
198,
220,
220,
220,
5518,
34,
709,
11,
198,
220,
220,
220,
6550,
2634,
35906,
2624,
34,
709,
11,
198,
220,
220,
220,
337,
9205,
2624,
34,
709,
11,
198,
220,
220,
220,
5923,
16,
11,
198,
220,
220,
220,
39849,
198,
198,
2,
2291,
7203,
6759,
8609,
75,
2360,
6636,
13,
20362,
4943,
198,
2,
10784,
198,
2,
220,
220,
220,
220,
24936,
11187,
26447,
11,
198,
2,
220,
220,
220,
220,
4067,
198,
198,
17256,
7203,
27830,
17080,
2455,
507,
13,
20362,
4943,
198,
39344,
198,
220,
220,
220,
27741,
43961,
20344,
3890,
11,
198,
220,
220,
220,
20021,
20344,
3890,
11,
198,
220,
220,
220,
15237,
43961,
20344,
3890,
11,
198,
220,
220,
220,
1086,
1631,
43961,
20344,
3890,
11,
198,
220,
220,
220,
5016,
1431,
43961,
20344,
3890,
11,
198,
220,
220,
220,
7386,
11,
198,
220,
220,
220,
651,
9630,
11,
198,
220,
220,
220,
4129,
198,
198,
17256,
7203,
5976,
270,
265,
13,
20362,
4943,
198,
39344,
198,
220,
220,
220,
41950,
265,
11,
198,
220,
220,
220,
651,
9630,
11,
198,
220,
220,
220,
4129,
11,
198,
220,
220,
220,
41950,
265,
6719,
4288,
198,
198,
17256,
7203,
65,
10036,
41935,
13,
20362,
4943,
198,
39344,
198,
220,
220,
220,
347,
10036,
41935,
17633,
11,
198,
220,
220,
220,
347,
10036,
41935,
11,
198,
220,
220,
220,
43720,
198,
198,
17256,
7203,
12924,
62,
67,
4989,
873,
13,
20362,
4943,
198,
39344,
198,
220,
220,
220,
20133,
35,
4989,
873,
17633,
11,
198,
220,
220,
220,
8099,
9012,
11,
198,
220,
220,
220,
35756,
41027,
11,
198,
220,
220,
220,
350,
12627,
13787,
75,
7899,
11,
198,
220,
220,
220,
520,
5374,
3477,
35027,
11,
198,
220,
220,
220,
43030,
5219,
11,
198,
220,
220,
220,
2239,
11,
198,
220,
220,
220,
2160,
11,
198,
220,
220,
220,
900,
9630,
28265,
198,
220,
220,
220,
4866,
198,
198,
17256,
7203,
21084,
434,
13,
20362,
4943,
198,
39344,
198,
220,
220,
220,
15477,
17633,
11,
198,
220,
220,
220,
37430,
17080,
11,
198,
220,
220,
220,
15477,
32184,
198,
198,
17256,
7203,
16793,
278,
13,
20362,
4943,
198,
39344,
198,
220,
220,
220,
27741,
21745,
278,
25267,
15759,
11,
198,
220,
220,
220,
14534,
21745,
278,
11,
198,
220,
220,
220,
10832,
21745,
278,
11,
198,
220,
220,
220,
27741,
36698,
33369,
21745,
278,
11,
198,
220,
220,
220,
42195,
33369,
21745,
278,
11,
198,
220,
220,
220,
26977,
36698,
33369,
21745,
278,
11,
198,
220,
220,
220,
2496,
11,
198,
220,
220,
220,
13259,
0,
198,
198,
17256,
7203,
40198,
1799,
13,
20362,
4943,
198,
39344,
198,
220,
220,
220,
27741,
34,
963,
1799,
11,
198,
220,
220,
220,
25750,
1799,
11,
198,
220,
220,
220,
360,
6377,
35,
8682,
34,
963,
1799,
11,
198,
220,
220,
220,
41950,
265,
34,
963,
1799,
11,
198,
220,
220,
220,
1635,
198,
198,
17256,
7203,
1158,
14002,
13,
20362,
4943,
198,
39344,
198,
220,
220,
220,
44734,
11,
198,
220,
220,
220,
25750,
11,
198,
220,
220,
220,
9135,
36,
11,
198,
220,
220,
220,
1343,
11,
532,
11,
198,
220,
220,
220,
5916,
28265,
198,
220,
220,
220,
651,
9630,
11,
198,
220,
220,
220,
20001,
11,
198,
220,
220,
220,
14891,
198,
198,
17256,
7203,
14323,
1741,
13,
20362,
4943,
198,
39344,
198,
220,
220,
220,
29308,
198,
198,
437,
1303,
8265,
198
] | 2.484694 | 784 |
module CLI # Bukdu
import ..Bukdu: Routing, Naming
"""
CLI.routes()
Showing the routing table.
"""
function routes()
A = Routing.store[:routing_tables]
isempty(A) && return
ncols = 5 # verb url C action pipe
nrows = Int(length(A)/ncols)
rt = reshape(A, ncols, nrows)
paddings = maximum((length ∘ string).(rt), dims=2) .+ 2
function f(idx, el, lastcolumn)
if idx == lastcolumn
el
else
rpad(el, paddings[idx])
end
end
for rowidx in 1:nrows
row = rt[:, rowidx]
lastcolumn = isempty(row[ncols]) ? ncols-1 : ncols
print.([f(idx, el, lastcolumn) for (idx, el) in enumerate(row[1:lastcolumn])])
println()
end
end
end # module Bukdu.CLI
| [
21412,
43749,
1303,
36810,
646,
198,
198,
11748,
11485,
33,
2724,
646,
25,
371,
13660,
11,
399,
3723,
198,
198,
37811,
198,
220,
220,
220,
43749,
13,
81,
448,
274,
3419,
198,
198,
2484,
7855,
262,
28166,
3084,
13,
198,
37811,
198,
8818,
11926,
3419,
198,
220,
220,
220,
317,
796,
371,
13660,
13,
8095,
58,
25,
81,
13660,
62,
83,
2977,
60,
198,
220,
220,
220,
318,
28920,
7,
32,
8,
11405,
1441,
198,
220,
220,
220,
299,
4033,
82,
796,
642,
1303,
15942,
19016,
327,
2223,
12656,
198,
220,
220,
220,
299,
8516,
796,
2558,
7,
13664,
7,
32,
20679,
77,
4033,
82,
8,
198,
220,
220,
220,
374,
83,
796,
27179,
1758,
7,
32,
11,
299,
4033,
82,
11,
299,
8516,
8,
198,
220,
220,
220,
14098,
654,
796,
5415,
19510,
13664,
18872,
246,
4731,
737,
7,
17034,
828,
5391,
82,
28,
17,
8,
764,
10,
362,
198,
220,
220,
220,
2163,
277,
7,
312,
87,
11,
1288,
11,
938,
28665,
8,
198,
220,
220,
220,
220,
220,
220,
220,
611,
4686,
87,
6624,
938,
28665,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1288,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
374,
15636,
7,
417,
11,
14098,
654,
58,
312,
87,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
329,
5752,
312,
87,
287,
352,
25,
77,
8516,
198,
220,
220,
220,
220,
220,
220,
220,
5752,
796,
374,
83,
58,
45299,
5752,
312,
87,
60,
198,
220,
220,
220,
220,
220,
220,
220,
938,
28665,
796,
318,
28920,
7,
808,
58,
77,
4033,
82,
12962,
5633,
299,
4033,
82,
12,
16,
1058,
299,
4033,
82,
198,
220,
220,
220,
220,
220,
220,
220,
3601,
12195,
58,
69,
7,
312,
87,
11,
1288,
11,
938,
28665,
8,
329,
357,
312,
87,
11,
1288,
8,
287,
27056,
378,
7,
808,
58,
16,
25,
12957,
28665,
12962,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
44872,
3419,
198,
220,
220,
220,
886,
198,
437,
198,
198,
437,
1303,
8265,
36810,
646,
13,
5097,
40,
198
] | 2.06267 | 367 |
### A Pluto.jl notebook ###
# v0.18.0
using Markdown
using InteractiveUtils
# This Pluto notebook uses @bind for interactivity. When running this notebook outside of Pluto, the following 'mock version' of @bind gives bound variables a default value (instead of an error).
macro bind(def, element)
quote
local iv = try Base.loaded_modules[Base.PkgId(Base.UUID("6e696c72-6542-2067-7265-42206c756150"), "AbstractPlutoDingetjes")].Bonds.initial_value catch; b -> missing; end
local el = $(esc(element))
global $(esc(def)) = Core.applicable(Base.get, el) ? Base.get(el) : iv(el)
el
end
end
# ╔═╡ 451ae3a0-8068-4747-95a7-d31955808f29
begin
# external packages -
using PlutoUI
using Plots
using PrettyTables
end
# ╔═╡ 8ba6a00a-7a53-4dcc-af4d-cb85aa9b4d68
md"""
### Simple and Complex Models of Enzyme Kinetics
The flux bounds are essential constraints in flux balance analysis calculations and the convex decomposition of the stoichiometric array. Beyond their role in the flux estimation problem, the flux bounds are _integrative_, i.e., these constraints integrate many types of genetic and biochemical information into the flux estimation problem.
Flux bounds constrain the values that each reaction in a metabolic network can take. A general model for these bounds is given by:
$$-\delta_{j}\left[{V_{max,j}^{\circ}}\left(\frac{e}{e^{\circ}}\right)\theta_{j}\left(\dots\right){f_{j}\left(\dots\right)}\right]\leq{v_{j}}\leq{V_{max,j}^{\circ}}\left(\frac{e}{e^{\circ}}\right)\theta_{j}\left(\dots\right){f_{j}\left(\dots\right)}$$
where $V_{max,j}^{\circ}$ denotes the maximum reaction velocity (units: flux) computed at some characteristic enzyme abundance (units: concentration), the ratio $e/e^{\circ}$ is a correction for enzyme abundance (units: dimensioness), $\theta_{j}\left(\dots\right)\in\left[0,1\right]$ is the fraction of maximial enzyme activity (a function or measurement producing units: dimensionless), and $f_{j}\left(\dots\right)$ is a function describing the substrate dependence of the reaction rate $j$ (units: dimensionless). Both $\theta_{j}\left(\dots\right)$ and $f_{j}\left(\dots\right)$ could have associated parameters, e.g., saturation or binding constants, etc. Finally, the quanity $\delta_{j}\in\left\{0,1\right\}$ is a _binary_ variable:
* If reaction $j$ is __reversible__ $\delta_{j}=1$ or,
* If reaction $j$ is __irreversible__ $\delta_{j}=0$
Today, let's focus on approaches for computing the value of these bounds, i.e., the form and value of the terms in the brackets. In this lecture, we will:
1. Develop simple models of enzyme kinetics using the Michaelis–Menten approach
1. Introduce the fundamental concepts underlying more complex models of allosteric regulation (the fast control mechanisms that we mentioned previously)
1. Introduce effective discrete regulation models to capture allosteric regulation
"""
# ╔═╡ 8869f117-1fc6-4cc5-9803-b8ec72a109a6
md"""
### What is allosteric regulation?
Allosteric regulation modulates enzyme activity by binding effector molecules to sites other than the enzyme's active site. These events can activate (enhances rate) and inhibit (decreases rate). Allosteric regulation operates on a fast time scale compared to gene expression (synthesis of the enzyme).
Allosteric mechanisms in Central Carbon Metabolism:
* [Reznik E, Christodoulou D, Goldford JE, Briars E, Sauer U, Segrè D, Noor E. Genome-Scale Architecture of Small Molecule Regulatory Networks and the Fundamental Trade-Off between Regulation and Enzymatic Activity. Cell Rep. 2017 Sep 12;20(11):2666-2677. doi: 10.1016/j.celrep.2017.08.066. PMID: 28903046; PMCID: PMC5600504.](https://pubmed.ncbi.nlm.nih.gov/28903046/)
"""
# ╔═╡ 17724757-604e-4c77-a42b-238ba121e88f
md"""
### Simple: Michaelis–Menten kinetics
Let's assume we have a well-mixed test tube containing an enzyme $E$ (a protein that catalyzes chemical reactions), which converts substrate $S$ (the starting compound)
into product $P$ according to three elementary reactions:
$$\begin{eqnarray}
E+S&\rightleftharpoons&{E:S}\\
{E:S}&\longrightarrow&E+P
\end{eqnarray}$$
The kinetics of each elementary step can be written using mass-action kinetics, i.e.,
$$\begin{eqnarray}
r_{1} & = & k_{1}\left[E\right]\left[S\right]\\
r_{2} & = & k_{2}\left[E:S\right]\\
r_{3} & = & k_{3}\left[E:S\right]
\end{eqnarray}$$
where $\left[\cdot\right]$ denotes a species concentration, and $k_{j}$ denotes the rate constant governing the $jth$ elementary reaction:
* The rate $r_{1}$ describes the _association_ rate between the enzyme and substrate,
* The rate $r_{2}$ represents the rate of _dissociation_ of the enzyme-substrate complex, and
* The $r_{3}$ denotes the rate of _chemical conversion_ of the bound substrate into the product (we assume the dissociation of the product from the enzyme is fast).
The enzyme must obey the relationship:
$$\left[E_{T}\right] = \left[E\right] + \left[E:S\right]$$
where $\left[E_{T}\right]$ denotes the total enzyme concentration in the tube,
$\left[E\right]$ denotes the free enzyme concentration (not bound to substrate) while
$\left[E:S\right]$ denotes the enzyme-substrate complex.
To estimate the _overall_ rate $v$, we stipulate a single rate-limiting step out of the set of elementary reactions. Let's assume that the rate of chemical conversion ($r_{3}$) is the slowest step, i.e., the substrate bounces on/off the enzyme quickly with only a tiny fraction of these binding events resulting in a successful chemical transformation. Thus, the overall rate is then given by:
$$v = k_{3}\left[E:S\right]$$
Let's also assume that we already know (or can estimate) the rate constants $k_{1},k_{2}$ and $k_{3}$. When this is true, the only unknown is $\left[E:S\right]$.
However, we can relate $\left[E:S\right]$ to variables we know ($E_{T}$ and at least initially $S$) through the enzyme balance, and the _pseudo-steady-state assumption_ for the reaction intermediate
$\left[E:S\right]$:
$$\frac{d\left[E:S\right]}{dt} = k_{1}\left[E\right]\left[S\right] - k_{2}\left[E:S\right] - k_{3}\left[E:S\right]\simeq{0}$$
Rearranging and solving for $\left[E:S\right]$ gives the relationship:
$$\left[E:S\right]\simeq\frac{k_{1}}{k_{2}+k_{3}}\left[E\right]\left[S\right]$$
where the ratio of constants is defined as the Michaelis-Menten saturation coefficient or $K_{M}$:
$$\frac{1}{K_{M}}\equiv\frac{k_{1}}{k_{2}+k_{3}}$$
Substituting the definition of $K_{M}$ into the overall rate yields:
$$v = k_{3}\frac{\left[E\right]\left[S\right]}{K_{M}}$$
However, we do not know the free enzyme concentration of $\left[E\right]$; to find $\left[E\right]$
we subsitute $\left[E:S\right]$ into the enzyme balance and solving for $\left[E\right]$:
$$\left[E\right] = \frac{\left[E_T\right]K_{M}}{K_{M}+\left[S\right]}$$
Lastly, we substitute $\left[E\right]$ into the overall rate to arrive at the final expression for $v$:
$$v = V_{max}\frac{\left[S\right]}{K_{M}+\left[S\right]}$$
where $V_{max}\equiv{k_{3}}\left[E_{T}\right]$.
__Limiting cases:__
* when $S\gg{K}_{M}$, the rate becomes close to $V_{max}$.
* when $S\ll{K}_{M}$ the rate appears to be linear with respect to substrate concentration.
* when $K_{M}\simeq S$ the reaction rate equals $v\simeq 1/2V_{max}$.
"""
# ╔═╡ 431ccdf0-93a9-4b3c-9576-8854ba2f1fad
@bind MM_parameters PlutoUI.combine() do Child
md"""
##### Michaelis–Menten Parameters
\[E\] $(
Child(Slider(1:5))
) (μM) and Kₘ $(
Child(Slider(5:100))
) (mM)
"""
end
# ╔═╡ 7efaf27c-8e0a-40f9-ac28-af90357450a3
begin
# get MM parameter values -
E = MM_parameters[1]
Kₘ = MM_parameters[2]
kcat = 13.7 # units: s^-1
number_of_steps = 1000
# substrate range -
S_array = range(0.0,stop=100.0,length=number_of_steps) |> collect;
# initialize space -
v_array = Array{Float64,1}(undef,number_of_steps)
# compute the rate -
for (i,S) ∈ enumerate(S_array)
# compute the rate -
v_array[i] = (kcat*E)*(S/(S+Kₘ))
end
# plot -
plot(S_array,v_array,xlims=(0.0,100.0),ylims=(0.0,14), label="v: E = $(E) μM and Kₘ = $(Kₘ) (mM)")
xlabel!("Substrate S (mM)",fontsize=18)
ylabel!("Rate v (μM/s)",fontsize=18)
end
# ╔═╡ 55ea8324-f36d-40bd-99e3-92e7fcbafca9
md"""
### Complex: MWC and Sequential kinetic models
The Monod-Wyman-Changeux model (MWC model, also known as the symmetry model) describes allosteric transitions of proteins made up of identical subunits. Effector binding modulates the state of the entire protein.
* [MONOD J, WYMAN J, CHANGEUX JP. ON THE NATURE OF ALLOSTERIC TRANSITIONS: A PLAUSIBLE MODEL. J Mol Biol. 1965 May;12:88-118. doi: 10.1016/s0022-2836(65)80285-6. PMID: 14343300.](https://pubmed.ncbi.nlm.nih.gov/14343300/)
The sequential model (KNF model) of allosteric regulation posits that enzyme subunits are independent.
Thus, binding substrate (or effector) to a subunit results in only slight conformational changes to adjacent subunits. KNF model can do describe both positive and negative cooperativity:
* [Koshland D Jr, Némethy G, Filmer D. Comparison of experimental binding data and theoretical models in proteins containing subunits. Biochemistry. 1966 Jan;5(1):365-85. doi: 10.1021/bi00865a047. PMID: 5938952.](https://pubmed.ncbi.nlm.nih.gov/5938952/)
"""
# ╔═╡ 3502da52-7d2b-4c79-82ce-7424d756cd9b
md"""
### Effective discrete state kinetic models
Michaelis–Menten kinetics are easy to understand, but they neglect many factors, e.g., the influence of allosteric regulators. On the other hand, MWC/sequential models are detailed but case-specific (and too complex). It would be great if we could correct Michaelis–Menten kinetics to capture the influence of allosteric factors.
Suppose we model the rate $v_{j}$ as the product of a kinetic limit (a simple model of the rate) and a correction term that accounts for the missing regulation:
$$v_{j} = r_{j}\theta\left(...\right)_{j}$$
where $v_{j}$ denotes the overall rate (units: $\mu$M/time), $r_{j}$ denotes the kinetic limit i.e., the maximum rate of conversion (units: $\mu$M/time) and
$0\leq \theta\left(...\right)_{j}\leq 1$ (units: dimensionless) is a control function that describes the influence of effector molecules.
"""
# ╔═╡ c392c8a9-361d-47e4-933e-2e51b793e069
md"""
##### Discrete state control function model
There is a wide variety of different possible ways we can build the $\theta\left(...\right)_{j}$ control functions. Ultimately, it doesn't matter what we choose, as long as it gives a good performance. However, let's introduce an idea that we will revisit later, namely a discrete probabilistic approach.
###### Theory
Suppose an enzyme $E$ can exits in one of $s=1,2\dots,\mathcal{S}$ possible microstates, where each microstate $s$ has some pseudo energy $\epsilon_{s}$. Some microstates will lead to activity (the ability to carry out the chemical reactions, while others will not). For each microstate $s$, let's assign a pseudo energy $\epsilon_{s}$, where by definition $\epsilon_{1}=0$; we assume the base state has the lowest energy. Next, suppose the probability that enzyme $E$ is in microstate $s$ follows a [Boltzmann distribution](https://en.wikipedia.org/wiki/Boltzmann_distribution) which says:
$$p_{i} = \frac{1}{Z} \times f_{i}\exp\left(-\beta\epsilon_{i}\right)\qquad{i=1,2,\dots,\mathcal{S}}$$
where $p_{i}$ denotes the probability that enzyme $E$ is in microstate $i=1,2,\dots,\mathcal{S}$, $f_{i}$ denotes a state-specific factor $f_{i}\in\left[0,1\right]$, $\beta$ denotes the [thermodynamic beta](https://en.wikipedia.org/wiki/Thermodynamic_beta) and $Z$ denotes a normalization factor (called the [Partiton function](https://en.wikipedia.org/wiki/Partition_function_(statistical_mechanics)) in the statistical physics community). We can find $Z$ using the summation law of discrete probolity e.g., $\sum_{s}p_{s} = 1$ which gives:
$$Z = \sum_{s=1}^{\mathcal{S}}f_{i}\exp\left(-\beta\epsilon_{i}\right)$$
which gives:
$$p_{i} = \frac{f_{i}\exp\left(-\beta\epsilon_{i}\right)}{\displaystyle \sum_{s=1}^{\mathcal{S}}f_{i}\exp\left(-\beta\epsilon_{i}\right)}\qquad{i=1,2,\dots,\mathcal{S}}$$.
Finally, we relate the probability that enzyme $E$ is in microstate $s$ back to the $\theta$ control function by computing the overall probability that the desired event happens, e.g., enzyme $E$ catalyzes the reaction of interests. We know if $\Omega = \left\{1,2,\dots,\mathcal{S}\right\}$, then we can define the subset $\mathcal{A}\subseteq\Omega$ in which the desired event happens. Given $\mathcal{A}$, the $\theta$ function becomes:
$$\theta=\sum_{s\in{\mathcal{A}}}p_{s}$$
###### Conceptual exampleTo illustrate this idea, consider an enzyme inhibited by a downstream product (this is a common allosteric motif known as [feedback inhibition](Pedreño S, Pisco JP, Larrouy-Maumus G, Kelly G, de Carvalho LP. Mechanism of feedback allosteric inhibition of ATP phosphoribosyltransferase. Biochemistry. 2012;51(40):8027-8038. doi:10.1021/bi300808b)). In this case, suppose enzyme $E$, which is inhibited by compound $I$, can exist in one of three possible microstates:
* __State s = 1__: No substrate $S$ is bound, $E$ is floating around in solution minding its own business (base state, no reaction)
* __State s = 2__: Substrate $S$ is bound to enzyme $E$, but inhibitor $I$ is not bound (reaction possible)
* __State s = 3__: Both the substrate $S$ and inhibitor $I$ are bound to enzyme $E$ (no reaction possible)
Given these microstates (and their functional assignment) we know that enzyme $E$ can only catalyze its reaction in microstate $s=2$, thus:
$$\theta = \frac{f_{2}\exp\left(-\beta\epsilon_{i}\right)}{\displaystyle \sum_{s=1}^{\mathcal{3}}f_{s}\exp\left(-\beta\epsilon_{s}\right)}$$
###### What are the state-specific factors?
The state-specific factors $f_{i}\in\left[0,1\right]$ control the reachability of a microstate:
* if $f_{\star} = 0$, then microstate $\star$ can __never__ be obtained
* if $f_{\star} = 1$, then microstate $\star$ can __always__ be obtained
As a modeler, you can choose the form (or value) that $f_{\star}$ takes. These factors can
be set to a specific value by definition (depending upon the state) or can be used to describe events associated with state $i$, e.g., such as binding events. For example, suppose state $i$ involved binding an effector molecule $x$ to the enzyme $E$. In this case, we could model the state-specific factor $f_{i}$ as:
$$f_{i} = (x/K_{i})^{n_{i}}/(1+(x/K_{i})^{n_{i}})$$
where $x\geq{0}$ denotes effector abundance, $K_{i}\geq{0}$ denotes a binding constant and $n_{i}\geq{0}$ denotes a binding order parameter.
"""
# ╔═╡ 91345d04-f502-4e90-935e-a4dc250244db
@bind DSM_parameters PlutoUI.combine() do Child
md"""
\[I\] $(
Child(Slider(0:100))
) (μM) K $(
Child(Slider(1:1:100))
) (mM) ϵ₂ $(
Child(Slider(0.001:0.1:100))
) (J/mol) ϵ₃ $(
Child(Slider(0.001:0.1:100))
) (J/mol)
"""
end
# ╔═╡ 719784fe-3ef6-4e53-ad52-82140e3d0b5e
begin
# get I -
Iₒ = DSM_parameters[1]
Kd = DSM_parameters[2]
ϵ₂ = (DSM_parameters[3])/100
ϵ₃ = (DSM_parameters[4])/100
# setup system -
R = 8.314 # units: J/mol-K
T = 273.15 + 25.0 # units: K
β = 1/R*T
# setup binding parameters for state 3 -
n = 2.0
# setup energy array -
ϵ_array = [
0.0 ; # state 1 (just E)
-ϵ₂ ; # state 2 (E bound to S, but no I)
-ϵ₃ ; # state 3 (E bound to I)
];
# compute W -
W_array = exp.(-β*ϵ_array)
# let's compute the state-specific factor array -
f_array = [
1.0 ; # state 1
1.0 ; # state 2
((Iₒ/Kd)^(n))/(1+(Iₒ/Kd)^(n))
];
# compute the θ variable -
microstate_array = f_array.*W_array;
Z = sum(microstate_array)
p_array = (1/Z)*microstate_array
θ = p_array[2]
# show -
with_terminal() do
println("θ = $(θ)")
end
end
# ╔═╡ 1d4d6059-5b79-43cd-ac17-ef2aa057ecad
with_terminal() do
# initialize -
𝒮 = 3
state_table = Array{Any,2}(undef,𝒮,4)
# populate the state array -
for s ∈ 1:𝒮
state_table[s,1] = s
state_table[s,2] = f_array[s]
state_table[s,3] = W_array[s]
state_table[s,4] = p_array[s]
end
# header -
header_row = (["s","fₛ","Wₛ","pₛ"])
pretty_table(state_table;header=header_row)
end
# ╔═╡ d46ced14-a5d3-45a9-9d43-38dc7879b0c7
let
# get MM parameter values -
E = 1.0 # units: μM
Kₘ = 5 # units: mM
kcat = 13.7 # units: s^-1
number_of_steps = 1000
# substrate range -
S_array = range(0.0,stop=100.0,length=number_of_steps) |> collect;
# initialize space -
v_array = Array{Float64,1}(undef,number_of_steps)
# compute the rate -
for (i,S) ∈ enumerate(S_array)
# compute the rate -
v_array[i] = (kcat*E)*(S/(S+Kₘ))*θ
end
# plot -
plot(S_array,v_array,xlims=(0.0,100.0),ylims=(0.0,14), label="v: I = $(Iₒ) mM and Kd = $(Kd) (mM)")
xlabel!("Substrate S (mM)",fontsize=18)
ylabel!("Rate v (μM/s)",fontsize=18)
end
# ╔═╡ d3568c5d-16bf-4698-9891-0be65d62b36c
md"""
### Summary and Conclusions
In this lecture we:
1. Developed simple models of enzyme kinetics using the Michaelis–Menten approach
1. Introduced the fundamental concepts underlying more complex models of allosteric regulation (the fast control mechanisms that we mentioned previously)
1. Introduced effective discrete regulation models to simulate allosteric regulation
"""
# ╔═╡ 55d4ab48-9589-4fd9-ac06-3338fdb418c4
md"""
### Next Time
* What about multiple substrates?
* Does the discrete state model work?
* How do we implement these bounds models in a flux balance analysis calculation?
"""
# ╔═╡ 54370424-3add-4f93-91b0-e136166842ae
TableOfContents(title="📚 Lecture Outline", indent=true, depth=5, aside=true)
# ╔═╡ 06a90381-b4cb-4d32-af0d-2f084364129c
html"""
<script>
// initialize -
var section = 0;
var subsection = 0;
var subsubsection = 0;
var headers = document.querySelectorAll('h3, h5, h6');
// main loop -
for (var i=0; i < headers.length; i++) {
var header = headers[i];
var text = header.innerText;
var original = header.getAttribute("text-original");
if (original === null) {
// Save original header text
header.setAttribute("text-original", text);
} else {
// Replace with original text before adding section number
text = header.getAttribute("text-original");
}
var numbering = "";
switch (header.tagName) {
case 'H3':
section += 1;
numbering = section + ".";
subsection = 0;
break;
case 'H5':
subsection += 1;
numbering = section + "." + subsection;
break;
case 'H6':
subsubsection += 1;
numbering = section + "." + subsection + "." + subsubsection;
break;
}
// update the header text
header.innerText = numbering + " " + text;
};
</script>"""
# ╔═╡ b6890de0-8923-11ec-3552-3113bdd53f86
html"""
<style>
main {
max-width: 860px;
width: 70%;
margin: auto;
font-family: "Roboto, monospace";
}
a {
color: blue;
text-decoration: none;
}
</style>"""
# ╔═╡ 00000000-0000-0000-0000-000000000001
PLUTO_PROJECT_TOML_CONTENTS = """
[deps]
Plots = "91a5bcdd-55d7-5caf-9e0b-520d859cae80"
PlutoUI = "7f904dfe-b85e-4ff6-b463-dae2292396a8"
PrettyTables = "08abe8d2-0d0c-5749-adfa-8a2ac140af0d"
[compat]
Plots = "~1.25.8"
PlutoUI = "~0.7.34"
PrettyTables = "~1.3.1"
"""
# ╔═╡ 00000000-0000-0000-0000-000000000002
PLUTO_MANIFEST_TOML_CONTENTS = """
# This file is machine-generated - editing it directly is not advised
julia_version = "1.7.2"
manifest_format = "2.0"
[[deps.AbstractPlutoDingetjes]]
deps = ["Pkg"]
git-tree-sha1 = "8eaf9f1b4921132a4cff3f36a1d9ba923b14a481"
uuid = "6e696c72-6542-2067-7265-42206c756150"
version = "1.1.4"
[[deps.Adapt]]
deps = ["LinearAlgebra"]
git-tree-sha1 = "af92965fb30777147966f58acb05da51c5616b5f"
uuid = "79e6a3ab-5dfb-504d-930d-738a2a938a0e"
version = "3.3.3"
[[deps.ArgTools]]
uuid = "0dad84c5-d112-42e6-8d28-ef12dabb789f"
[[deps.Artifacts]]
uuid = "56f22d72-fd6d-98f1-02f0-08ddc0907c33"
[[deps.Base64]]
uuid = "2a0f44e3-6c83-55bd-87e4-b1978d98bd5f"
[[deps.Bzip2_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "19a35467a82e236ff51bc17a3a44b69ef35185a2"
uuid = "6e34b625-4abd-537c-b88f-471c36dfa7a0"
version = "1.0.8+0"
[[deps.Cairo]]
deps = ["Cairo_jll", "Colors", "Glib_jll", "Graphics", "Libdl", "Pango_jll"]
git-tree-sha1 = "d0b3f8b4ad16cb0a2988c6788646a5e6a17b6b1b"
uuid = "159f3aea-2a34-519c-b102-8c37f9878175"
version = "1.0.5"
[[deps.Cairo_jll]]
deps = ["Artifacts", "Bzip2_jll", "Fontconfig_jll", "FreeType2_jll", "Glib_jll", "JLLWrappers", "LZO_jll", "Libdl", "Pixman_jll", "Pkg", "Xorg_libXext_jll", "Xorg_libXrender_jll", "Zlib_jll", "libpng_jll"]
git-tree-sha1 = "4b859a208b2397a7a623a03449e4636bdb17bcf2"
uuid = "83423d85-b0ee-5818-9007-b63ccbeb887a"
version = "1.16.1+1"
[[deps.ChainRulesCore]]
deps = ["Compat", "LinearAlgebra", "SparseArrays"]
git-tree-sha1 = "f9982ef575e19b0e5c7a98c6e75ee496c0f73a93"
uuid = "d360d2e6-b24c-11e9-a2a3-2a2ae2dbcce4"
version = "1.12.0"
[[deps.ChangesOfVariables]]
deps = ["ChainRulesCore", "LinearAlgebra", "Test"]
git-tree-sha1 = "bf98fa45a0a4cee295de98d4c1462be26345b9a1"
uuid = "9e997f8a-9a97-42d5-a9f1-ce6bfc15e2c0"
version = "0.1.2"
[[deps.ColorSchemes]]
deps = ["ColorTypes", "Colors", "FixedPointNumbers", "Luxor", "Random"]
git-tree-sha1 = "5b7d2a8b53c68dfdbce545e957a3b5cc4da80b01"
uuid = "35d6a980-a343-548e-a6ea-1d62b119f2f4"
version = "3.17.0"
[[deps.ColorTypes]]
deps = ["FixedPointNumbers", "Random"]
git-tree-sha1 = "024fe24d83e4a5bf5fc80501a314ce0d1aa35597"
uuid = "3da002f7-5984-5a60-b8a6-cbb66c0b333f"
version = "0.11.0"
[[deps.Colors]]
deps = ["ColorTypes", "FixedPointNumbers", "Reexport"]
git-tree-sha1 = "417b0ed7b8b838aa6ca0a87aadf1bb9eb111ce40"
uuid = "5ae59095-9a9b-59fe-a467-6f913c188581"
version = "0.12.8"
[[deps.Compat]]
deps = ["Base64", "Dates", "DelimitedFiles", "Distributed", "InteractiveUtils", "LibGit2", "Libdl", "LinearAlgebra", "Markdown", "Mmap", "Pkg", "Printf", "REPL", "Random", "SHA", "Serialization", "SharedArrays", "Sockets", "SparseArrays", "Statistics", "Test", "UUIDs", "Unicode"]
git-tree-sha1 = "44c37b4636bc54afac5c574d2d02b625349d6582"
uuid = "34da2185-b29b-5c13-b0c7-acf172513d20"
version = "3.41.0"
[[deps.CompilerSupportLibraries_jll]]
deps = ["Artifacts", "Libdl"]
uuid = "e66e0078-7015-5450-92f7-15fbd957f2ae"
[[deps.Contour]]
deps = ["StaticArrays"]
git-tree-sha1 = "9f02045d934dc030edad45944ea80dbd1f0ebea7"
uuid = "d38c429a-6771-53c6-b99e-75d170b6e991"
version = "0.5.7"
[[deps.Crayons]]
git-tree-sha1 = "249fe38abf76d48563e2f4556bebd215aa317e15"
uuid = "a8cc5b0e-0ffa-5ad4-8c14-923d3ee1735f"
version = "4.1.1"
[[deps.DataAPI]]
git-tree-sha1 = "cc70b17275652eb47bc9e5f81635981f13cea5c8"
uuid = "9a962f9c-6df0-11e9-0e5d-c546b8b5ee8a"
version = "1.9.0"
[[deps.DataStructures]]
deps = ["Compat", "InteractiveUtils", "OrderedCollections"]
git-tree-sha1 = "3daef5523dd2e769dad2365274f760ff5f282c7d"
uuid = "864edb3b-99cc-5e75-8d2d-829cb0a9cfe8"
version = "0.18.11"
[[deps.DataValueInterfaces]]
git-tree-sha1 = "bfc1187b79289637fa0ef6d4436ebdfe6905cbd6"
uuid = "e2d170a0-9d28-54be-80f0-106bbe20a464"
version = "1.0.0"
[[deps.Dates]]
deps = ["Printf"]
uuid = "ade2ca70-3891-5945-98fb-dc099432e06a"
[[deps.DelimitedFiles]]
deps = ["Mmap"]
uuid = "8bb1440f-4735-579b-a4ab-409b98df4dab"
[[deps.Distributed]]
deps = ["Random", "Serialization", "Sockets"]
uuid = "8ba89e20-285c-5b6f-9357-94700520ee1b"
[[deps.DocStringExtensions]]
deps = ["LibGit2"]
git-tree-sha1 = "b19534d1895d702889b219c382a6e18010797f0b"
uuid = "ffbed154-4ef7-542d-bbb7-c09d3a79fcae"
version = "0.8.6"
[[deps.Downloads]]
deps = ["ArgTools", "LibCURL", "NetworkOptions"]
uuid = "f43a241f-c20a-4ad4-852c-f6b1247861c6"
[[deps.EarCut_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "3f3a2501fa7236e9b911e0f7a588c657e822bb6d"
uuid = "5ae413db-bbd1-5e63-b57d-d24a61df00f5"
version = "2.2.3+0"
[[deps.Expat_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "ae13fcbc7ab8f16b0856729b050ef0c446aa3492"
uuid = "2e619515-83b5-522b-bb60-26c02a35a201"
version = "2.4.4+0"
[[deps.FFMPEG]]
deps = ["FFMPEG_jll"]
git-tree-sha1 = "b57e3acbe22f8484b4b5ff66a7499717fe1a9cc8"
uuid = "c87230d0-a227-11e9-1b43-d7ebe4e7570a"
version = "0.4.1"
[[deps.FFMPEG_jll]]
deps = ["Artifacts", "Bzip2_jll", "FreeType2_jll", "FriBidi_jll", "JLLWrappers", "LAME_jll", "Libdl", "Ogg_jll", "OpenSSL_jll", "Opus_jll", "Pkg", "Zlib_jll", "libass_jll", "libfdk_aac_jll", "libvorbis_jll", "x264_jll", "x265_jll"]
git-tree-sha1 = "d8a578692e3077ac998b50c0217dfd67f21d1e5f"
uuid = "b22a6f82-2f65-5046-a5b2-351ab43fb4e5"
version = "4.4.0+0"
[[deps.FileIO]]
deps = ["Pkg", "Requires", "UUIDs"]
git-tree-sha1 = "80ced645013a5dbdc52cf70329399c35ce007fae"
uuid = "5789e2e9-d7fb-5bc7-8068-2c6fae9b9549"
version = "1.13.0"
[[deps.FixedPointNumbers]]
deps = ["Statistics"]
git-tree-sha1 = "335bfdceacc84c5cdf16aadc768aa5ddfc5383cc"
uuid = "53c48c17-4a7d-5ca2-90c5-79b7896eea93"
version = "0.8.4"
[[deps.Fontconfig_jll]]
deps = ["Artifacts", "Bzip2_jll", "Expat_jll", "FreeType2_jll", "JLLWrappers", "Libdl", "Libuuid_jll", "Pkg", "Zlib_jll"]
git-tree-sha1 = "21efd19106a55620a188615da6d3d06cd7f6ee03"
uuid = "a3f928ae-7b40-5064-980b-68af3947d34b"
version = "2.13.93+0"
[[deps.Formatting]]
deps = ["Printf"]
git-tree-sha1 = "8339d61043228fdd3eb658d86c926cb282ae72a8"
uuid = "59287772-0a20-5a39-b81b-1366585eb4c0"
version = "0.4.2"
[[deps.FreeType2_jll]]
deps = ["Artifacts", "Bzip2_jll", "JLLWrappers", "Libdl", "Pkg", "Zlib_jll"]
git-tree-sha1 = "87eb71354d8ec1a96d4a7636bd57a7347dde3ef9"
uuid = "d7e528f0-a631-5988-bf34-fe36492bcfd7"
version = "2.10.4+0"
[[deps.FriBidi_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "aa31987c2ba8704e23c6c8ba8a4f769d5d7e4f91"
uuid = "559328eb-81f9-559d-9380-de523a88c83c"
version = "1.0.10+0"
[[deps.GLFW_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Libglvnd_jll", "Pkg", "Xorg_libXcursor_jll", "Xorg_libXi_jll", "Xorg_libXinerama_jll", "Xorg_libXrandr_jll"]
git-tree-sha1 = "51d2dfe8e590fbd74e7a842cf6d13d8a2f45dc01"
uuid = "0656b61e-2033-5cc2-a64a-77c0f6c09b89"
version = "3.3.6+0"
[[deps.GR]]
deps = ["Base64", "DelimitedFiles", "GR_jll", "HTTP", "JSON", "Libdl", "LinearAlgebra", "Pkg", "Printf", "Random", "RelocatableFolders", "Serialization", "Sockets", "Test", "UUIDs"]
git-tree-sha1 = "4a740db447aae0fbeb3ee730de1afbb14ac798a1"
uuid = "28b8d3ca-fb5f-59d9-8090-bfdbd6d07a71"
version = "0.63.1"
[[deps.GR_jll]]
deps = ["Artifacts", "Bzip2_jll", "Cairo_jll", "FFMPEG_jll", "Fontconfig_jll", "GLFW_jll", "JLLWrappers", "JpegTurbo_jll", "Libdl", "Libtiff_jll", "Pixman_jll", "Pkg", "Qt5Base_jll", "Zlib_jll", "libpng_jll"]
git-tree-sha1 = "aa22e1ee9e722f1da183eb33370df4c1aeb6c2cd"
uuid = "d2c73de3-f751-5644-a686-071e5b155ba9"
version = "0.63.1+0"
[[deps.GeometryBasics]]
deps = ["EarCut_jll", "IterTools", "LinearAlgebra", "StaticArrays", "StructArrays", "Tables"]
git-tree-sha1 = "58bcdf5ebc057b085e58d95c138725628dd7453c"
uuid = "5c1252a2-5f33-56bf-86c9-59e7332b4326"
version = "0.4.1"
[[deps.Gettext_jll]]
deps = ["Artifacts", "CompilerSupportLibraries_jll", "JLLWrappers", "Libdl", "Libiconv_jll", "Pkg", "XML2_jll"]
git-tree-sha1 = "9b02998aba7bf074d14de89f9d37ca24a1a0b046"
uuid = "78b55507-aeef-58d4-861c-77aaff3498b1"
version = "0.21.0+0"
[[deps.Glib_jll]]
deps = ["Artifacts", "Gettext_jll", "JLLWrappers", "Libdl", "Libffi_jll", "Libiconv_jll", "Libmount_jll", "PCRE_jll", "Pkg", "Zlib_jll"]
git-tree-sha1 = "a32d672ac2c967f3deb8a81d828afc739c838a06"
uuid = "7746bdde-850d-59dc-9ae8-88ece973131d"
version = "2.68.3+2"
[[deps.Graphics]]
deps = ["Colors", "LinearAlgebra", "NaNMath"]
git-tree-sha1 = "1c5a84319923bea76fa145d49e93aa4394c73fc2"
uuid = "a2bd30eb-e257-5431-a919-1863eab51364"
version = "1.1.1"
[[deps.Graphite2_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "344bf40dcab1073aca04aa0df4fb092f920e4011"
uuid = "3b182d85-2403-5c21-9c21-1e1f0cc25472"
version = "1.3.14+0"
[[deps.Grisu]]
git-tree-sha1 = "53bb909d1151e57e2484c3d1b53e19552b887fb2"
uuid = "42e2da0e-8278-4e71-bc24-59509adca0fe"
version = "1.0.2"
[[deps.HTTP]]
deps = ["Base64", "Dates", "IniFile", "Logging", "MbedTLS", "NetworkOptions", "Sockets", "URIs"]
git-tree-sha1 = "0fa77022fe4b511826b39c894c90daf5fce3334a"
uuid = "cd3eb016-35fb-5094-929b-558a96fad6f3"
version = "0.9.17"
[[deps.HarfBuzz_jll]]
deps = ["Artifacts", "Cairo_jll", "Fontconfig_jll", "FreeType2_jll", "Glib_jll", "Graphite2_jll", "JLLWrappers", "Libdl", "Libffi_jll", "Pkg"]
git-tree-sha1 = "129acf094d168394e80ee1dc4bc06ec835e510a3"
uuid = "2e76f6c2-a576-52d4-95c1-20adfe4de566"
version = "2.8.1+1"
[[deps.Hyperscript]]
deps = ["Test"]
git-tree-sha1 = "8d511d5b81240fc8e6802386302675bdf47737b9"
uuid = "47d2ed2b-36de-50cf-bf87-49c2cf4b8b91"
version = "0.0.4"
[[deps.HypertextLiteral]]
git-tree-sha1 = "2b078b5a615c6c0396c77810d92ee8c6f470d238"
uuid = "ac1192a8-f4b3-4bfe-ba22-af5b92cd3ab2"
version = "0.9.3"
[[deps.IOCapture]]
deps = ["Logging", "Random"]
git-tree-sha1 = "f7be53659ab06ddc986428d3a9dcc95f6fa6705a"
uuid = "b5f81e59-6552-4d32-b1f0-c071b021bf89"
version = "0.2.2"
[[deps.IniFile]]
deps = ["Test"]
git-tree-sha1 = "098e4d2c533924c921f9f9847274f2ad89e018b8"
uuid = "83e8ac13-25f8-5344-8a64-a9f2b223428f"
version = "0.5.0"
[[deps.InteractiveUtils]]
deps = ["Markdown"]
uuid = "b77e0a4c-d291-57a0-90e8-8db25a27a240"
[[deps.InverseFunctions]]
deps = ["Test"]
git-tree-sha1 = "a7254c0acd8e62f1ac75ad24d5db43f5f19f3c65"
uuid = "3587e190-3f89-42d0-90ee-14403ec27112"
version = "0.1.2"
[[deps.IrrationalConstants]]
git-tree-sha1 = "7fd44fd4ff43fc60815f8e764c0f352b83c49151"
uuid = "92d709cd-6900-40b7-9082-c6be49f344b6"
version = "0.1.1"
[[deps.IterTools]]
git-tree-sha1 = "fa6287a4469f5e048d763df38279ee729fbd44e5"
uuid = "c8e1da08-722c-5040-9ed9-7db0dc04731e"
version = "1.4.0"
[[deps.IteratorInterfaceExtensions]]
git-tree-sha1 = "a3f24677c21f5bbe9d2a714f95dcd58337fb2856"
uuid = "82899510-4779-5014-852e-03e436cf321d"
version = "1.0.0"
[[deps.JLLWrappers]]
deps = ["Preferences"]
git-tree-sha1 = "abc9885a7ca2052a736a600f7fa66209f96506e1"
uuid = "692b3bcd-3c85-4b1f-b108-f13ce0eb3210"
version = "1.4.1"
[[deps.JSON]]
deps = ["Dates", "Mmap", "Parsers", "Unicode"]
git-tree-sha1 = "8076680b162ada2a031f707ac7b4953e30667a37"
uuid = "682c06a0-de6a-54ab-a142-c8b1cf79cde6"
version = "0.21.2"
[[deps.JpegTurbo_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "b53380851c6e6664204efb2e62cd24fa5c47e4ba"
uuid = "aacddb02-875f-59d6-b918-886e6ef4fbf8"
version = "2.1.2+0"
[[deps.Juno]]
deps = ["Base64", "Logging", "Media", "Profile"]
git-tree-sha1 = "07cb43290a840908a771552911a6274bc6c072c7"
uuid = "e5e0dc1b-0480-54bc-9374-aad01c23163d"
version = "0.8.4"
[[deps.LAME_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "f6250b16881adf048549549fba48b1161acdac8c"
uuid = "c1c5ebd0-6772-5130-a774-d5fcae4a789d"
version = "3.100.1+0"
[[deps.LZO_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "e5b909bcf985c5e2605737d2ce278ed791b89be6"
uuid = "dd4b983a-f0e5-5f8d-a1b7-129d4a5fb1ac"
version = "2.10.1+0"
[[deps.LaTeXStrings]]
git-tree-sha1 = "f2355693d6778a178ade15952b7ac47a4ff97996"
uuid = "b964fa9f-0449-5b57-a5c2-d3ea65f4040f"
version = "1.3.0"
[[deps.Latexify]]
deps = ["Formatting", "InteractiveUtils", "LaTeXStrings", "MacroTools", "Markdown", "Printf", "Requires"]
git-tree-sha1 = "a8f4f279b6fa3c3c4f1adadd78a621b13a506bce"
uuid = "23fbe1c1-3f47-55db-b15f-69d7ec21a316"
version = "0.15.9"
[[deps.LibCURL]]
deps = ["LibCURL_jll", "MozillaCACerts_jll"]
uuid = "b27032c2-a3e7-50c8-80cd-2d36dbcbfd21"
[[deps.LibCURL_jll]]
deps = ["Artifacts", "LibSSH2_jll", "Libdl", "MbedTLS_jll", "Zlib_jll", "nghttp2_jll"]
uuid = "deac9b47-8bc7-5906-a0fe-35ac56dc84c0"
[[deps.LibGit2]]
deps = ["Base64", "NetworkOptions", "Printf", "SHA"]
uuid = "76f85450-5226-5b5a-8eaa-529ad045b433"
[[deps.LibSSH2_jll]]
deps = ["Artifacts", "Libdl", "MbedTLS_jll"]
uuid = "29816b5a-b9ab-546f-933c-edad1886dfa8"
[[deps.Libdl]]
uuid = "8f399da3-3557-5675-b5ff-fb832c97cbdb"
[[deps.Libffi_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "0b4a5d71f3e5200a7dff793393e09dfc2d874290"
uuid = "e9f186c6-92d2-5b65-8a66-fee21dc1b490"
version = "3.2.2+1"
[[deps.Libgcrypt_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Libgpg_error_jll", "Pkg"]
git-tree-sha1 = "64613c82a59c120435c067c2b809fc61cf5166ae"
uuid = "d4300ac3-e22c-5743-9152-c294e39db1e4"
version = "1.8.7+0"
[[deps.Libglvnd_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libX11_jll", "Xorg_libXext_jll"]
git-tree-sha1 = "7739f837d6447403596a75d19ed01fd08d6f56bf"
uuid = "7e76a0d4-f3c7-5321-8279-8d96eeed0f29"
version = "1.3.0+3"
[[deps.Libgpg_error_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "c333716e46366857753e273ce6a69ee0945a6db9"
uuid = "7add5ba3-2f88-524e-9cd5-f83b8a55f7b8"
version = "1.42.0+0"
[[deps.Libiconv_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "42b62845d70a619f063a7da093d995ec8e15e778"
uuid = "94ce4f54-9a6c-5748-9c1c-f9c7231a4531"
version = "1.16.1+1"
[[deps.Libmount_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "9c30530bf0effd46e15e0fdcf2b8636e78cbbd73"
uuid = "4b2f31a3-9ecc-558c-b454-b3730dcb73e9"
version = "2.35.0+0"
[[deps.Librsvg_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pango_jll", "Pkg", "gdk_pixbuf_jll"]
git-tree-sha1 = "25d5e6b4eb3558613ace1c67d6a871420bfca527"
uuid = "925c91fb-5dd6-59dd-8e8c-345e74382d89"
version = "2.52.4+0"
[[deps.Libtiff_jll]]
deps = ["Artifacts", "JLLWrappers", "JpegTurbo_jll", "Libdl", "Pkg", "Zlib_jll", "Zstd_jll"]
git-tree-sha1 = "340e257aada13f95f98ee352d316c3bed37c8ab9"
uuid = "89763e89-9b03-5906-acba-b20f662cd828"
version = "4.3.0+0"
[[deps.Libuuid_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "7f3efec06033682db852f8b3bc3c1d2b0a0ab066"
uuid = "38a345b3-de98-5d2b-a5d3-14cd9215e700"
version = "2.36.0+0"
[[deps.LinearAlgebra]]
deps = ["Libdl", "libblastrampoline_jll"]
uuid = "37e2e46d-f89d-539d-b4ee-838fcccc9c8e"
[[deps.LogExpFunctions]]
deps = ["ChainRulesCore", "ChangesOfVariables", "DocStringExtensions", "InverseFunctions", "IrrationalConstants", "LinearAlgebra"]
git-tree-sha1 = "e5718a00af0ab9756305a0392832c8952c7426c1"
uuid = "2ab3a3ac-af41-5b50-aa03-7779005ae688"
version = "0.3.6"
[[deps.Logging]]
uuid = "56ddb016-857b-54e1-b83d-db4d58db5568"
[[deps.Luxor]]
deps = ["Base64", "Cairo", "Colors", "Dates", "FFMPEG", "FileIO", "Juno", "LaTeXStrings", "Random", "Requires", "Rsvg"]
git-tree-sha1 = "81a4fd2c618ba952feec85e4236f36c7a5660393"
uuid = "ae8d54c2-7ccd-5906-9d76-62fc9837b5bc"
version = "3.0.0"
[[deps.MacroTools]]
deps = ["Markdown", "Random"]
git-tree-sha1 = "3d3e902b31198a27340d0bf00d6ac452866021cf"
uuid = "1914dd2f-81c6-5fcd-8719-6d5c9610ff09"
version = "0.5.9"
[[deps.Markdown]]
deps = ["Base64"]
uuid = "d6f4376e-aef5-505a-96c1-9c027394607a"
[[deps.MbedTLS]]
deps = ["Dates", "MbedTLS_jll", "Random", "Sockets"]
git-tree-sha1 = "1c38e51c3d08ef2278062ebceade0e46cefc96fe"
uuid = "739be429-bea8-5141-9913-cc70e7f3736d"
version = "1.0.3"
[[deps.MbedTLS_jll]]
deps = ["Artifacts", "Libdl"]
uuid = "c8ffd9c3-330d-5841-b78e-0817d7145fa1"
[[deps.Measures]]
git-tree-sha1 = "e498ddeee6f9fdb4551ce855a46f54dbd900245f"
uuid = "442fdcdd-2543-5da2-b0f3-8c86c306513e"
version = "0.3.1"
[[deps.Media]]
deps = ["MacroTools", "Test"]
git-tree-sha1 = "75a54abd10709c01f1b86b84ec225d26e840ed58"
uuid = "e89f7d12-3494-54d1-8411-f7d8b9ae1f27"
version = "0.5.0"
[[deps.Missings]]
deps = ["DataAPI"]
git-tree-sha1 = "bf210ce90b6c9eed32d25dbcae1ebc565df2687f"
uuid = "e1d29d7a-bbdc-5cf2-9ac0-f12de2c33e28"
version = "1.0.2"
[[deps.Mmap]]
uuid = "a63ad114-7e13-5084-954f-fe012c677804"
[[deps.MozillaCACerts_jll]]
uuid = "14a3606d-f60d-562e-9121-12d972cd8159"
[[deps.NaNMath]]
git-tree-sha1 = "b086b7ea07f8e38cf122f5016af580881ac914fe"
uuid = "77ba4419-2d1f-58cd-9bb1-8ffee604a2e3"
version = "0.3.7"
[[deps.NetworkOptions]]
uuid = "ca575930-c2e3-43a9-ace4-1e988b2c1908"
[[deps.Ogg_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "887579a3eb005446d514ab7aeac5d1d027658b8f"
uuid = "e7412a2a-1a6e-54c0-be00-318e2571c051"
version = "1.3.5+1"
[[deps.OpenBLAS_jll]]
deps = ["Artifacts", "CompilerSupportLibraries_jll", "Libdl"]
uuid = "4536629a-c528-5b80-bd46-f80d51c5b363"
[[deps.OpenSSL_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "648107615c15d4e09f7eca16307bc821c1f718d8"
uuid = "458c3c95-2e84-50aa-8efc-19380b2a3a95"
version = "1.1.13+0"
[[deps.Opus_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "51a08fb14ec28da2ec7a927c4337e4332c2a4720"
uuid = "91d4177d-7536-5919-b921-800302f37372"
version = "1.3.2+0"
[[deps.OrderedCollections]]
git-tree-sha1 = "85f8e6578bf1f9ee0d11e7bb1b1456435479d47c"
uuid = "bac558e1-5e72-5ebc-8fee-abe8a469f55d"
version = "1.4.1"
[[deps.PCRE_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "b2a7af664e098055a7529ad1a900ded962bca488"
uuid = "2f80f16e-611a-54ab-bc61-aa92de5b98fc"
version = "8.44.0+0"
[[deps.Pango_jll]]
deps = ["Artifacts", "Cairo_jll", "Fontconfig_jll", "FreeType2_jll", "FriBidi_jll", "Glib_jll", "HarfBuzz_jll", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "3a121dfbba67c94a5bec9dde613c3d0cbcf3a12b"
uuid = "36c8627f-9965-5494-a995-c6b170f724f3"
version = "1.50.3+0"
[[deps.Parsers]]
deps = ["Dates"]
git-tree-sha1 = "0b5cfbb704034b5b4c1869e36634438a047df065"
uuid = "69de0a69-1ddd-5017-9359-2bf0b02dc9f0"
version = "2.2.1"
[[deps.Pixman_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "b4f5d02549a10e20780a24fce72bea96b6329e29"
uuid = "30392449-352a-5448-841d-b1acce4e97dc"
version = "0.40.1+0"
[[deps.Pkg]]
deps = ["Artifacts", "Dates", "Downloads", "LibGit2", "Libdl", "Logging", "Markdown", "Printf", "REPL", "Random", "SHA", "Serialization", "TOML", "Tar", "UUIDs", "p7zip_jll"]
uuid = "44cfe95a-1eb2-52ea-b672-e2afdf69b78f"
[[deps.PlotThemes]]
deps = ["PlotUtils", "Requires", "Statistics"]
git-tree-sha1 = "a3a964ce9dc7898193536002a6dd892b1b5a6f1d"
uuid = "ccf2f8ad-2431-5c83-bf29-c5338b663b6a"
version = "2.0.1"
[[deps.PlotUtils]]
deps = ["ColorSchemes", "Colors", "Dates", "Printf", "Random", "Reexport", "Statistics"]
git-tree-sha1 = "6f1b25e8ea06279b5689263cc538f51331d7ca17"
uuid = "995b91a9-d308-5afd-9ec6-746e21dbc043"
version = "1.1.3"
[[deps.Plots]]
deps = ["Base64", "Contour", "Dates", "Downloads", "FFMPEG", "FixedPointNumbers", "GR", "GeometryBasics", "JSON", "Latexify", "LinearAlgebra", "Measures", "NaNMath", "PlotThemes", "PlotUtils", "Printf", "REPL", "Random", "RecipesBase", "RecipesPipeline", "Reexport", "Requires", "Scratch", "Showoff", "SparseArrays", "Statistics", "StatsBase", "UUIDs", "UnicodeFun", "Unzip"]
git-tree-sha1 = "eb1432ec2b781f70ce2126c277d120554605669a"
uuid = "91a5bcdd-55d7-5caf-9e0b-520d859cae80"
version = "1.25.8"
[[deps.PlutoUI]]
deps = ["AbstractPlutoDingetjes", "Base64", "ColorTypes", "Dates", "Hyperscript", "HypertextLiteral", "IOCapture", "InteractiveUtils", "JSON", "Logging", "Markdown", "Random", "Reexport", "UUIDs"]
git-tree-sha1 = "8979e9802b4ac3d58c503a20f2824ad67f9074dd"
uuid = "7f904dfe-b85e-4ff6-b463-dae2292396a8"
version = "0.7.34"
[[deps.Preferences]]
deps = ["TOML"]
git-tree-sha1 = "2cf929d64681236a2e074ffafb8d568733d2e6af"
uuid = "21216c6a-2e73-6563-6e65-726566657250"
version = "1.2.3"
[[deps.PrettyTables]]
deps = ["Crayons", "Formatting", "Markdown", "Reexport", "Tables"]
git-tree-sha1 = "dfb54c4e414caa595a1f2ed759b160f5a3ddcba5"
uuid = "08abe8d2-0d0c-5749-adfa-8a2ac140af0d"
version = "1.3.1"
[[deps.Printf]]
deps = ["Unicode"]
uuid = "de0858da-6303-5e67-8744-51eddeeeb8d7"
[[deps.Profile]]
deps = ["Printf"]
uuid = "9abbd945-dff8-562f-b5e8-e1ebf5ef1b79"
[[deps.Qt5Base_jll]]
deps = ["Artifacts", "CompilerSupportLibraries_jll", "Fontconfig_jll", "Glib_jll", "JLLWrappers", "Libdl", "Libglvnd_jll", "OpenSSL_jll", "Pkg", "Xorg_libXext_jll", "Xorg_libxcb_jll", "Xorg_xcb_util_image_jll", "Xorg_xcb_util_keysyms_jll", "Xorg_xcb_util_renderutil_jll", "Xorg_xcb_util_wm_jll", "Zlib_jll", "xkbcommon_jll"]
git-tree-sha1 = "ad368663a5e20dbb8d6dc2fddeefe4dae0781ae8"
uuid = "ea2cea3b-5b76-57ae-a6ef-0a8af62496e1"
version = "5.15.3+0"
[[deps.REPL]]
deps = ["InteractiveUtils", "Markdown", "Sockets", "Unicode"]
uuid = "3fa0cd96-eef1-5676-8a61-b3b8758bbffb"
[[deps.Random]]
deps = ["SHA", "Serialization"]
uuid = "9a3f8284-a2c9-5f02-9a11-845980a1fd5c"
[[deps.RecipesBase]]
git-tree-sha1 = "6bf3f380ff52ce0832ddd3a2a7b9538ed1bcca7d"
uuid = "3cdcf5f2-1ef4-517c-9805-6587b60abb01"
version = "1.2.1"
[[deps.RecipesPipeline]]
deps = ["Dates", "NaNMath", "PlotUtils", "RecipesBase"]
git-tree-sha1 = "37c1631cb3cc36a535105e6d5557864c82cd8c2b"
uuid = "01d81517-befc-4cb6-b9ec-a95719d0359c"
version = "0.5.0"
[[deps.Reexport]]
git-tree-sha1 = "45e428421666073eab6f2da5c9d310d99bb12f9b"
uuid = "189a3867-3050-52da-a836-e630ba90ab69"
version = "1.2.2"
[[deps.RelocatableFolders]]
deps = ["SHA", "Scratch"]
git-tree-sha1 = "cdbd3b1338c72ce29d9584fdbe9e9b70eeb5adca"
uuid = "05181044-ff0b-4ac5-8273-598c1e38db00"
version = "0.1.3"
[[deps.Requires]]
deps = ["UUIDs"]
git-tree-sha1 = "838a3a4188e2ded87a4f9f184b4b0d78a1e91cb7"
uuid = "ae029012-a4dd-5104-9daa-d747884805df"
version = "1.3.0"
[[deps.Rsvg]]
deps = ["Cairo", "Glib_jll", "Librsvg_jll"]
git-tree-sha1 = "3d3dc66eb46568fb3a5259034bfc752a0eb0c686"
uuid = "c4c386cf-5103-5370-be45-f3a111cca3b8"
version = "1.0.0"
[[deps.SHA]]
uuid = "ea8e919c-243c-51af-8825-aaa63cd721ce"
[[deps.Scratch]]
deps = ["Dates"]
git-tree-sha1 = "0b4b7f1393cff97c33891da2a0bf69c6ed241fda"
uuid = "6c6a2e73-6563-6170-7368-637461726353"
version = "1.1.0"
[[deps.Serialization]]
uuid = "9e88b42a-f829-5b0c-bbe9-9e923198166b"
[[deps.SharedArrays]]
deps = ["Distributed", "Mmap", "Random", "Serialization"]
uuid = "1a1011a3-84de-559e-8e89-a11a2f7dc383"
[[deps.Showoff]]
deps = ["Dates", "Grisu"]
git-tree-sha1 = "91eddf657aca81df9ae6ceb20b959ae5653ad1de"
uuid = "992d4aef-0814-514b-bc4d-f2e9a6c4116f"
version = "1.0.3"
[[deps.Sockets]]
uuid = "6462fe0b-24de-5631-8697-dd941f90decc"
[[deps.SortingAlgorithms]]
deps = ["DataStructures"]
git-tree-sha1 = "b3363d7460f7d098ca0912c69b082f75625d7508"
uuid = "a2af1166-a08f-5f64-846c-94a0d3cef48c"
version = "1.0.1"
[[deps.SparseArrays]]
deps = ["LinearAlgebra", "Random"]
uuid = "2f01184e-e22b-5df5-ae63-d93ebab69eaf"
[[deps.StaticArrays]]
deps = ["LinearAlgebra", "Random", "Statistics"]
git-tree-sha1 = "a635a9333989a094bddc9f940c04c549cd66afcf"
uuid = "90137ffa-7385-5640-81b9-e52037218182"
version = "1.3.4"
[[deps.Statistics]]
deps = ["LinearAlgebra", "SparseArrays"]
uuid = "10745b16-79ce-11e8-11f9-7d13ad32a3b2"
[[deps.StatsAPI]]
git-tree-sha1 = "d88665adc9bcf45903013af0982e2fd05ae3d0a6"
uuid = "82ae8749-77ed-4fe6-ae5f-f523153014b0"
version = "1.2.0"
[[deps.StatsBase]]
deps = ["DataAPI", "DataStructures", "LinearAlgebra", "LogExpFunctions", "Missings", "Printf", "Random", "SortingAlgorithms", "SparseArrays", "Statistics", "StatsAPI"]
git-tree-sha1 = "51383f2d367eb3b444c961d485c565e4c0cf4ba0"
uuid = "2913bbd2-ae8a-5f71-8c99-4fb6c76f3a91"
version = "0.33.14"
[[deps.StructArrays]]
deps = ["Adapt", "DataAPI", "StaticArrays", "Tables"]
git-tree-sha1 = "d21f2c564b21a202f4677c0fba5b5ee431058544"
uuid = "09ab397b-f2b6-538f-b94a-2f83cf4a842a"
version = "0.6.4"
[[deps.TOML]]
deps = ["Dates"]
uuid = "fa267f1f-6049-4f14-aa54-33bafae1ed76"
[[deps.TableTraits]]
deps = ["IteratorInterfaceExtensions"]
git-tree-sha1 = "c06b2f539df1c6efa794486abfb6ed2022561a39"
uuid = "3783bdb8-4a98-5b6b-af9a-565f29a5fe9c"
version = "1.0.1"
[[deps.Tables]]
deps = ["DataAPI", "DataValueInterfaces", "IteratorInterfaceExtensions", "LinearAlgebra", "TableTraits", "Test"]
git-tree-sha1 = "bb1064c9a84c52e277f1096cf41434b675cd368b"
uuid = "bd369af6-aec1-5ad0-b16a-f7cc5008161c"
version = "1.6.1"
[[deps.Tar]]
deps = ["ArgTools", "SHA"]
uuid = "a4e569a6-e804-4fa4-b0f3-eef7a1d5b13e"
[[deps.Test]]
deps = ["InteractiveUtils", "Logging", "Random", "Serialization"]
uuid = "8dfed614-e22c-5e08-85e1-65c5234f0b40"
[[deps.URIs]]
git-tree-sha1 = "97bbe755a53fe859669cd907f2d96aee8d2c1355"
uuid = "5c2747f8-b7ea-4ff2-ba2e-563bfd36b1d4"
version = "1.3.0"
[[deps.UUIDs]]
deps = ["Random", "SHA"]
uuid = "cf7118a7-6976-5b1a-9a39-7adc72f591a4"
[[deps.Unicode]]
uuid = "4ec0a83e-493e-50e2-b9ac-8f72acf5a8f5"
[[deps.UnicodeFun]]
deps = ["REPL"]
git-tree-sha1 = "53915e50200959667e78a92a418594b428dffddf"
uuid = "1cfade01-22cf-5700-b092-accc4b62d6e1"
version = "0.4.1"
[[deps.Unzip]]
git-tree-sha1 = "34db80951901073501137bdbc3d5a8e7bbd06670"
uuid = "41fe7b60-77ed-43a1-b4f0-825fd5a5650d"
version = "0.1.2"
[[deps.Wayland_jll]]
deps = ["Artifacts", "Expat_jll", "JLLWrappers", "Libdl", "Libffi_jll", "Pkg", "XML2_jll"]
git-tree-sha1 = "3e61f0b86f90dacb0bc0e73a0c5a83f6a8636e23"
uuid = "a2964d1f-97da-50d4-b82a-358c7fce9d89"
version = "1.19.0+0"
[[deps.Wayland_protocols_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "66d72dc6fcc86352f01676e8f0f698562e60510f"
uuid = "2381bf8a-dfd0-557d-9999-79630e7b1b91"
version = "1.23.0+0"
[[deps.XML2_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Libiconv_jll", "Pkg", "Zlib_jll"]
git-tree-sha1 = "1acf5bdf07aa0907e0a37d3718bb88d4b687b74a"
uuid = "02c8fc9c-b97f-50b9-bbe4-9be30ff0a78a"
version = "2.9.12+0"
[[deps.XSLT_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Libgcrypt_jll", "Libgpg_error_jll", "Libiconv_jll", "Pkg", "XML2_jll", "Zlib_jll"]
git-tree-sha1 = "91844873c4085240b95e795f692c4cec4d805f8a"
uuid = "aed1982a-8fda-507f-9586-7b0439959a61"
version = "1.1.34+0"
[[deps.Xorg_libX11_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libxcb_jll", "Xorg_xtrans_jll"]
git-tree-sha1 = "5be649d550f3f4b95308bf0183b82e2582876527"
uuid = "4f6342f7-b3d2-589e-9d20-edeb45f2b2bc"
version = "1.6.9+4"
[[deps.Xorg_libXau_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "4e490d5c960c314f33885790ed410ff3a94ce67e"
uuid = "0c0b7dd1-d40b-584c-a123-a41640f87eec"
version = "1.0.9+4"
[[deps.Xorg_libXcursor_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libXfixes_jll", "Xorg_libXrender_jll"]
git-tree-sha1 = "12e0eb3bc634fa2080c1c37fccf56f7c22989afd"
uuid = "935fb764-8cf2-53bf-bb30-45bb1f8bf724"
version = "1.2.0+4"
[[deps.Xorg_libXdmcp_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "4fe47bd2247248125c428978740e18a681372dd4"
uuid = "a3789734-cfe1-5b06-b2d0-1dd0d9d62d05"
version = "1.1.3+4"
[[deps.Xorg_libXext_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libX11_jll"]
git-tree-sha1 = "b7c0aa8c376b31e4852b360222848637f481f8c3"
uuid = "1082639a-0dae-5f34-9b06-72781eeb8cb3"
version = "1.3.4+4"
[[deps.Xorg_libXfixes_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libX11_jll"]
git-tree-sha1 = "0e0dc7431e7a0587559f9294aeec269471c991a4"
uuid = "d091e8ba-531a-589c-9de9-94069b037ed8"
version = "5.0.3+4"
[[deps.Xorg_libXi_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libXext_jll", "Xorg_libXfixes_jll"]
git-tree-sha1 = "89b52bc2160aadc84d707093930ef0bffa641246"
uuid = "a51aa0fd-4e3c-5386-b890-e753decda492"
version = "1.7.10+4"
[[deps.Xorg_libXinerama_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libXext_jll"]
git-tree-sha1 = "26be8b1c342929259317d8b9f7b53bf2bb73b123"
uuid = "d1454406-59df-5ea1-beac-c340f2130bc3"
version = "1.1.4+4"
[[deps.Xorg_libXrandr_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libXext_jll", "Xorg_libXrender_jll"]
git-tree-sha1 = "34cea83cb726fb58f325887bf0612c6b3fb17631"
uuid = "ec84b674-ba8e-5d96-8ba1-2a689ba10484"
version = "1.5.2+4"
[[deps.Xorg_libXrender_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libX11_jll"]
git-tree-sha1 = "19560f30fd49f4d4efbe7002a1037f8c43d43b96"
uuid = "ea2f1a96-1ddc-540d-b46f-429655e07cfa"
version = "0.9.10+4"
[[deps.Xorg_libpthread_stubs_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "6783737e45d3c59a4a4c4091f5f88cdcf0908cbb"
uuid = "14d82f49-176c-5ed1-bb49-ad3f5cbd8c74"
version = "0.1.0+3"
[[deps.Xorg_libxcb_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "XSLT_jll", "Xorg_libXau_jll", "Xorg_libXdmcp_jll", "Xorg_libpthread_stubs_jll"]
git-tree-sha1 = "daf17f441228e7a3833846cd048892861cff16d6"
uuid = "c7cfdc94-dc32-55de-ac96-5a1b8d977c5b"
version = "1.13.0+3"
[[deps.Xorg_libxkbfile_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libX11_jll"]
git-tree-sha1 = "926af861744212db0eb001d9e40b5d16292080b2"
uuid = "cc61e674-0454-545c-8b26-ed2c68acab7a"
version = "1.1.0+4"
[[deps.Xorg_xcb_util_image_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_xcb_util_jll"]
git-tree-sha1 = "0fab0a40349ba1cba2c1da699243396ff8e94b97"
uuid = "12413925-8142-5f55-bb0e-6d7ca50bb09b"
version = "0.4.0+1"
[[deps.Xorg_xcb_util_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libxcb_jll"]
git-tree-sha1 = "e7fd7b2881fa2eaa72717420894d3938177862d1"
uuid = "2def613f-5ad1-5310-b15b-b15d46f528f5"
version = "0.4.0+1"
[[deps.Xorg_xcb_util_keysyms_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_xcb_util_jll"]
git-tree-sha1 = "d1151e2c45a544f32441a567d1690e701ec89b00"
uuid = "975044d2-76e6-5fbe-bf08-97ce7c6574c7"
version = "0.4.0+1"
[[deps.Xorg_xcb_util_renderutil_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_xcb_util_jll"]
git-tree-sha1 = "dfd7a8f38d4613b6a575253b3174dd991ca6183e"
uuid = "0d47668e-0667-5a69-a72c-f761630bfb7e"
version = "0.3.9+1"
[[deps.Xorg_xcb_util_wm_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_xcb_util_jll"]
git-tree-sha1 = "e78d10aab01a4a154142c5006ed44fd9e8e31b67"
uuid = "c22f9ab0-d5fe-5066-847c-f4bb1cd4e361"
version = "0.4.1+1"
[[deps.Xorg_xkbcomp_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_libxkbfile_jll"]
git-tree-sha1 = "4bcbf660f6c2e714f87e960a171b119d06ee163b"
uuid = "35661453-b289-5fab-8a00-3d9160c6a3a4"
version = "1.4.2+4"
[[deps.Xorg_xkeyboard_config_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Xorg_xkbcomp_jll"]
git-tree-sha1 = "5c8424f8a67c3f2209646d4425f3d415fee5931d"
uuid = "33bec58e-1273-512f-9401-5d533626f822"
version = "2.27.0+4"
[[deps.Xorg_xtrans_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "79c31e7844f6ecf779705fbc12146eb190b7d845"
uuid = "c5fb5394-a638-5e4d-96e5-b29de1b5cf10"
version = "1.4.0+3"
[[deps.Zlib_jll]]
deps = ["Libdl"]
uuid = "83775a58-1f1d-513f-b197-d71354ab007a"
[[deps.Zstd_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "e45044cd873ded54b6a5bac0eb5c971392cf1927"
uuid = "3161d3a3-bdf6-5164-811a-617609db77b4"
version = "1.5.2+0"
[[deps.gdk_pixbuf_jll]]
deps = ["Artifacts", "Glib_jll", "JLLWrappers", "JpegTurbo_jll", "Libdl", "Libtiff_jll", "Pkg", "Xorg_libX11_jll", "libpng_jll"]
git-tree-sha1 = "c23323cd30d60941f8c68419a70905d9bdd92808"
uuid = "da03df04-f53b-5353-a52f-6a8b0620ced0"
version = "2.42.6+1"
[[deps.libass_jll]]
deps = ["Artifacts", "Bzip2_jll", "FreeType2_jll", "FriBidi_jll", "HarfBuzz_jll", "JLLWrappers", "Libdl", "Pkg", "Zlib_jll"]
git-tree-sha1 = "5982a94fcba20f02f42ace44b9894ee2b140fe47"
uuid = "0ac62f75-1d6f-5e53-bd7c-93b484bb37c0"
version = "0.15.1+0"
[[deps.libblastrampoline_jll]]
deps = ["Artifacts", "Libdl", "OpenBLAS_jll"]
uuid = "8e850b90-86db-534c-a0d3-1478176c7d93"
[[deps.libfdk_aac_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "daacc84a041563f965be61859a36e17c4e4fcd55"
uuid = "f638f0a6-7fb0-5443-88ba-1cc74229b280"
version = "2.0.2+0"
[[deps.libpng_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Zlib_jll"]
git-tree-sha1 = "94d180a6d2b5e55e447e2d27a29ed04fe79eb30c"
uuid = "b53b4c65-9356-5827-b1ea-8c7a1a84506f"
version = "1.6.38+0"
[[deps.libvorbis_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Ogg_jll", "Pkg"]
git-tree-sha1 = "b910cb81ef3fe6e78bf6acee440bda86fd6ae00c"
uuid = "f27f6e37-5d2b-51aa-960f-b287f2bc3b7a"
version = "1.3.7+1"
[[deps.nghttp2_jll]]
deps = ["Artifacts", "Libdl"]
uuid = "8e850ede-7688-5339-a07c-302acd2aaf8d"
[[deps.p7zip_jll]]
deps = ["Artifacts", "Libdl"]
uuid = "3f19e933-33d8-53b3-aaab-bd5110c3b7a0"
[[deps.x264_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "4fea590b89e6ec504593146bf8b988b2c00922b2"
uuid = "1270edf5-f2f9-52d2-97e9-ab00b5d0237a"
version = "2021.5.5+0"
[[deps.x265_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"]
git-tree-sha1 = "ee567a171cce03570d77ad3a43e90218e38937a9"
uuid = "dfaa095f-4041-5dcd-9319-2fabd8486b76"
version = "3.5.0+0"
[[deps.xkbcommon_jll]]
deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Wayland_jll", "Wayland_protocols_jll", "Xorg_libxcb_jll", "Xorg_xkeyboard_config_jll"]
git-tree-sha1 = "ece2350174195bb31de1a63bea3a41ae1aa593b6"
uuid = "d8fb68d0-12a3-5cfd-a85a-d49703b185fd"
version = "0.9.1+5"
"""
# ╔═╡ Cell order:
# ╟─8ba6a00a-7a53-4dcc-af4d-cb85aa9b4d68
# ╟─8869f117-1fc6-4cc5-9803-b8ec72a109a6
# ╟─17724757-604e-4c77-a42b-238ba121e88f
# ╟─431ccdf0-93a9-4b3c-9576-8854ba2f1fad
# ╟─7efaf27c-8e0a-40f9-ac28-af90357450a3
# ╟─55ea8324-f36d-40bd-99e3-92e7fcbafca9
# ╟─3502da52-7d2b-4c79-82ce-7424d756cd9b
# ╟─c392c8a9-361d-47e4-933e-2e51b793e069
# ╟─91345d04-f502-4e90-935e-a4dc250244db
# ╟─719784fe-3ef6-4e53-ad52-82140e3d0b5e
# ╟─1d4d6059-5b79-43cd-ac17-ef2aa057ecad
# ╟─d46ced14-a5d3-45a9-9d43-38dc7879b0c7
# ╟─d3568c5d-16bf-4698-9891-0be65d62b36c
# ╟─55d4ab48-9589-4fd9-ac06-3338fdb418c4
# ╟─54370424-3add-4f93-91b0-e136166842ae
# ╠═451ae3a0-8068-4747-95a7-d31955808f29
# ╠═06a90381-b4cb-4d32-af0d-2f084364129c
# ╠═b6890de0-8923-11ec-3552-3113bdd53f86
# ╟─00000000-0000-0000-0000-000000000001
# ╟─00000000-0000-0000-0000-000000000002
| [
21017,
317,
32217,
13,
20362,
20922,
44386,
198,
2,
410,
15,
13,
1507,
13,
15,
198,
198,
3500,
2940,
2902,
198,
3500,
21365,
18274,
4487,
198,
198,
2,
770,
32217,
20922,
3544,
2488,
21653,
329,
9427,
3458,
13,
1649,
2491,
428,
20922,
2354,
286,
32217,
11,
262,
1708,
705,
76,
735,
2196,
6,
286,
2488,
21653,
3607,
5421,
9633,
257,
4277,
1988,
357,
38070,
286,
281,
4049,
737,
198,
20285,
305,
11007,
7,
4299,
11,
5002,
8,
198,
220,
220,
220,
9577,
198,
220,
220,
220,
220,
220,
220,
220,
1957,
21628,
796,
1949,
7308,
13,
14578,
62,
18170,
58,
14881,
13,
47,
10025,
7390,
7,
14881,
13,
52,
27586,
7203,
21,
68,
38205,
66,
4761,
12,
2996,
3682,
12,
1238,
3134,
12,
22,
22980,
12,
3682,
22136,
66,
2425,
5333,
1120,
12340,
366,
23839,
3646,
9390,
35,
278,
316,
73,
274,
4943,
4083,
33,
24764,
13,
36733,
62,
8367,
4929,
26,
275,
4613,
4814,
26,
886,
198,
220,
220,
220,
220,
220,
220,
220,
1957,
1288,
796,
29568,
3798,
7,
30854,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
3298,
29568,
3798,
7,
4299,
4008,
796,
7231,
13,
1324,
677,
540,
7,
14881,
13,
1136,
11,
1288,
8,
5633,
7308,
13,
1136,
7,
417,
8,
1058,
21628,
7,
417,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1288,
198,
220,
220,
220,
886,
198,
437,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
49356,
3609,
18,
64,
15,
12,
1795,
3104,
12,
2857,
2857,
12,
3865,
64,
22,
12,
67,
35175,
2816,
28362,
69,
1959,
198,
27471,
628,
197,
2,
7097,
10392,
532,
198,
197,
3500,
32217,
10080,
198,
197,
3500,
1345,
1747,
198,
197,
3500,
20090,
51,
2977,
198,
437,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
807,
7012,
21,
64,
405,
64,
12,
22,
64,
4310,
12,
19,
67,
535,
12,
1878,
19,
67,
12,
21101,
5332,
7252,
24,
65,
19,
67,
3104,
198,
9132,
37811,
198,
21017,
17427,
290,
19157,
32329,
286,
2039,
24266,
16645,
14596,
198,
198,
464,
28462,
22303,
389,
6393,
17778,
287,
28462,
5236,
3781,
16765,
290,
262,
24748,
87,
26969,
9150,
286,
262,
3995,
16590,
16996,
7177,
13,
12197,
511,
2597,
287,
262,
28462,
31850,
1917,
11,
262,
28462,
22303,
389,
4808,
18908,
13260,
62,
11,
1312,
13,
68,
1539,
777,
17778,
19386,
867,
3858,
286,
8513,
290,
47685,
1321,
656,
262,
28462,
31850,
1917,
13,
220,
198,
198,
37,
22564,
22303,
1500,
3201,
262,
3815,
326,
1123,
6317,
287,
257,
19737,
3127,
460,
1011,
13,
317,
2276,
2746,
329,
777,
22303,
318,
1813,
416,
25,
198,
198,
13702,
12,
59,
67,
12514,
23330,
73,
32239,
9464,
58,
90,
53,
23330,
9806,
11,
73,
92,
61,
31478,
21170,
11709,
59,
9464,
38016,
31944,
90,
68,
18477,
68,
61,
31478,
21170,
11709,
59,
3506,
19415,
1169,
8326,
23330,
73,
32239,
9464,
38016,
67,
1747,
59,
3506,
19953,
69,
23330,
73,
32239,
9464,
38016,
67,
1747,
59,
3506,
8,
32239,
3506,
60,
59,
293,
80,
90,
85,
23330,
73,
11709,
59,
293,
80,
90,
53,
23330,
9806,
11,
73,
92,
61,
31478,
21170,
11709,
59,
9464,
38016,
31944,
90,
68,
18477,
68,
61,
31478,
21170,
11709,
59,
3506,
19415,
1169,
8326,
23330,
73,
32239,
9464,
38016,
67,
1747,
59,
3506,
19953,
69,
23330,
73,
32239,
9464,
38016,
67,
1747,
59,
3506,
38165,
13702,
198,
198,
3003,
720,
53,
23330,
9806,
11,
73,
92,
61,
31478,
21170,
92,
3,
43397,
262,
5415,
6317,
15432,
357,
41667,
25,
28462,
8,
29231,
379,
617,
16704,
27679,
20038,
357,
41667,
25,
10368,
828,
262,
8064,
720,
68,
14,
68,
61,
31478,
21170,
92,
3,
318,
257,
17137,
329,
27679,
20038,
357,
41667,
25,
15793,
408,
828,
39280,
1169,
8326,
23330,
73,
32239,
9464,
38016,
67,
1747,
59,
3506,
19415,
259,
59,
9464,
58,
15,
11,
16,
59,
3506,
60,
3,
318,
262,
13390,
286,
12991,
498,
27679,
3842,
357,
64,
2163,
393,
15558,
9194,
4991,
25,
15793,
1203,
828,
290,
720,
69,
23330,
73,
32239,
9464,
38016,
67,
1747,
59,
3506,
8,
3,
318,
257,
2163,
12059,
262,
32305,
21403,
286,
262,
6317,
2494,
720,
73,
3,
357,
41667,
25,
15793,
1203,
737,
5747,
39280,
1169,
8326,
23330,
73,
32239,
9464,
38016,
67,
1747,
59,
3506,
8,
3,
290,
720,
69,
23330,
73,
32239,
9464,
38016,
67,
1747,
59,
3506,
8,
3,
714,
423,
3917,
10007,
11,
304,
13,
70,
1539,
36275,
393,
12765,
38491,
11,
3503,
13,
220,
9461,
11,
262,
627,
19689,
39280,
67,
12514,
23330,
73,
32239,
259,
59,
9464,
59,
90,
15,
11,
16,
59,
3506,
59,
92,
3,
318,
257,
4808,
39491,
62,
7885,
25,
220,
198,
9,
1002,
6317,
720,
73,
3,
318,
11593,
260,
37393,
834,
39280,
67,
12514,
23330,
73,
92,
28,
16,
3,
393,
11,
198,
9,
1002,
6317,
720,
73,
3,
318,
11593,
343,
260,
37393,
834,
39280,
67,
12514,
23330,
73,
92,
28,
15,
3,
198,
198,
8888,
11,
1309,
338,
2962,
319,
10581,
329,
14492,
262,
1988,
286,
777,
22303,
11,
1312,
13,
68,
1539,
262,
1296,
290,
1988,
286,
262,
2846,
287,
262,
28103,
13,
554,
428,
19143,
11,
356,
481,
25,
198,
198,
16,
13,
6013,
2829,
4981,
286,
27679,
18967,
14596,
1262,
262,
3899,
271,
1906,
44,
298,
268,
3164,
198,
16,
13,
11036,
344,
262,
7531,
10838,
10238,
517,
3716,
4981,
286,
477,
6197,
291,
9001,
357,
1169,
3049,
1630,
11701,
326,
356,
4750,
4271,
8,
198,
16,
13,
11036,
344,
4050,
28810,
9001,
4981,
284,
8006,
477,
6197,
291,
9001,
198,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
9193,
3388,
69,
17657,
12,
16,
16072,
21,
12,
19,
535,
20,
12,
40022,
18,
12,
65,
23,
721,
4761,
64,
14454,
64,
21,
198,
9132,
37811,
198,
21017,
1867,
318,
477,
6197,
291,
9001,
30,
198,
3237,
6197,
291,
9001,
953,
15968,
27679,
3842,
416,
12765,
1245,
273,
17745,
284,
5043,
584,
621,
262,
27679,
338,
4075,
2524,
13,
2312,
2995,
460,
15155,
357,
16550,
1817,
2494,
8,
290,
26776,
357,
12501,
260,
1386,
2494,
737,
1439,
6197,
291,
9001,
14051,
319,
257,
3049,
640,
5046,
3688,
284,
9779,
5408,
357,
1837,
429,
8497,
286,
262,
27679,
737,
220,
198,
198,
3237,
6197,
291,
11701,
287,
5694,
23699,
3395,
28426,
1042,
25,
198,
198,
9,
685,
3041,
89,
17187,
412,
11,
1951,
375,
2852,
280,
360,
11,
3561,
3841,
449,
36,
11,
25866,
945,
412,
11,
311,
16261,
471,
11,
1001,
2164,
14064,
360,
11,
1400,
273,
412,
13,
5215,
462,
12,
29990,
29778,
286,
10452,
25726,
23172,
38018,
27862,
290,
262,
49983,
9601,
12,
9362,
1022,
26472,
290,
2039,
89,
4948,
1512,
24641,
13,
12440,
1432,
13,
2177,
8621,
1105,
26,
1238,
7,
1157,
2599,
2075,
2791,
12,
2075,
3324,
13,
23899,
25,
838,
13,
27956,
14,
73,
13,
5276,
7856,
13,
5539,
13,
2919,
13,
15,
2791,
13,
3122,
2389,
25,
2579,
3829,
1270,
3510,
26,
3122,
34,
2389,
25,
3122,
34,
3980,
405,
33580,
8183,
7,
5450,
1378,
12984,
1150,
13,
10782,
8482,
13,
21283,
76,
13,
37373,
13,
9567,
14,
2078,
3829,
1270,
3510,
34729,
198,
198,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
26607,
1731,
39251,
12,
31916,
68,
12,
19,
66,
3324,
12,
64,
3682,
65,
12,
23721,
7012,
19244,
68,
3459,
69,
198,
9132,
37811,
198,
21017,
17427,
25,
3899,
271,
1906,
44,
298,
268,
18967,
14596,
198,
5756,
338,
7048,
356,
423,
257,
880,
12,
76,
2966,
1332,
12403,
7268,
281,
27679,
720,
36,
3,
357,
64,
7532,
326,
36745,
12271,
5931,
12737,
828,
543,
26161,
32305,
720,
50,
3,
357,
1169,
3599,
13061,
8,
220,
198,
20424,
1720,
720,
47,
3,
1864,
284,
1115,
19823,
12737,
25,
198,
198,
13702,
59,
27471,
90,
27363,
77,
18747,
92,
198,
197,
36,
10,
50,
5,
59,
3506,
293,
69,
400,
5117,
13022,
5,
90,
36,
25,
50,
92,
6852,
198,
197,
90,
36,
25,
50,
92,
5,
59,
6511,
3506,
6018,
5,
36,
10,
47,
198,
59,
437,
90,
27363,
77,
18747,
92,
13702,
198,
198,
464,
18967,
14596,
286,
1123,
19823,
2239,
460,
307,
3194,
1262,
2347,
12,
2673,
18967,
14596,
11,
1312,
13,
68,
1539,
198,
198,
13702,
59,
27471,
90,
27363,
77,
18747,
92,
198,
197,
81,
23330,
16,
92,
1222,
796,
1222,
479,
23330,
16,
32239,
9464,
58,
36,
59,
3506,
60,
59,
9464,
58,
50,
59,
3506,
60,
6852,
198,
197,
81,
23330,
17,
92,
1222,
796,
1222,
479,
23330,
17,
32239,
9464,
58,
36,
25,
50,
59,
3506,
60,
6852,
198,
197,
81,
23330,
18,
92,
1222,
796,
1222,
479,
23330,
18,
32239,
9464,
58,
36,
25,
50,
59,
3506,
60,
198,
59,
437,
90,
27363,
77,
18747,
92,
13702,
198,
198,
3003,
39280,
9464,
58,
59,
10210,
313,
59,
3506,
60,
3,
43397,
257,
4693,
10368,
11,
290,
720,
74,
23330,
73,
92,
3,
43397,
262,
2494,
6937,
15030,
262,
720,
73,
400,
3,
19823,
6317,
25,
198,
198,
9,
383,
2494,
720,
81,
23330,
16,
92,
3,
8477,
262,
4808,
562,
41003,
62,
2494,
1022,
262,
27679,
290,
32305,
11,
198,
9,
383,
2494,
720,
81,
23330,
17,
92,
3,
6870,
262,
2494,
286,
4808,
67,
747,
41003,
62,
286,
262,
27679,
12,
7266,
23104,
3716,
11,
290,
198,
9,
383,
720,
81,
23330,
18,
92,
3,
43397,
262,
2494,
286,
4808,
31379,
11315,
62,
286,
262,
5421,
32305,
656,
262,
1720,
357,
732,
7048,
262,
6249,
41003,
286,
262,
1720,
422,
262,
27679,
318,
3049,
737,
198,
198,
464,
27679,
1276,
22389,
262,
2776,
25,
198,
198,
13702,
59,
9464,
58,
36,
23330,
51,
32239,
3506,
60,
796,
3467,
9464,
58,
36,
59,
3506,
60,
1343,
3467,
9464,
58,
36,
25,
50,
59,
3506,
60,
13702,
198,
198,
3003,
39280,
9464,
58,
36,
23330,
51,
32239,
3506,
60,
3,
43397,
262,
2472,
27679,
10368,
287,
262,
12403,
11,
220,
198,
3,
59,
9464,
58,
36,
59,
3506,
60,
3,
43397,
262,
1479,
27679,
10368,
357,
1662,
5421,
284,
32305,
8,
981,
198,
3,
59,
9464,
58,
36,
25,
50,
59,
3506,
60,
3,
43397,
262,
27679,
12,
7266,
23104,
3716,
13,
220,
198,
198,
2514,
8636,
262,
4808,
2502,
439,
62,
2494,
720,
85,
47113,
356,
22111,
5039,
257,
2060,
2494,
12,
2475,
1780,
2239,
503,
286,
262,
900,
286,
19823,
12737,
13,
3914,
338,
7048,
326,
262,
2494,
286,
5931,
11315,
7198,
81,
23330,
18,
92,
3,
8,
318,
262,
3105,
395,
2239,
11,
1312,
13,
68,
1539,
262,
32305,
49623,
319,
14,
2364,
262,
27679,
2952,
351,
691,
257,
7009,
13390,
286,
777,
12765,
2995,
7186,
287,
257,
4388,
5931,
13389,
13,
6660,
11,
262,
4045,
2494,
318,
788,
1813,
416,
25,
198,
198,
13702,
85,
796,
479,
23330,
18,
32239,
9464,
58,
36,
25,
50,
59,
3506,
60,
13702,
198,
198,
5756,
338,
635,
7048,
326,
356,
1541,
760,
357,
273,
460,
8636,
8,
262,
2494,
38491,
720,
74,
23330,
16,
5512,
74,
23330,
17,
92,
3,
290,
720,
74,
23330,
18,
92,
35307,
1649,
428,
318,
2081,
11,
262,
691,
6439,
318,
39280,
9464,
58,
36,
25,
50,
59,
3506,
60,
35307,
198,
4864,
11,
356,
460,
15124,
39280,
9464,
58,
36,
25,
50,
59,
3506,
60,
3,
284,
9633,
356,
760,
7198,
36,
23330,
51,
92,
3,
290,
379,
1551,
7317,
720,
50,
3,
8,
832,
262,
27679,
5236,
11,
290,
262,
4808,
7752,
12003,
12,
28044,
88,
12,
5219,
13196,
62,
329,
262,
6317,
19898,
220,
198,
3,
59,
9464,
58,
36,
25,
50,
59,
3506,
60,
3,
25,
198,
198,
13702,
59,
31944,
90,
67,
59,
9464,
58,
36,
25,
50,
59,
3506,
60,
18477,
28664,
92,
796,
479,
23330,
16,
32239,
9464,
58,
36,
59,
3506,
60,
59,
9464,
58,
50,
59,
3506,
60,
532,
479,
23330,
17,
32239,
9464,
58,
36,
25,
50,
59,
3506,
60,
532,
479,
23330,
18,
32239,
9464,
58,
36,
25,
50,
59,
3506,
60,
59,
82,
524,
80,
90,
15,
92,
13702,
198,
198,
49,
451,
32319,
290,
18120,
329,
39280,
9464,
58,
36,
25,
50,
59,
3506,
60,
3,
3607,
262,
2776,
25,
198,
198,
13702,
59,
9464,
58,
36,
25,
50,
59,
3506,
60,
59,
82,
524,
80,
59,
31944,
90,
74,
23330,
16,
11709,
90,
74,
23330,
17,
92,
10,
74,
23330,
18,
11709,
59,
9464,
58,
36,
59,
3506,
60,
59,
9464,
58,
50,
59,
3506,
60,
13702,
198,
198,
3003,
262,
8064,
286,
38491,
318,
5447,
355,
262,
3899,
271,
12,
44,
298,
268,
36275,
35381,
393,
720,
42,
23330,
44,
92,
3,
25,
198,
198,
13702,
59,
31944,
90,
16,
18477,
42,
23330,
44,
11709,
59,
4853,
452,
59,
31944,
90,
74,
23330,
16,
11709,
90,
74,
23330,
17,
92,
10,
74,
23330,
18,
11709,
13702,
198,
198,
7004,
301,
270,
15129,
262,
6770,
286,
720,
42,
23330,
44,
92,
3,
656,
262,
4045,
2494,
19299,
25,
198,
198,
13702,
85,
796,
479,
23330,
18,
32239,
31944,
31478,
9464,
58,
36,
59,
3506,
60,
59,
9464,
58,
50,
59,
3506,
60,
18477,
42,
23330,
44,
11709,
13702,
198,
198,
4864,
11,
356,
466,
407,
760,
262,
1479,
27679,
10368,
286,
39280,
9464,
58,
36,
59,
3506,
60,
3,
26,
284,
1064,
39280,
9464,
58,
36,
59,
3506,
60,
3,
198,
732,
6352,
3678,
39280,
9464,
58,
36,
25,
50,
59,
3506,
60,
3,
656,
262,
27679,
5236,
290,
18120,
329,
39280,
9464,
58,
36,
59,
3506,
60,
3,
25,
198,
198,
13702,
59,
9464,
58,
36,
59,
3506,
60,
796,
3467,
31944,
31478,
9464,
58,
36,
62,
51,
59,
3506,
60,
42,
23330,
44,
11709,
90,
42,
23330,
44,
92,
10,
59,
9464,
58,
50,
59,
3506,
48999,
13702,
198,
198,
37511,
11,
356,
15373,
39280,
9464,
58,
36,
59,
3506,
60,
3,
656,
262,
4045,
2494,
284,
9240,
379,
262,
2457,
5408,
329,
720,
85,
3,
25,
198,
198,
13702,
85,
796,
569,
23330,
9806,
32239,
31944,
31478,
9464,
58,
50,
59,
3506,
60,
18477,
42,
23330,
44,
92,
10,
59,
9464,
58,
50,
59,
3506,
48999,
13702,
198,
198,
3003,
720,
53,
23330,
9806,
32239,
4853,
452,
90,
74,
23330,
18,
11709,
59,
9464,
58,
36,
23330,
51,
32239,
3506,
60,
35307,
220,
198,
198,
834,
19352,
1780,
2663,
25,
834,
198,
9,
618,
720,
50,
59,
1130,
90,
42,
92,
23330,
44,
92,
47113,
262,
2494,
4329,
1969,
284,
720,
53,
23330,
9806,
92,
35307,
198,
9,
618,
720,
50,
59,
297,
90,
42,
92,
23330,
44,
92,
3,
262,
2494,
3568,
284,
307,
14174,
351,
2461,
284,
32305,
10368,
13,
198,
9,
618,
720,
42,
23330,
44,
32239,
82,
524,
80,
311,
3,
262,
6317,
2494,
21767,
720,
85,
59,
82,
524,
80,
352,
14,
17,
53,
23330,
9806,
92,
35307,
220,
198,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
604,
3132,
535,
7568,
15,
12,
6052,
64,
24,
12,
19,
65,
18,
66,
12,
24,
37452,
12,
3459,
4051,
7012,
17,
69,
16,
69,
324,
198,
31,
21653,
20806,
62,
17143,
7307,
32217,
10080,
13,
24011,
500,
3419,
466,
5932,
198,
197,
9132,
37811,
198,
197,
4242,
2,
3899,
271,
1906,
44,
298,
268,
40117,
198,
197,
198,
197,
59,
58,
36,
59,
60,
29568,
198,
197,
197,
16424,
7,
11122,
1304,
7,
16,
25,
20,
4008,
198,
197,
8,
357,
34703,
44,
8,
290,
509,
158,
224,
246,
29568,
198,
197,
197,
16424,
7,
11122,
1304,
7,
20,
25,
3064,
4008,
198,
197,
8,
357,
76,
44,
8,
628,
197,
37811,
198,
437,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
767,
891,
1878,
1983,
66,
12,
23,
68,
15,
64,
12,
1821,
69,
24,
12,
330,
2078,
12,
1878,
3829,
2327,
4524,
1120,
64,
18,
198,
27471,
628,
197,
2,
651,
20806,
11507,
3815,
532,
198,
197,
36,
796,
20806,
62,
17143,
7307,
58,
16,
60,
198,
197,
42,
158,
224,
246,
796,
20806,
62,
17143,
7307,
58,
17,
60,
198,
197,
74,
9246,
796,
1511,
13,
22,
1303,
4991,
25,
264,
61,
12,
16,
198,
197,
17618,
62,
1659,
62,
20214,
796,
8576,
628,
197,
2,
32305,
2837,
532,
198,
197,
50,
62,
18747,
796,
2837,
7,
15,
13,
15,
11,
11338,
28,
3064,
13,
15,
11,
13664,
28,
17618,
62,
1659,
62,
20214,
8,
930,
29,
2824,
26,
628,
197,
2,
41216,
2272,
532,
198,
197,
85,
62,
18747,
796,
15690,
90,
43879,
2414,
11,
16,
92,
7,
917,
891,
11,
17618,
62,
1659,
62,
20214,
8,
628,
197,
2,
24061,
262,
2494,
532,
198,
197,
1640,
357,
72,
11,
50,
8,
18872,
230,
27056,
378,
7,
50,
62,
18747,
8,
628,
197,
197,
2,
24061,
262,
2494,
532,
198,
197,
197,
85,
62,
18747,
58,
72,
60,
796,
357,
74,
9246,
9,
36,
27493,
7,
50,
29006,
50,
10,
42,
158,
224,
246,
4008,
198,
197,
437,
628,
197,
2,
7110,
532,
198,
197,
29487,
7,
50,
62,
18747,
11,
85,
62,
18747,
11,
87,
2475,
82,
16193,
15,
13,
15,
11,
3064,
13,
15,
828,
88,
2475,
82,
16193,
15,
13,
15,
11,
1415,
828,
6167,
2625,
85,
25,
412,
796,
29568,
36,
8,
18919,
44,
290,
509,
158,
224,
246,
796,
29568,
42,
158,
224,
246,
8,
357,
76,
44,
8,
4943,
198,
197,
87,
18242,
0,
7203,
7004,
23104,
311,
357,
76,
44,
42501,
10331,
7857,
28,
1507,
8,
198,
197,
2645,
9608,
0,
7203,
32184,
410,
357,
34703,
44,
14,
82,
42501,
10331,
7857,
28,
1507,
8,
198,
437,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
5996,
18213,
5999,
1731,
12,
69,
2623,
67,
12,
1821,
17457,
12,
2079,
68,
18,
12,
5892,
68,
22,
16072,
65,
1878,
6888,
24,
198,
9132,
37811,
198,
21017,
19157,
25,
337,
27353,
290,
24604,
1843,
37892,
4981,
198,
464,
2892,
375,
12,
54,
88,
805,
12,
19400,
2821,
2746,
357,
14326,
34,
2746,
11,
635,
1900,
355,
262,
40686,
2746,
8,
8477,
477,
6197,
291,
27188,
286,
15568,
925,
510,
286,
10411,
850,
41667,
13,
7896,
273,
12765,
953,
15968,
262,
1181,
286,
262,
2104,
7532,
13,
198,
198,
9,
685,
27857,
3727,
449,
11,
370,
56,
10725,
449,
11,
5870,
27746,
31235,
21331,
13,
6177,
3336,
10149,
11335,
3963,
11096,
10892,
1137,
2149,
44069,
2043,
11053,
25,
317,
45838,
2937,
34563,
19164,
3698,
13,
449,
17958,
38637,
13,
17672,
1737,
26,
1065,
25,
3459,
12,
16817,
13,
23899,
25,
838,
13,
27956,
14,
82,
405,
1828,
12,
2078,
2623,
7,
2996,
8,
1795,
26279,
12,
21,
13,
3122,
2389,
25,
1478,
2682,
2091,
405,
8183,
7,
5450,
1378,
12984,
1150,
13,
10782,
8482,
13,
21283,
76,
13,
37373,
13,
9567,
14,
1415,
2682,
2091,
405,
34729,
198,
198,
464,
35582,
2746,
357,
42,
21870,
2746,
8,
286,
477,
6197,
291,
9001,
1426,
896,
326,
27679,
850,
41667,
389,
4795,
13,
198,
19093,
11,
12765,
32305,
357,
273,
1245,
273,
8,
284,
257,
850,
20850,
2482,
287,
691,
3731,
17216,
864,
2458,
284,
15909,
850,
41667,
13,
509,
21870,
2746,
460,
466,
6901,
1111,
3967,
290,
4633,
6788,
22055,
25,
220,
198,
198,
9,
685,
42,
3768,
1044,
360,
7504,
11,
399,
2634,
76,
33077,
402,
11,
7066,
647,
360,
13,
34420,
286,
11992,
12765,
1366,
290,
16200,
4981,
287,
15568,
7268,
850,
41667,
13,
8436,
37074,
13,
19322,
2365,
26,
20,
7,
16,
2599,
24760,
12,
5332,
13,
23899,
25,
838,
13,
940,
2481,
14,
8482,
25257,
2996,
64,
48000,
13,
3122,
2389,
25,
7863,
2548,
49234,
8183,
7,
5450,
1378,
12984,
1150,
13,
10782,
8482,
13,
21283,
76,
13,
37373,
13,
9567,
14,
3270,
2548,
49234,
34729,
628,
220,
220,
198,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
13803,
17,
6814,
4309,
12,
22,
67,
17,
65,
12,
19,
66,
3720,
12,
6469,
344,
12,
4524,
1731,
67,
38219,
10210,
24,
65,
198,
9132,
37811,
198,
21017,
29455,
28810,
1181,
37892,
4981,
198,
198,
13256,
271,
1906,
44,
298,
268,
18967,
14596,
389,
2562,
284,
1833,
11,
475,
484,
17985,
867,
5087,
11,
304,
13,
70,
1539,
262,
4588,
286,
477,
6197,
291,
17199,
13,
1550,
262,
584,
1021,
11,
337,
27353,
14,
3107,
1843,
4981,
389,
6496,
475,
1339,
12,
11423,
357,
392,
1165,
3716,
737,
632,
561,
307,
1049,
611,
356,
714,
3376,
3899,
271,
1906,
44,
298,
268,
18967,
14596,
284,
8006,
262,
4588,
286,
477,
6197,
291,
5087,
13,
220,
198,
198,
15979,
577,
356,
2746,
262,
2494,
720,
85,
23330,
73,
92,
3,
355,
262,
1720,
286,
257,
37892,
4179,
357,
64,
2829,
2746,
286,
262,
2494,
8,
290,
257,
17137,
3381,
326,
5504,
329,
262,
4814,
9001,
25,
198,
198,
13702,
85,
23330,
73,
92,
796,
374,
23330,
73,
32239,
1169,
8326,
59,
9464,
7,
986,
59,
3506,
8,
23330,
73,
92,
13702,
198,
198,
3003,
720,
85,
23330,
73,
92,
3,
43397,
262,
4045,
2494,
357,
41667,
25,
39280,
30300,
3,
44,
14,
2435,
828,
720,
81,
23330,
73,
92,
3,
43397,
262,
37892,
4179,
1312,
13,
68,
1539,
262,
5415,
2494,
286,
11315,
357,
41667,
25,
39280,
30300,
3,
44,
14,
2435,
8,
290,
220,
198,
3,
15,
59,
293,
80,
3467,
1169,
8326,
59,
9464,
7,
986,
59,
3506,
8,
23330,
73,
32239,
293,
80,
352,
3,
357,
41667,
25,
15793,
1203,
8,
318,
257,
1630,
2163,
326,
8477,
262,
4588,
286,
1245,
273,
17745,
13,
220,
198,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
269,
32321,
66,
23,
64,
24,
12,
35195,
67,
12,
2857,
68,
19,
12,
24,
2091,
68,
12,
17,
68,
4349,
65,
44750,
68,
3312,
24,
198,
9132,
37811,
198,
4242,
2,
8444,
8374,
1181,
1630,
2163,
2746,
198,
1858,
318,
257,
3094,
4996,
286,
1180,
1744,
2842,
356,
460,
1382,
262,
39280,
1169,
8326,
59,
9464,
7,
986,
59,
3506,
8,
23330,
73,
92,
3,
1630,
5499,
13,
24199,
11,
340,
1595,
470,
2300,
644,
356,
3853,
11,
355,
890,
355,
340,
3607,
257,
922,
2854,
13,
2102,
11,
1309,
338,
10400,
281,
2126,
326,
356,
481,
32302,
1568,
11,
14811,
257,
28810,
1861,
14991,
2569,
3164,
13,
198,
198,
4242,
2235,
17003,
198,
15979,
577,
281,
27679,
720,
36,
3,
460,
30151,
287,
530,
286,
720,
82,
28,
16,
11,
17,
59,
67,
1747,
11,
59,
11018,
9948,
90,
50,
92,
3,
1744,
4580,
27219,
11,
810,
1123,
4580,
5219,
720,
82,
3,
468,
617,
24543,
2568,
39280,
538,
18217,
261,
23330,
82,
92,
35307,
2773,
4580,
27219,
481,
1085,
284,
3842,
357,
1169,
2694,
284,
3283,
503,
262,
5931,
12737,
11,
981,
1854,
481,
407,
737,
1114,
1123,
4580,
5219,
720,
82,
47113,
1309,
338,
8333,
257,
24543,
2568,
39280,
538,
18217,
261,
23330,
82,
92,
47113,
810,
416,
6770,
39280,
538,
18217,
261,
23330,
16,
92,
28,
15,
3,
26,
356,
7048,
262,
2779,
1181,
468,
262,
9016,
2568,
13,
7406,
11,
11691,
262,
12867,
326,
27679,
720,
36,
3,
318,
287,
4580,
5219,
720,
82,
3,
5679,
257,
685,
33,
5978,
89,
9038,
6082,
16151,
5450,
1378,
268,
13,
31266,
13,
2398,
14,
15466,
14,
33,
5978,
89,
9038,
62,
17080,
3890,
8,
543,
1139,
25,
198,
198,
13702,
79,
23330,
72,
92,
796,
3467,
31944,
90,
16,
18477,
57,
92,
3467,
22355,
277,
23330,
72,
32239,
11201,
59,
9464,
32590,
59,
31361,
59,
538,
18217,
261,
23330,
72,
32239,
3506,
19415,
80,
47003,
90,
72,
28,
16,
11,
17,
11,
59,
67,
1747,
11,
59,
11018,
9948,
90,
50,
11709,
13702,
198,
198,
3003,
720,
79,
23330,
72,
92,
3,
43397,
262,
12867,
326,
27679,
720,
36,
3,
318,
287,
4580,
5219,
720,
72,
28,
16,
11,
17,
11,
59,
67,
1747,
11,
59,
11018,
9948,
90,
50,
92,
47113,
720,
69,
23330,
72,
92,
3,
43397,
257,
1181,
12,
11423,
5766,
720,
69,
23330,
72,
32239,
259,
59,
9464,
58,
15,
11,
16,
59,
3506,
60,
47113,
39280,
31361,
3,
43397,
262,
685,
490,
76,
34743,
12159,
16151,
5450,
1378,
268,
13,
31266,
13,
2398,
14,
15466,
14,
35048,
76,
34743,
62,
31361,
8,
290,
720,
57,
3,
43397,
257,
3487,
1634,
5766,
357,
7174,
262,
685,
7841,
37752,
2163,
16151,
5450,
1378,
268,
13,
31266,
13,
2398,
14,
15466,
14,
7841,
653,
62,
8818,
41052,
14269,
19929,
62,
1326,
3147,
873,
4008,
287,
262,
13905,
11887,
2055,
737,
775,
460,
1064,
720,
57,
3,
1262,
262,
30114,
341,
1099,
286,
28810,
1861,
349,
414,
304,
13,
70,
1539,
220,
39280,
16345,
23330,
82,
92,
79,
23330,
82,
92,
796,
352,
3,
543,
3607,
25,
198,
198,
13702,
57,
796,
3467,
16345,
23330,
82,
28,
16,
92,
61,
31478,
11018,
9948,
90,
50,
11709,
69,
23330,
72,
32239,
11201,
59,
9464,
32590,
59,
31361,
59,
538,
18217,
261,
23330,
72,
32239,
3506,
8,
13702,
198,
198,
4758,
3607,
25,
198,
198,
13702,
79,
23330,
72,
92,
796,
3467,
31944,
90,
69,
23330,
72,
32239,
11201,
59,
9464,
32590,
59,
31361,
59,
538,
18217,
261,
23330,
72,
32239,
3506,
8,
18477,
59,
13812,
7635,
3467,
16345,
23330,
82,
28,
16,
92,
61,
31478,
11018,
9948,
90,
50,
11709,
69,
23330,
72,
32239,
11201,
59,
9464,
32590,
59,
31361,
59,
538,
18217,
261,
23330,
72,
32239,
3506,
8,
32239,
80,
47003,
90,
72,
28,
16,
11,
17,
11,
59,
67,
1747,
11,
59,
11018,
9948,
90,
50,
11709,
13702,
13,
198,
198,
11158,
11,
356,
15124,
262,
12867,
326,
27679,
720,
36,
3,
318,
287,
4580,
5219,
720,
82,
3,
736,
284,
262,
39280,
1169,
8326,
3,
1630,
2163,
416,
14492,
262,
4045,
12867,
326,
262,
10348,
1785,
4325,
11,
304,
13,
70,
1539,
27679,
720,
36,
3,
36745,
12271,
262,
6317,
286,
5353,
13,
775,
760,
611,
39280,
46,
13731,
796,
3467,
9464,
59,
90,
16,
11,
17,
11,
59,
67,
1747,
11,
59,
11018,
9948,
90,
50,
32239,
3506,
59,
92,
47113,
788,
356,
460,
8160,
262,
24637,
39280,
11018,
9948,
90,
32,
32239,
7266,
2617,
27363,
59,
46,
13731,
3,
287,
543,
262,
10348,
1785,
4325,
13,
11259,
39280,
11018,
9948,
90,
32,
92,
47113,
262,
39280,
1169,
8326,
3,
2163,
4329,
25,
198,
198,
13702,
59,
1169,
8326,
28,
59,
16345,
23330,
82,
59,
259,
31478,
11018,
9948,
90,
32,
42535,
79,
23330,
82,
92,
13702,
198,
198,
4242,
2235,
26097,
723,
1672,
2514,
19418,
428,
2126,
11,
2074,
281,
27679,
48582,
416,
257,
33218,
1720,
357,
5661,
318,
257,
2219,
477,
6197,
291,
32702,
1900,
355,
685,
12363,
1891,
30725,
16151,
43468,
260,
31329,
311,
11,
350,
4861,
21331,
11,
25577,
472,
88,
12,
21467,
388,
385,
402,
11,
9077,
402,
11,
390,
1879,
2100,
8873,
18470,
13,
13438,
1042,
286,
7538,
477,
6197,
291,
30725,
286,
39046,
18431,
273,
571,
418,
2645,
39437,
589,
13,
8436,
37074,
13,
2321,
26,
4349,
7,
1821,
2599,
1795,
1983,
12,
1795,
2548,
13,
23899,
25,
940,
13,
940,
2481,
14,
8482,
6200,
28362,
65,
29720,
554,
428,
1339,
11,
11691,
27679,
720,
36,
47113,
543,
318,
48582,
416,
13061,
720,
40,
47113,
460,
2152,
287,
530,
286,
1115,
1744,
4580,
27219,
25,
198,
198,
9,
11593,
9012,
264,
796,
352,
834,
25,
1400,
32305,
720,
50,
3,
318,
5421,
11,
720,
36,
3,
318,
12462,
1088,
287,
4610,
2000,
278,
663,
898,
1597,
357,
8692,
1181,
11,
645,
6317,
8,
198,
9,
11593,
9012,
264,
796,
362,
834,
25,
3834,
23104,
720,
50,
3,
318,
5421,
284,
27679,
720,
36,
47113,
475,
41704,
720,
40,
3,
318,
407,
5421,
357,
260,
2673,
1744,
8,
198,
9,
11593,
9012,
264,
796,
513,
834,
25,
5747,
262,
32305,
720,
50,
3,
290,
41704,
720,
40,
3,
389,
5421,
284,
27679,
720,
36,
3,
357,
3919,
6317,
1744,
8,
628,
198,
15056,
777,
4580,
27219,
357,
392,
511,
10345,
16237,
8,
356,
760,
326,
27679,
720,
36,
3,
460,
691,
36745,
2736,
663,
6317,
287,
4580,
5219,
720,
82,
28,
17,
47113,
4145,
25,
198,
198,
13702,
59,
1169,
8326,
796,
3467,
31944,
90,
69,
23330,
17,
32239,
11201,
59,
9464,
32590,
59,
31361,
59,
538,
18217,
261,
23330,
72,
32239,
3506,
8,
18477,
59,
13812,
7635,
3467,
16345,
23330,
82,
28,
16,
92,
61,
31478,
11018,
9948,
90,
18,
11709,
69,
23330,
82,
32239,
11201,
59,
9464,
32590,
59,
31361,
59,
538,
18217,
261,
23330,
82,
32239,
3506,
38165,
13702,
198,
198,
4242,
2235,
1867,
389,
262,
1181,
12,
11423,
5087,
30,
198,
464,
1181,
12,
11423,
5087,
720,
69,
23330,
72,
32239,
259,
59,
9464,
58,
15,
11,
16,
59,
3506,
60,
3,
1630,
262,
3151,
1799,
286,
257,
4580,
5219,
25,
198,
198,
9,
611,
720,
69,
23330,
59,
7364,
92,
796,
657,
47113,
788,
4580,
5219,
39280,
7364,
3,
460,
11593,
12081,
834,
307,
6492,
198,
9,
611,
720,
69,
23330,
59,
7364,
92,
796,
352,
47113,
788,
4580,
5219,
39280,
7364,
3,
460,
11593,
33770,
834,
307,
6492,
198,
198,
1722,
257,
2746,
263,
11,
345,
460,
3853,
262,
1296,
357,
273,
1988,
8,
326,
720,
69,
23330,
59,
7364,
92,
3,
2753,
13,
2312,
5087,
460,
198,
1350,
900,
284,
257,
2176,
1988,
416,
6770,
357,
44023,
2402,
262,
1181,
8,
393,
460,
307,
973,
284,
6901,
2995,
3917,
351,
1181,
720,
72,
47113,
304,
13,
70,
1539,
884,
355,
12765,
2995,
13,
1114,
1672,
11,
11691,
1181,
720,
72,
3,
2950,
12765,
281,
1245,
273,
27756,
720,
87,
3,
284,
262,
27679,
720,
36,
35307,
554,
428,
1339,
11,
356,
714,
2746,
262,
1181,
12,
11423,
5766,
720,
69,
23330,
72,
92,
3,
355,
25,
198,
198,
13702,
69,
23330,
72,
92,
796,
357,
87,
14,
42,
23330,
72,
30072,
36796,
77,
23330,
72,
11709,
29006,
16,
33747,
87,
14,
42,
23330,
72,
30072,
36796,
77,
23330,
72,
11709,
8,
13702,
198,
198,
3003,
720,
87,
59,
469,
80,
90,
15,
92,
3,
43397,
1245,
273,
20038,
11,
720,
42,
23330,
72,
32239,
469,
80,
90,
15,
92,
3,
43397,
257,
12765,
6937,
290,
720,
77,
23330,
72,
32239,
469,
80,
90,
15,
92,
3,
43397,
257,
12765,
1502,
11507,
13,
220,
198,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
860,
1485,
2231,
67,
3023,
12,
69,
35126,
12,
19,
68,
3829,
12,
24,
2327,
68,
12,
64,
19,
17896,
9031,
25707,
9945,
198,
31,
21653,
37297,
62,
17143,
7307,
32217,
10080,
13,
24011,
500,
3419,
466,
5932,
198,
197,
198,
197,
9132,
37811,
198,
197,
59,
58,
40,
59,
60,
29568,
198,
197,
197,
16424,
7,
11122,
1304,
7,
15,
25,
3064,
4008,
198,
197,
8,
357,
34703,
44,
8,
220,
509,
29568,
198,
197,
197,
16424,
7,
11122,
1304,
7,
16,
25,
16,
25,
3064,
4008,
198,
197,
8,
357,
76,
44,
8,
220,
18074,
113,
158,
224,
224,
29568,
198,
197,
197,
16424,
7,
11122,
1304,
7,
15,
13,
8298,
25,
15,
13,
16,
25,
3064,
4008,
198,
197,
8,
357,
41,
14,
43132,
8,
18074,
113,
158,
224,
225,
29568,
198,
197,
197,
16424,
7,
11122,
1304,
7,
15,
13,
8298,
25,
15,
13,
16,
25,
3064,
4008,
198,
197,
8,
357,
41,
14,
43132,
8,
220,
198,
197,
37811,
198,
437,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
767,
1129,
37688,
5036,
12,
18,
891,
21,
12,
19,
68,
4310,
12,
324,
4309,
12,
6469,
15187,
68,
18,
67,
15,
65,
20,
68,
198,
27471,
628,
197,
2,
651,
314,
532,
198,
197,
40,
158,
224,
240,
796,
37297,
62,
17143,
7307,
58,
16,
60,
198,
197,
42,
67,
796,
37297,
62,
17143,
7307,
58,
17,
60,
198,
197,
139,
113,
158,
224,
224,
796,
357,
5258,
44,
62,
17143,
7307,
58,
18,
12962,
14,
3064,
198,
197,
139,
113,
158,
224,
225,
796,
357,
5258,
44,
62,
17143,
7307,
58,
19,
12962,
14,
3064,
198,
197,
198,
197,
2,
9058,
1080,
532,
198,
197,
49,
796,
807,
13,
33638,
220,
197,
197,
197,
2,
4991,
25,
449,
14,
43132,
12,
42,
198,
197,
51,
796,
38549,
13,
1314,
1343,
1679,
13,
15,
220,
197,
2,
4991,
25,
509,
198,
197,
26638,
796,
352,
14,
49,
9,
51,
628,
197,
2,
9058,
12765,
10007,
329,
1181,
513,
532,
198,
197,
77,
796,
362,
13,
15,
198,
197,
198,
197,
2,
9058,
2568,
7177,
532,
198,
197,
139,
113,
62,
18747,
796,
685,
198,
197,
197,
15,
13,
15,
220,
197,
26,
1303,
1181,
352,
357,
3137,
412,
8,
198,
197,
197,
12,
139,
113,
158,
224,
224,
220,
197,
26,
1303,
1181,
362,
357,
36,
5421,
284,
311,
11,
475,
645,
314,
8,
198,
197,
197,
12,
139,
113,
158,
224,
225,
220,
197,
26,
1303,
1181,
513,
357,
36,
5421,
284,
314,
8,
198,
197,
11208,
628,
197,
2,
24061,
370,
532,
198,
197,
54,
62,
18747,
796,
1033,
12195,
12,
26638,
9,
139,
113,
62,
18747,
8,
628,
197,
2,
1309,
338,
24061,
262,
1181,
12,
11423,
5766,
7177,
532,
198,
197,
69,
62,
18747,
796,
685,
198,
197,
197,
16,
13,
15,
2162,
1303,
1181,
352,
220,
198,
197,
197,
16,
13,
15,
2162,
1303,
1181,
362,
198,
197,
197,
19510,
40,
158,
224,
240,
14,
42,
67,
8,
61,
7,
77,
4008,
29006,
16,
33747,
40,
158,
224,
240,
14,
42,
67,
8,
61,
7,
77,
4008,
198,
197,
11208,
628,
197,
2,
24061,
262,
7377,
116,
7885,
532,
198,
197,
24055,
5219,
62,
18747,
796,
277,
62,
18747,
15885,
54,
62,
18747,
26,
198,
197,
57,
796,
2160,
7,
24055,
5219,
62,
18747,
8,
198,
197,
79,
62,
18747,
796,
357,
16,
14,
57,
27493,
24055,
5219,
62,
18747,
198,
197,
138,
116,
796,
279,
62,
18747,
58,
17,
60,
628,
197,
2,
905,
532,
198,
197,
4480,
62,
23705,
282,
3419,
466,
198,
197,
197,
35235,
7203,
138,
116,
796,
29568,
138,
116,
8,
4943,
198,
197,
437,
198,
437,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
352,
67,
19,
67,
1899,
3270,
12,
20,
65,
3720,
12,
3559,
10210,
12,
330,
1558,
12,
891,
17,
7252,
43526,
721,
324,
198,
4480,
62,
23705,
282,
3419,
466,
628,
197,
2,
41216,
532,
198,
197,
47728,
240,
106,
796,
513,
198,
197,
5219,
62,
11487,
796,
15690,
90,
7149,
11,
17,
92,
7,
917,
891,
11,
47728,
240,
106,
11,
19,
8,
198,
197,
198,
197,
2,
48040,
262,
1181,
7177,
532,
198,
197,
1640,
264,
18872,
230,
352,
25,
47728,
240,
106,
628,
197,
197,
5219,
62,
11487,
58,
82,
11,
16,
60,
796,
264,
198,
197,
197,
5219,
62,
11487,
58,
82,
11,
17,
60,
796,
277,
62,
18747,
58,
82,
60,
198,
197,
197,
5219,
62,
11487,
58,
82,
11,
18,
60,
796,
370,
62,
18747,
58,
82,
60,
198,
197,
197,
5219,
62,
11487,
58,
82,
11,
19,
60,
796,
279,
62,
18747,
58,
82,
60,
198,
197,
437,
628,
197,
2,
13639,
532,
198,
197,
25677,
62,
808,
796,
357,
14692,
82,
2430,
69,
158,
224,
249,
2430,
54,
158,
224,
249,
2430,
79,
158,
224,
249,
8973,
8,
198,
197,
37784,
62,
11487,
7,
5219,
62,
11487,
26,
25677,
28,
25677,
62,
808,
8,
198,
197,
198,
437,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
288,
3510,
771,
1415,
12,
64,
20,
67,
18,
12,
2231,
64,
24,
12,
24,
67,
3559,
12,
2548,
17896,
3695,
3720,
65,
15,
66,
22,
198,
1616,
628,
197,
2,
651,
20806,
11507,
3815,
532,
198,
197,
36,
796,
352,
13,
15,
1303,
4991,
25,
18919,
44,
198,
197,
42,
158,
224,
246,
796,
642,
220,
197,
2,
4991,
25,
47676,
198,
197,
74,
9246,
796,
1511,
13,
22,
1303,
4991,
25,
264,
61,
12,
16,
198,
197,
17618,
62,
1659,
62,
20214,
796,
8576,
628,
197,
2,
32305,
2837,
532,
198,
197,
50,
62,
18747,
796,
2837,
7,
15,
13,
15,
11,
11338,
28,
3064,
13,
15,
11,
13664,
28,
17618,
62,
1659,
62,
20214,
8,
930,
29,
2824,
26,
628,
197,
2,
41216,
2272,
532,
198,
197,
85,
62,
18747,
796,
15690,
90,
43879,
2414,
11,
16,
92,
7,
917,
891,
11,
17618,
62,
1659,
62,
20214,
8,
628,
197,
2,
24061,
262,
2494,
532,
198,
197,
1640,
357,
72,
11,
50,
8,
18872,
230,
27056,
378,
7,
50,
62,
18747,
8,
628,
197,
197,
2,
24061,
262,
2494,
532,
198,
197,
197,
85,
62,
18747,
58,
72,
60,
796,
357,
74,
9246,
9,
36,
27493,
7,
50,
29006,
50,
10,
42,
158,
224,
246,
4008,
9,
138,
116,
198,
197,
437,
628,
197,
2,
7110,
532,
198,
197,
29487,
7,
50,
62,
18747,
11,
85,
62,
18747,
11,
87,
2475,
82,
16193,
15,
13,
15,
11,
3064,
13,
15,
828,
88,
2475,
82,
16193,
15,
13,
15,
11,
1415,
828,
6167,
2625,
85,
25,
314,
796,
29568,
40,
158,
224,
240,
8,
47676,
290,
509,
67,
796,
29568,
42,
67,
8,
357,
76,
44,
8,
4943,
198,
197,
87,
18242,
0,
7203,
7004,
23104,
311,
357,
76,
44,
42501,
10331,
7857,
28,
1507,
8,
198,
197,
2645,
9608,
0,
7203,
32184,
410,
357,
34703,
44,
14,
82,
42501,
10331,
7857,
28,
1507,
8,
198,
197,
198,
437,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
288,
2327,
3104,
66,
20,
67,
12,
1433,
19881,
12,
19,
39357,
12,
4089,
6420,
12,
15,
1350,
2996,
67,
5237,
65,
2623,
66,
198,
9132,
37811,
198,
21017,
21293,
290,
1482,
11539,
198,
198,
818,
428,
19143,
356,
25,
198,
198,
16,
13,
6013,
276,
2829,
4981,
286,
27679,
18967,
14596,
1262,
262,
3899,
271,
1906,
44,
298,
268,
3164,
198,
16,
13,
16745,
262,
7531,
10838,
10238,
517,
3716,
4981,
286,
477,
6197,
291,
9001,
357,
1169,
3049,
1630,
11701,
326,
356,
4750,
4271,
8,
198,
16,
13,
16745,
4050,
28810,
9001,
4981,
284,
29308,
477,
6197,
291,
9001,
198,
198,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
5996,
67,
19,
397,
2780,
12,
24,
44169,
12,
19,
16344,
24,
12,
330,
3312,
12,
2091,
2548,
69,
9945,
39667,
66,
19,
198,
9132,
37811,
198,
21017,
7406,
3862,
198,
198,
9,
1867,
546,
3294,
47294,
689,
30,
198,
9,
8314,
262,
28810,
1181,
2746,
670,
30,
198,
9,
1374,
466,
356,
3494,
777,
22303,
4981,
287,
257,
28462,
5236,
3781,
17952,
30,
198,
198,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
642,
3559,
32869,
1731,
12,
18,
2860,
12,
19,
69,
6052,
12,
6420,
65,
15,
12,
68,
20809,
1433,
3104,
3682,
3609,
198,
10962,
5189,
15842,
7,
7839,
2625,
8582,
241,
248,
31209,
495,
3806,
1370,
1600,
33793,
28,
7942,
11,
6795,
28,
20,
11,
7263,
28,
7942,
8,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
9130,
64,
3829,
36626,
12,
65,
19,
21101,
12,
19,
67,
2624,
12,
1878,
15,
67,
12,
17,
69,
2919,
3559,
2414,
18741,
66,
198,
6494,
37811,
198,
27,
12048,
29,
198,
197,
1003,
41216,
532,
198,
197,
7785,
2665,
796,
657,
26,
198,
197,
7785,
8371,
796,
657,
26,
198,
197,
7785,
6352,
549,
5458,
796,
657,
26,
198,
197,
7785,
24697,
796,
3188,
13,
22766,
17563,
273,
3237,
10786,
71,
18,
11,
289,
20,
11,
289,
21,
24036,
198,
197,
198,
197,
1003,
1388,
9052,
532,
198,
197,
1640,
357,
7785,
1312,
28,
15,
26,
1312,
1279,
24697,
13,
13664,
26,
1312,
29577,
1391,
198,
197,
220,
220,
220,
220,
198,
197,
197,
7785,
13639,
796,
24697,
58,
72,
11208,
198,
197,
220,
220,
220,
1401,
2420,
796,
13639,
13,
5083,
8206,
26,
198,
197,
220,
220,
220,
1401,
2656,
796,
13639,
13,
1136,
33682,
7203,
5239,
12,
14986,
15341,
198,
197,
220,
220,
220,
611,
357,
14986,
24844,
9242,
8,
1391,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
198,
197,
197,
197,
1003,
12793,
2656,
13639,
2420,
198,
197,
220,
220,
220,
220,
220,
220,
220,
13639,
13,
2617,
33682,
7203,
5239,
12,
14986,
1600,
2420,
1776,
198,
197,
220,
220,
220,
1782,
2073,
1391,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
198,
197,
197,
197,
1003,
40177,
351,
2656,
2420,
878,
4375,
2665,
1271,
198,
197,
220,
220,
220,
220,
220,
220,
220,
2420,
796,
13639,
13,
1136,
33682,
7203,
5239,
12,
14986,
15341,
198,
197,
220,
220,
220,
1782,
198,
197,
198,
197,
220,
220,
220,
1401,
47622,
796,
366,
8172,
198,
197,
220,
220,
220,
5078,
357,
25677,
13,
12985,
5376,
8,
1391,
198,
197,
220,
220,
220,
220,
220,
220,
220,
1339,
705,
39,
18,
10354,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2665,
15853,
352,
26,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
47622,
796,
2665,
1343,
366,
526,
26,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
8371,
796,
657,
26,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2270,
26,
198,
197,
220,
220,
220,
220,
220,
220,
220,
1339,
705,
39,
20,
10354,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
8371,
15853,
352,
26,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
47622,
796,
2665,
1343,
366,
526,
1343,
8371,
26,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2270,
26,
198,
197,
197,
197,
7442,
705,
39,
21,
10354,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6352,
549,
5458,
15853,
352,
26,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
47622,
796,
2665,
1343,
366,
526,
1343,
8371,
1343,
366,
526,
1343,
6352,
549,
5458,
26,
198,
197,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2270,
26,
198,
197,
220,
220,
220,
1782,
198,
197,
197,
1003,
4296,
262,
13639,
2420,
220,
198,
197,
197,
25677,
13,
5083,
8206,
796,
47622,
1343,
366,
366,
1343,
2420,
26,
198,
197,
19629,
198,
3556,
12048,
29,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
275,
3104,
3829,
2934,
15,
12,
4531,
1954,
12,
1157,
721,
12,
2327,
4309,
12,
18,
16616,
65,
1860,
4310,
69,
4521,
198,
6494,
37811,
198,
27,
7635,
29,
198,
12417,
1391,
198,
220,
220,
220,
3509,
12,
10394,
25,
807,
1899,
8416,
26,
198,
220,
220,
220,
9647,
25,
4317,
26525,
198,
220,
220,
220,
10330,
25,
8295,
26,
198,
220,
220,
220,
10369,
12,
17989,
25,
366,
14350,
2069,
11,
937,
24912,
8172,
198,
92,
198,
198,
64,
1391,
198,
220,
220,
220,
3124,
25,
4171,
26,
198,
220,
220,
220,
2420,
12,
12501,
6944,
25,
4844,
26,
198,
92,
198,
3556,
7635,
29,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
27551,
12,
2388,
12,
2388,
12,
2388,
12,
8269,
18005,
198,
6489,
3843,
46,
62,
31190,
23680,
62,
51,
2662,
43,
62,
37815,
15365,
796,
37227,
198,
58,
10378,
82,
60,
198,
3646,
1747,
796,
366,
6420,
64,
20,
15630,
1860,
12,
2816,
67,
22,
12,
20,
66,
1878,
12,
24,
68,
15,
65,
12,
31211,
67,
23,
3270,
66,
3609,
1795,
1,
198,
3646,
9390,
10080,
796,
366,
22,
69,
24,
3023,
67,
5036,
12,
65,
5332,
68,
12,
19,
487,
21,
12,
65,
38380,
12,
67,
3609,
23539,
1954,
4846,
64,
23,
1,
198,
35700,
51,
2977,
796,
366,
2919,
11231,
23,
67,
17,
12,
15,
67,
15,
66,
12,
3553,
2920,
12,
324,
13331,
12,
23,
64,
17,
330,
15187,
1878,
15,
67,
1,
198,
198,
58,
5589,
265,
60,
198,
3646,
1747,
796,
366,
93,
16,
13,
1495,
13,
23,
1,
198,
3646,
9390,
10080,
796,
366,
93,
15,
13,
22,
13,
2682,
1,
198,
35700,
51,
2977,
796,
366,
93,
16,
13,
18,
13,
16,
1,
198,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
27551,
12,
2388,
12,
2388,
12,
2388,
12,
8269,
34215,
198,
6489,
3843,
46,
62,
10725,
5064,
6465,
62,
51,
2662,
43,
62,
37815,
15365,
796,
37227,
198,
2,
770,
2393,
318,
4572,
12,
27568,
532,
12857,
340,
3264,
318,
407,
13030,
198,
198,
73,
43640,
62,
9641,
796,
366,
16,
13,
22,
13,
17,
1,
198,
805,
8409,
62,
18982,
796,
366,
17,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
23839,
3646,
9390,
35,
278,
316,
73,
274,
11907,
198,
10378,
82,
796,
14631,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
23,
68,
1878,
24,
69,
16,
65,
2920,
21895,
2624,
64,
19,
66,
487,
18,
69,
2623,
64,
16,
67,
24,
7012,
24,
1954,
65,
1415,
64,
40271,
1,
198,
12303,
312,
796,
366,
21,
68,
38205,
66,
4761,
12,
2996,
3682,
12,
1238,
3134,
12,
22,
22980,
12,
3682,
22136,
66,
2425,
5333,
1120,
1,
198,
9641,
796,
366,
16,
13,
16,
13,
19,
1,
198,
198,
30109,
10378,
82,
13,
48003,
11907,
198,
10378,
82,
796,
14631,
14993,
451,
2348,
29230,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
1878,
24,
1959,
2996,
21855,
1270,
29331,
1415,
3720,
2791,
69,
3365,
330,
65,
2713,
6814,
4349,
66,
3980,
1433,
65,
20,
69,
1,
198,
12303,
312,
796,
366,
3720,
68,
21,
64,
18,
397,
12,
20,
7568,
65,
12,
33580,
67,
12,
45418,
67,
12,
22,
2548,
64,
17,
64,
24,
2548,
64,
15,
68,
1,
198,
9641,
796,
366,
18,
13,
18,
13,
18,
1,
198,
198,
30109,
10378,
82,
13,
28100,
33637,
11907,
198,
12303,
312,
796,
366,
15,
47984,
5705,
66,
20,
12,
67,
14686,
12,
3682,
68,
21,
12,
23,
67,
2078,
12,
891,
1065,
67,
6485,
40401,
69,
1,
198,
198,
30109,
10378,
82,
13,
8001,
37199,
11907,
198,
12303,
312,
796,
366,
3980,
69,
1828,
67,
4761,
12,
16344,
21,
67,
12,
4089,
69,
16,
12,
2999,
69,
15,
12,
2919,
1860,
66,
2931,
2998,
66,
2091,
1,
198,
198,
30109,
10378,
82,
13,
14881,
2414,
11907,
198,
12303,
312,
796,
366,
17,
64,
15,
69,
2598,
68,
18,
12,
21,
66,
5999,
12,
2816,
17457,
12,
5774,
68,
19,
12,
65,
37950,
67,
4089,
17457,
20,
69,
1,
198,
198,
30109,
10378,
82,
13,
33,
13344,
17,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
1129,
64,
2327,
24669,
64,
6469,
68,
24940,
487,
4349,
15630,
1558,
64,
18,
64,
2598,
65,
3388,
891,
2327,
21652,
64,
17,
1,
198,
12303,
312,
796,
366,
21,
68,
2682,
65,
26704,
12,
19,
397,
67,
12,
46096,
66,
12,
65,
3459,
69,
12,
38339,
66,
2623,
7568,
64,
22,
64,
15,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
23,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
34,
18131,
11907,
198,
10378,
82,
796,
14631,
34,
18131,
62,
73,
297,
1600,
366,
5216,
669,
1600,
366,
38,
8019,
62,
73,
297,
1600,
366,
18172,
1600,
366,
25835,
25404,
1600,
366,
47,
14208,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
67,
15,
65,
18,
69,
23,
65,
19,
324,
1433,
21101,
15,
64,
1959,
3459,
66,
3134,
3459,
27720,
64,
20,
68,
21,
64,
1558,
65,
21,
65,
16,
65,
1,
198,
12303,
312,
796,
366,
19707,
69,
18,
44705,
12,
17,
64,
2682,
12,
47785,
66,
12,
65,
15377,
12,
23,
66,
2718,
69,
4089,
3695,
17430,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
20,
1,
198,
198,
30109,
10378,
82,
13,
34,
18131,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
33,
13344,
17,
62,
73,
297,
1600,
366,
23252,
11250,
62,
73,
297,
1600,
366,
11146,
6030,
17,
62,
73,
297,
1600,
366,
38,
8019,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
43,
57,
46,
62,
73,
297,
1600,
366,
25835,
25404,
1600,
366,
47,
844,
805,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
2302,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
55,
13287,
62,
73,
297,
1600,
366,
57,
8019,
62,
73,
297,
1600,
366,
8019,
11134,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
19,
65,
23,
3270,
64,
21315,
65,
1954,
5607,
64,
22,
64,
46872,
64,
3070,
31911,
68,
3510,
2623,
65,
9945,
1558,
65,
12993,
17,
1,
198,
12303,
312,
796,
366,
23,
2682,
1954,
67,
5332,
12,
65,
15,
1453,
12,
3365,
1507,
12,
12865,
22,
12,
65,
5066,
535,
1350,
65,
46660,
64,
1,
198,
9641,
796,
366,
16,
13,
1433,
13,
16,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
35491,
37766,
14055,
11907,
198,
10378,
82,
796,
14631,
40073,
1600,
366,
14993,
451,
2348,
29230,
1600,
366,
50,
29572,
3163,
20477,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
69,
2079,
6469,
891,
36189,
68,
1129,
65,
15,
68,
20,
66,
22,
64,
4089,
66,
21,
68,
2425,
1453,
37747,
66,
15,
69,
4790,
64,
6052,
1,
198,
12303,
312,
796,
366,
67,
15277,
67,
17,
68,
21,
12,
65,
1731,
66,
12,
1157,
68,
24,
12,
64,
17,
64,
18,
12,
17,
64,
17,
3609,
17,
9945,
66,
344,
19,
1,
198,
9641,
796,
366,
16,
13,
1065,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
29238,
5189,
23907,
2977,
11907,
198,
10378,
82,
796,
14631,
35491,
37766,
14055,
1600,
366,
14993,
451,
2348,
29230,
1600,
366,
14402,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
19881,
4089,
13331,
2231,
64,
15,
64,
19,
344,
68,
25710,
2934,
4089,
67,
19,
66,
1415,
5237,
1350,
2075,
27712,
65,
24,
64,
16,
1,
198,
12303,
312,
796,
366,
24,
68,
39647,
69,
23,
64,
12,
24,
64,
5607,
12,
3682,
67,
20,
12,
64,
24,
69,
16,
12,
344,
21,
65,
16072,
1314,
68,
17,
66,
15,
1,
198,
9641,
796,
366,
15,
13,
16,
13,
17,
1,
198,
198,
30109,
10378,
82,
13,
10258,
27054,
6880,
11907,
198,
10378,
82,
796,
14631,
10258,
31431,
1600,
366,
5216,
669,
1600,
366,
13715,
12727,
49601,
1600,
366,
43,
2821,
273,
1600,
366,
29531,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
20,
65,
22,
67,
17,
64,
23,
65,
4310,
66,
3104,
7568,
9945,
344,
45326,
68,
24,
3553,
64,
18,
65,
20,
535,
19,
6814,
1795,
65,
486,
1,
198,
12303,
312,
796,
366,
2327,
67,
21,
64,
40022,
12,
64,
32118,
12,
49934,
68,
12,
64,
21,
18213,
12,
16,
67,
5237,
65,
16315,
69,
17,
69,
19,
1,
198,
9641,
796,
366,
18,
13,
1558,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
10258,
31431,
11907,
198,
10378,
82,
796,
14631,
13715,
12727,
49601,
1600,
366,
29531,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
40839,
5036,
1731,
67,
5999,
68,
19,
64,
20,
19881,
20,
16072,
28256,
486,
64,
33638,
344,
15,
67,
16,
7252,
2327,
43239,
1,
198,
12303,
312,
796,
366,
18,
6814,
21601,
69,
22,
12,
3270,
5705,
12,
20,
64,
1899,
12,
65,
23,
64,
21,
12,
66,
11848,
2791,
66,
15,
65,
20370,
69,
1,
198,
9641,
796,
366,
15,
13,
1157,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
5216,
669,
11907,
198,
10378,
82,
796,
14631,
10258,
31431,
1600,
366,
13715,
12727,
49601,
1600,
366,
3041,
39344,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
38547,
65,
15,
276,
22,
65,
23,
65,
23,
2548,
7252,
21,
6888,
15,
64,
5774,
64,
324,
69,
16,
11848,
24,
1765,
16243,
344,
1821,
1,
198,
12303,
312,
796,
366,
20,
3609,
3270,
2931,
20,
12,
24,
64,
24,
65,
12,
3270,
5036,
12,
64,
24669,
12,
21,
69,
24,
1485,
66,
20356,
48630,
1,
198,
9641,
796,
366,
15,
13,
1065,
13,
23,
1,
198,
198,
30109,
10378,
82,
13,
40073,
11907,
198,
10378,
82,
796,
14631,
14881,
2414,
1600,
366,
35,
689,
1600,
366,
13856,
320,
863,
25876,
1600,
366,
20344,
6169,
1600,
366,
9492,
5275,
18274,
4487,
1600,
366,
25835,
38,
270,
17,
1600,
366,
25835,
25404,
1600,
366,
14993,
451,
2348,
29230,
1600,
366,
9704,
2902,
1600,
366,
44,
8899,
1600,
366,
47,
10025,
1600,
366,
18557,
69,
1600,
366,
2200,
6489,
1600,
366,
29531,
1600,
366,
37596,
1600,
366,
32634,
1634,
1600,
366,
2484,
1144,
3163,
20477,
1600,
366,
50,
11603,
1600,
366,
50,
29572,
3163,
20477,
1600,
366,
48346,
1600,
366,
14402,
1600,
366,
52,
27586,
82,
1600,
366,
3118,
291,
1098,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
2598,
66,
2718,
65,
3510,
2623,
15630,
4051,
1878,
330,
20,
66,
46900,
67,
17,
67,
2999,
65,
26704,
27371,
67,
2996,
6469,
1,
198,
12303,
312,
796,
366,
2682,
6814,
17,
21652,
12,
65,
1959,
65,
12,
20,
66,
1485,
12,
65,
15,
66,
22,
12,
330,
69,
1558,
1495,
1485,
67,
1238,
1,
198,
9641,
796,
366,
18,
13,
3901,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
7293,
5329,
15514,
43,
11127,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
25835,
25404,
8973,
198,
12303,
312,
796,
366,
68,
2791,
68,
405,
3695,
12,
22,
25150,
12,
4051,
1120,
12,
5892,
69,
22,
12,
1314,
69,
17457,
24,
3553,
69,
17,
3609,
1,
198,
198,
30109,
10378,
82,
13,
4264,
454,
11907,
198,
10378,
82,
796,
14631,
45442,
3163,
20477,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
24,
69,
33618,
2231,
67,
24,
2682,
17896,
39101,
276,
324,
33459,
2598,
18213,
1795,
9945,
67,
16,
69,
15,
68,
1350,
64,
22,
1,
198,
12303,
312,
796,
366,
67,
2548,
66,
11785,
64,
12,
3134,
4869,
12,
4310,
66,
21,
12,
65,
2079,
68,
12,
2425,
67,
17279,
65,
21,
68,
2079,
16,
1,
198,
9641,
796,
366,
15,
13,
20,
13,
22,
1,
198,
198,
30109,
10378,
82,
13,
34,
2433,
684,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
21626,
5036,
2548,
397,
69,
4304,
67,
2780,
46572,
68,
17,
69,
2231,
3980,
1350,
17457,
23349,
7252,
34125,
68,
1314,
1,
198,
12303,
312,
796,
366,
64,
23,
535,
20,
65,
15,
68,
12,
15,
487,
64,
12,
20,
324,
19,
12,
23,
66,
1415,
12,
24,
1954,
67,
18,
1453,
1558,
2327,
69,
1,
198,
9641,
796,
366,
19,
13,
16,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
6601,
17614,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
535,
2154,
65,
1558,
23195,
43193,
1765,
2857,
15630,
24,
68,
20,
69,
23,
1433,
2327,
4089,
16,
69,
1485,
344,
64,
20,
66,
23,
1,
198,
12303,
312,
796,
366,
24,
64,
4846,
17,
69,
24,
66,
12,
21,
7568,
15,
12,
1157,
68,
24,
12,
15,
68,
20,
67,
12,
66,
49489,
65,
23,
65,
20,
1453,
23,
64,
1,
198,
9641,
796,
366,
16,
13,
24,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
6601,
44909,
942,
11907,
198,
10378,
82,
796,
14631,
40073,
1600,
366,
9492,
5275,
18274,
4487,
1600,
366,
35422,
1068,
5216,
26448,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
18,
6814,
891,
2816,
1954,
1860,
17,
68,
22,
3388,
47984,
1954,
2996,
28857,
69,
40761,
487,
20,
69,
32568,
66,
22,
67,
1,
198,
12303,
312,
796,
366,
39570,
276,
65,
18,
65,
12,
2079,
535,
12,
20,
68,
2425,
12,
23,
67,
17,
67,
12,
23,
1959,
21101,
15,
64,
24,
66,
5036,
23,
1,
198,
9641,
796,
366,
15,
13,
1507,
13,
1157,
1,
198,
198,
30109,
10378,
82,
13,
6601,
11395,
9492,
32186,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
65,
16072,
1157,
5774,
65,
3720,
2078,
4846,
2718,
13331,
15,
891,
21,
67,
2598,
2623,
1765,
67,
5036,
3388,
2713,
66,
17457,
21,
1,
198,
12303,
312,
796,
366,
68,
17,
67,
17279,
64,
15,
12,
24,
67,
2078,
12,
4051,
1350,
12,
1795,
69,
15,
12,
15801,
65,
1350,
1238,
64,
44578,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
35,
689,
11907,
198,
10378,
82,
796,
14631,
18557,
69,
8973,
198,
12303,
312,
796,
366,
671,
17,
6888,
2154,
12,
2548,
6420,
12,
3270,
2231,
12,
4089,
21855,
12,
17896,
15,
42691,
2624,
68,
3312,
64,
1,
198,
198,
30109,
10378,
82,
13,
13856,
320,
863,
25876,
11907,
198,
10378,
82,
796,
14631,
44,
8899,
8973,
198,
12303,
312,
796,
366,
23,
11848,
1415,
1821,
69,
12,
2857,
2327,
12,
41734,
65,
12,
64,
19,
397,
12,
29416,
65,
4089,
7568,
19,
67,
397,
1,
198,
198,
30109,
10378,
82,
13,
20344,
6169,
11907,
198,
10378,
82,
796,
14631,
29531,
1600,
366,
32634,
1634,
1600,
366,
50,
11603,
8973,
198,
12303,
312,
796,
366,
23,
7012,
4531,
68,
1238,
12,
26279,
66,
12,
20,
65,
21,
69,
12,
24,
27277,
12,
24,
2857,
22544,
1238,
1453,
16,
65,
1,
198,
198,
30109,
10378,
82,
13,
23579,
10100,
11627,
5736,
11907,
198,
10378,
82,
796,
14631,
25835,
38,
270,
17,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
65,
22186,
2682,
67,
1507,
3865,
67,
2154,
2078,
4531,
65,
28896,
66,
36243,
64,
21,
68,
1507,
486,
2998,
5607,
69,
15,
65,
1,
198,
12303,
312,
796,
366,
487,
3077,
21526,
12,
19,
891,
22,
12,
20,
3682,
67,
12,
11848,
65,
22,
12,
66,
2931,
67,
18,
64,
3720,
16072,
3609,
1,
198,
9641,
796,
366,
15,
13,
23,
13,
21,
1,
198,
198,
30109,
10378,
82,
13,
10002,
82,
11907,
198,
10378,
82,
796,
14631,
28100,
33637,
1600,
366,
25835,
34,
21886,
1600,
366,
26245,
29046,
8973,
198,
12303,
312,
796,
366,
69,
3559,
64,
28872,
69,
12,
66,
1238,
64,
12,
19,
324,
19,
12,
23,
4309,
66,
12,
69,
21,
65,
1065,
2857,
4521,
16,
66,
21,
1,
198,
198,
30109,
10378,
82,
13,
8419,
26254,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
18,
69,
18,
64,
1495,
486,
13331,
22,
24940,
68,
24,
65,
35549,
68,
15,
69,
22,
64,
39118,
66,
37680,
68,
23,
1828,
11848,
21,
67,
1,
198,
12303,
312,
796,
366,
20,
3609,
44103,
9945,
12,
11848,
67,
16,
12,
20,
68,
5066,
12,
65,
3553,
67,
12,
67,
1731,
64,
5333,
7568,
405,
69,
20,
1,
198,
9641,
796,
366,
17,
13,
17,
13,
18,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
3109,
8071,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
3609,
1485,
16072,
15630,
22,
397,
23,
69,
1433,
65,
2919,
20,
3134,
1959,
65,
28669,
891,
15,
66,
27260,
7252,
2682,
5892,
1,
198,
12303,
312,
796,
366,
17,
68,
21,
22186,
1314,
12,
5999,
65,
20,
12,
49542,
65,
12,
11848,
1899,
12,
2075,
66,
2999,
64,
2327,
64,
1264,
1,
198,
9641,
796,
366,
17,
13,
19,
13,
19,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
5777,
7378,
7156,
11907,
198,
10378,
82,
796,
14631,
5777,
7378,
7156,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
65,
3553,
68,
18,
330,
1350,
1828,
69,
23,
34137,
65,
19,
65,
20,
487,
2791,
64,
4524,
39647,
1558,
5036,
16,
64,
24,
535,
23,
1,
198,
12303,
312,
796,
366,
66,
23,
4761,
1270,
67,
15,
12,
64,
24403,
12,
1157,
68,
24,
12,
16,
65,
3559,
12,
67,
22,
68,
1350,
19,
68,
2425,
2154,
64,
1,
198,
9641,
796,
366,
15,
13,
19,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
5777,
7378,
7156,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
33,
13344,
17,
62,
73,
297,
1600,
366,
11146,
6030,
17,
62,
73,
297,
1600,
366,
30214,
33,
19830,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
43,
10067,
62,
73,
297,
1600,
366,
25835,
25404,
1600,
366,
46,
1130,
62,
73,
297,
1600,
366,
11505,
31127,
62,
73,
297,
1600,
366,
18257,
385,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
57,
8019,
62,
73,
297,
1600,
366,
8019,
562,
62,
73,
297,
1600,
366,
8019,
16344,
74,
62,
64,
330,
62,
73,
297,
1600,
366,
8019,
20867,
41907,
62,
73,
297,
1600,
366,
87,
18897,
62,
73,
297,
1600,
366,
87,
22980,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
67,
23,
64,
38907,
46589,
68,
1270,
3324,
330,
34808,
65,
1120,
66,
2999,
1558,
7568,
67,
3134,
69,
2481,
67,
16,
68,
20,
69,
1,
198,
12303,
312,
796,
366,
65,
1828,
64,
21,
69,
6469,
12,
17,
69,
2996,
12,
1120,
3510,
12,
64,
20,
65,
17,
12,
35273,
397,
3559,
21855,
19,
68,
20,
1,
198,
9641,
796,
366,
19,
13,
19,
13,
15,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
8979,
9399,
11907,
198,
10378,
82,
796,
14631,
47,
10025,
1600,
366,
39618,
1600,
366,
52,
27586,
82,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
1795,
771,
49259,
30273,
64,
20,
9945,
17896,
4309,
12993,
36809,
1959,
28771,
66,
2327,
344,
25816,
69,
3609,
1,
198,
12303,
312,
796,
366,
3553,
4531,
68,
17,
68,
24,
12,
67,
22,
21855,
12,
20,
15630,
22,
12,
1795,
3104,
12,
17,
66,
21,
69,
3609,
24,
65,
3865,
2920,
1,
198,
9641,
796,
366,
16,
13,
1485,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
13715,
12727,
49601,
11907,
198,
10378,
82,
796,
14631,
48346,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
27326,
65,
16344,
344,
4134,
5705,
66,
20,
66,
7568,
1433,
64,
324,
66,
30610,
7252,
20,
1860,
16072,
20,
34741,
535,
1,
198,
12303,
312,
796,
366,
4310,
66,
2780,
66,
1558,
12,
19,
64,
22,
67,
12,
20,
6888,
17,
12,
3829,
66,
20,
12,
3720,
65,
3695,
4846,
1453,
64,
6052,
1,
198,
9641,
796,
366,
15,
13,
23,
13,
19,
1,
198,
198,
30109,
10378,
82,
13,
23252,
11250,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
33,
13344,
17,
62,
73,
297,
1600,
366,
3109,
8071,
62,
73,
297,
1600,
366,
11146,
6030,
17,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
25835,
12303,
312,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
57,
8019,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
2481,
891,
67,
1129,
15801,
64,
37864,
1238,
64,
1507,
4521,
1314,
6814,
21,
67,
18,
67,
3312,
10210,
22,
69,
21,
1453,
3070,
1,
198,
12303,
312,
796,
366,
64,
18,
69,
24,
2078,
3609,
12,
22,
65,
1821,
12,
1120,
2414,
12,
40022,
65,
12,
3104,
1878,
2670,
2857,
67,
2682,
65,
1,
198,
9641,
796,
366,
17,
13,
1485,
13,
6052,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
26227,
889,
11907,
198,
10378,
82,
796,
14631,
18557,
69,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
23,
29626,
67,
39132,
3559,
23815,
69,
1860,
18,
1765,
38431,
67,
4521,
66,
24,
2075,
21101,
32568,
3609,
4761,
64,
23,
1,
198,
12303,
312,
796,
366,
3270,
2078,
3324,
4761,
12,
15,
64,
1238,
12,
20,
64,
2670,
12,
65,
6659,
65,
12,
1485,
2791,
38905,
1765,
19,
66,
15,
1,
198,
9641,
796,
366,
15,
13,
19,
13,
17,
1,
198,
198,
30109,
10378,
82,
13,
11146,
6030,
17,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
33,
13344,
17,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
57,
8019,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
5774,
1765,
50055,
4051,
67,
23,
721,
16,
64,
4846,
67,
19,
64,
4304,
2623,
17457,
3553,
64,
22,
30995,
1860,
68,
18,
891,
24,
1,
198,
12303,
312,
796,
366,
67,
22,
68,
49351,
69,
15,
12,
64,
21,
3132,
12,
3270,
3459,
12,
19881,
2682,
12,
5036,
26780,
5892,
65,
12993,
67,
22,
1,
198,
9641,
796,
366,
17,
13,
940,
13,
19,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
30214,
33,
19830,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
7252,
18,
27301,
66,
17,
7012,
23,
32869,
68,
1954,
66,
21,
66,
23,
7012,
23,
64,
19,
69,
22,
3388,
67,
20,
67,
22,
68,
19,
69,
6420,
1,
198,
12303,
312,
796,
366,
2816,
6052,
2078,
1765,
12,
6659,
69,
24,
12,
38605,
67,
12,
6052,
1795,
12,
2934,
49803,
64,
3459,
66,
5999,
66,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
940,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
8763,
24160,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
25835,
4743,
85,
358,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
66,
21471,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
42528,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
55,
7274,
1689,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
55,
25192,
81,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
4349,
67,
17,
67,
5036,
23,
68,
36993,
69,
17457,
4524,
68,
22,
64,
23,
3682,
12993,
21,
67,
1485,
67,
23,
64,
17,
69,
2231,
17896,
486,
1,
198,
12303,
312,
796,
366,
15,
37466,
65,
5333,
68,
12,
1238,
2091,
12,
20,
535,
17,
12,
64,
2414,
64,
12,
3324,
66,
15,
69,
21,
66,
2931,
65,
4531,
1,
198,
9641,
796,
366,
18,
13,
18,
13,
21,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
10761,
11907,
198,
10378,
82,
796,
14631,
14881,
2414,
1600,
366,
13856,
320,
863,
25876,
1600,
366,
10761,
62,
73,
297,
1600,
366,
40717,
1600,
366,
40386,
1600,
366,
25835,
25404,
1600,
366,
14993,
451,
2348,
29230,
1600,
366,
47,
10025,
1600,
366,
18557,
69,
1600,
366,
29531,
1600,
366,
6892,
420,
21156,
37,
727,
364,
1600,
366,
32634,
1634,
1600,
366,
50,
11603,
1600,
366,
14402,
1600,
366,
52,
27586,
82,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
19,
64,
45598,
9945,
34825,
64,
3609,
15,
69,
1350,
65,
18,
1453,
43916,
2934,
16,
1878,
11848,
1415,
330,
43240,
64,
16,
1,
198,
12303,
312,
796,
366,
2078,
65,
23,
67,
18,
6888,
12,
21855,
20,
69,
12,
3270,
67,
24,
12,
1795,
3829,
12,
19881,
9945,
67,
21,
67,
2998,
64,
4869,
1,
198,
9641,
796,
366,
15,
13,
5066,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
10761,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
33,
13344,
17,
62,
73,
297,
1600,
366,
34,
18131,
62,
73,
297,
1600,
366,
5777,
7378,
7156,
62,
73,
297,
1600,
366,
23252,
11250,
62,
73,
297,
1600,
366,
8763,
24160,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
41,
22071,
17483,
2127,
62,
73,
297,
1600,
366,
25835,
25404,
1600,
366,
25835,
83,
733,
62,
73,
297,
1600,
366,
47,
844,
805,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
48,
83,
20,
14881,
62,
73,
297,
1600,
366,
57,
8019,
62,
73,
297,
1600,
366,
8019,
11134,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
7252,
1828,
68,
16,
1453,
24,
68,
22,
1828,
69,
16,
6814,
24839,
1765,
2091,
20167,
7568,
19,
66,
16,
64,
1765,
21,
66,
17,
10210,
1,
198,
12303,
312,
796,
366,
67,
17,
66,
4790,
2934,
18,
12,
69,
48365,
12,
20,
29173,
12,
64,
33808,
12,
2998,
16,
68,
20,
65,
18742,
7012,
24,
1,
198,
9641,
796,
366,
15,
13,
5066,
13,
16,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
10082,
15748,
15522,
873,
11907,
198,
10378,
82,
796,
14631,
8419,
26254,
62,
73,
297,
1600,
366,
29993,
33637,
1600,
366,
14993,
451,
2348,
29230,
1600,
366,
45442,
3163,
20477,
1600,
366,
44909,
3163,
20477,
1600,
366,
51,
2977,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
3365,
15630,
7568,
20,
1765,
66,
43526,
65,
2919,
20,
68,
3365,
67,
3865,
66,
1485,
5774,
11645,
2078,
1860,
22,
36625,
66,
1,
198,
12303,
312,
796,
366,
20,
66,
1065,
4309,
64,
17,
12,
20,
69,
2091,
12,
3980,
19881,
12,
4521,
66,
24,
12,
3270,
68,
22,
32148,
65,
3559,
2075,
1,
198,
9641,
796,
366,
15,
13,
19,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
3855,
5239,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
7293,
5329,
15514,
43,
11127,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
25835,
4749,
85,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
55,
5805,
17,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
24,
65,
48891,
4089,
15498,
22,
19881,
2998,
19,
67,
1415,
2934,
4531,
69,
24,
67,
2718,
6888,
1731,
64,
16,
64,
15,
65,
45438,
1,
198,
12303,
312,
796,
366,
3695,
65,
2816,
35378,
12,
3609,
891,
12,
3365,
67,
19,
12,
4521,
16,
66,
12,
3324,
64,
2001,
2682,
4089,
65,
16,
1,
198,
9641,
796,
366,
15,
13,
2481,
13,
15,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
38,
8019,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
3855,
5239,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
25835,
487,
72,
62,
73,
297,
1600,
366,
25835,
4749,
85,
62,
73,
297,
1600,
366,
25835,
14948,
62,
73,
297,
1600,
366,
5662,
2200,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
57,
8019,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
64,
2624,
67,
43864,
330,
17,
66,
24,
3134,
69,
18,
11275,
23,
64,
6659,
67,
23,
2078,
1878,
66,
22,
2670,
66,
23,
2548,
64,
3312,
1,
198,
12303,
312,
796,
366,
3324,
3510,
65,
1860,
68,
12,
25764,
67,
12,
3270,
17896,
12,
24,
3609,
23,
12,
3459,
68,
344,
24,
4790,
22042,
67,
1,
198,
9641,
796,
366,
17,
13,
3104,
13,
18,
10,
17,
1,
198,
198,
30109,
10378,
82,
13,
18172,
11907,
198,
10378,
82,
796,
14631,
5216,
669,
1600,
366,
14993,
451,
2348,
29230,
1600,
366,
26705,
32755,
776,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
16,
66,
20,
64,
23,
3559,
19104,
1954,
1350,
64,
4304,
13331,
18781,
67,
2920,
68,
6052,
7252,
19,
34626,
66,
4790,
16072,
17,
1,
198,
12303,
312,
796,
366,
64,
17,
17457,
1270,
1765,
12,
68,
28676,
12,
4051,
3132,
12,
64,
24,
1129,
12,
1507,
5066,
68,
397,
48645,
2414,
1,
198,
9641,
796,
366,
16,
13,
16,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
37065,
578,
17,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
33535,
19881,
1821,
17896,
397,
940,
4790,
22260,
3023,
7252,
15,
7568,
19,
21855,
2931,
17,
69,
37128,
68,
21844,
16,
1,
198,
12303,
312,
796,
366,
18,
65,
24294,
67,
5332,
12,
1731,
3070,
12,
20,
66,
2481,
12,
24,
66,
2481,
12,
16,
68,
16,
69,
15,
535,
1495,
37856,
1,
198,
9641,
796,
366,
16,
13,
18,
13,
1415,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
38,
2442,
84,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
4310,
11848,
44675,
67,
1157,
4349,
68,
3553,
68,
1731,
5705,
66,
18,
67,
16,
65,
4310,
68,
1129,
40427,
65,
46660,
21855,
17,
1,
198,
12303,
312,
796,
366,
3682,
68,
17,
6814,
15,
68,
12,
23,
25870,
12,
19,
68,
4869,
12,
15630,
1731,
12,
3270,
29022,
324,
6888,
15,
5036,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
17,
1,
198,
198,
30109,
10378,
82,
13,
40717,
11907,
198,
10378,
82,
796,
14631,
14881,
2414,
1600,
366,
35,
689,
1600,
366,
818,
72,
8979,
1600,
366,
11187,
2667,
1600,
366,
44,
3077,
51,
6561,
1600,
366,
26245,
29046,
1600,
366,
50,
11603,
1600,
366,
4261,
3792,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
15,
13331,
41820,
1828,
5036,
19,
65,
20,
16817,
2075,
65,
2670,
66,
4531,
19,
66,
3829,
67,
1878,
20,
69,
344,
2091,
2682,
64,
1,
198,
12303,
312,
796,
366,
10210,
18,
1765,
27037,
12,
2327,
21855,
12,
1120,
5824,
12,
24,
1959,
65,
12,
40486,
64,
4846,
69,
324,
21,
69,
18,
1,
198,
9641,
796,
366,
15,
13,
24,
13,
1558,
1,
198,
198,
30109,
10378,
82,
13,
13587,
69,
48230,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
34,
18131,
62,
73,
297,
1600,
366,
23252,
11250,
62,
73,
297,
1600,
366,
11146,
6030,
17,
62,
73,
297,
1600,
366,
38,
8019,
62,
73,
297,
1600,
366,
37065,
578,
17,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
25835,
487,
72,
62,
73,
297,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
18741,
330,
69,
2931,
19,
67,
14656,
34626,
68,
1795,
1453,
16,
17896,
19,
15630,
3312,
721,
23,
2327,
68,
33690,
64,
18,
1,
198,
12303,
312,
796,
366,
17,
68,
4304,
69,
21,
66,
17,
12,
64,
37452,
12,
4309,
67,
19,
12,
3865,
66,
16,
12,
1238,
324,
5036,
19,
2934,
20,
2791,
1,
198,
9641,
796,
366,
17,
13,
23,
13,
16,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
49926,
364,
6519,
11907,
198,
10378,
82,
796,
14631,
14402,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
23,
67,
41647,
67,
20,
65,
23,
1065,
1821,
16072,
23,
68,
37397,
1954,
4521,
1270,
2075,
2425,
65,
7568,
32883,
2718,
65,
24,
1,
198,
12303,
312,
796,
366,
2857,
67,
17,
276,
17,
65,
12,
2623,
2934,
12,
1120,
12993,
12,
19881,
5774,
12,
2920,
66,
17,
12993,
19,
65,
23,
65,
6420,
1,
198,
9641,
796,
366,
15,
13,
15,
13,
19,
1,
198,
198,
30109,
10378,
82,
13,
38197,
5239,
43,
270,
1691,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
17,
65,
2998,
23,
65,
20,
64,
47007,
66,
21,
66,
15,
34107,
66,
39761,
940,
67,
5892,
1453,
23,
66,
21,
69,
27790,
67,
23721,
1,
198,
12303,
312,
796,
366,
330,
16315,
17,
64,
23,
12,
69,
19,
65,
18,
12,
19,
65,
5036,
12,
7012,
1828,
12,
1878,
20,
65,
5892,
10210,
18,
397,
17,
1,
198,
9641,
796,
366,
15,
13,
24,
13,
18,
1,
198,
198,
30109,
10378,
82,
13,
40,
4503,
2373,
495,
11907,
198,
10378,
82,
796,
14631,
11187,
2667,
1600,
366,
29531,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
69,
22,
1350,
44468,
3270,
397,
3312,
1860,
66,
4089,
2414,
2078,
67,
18,
64,
24,
67,
535,
3865,
69,
21,
13331,
21,
34801,
64,
1,
198,
12303,
312,
796,
366,
65,
20,
69,
6659,
68,
3270,
12,
35916,
17,
12,
19,
67,
2624,
12,
65,
16,
69,
15,
12,
66,
2998,
16,
65,
46821,
19881,
4531,
1,
198,
9641,
796,
366,
15,
13,
17,
13,
17,
1,
198,
198,
30109,
10378,
82,
13,
818,
72,
8979,
11907,
198,
10378,
82,
796,
14631,
14402,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
2931,
23,
68,
19,
67,
17,
66,
20,
29626,
1731,
66,
24,
2481,
69,
24,
69,
4089,
2857,
28857,
69,
17,
324,
4531,
68,
29159,
65,
23,
1,
198,
12303,
312,
796,
366,
5999,
68,
23,
330,
1485,
12,
1495,
69,
23,
12,
4310,
2598,
12,
23,
64,
2414,
12,
64,
24,
69,
17,
65,
1828,
2682,
2078,
69,
1,
198,
9641,
796,
366,
15,
13,
20,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
9492,
5275,
18274,
4487,
11907,
198,
10378,
82,
796,
14631,
9704,
2902,
8973,
198,
12303,
312,
796,
366,
65,
3324,
68,
15,
64,
19,
66,
12,
67,
33551,
12,
3553,
64,
15,
12,
3829,
68,
23,
12,
23,
9945,
1495,
64,
1983,
64,
16102,
1,
198,
198,
30109,
10378,
82,
13,
818,
4399,
24629,
2733,
11907,
198,
10378,
82,
796,
14631,
14402,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
64,
22,
24970,
66,
15,
330,
67,
23,
68,
5237,
69,
16,
330,
2425,
324,
1731,
67,
20,
9945,
3559,
69,
20,
69,
1129,
69,
18,
66,
2996,
1,
198,
12303,
312,
796,
366,
2327,
5774,
68,
19782,
12,
18,
69,
4531,
12,
3682,
67,
15,
12,
3829,
1453,
12,
1415,
31552,
721,
1983,
14686,
1,
198,
9641,
796,
366,
15,
13,
16,
13,
17,
1,
198,
198,
30109,
10378,
82,
13,
23820,
20310,
34184,
1187,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
22,
16344,
2598,
16344,
19,
487,
3559,
16072,
28688,
1314,
69,
23,
68,
22,
2414,
66,
15,
69,
33394,
65,
5999,
66,
2920,
24309,
1,
198,
12303,
312,
796,
366,
5892,
67,
31495,
10210,
12,
3388,
405,
12,
1821,
65,
22,
12,
24,
2919,
17,
12,
66,
21,
1350,
2920,
69,
33535,
65,
21,
1,
198,
9641,
796,
366,
15,
13,
16,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
29993,
33637,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
13331,
21,
27800,
64,
2598,
3388,
69,
20,
68,
47202,
67,
49641,
7568,
2548,
26050,
1453,
48555,
69,
17457,
2598,
68,
20,
1,
198,
12303,
312,
796,
366,
66,
23,
68,
16,
6814,
2919,
12,
22,
1828,
66,
12,
1120,
1821,
12,
24,
276,
24,
12,
22,
9945,
15,
17896,
48000,
3132,
68,
1,
198,
9641,
796,
366,
16,
13,
19,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
37787,
39317,
11627,
5736,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
64,
18,
69,
1731,
40179,
66,
2481,
69,
20,
65,
1350,
24,
67,
17,
64,
45722,
69,
3865,
67,
10210,
3365,
31496,
21855,
2078,
3980,
1,
198,
12303,
312,
796,
366,
23,
2078,
33438,
940,
12,
2857,
3720,
12,
20,
28645,
12,
23,
4309,
68,
12,
3070,
68,
43690,
12993,
36453,
67,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
41,
3069,
36918,
11799,
11907,
198,
10378,
82,
796,
14631,
36698,
4972,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
39305,
24,
44230,
64,
22,
6888,
1238,
4309,
64,
49150,
64,
8054,
69,
22,
13331,
2791,
22567,
69,
4846,
35638,
68,
16,
1,
198,
12303,
312,
796,
366,
46589,
65,
18,
65,
10210,
12,
18,
66,
5332,
12,
19,
65,
16,
69,
12,
65,
15711,
12,
69,
1485,
344,
15,
1765,
2624,
940,
1,
198,
9641,
796,
366,
16,
13,
19,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
40386,
11907,
198,
10378,
82,
796,
14631,
35,
689,
1600,
366,
44,
8899,
1600,
366,
47,
945,
364,
1600,
366,
3118,
291,
1098,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
36928,
2791,
1795,
65,
25061,
4763,
17,
64,
43637,
69,
24038,
330,
22,
65,
2920,
4310,
68,
1270,
28933,
64,
2718,
1,
198,
12303,
312,
796,
366,
43950,
66,
3312,
64,
15,
12,
2934,
21,
64,
12,
4051,
397,
12,
64,
23726,
12,
66,
23,
65,
16,
12993,
3720,
66,
2934,
21,
1,
198,
9641,
796,
366,
15,
13,
2481,
13,
17,
1,
198,
198,
30109,
10378,
82,
13,
41,
22071,
17483,
2127,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
65,
44994,
28362,
4349,
66,
21,
68,
2791,
2414,
18638,
891,
65,
17,
68,
5237,
10210,
1731,
13331,
20,
66,
2857,
68,
19,
7012,
1,
198,
12303,
312,
796,
366,
64,
330,
1860,
65,
2999,
12,
31360,
69,
12,
3270,
67,
21,
12,
65,
24,
1507,
12,
44980,
68,
21,
891,
19,
69,
19881,
23,
1,
198,
9641,
796,
366,
17,
13,
16,
13,
17,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
22396,
78,
11907,
198,
10378,
82,
796,
14631,
14881,
2414,
1600,
366,
11187,
2667,
1600,
366,
13152,
1600,
366,
37046,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
2998,
21101,
3559,
24369,
64,
23,
29416,
2919,
64,
3324,
18742,
1959,
1157,
64,
21,
28857,
15630,
21,
66,
2998,
17,
66,
22,
1,
198,
12303,
312,
796,
366,
68,
20,
68,
15,
17896,
16,
65,
12,
3023,
1795,
12,
4051,
15630,
12,
24,
31020,
12,
64,
324,
486,
66,
1954,
24136,
67,
1,
198,
9641,
796,
366,
15,
13,
23,
13,
19,
1,
198,
198,
30109,
10378,
82,
13,
43,
10067,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
69,
5237,
1120,
65,
1433,
3459,
16,
324,
69,
15,
32642,
33781,
2920,
69,
7012,
2780,
65,
1157,
5333,
330,
67,
330,
23,
66,
1,
198,
12303,
312,
796,
366,
66,
16,
66,
20,
1765,
67,
15,
12,
3134,
4761,
12,
4349,
1270,
12,
64,
47582,
12,
67,
20,
16072,
3609,
19,
64,
40401,
67,
1,
198,
9641,
796,
366,
18,
13,
3064,
13,
16,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
43,
57,
46,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
68,
20,
65,
44675,
65,
12993,
42250,
66,
20,
68,
21719,
3553,
2718,
67,
17,
344,
25870,
276,
3720,
16,
65,
4531,
1350,
21,
1,
198,
12303,
312,
796,
366,
1860,
19,
65,
4089,
18,
64,
12,
69,
15,
68,
20,
12,
20,
69,
23,
67,
12,
64,
16,
65,
22,
12,
18741,
67,
19,
64,
20,
21855,
16,
330,
1,
198,
9641,
796,
366,
17,
13,
940,
13,
16,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
14772,
49568,
13290,
654,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
69,
1954,
2816,
48528,
67,
3134,
3695,
64,
23188,
671,
1314,
49234,
65,
22,
330,
2857,
64,
19,
487,
5607,
38565,
1,
198,
12303,
312,
796,
366,
65,
24,
2414,
13331,
24,
69,
12,
15,
31911,
12,
20,
65,
3553,
12,
64,
20,
66,
17,
12,
67,
18,
18213,
2996,
69,
1821,
1821,
69,
1,
198,
9641,
796,
366,
16,
13,
18,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
26302,
87,
1958,
11907,
198,
10378,
82,
796,
14631,
26227,
889,
1600,
366,
9492,
5275,
18274,
4487,
1600,
366,
14772,
49568,
13290,
654,
1600,
366,
14155,
305,
33637,
1600,
366,
9704,
2902,
1600,
366,
18557,
69,
1600,
366,
39618,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
64,
23,
69,
19,
69,
26050,
65,
21,
13331,
18,
66,
18,
66,
19,
69,
16,
324,
2860,
3695,
64,
21,
2481,
65,
1485,
64,
35638,
65,
344,
1,
198,
12303,
312,
796,
366,
1954,
69,
1350,
16,
66,
16,
12,
18,
69,
2857,
12,
2816,
9945,
12,
65,
1314,
69,
12,
3388,
67,
22,
721,
2481,
64,
33400,
1,
198,
9641,
796,
366,
15,
13,
1314,
13,
24,
1,
198,
198,
30109,
10378,
82,
13,
25835,
34,
21886,
11907,
198,
10378,
82,
796,
14631,
25835,
34,
21886,
62,
73,
297,
1600,
366,
44,
8590,
5049,
34,
2246,
861,
82,
62,
73,
297,
8973,
198,
12303,
312,
796,
366,
65,
20233,
2624,
66,
17,
12,
64,
18,
68,
22,
12,
1120,
66,
23,
12,
1795,
10210,
12,
17,
67,
2623,
9945,
21101,
16344,
2481,
1,
198,
198,
30109,
10378,
82,
13,
25835,
34,
21886,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
25835,
5432,
39,
17,
62,
73,
297,
1600,
366,
25835,
25404,
1600,
366,
44,
3077,
51,
6561,
62,
73,
297,
1600,
366,
57,
8019,
62,
73,
297,
1600,
366,
77,
456,
29281,
17,
62,
73,
297,
8973,
198,
12303,
312,
796,
366,
2934,
330,
24,
65,
2857,
12,
23,
15630,
22,
12,
3270,
3312,
12,
64,
15,
5036,
12,
2327,
330,
3980,
17896,
5705,
66,
15,
1,
198,
198,
30109,
10378,
82,
13,
25835,
38,
270,
17,
11907,
198,
10378,
82,
796,
14631,
14881,
2414,
1600,
366,
26245,
29046,
1600,
366,
18557,
69,
1600,
366,
37596,
8973,
198,
12303,
312,
796,
366,
4304,
69,
23,
4051,
1120,
12,
20,
24909,
12,
20,
65,
20,
64,
12,
23,
68,
7252,
12,
49721,
324,
40350,
65,
42117,
1,
198,
198,
30109,
10378,
82,
13,
25835,
5432,
39,
17,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
25835,
25404,
1600,
366,
44,
3077,
51,
6561,
62,
73,
297,
8973,
198,
12303,
312,
796,
366,
27728,
1433,
65,
20,
64,
12,
65,
24,
397,
12,
49489,
69,
12,
24,
2091,
66,
12,
276,
324,
1507,
4521,
7568,
64,
23,
1,
198,
198,
30109,
10378,
82,
13,
25835,
25404,
11907,
198,
12303,
312,
796,
366,
23,
69,
28771,
6814,
18,
12,
2327,
3553,
12,
3980,
2425,
12,
65,
20,
487,
12,
21855,
23,
2624,
66,
5607,
21101,
9945,
1,
198,
198,
30109,
10378,
82,
13,
25835,
487,
72,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
15,
65,
19,
64,
20,
67,
4869,
69,
18,
68,
20,
2167,
64,
22,
67,
487,
3720,
2091,
6052,
68,
2931,
7568,
66,
17,
67,
23,
4524,
24369,
1,
198,
12303,
312,
796,
366,
68,
24,
69,
25096,
66,
21,
12,
5892,
67,
17,
12,
20,
65,
2996,
12,
23,
64,
2791,
12,
39071,
2481,
17896,
16,
65,
31503,
1,
198,
9641,
796,
366,
18,
13,
17,
13,
17,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
25835,
70,
29609,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
25835,
70,
6024,
62,
18224,
62,
73,
297,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
27720,
1485,
66,
6469,
64,
3270,
66,
1065,
3023,
2327,
66,
15,
3134,
66,
17,
65,
34583,
16072,
5333,
12993,
20,
23055,
3609,
1,
198,
12303,
312,
796,
366,
67,
3559,
405,
330,
18,
12,
68,
1828,
66,
12,
3553,
3559,
12,
24,
17827,
12,
66,
27696,
68,
2670,
9945,
16,
68,
19,
1,
198,
9641,
796,
366,
16,
13,
23,
13,
22,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
25835,
4743,
85,
358,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
1157,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
55,
2302,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
3324,
2670,
69,
23,
2718,
67,
2414,
2857,
1821,
2327,
4846,
64,
2425,
67,
1129,
276,
486,
16344,
2919,
67,
21,
69,
3980,
19881,
1,
198,
12303,
312,
796,
366,
22,
68,
4304,
64,
15,
67,
19,
12,
69,
18,
66,
22,
12,
4310,
2481,
12,
23,
26050,
12,
23,
67,
4846,
1453,
276,
15,
69,
1959,
1,
198,
9641,
796,
366,
16,
13,
18,
13,
15,
10,
18,
1,
198,
198,
30109,
10378,
82,
13,
25835,
70,
6024,
62,
18224,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
66,
2091,
2718,
1433,
68,
3510,
2623,
3104,
3553,
44550,
68,
27367,
344,
21,
64,
3388,
1453,
2931,
2231,
64,
21,
9945,
24,
1,
198,
12303,
312,
796,
366,
22,
2860,
20,
7012,
18,
12,
17,
69,
3459,
12,
48057,
68,
12,
24,
10210,
20,
12,
69,
5999,
65,
23,
64,
2816,
69,
22,
65,
23,
1,
198,
9641,
796,
366,
16,
13,
3682,
13,
15,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
25835,
4749,
85,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
3682,
65,
48200,
2231,
67,
2154,
64,
21,
1129,
69,
3312,
18,
64,
22,
6814,
2931,
18,
67,
33438,
721,
23,
68,
1314,
68,
39761,
1,
198,
12303,
312,
796,
366,
5824,
344,
19,
69,
4051,
12,
24,
64,
21,
66,
12,
3553,
2780,
12,
24,
66,
16,
66,
12,
69,
24,
66,
22,
25667,
64,
2231,
3132,
1,
198,
9641,
796,
366,
16,
13,
1433,
13,
16,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
25835,
14948,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
24,
66,
22515,
1270,
19881,
15,
14822,
67,
3510,
68,
1314,
68,
15,
16344,
12993,
17,
65,
4521,
2623,
68,
3695,
66,
11848,
67,
4790,
1,
198,
12303,
312,
796,
366,
19,
65,
17,
69,
3132,
64,
18,
12,
24,
68,
535,
12,
40486,
66,
12,
65,
34229,
12,
65,
2718,
1270,
17896,
65,
4790,
68,
24,
1,
198,
9641,
796,
366,
17,
13,
2327,
13,
15,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
43,
2889,
21370,
70,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
14208,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
21287,
74,
62,
79,
844,
29325,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
1495,
67,
20,
68,
21,
65,
19,
1765,
2327,
29796,
1485,
558,
16,
66,
3134,
67,
21,
64,
5774,
1415,
1238,
19881,
6888,
20,
1983,
1,
198,
12303,
312,
796,
366,
46351,
66,
6420,
21855,
12,
20,
1860,
21,
12,
3270,
1860,
12,
23,
68,
23,
66,
12,
27712,
68,
4524,
36243,
67,
4531,
1,
198,
9641,
796,
366,
17,
13,
4309,
13,
19,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
25835,
83,
733,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
41,
22071,
17483,
2127,
62,
73,
297,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
57,
8019,
62,
73,
297,
1600,
366,
57,
19282,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
23601,
68,
28676,
64,
4763,
1485,
69,
3865,
69,
4089,
1453,
33394,
67,
33400,
66,
18,
3077,
2718,
66,
23,
397,
24,
1,
198,
12303,
312,
796,
366,
4531,
49641,
68,
4531,
12,
24,
65,
3070,
12,
3270,
3312,
12,
330,
7012,
12,
65,
1238,
69,
39380,
10210,
23,
2078,
1,
198,
9641,
796,
366,
19,
13,
18,
13,
15,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
25835,
12303,
312,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
22,
69,
18,
891,
721,
41322,
2091,
43950,
9945,
23,
4309,
69,
23,
65,
18,
15630,
18,
66,
16,
67,
17,
65,
15,
64,
15,
397,
15,
2791,
1,
198,
12303,
312,
796,
366,
2548,
64,
27712,
65,
18,
12,
2934,
4089,
12,
20,
67,
17,
65,
12,
64,
20,
67,
18,
12,
1415,
10210,
5892,
1314,
68,
9879,
1,
198,
9641,
796,
366,
17,
13,
2623,
13,
15,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
14993,
451,
2348,
29230,
11907,
198,
10378,
82,
796,
14631,
25835,
25404,
1600,
366,
8019,
39806,
81,
696,
14453,
62,
73,
297,
8973,
198,
12303,
312,
796,
366,
2718,
68,
17,
68,
3510,
67,
12,
69,
4531,
67,
12,
20,
2670,
67,
12,
65,
19,
1453,
12,
23,
2548,
69,
535,
535,
24,
66,
23,
68,
1,
198,
198,
30109,
10378,
82,
13,
11187,
16870,
24629,
2733,
11907,
198,
10378,
82,
796,
14631,
35491,
37766,
14055,
1600,
366,
29238,
5189,
23907,
2977,
1600,
366,
23579,
10100,
11627,
5736,
1600,
366,
818,
4399,
24629,
2733,
1600,
366,
23820,
20310,
34184,
1187,
1600,
366,
14993,
451,
2348,
29230,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
68,
3553,
1507,
64,
405,
1878,
15,
397,
24,
38219,
22515,
64,
15,
2670,
2078,
2624,
66,
23,
49234,
66,
4524,
2075,
66,
16,
1,
198,
12303,
312,
796,
366,
17,
397,
18,
64,
18,
330,
12,
1878,
3901,
12,
20,
65,
1120,
12,
7252,
3070,
12,
3324,
3720,
22544,
3609,
34427,
1,
198,
9641,
796,
366,
15,
13,
18,
13,
21,
1,
198,
198,
30109,
10378,
82,
13,
11187,
2667,
11907,
198,
12303,
312,
796,
366,
3980,
1860,
65,
27037,
12,
23,
3553,
65,
12,
4051,
68,
16,
12,
65,
5999,
67,
12,
9945,
19,
67,
3365,
9945,
2816,
3104,
1,
198,
198,
30109,
10378,
82,
13,
43,
2821,
273,
11907,
198,
10378,
82,
796,
14631,
14881,
2414,
1600,
366,
34,
18131,
1600,
366,
5216,
669,
1600,
366,
35,
689,
1600,
366,
5777,
7378,
7156,
1600,
366,
8979,
9399,
1600,
366,
22396,
78,
1600,
366,
14772,
49568,
13290,
654,
1600,
366,
29531,
1600,
366,
39618,
1600,
366,
49,
21370,
70,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
6659,
64,
19,
16344,
17,
66,
47448,
7012,
49234,
5036,
721,
5332,
68,
19,
24940,
69,
2623,
66,
22,
64,
3980,
1899,
26007,
1,
198,
12303,
312,
796,
366,
3609,
23,
67,
4051,
66,
17,
12,
22,
535,
67,
12,
3270,
3312,
12,
24,
67,
4304,
12,
5237,
16072,
4089,
2718,
65,
20,
15630,
1,
198,
9641,
796,
366,
18,
13,
15,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
14155,
305,
33637,
11907,
198,
10378,
82,
796,
14631,
9704,
2902,
1600,
366,
29531,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
18,
67,
18,
68,
24,
2999,
65,
3132,
22337,
64,
1983,
23601,
67,
15,
19881,
405,
67,
21,
330,
2231,
27033,
1899,
2481,
12993,
1,
198,
12303,
312,
796,
366,
1129,
1415,
1860,
17,
69,
12,
6659,
66,
21,
12,
20,
69,
10210,
12,
5774,
1129,
12,
21,
67,
20,
66,
4846,
940,
487,
2931,
1,
198,
9641,
796,
366,
15,
13,
20,
13,
24,
1,
198,
198,
30109,
10378,
82,
13,
9704,
2902,
11907,
198,
10378,
82,
796,
14631,
14881,
2414,
8973,
198,
12303,
312,
796,
366,
67,
21,
69,
19,
32128,
68,
12,
64,
891,
20,
12,
31654,
64,
12,
4846,
66,
16,
12,
24,
66,
44698,
34626,
31980,
64,
1,
198,
198,
30109,
10378,
82,
13,
44,
3077,
51,
6561,
11907,
198,
10378,
82,
796,
14631,
35,
689,
1600,
366,
44,
3077,
51,
6561,
62,
73,
297,
1600,
366,
29531,
1600,
366,
50,
11603,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
16,
66,
2548,
68,
4349,
66,
18,
67,
2919,
891,
24403,
1795,
5237,
1765,
344,
671,
15,
68,
3510,
344,
16072,
4846,
5036,
1,
198,
12303,
312,
796,
366,
22,
2670,
1350,
11785,
12,
1350,
64,
23,
12,
20,
23756,
12,
2079,
1485,
12,
535,
2154,
68,
22,
69,
2718,
2623,
67,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
18,
1,
198,
198,
30109,
10378,
82,
13,
44,
3077,
51,
6561,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
25835,
25404,
8973,
198,
12303,
312,
796,
366,
66,
23,
487,
67,
24,
66,
18,
12,
26073,
67,
12,
3365,
3901,
12,
65,
3695,
68,
12,
2919,
1558,
67,
22,
18781,
13331,
16,
1,
198,
198,
30109,
10378,
82,
13,
5308,
13846,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
68,
36260,
1860,
1453,
68,
21,
69,
24,
69,
9945,
2231,
4349,
344,
45432,
64,
3510,
69,
4051,
9945,
67,
12865,
22995,
69,
1,
198,
12303,
312,
796,
366,
39506,
16344,
66,
1860,
12,
1495,
3559,
12,
20,
6814,
17,
12,
65,
15,
69,
18,
12,
23,
66,
4521,
66,
1270,
2996,
1485,
68,
1,
198,
9641,
796,
366,
15,
13,
18,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
13152,
11907,
198,
10378,
82,
796,
14631,
14155,
305,
33637,
1600,
366,
14402,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
2425,
64,
4051,
397,
67,
940,
31495,
66,
486,
69,
16,
65,
4521,
65,
5705,
721,
18182,
67,
2075,
68,
40675,
276,
3365,
1,
198,
12303,
312,
796,
366,
68,
4531,
69,
22,
67,
1065,
12,
2682,
5824,
12,
4051,
67,
16,
12,
5705,
1157,
12,
69,
22,
67,
23,
65,
24,
3609,
16,
69,
1983,
1,
198,
9641,
796,
366,
15,
13,
20,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
17140,
654,
11907,
198,
10378,
82,
796,
14631,
6601,
17614,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
19881,
21536,
344,
3829,
65,
21,
66,
24,
2308,
2624,
67,
1495,
9945,
66,
3609,
16,
1765,
66,
47372,
7568,
2075,
5774,
69,
1,
198,
12303,
312,
796,
366,
68,
16,
67,
1959,
67,
22,
64,
12,
11848,
17896,
12,
20,
12993,
17,
12,
24,
330,
15,
12,
69,
1065,
2934,
17,
66,
2091,
68,
2078,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
17,
1,
198,
198,
30109,
10378,
82,
13,
44,
8899,
11907,
198,
12303,
312,
796,
366,
64,
5066,
324,
16562,
12,
22,
68,
1485,
12,
1120,
5705,
12,
48372,
69,
12,
5036,
30206,
66,
40179,
36088,
1,
198,
198,
30109,
10378,
82,
13,
44,
8590,
5049,
34,
2246,
861,
82,
62,
73,
297,
11907,
198,
12303,
312,
796,
366,
1415,
64,
15277,
21,
67,
12,
69,
1899,
67,
12,
43918,
68,
12,
24,
19244,
12,
1065,
67,
24,
4761,
10210,
23,
19707,
1,
198,
198,
30109,
10378,
82,
13,
26705,
32755,
776,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
65,
2919,
21,
65,
22,
18213,
2998,
69,
23,
68,
2548,
12993,
18376,
69,
20,
27037,
1878,
39322,
3459,
16,
330,
24,
1415,
5036,
1,
198,
12303,
312,
796,
366,
3324,
7012,
2598,
1129,
12,
17,
67,
16,
69,
12,
3365,
10210,
12,
24,
11848,
16,
12,
23,
5853,
31916,
64,
17,
68,
18,
1,
198,
9641,
796,
366,
15,
13,
18,
13,
22,
1,
198,
198,
30109,
10378,
82,
13,
26245,
29046,
11907,
198,
12303,
312,
796,
366,
6888,
36189,
45418,
12,
66,
17,
68,
18,
12,
3559,
64,
24,
12,
558,
19,
12,
16,
68,
24,
3459,
65,
17,
66,
1129,
2919,
1,
198,
198,
30109,
10378,
82,
13,
46,
1130,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
3459,
2425,
3720,
64,
18,
1765,
22544,
27260,
67,
47396,
397,
22,
3609,
330,
20,
67,
16,
67,
44698,
38431,
65,
23,
69,
1,
198,
12303,
312,
796,
366,
68,
4524,
1065,
64,
17,
64,
12,
16,
64,
21,
68,
12,
4051,
66,
15,
12,
1350,
405,
12,
36042,
68,
1495,
4869,
66,
2713,
16,
1,
198,
9641,
796,
366,
16,
13,
18,
13,
20,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
11505,
9148,
1921,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
7293,
5329,
15514,
43,
11127,
62,
73,
297,
1600,
366,
25835,
25404,
8973,
198,
12303,
312,
796,
366,
2231,
32459,
1959,
64,
12,
66,
49351,
12,
20,
65,
1795,
12,
17457,
3510,
12,
69,
1795,
67,
4349,
66,
20,
65,
35447,
1,
198,
198,
30109,
10378,
82,
13,
11505,
31127,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
34287,
940,
4304,
1314,
66,
1314,
67,
19,
68,
2931,
69,
22,
31047,
1433,
22996,
15630,
23,
2481,
66,
16,
69,
45720,
67,
23,
1,
198,
12303,
312,
796,
366,
29334,
66,
18,
66,
3865,
12,
17,
68,
5705,
12,
1120,
7252,
12,
23,
891,
66,
12,
1129,
23734,
65,
17,
64,
18,
64,
3865,
1,
198,
9641,
796,
366,
16,
13,
16,
13,
1485,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
18257,
385,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
4349,
64,
2919,
21855,
1415,
721,
2078,
6814,
17,
721,
22,
64,
24,
1983,
66,
19,
31496,
68,
19,
32148,
66,
17,
64,
2857,
1238,
1,
198,
12303,
312,
796,
366,
6420,
67,
19,
22413,
67,
12,
2425,
2623,
12,
3270,
1129,
12,
65,
24,
2481,
12,
7410,
22709,
69,
2718,
36720,
1,
198,
9641,
796,
366,
16,
13,
18,
13,
17,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
35422,
1068,
5216,
26448,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
5332,
69,
23,
68,
2996,
3695,
19881,
16,
69,
24,
1453,
15,
67,
1157,
68,
22,
11848,
16,
65,
18781,
2414,
2327,
31714,
67,
2857,
66,
1,
198,
12303,
312,
796,
366,
65,
330,
40486,
68,
16,
12,
20,
68,
4761,
12,
20,
1765,
66,
12,
23,
39071,
12,
11231,
23,
64,
42947,
69,
2816,
67,
1,
198,
9641,
796,
366,
16,
13,
19,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
5662,
2200,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
65,
17,
64,
22,
1878,
21,
2414,
68,
2931,
1795,
2816,
64,
2425,
1959,
324,
16,
64,
12865,
9395,
4846,
17,
65,
6888,
33646,
1,
198,
12303,
312,
796,
366,
17,
69,
1795,
69,
1433,
68,
12,
21,
1157,
64,
12,
4051,
397,
12,
15630,
5333,
12,
7252,
5892,
2934,
20,
65,
4089,
16072,
1,
198,
9641,
796,
366,
23,
13,
2598,
13,
15,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
47,
14208,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
34,
18131,
62,
73,
297,
1600,
366,
23252,
11250,
62,
73,
297,
1600,
366,
11146,
6030,
17,
62,
73,
297,
1600,
366,
30214,
33,
19830,
62,
73,
297,
1600,
366,
38,
8019,
62,
73,
297,
1600,
366,
13587,
69,
48230,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
18,
64,
19244,
7568,
65,
7012,
3134,
66,
5824,
64,
20,
9423,
24,
1860,
68,
47512,
66,
18,
67,
15,
21101,
12993,
18,
64,
1065,
65,
1,
198,
12303,
312,
796,
366,
2623,
66,
4521,
1983,
69,
12,
2079,
2996,
12,
20,
39449,
12,
64,
33438,
12,
66,
21,
65,
17279,
69,
22,
1731,
69,
18,
1,
198,
9641,
796,
366,
16,
13,
1120,
13,
18,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
47,
945,
364,
11907,
198,
10378,
82,
796,
14631,
35,
689,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
15,
65,
20,
12993,
11848,
2154,
1821,
2682,
65,
20,
65,
19,
66,
1507,
3388,
68,
2623,
5066,
2598,
2548,
64,
48000,
7568,
15,
2996,
1,
198,
12303,
312,
796,
366,
3388,
2934,
15,
64,
3388,
12,
16,
1860,
67,
12,
20,
29326,
12,
24,
30743,
12,
17,
19881,
15,
65,
2999,
17896,
24,
69,
15,
1,
198,
9641,
796,
366,
17,
13,
17,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
47,
844,
805,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
65,
19,
69,
20,
67,
36629,
2920,
64,
940,
68,
22745,
1795,
64,
1731,
69,
344,
4761,
1350,
64,
4846,
65,
5066,
1959,
68,
1959,
1,
198,
12303,
312,
796,
366,
1270,
2670,
1731,
2920,
12,
33394,
64,
12,
20,
31115,
12,
23,
3901,
67,
12,
65,
16,
330,
344,
19,
68,
5607,
17896,
1,
198,
9641,
796,
366,
15,
13,
1821,
13,
16,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
47,
10025,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
35,
689,
1600,
366,
10002,
82,
1600,
366,
25835,
38,
270,
17,
1600,
366,
25835,
25404,
1600,
366,
11187,
2667,
1600,
366,
9704,
2902,
1600,
366,
18557,
69,
1600,
366,
2200,
6489,
1600,
366,
29531,
1600,
366,
37596,
1600,
366,
32634,
1634,
1600,
366,
51,
2662,
43,
1600,
366,
47079,
1600,
366,
52,
27586,
82,
1600,
366,
79,
22,
13344,
62,
73,
297,
8973,
198,
12303,
312,
796,
366,
2598,
66,
5036,
3865,
64,
12,
16,
1765,
17,
12,
4309,
18213,
12,
65,
43864,
12,
68,
17,
1878,
7568,
3388,
65,
3695,
69,
1,
198,
198,
30109,
10378,
82,
13,
43328,
464,
6880,
11907,
198,
10378,
82,
796,
14631,
43328,
18274,
4487,
1600,
366,
39618,
1600,
366,
48346,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
64,
18,
64,
24,
2414,
344,
24,
17896,
3695,
4089,
1129,
2327,
2623,
21601,
64,
21,
1860,
4531,
17,
65,
16,
65,
20,
64,
21,
69,
16,
67,
1,
198,
12303,
312,
796,
366,
535,
69,
17,
69,
23,
324,
12,
1731,
3132,
12,
20,
66,
5999,
12,
19881,
1959,
12,
66,
20,
28460,
65,
45791,
65,
21,
64,
1,
198,
9641,
796,
366,
17,
13,
15,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
43328,
18274,
4487,
11907,
198,
10378,
82,
796,
14631,
10258,
27054,
6880,
1600,
366,
5216,
669,
1600,
366,
35,
689,
1600,
366,
18557,
69,
1600,
366,
29531,
1600,
366,
3041,
39344,
1600,
366,
48346,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
21,
69,
16,
65,
1495,
68,
23,
18213,
3312,
26050,
65,
20,
40523,
29558,
535,
49561,
69,
48645,
3132,
67,
22,
6888,
1558,
1,
198,
12303,
312,
796,
366,
33438,
65,
6420,
64,
24,
12,
67,
21495,
12,
20,
1878,
67,
12,
24,
721,
21,
12,
22,
3510,
68,
2481,
9945,
66,
48768,
1,
198,
9641,
796,
366,
16,
13,
16,
13,
18,
1,
198,
198,
30109,
10378,
82,
13,
3646,
1747,
11907,
198,
10378,
82,
796,
14631,
14881,
2414,
1600,
366,
4264,
454,
1600,
366,
35,
689,
1600,
366,
10002,
82,
1600,
366,
5777,
7378,
7156,
1600,
366,
13715,
12727,
49601,
1600,
366,
10761,
1600,
366,
10082,
15748,
15522,
873,
1600,
366,
40386,
1600,
366,
26302,
87,
1958,
1600,
366,
14993,
451,
2348,
29230,
1600,
366,
5308,
13846,
1600,
366,
26705,
32755,
776,
1600,
366,
43328,
464,
6880,
1600,
366,
43328,
18274,
4487,
1600,
366,
18557,
69,
1600,
366,
2200,
6489,
1600,
366,
29531,
1600,
366,
6690,
18636,
14881,
1600,
366,
6690,
18636,
47,
541,
4470,
1600,
366,
3041,
39344,
1600,
366,
39618,
1600,
366,
3351,
36722,
1600,
366,
15307,
2364,
1600,
366,
50,
29572,
3163,
20477,
1600,
366,
48346,
1600,
366,
29668,
14881,
1600,
366,
52,
27586,
82,
1600,
366,
3118,
291,
1098,
24629,
1600,
366,
3118,
13344,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
1765,
1415,
2624,
721,
17,
65,
49703,
69,
2154,
344,
17,
19420,
66,
27019,
67,
1065,
2713,
4051,
32417,
36657,
64,
1,
198,
12303,
312,
796,
366,
6420,
64,
20,
15630,
1860,
12,
2816,
67,
22,
12,
20,
66,
1878,
12,
24,
68,
15,
65,
12,
31211,
67,
23,
3270,
66,
3609,
1795,
1,
198,
9641,
796,
366,
16,
13,
1495,
13,
23,
1,
198,
198,
30109,
10378,
82,
13,
3646,
9390,
10080,
11907,
198,
10378,
82,
796,
14631,
23839,
3646,
9390,
35,
278,
316,
73,
274,
1600,
366,
14881,
2414,
1600,
366,
10258,
31431,
1600,
366,
35,
689,
1600,
366,
49926,
364,
6519,
1600,
366,
38197,
5239,
43,
270,
1691,
1600,
366,
40,
4503,
2373,
495,
1600,
366,
9492,
5275,
18274,
4487,
1600,
366,
40386,
1600,
366,
11187,
2667,
1600,
366,
9704,
2902,
1600,
366,
29531,
1600,
366,
3041,
39344,
1600,
366,
52,
27586,
82,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
4531,
3720,
68,
24,
30863,
65,
19,
330,
18,
67,
3365,
66,
31938,
64,
1238,
69,
2078,
1731,
324,
3134,
69,
24,
2998,
19,
1860,
1,
198,
12303,
312,
796,
366,
22,
69,
24,
3023,
67,
5036,
12,
65,
5332,
68,
12,
19,
487,
21,
12,
65,
38380,
12,
67,
3609,
23539,
1954,
4846,
64,
23,
1,
198,
9641,
796,
366,
15,
13,
22,
13,
2682,
1,
198,
198,
30109,
10378,
82,
13,
36698,
4972,
11907,
198,
10378,
82,
796,
14631,
51,
2662,
43,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
17,
12993,
24,
1959,
67,
2414,
3104,
1065,
2623,
64,
17,
68,
2998,
19,
487,
1878,
65,
23,
67,
20,
39925,
2091,
67,
17,
68,
21,
1878,
1,
198,
12303,
312,
796,
366,
21777,
1433,
66,
21,
64,
12,
17,
68,
4790,
12,
2996,
5066,
12,
21,
68,
2996,
12,
22,
22980,
2791,
2996,
4761,
1120,
1,
198,
9641,
796,
366,
16,
13,
17,
13,
18,
1,
198,
198,
30109,
10378,
82,
13,
35700,
51,
2977,
11907,
198,
10378,
82,
796,
14631,
34,
2433,
684,
1600,
366,
26227,
889,
1600,
366,
9704,
2902,
1600,
366,
3041,
39344,
1600,
366,
51,
2977,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
7568,
65,
4051,
66,
19,
68,
37309,
6888,
64,
35124,
64,
16,
69,
17,
276,
38314,
65,
14198,
69,
20,
64,
18,
1860,
66,
7012,
20,
1,
198,
12303,
312,
796,
366,
2919,
11231,
23,
67,
17,
12,
15,
67,
15,
66,
12,
3553,
2920,
12,
324,
13331,
12,
23,
64,
17,
330,
15187,
1878,
15,
67,
1,
198,
9641,
796,
366,
16,
13,
18,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
18557,
69,
11907,
198,
10378,
82,
796,
14631,
3118,
291,
1098,
8973,
198,
12303,
312,
796,
366,
2934,
2919,
3365,
6814,
12,
21,
22572,
12,
20,
68,
3134,
12,
5774,
2598,
12,
4349,
6048,
1453,
1765,
23,
67,
22,
1,
198,
198,
30109,
10378,
82,
13,
37046,
11907,
198,
10378,
82,
796,
14631,
18557,
69,
8973,
198,
12303,
312,
796,
366,
24,
6485,
67,
24,
2231,
12,
67,
487,
23,
12,
43918,
69,
12,
65,
20,
68,
23,
12,
68,
16,
1765,
69,
20,
891,
16,
65,
3720,
1,
198,
198,
30109,
10378,
82,
13,
48,
83,
20,
14881,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
7293,
5329,
15514,
43,
11127,
62,
73,
297,
1600,
366,
23252,
11250,
62,
73,
297,
1600,
366,
38,
8019,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
25835,
4743,
85,
358,
62,
73,
297,
1600,
366,
11505,
31127,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
2302,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
87,
21101,
62,
73,
297,
1600,
366,
55,
2398,
62,
87,
21101,
62,
22602,
62,
9060,
62,
73,
297,
1600,
366,
55,
2398,
62,
87,
21101,
62,
22602,
62,
13083,
88,
907,
62,
73,
297,
1600,
366,
55,
2398,
62,
87,
21101,
62,
22602,
62,
13287,
22602,
62,
73,
297,
1600,
366,
55,
2398,
62,
87,
21101,
62,
22602,
62,
26377,
62,
73,
297,
1600,
366,
57,
8019,
62,
73,
297,
1600,
366,
87,
32812,
11321,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
324,
27412,
45791,
64,
20,
68,
1238,
9945,
65,
23,
67,
21,
17896,
17,
69,
1860,
68,
22521,
19,
67,
3609,
2998,
6659,
3609,
23,
1,
198,
12303,
312,
796,
366,
18213,
17,
344,
64,
18,
65,
12,
20,
65,
4304,
12,
3553,
3609,
12,
64,
21,
891,
12,
15,
64,
23,
1878,
21,
1731,
4846,
68,
16,
1,
198,
9641,
796,
366,
20,
13,
1314,
13,
18,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
2200,
6489,
11907,
198,
10378,
82,
796,
14631,
9492,
5275,
18274,
4487,
1600,
366,
9704,
2902,
1600,
366,
50,
11603,
1600,
366,
3118,
291,
1098,
8973,
198,
12303,
312,
796,
366,
18,
13331,
15,
10210,
4846,
12,
68,
891,
16,
12,
20,
42548,
12,
23,
64,
5333,
12,
65,
18,
65,
31360,
23,
11848,
487,
65,
1,
198,
198,
30109,
10378,
82,
13,
29531,
11907,
198,
10378,
82,
796,
14631,
37596,
1600,
366,
32634,
1634,
8973,
198,
12303,
312,
796,
366,
24,
64,
18,
69,
23,
30336,
12,
64,
17,
66,
24,
12,
20,
69,
2999,
12,
24,
64,
1157,
12,
23,
33459,
1795,
64,
16,
16344,
20,
66,
1,
198,
198,
30109,
10378,
82,
13,
6690,
18636,
14881,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
21,
19881,
18,
69,
23734,
487,
4309,
344,
2919,
2624,
1860,
67,
18,
64,
17,
64,
22,
65,
3865,
2548,
276,
16,
65,
13227,
22,
67,
1,
198,
12303,
312,
796,
366,
18,
10210,
12993,
20,
69,
17,
12,
16,
891,
19,
12,
48170,
66,
12,
24,
28256,
12,
2996,
5774,
65,
1899,
6485,
486,
1,
198,
9641,
796,
366,
16,
13,
17,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
6690,
18636,
47,
541,
4470,
11907,
198,
10378,
82,
796,
14631,
35,
689,
1600,
366,
26705,
32755,
776,
1600,
366,
43328,
18274,
4487,
1600,
366,
6690,
18636,
14881,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
2718,
66,
1433,
3132,
21101,
18,
535,
2623,
64,
44465,
13348,
68,
21,
67,
2816,
38907,
2414,
66,
6469,
10210,
23,
66,
17,
65,
1,
198,
12303,
312,
796,
366,
486,
67,
49503,
1558,
12,
65,
891,
66,
12,
19,
21101,
21,
12,
65,
24,
721,
12,
64,
24,
3553,
1129,
67,
15,
30743,
66,
1,
198,
9641,
796,
366,
15,
13,
20,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
3041,
39344,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
2231,
68,
40173,
3682,
23055,
1899,
4790,
68,
397,
21,
69,
17,
6814,
20,
66,
24,
67,
26717,
67,
2079,
11848,
1065,
69,
24,
65,
1,
198,
12303,
312,
796,
366,
23362,
64,
2548,
3134,
12,
1270,
1120,
12,
4309,
6814,
12,
64,
23,
2623,
12,
68,
30005,
7012,
3829,
397,
3388,
1,
198,
9641,
796,
366,
16,
13,
17,
13,
17,
1,
198,
198,
30109,
10378,
82,
13,
6892,
420,
21156,
37,
727,
364,
11907,
198,
10378,
82,
796,
14631,
37596,
1600,
366,
3351,
36722,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
66,
9945,
67,
18,
65,
1485,
2548,
66,
4761,
344,
1959,
67,
24,
46352,
16344,
1350,
24,
68,
24,
65,
2154,
1453,
65,
20,
324,
6888,
1,
198,
12303,
312,
796,
366,
2713,
1507,
940,
2598,
12,
487,
15,
65,
12,
19,
330,
20,
12,
23,
27367,
12,
41292,
66,
16,
68,
2548,
9945,
405,
1,
198,
9641,
796,
366,
15,
13,
16,
13,
18,
1,
198,
198,
30109,
10378,
82,
13,
39618,
11907,
198,
10378,
82,
796,
14631,
52,
27586,
82,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
23,
2548,
64,
18,
64,
19,
20356,
68,
17,
9395,
5774,
64,
19,
69,
24,
69,
22883,
65,
19,
65,
15,
67,
3695,
64,
16,
68,
6420,
21101,
22,
1,
198,
12303,
312,
796,
366,
3609,
48891,
30206,
12,
64,
19,
1860,
12,
20,
13464,
12,
24,
6814,
64,
12,
67,
48882,
3459,
22148,
20,
7568,
1,
198,
9641,
796,
366,
16,
13,
18,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
49,
21370,
70,
11907,
198,
10378,
82,
796,
14631,
34,
18131,
1600,
366,
38,
8019,
62,
73,
297,
1600,
366,
43,
2889,
21370,
70,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
18,
67,
18,
17896,
2791,
1765,
42018,
3104,
21855,
18,
64,
39088,
3829,
2682,
65,
16072,
43665,
64,
15,
1765,
15,
66,
33808,
1,
198,
12303,
312,
796,
366,
66,
19,
66,
21734,
12993,
12,
20,
15197,
12,
4310,
2154,
12,
1350,
2231,
12,
69,
18,
64,
16243,
13227,
18,
65,
23,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
37596,
11907,
198,
12303,
312,
796,
366,
18213,
23,
68,
24,
1129,
66,
12,
26660,
66,
12,
4349,
1878,
12,
3459,
1495,
12,
46071,
5066,
10210,
22,
2481,
344,
1,
198,
198,
30109,
10378,
82,
13,
3351,
36722,
11907,
198,
10378,
82,
796,
14631,
35,
689,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
15,
65,
19,
65,
22,
69,
1485,
6052,
66,
487,
5607,
66,
2091,
4531,
16,
6814,
17,
64,
15,
19881,
3388,
66,
21,
276,
28872,
69,
6814,
1,
198,
12303,
312,
796,
366,
21,
66,
21,
64,
17,
68,
4790,
12,
2996,
5066,
12,
21,
17279,
12,
22,
27412,
12,
21,
2718,
3510,
1558,
2075,
33319,
1,
198,
9641,
796,
366,
16,
13,
16,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
32634,
1634,
11907,
198,
12303,
312,
796,
366,
24,
68,
3459,
65,
3682,
64,
12,
69,
23,
1959,
12,
20,
65,
15,
66,
12,
65,
1350,
24,
12,
24,
68,
24,
1954,
22337,
23055,
65,
1,
198,
198,
30109,
10378,
82,
13,
2484,
1144,
3163,
20477,
11907,
198,
10378,
82,
796,
14631,
20344,
6169,
1600,
366,
44,
8899,
1600,
366,
29531,
1600,
366,
32634,
1634,
8973,
198,
12303,
312,
796,
366,
16,
64,
8784,
16,
64,
18,
12,
5705,
2934,
12,
38605,
68,
12,
23,
68,
4531,
12,
64,
1157,
64,
17,
69,
22,
17896,
34741,
1,
198,
198,
30109,
10378,
82,
13,
15307,
2364,
11907,
198,
10378,
82,
796,
14631,
35,
689,
1600,
366,
38,
2442,
84,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
6420,
6048,
69,
37680,
22260,
6659,
7568,
24,
3609,
21,
344,
65,
1238,
65,
24,
3270,
3609,
20,
46435,
324,
16,
2934,
1,
198,
12303,
312,
796,
366,
41561,
67,
19,
64,
891,
12,
2919,
1415,
12,
47396,
65,
12,
15630,
19,
67,
12,
69,
17,
68,
24,
64,
21,
66,
19,
18298,
69,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
18,
1,
198,
198,
30109,
10378,
82,
13,
50,
11603,
11907,
198,
12303,
312,
796,
366,
2414,
5237,
5036,
15,
65,
12,
1731,
2934,
12,
3980,
3132,
12,
23,
40035,
12,
1860,
24,
3901,
69,
3829,
2934,
535,
1,
198,
198,
30109,
10378,
82,
13,
50,
24707,
2348,
7727,
907,
11907,
198,
10378,
82,
796,
14631,
6601,
44909,
942,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
65,
2091,
5066,
67,
4524,
1899,
69,
22,
67,
2931,
23,
6888,
2931,
1065,
66,
3388,
65,
2919,
17,
69,
2425,
26704,
67,
15426,
23,
1,
198,
12303,
312,
796,
366,
64,
17,
1878,
1157,
2791,
12,
64,
2919,
69,
12,
20,
69,
2414,
12,
23,
3510,
66,
12,
5824,
64,
15,
67,
18,
344,
69,
2780,
66,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
50,
29572,
3163,
20477,
11907,
198,
10378,
82,
796,
14631,
14993,
451,
2348,
29230,
1600,
366,
29531,
8973,
198,
12303,
312,
796,
366,
17,
69,
486,
22883,
68,
12,
68,
1828,
65,
12,
20,
7568,
20,
12,
3609,
5066,
12,
67,
6052,
1765,
397,
3388,
68,
1878,
1,
198,
198,
30109,
10378,
82,
13,
45442,
3163,
20477,
11907,
198,
10378,
82,
796,
14631,
14993,
451,
2348,
29230,
1600,
366,
29531,
1600,
366,
48346,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
64,
48250,
64,
24,
2091,
2670,
4531,
64,
2931,
19,
65,
1860,
66,
24,
69,
46899,
66,
3023,
66,
44966,
10210,
2791,
1878,
12993,
1,
198,
12303,
312,
796,
366,
46815,
2718,
487,
64,
12,
22,
27203,
12,
3980,
1821,
12,
6659,
65,
24,
12,
68,
31211,
2718,
28727,
24294,
1,
198,
9641,
796,
366,
16,
13,
18,
13,
19,
1,
198,
198,
30109,
10378,
82,
13,
48346,
11907,
198,
10378,
82,
796,
14631,
14993,
451,
2348,
29230,
1600,
366,
50,
29572,
3163,
20477,
8973,
198,
12303,
312,
796,
366,
15982,
2231,
65,
1433,
12,
3720,
344,
12,
1157,
68,
23,
12,
1157,
69,
24,
12,
22,
67,
1485,
324,
2624,
64,
18,
65,
17,
1,
198,
198,
30109,
10378,
82,
13,
29668,
17614,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
67,
3459,
36879,
324,
66,
24,
65,
12993,
33459,
3070,
30273,
1878,
2931,
6469,
68,
17,
16344,
2713,
3609,
18,
67,
15,
64,
21,
1,
198,
12303,
312,
796,
366,
6469,
3609,
5774,
2920,
12,
3324,
276,
12,
19,
5036,
21,
12,
3609,
20,
69,
12,
69,
49803,
1314,
18938,
19,
65,
15,
1,
198,
9641,
796,
366,
16,
13,
17,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
29668,
14881,
11907,
198,
10378,
82,
796,
14631,
6601,
17614,
1600,
366,
6601,
44909,
942,
1600,
366,
14993,
451,
2348,
29230,
1600,
366,
11187,
16870,
24629,
2733,
1600,
366,
17140,
654,
1600,
366,
18557,
69,
1600,
366,
29531,
1600,
366,
50,
24707,
2348,
7727,
907,
1600,
366,
50,
29572,
3163,
20477,
1600,
366,
48346,
1600,
366,
29668,
17614,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
48645,
5999,
69,
17,
67,
27824,
1765,
18,
65,
30272,
66,
4846,
16,
67,
32642,
66,
47372,
68,
19,
66,
15,
12993,
19,
7012,
15,
1,
198,
12303,
312,
796,
366,
1959,
1485,
11848,
67,
17,
12,
3609,
23,
64,
12,
20,
69,
4869,
12,
23,
66,
2079,
12,
19,
21855,
21,
66,
4304,
69,
18,
64,
6420,
1,
198,
9641,
796,
366,
15,
13,
2091,
13,
1415,
1,
198,
198,
30109,
10378,
82,
13,
44909,
3163,
20477,
11907,
198,
10378,
82,
796,
14631,
48003,
1600,
366,
6601,
17614,
1600,
366,
45442,
3163,
20477,
1600,
366,
51,
2977,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
67,
2481,
69,
17,
66,
20,
2414,
65,
2481,
64,
19004,
69,
24669,
22,
66,
15,
69,
7012,
20,
65,
20,
1453,
3559,
940,
38905,
2598,
1,
198,
12303,
312,
796,
366,
2931,
397,
33372,
65,
12,
69,
17,
65,
21,
12,
49561,
69,
12,
65,
5824,
64,
12,
17,
69,
5999,
12993,
19,
64,
23,
3682,
64,
1,
198,
9641,
796,
366,
15,
13,
21,
13,
19,
1,
198,
198,
30109,
10378,
82,
13,
51,
2662,
43,
11907,
198,
10378,
82,
796,
14631,
35,
689,
8973,
198,
12303,
312,
796,
366,
13331,
25674,
69,
16,
69,
12,
1899,
2920,
12,
19,
69,
1415,
12,
7252,
4051,
12,
2091,
65,
1878,
3609,
16,
276,
4304,
1,
198,
198,
30109,
10378,
82,
13,
10962,
15721,
896,
11907,
198,
10378,
82,
796,
14631,
37787,
39317,
11627,
5736,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
66,
3312,
65,
17,
69,
20,
2670,
7568,
16,
66,
21,
891,
64,
3720,
2598,
4521,
397,
21855,
21,
276,
1238,
18182,
5333,
64,
2670,
1,
198,
12303,
312,
796,
366,
2718,
5999,
65,
9945,
23,
12,
19,
64,
4089,
12,
20,
65,
21,
65,
12,
1878,
24,
64,
12,
47372,
69,
1959,
64,
20,
5036,
24,
66,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
51,
2977,
11907,
198,
10378,
82,
796,
14631,
6601,
17614,
1600,
366,
6601,
11395,
9492,
32186,
1600,
366,
37787,
39317,
11627,
5736,
1600,
366,
14993,
451,
2348,
29230,
1600,
366,
10962,
15721,
896,
1600,
366,
14402,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
11848,
940,
2414,
66,
24,
64,
5705,
66,
4309,
68,
27019,
69,
940,
4846,
12993,
37309,
2682,
65,
42444,
10210,
27412,
65,
1,
198,
12303,
312,
796,
366,
17457,
30803,
1878,
21,
12,
64,
721,
16,
12,
20,
324,
15,
12,
65,
1433,
64,
12,
69,
22,
535,
4059,
23,
25948,
66,
1,
198,
9641,
796,
366,
16,
13,
21,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
47079,
11907,
198,
10378,
82,
796,
14631,
28100,
33637,
1600,
366,
37596,
8973,
198,
12303,
312,
796,
366,
64,
19,
68,
20,
3388,
64,
21,
12,
68,
36088,
12,
19,
13331,
19,
12,
65,
15,
69,
18,
12,
68,
891,
22,
64,
16,
67,
20,
65,
1485,
68,
1,
198,
198,
30109,
10378,
82,
13,
14402,
11907,
198,
10378,
82,
796,
14631,
9492,
5275,
18274,
4487,
1600,
366,
11187,
2667,
1600,
366,
29531,
1600,
366,
32634,
1634,
8973,
198,
12303,
312,
796,
366,
23,
7568,
276,
46841,
12,
68,
1828,
66,
12,
20,
68,
2919,
12,
5332,
68,
16,
12,
2996,
66,
20,
24409,
69,
15,
65,
1821,
1,
198,
198,
30109,
10378,
82,
13,
4261,
3792,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
5607,
65,
1350,
38172,
64,
4310,
5036,
23,
3270,
36657,
10210,
24,
2998,
69,
17,
67,
4846,
64,
1453,
23,
67,
17,
66,
1485,
2816,
1,
198,
12303,
312,
796,
366,
20,
66,
1983,
2857,
69,
23,
12,
65,
22,
18213,
12,
19,
487,
17,
12,
7012,
17,
68,
12,
46572,
65,
16344,
2623,
65,
16,
67,
19,
1,
198,
9641,
796,
366,
16,
13,
18,
13,
15,
1,
198,
198,
30109,
10378,
82,
13,
52,
27586,
82,
11907,
198,
10378,
82,
796,
14631,
29531,
1600,
366,
37596,
8973,
198,
12303,
312,
796,
366,
12993,
22,
16817,
64,
22,
12,
3388,
4304,
12,
20,
65,
16,
64,
12,
24,
64,
2670,
12,
22,
324,
66,
4761,
69,
48952,
64,
19,
1,
198,
198,
30109,
10378,
82,
13,
3118,
291,
1098,
11907,
198,
12303,
312,
796,
366,
19,
721,
15,
64,
5999,
68,
12,
43134,
68,
12,
1120,
68,
17,
12,
65,
24,
330,
12,
23,
69,
4761,
330,
69,
20,
64,
23,
69,
20,
1,
198,
198,
30109,
10378,
82,
13,
3118,
291,
1098,
24629,
11907,
198,
10378,
82,
796,
14631,
2200,
6489,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
20,
2670,
1314,
68,
1120,
10531,
3270,
28933,
68,
3695,
64,
5892,
64,
39667,
46438,
65,
40173,
67,
487,
1860,
69,
1,
198,
12303,
312,
796,
366,
16,
12993,
671,
486,
12,
1828,
12993,
12,
3553,
405,
12,
65,
2931,
17,
12,
330,
535,
19,
65,
5237,
67,
21,
68,
16,
1,
198,
9641,
796,
366,
15,
13,
19,
13,
16,
1,
198,
198,
30109,
10378,
82,
13,
3118,
13344,
11907,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
2682,
9945,
1795,
3865,
1129,
486,
2998,
2327,
486,
19708,
65,
9945,
66,
18,
67,
20,
64,
23,
68,
22,
11848,
67,
15,
2791,
2154,
1,
198,
12303,
312,
796,
366,
3901,
5036,
22,
65,
1899,
12,
3324,
276,
12,
3559,
64,
16,
12,
65,
19,
69,
15,
12,
47338,
16344,
20,
64,
3980,
1120,
67,
1,
198,
9641,
796,
366,
15,
13,
16,
13,
17,
1,
198,
198,
30109,
10378,
82,
13,
25309,
1044,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
3109,
8071,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
25835,
487,
72,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
55,
5805,
17,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
18,
68,
5333,
69,
15,
65,
4521,
69,
3829,
67,
330,
65,
15,
15630,
15,
68,
4790,
64,
15,
66,
20,
64,
5999,
69,
21,
64,
4521,
2623,
68,
1954,
1,
198,
12303,
312,
796,
366,
64,
1959,
2414,
67,
16,
69,
12,
5607,
6814,
12,
1120,
67,
19,
12,
65,
6469,
64,
12,
31128,
66,
22,
69,
344,
24,
67,
4531,
1,
198,
9641,
796,
366,
16,
13,
1129,
13,
15,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
25309,
1044,
62,
11235,
4668,
82,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
2791,
67,
4761,
17896,
21,
69,
535,
4521,
33394,
69,
486,
42548,
68,
23,
69,
15,
69,
39357,
43918,
68,
32417,
940,
69,
1,
198,
12303,
312,
796,
366,
1954,
6659,
19881,
23,
64,
12,
7568,
67,
15,
12,
41948,
67,
12,
24214,
12,
3720,
30005,
68,
22,
65,
16,
65,
6420,
1,
198,
9641,
796,
366,
16,
13,
1954,
13,
15,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
55,
5805,
17,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
25835,
4749,
85,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
57,
8019,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
16,
330,
69,
20,
65,
7568,
2998,
7252,
2931,
2998,
68,
15,
64,
2718,
67,
2718,
1507,
11848,
3459,
67,
19,
65,
39925,
65,
4524,
64,
1,
198,
12303,
312,
796,
366,
2999,
66,
23,
16072,
24,
66,
12,
65,
5607,
69,
12,
1120,
65,
24,
12,
65,
1350,
19,
12,
24,
1350,
1270,
487,
15,
64,
3695,
64,
1,
198,
9641,
796,
366,
17,
13,
24,
13,
1065,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
55,
8634,
51,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
25835,
70,
29609,
62,
73,
297,
1600,
366,
25835,
70,
6024,
62,
18224,
62,
73,
297,
1600,
366,
25835,
4749,
85,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
55,
5805,
17,
62,
73,
297,
1600,
366,
57,
8019,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
24,
1507,
31115,
4790,
66,
1821,
5332,
16102,
65,
3865,
68,
41544,
69,
46589,
66,
19,
344,
66,
19,
67,
28256,
69,
23,
64,
1,
198,
12303,
312,
796,
366,
8432,
30763,
64,
12,
23,
69,
6814,
12,
35378,
69,
12,
24,
29796,
12,
22,
65,
3023,
28771,
3270,
64,
5333,
1,
198,
9641,
796,
366,
16,
13,
16,
13,
2682,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
55,
1157,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
87,
21101,
62,
73,
297,
1600,
366,
55,
2398,
62,
742,
26084,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
20,
1350,
33300,
67,
22730,
69,
18,
69,
19,
65,
3865,
21495,
19881,
486,
5999,
65,
6469,
68,
25600,
27800,
2996,
1983,
1,
198,
12303,
312,
796,
366,
19,
69,
21,
31575,
69,
22,
12,
65,
18,
67,
17,
12,
44169,
68,
12,
24,
67,
1238,
12,
276,
1765,
2231,
69,
17,
65,
17,
15630,
1,
198,
9641,
796,
366,
16,
13,
21,
13,
24,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
55,
559,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
19,
68,
31503,
67,
20,
66,
39277,
66,
33638,
69,
2091,
3459,
3553,
3829,
276,
33289,
487,
18,
64,
5824,
344,
3134,
68,
1,
198,
12303,
312,
796,
366,
15,
66,
15,
65,
22,
1860,
16,
12,
67,
1821,
65,
12,
46352,
66,
12,
64,
10163,
12,
64,
35218,
1821,
69,
5774,
68,
721,
1,
198,
9641,
796,
366,
16,
13,
15,
13,
24,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
55,
66,
21471,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
42624,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
55,
13287,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
1065,
68,
15,
1765,
18,
15630,
21,
2682,
13331,
1238,
1795,
66,
16,
66,
2718,
69,
535,
69,
3980,
69,
22,
66,
1828,
42520,
1878,
67,
1,
198,
12303,
312,
796,
366,
24,
2327,
21855,
22,
2414,
12,
23,
12993,
17,
12,
4310,
19881,
12,
11848,
1270,
12,
2231,
11848,
16,
69,
23,
19881,
22,
1731,
1,
198,
9641,
796,
366,
16,
13,
17,
13,
15,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
55,
36020,
13155,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
19,
5036,
2857,
17457,
17,
23753,
23045,
11623,
66,
19,
27693,
41019,
1821,
68,
1507,
64,
3104,
1485,
4761,
1860,
19,
1,
198,
12303,
312,
796,
366,
64,
2718,
4531,
22,
2682,
12,
66,
5036,
16,
12,
20,
65,
3312,
12,
65,
17,
67,
15,
12,
16,
1860,
15,
67,
24,
67,
5237,
67,
2713,
1,
198,
9641,
796,
366,
16,
13,
16,
13,
18,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
55,
2302,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
1157,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
65,
22,
66,
15,
7252,
23,
66,
32128,
65,
3132,
68,
2780,
4309,
65,
15277,
1828,
2078,
34251,
2718,
69,
40271,
69,
23,
66,
18,
1,
198,
12303,
312,
796,
366,
15711,
2075,
2670,
64,
12,
15,
67,
3609,
12,
20,
69,
2682,
12,
24,
65,
3312,
12,
47760,
6659,
1453,
65,
23,
21101,
18,
1,
198,
9641,
796,
366,
16,
13,
18,
13,
19,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
55,
42624,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
1157,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
15,
68,
15,
17896,
4524,
3132,
68,
22,
64,
2713,
31360,
3270,
69,
24,
27696,
3609,
721,
26276,
38339,
66,
2079,
16,
64,
19,
1,
198,
12303,
312,
796,
366,
67,
2931,
16,
68,
23,
7012,
12,
20,
3132,
64,
12,
44169,
66,
12,
24,
2934,
24,
12,
46899,
3388,
65,
15,
2718,
276,
23,
1,
198,
9641,
796,
366,
20,
13,
15,
13,
18,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
42528,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
2302,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
55,
42624,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
4531,
65,
4309,
15630,
17,
14198,
64,
324,
66,
5705,
67,
2154,
31495,
2670,
1270,
891,
15,
65,
487,
64,
2414,
1065,
3510,
1,
198,
12303,
312,
796,
366,
64,
4349,
7252,
15,
16344,
12,
19,
68,
18,
66,
12,
20,
21734,
12,
65,
23,
3829,
12,
68,
44550,
12501,
6814,
40256,
1,
198,
9641,
796,
366,
16,
13,
22,
13,
940,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
55,
7274,
1689,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
2302,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
2075,
1350,
23,
65,
16,
66,
2682,
1959,
1959,
1495,
6052,
1558,
67,
23,
65,
24,
69,
22,
65,
4310,
19881,
17,
11848,
4790,
65,
10163,
1,
198,
12303,
312,
796,
366,
67,
1415,
4051,
29703,
12,
3270,
7568,
12,
20,
18213,
16,
12,
1350,
330,
12,
66,
23601,
69,
2481,
1270,
15630,
18,
1,
198,
9641,
796,
366,
16,
13,
16,
13,
19,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
55,
25192,
81,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
2302,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
55,
13287,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
2682,
344,
64,
5999,
21101,
22,
2075,
21855,
3365,
69,
26582,
46660,
19881,
3312,
1065,
66,
21,
65,
18,
21855,
24096,
3132,
1,
198,
12303,
312,
796,
366,
721,
5705,
65,
45385,
12,
7012,
23,
68,
12,
20,
67,
4846,
12,
23,
7012,
16,
12,
17,
64,
40523,
7012,
940,
34137,
1,
198,
9641,
796,
366,
16,
13,
20,
13,
17,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
55,
13287,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
1157,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
22186,
1899,
69,
1270,
16344,
2920,
69,
19,
67,
19,
891,
1350,
9879,
17,
64,
940,
2718,
69,
23,
66,
3559,
67,
3559,
65,
4846,
1,
198,
12303,
312,
796,
366,
18213,
17,
69,
16,
64,
4846,
12,
16,
1860,
66,
12,
35005,
67,
12,
65,
3510,
69,
12,
11785,
35916,
68,
2998,
12993,
64,
1,
198,
9641,
796,
366,
15,
13,
24,
13,
940,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
79,
16663,
62,
301,
23161,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
30924,
2718,
2718,
68,
2231,
67,
18,
66,
3270,
64,
19,
64,
19,
66,
1821,
6420,
69,
20,
69,
3459,
10210,
12993,
2931,
2919,
66,
11848,
1,
198,
12303,
312,
796,
366,
1415,
67,
6469,
69,
2920,
12,
24096,
66,
12,
20,
276,
16,
12,
11848,
2920,
12,
324,
18,
69,
20,
66,
17457,
23,
66,
4524,
1,
198,
9641,
796,
366,
15,
13,
16,
13,
15,
10,
18,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
87,
21101,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
8634,
51,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
55,
559,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
55,
36020,
13155,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
79,
16663,
62,
301,
23161,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
67,
1878,
1558,
69,
2598,
1065,
2078,
68,
22,
64,
2548,
28460,
3510,
10210,
47202,
4531,
2078,
5333,
66,
487,
1433,
67,
21,
1,
198,
12303,
312,
796,
366,
66,
22,
12993,
17896,
5824,
12,
17896,
2624,
12,
2816,
2934,
12,
330,
4846,
12,
20,
64,
16,
65,
23,
67,
24,
3324,
66,
20,
65,
1,
198,
9641,
796,
366,
16,
13,
1485,
13,
15,
10,
18,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
8019,
87,
32812,
7753,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
1157,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
24,
2075,
1878,
4521,
1558,
2598,
21777,
9945,
15,
1765,
8298,
67,
24,
68,
1821,
65,
20,
67,
1433,
1959,
1238,
1795,
65,
17,
1,
198,
12303,
312,
796,
366,
535,
5333,
68,
45385,
12,
15,
34229,
12,
45326,
66,
12,
23,
65,
2075,
12,
276,
17,
66,
3104,
330,
397,
22,
64,
1,
198,
9641,
796,
366,
16,
13,
16,
13,
15,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
87,
21101,
62,
22602,
62,
9060,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
87,
21101,
62,
22602,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
15,
36434,
15,
64,
1821,
27371,
7012,
16,
66,
7012,
17,
66,
16,
6814,
47325,
1731,
2091,
4846,
487,
23,
68,
5824,
65,
5607,
1,
198,
12303,
312,
796,
366,
17464,
20219,
1495,
12,
23,
23726,
12,
20,
69,
2816,
12,
11848,
15,
68,
12,
21,
67,
22,
6888,
1120,
11848,
2931,
65,
1,
198,
9641,
796,
366,
15,
13,
19,
13,
15,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
87,
21101,
62,
22602,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
87,
21101,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
68,
22,
16344,
22,
65,
2078,
6659,
13331,
17,
68,
7252,
47760,
22985,
1238,
4531,
19,
67,
2670,
2548,
1558,
3695,
5237,
67,
16,
1,
198,
12303,
312,
796,
366,
17,
4299,
47512,
69,
12,
20,
324,
16,
12,
4310,
940,
12,
65,
1314,
65,
12,
65,
1314,
67,
3510,
69,
49351,
69,
20,
1,
198,
9641,
796,
366,
15,
13,
19,
13,
15,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
87,
21101,
62,
22602,
62,
13083,
88,
907,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
87,
21101,
62,
22602,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
67,
1157,
4349,
68,
17,
66,
2231,
64,
47576,
69,
33916,
3901,
64,
20,
3134,
67,
1433,
3829,
68,
41583,
721,
4531,
65,
405,
1,
198,
12303,
312,
796,
366,
5607,
1120,
2598,
67,
17,
12,
4304,
68,
21,
12,
20,
69,
1350,
12,
19881,
2919,
12,
5607,
344,
22,
66,
2996,
4524,
66,
22,
1,
198,
9641,
796,
366,
15,
13,
19,
13,
15,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
87,
21101,
62,
22602,
62,
13287,
22602,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
87,
21101,
62,
22602,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
7568,
67,
22,
64,
23,
69,
2548,
67,
3510,
1485,
65,
21,
64,
36189,
28592,
65,
18,
22985,
1860,
2079,
16,
6888,
21,
24839,
68,
1,
198,
12303,
312,
796,
366,
15,
67,
2857,
35809,
68,
12,
15,
28933,
12,
20,
64,
3388,
12,
64,
4761,
66,
12,
69,
4304,
1433,
1270,
19881,
65,
22,
68,
1,
198,
9641,
796,
366,
15,
13,
18,
13,
24,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
87,
21101,
62,
22602,
62,
26377,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
87,
21101,
62,
22602,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
68,
3695,
67,
940,
64,
397,
486,
64,
19,
64,
21526,
23726,
66,
4059,
21,
276,
2598,
16344,
24,
68,
23,
68,
3132,
65,
3134,
1,
198,
12303,
312,
796,
366,
66,
1828,
69,
24,
397,
15,
12,
67,
20,
5036,
12,
1120,
2791,
12,
23,
2857,
66,
12,
69,
19,
11848,
16,
10210,
19,
68,
35195,
1,
198,
9641,
796,
366,
15,
13,
19,
13,
16,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
87,
32812,
5589,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
87,
32812,
7753,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
19,
15630,
19881,
39885,
69,
21,
66,
17,
68,
45722,
69,
5774,
68,
39277,
64,
27192,
65,
16315,
67,
3312,
1453,
24136,
65,
1,
198,
12303,
312,
796,
366,
2327,
2791,
1415,
4310,
12,
65,
27693,
12,
20,
36434,
12,
23,
64,
405,
12,
18,
67,
24,
14198,
66,
21,
64,
18,
64,
19,
1,
198,
9641,
796,
366,
16,
13,
19,
13,
17,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
87,
2539,
3526,
62,
11250,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
87,
32812,
5589,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
20,
66,
5705,
1731,
69,
23,
64,
3134,
66,
18,
69,
17572,
24,
27720,
67,
2598,
1495,
69,
18,
67,
35038,
39071,
3270,
3132,
67,
1,
198,
12303,
312,
796,
366,
2091,
9423,
3365,
68,
12,
1065,
4790,
12,
25836,
69,
12,
5824,
486,
12,
20,
67,
20,
29211,
2075,
69,
23,
1828,
1,
198,
9641,
796,
366,
17,
13,
1983,
13,
15,
10,
19,
1,
198,
198,
30109,
10378,
82,
13,
55,
2398,
62,
742,
26084,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
3720,
66,
3132,
68,
3695,
2598,
69,
21,
721,
69,
40393,
34801,
69,
15630,
1065,
20964,
1765,
19782,
65,
22,
67,
23,
2231,
1,
198,
12303,
312,
796,
366,
66,
20,
21855,
20,
34626,
12,
64,
21,
2548,
12,
20,
68,
19,
67,
12,
4846,
68,
20,
12,
65,
1959,
2934,
16,
65,
20,
12993,
940,
1,
198,
9641,
796,
366,
16,
13,
19,
13,
15,
10,
18,
1,
198,
198,
30109,
10378,
82,
13,
57,
8019,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
25835,
25404,
8973,
198,
12303,
312,
796,
366,
23,
2718,
2425,
64,
3365,
12,
16,
69,
16,
67,
12,
48645,
69,
12,
65,
24991,
12,
67,
50055,
4051,
397,
25816,
64,
1,
198,
198,
30109,
10378,
82,
13,
57,
19282,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
68,
17885,
2598,
10210,
23,
4790,
9395,
4051,
65,
21,
64,
20,
65,
330,
15,
1765,
20,
66,
5607,
1485,
5892,
12993,
1129,
1983,
1,
198,
12303,
312,
796,
366,
18,
25948,
67,
18,
64,
18,
12,
65,
7568,
21,
12,
20,
23237,
12,
23,
1157,
64,
12,
47941,
31751,
9945,
3324,
65,
19,
1,
198,
9641,
796,
366,
16,
13,
20,
13,
17,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
21287,
74,
62,
79,
844,
29325,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
38,
8019,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
41,
22071,
17483,
2127,
62,
73,
297,
1600,
366,
25835,
25404,
1600,
366,
25835,
83,
733,
62,
73,
297,
1600,
366,
47,
10025,
1600,
366,
55,
2398,
62,
8019,
55,
1157,
62,
73,
297,
1600,
366,
8019,
11134,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
66,
25429,
1954,
10210,
1270,
67,
31751,
3901,
69,
23,
66,
41580,
1129,
64,
31495,
2713,
67,
24,
65,
1860,
5892,
28362,
1,
198,
12303,
312,
796,
366,
6814,
3070,
7568,
3023,
12,
69,
4310,
65,
12,
20,
33319,
12,
64,
4309,
69,
12,
21,
64,
23,
65,
3312,
1238,
771,
15,
1,
198,
9641,
796,
366,
17,
13,
3682,
13,
21,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
8019,
562,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
33,
13344,
17,
62,
73,
297,
1600,
366,
11146,
6030,
17,
62,
73,
297,
1600,
366,
30214,
33,
19830,
62,
73,
297,
1600,
366,
13587,
69,
48230,
62,
73,
297,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
57,
8019,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
3270,
6469,
64,
5824,
16072,
7012,
1238,
69,
2999,
69,
3682,
558,
2598,
65,
4089,
5824,
1453,
17,
65,
15187,
5036,
2857,
1,
198,
12303,
312,
796,
366,
15,
330,
5237,
69,
2425,
12,
16,
67,
21,
69,
12,
20,
68,
4310,
12,
17457,
22,
66,
12,
6052,
65,
34137,
11848,
2718,
66,
15,
1,
198,
9641,
796,
366,
15,
13,
1314,
13,
16,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
8019,
39806,
81,
696,
14453,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
25835,
25404,
1600,
366,
11505,
9148,
1921,
62,
73,
297,
8973,
198,
12303,
312,
796,
366,
23,
68,
25764,
65,
3829,
12,
4521,
9945,
12,
20,
2682,
66,
12,
64,
15,
67,
18,
12,
1415,
3695,
24096,
66,
22,
67,
6052,
1,
198,
198,
30109,
10378,
82,
13,
8019,
16344,
74,
62,
64,
330,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
6814,
4134,
5705,
64,
3023,
1314,
5066,
69,
24,
2996,
1350,
47448,
3270,
64,
2623,
68,
1558,
66,
19,
68,
19,
69,
10210,
2816,
1,
198,
12303,
312,
796,
366,
69,
21,
2548,
69,
15,
64,
21,
12,
22,
21855,
15,
12,
20,
34938,
12,
3459,
7012,
12,
16,
535,
4524,
23539,
65,
21033,
1,
198,
9641,
796,
366,
17,
13,
15,
13,
17,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
8019,
11134,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
57,
8019,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
5824,
67,
15259,
64,
21,
67,
17,
65,
20,
68,
2816,
68,
34825,
68,
17,
67,
1983,
64,
1959,
276,
3023,
5036,
3720,
1765,
1270,
66,
1,
198,
12303,
312,
796,
366,
65,
4310,
65,
19,
66,
2996,
12,
24,
32066,
12,
3365,
1983,
12,
65,
16,
18213,
12,
23,
66,
22,
64,
16,
64,
5705,
35638,
69,
1,
198,
9641,
796,
366,
16,
13,
21,
13,
2548,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
8019,
20867,
41907,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
46,
1130,
62,
73,
297,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
65,
43234,
21101,
6659,
891,
18,
5036,
21,
68,
3695,
19881,
21,
558,
68,
25644,
43444,
4521,
16344,
21,
3609,
405,
66,
1,
198,
12303,
312,
796,
366,
69,
1983,
69,
21,
68,
2718,
12,
20,
67,
17,
65,
12,
4349,
7252,
12,
39277,
69,
12,
65,
27800,
69,
17,
15630,
18,
65,
22,
64,
1,
198,
9641,
796,
366,
16,
13,
18,
13,
22,
10,
16,
1,
198,
198,
30109,
10378,
82,
13,
77,
456,
29281,
17,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
25835,
25404,
8973,
198,
12303,
312,
796,
366,
23,
68,
25764,
18654,
12,
30610,
23,
12,
20,
29626,
12,
64,
2998,
66,
12,
22709,
330,
67,
17,
64,
1878,
23,
67,
1,
198,
198,
30109,
10378,
82,
13,
79,
22,
13344,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
25835,
25404,
8973,
198,
12303,
312,
796,
366,
18,
69,
1129,
68,
24,
2091,
12,
2091,
67,
23,
12,
4310,
65,
18,
12,
7252,
397,
12,
17457,
4349,
940,
66,
18,
65,
22,
64,
15,
1,
198,
198,
30109,
10378,
82,
13,
87,
18897,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
19,
5036,
64,
36993,
65,
4531,
68,
21,
721,
1120,
2231,
6052,
20964,
19881,
23,
65,
24,
3459,
65,
17,
66,
28694,
1828,
65,
17,
1,
198,
12303,
312,
796,
366,
1065,
2154,
276,
69,
20,
12,
69,
17,
69,
24,
12,
4309,
67,
17,
12,
5607,
68,
24,
12,
397,
405,
65,
20,
67,
15,
24693,
64,
1,
198,
9641,
796,
366,
1238,
2481,
13,
20,
13,
20,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
87,
22980,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
1453,
20,
3134,
64,
27192,
66,
344,
44215,
2154,
67,
3324,
324,
18,
64,
3559,
68,
24,
2999,
1507,
68,
29769,
2718,
64,
24,
1,
198,
12303,
312,
796,
366,
7568,
7252,
2931,
20,
69,
12,
1821,
3901,
12,
20,
67,
10210,
12,
6052,
1129,
12,
17,
36434,
67,
23,
34251,
65,
4304,
1,
198,
9641,
796,
366,
18,
13,
20,
13,
15,
10,
15,
1,
198,
198,
30109,
10378,
82,
13,
87,
32812,
11321,
62,
73,
297,
11907,
198,
10378,
82,
796,
14631,
8001,
37199,
1600,
366,
41,
3069,
36918,
11799,
1600,
366,
25835,
25404,
1600,
366,
47,
10025,
1600,
366,
25309,
1044,
62,
73,
297,
1600,
366,
25309,
1044,
62,
11235,
4668,
82,
62,
73,
297,
1600,
366,
55,
2398,
62,
8019,
87,
21101,
62,
73,
297,
1600,
366,
55,
2398,
62,
87,
2539,
3526,
62,
11250,
62,
73,
297,
8973,
198,
18300,
12,
21048,
12,
26270,
16,
796,
366,
68,
344,
22370,
486,
4524,
22186,
11848,
3132,
2934,
16,
64,
5066,
1350,
64,
18,
64,
3901,
3609,
16,
7252,
49051,
65,
21,
1,
198,
12303,
312,
796,
366,
67,
23,
21855,
3104,
67,
15,
12,
1065,
64,
18,
12,
20,
12993,
67,
12,
64,
5332,
64,
12,
67,
2920,
36809,
65,
21652,
16344,
1,
198,
9641,
796,
366,
15,
13,
24,
13,
16,
10,
20,
1,
198,
37811,
198,
198,
2,
2343,
243,
242,
28670,
22880,
94,
12440,
1502,
25,
198,
2,
2343,
243,
253,
7280,
23,
7012,
21,
64,
405,
64,
12,
22,
64,
4310,
12,
19,
67,
535,
12,
1878,
19,
67,
12,
21101,
5332,
7252,
24,
65,
19,
67,
3104,
198,
2,
2343,
243,
253,
7280,
3459,
3388,
69,
17657,
12,
16,
16072,
21,
12,
19,
535,
20,
12,
40022,
18,
12,
65,
23,
721,
4761,
64,
14454,
64,
21,
198,
2,
2343,
243,
253,
7280,
22413,
1731,
39251,
12,
31916,
68,
12,
19,
66,
3324,
12,
64,
3682,
65,
12,
23721,
7012,
19244,
68,
3459,
69,
198,
2,
2343,
243,
253,
7280,
50080,
535,
7568,
15,
12,
6052,
64,
24,
12,
19,
65,
18,
66,
12,
24,
37452,
12,
3459,
4051,
7012,
17,
69,
16,
69,
324,
198,
2,
2343,
243,
253,
7280,
22,
891,
1878,
1983,
66,
12,
23,
68,
15,
64,
12,
1821,
69,
24,
12,
330,
2078,
12,
1878,
3829,
2327,
4524,
1120,
64,
18,
198,
2,
2343,
243,
253,
7280,
2816,
18213,
5999,
1731,
12,
69,
2623,
67,
12,
1821,
17457,
12,
2079,
68,
18,
12,
5892,
68,
22,
16072,
65,
1878,
6888,
24,
198,
2,
2343,
243,
253,
7280,
14877,
17,
6814,
4309,
12,
22,
67,
17,
65,
12,
19,
66,
3720,
12,
6469,
344,
12,
4524,
1731,
67,
38219,
10210,
24,
65,
198,
2,
2343,
243,
253,
7280,
66,
32321,
66,
23,
64,
24,
12,
35195,
67,
12,
2857,
68,
19,
12,
24,
2091,
68,
12,
17,
68,
4349,
65,
44750,
68,
3312,
24,
198,
2,
2343,
243,
253,
7280,
24,
1485,
2231,
67,
3023,
12,
69,
35126,
12,
19,
68,
3829,
12,
24,
2327,
68,
12,
64,
19,
17896,
9031,
25707,
9945,
198,
2,
2343,
243,
253,
7280,
22,
1129,
37688,
5036,
12,
18,
891,
21,
12,
19,
68,
4310,
12,
324,
4309,
12,
6469,
15187,
68,
18,
67,
15,
65,
20,
68,
198,
2,
2343,
243,
253,
7280,
16,
67,
19,
67,
1899,
3270,
12,
20,
65,
3720,
12,
3559,
10210,
12,
330,
1558,
12,
891,
17,
7252,
43526,
721,
324,
198,
2,
2343,
243,
253,
7280,
67,
3510,
771,
1415,
12,
64,
20,
67,
18,
12,
2231,
64,
24,
12,
24,
67,
3559,
12,
2548,
17896,
3695,
3720,
65,
15,
66,
22,
198,
2,
2343,
243,
253,
7280,
67,
2327,
3104,
66,
20,
67,
12,
1433,
19881,
12,
19,
39357,
12,
4089,
6420,
12,
15,
1350,
2996,
67,
5237,
65,
2623,
66,
198,
2,
2343,
243,
253,
7280,
2816,
67,
19,
397,
2780,
12,
24,
44169,
12,
19,
16344,
24,
12,
330,
3312,
12,
2091,
2548,
69,
9945,
39667,
66,
19,
198,
2,
2343,
243,
253,
7280,
20,
3559,
32869,
1731,
12,
18,
2860,
12,
19,
69,
6052,
12,
6420,
65,
15,
12,
68,
20809,
1433,
3104,
3682,
3609,
198,
2,
2343,
243,
254,
28670,
36330,
3609,
18,
64,
15,
12,
1795,
3104,
12,
2857,
2857,
12,
3865,
64,
22,
12,
67,
35175,
2816,
28362,
69,
1959,
198,
2,
2343,
243,
254,
28670,
3312,
64,
3829,
36626,
12,
65,
19,
21101,
12,
19,
67,
2624,
12,
1878,
15,
67,
12,
17,
69,
2919,
3559,
2414,
18741,
66,
198,
2,
2343,
243,
254,
28670,
65,
3104,
3829,
2934,
15,
12,
4531,
1954,
12,
1157,
721,
12,
2327,
4309,
12,
18,
16616,
65,
1860,
4310,
69,
4521,
198,
2,
2343,
243,
253,
7280,
8269,
12,
2388,
12,
2388,
12,
2388,
12,
8269,
18005,
198,
2,
2343,
243,
253,
7280,
8269,
12,
2388,
12,
2388,
12,
2388,
12,
8269,
34215,
198
] | 2.051136 | 26,283 |
#!/bin/bash
#=
exec julia -O3 --color=yes -qi "${BASH_SOURCE[0]}"
=#
using Pkg
cd(@__DIR__)
Pkg.activate("..")
using Retest
@retest(@__DIR__)
# Local Variables:
# mode: julia
# End:
| [
2,
48443,
8800,
14,
41757,
198,
2,
28,
198,
18558,
474,
43640,
532,
46,
18,
1377,
8043,
28,
8505,
532,
40603,
17971,
90,
33,
11211,
62,
47690,
58,
15,
60,
36786,
198,
46249,
198,
198,
3500,
350,
10025,
198,
10210,
7,
31,
834,
34720,
834,
8,
198,
47,
10025,
13,
39022,
7203,
492,
4943,
198,
198,
3500,
4990,
395,
198,
31,
1186,
395,
7,
31,
834,
34720,
834,
8,
198,
198,
2,
10714,
15965,
2977,
25,
198,
2,
4235,
25,
474,
43640,
198,
2,
5268,
25,
198
] | 2.126437 | 87 |
mutable struct Position
x::Int
y::Int
end
struct Size
width::Int
height::Int
end
s1 = Spaceship(Position(0,0), Size(30,5), Missile);
s2 = Spaceship(Position(10,0), Size(30,5), Laser);
a1 = Asteroid(Position(20,0), Size(20,20));
a2 = Asteroid(Position(0,20), Size(20,20));
struct Rectangle
top::Int
left::Int
bottom::Int
right::Int
# return the upper-left and lower-right points
Rectangle(p::Position, s::Size) =
new(p.y + s.height, p.x, p.y, p.x+s.width)
end
# check if the 2 rectangles (A & B) overlap
function overlap(A::Rectangle, B::Rectangle)
return A.left < B.right && A.right > B.left &&
A.top > B.bottom && A.bottom < B.top
end
function collide(A::Thing, B::Thing)
println("Checking collision of thing vs. thing")
rectA = Rectangle(position(A), size(A))
rectB = Rectangle(position(B), size(B))
return overlap(rectA, rectB)
end
function collide(A::Spaceship, B::Spaceship)
println("Checking collision of spaceship vs. spaceship")
return true # just a test
end
# Randomly pick two things and check
function check_randomly(things)
for i in 1:5
two = rand(things, 2)
collide(two...)
end
end | [
76,
18187,
2878,
23158,
198,
220,
220,
220,
2124,
3712,
5317,
198,
220,
220,
220,
331,
3712,
5317,
198,
437,
198,
198,
7249,
12849,
198,
220,
220,
220,
9647,
3712,
5317,
198,
220,
220,
220,
6001,
3712,
5317,
198,
437,
198,
198,
82,
16,
796,
48086,
1056,
7,
26545,
7,
15,
11,
15,
828,
12849,
7,
1270,
11,
20,
828,
25350,
1776,
198,
82,
17,
796,
48086,
1056,
7,
26545,
7,
940,
11,
15,
828,
12849,
7,
1270,
11,
20,
828,
23222,
1776,
198,
64,
16,
796,
38484,
1868,
7,
26545,
7,
1238,
11,
15,
828,
12849,
7,
1238,
11,
1238,
18125,
198,
64,
17,
796,
38484,
1868,
7,
26545,
7,
15,
11,
1238,
828,
12849,
7,
1238,
11,
1238,
18125,
628,
198,
7249,
48599,
9248,
198,
220,
220,
220,
1353,
3712,
5317,
198,
220,
220,
220,
1364,
3712,
5317,
198,
220,
220,
220,
4220,
3712,
5317,
198,
220,
220,
220,
826,
3712,
5317,
198,
220,
220,
220,
1303,
1441,
262,
6727,
12,
9464,
290,
2793,
12,
3506,
2173,
198,
220,
220,
220,
48599,
9248,
7,
79,
3712,
26545,
11,
264,
3712,
10699,
8,
796,
198,
220,
220,
220,
220,
220,
220,
220,
649,
7,
79,
13,
88,
1343,
264,
13,
17015,
11,
279,
13,
87,
11,
279,
13,
88,
11,
279,
13,
87,
10,
82,
13,
10394,
8,
198,
437,
198,
198,
2,
2198,
611,
262,
362,
13621,
27787,
357,
32,
1222,
347,
8,
21721,
198,
8818,
21721,
7,
32,
3712,
45474,
9248,
11,
347,
3712,
45474,
9248,
8,
198,
220,
220,
220,
1441,
317,
13,
9464,
1279,
347,
13,
3506,
11405,
317,
13,
3506,
1875,
347,
13,
9464,
11405,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
317,
13,
4852,
1875,
347,
13,
22487,
11405,
317,
13,
22487,
1279,
347,
13,
4852,
198,
437,
198,
198,
8818,
46592,
7,
32,
3712,
51,
722,
11,
347,
3712,
51,
722,
8,
198,
220,
220,
220,
44872,
7203,
9787,
278,
17661,
286,
1517,
3691,
13,
1517,
4943,
198,
220,
220,
220,
13621,
32,
796,
48599,
9248,
7,
9150,
7,
32,
828,
2546,
7,
32,
4008,
198,
220,
220,
220,
13621,
33,
796,
48599,
9248,
7,
9150,
7,
33,
828,
2546,
7,
33,
4008,
198,
220,
220,
220,
1441,
21721,
7,
2554,
32,
11,
13621,
33,
8,
198,
437,
628,
198,
8818,
46592,
7,
32,
3712,
4561,
2114,
1056,
11,
347,
3712,
4561,
2114,
1056,
8,
198,
220,
220,
220,
44872,
7203,
9787,
278,
17661,
286,
40663,
3691,
13,
40663,
4943,
198,
220,
220,
220,
1441,
2081,
1303,
655,
257,
1332,
198,
437,
198,
198,
2,
14534,
306,
2298,
734,
1243,
290,
2198,
198,
8818,
2198,
62,
25120,
306,
7,
27971,
8,
198,
220,
220,
220,
329,
1312,
287,
352,
25,
20,
198,
220,
220,
220,
220,
220,
220,
220,
734,
796,
43720,
7,
27971,
11,
362,
8,
198,
220,
220,
220,
220,
220,
220,
220,
46592,
7,
11545,
23029,
198,
220,
220,
220,
886,
198,
437
] | 2.487705 | 488 |
############################################################
# judiWavefield ##############################################
############################################################
# Authors: Philipp Witte ([email protected]), Henryk Modzelewski ([email protected])
# Date: June 2017
export judiWavefield, fft, ifft
############################################################
mutable struct judiWavefield{T} <: judiMultiSourceVector{T}
nsrc::Integer
dt::Vector{T}
data::Vector{<:Union{Array{T, N}, PyArray}} where N
end
############################################################
## outer constructors
"""
judiWavefield
nsrc::Integer
dt::AbstractFloat
data
Abstract vector for seismic wavefields.
Constructors
============
Construct wavefield vector from an info structure, a cell array of wavefields and the computational \\
time step dt:
judiWavefield(nsrc, dt, data)
"""
function judiWavefield(nsrc::Integer, dt::AbstractFloat, data::Array{T, N}) where {T<:Number, N}
# length of vector
dataCell = [convert(Array{Float32, N}, data) for j=1:nsrc]
return judiWavefield{Float32}(nsrc, [Float32(dt) for i=1:nsrc], dataCell)
end
function judiWavefield(dt::AbstractFloat, data::Vector{Array{T, N}}) where {T, N}
# length of vector
nsrc = length(data)
T != Float32 && (data = tof32.(data))
return judiWavefield{Float32}(nsrc, [Float32(dt) for i=1:nsrc], data)
end
judiWavefield(dt::AbstractFloat, nsrc::Integer, data::Array{T, N}) where {T<:Number, N} = judiWavefield(nsrc, dt, data)
judiWavefield(dt::AbstractFloat, data::Vector{Any}) = judiWavefield(dt, tof32.(data))
judiWavefield(dt::AbstractFloat, data::Array{T, N}) where {T<:Number, N} = judiWavefield(1, dt, data)
conj(w::judiWavefield{T}) where {T<:Complex} = judiWavefield{R}(w.nsrc, w.dt, conj(w.data))
############################################################
## overloaded multi_source functions
time_sampling(jv::judiWavefield) = jv.dt
####################################################################
# JOLI conversion
jo_convert(::Type{T}, jw::judiWavefield{T}, ::Bool) where {T<:Number} = jw
jo_convert(::Type{T}, jw::judiWavefield{vT}, B::Bool) where {T<:Number, vT} = judiWavefield{T}(jw.nsrc, jv.dt, jo_convert.(T, jw.data, B))
zero(::Type{T}, v::judiWavefield{vT}; nsrc::Integer=v.nsrc) where {T, vT} = judiWavefield{T}(nsrc, v.dt, T(0) .* v.data[1:nsrc])
zero(::Type{T}, v::judiWavefield{vT}; nsrc::Integer=v.nsrc) where {T<:AbstractFloat, vT<:Complex} = judiWavefield{T}(nsrc, v.dt, T(0) .* real(v.data[1:nsrc]))
(w::judiWavefield)(x::Vector{<:Array}) = judiWavefield(w.dt, x)
function copy!(jv::judiWavefield, jv2::judiWavefield)
v.data .= jv2.data
jv.dt = jv2.dt
jv
end
copyto!(jv::judiWavefield, jv2::judiWavefield) = copy!(jv, jv2)
make_input(w::judiWavefield) = w.data[1]
check_compat(ms::Vararg{judiWavefield, N}) where N = all(y -> y.dt == first(ms).dt, ms)
getindex(a::judiWavefield{T}, srcnum::RangeOrVec) where T = judiWavefield{T}(length(srcnum), a.dt[srcnum], a.data[srcnum])
####################################################################
function push!(a::judiWavefield{T}, b::judiWavefield{T}) where T
append!(a.data, b.data)
append!(a.dt, b.dt)
a.nsrc += b.nsrc
end
# DFT operator for wavefields, acts along time dimension
function fft(x_in::judiWavefield{T}) where T
x = similar(x_in, Complex{Float32})
for i=1:x_in.nsrc
x.data[i] = fft(x_in.data[i], 1)/sqrt(size(x_in.data[i], 1))
end
return x
end
function ifft(x_in::judiWavefield{T}) where T
x = similar(x_in, Float32)
for i=1:x_in.nsrc
x.data[i] = real(ifft(x_in.data[i], 1)) * sqrt(size(x_in.data[i], 1))
end
return x
end
| [
29113,
14468,
7804,
4242,
198,
2,
2553,
72,
39709,
3245,
1303,
29113,
7804,
4242,
2,
198,
29113,
14468,
7804,
4242,
198,
198,
2,
46665,
25,
9844,
370,
2654,
357,
79,
86,
2654,
31,
68,
418,
13,
549,
66,
13,
6888,
828,
8616,
74,
3401,
2736,
293,
18504,
4106,
357,
71,
4666,
2736,
293,
18504,
4106,
31,
68,
418,
13,
549,
66,
13,
6888,
8,
198,
2,
7536,
25,
2795,
2177,
198,
198,
39344,
2553,
72,
39709,
3245,
11,
277,
701,
11,
611,
701,
198,
198,
29113,
14468,
7804,
4242,
198,
198,
76,
18187,
2878,
2553,
72,
39709,
3245,
90,
51,
92,
1279,
25,
2553,
72,
29800,
7416,
38469,
90,
51,
92,
198,
220,
220,
220,
299,
10677,
3712,
46541,
198,
220,
220,
220,
288,
83,
3712,
38469,
90,
51,
92,
198,
220,
220,
220,
1366,
3712,
38469,
90,
27,
25,
38176,
90,
19182,
90,
51,
11,
399,
5512,
9485,
19182,
11709,
810,
399,
198,
437,
198,
198,
29113,
14468,
7804,
4242,
198,
198,
2235,
12076,
5678,
669,
198,
198,
37811,
198,
10456,
72,
39709,
3245,
198,
220,
220,
220,
220,
220,
220,
220,
299,
10677,
3712,
46541,
198,
220,
220,
220,
220,
220,
220,
220,
288,
83,
3712,
23839,
43879,
198,
220,
220,
220,
220,
220,
220,
220,
1366,
198,
198,
23839,
15879,
329,
37463,
6769,
25747,
13,
198,
198,
42316,
669,
198,
25609,
198,
198,
42316,
6769,
3245,
15879,
422,
281,
7508,
4645,
11,
257,
2685,
7177,
286,
6769,
25747,
290,
262,
31350,
26867,
198,
2435,
2239,
288,
83,
25,
628,
220,
220,
220,
2553,
72,
39709,
3245,
7,
5907,
6015,
11,
288,
83,
11,
1366,
8,
628,
198,
37811,
198,
8818,
2553,
72,
39709,
3245,
7,
5907,
6015,
3712,
46541,
11,
288,
83,
3712,
23839,
43879,
11,
1366,
3712,
19182,
90,
51,
11,
399,
30072,
810,
1391,
51,
27,
25,
15057,
11,
399,
92,
198,
197,
2,
4129,
286,
15879,
198,
197,
7890,
28780,
796,
685,
1102,
1851,
7,
19182,
90,
43879,
2624,
11,
399,
5512,
1366,
8,
329,
474,
28,
16,
25,
5907,
6015,
60,
198,
197,
7783,
2553,
72,
39709,
3245,
90,
43879,
2624,
92,
7,
5907,
6015,
11,
685,
43879,
2624,
7,
28664,
8,
329,
1312,
28,
16,
25,
5907,
6015,
4357,
1366,
28780,
8,
198,
437,
198,
198,
8818,
2553,
72,
39709,
3245,
7,
28664,
3712,
23839,
43879,
11,
1366,
3712,
38469,
90,
19182,
90,
51,
11,
399,
11709,
8,
810,
1391,
51,
11,
399,
92,
198,
197,
2,
4129,
286,
15879,
198,
197,
5907,
6015,
796,
4129,
7,
7890,
8,
198,
197,
51,
14512,
48436,
2624,
11405,
357,
7890,
796,
284,
69,
2624,
12195,
7890,
4008,
198,
197,
7783,
2553,
72,
39709,
3245,
90,
43879,
2624,
92,
7,
5907,
6015,
11,
685,
43879,
2624,
7,
28664,
8,
329,
1312,
28,
16,
25,
5907,
6015,
4357,
1366,
8,
198,
437,
198,
198,
10456,
72,
39709,
3245,
7,
28664,
3712,
23839,
43879,
11,
299,
10677,
3712,
46541,
11,
1366,
3712,
19182,
90,
51,
11,
399,
30072,
810,
1391,
51,
27,
25,
15057,
11,
399,
92,
796,
2553,
72,
39709,
3245,
7,
5907,
6015,
11,
288,
83,
11,
1366,
8,
198,
10456,
72,
39709,
3245,
7,
28664,
3712,
23839,
43879,
11,
1366,
3712,
38469,
90,
7149,
30072,
796,
2553,
72,
39709,
3245,
7,
28664,
11,
284,
69,
2624,
12195,
7890,
4008,
198,
10456,
72,
39709,
3245,
7,
28664,
3712,
23839,
43879,
11,
1366,
3712,
19182,
90,
51,
11,
399,
30072,
810,
1391,
51,
27,
25,
15057,
11,
399,
92,
796,
2553,
72,
39709,
3245,
7,
16,
11,
288,
83,
11,
1366,
8,
198,
198,
1102,
73,
7,
86,
3712,
10456,
72,
39709,
3245,
90,
51,
30072,
810,
1391,
51,
27,
25,
5377,
11141,
92,
796,
2553,
72,
39709,
3245,
90,
49,
92,
7,
86,
13,
5907,
6015,
11,
266,
13,
28664,
11,
11644,
7,
86,
13,
7890,
4008,
198,
198,
29113,
14468,
7804,
4242,
198,
2235,
50068,
5021,
62,
10459,
5499,
198,
2435,
62,
37687,
11347,
7,
73,
85,
3712,
10456,
72,
39709,
3245,
8,
796,
474,
85,
13,
28664,
198,
198,
29113,
29113,
4242,
198,
2,
449,
3535,
40,
11315,
198,
7639,
62,
1102,
1851,
7,
3712,
6030,
90,
51,
5512,
474,
86,
3712,
10456,
72,
39709,
3245,
90,
51,
5512,
7904,
33,
970,
8,
810,
1391,
51,
27,
25,
15057,
92,
796,
474,
86,
198,
7639,
62,
1102,
1851,
7,
3712,
6030,
90,
51,
5512,
474,
86,
3712,
10456,
72,
39709,
3245,
90,
85,
51,
5512,
347,
3712,
33,
970,
8,
810,
1391,
51,
27,
25,
15057,
11,
410,
51,
92,
796,
2553,
72,
39709,
3245,
90,
51,
92,
7,
73,
86,
13,
5907,
6015,
11,
474,
85,
13,
28664,
11,
2525,
62,
1102,
1851,
12195,
51,
11,
474,
86,
13,
7890,
11,
347,
4008,
198,
22570,
7,
3712,
6030,
90,
51,
5512,
410,
3712,
10456,
72,
39709,
3245,
90,
85,
51,
19629,
299,
10677,
3712,
46541,
28,
85,
13,
5907,
6015,
8,
810,
1391,
51,
11,
410,
51,
92,
796,
2553,
72,
39709,
3245,
90,
51,
92,
7,
5907,
6015,
11,
410,
13,
28664,
11,
309,
7,
15,
8,
764,
9,
410,
13,
7890,
58,
16,
25,
5907,
6015,
12962,
198,
22570,
7,
3712,
6030,
90,
51,
5512,
410,
3712,
10456,
72,
39709,
3245,
90,
85,
51,
19629,
299,
10677,
3712,
46541,
28,
85,
13,
5907,
6015,
8,
810,
1391,
51,
27,
25,
23839,
43879,
11,
410,
51,
27,
25,
5377,
11141,
92,
796,
2553,
72,
39709,
3245,
90,
51,
92,
7,
5907,
6015,
11,
410,
13,
28664,
11,
309,
7,
15,
8,
764,
9,
1103,
7,
85,
13,
7890,
58,
16,
25,
5907,
6015,
60,
4008,
198,
7,
86,
3712,
10456,
72,
39709,
3245,
5769,
87,
3712,
38469,
90,
27,
25,
19182,
30072,
796,
2553,
72,
39709,
3245,
7,
86,
13,
28664,
11,
2124,
8,
198,
198,
8818,
4866,
0,
7,
73,
85,
3712,
10456,
72,
39709,
3245,
11,
474,
85,
17,
3712,
10456,
72,
39709,
3245,
8,
198,
220,
220,
220,
410,
13,
7890,
764,
28,
474,
85,
17,
13,
7890,
198,
220,
220,
220,
474,
85,
13,
28664,
796,
474,
85,
17,
13,
28664,
198,
220,
220,
220,
474,
85,
198,
437,
198,
198,
30073,
1462,
0,
7,
73,
85,
3712,
10456,
72,
39709,
3245,
11,
474,
85,
17,
3712,
10456,
72,
39709,
3245,
8,
796,
4866,
0,
7,
73,
85,
11,
474,
85,
17,
8,
198,
15883,
62,
15414,
7,
86,
3712,
10456,
72,
39709,
3245,
8,
796,
266,
13,
7890,
58,
16,
60,
198,
9122,
62,
5589,
265,
7,
907,
3712,
19852,
853,
90,
10456,
72,
39709,
3245,
11,
399,
30072,
810,
399,
796,
477,
7,
88,
4613,
331,
13,
28664,
6624,
717,
7,
907,
737,
28664,
11,
13845,
8,
198,
198,
1136,
9630,
7,
64,
3712,
10456,
72,
39709,
3245,
90,
51,
5512,
12351,
22510,
3712,
17257,
5574,
53,
721,
8,
810,
309,
796,
2553,
72,
39709,
3245,
90,
51,
92,
7,
13664,
7,
10677,
22510,
828,
257,
13,
28664,
58,
10677,
22510,
4357,
257,
13,
7890,
58,
10677,
22510,
12962,
198,
29113,
29113,
4242,
198,
198,
8818,
4574,
0,
7,
64,
3712,
10456,
72,
39709,
3245,
90,
51,
5512,
275,
3712,
10456,
72,
39709,
3245,
90,
51,
30072,
810,
309,
198,
220,
220,
220,
24443,
0,
7,
64,
13,
7890,
11,
275,
13,
7890,
8,
198,
220,
220,
220,
24443,
0,
7,
64,
13,
28664,
11,
275,
13,
28664,
8,
198,
220,
220,
220,
257,
13,
5907,
6015,
15853,
275,
13,
5907,
6015,
198,
437,
198,
198,
2,
360,
9792,
10088,
329,
6769,
25747,
11,
6529,
1863,
640,
15793,
198,
8818,
277,
701,
7,
87,
62,
259,
3712,
10456,
72,
39709,
3245,
90,
51,
30072,
810,
309,
198,
220,
220,
220,
2124,
796,
2092,
7,
87,
62,
259,
11,
19157,
90,
43879,
2624,
30072,
198,
220,
220,
220,
329,
1312,
28,
16,
25,
87,
62,
259,
13,
5907,
6015,
198,
220,
220,
220,
220,
220,
220,
220,
2124,
13,
7890,
58,
72,
60,
796,
277,
701,
7,
87,
62,
259,
13,
7890,
58,
72,
4357,
352,
20679,
31166,
17034,
7,
7857,
7,
87,
62,
259,
13,
7890,
58,
72,
4357,
352,
4008,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
2124,
198,
437,
198,
198,
8818,
611,
701,
7,
87,
62,
259,
3712,
10456,
72,
39709,
3245,
90,
51,
30072,
810,
309,
198,
220,
220,
220,
2124,
796,
2092,
7,
87,
62,
259,
11,
48436,
2624,
8,
198,
220,
220,
220,
329,
1312,
28,
16,
25,
87,
62,
259,
13,
5907,
6015,
198,
220,
220,
220,
220,
220,
220,
220,
2124,
13,
7890,
58,
72,
60,
796,
1103,
7,
361,
701,
7,
87,
62,
259,
13,
7890,
58,
72,
4357,
352,
4008,
1635,
19862,
17034,
7,
7857,
7,
87,
62,
259,
13,
7890,
58,
72,
4357,
352,
4008,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
2124,
198,
437,
198
] | 2.557613 | 1,458 |
export pswap, singlet_block, basis_rotor
using YaoBlocks
using YaoArrayRegister: mulrow!, u1rows!
function Yao.apply!(reg::ArrayReg, pb::PutBlock{N,2,RotationGate{2,T,G}}) where {N,T,G<:SWAPGate}
mask1 = bmask(pb.locs[1])
mask2 = bmask(pb.locs[2])
mask12 = mask1|mask2
a, c, b_, d = mat(Rx(pb.content.theta))
e = exp(-im/2*pb.content.theta)
state = statevec(reg)
for b in basis(reg)
if b&mask1==0
i = b+1
i_ = b ⊻ mask12 + 1
if b&mask2==mask2
u1rows!(state, i, i_, a, b_, c, d)
else
mulrow!(state, i, e)
mulrow!(state, i_, e)
end
end
end
return reg
end
mutable struct Bag{N}<:TagBlock{AbstractBlock, N}
content::AbstractBlock{N}
end
Yao.content(bag) = bag.content
Yao.chcontent(bag::Bag, content) = Bag(content)
Yao.mat(bag::Bag) = mat(bag.content)
Yao.apply!(reg::AbstractRegister, bag::Bag) = apply!(reg, bag.content)
YaoBlocks.PreserveStyle(::Bag) = YaoBlocks.PreserveAll()
setcontent!(bag::Bag, content) = (bag.content = content; bag)
function YaoBlocks.print_annotation(io::IO, bag::Bag)
printstyled(io, "[⊞] "; bold=true, color=:blue)
end
"""parametrized swap gate."""
function pswap(nbit::Int, i::Int, j::Int)
put(nbit, (i,j)=>rot(SWAP, 0.0))
end
"""block for generating singlets."""
function singlet_block(nbit::Int, i::Int, j::Int)
unit = chain(nbit)
push!(unit, put(nbit, i=>chain(X, H)))
push!(unit, control(nbit, -i, j=>X))
end
basis_rotor(::ZGate) = I2Gate()
basis_rotor(::XGate) = Ry(-0.5π)
basis_rotor(::YGate) = Rx(0.5π)
basis_rotor(basis::PauliGate, nbit, locs) = repeat(nbit, basis_rotor(basis), locs)
| [
39344,
279,
2032,
499,
11,
1702,
1616,
62,
9967,
11,
4308,
62,
10599,
273,
198,
3500,
37826,
45356,
198,
3500,
37826,
19182,
38804,
25,
35971,
808,
28265,
334,
16,
8516,
0,
198,
198,
8818,
37826,
13,
39014,
0,
7,
2301,
3712,
19182,
8081,
11,
279,
65,
3712,
11588,
12235,
90,
45,
11,
17,
11,
49,
14221,
22628,
90,
17,
11,
51,
11,
38,
11709,
8,
810,
1391,
45,
11,
51,
11,
38,
27,
25,
17887,
2969,
22628,
92,
198,
220,
220,
220,
9335,
16,
796,
275,
27932,
7,
40842,
13,
17946,
82,
58,
16,
12962,
198,
220,
220,
220,
9335,
17,
796,
275,
27932,
7,
40842,
13,
17946,
82,
58,
17,
12962,
198,
220,
220,
220,
9335,
1065,
796,
9335,
16,
91,
27932,
17,
198,
220,
220,
220,
257,
11,
269,
11,
275,
62,
11,
288,
796,
2603,
7,
49,
87,
7,
40842,
13,
11299,
13,
1169,
8326,
4008,
198,
220,
220,
220,
304,
796,
1033,
32590,
320,
14,
17,
9,
40842,
13,
11299,
13,
1169,
8326,
8,
198,
220,
220,
220,
1181,
796,
1181,
35138,
7,
2301,
8,
198,
220,
220,
220,
329,
275,
287,
4308,
7,
2301,
8,
198,
220,
220,
220,
220,
220,
220,
220,
611,
275,
5,
27932,
16,
855,
15,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1312,
796,
275,
10,
16,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1312,
62,
796,
275,
2343,
232,
119,
9335,
1065,
1343,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
275,
5,
27932,
17,
855,
27932,
17,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
16,
8516,
0,
7,
5219,
11,
1312,
11,
1312,
62,
11,
257,
11,
275,
62,
11,
269,
11,
288,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
35971,
808,
0,
7,
5219,
11,
1312,
11,
304,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
35971,
808,
0,
7,
5219,
11,
1312,
62,
11,
304,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
842,
198,
437,
198,
198,
76,
18187,
2878,
20127,
90,
45,
92,
27,
25,
24835,
12235,
90,
23839,
12235,
11,
399,
92,
198,
220,
220,
220,
2695,
3712,
23839,
12235,
90,
45,
92,
198,
437,
198,
198,
56,
5488,
13,
11299,
7,
21454,
8,
796,
6131,
13,
11299,
198,
56,
5488,
13,
354,
11299,
7,
21454,
3712,
33,
363,
11,
2695,
8,
796,
20127,
7,
11299,
8,
198,
56,
5488,
13,
6759,
7,
21454,
3712,
33,
363,
8,
796,
2603,
7,
21454,
13,
11299,
8,
198,
56,
5488,
13,
39014,
0,
7,
2301,
3712,
23839,
38804,
11,
6131,
3712,
33,
363,
8,
796,
4174,
0,
7,
2301,
11,
6131,
13,
11299,
8,
198,
56,
5488,
45356,
13,
25460,
3760,
21466,
7,
3712,
33,
363,
8,
796,
37826,
45356,
13,
25460,
3760,
3237,
3419,
198,
2617,
11299,
0,
7,
21454,
3712,
33,
363,
11,
2695,
8,
796,
357,
21454,
13,
11299,
796,
2695,
26,
6131,
8,
198,
198,
8818,
37826,
45356,
13,
4798,
62,
1236,
14221,
7,
952,
3712,
9399,
11,
6131,
3712,
33,
363,
8,
198,
220,
220,
220,
3601,
34365,
992,
7,
952,
11,
12878,
158,
232,
252,
60,
366,
26,
10758,
28,
7942,
11,
3124,
28,
25,
17585,
8,
198,
437,
198,
198,
37811,
17143,
316,
380,
8863,
16075,
8946,
526,
15931,
198,
8818,
279,
2032,
499,
7,
77,
2545,
3712,
5317,
11,
1312,
3712,
5317,
11,
474,
3712,
5317,
8,
198,
220,
220,
220,
1234,
7,
77,
2545,
11,
357,
72,
11,
73,
8,
14804,
10599,
7,
17887,
2969,
11,
657,
13,
15,
4008,
198,
437,
198,
198,
37811,
9967,
329,
15453,
2060,
912,
526,
15931,
198,
8818,
1702,
1616,
62,
9967,
7,
77,
2545,
3712,
5317,
11,
1312,
3712,
5317,
11,
474,
3712,
5317,
8,
198,
220,
220,
220,
4326,
796,
6333,
7,
77,
2545,
8,
198,
220,
220,
220,
4574,
0,
7,
20850,
11,
1234,
7,
77,
2545,
11,
1312,
14804,
7983,
7,
55,
11,
367,
22305,
198,
220,
220,
220,
4574,
0,
7,
20850,
11,
1630,
7,
77,
2545,
11,
532,
72,
11,
474,
14804,
55,
4008,
198,
437,
198,
198,
12093,
271,
62,
10599,
273,
7,
3712,
57,
22628,
8,
796,
314,
17,
22628,
3419,
198,
12093,
271,
62,
10599,
273,
7,
3712,
55,
22628,
8,
796,
11089,
32590,
15,
13,
20,
46582,
8,
198,
12093,
271,
62,
10599,
273,
7,
3712,
56,
22628,
8,
796,
49715,
7,
15,
13,
20,
46582,
8,
198,
198,
12093,
271,
62,
10599,
273,
7,
12093,
271,
3712,
12041,
72,
22628,
11,
299,
2545,
11,
1179,
82,
8,
796,
9585,
7,
77,
2545,
11,
4308,
62,
10599,
273,
7,
12093,
271,
828,
1179,
82,
8,
628,
198
] | 2.040476 | 840 |
# this takes a load of spikes and plots them on an animated graph
function spiketrain(t, spikes)
# get co-ordinates for the spikes
spiked= findall(spikes)
spcoords = (t .* ones(length(spiked)), spiked)
sc = scatter!(spcoords,xlims=(0,1000),marker=1, legend=false)
display(sc)
end
function spiketrain(t, matrix::Array{<:Any,2}, spikes::BitArray{1})
matrix[:,t] = spikes
imshow(matrix)
return(matrix)
end
function visualiseweights(weights)
GR.imshow(repeat(weights))
end
function dashboard(plt, t, weights, activation, spt, da, rec)
plt.p1 = plotact!(plt.p1, activation)
plt.p2 = plotspt!(plt.p2, spt, t)
plt.p3 = plotda!(plt.p3, [da], [t])
plt.p4 = plotrec!(plt.p4, rec)
p = plot(plt.p1, plt.p2, plt.p3, plt.p4, layout = grid(2,2), legend=false, show=true)
display(p)
end
function dashboard(plt, t, l, m::MatrixTypes, da)
plt.p1 = plotact!(plt.p1, m.activation.layers[l])
plt.p2 = plotspt!(plt.p2, m.spt.layers[l], t)
plt.p3 = plotda!(plt.p3, [da], [t])
plt.p4 = plotrec!(plt.p4, m.rec.layers[l])
p = plot(plt.p1, plt.p2, plt.p3, plt.p4, layout = grid(2,2), legend=false, show=true)
display(p)
end
mutable struct Dashplot
p1::Plots.Plot{<:AbstractBackend}
p2::Plots.Plot{<:AbstractBackend}
p3::Plots.Plot{<:AbstractBackend}
p4::Plots.Plot{<:AbstractBackend}
Dashplot() = new(heatmap(),heatmap(), scatter(), heatmap())
end
function initialiseplot(plottype::Function)
return plottype()
end
function plotact!(p1, activation)
heatmap!(p1, reshape(activation, length(activation), 1))
end
function plotspt!(p2, spt, t)
spiked = spt.==t
heatmap!(p2, reshape(spiked, length(spiked),1))
end
function plotda!(p3, t, da)
scatter!(p3, da, t)
end
function plotrec!(p4, rec)
heatmap!(p4, reshape(rec,length(rec),1))
end | [
2,
428,
2753,
257,
3440,
286,
27198,
290,
21528,
606,
319,
281,
15108,
4823,
198,
8818,
599,
1134,
316,
3201,
7,
83,
11,
27198,
8,
628,
198,
197,
2,
651,
763,
12,
585,
17540,
329,
262,
27198,
198,
197,
2777,
17951,
28,
1064,
439,
7,
2777,
7938,
8,
198,
197,
2777,
1073,
3669,
796,
357,
83,
764,
9,
3392,
7,
13664,
7,
2777,
17951,
36911,
38927,
8,
198,
197,
1416,
796,
41058,
0,
7,
2777,
1073,
3669,
11,
87,
2475,
82,
16193,
15,
11,
12825,
828,
4102,
263,
28,
16,
11,
8177,
28,
9562,
8,
198,
197,
13812,
7,
1416,
8,
198,
437,
198,
198,
8818,
599,
1134,
316,
3201,
7,
83,
11,
17593,
3712,
19182,
90,
27,
25,
7149,
11,
17,
5512,
27198,
3712,
13128,
19182,
90,
16,
30072,
628,
197,
6759,
8609,
58,
45299,
83,
60,
796,
27198,
198,
197,
320,
12860,
7,
6759,
8609,
8,
198,
197,
7783,
7,
6759,
8609,
8,
198,
437,
198,
198,
8818,
5874,
271,
413,
68,
2337,
7,
43775,
8,
628,
197,
10761,
13,
320,
12860,
7,
44754,
7,
43775,
4008,
198,
437,
198,
198,
8818,
30415,
7,
489,
83,
11,
256,
11,
19590,
11,
14916,
11,
264,
457,
11,
12379,
11,
664,
8,
628,
197,
489,
83,
13,
79,
16,
796,
7110,
529,
0,
7,
489,
83,
13,
79,
16,
11,
14916,
8,
198,
197,
489,
83,
13,
79,
17,
796,
21528,
457,
0,
7,
489,
83,
13,
79,
17,
11,
264,
457,
11,
256,
8,
198,
197,
489,
83,
13,
79,
18,
796,
7110,
6814,
0,
7,
489,
83,
13,
79,
18,
11,
685,
6814,
4357,
685,
83,
12962,
198,
197,
489,
83,
13,
79,
19,
796,
7110,
8344,
0,
7,
489,
83,
13,
79,
19,
11,
664,
8,
198,
197,
79,
796,
7110,
7,
489,
83,
13,
79,
16,
11,
458,
83,
13,
79,
17,
11,
458,
83,
13,
79,
18,
11,
458,
83,
13,
79,
19,
11,
12461,
796,
10706,
7,
17,
11,
17,
828,
8177,
28,
9562,
11,
905,
28,
7942,
8,
198,
197,
13812,
7,
79,
8,
198,
437,
198,
8818,
30415,
7,
489,
83,
11,
256,
11,
300,
11,
285,
3712,
46912,
31431,
11,
12379,
8,
628,
197,
489,
83,
13,
79,
16,
796,
7110,
529,
0,
7,
489,
83,
13,
79,
16,
11,
285,
13,
48545,
13,
75,
6962,
58,
75,
12962,
198,
197,
489,
83,
13,
79,
17,
796,
21528,
457,
0,
7,
489,
83,
13,
79,
17,
11,
285,
13,
82,
457,
13,
75,
6962,
58,
75,
4357,
256,
8,
198,
197,
489,
83,
13,
79,
18,
796,
7110,
6814,
0,
7,
489,
83,
13,
79,
18,
11,
685,
6814,
4357,
685,
83,
12962,
198,
197,
489,
83,
13,
79,
19,
796,
7110,
8344,
0,
7,
489,
83,
13,
79,
19,
11,
285,
13,
8344,
13,
75,
6962,
58,
75,
12962,
198,
197,
79,
796,
7110,
7,
489,
83,
13,
79,
16,
11,
458,
83,
13,
79,
17,
11,
458,
83,
13,
79,
18,
11,
458,
83,
13,
79,
19,
11,
12461,
796,
10706,
7,
17,
11,
17,
828,
8177,
28,
9562,
11,
905,
28,
7942,
8,
198,
197,
13812,
7,
79,
8,
198,
437,
198,
198,
76,
18187,
2878,
16189,
29487,
198,
197,
79,
16,
3712,
3646,
1747,
13,
43328,
90,
27,
25,
23839,
7282,
437,
92,
198,
197,
79,
17,
3712,
3646,
1747,
13,
43328,
90,
27,
25,
23839,
7282,
437,
92,
198,
197,
79,
18,
3712,
3646,
1747,
13,
43328,
90,
27,
25,
23839,
7282,
437,
92,
198,
197,
79,
19,
3712,
3646,
1747,
13,
43328,
90,
27,
25,
23839,
7282,
437,
92,
198,
197,
43041,
29487,
3419,
796,
649,
7,
25080,
8899,
22784,
25080,
8899,
22784,
41058,
22784,
4894,
8899,
28955,
198,
437,
198,
198,
8818,
4238,
786,
29487,
7,
29487,
4906,
3712,
22203,
8,
628,
197,
7783,
7110,
4906,
3419,
198,
437,
198,
198,
8818,
7110,
529,
0,
7,
79,
16,
11,
14916,
8,
628,
197,
25080,
8899,
0,
7,
79,
16,
11,
27179,
1758,
7,
48545,
11,
4129,
7,
48545,
828,
352,
4008,
198,
437,
198,
198,
8818,
21528,
457,
0,
7,
79,
17,
11,
264,
457,
11,
256,
8,
628,
197,
2777,
17951,
796,
264,
457,
13,
855,
83,
198,
197,
25080,
8899,
0,
7,
79,
17,
11,
27179,
1758,
7,
2777,
17951,
11,
4129,
7,
2777,
17951,
828,
16,
4008,
198,
437,
198,
198,
8818,
7110,
6814,
0,
7,
79,
18,
11,
256,
11,
12379,
8,
198,
197,
1416,
1436,
0,
7,
79,
18,
11,
12379,
11,
256,
8,
198,
437,
198,
198,
8818,
7110,
8344,
0,
7,
79,
19,
11,
664,
8,
198,
197,
25080,
8899,
0,
7,
79,
19,
11,
27179,
1758,
7,
8344,
11,
13664,
7,
8344,
828,
16,
4008,
198,
437
] | 2.245839 | 781 |
using Escher
using FactCheck
using Compat
include("macros.jl")
include("interop.jl")
FactCheck.exitstatus()
| [
3500,
16319,
372,
198,
3500,
19020,
9787,
198,
3500,
3082,
265,
198,
198,
17256,
7203,
20285,
4951,
13,
20362,
4943,
198,
17256,
7203,
3849,
404,
13,
20362,
4943,
198,
29054,
9787,
13,
37023,
13376,
3419,
198
] | 3.027778 | 36 |
include("c-lib-p2f-test.jl")
include("c-lib-f2p-test.jl")
include("c-lib-add-test.jl")
include("c-lib-mul-test.jl")
include("c-lib-div-test.jl")
include("c-lib-mode-test.jl")
| [
17256,
7203,
66,
12,
8019,
12,
79,
17,
69,
12,
9288,
13,
20362,
4943,
198,
17256,
7203,
66,
12,
8019,
12,
69,
17,
79,
12,
9288,
13,
20362,
4943,
198,
17256,
7203,
66,
12,
8019,
12,
2860,
12,
9288,
13,
20362,
4943,
198,
17256,
7203,
66,
12,
8019,
12,
76,
377,
12,
9288,
13,
20362,
4943,
198,
17256,
7203,
66,
12,
8019,
12,
7146,
12,
9288,
13,
20362,
4943,
198,
17256,
7203,
66,
12,
8019,
12,
14171,
12,
9288,
13,
20362,
4943,
198
] | 2.108434 | 83 |
"""
Cropbox
Declarative crop modeling framework. https://github.com/cropbox/Cropbox.jl
See also: [`@system`](@ref), [`@config`](@ref), [`simulate`](@ref), [`evaluate`](@ref), [`calibrate`](@ref), [`visualize`](@ref), [`manipulate`](@ref)
"""
module Cropbox
include("system.jl")
include("unit.jl")
include("random.jl")
include("graph.jl")
include("macro.jl")
include("state.jl")
include("bundle.jl")
include("config.jl")
include("system/clock.jl")
include("system/context.jl")
include("system/controller.jl")
include("system/calendar.jl")
include("system/store.jl")
include("system/thermaltime.jl")
include("util/simulate.jl")
include("util/calibrate.jl")
include("util/evaluate.jl")
include("util/gather.jl")
include("util/color.jl")
include("util/dive.jl")
include("util/hierarchy.jl")
include("util/plot.jl")
include("util/visualize.jl")
include("util/manipulate.jl")
end
| [
37811,
198,
220,
220,
220,
327,
1773,
3524,
198,
198,
37835,
283,
876,
13833,
21128,
9355,
13,
3740,
1378,
12567,
13,
785,
14,
31476,
3524,
14,
34,
1773,
3524,
13,
20362,
198,
198,
6214,
635,
25,
685,
63,
31,
10057,
63,
16151,
31,
5420,
828,
685,
63,
31,
11250,
63,
16151,
31,
5420,
828,
685,
63,
14323,
5039,
63,
16151,
31,
5420,
828,
685,
63,
49786,
63,
16151,
31,
5420,
828,
685,
63,
9948,
2889,
378,
63,
16151,
31,
5420,
828,
685,
63,
41464,
1096,
63,
16151,
31,
5420,
828,
685,
63,
805,
541,
5039,
63,
16151,
31,
5420,
8,
198,
37811,
198,
21412,
327,
1773,
3524,
198,
198,
17256,
7203,
10057,
13,
20362,
4943,
198,
17256,
7203,
20850,
13,
20362,
4943,
198,
17256,
7203,
25120,
13,
20362,
4943,
198,
17256,
7203,
34960,
13,
20362,
4943,
198,
17256,
7203,
20285,
305,
13,
20362,
4943,
198,
17256,
7203,
5219,
13,
20362,
4943,
198,
17256,
7203,
65,
31249,
13,
20362,
4943,
198,
17256,
7203,
11250,
13,
20362,
4943,
198,
198,
17256,
7203,
10057,
14,
15750,
13,
20362,
4943,
198,
17256,
7203,
10057,
14,
22866,
13,
20362,
4943,
198,
17256,
7203,
10057,
14,
36500,
13,
20362,
4943,
198,
17256,
7203,
10057,
14,
9948,
9239,
13,
20362,
4943,
198,
17256,
7203,
10057,
14,
8095,
13,
20362,
4943,
198,
17256,
7203,
10057,
14,
490,
7617,
2435,
13,
20362,
4943,
198,
198,
17256,
7203,
22602,
14,
14323,
5039,
13,
20362,
4943,
198,
17256,
7203,
22602,
14,
9948,
2889,
378,
13,
20362,
4943,
198,
17256,
7203,
22602,
14,
49786,
13,
20362,
4943,
198,
17256,
7203,
22602,
14,
70,
1032,
13,
20362,
4943,
198,
17256,
7203,
22602,
14,
8043,
13,
20362,
4943,
198,
17256,
7203,
22602,
14,
67,
425,
13,
20362,
4943,
198,
17256,
7203,
22602,
14,
71,
959,
9282,
13,
20362,
4943,
198,
17256,
7203,
22602,
14,
29487,
13,
20362,
4943,
198,
17256,
7203,
22602,
14,
41464,
1096,
13,
20362,
4943,
198,
17256,
7203,
22602,
14,
805,
541,
5039,
13,
20362,
4943,
198,
198,
437,
198
] | 2.68693 | 329 |
function Log_LikeliHood(m::AbstractModel, om, leaves)
if leaves
#= if the animal has left we want the probability of this to happen
at that omission, given that it has not left before.
Since we assume that the events are independent the product of each likelihood
should give me the total probability. Using the log we can simply sum them =#
return log(cdf(m,om) - cdf(m,om-1))
else
#= if the animal hasn't left we want the probability of not leaving until om =#
# this is equivalent log(1-cdf(dist,om)) but it's safe when cdf is near 1
return log(1-cdf(m, om))
end
end
function nll_data(m::AbstractModel,cm::Dict)
-sum(v*Log_LikeliHood(m, k...) for (k, v) in cm)
end
function Distributions.fit(::Type{T}, b::DataFrames.AbstractDataFrame) where T<:AbstractModel
cm = countmap(StructArray((Omissions_plus_one = b.Omissions_plus_one, Leave = b.Leave)))
p = init(T, cm)
res = optimize(params(p)) do param
all(param .> 1e-10) || return 1e10
params(p) .= param
return nll_data(p, cm)
end
params(p) .= Optim.minimizer(res)
return p
end
###
function simulate(m::AbstractModel,n_samples=1)
w = [cdf(m,x)-cdf(m,x-1) for x in 1:maximum(m)]
weights = StatsBase.weights(w)
[sample(1:maximum(m),weights) for _ in 1:n_samples]
end
| [
8818,
5972,
62,
7594,
4528,
39,
702,
7,
76,
3712,
23839,
17633,
11,
39030,
11,
5667,
8,
198,
220,
220,
220,
611,
5667,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
28,
611,
262,
5044,
468,
1364,
356,
765,
262,
12867,
286,
428,
284,
1645,
198,
220,
220,
220,
220,
220,
220,
220,
379,
326,
35725,
11,
1813,
326,
340,
468,
407,
1364,
878,
13,
198,
220,
220,
220,
220,
220,
220,
220,
4619,
356,
7048,
326,
262,
2995,
389,
4795,
262,
1720,
286,
1123,
14955,
198,
220,
220,
220,
220,
220,
220,
220,
815,
1577,
502,
262,
2472,
12867,
13,
8554,
262,
2604,
356,
460,
2391,
2160,
606,
796,
2,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
2604,
7,
66,
7568,
7,
76,
11,
296,
8,
532,
269,
7568,
7,
76,
11,
296,
12,
16,
4008,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
28,
611,
262,
5044,
5818,
470,
1364,
356,
765,
262,
12867,
286,
407,
4305,
1566,
39030,
796,
2,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
428,
318,
7548,
2604,
7,
16,
12,
66,
7568,
7,
17080,
11,
296,
4008,
475,
340,
338,
3338,
618,
269,
7568,
318,
1474,
352,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
2604,
7,
16,
12,
66,
7568,
7,
76,
11,
39030,
4008,
198,
220,
220,
220,
886,
198,
437,
198,
198,
8818,
220,
299,
297,
62,
7890,
7,
76,
3712,
23839,
17633,
11,
11215,
3712,
35,
713,
8,
198,
220,
220,
220,
532,
16345,
7,
85,
9,
11187,
62,
7594,
4528,
39,
702,
7,
76,
11,
479,
23029,
329,
357,
74,
11,
410,
8,
287,
12067,
8,
198,
437,
198,
198,
8818,
46567,
507,
13,
11147,
7,
3712,
6030,
90,
51,
5512,
275,
3712,
6601,
35439,
13,
23839,
6601,
19778,
8,
810,
309,
27,
25,
23839,
17633,
198,
220,
220,
220,
12067,
796,
954,
8899,
7,
44909,
19182,
19510,
46,
8481,
62,
9541,
62,
505,
796,
275,
13,
46,
8481,
62,
9541,
62,
505,
11,
17446,
796,
275,
13,
35087,
22305,
198,
220,
220,
220,
279,
796,
2315,
7,
51,
11,
12067,
8,
198,
220,
220,
220,
581,
796,
27183,
7,
37266,
7,
79,
4008,
466,
5772,
198,
220,
220,
220,
220,
220,
220,
220,
477,
7,
17143,
764,
29,
352,
68,
12,
940,
8,
8614,
1441,
352,
68,
940,
198,
220,
220,
220,
220,
220,
220,
220,
42287,
7,
79,
8,
764,
28,
5772,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
299,
297,
62,
7890,
7,
79,
11,
12067,
8,
198,
220,
220,
220,
886,
198,
220,
220,
220,
42287,
7,
79,
8,
764,
28,
30011,
13,
1084,
320,
7509,
7,
411,
8,
198,
220,
220,
220,
1441,
279,
198,
437,
198,
198,
21017,
198,
8818,
29308,
7,
76,
3712,
23839,
17633,
11,
77,
62,
82,
12629,
28,
16,
8,
198,
220,
220,
220,
266,
796,
685,
66,
7568,
7,
76,
11,
87,
13219,
66,
7568,
7,
76,
11,
87,
12,
16,
8,
329,
2124,
287,
352,
25,
47033,
7,
76,
15437,
198,
220,
220,
220,
19590,
796,
20595,
14881,
13,
43775,
7,
86,
8,
198,
220,
220,
220,
685,
39873,
7,
16,
25,
47033,
7,
76,
828,
43775,
8,
329,
4808,
287,
352,
25,
77,
62,
82,
12629,
60,
198,
437,
198
] | 2.479053 | 549 |
# implementation of the GPUCompiler interfaces for generating WASM code
## target
export WASMCompilerTarget
Base.@kwdef struct WASMCompilerTarget <: AbstractCompilerTarget
end
llvm_triple(::WASMCompilerTarget) = "wasm32-unknown-unknown"
function llvm_machine(target::WASMCompilerTarget)
triple = llvm_triple(target)
t = Target(triple=triple)
cpu = ""
feat = ""
tm = TargetMachine(t, triple, cpu, feat)
asm_verbosity!(tm, true)
return tm
end
function process_entry!(job::CompilerJob{WASMCompilerTarget}, mod::LLVM.Module, entry::LLVM.Function)
push!(function_attributes(entry), StringAttribute("wasm-export-name", String(chop(LLVM.name(entry), tail=4)), context(mod)))
invoke(process_entry!, Tuple{CompilerJob, LLVM.Module, LLVM.Function}, job, mod, entry)
end
## job
runtime_slug(job::CompilerJob{WASMCompilerTarget}) = "wasm"
| [
2,
7822,
286,
262,
11362,
7293,
5329,
20314,
329,
15453,
21725,
44,
2438,
198,
198,
2235,
2496,
198,
198,
39344,
21725,
44,
7293,
5329,
21745,
198,
198,
14881,
13,
31,
46265,
4299,
2878,
21725,
44,
7293,
5329,
21745,
1279,
25,
27741,
7293,
5329,
21745,
198,
437,
198,
198,
297,
14761,
62,
28461,
1154,
7,
3712,
54,
1921,
44,
7293,
5329,
21745,
8,
796,
366,
86,
8597,
2624,
12,
34680,
12,
34680,
1,
198,
198,
8818,
32660,
14761,
62,
30243,
7,
16793,
3712,
54,
1921,
44,
7293,
5329,
21745,
8,
198,
220,
15055,
796,
32660,
14761,
62,
28461,
1154,
7,
16793,
8,
628,
220,
256,
796,
12744,
7,
28461,
1154,
28,
28461,
1154,
8,
628,
220,
42804,
796,
13538,
198,
220,
2218,
796,
13538,
198,
220,
256,
76,
796,
12744,
37573,
7,
83,
11,
15055,
11,
42804,
11,
2218,
8,
198,
220,
355,
76,
62,
19011,
16579,
0,
7,
17209,
11,
2081,
8,
628,
220,
1441,
256,
76,
198,
437,
198,
198,
8818,
1429,
62,
13000,
0,
7,
21858,
3712,
7293,
5329,
33308,
90,
54,
1921,
44,
7293,
5329,
21745,
5512,
953,
3712,
3069,
15996,
13,
26796,
11,
5726,
3712,
3069,
15996,
13,
22203,
8,
198,
220,
4574,
0,
7,
8818,
62,
1078,
7657,
7,
13000,
828,
10903,
33682,
7203,
86,
8597,
12,
39344,
12,
3672,
1600,
10903,
7,
354,
404,
7,
3069,
15996,
13,
3672,
7,
13000,
828,
7894,
28,
19,
36911,
4732,
7,
4666,
22305,
198,
220,
26342,
7,
14681,
62,
13000,
28265,
309,
29291,
90,
7293,
5329,
33308,
11,
27140,
15996,
13,
26796,
11,
27140,
15996,
13,
22203,
5512,
1693,
11,
953,
11,
5726,
8,
198,
437,
198,
198,
2235,
1693,
198,
198,
43282,
62,
6649,
1018,
7,
21858,
3712,
7293,
5329,
33308,
90,
54,
1921,
44,
7293,
5329,
21745,
30072,
796,
366,
86,
8597,
1,
198
] | 2.862876 | 299 |
"""
reproduce!(bact::Bacterium, model::ABM)
Simulates reproduction of bacteria. Energy is halved after subtracting a cost. Inherited
features are varied.
"""
function reproduce!(bact::Bacterium, model::ABM)
add_agent!(
bact.pos,
Bacterium,
model,
bact.species,
0,
(bact.energy - model.reproduction_energy_cost) / 2.0,
inherit(bact.sensory_radius, model.rng, model.σ_sensory_radius),
inherit(bact.reproduction_threshold, model.rng, model.σ_reproduction_threshold),
inherit(bact.speed, model.rng, model.σ_speed),
bact.food_target,
)
bact.age = 0
bact.energy = (bact.energy - model.reproduction_energy_cost) / 2.0
bact.sensory_radius = inherit(bact.sensory_radius, model.rng, model.σ_sensory_radius)
bact.reproduction_threshold =
inherit(bact.reproduction_threshold, model.rng, model.σ_reproduction_threshold)
bact.speed = inherit(bact.speed, model.rng, model.σ_speed)
end
function agent_step!(bact::Bacterium, model::ABM)
# die of age or starvation
(bact.age > model.lifetime || bact.energy <= 0) && (kill_agent!(bact, model); return)
# grow older
bact.age += 1
# reproduce if possible
bact.energy >= bact.reproduction_threshold && reproduce!(bact, model)
# if currently on a food source
if model.food[bact.pos...] > 0.0
# eat
eaten = min(model.food[bact.pos...], bact.speed * model.eat_rate_factor)
model.food[bact.pos...] -= eaten
bact.energy += eaten
return
else
# can't eat, so look for something else
bact.food_target = (-1, -1)
end
# if bact doesn't see any food
if bact.food_target == (-1, -1)
best_pos = (-1, -1)
# look for the best food nearby
for pos in nearby_positions(bact.pos, model, bact.sensory_radius)
best_pos == (-1, -1) || model.food[best_pos...] < model.food[pos...] || continue
best_pos = pos
end
best_pos != (-1, -1) && (bact.food_target = best_pos)
end
# if we found some food or already had eyes on it
if bact.food_target != (-1, -1)
# move toward target
delta = bact.food_target .- bact.pos
#move as many steps diagonally as possible
diag = min(abs.(delta)..., bact.speed)
steps = diag
movement = sign.(delta) .* diag
# move the rest steps axially, if possible
delta = delta .- movement
while steps < bact.speed && any(delta .> 0)
movement = movement .+ sign.(delta)
delta = delta .- sign.(delta)
steps += 1
end
else
# move randomly if there's no food nearby
movement = rand.(model.rng, (AXIAL_DIRECTIONS, AXIAL_DIRECTIONS)) .* bact.speed
end
# move
move_agent!(bact, clamp.(bact.pos .+ movement, 1, size(model.space.s)), model)
# subtract cost of movement and looking
bact.energy -=
model.sensory_radius_cost * bact.sensory_radius +
model.distance_cost * max(abs.(movement)...)
end
| [
37811,
198,
220,
220,
220,
22919,
0,
7,
65,
529,
3712,
33,
7321,
1505,
11,
2746,
3712,
6242,
44,
8,
198,
198,
8890,
15968,
20728,
286,
11492,
13,
6682,
318,
10284,
1079,
706,
34128,
278,
257,
1575,
13,
47025,
863,
198,
40890,
389,
15641,
13,
198,
37811,
198,
8818,
22919,
0,
7,
65,
529,
3712,
33,
7321,
1505,
11,
2746,
3712,
6242,
44,
8,
198,
220,
220,
220,
751,
62,
25781,
0,
7,
198,
220,
220,
220,
220,
220,
220,
220,
275,
529,
13,
1930,
11,
198,
220,
220,
220,
220,
220,
220,
220,
347,
7321,
1505,
11,
198,
220,
220,
220,
220,
220,
220,
220,
2746,
11,
198,
220,
220,
220,
220,
220,
220,
220,
275,
529,
13,
35448,
11,
198,
220,
220,
220,
220,
220,
220,
220,
657,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
65,
529,
13,
22554,
532,
2746,
13,
260,
25493,
62,
22554,
62,
15805,
8,
1220,
362,
13,
15,
11,
198,
220,
220,
220,
220,
220,
220,
220,
16955,
7,
65,
529,
13,
82,
641,
652,
62,
42172,
11,
2746,
13,
81,
782,
11,
2746,
13,
38392,
62,
82,
641,
652,
62,
42172,
828,
198,
220,
220,
220,
220,
220,
220,
220,
16955,
7,
65,
529,
13,
260,
25493,
62,
400,
10126,
11,
2746,
13,
81,
782,
11,
2746,
13,
38392,
62,
260,
25493,
62,
400,
10126,
828,
198,
220,
220,
220,
220,
220,
220,
220,
16955,
7,
65,
529,
13,
12287,
11,
2746,
13,
81,
782,
11,
2746,
13,
38392,
62,
12287,
828,
198,
220,
220,
220,
220,
220,
220,
220,
275,
529,
13,
19425,
62,
16793,
11,
198,
220,
220,
220,
1267,
628,
220,
220,
220,
275,
529,
13,
496,
796,
657,
198,
220,
220,
220,
275,
529,
13,
22554,
796,
357,
65,
529,
13,
22554,
532,
2746,
13,
260,
25493,
62,
22554,
62,
15805,
8,
1220,
362,
13,
15,
628,
220,
220,
220,
275,
529,
13,
82,
641,
652,
62,
42172,
796,
16955,
7,
65,
529,
13,
82,
641,
652,
62,
42172,
11,
2746,
13,
81,
782,
11,
2746,
13,
38392,
62,
82,
641,
652,
62,
42172,
8,
198,
220,
220,
220,
275,
529,
13,
260,
25493,
62,
400,
10126,
796,
198,
220,
220,
220,
220,
220,
220,
220,
16955,
7,
65,
529,
13,
260,
25493,
62,
400,
10126,
11,
2746,
13,
81,
782,
11,
2746,
13,
38392,
62,
260,
25493,
62,
400,
10126,
8,
198,
220,
220,
220,
275,
529,
13,
12287,
796,
16955,
7,
65,
529,
13,
12287,
11,
2746,
13,
81,
782,
11,
2746,
13,
38392,
62,
12287,
8,
198,
437,
198,
198,
8818,
5797,
62,
9662,
0,
7,
65,
529,
3712,
33,
7321,
1505,
11,
2746,
3712,
6242,
44,
8,
198,
220,
220,
220,
1303,
4656,
286,
2479,
393,
32143,
198,
220,
220,
220,
357,
65,
529,
13,
496,
1875,
2746,
13,
36195,
8079,
8614,
275,
529,
13,
22554,
19841,
657,
8,
11405,
357,
12728,
62,
25781,
0,
7,
65,
529,
11,
2746,
1776,
1441,
8,
628,
220,
220,
220,
1303,
1663,
4697,
198,
220,
220,
220,
275,
529,
13,
496,
15853,
352,
628,
220,
220,
220,
1303,
22919,
611,
1744,
198,
220,
220,
220,
275,
529,
13,
22554,
18189,
275,
529,
13,
260,
25493,
62,
400,
10126,
11405,
22919,
0,
7,
65,
529,
11,
2746,
8,
628,
220,
220,
220,
1303,
611,
3058,
319,
257,
2057,
2723,
198,
220,
220,
220,
611,
2746,
13,
19425,
58,
65,
529,
13,
1930,
22345,
1875,
657,
13,
15,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
4483,
198,
220,
220,
220,
220,
220,
220,
220,
17065,
796,
949,
7,
19849,
13,
19425,
58,
65,
529,
13,
1930,
986,
4357,
275,
529,
13,
12287,
1635,
2746,
13,
4098,
62,
4873,
62,
31412,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2746,
13,
19425,
58,
65,
529,
13,
1930,
22345,
48185,
17065,
198,
220,
220,
220,
220,
220,
220,
220,
275,
529,
13,
22554,
15853,
17065,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
460,
470,
4483,
11,
523,
804,
329,
1223,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
275,
529,
13,
19425,
62,
16793,
796,
13841,
16,
11,
532,
16,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
611,
275,
529,
1595,
470,
766,
597,
2057,
198,
220,
220,
220,
611,
275,
529,
13,
19425,
62,
16793,
6624,
13841,
16,
11,
532,
16,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1266,
62,
1930,
796,
13841,
16,
11,
532,
16,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
804,
329,
262,
1266,
2057,
6716,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1426,
287,
6716,
62,
1930,
1756,
7,
65,
529,
13,
1930,
11,
2746,
11,
275,
529,
13,
82,
641,
652,
62,
42172,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1266,
62,
1930,
6624,
13841,
16,
11,
532,
16,
8,
8614,
2746,
13,
19425,
58,
13466,
62,
1930,
22345,
1279,
2746,
13,
19425,
58,
1930,
22345,
8614,
2555,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1266,
62,
1930,
796,
1426,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
1266,
62,
1930,
14512,
13841,
16,
11,
532,
16,
8,
11405,
357,
65,
529,
13,
19425,
62,
16793,
796,
1266,
62,
1930,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
611,
356,
1043,
617,
2057,
393,
1541,
550,
2951,
319,
340,
198,
220,
220,
220,
611,
275,
529,
13,
19425,
62,
16793,
14512,
13841,
16,
11,
532,
16,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
1445,
3812,
2496,
198,
220,
220,
220,
220,
220,
220,
220,
25979,
796,
275,
529,
13,
19425,
62,
16793,
764,
12,
275,
529,
13,
1930,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
21084,
355,
867,
4831,
2566,
1840,
453,
355,
1744,
198,
220,
220,
220,
220,
220,
220,
220,
2566,
363,
796,
949,
7,
8937,
12195,
67,
12514,
26513,
11,
275,
529,
13,
12287,
8,
628,
220,
220,
220,
220,
220,
220,
220,
4831,
796,
2566,
363,
628,
220,
220,
220,
220,
220,
220,
220,
3356,
796,
1051,
12195,
67,
12514,
8,
764,
9,
2566,
363,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
1445,
262,
1334,
4831,
7877,
1927,
11,
611,
1744,
198,
220,
220,
220,
220,
220,
220,
220,
25979,
796,
25979,
764,
12,
3356,
198,
220,
220,
220,
220,
220,
220,
220,
981,
4831,
1279,
275,
529,
13,
12287,
11405,
597,
7,
67,
12514,
764,
29,
657,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3356,
796,
3356,
764,
10,
1051,
12195,
67,
12514,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
25979,
796,
25979,
764,
12,
1051,
12195,
67,
12514,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4831,
15853,
352,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
1445,
15456,
611,
612,
338,
645,
2057,
6716,
198,
220,
220,
220,
220,
220,
220,
220,
3356,
796,
43720,
12195,
19849,
13,
81,
782,
11,
357,
25922,
12576,
62,
17931,
23988,
11053,
11,
43051,
12576,
62,
17931,
23988,
11053,
4008,
764,
9,
275,
529,
13,
12287,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
1445,
198,
220,
220,
220,
1445,
62,
25781,
0,
7,
65,
529,
11,
29405,
12195,
65,
529,
13,
1930,
764,
10,
3356,
11,
352,
11,
2546,
7,
19849,
13,
13200,
13,
82,
36911,
2746,
8,
628,
220,
220,
220,
1303,
34128,
1575,
286,
3356,
290,
2045,
198,
220,
220,
220,
275,
529,
13,
22554,
48185,
198,
220,
220,
220,
220,
220,
220,
220,
2746,
13,
82,
641,
652,
62,
42172,
62,
15805,
1635,
275,
529,
13,
82,
641,
652,
62,
42172,
1343,
198,
220,
220,
220,
220,
220,
220,
220,
2746,
13,
30246,
62,
15805,
1635,
3509,
7,
8937,
12195,
21084,
434,
8,
23029,
198,
437,
198
] | 2.293769 | 1,348 |
include("Batcher.jl")
include("ForwardBatcher.jl")
| [
17256,
7203,
24541,
2044,
13,
20362,
4943,
198,
17256,
7203,
39746,
24541,
2044,
13,
20362,
4943,
198
] | 3 | 17 |
@testset "chi-square-analysis" begin
msr_path = joinpath(mktempdir(),"temp.csv")
data = _PMD.parse_file(_PMDSE.get_enwl_dss_path(ntw, fdr))
if rm_transfo _PMDSE.rm_enwl_transformer!(data) end
if rd_lines _PMDSE.reduce_enwl_lines_eng!(data) end
data["settings"]["sbase_default"] = 100.0
# insert the load profiles
_PMDSE.insert_profiles!(data, season, elm, pfs, t = time_step)
# transform data model
data = _PMD.transform_data_model(data);
_PMDSE.reduce_single_phase_loadbuses!(data)
# solve the power flow
pf_result = _PMD.solve_mc_pf(data, _PMD.ACPUPowerModel, ipopt_solver)
key = "1" # or "sourcebus"
v_pu = data["settings"]["vbases_default"][key]* data["settings"]["voltage_scale_factor"] # divider [V] to get the voltage in per units.
v_max_err = 1.15 # maximum error of voltage measurement = 0.5% or 1.15 V
σ_v = 1/3*v_max_err/v_pu
p_pu = data["settings"]["sbase"] # divider [kW] to get the power in per units.
p_max_err = 0.01 # maximum error of power measurement = 10W, or 0.01 kW
σ_p = 1/3*p_max_err/p_pu
# sigma_dict
σ_dict = Dict("load" => Dict("load" => σ_p,
"bus" => σ_v),
"gen" => Dict("gen" => σ_p/100,
"bus" => σ_v/100)
)
# write measurements based on power flow
_PMDSE.write_measurements!(_PMD.ACPUPowerModel, data, pf_result, msr_path, exclude = ["vi","vr"], σ = σ_dict)
# read-in measurement data and set initial values
_PMDSE.add_measurements!(data, msr_path, actual_meas = true)
data["se_settings"] = Dict{String,Any}("criterion" => "rwlav", "rescaler" => 1)
se_result = _PMDSE.solve_acp_red_mc_se(data, ipopt_solver)
@test _PMDSE.get_degrees_of_freedom(data) == 34
chi_result = _PMDSE.exceeds_chi_squares_threshold(se_result, data)
@test chi_result[1] == false
@test isapprox(chi_result[2], 0.0, atol = 1e-8)
@test isapprox(chi_result[3], 48.60, atol = 1e-2)
_PMDSE.add_measurements!(data, msr_path, actual_meas = false)
se_result = _PMDSE.solve_acp_red_mc_se(data, ipopt_solver)
chi_result = _PMDSE.exceeds_chi_squares_threshold(se_result, data)
@test chi_result[1] == true #TODO: there's no real bad data, check whether there is a problem with write_meas
@test isapprox(chi_result[2], 963.32, atol = 1e-2)
@test isapprox(chi_result[3], 48.60, atol = 1e-2)
end
@testset "h_functions" begin
# NB: the length (in terms of lines of code) of this sub-test could/should be significantly result but have no time now
msr_path = joinpath(mktempdir(),"temp.csv")
data = _PMD.parse_file(joinpath(BASE_DIR, "test/data/extra/networks/case3_unbalanced.dss"); data_model=MATHEMATICAL)
#reduce grid
[delete!(data["load"], l) for (l, load) in data["load"] if l!="1"]
_PMDSE.reduce_single_phase_loadbuses!(data)
pf_result = _PMD.solve_mc_pf(data, _PMD.ACPUPowerModel, ipopt_solver)
_PMDSE.write_measurements!(_PMD.ACPUPowerModel, data, pf_result, msr_path, exclude = ["vr","vi"])
_PMDSE.add_measurements!(data, msr_path, actual_meas = true)
# state is the result of the power flow
vv = pf_result["solution"]["bus"]
state = [ vv["4"]["vm"][1], vv["4"]["vm"][2], vv["4"]["vm"][3], vv["1"]["vm"][1], vv["1"]["vm"][2], vv["1"]["vm"][3], vv["2"]["vm"][1], vv["2"]["vm"][2], vv["2"]["vm"][3], vv["3"]["vm"][1],
vv["1"]["va"][1], vv["1"]["va"][2], vv["1"]["va"][3], vv["2"]["va"][1], vv["2"]["va"][2], vv["2"]["va"][3], vv["3"]["va"][1] ]
variable_dict = _PMDSE.build_variable_dictionary(data)
state_array = _PMDSE.build_state_array(pf_result, variable_dict)
@test state_array == state
# push h functions
functions = []
ref_bus = 4
_PMDSE.add_h_function!(:pd, "4", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:qd, "5", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:pg, "1", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:qg, "2", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:vm, "3", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:vm, "6", data, ref_bus, variable_dict, functions)
@test isapprox( functions[1](state), -_DST.mean(data["meas"]["4"]["dst"][1]) ) #pd
@test isapprox( functions[2](state), -_DST.mean(data["meas"]["5"]["dst"][1]) ) # qd
@test isapprox( functions[3](state), pf_result["solution"]["gen"]["1"]["pg"][1], atol=1e-8 )
@test isapprox( functions[4](state), pf_result["solution"]["gen"]["1"]["pg"][2], atol=1e-8 )
@test isapprox( functions[5](state), pf_result["solution"]["gen"]["1"]["pg"][3], atol=1e-8 )
@test isapprox( functions[6](state), pf_result["solution"]["gen"]["1"]["qg"][1], atol=1e-8 )
@test isapprox( functions[7](state), pf_result["solution"]["gen"]["1"]["qg"][2], atol=1e-8 )
@test isapprox( functions[8](state), pf_result["solution"]["gen"]["1"]["qg"][3], atol=1e-8 )
@test isapprox( functions[9](state), pf_result["solution"]["bus"]["4"]["vm"][1] )
@test isapprox( functions[10](state), pf_result["solution"]["bus"]["4"]["vm"][2] )
@test isapprox( functions[11](state), pf_result["solution"]["bus"]["4"]["vm"][3] )
@test isapprox( functions[12](state), pf_result["solution"]["bus"]["3"]["vm"][1] )
_PMDSE.add_measurement!(data, :p, :branch, 1, pf_result["solution"]["branch"]["1"]["pt"], [0.0003])
_PMDSE.add_measurement!(data, :q, :branch, 3, pf_result["solution"]["branch"]["3"]["qf"], [0.0003, 0.0003, 0.0003])
_PMDSE.add_measurement!(data, :q, :branch, 1, pf_result["solution"]["branch"]["1"]["qf"], [0.0003])
_PMDSE.add_h_function!(:p, "7", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:q, "8", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:q, "9", data, ref_bus, variable_dict, functions)
cm3 = sqrt.(pf_result["solution"]["branch"]["3"]["pf"].^2+pf_result["solution"]["branch"]["3"]["qf"].^2)./(pf_result["solution"]["bus"]["4"]["vm"])
cm1 = sqrt(pf_result["solution"]["branch"]["1"]["pf"][1]^2+pf_result["solution"]["branch"]["1"]["qf"][1]^2)/(pf_result["solution"]["bus"]["1"]["vm"][2])
_PMDSE.add_measurement!(data, :cm, :branch, 3, cm3, [0.0003, 0.0003, 0.0003])
_PMDSE.add_measurement!(data, :cm, :branch, 1, [cm1], [0.0003])
_PMDSE.add_measurement!(data, :va, :bus, 2, pf_result["solution"]["bus"]["2"]["va"], [0.0003, 0.0003, 0.0003])
_PMDSE.add_h_function!(:cm, "10", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:cm, "11", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:va, "12", data, ref_bus, variable_dict, functions)
@test isapprox( functions[13](state), pf_result["solution"]["branch"]["1"]["pf"][1] )
@test isapprox( functions[14](state), pf_result["solution"]["branch"]["3"]["qf"][1], atol=1e-8 )
@test isapprox( functions[15](state), pf_result["solution"]["branch"]["3"]["qf"][2], atol=1e-8 )
@test isapprox( functions[16](state), pf_result["solution"]["branch"]["3"]["qf"][3], atol=1e-8 )
@test isapprox( functions[17](state), pf_result["solution"]["branch"]["1"]["qf"][1] )
@test isapprox( functions[18](state), cm3[1] , atol=1e-8)
@test isapprox( functions[19](state), cm3[2] , atol=1e-8)
@test isapprox( functions[20](state), cm3[3], atol=1e-8 )
@test isapprox( functions[21](state), cm1 )
@test isapprox( functions[22](state), pf_result["solution"]["bus"]["2"]["va"][1])
@test isapprox( functions[23](state), pf_result["solution"]["bus"]["2"]["va"][2])
@test isapprox( functions[24](state), pf_result["solution"]["bus"]["2"]["va"][3])
pf_result_ivr = _PMD.solve_mc_pf(data, _PMD.IVRUPowerModel, ipopt_solver)
_PMDSE.add_measurement!(data, :cr, :branch, 3, pf_result_ivr["solution"]["branch"]["3"]["cr_fr"], [0.0003, 0.0003, 0.0003])
_PMDSE.add_measurement!(data, :ci, :branch, 3, pf_result_ivr["solution"]["branch"]["3"]["ci_fr"], [0.0003, 0.0003, 0.0003])
_PMDSE.add_measurement!(data, :crd, :branch, 1, pf_result_ivr["solution"]["load"]["1"]["crd_bus"], [0.0003])
_PMDSE.add_measurement!(data, :cid, :branch, 1, pf_result_ivr["solution"]["load"]["1"]["cid_bus"], [0.0003])
_PMDSE.add_h_function!(:cr, "13", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:ci, "14", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:crd, "15", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:cid, "16", data, ref_bus, variable_dict, functions)
@test isapprox( functions[25](state), pf_result_ivr["solution"]["branch"]["3"]["cr_fr"][1], atol=1e-8)
@test isapprox( functions[26](state), pf_result_ivr["solution"]["branch"]["3"]["cr_fr"][2], atol=4e-5)
@test isapprox( functions[27](state), pf_result_ivr["solution"]["branch"]["3"]["cr_fr"][3], atol=1e-8)
@test isapprox( functions[28](state), pf_result_ivr["solution"]["branch"]["3"]["ci_fr"][1], atol=1e-5)
@test isapprox( functions[29](state), pf_result_ivr["solution"]["branch"]["3"]["ci_fr"][2], atol=2e-5)
@test isapprox( functions[30](state), pf_result_ivr["solution"]["branch"]["3"]["ci_fr"][3], atol=2e-5)
@test isapprox( functions[31](state), -pf_result_ivr["solution"]["load"]["1"]["crd_bus"][1], atol=2e-4)
@test isapprox( functions[32](state), -pf_result_ivr["solution"]["load"]["1"]["cid_bus"][1], atol=2e-4)
_PMDSE.add_measurement!(data, :p, :branch, 2, pf_result["solution"]["branch"]["2"]["pf"], [0.0003, 0.0003, 0.0003])
_PMDSE.add_measurement!(data, :q, :branch, 2, pf_result["solution"]["branch"]["2"]["qf"], [0.0003, 0.0003, 0.0003])
_PMDSE.add_measurement!(data, :cr, :branch, 2, pf_result_ivr["solution"]["branch"]["2"]["cr_fr"], [0.0003, 0.0003, 0.0003])
_PMDSE.add_measurement!(data, :ci, :branch, 2, pf_result_ivr["solution"]["branch"]["2"]["ci_fr"], [0.0003, 0.0003, 0.0003])
cmfr = sqrt.(pf_result_ivr["solution"]["branch"]["2"]["cr_fr"].^2 + pf_result_ivr["solution"]["branch"]["2"]["ci_fr"].^2)
_PMDSE.add_measurement!(data, :cm, :branch, 2, cmfr, [0.0003, 0.0003, 0.0003])
_PMDSE.add_h_function!(:p, "17", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:q, "18", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:cr, "19", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:ci, "20", data, ref_bus, variable_dict, functions)
_PMDSE.add_h_function!(:cm, "21", data, ref_bus, variable_dict, functions)
@test isapprox( functions[33](state), pf_result["solution"]["branch"]["2"]["pf"][1], atol=1e-8)
@test isapprox( functions[34](state), pf_result["solution"]["branch"]["2"]["pf"][2], atol=1e-8)
@test isapprox( functions[35](state), pf_result["solution"]["branch"]["2"]["pf"][3], atol=1e-8)
@test isapprox( functions[36](state), pf_result["solution"]["branch"]["2"]["qf"][1], atol=1e-8)
@test isapprox( functions[37](state), pf_result["solution"]["branch"]["2"]["qf"][2], atol=1e-8)
@test isapprox( functions[38](state), pf_result["solution"]["branch"]["2"]["qf"][3], atol=1e-8)
@test isapprox( functions[39](state), pf_result_ivr["solution"]["branch"]["2"]["cr_fr"][1], atol=1e-4)
@test isapprox( functions[40](state), pf_result_ivr["solution"]["branch"]["2"]["cr_fr"][2], atol=1e-4)
@test isapprox( functions[41](state), pf_result_ivr["solution"]["branch"]["2"]["cr_fr"][3], atol=1e-4)
@test isapprox( functions[42](state), pf_result_ivr["solution"]["branch"]["2"]["ci_fr"][1], atol=1e-4)
@test isapprox( functions[43](state), pf_result_ivr["solution"]["branch"]["2"]["ci_fr"][2], atol=1e-4)
@test isapprox( functions[44](state), pf_result_ivr["solution"]["branch"]["2"]["ci_fr"][3], atol=1e-4)
@test isapprox( functions[45](state), cmfr[1], atol=1e-6)
@test isapprox( functions[46](state), cmfr[2], atol=1e-6)
@test isapprox( functions[47](state), cmfr[3], atol=1e-6)
end
@testset "BadData_matrices_and_LNR" begin
msr_path = joinpath(mktempdir(),"temp.csv")
data = _PMD.parse_file(joinpath(BASE_DIR, "test/data/extra/networks/case3_unbalanced.dss"); data_model=MATHEMATICAL)
#reduce grid
[delete!(data["load"], l) for (l, load) in data["load"] if l!="1"]
_PMDSE.reduce_single_phase_loadbuses!(data)
pf_result = _PMD.solve_mc_pf(data, _PMD.ACPUPowerModel, ipopt_solver)
_PMDSE.write_measurements!(_PMD.ACPUPowerModel, data, pf_result, msr_path, exclude = ["vr","vi"])
_PMDSE.add_measurements!(data, msr_path, actual_meas = true)
_PMDSE.assign_start_to_variables!(data)
data["se_settings"] = Dict{String,Any}("criterion" => "wls", "rescaler" => 1)
se_result = _PMDSE.solve_acp_red_mc_se(data, ipopt_solver)
_PMDSE.add_zib_virtual_meas!(data, 0.00000001, exclude = [2])
_PMDSE.add_zib_virtual_residuals!(se_result, data)
variable_dict = _PMDSE.build_variable_dictionary(data)
h_array = _PMDSE.build_measurement_function_array(data, variable_dict)
state_array = _PMDSE.build_state_array(pf_result, variable_dict)
stored_H_matrix = h5open(joinpath(BASE_DIR, "test/data/H_matrix.h5"), "r") do file
read(file, "H")
end
stored_G_matrix = h5open(joinpath(BASE_DIR, "test/data/G_matrix.h5"), "r") do file
read(file, "G")
end
stored_R_matrix = h5open(joinpath(BASE_DIR, "test/data/R_matrix.h5"), "r") do file
read(file, "R")
end
stored_Ω_matrix = h5open(joinpath(BASE_DIR, "test/data/Ω_matrix.h5"), "r") do file
read(file, "Ω")
end
H = _PMDSE.build_H_matrix(h_array, state_array)
R = _PMDSE.build_R_matrix(data)
G = _PMDSE.build_G_matrix(stored_H_matrix, R)
Ω = _PMDSE.build_omega_matrix(R, stored_H_matrix, G)
@test all(isapprox.(H, stored_H_matrix, atol=1))
@test all(isapprox.(R, stored_R_matrix, atol=1))
#@test all(isapprox.(G, stored_G_matrix, atol=1))
@test all(isapprox.(Ω, stored_Ω_matrix, atol=1))
id_val, exc = _PMDSE.normalized_residuals(data, se_result, Ω)
#@test !exc
#@test id_val[1] == "3"
#@test isapprox(id_val[2], 0.11035175, atol=1e-8)
_PMDSE.simple_normalized_residuals(data, se_result, R)
@test haskey(se_result["solution"]["meas"]["5"], "nr")
end | [
31,
9288,
2617,
366,
11072,
12,
23415,
12,
20930,
1,
2221,
628,
220,
220,
220,
13845,
81,
62,
6978,
796,
4654,
6978,
7,
28015,
29510,
15908,
3419,
553,
29510,
13,
40664,
4943,
628,
220,
220,
220,
1366,
796,
4808,
5868,
35,
13,
29572,
62,
7753,
28264,
5868,
35,
5188,
13,
1136,
62,
268,
40989,
62,
67,
824,
62,
6978,
7,
429,
86,
11,
277,
7109,
4008,
198,
220,
220,
220,
611,
42721,
62,
7645,
6513,
4808,
5868,
35,
5188,
13,
26224,
62,
268,
40989,
62,
7645,
16354,
0,
7,
7890,
8,
886,
198,
220,
220,
220,
611,
374,
67,
62,
6615,
220,
220,
4808,
5868,
35,
5188,
13,
445,
7234,
62,
268,
40989,
62,
6615,
62,
1516,
0,
7,
7890,
8,
886,
198,
220,
220,
220,
1366,
14692,
33692,
1,
7131,
1,
82,
8692,
62,
12286,
8973,
796,
1802,
13,
15,
198,
220,
220,
220,
1303,
7550,
262,
3440,
16545,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
28463,
62,
5577,
2915,
0,
7,
7890,
11,
1622,
11,
1288,
76,
11,
279,
9501,
11,
256,
796,
640,
62,
9662,
8,
628,
220,
220,
220,
1303,
6121,
1366,
2746,
198,
220,
220,
220,
1366,
796,
4808,
5868,
35,
13,
35636,
62,
7890,
62,
19849,
7,
7890,
1776,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
445,
7234,
62,
29762,
62,
40715,
62,
2220,
65,
2664,
0,
7,
7890,
8,
628,
220,
220,
220,
1303,
8494,
262,
1176,
5202,
198,
220,
220,
220,
279,
69,
62,
20274,
796,
4808,
5868,
35,
13,
82,
6442,
62,
23209,
62,
79,
69,
7,
7890,
11,
4808,
5868,
35,
13,
2246,
5105,
13434,
17633,
11,
20966,
8738,
62,
82,
14375,
8,
628,
220,
220,
220,
1994,
796,
366,
16,
1,
1303,
393,
366,
10459,
10885,
1,
198,
220,
220,
220,
410,
62,
19944,
796,
1366,
14692,
33692,
1,
7131,
1,
85,
65,
1386,
62,
12286,
1,
7131,
2539,
60,
9,
1366,
14692,
33692,
1,
7131,
1,
37764,
496,
62,
9888,
62,
31412,
8973,
1303,
2659,
1304,
685,
53,
60,
284,
651,
262,
15004,
287,
583,
4991,
13,
198,
220,
220,
220,
410,
62,
9806,
62,
8056,
796,
352,
13,
1314,
1303,
5415,
4049,
286,
15004,
15558,
796,
657,
13,
20,
4,
393,
352,
13,
1314,
569,
198,
220,
220,
220,
18074,
225,
62,
85,
796,
352,
14,
18,
9,
85,
62,
9806,
62,
8056,
14,
85,
62,
19944,
628,
220,
220,
220,
279,
62,
19944,
796,
1366,
14692,
33692,
1,
7131,
1,
82,
8692,
8973,
1303,
2659,
1304,
685,
74,
54,
60,
284,
651,
262,
1176,
287,
583,
4991,
13,
198,
220,
220,
220,
279,
62,
9806,
62,
8056,
796,
657,
13,
486,
1303,
5415,
4049,
286,
1176,
15558,
796,
838,
54,
11,
393,
657,
13,
486,
50223,
198,
220,
220,
220,
18074,
225,
62,
79,
796,
352,
14,
18,
9,
79,
62,
9806,
62,
8056,
14,
79,
62,
19944,
628,
220,
220,
220,
1303,
264,
13495,
62,
11600,
198,
220,
220,
220,
18074,
225,
62,
11600,
796,
360,
713,
7203,
2220,
1,
5218,
360,
713,
7203,
2220,
1,
5218,
18074,
225,
62,
79,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
366,
10885,
1,
220,
220,
5218,
18074,
225,
62,
85,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
366,
5235,
1,
220,
5218,
360,
713,
7203,
5235,
1,
5218,
18074,
225,
62,
79,
14,
3064,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
366,
10885,
1,
5218,
18074,
225,
62,
85,
14,
3064,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1267,
628,
220,
220,
220,
1303,
3551,
13871,
1912,
319,
1176,
5202,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
13564,
62,
1326,
5015,
902,
0,
28264,
5868,
35,
13,
2246,
5105,
13434,
17633,
11,
1366,
11,
279,
69,
62,
20274,
11,
13845,
81,
62,
6978,
11,
19607,
796,
14631,
8903,
2430,
37020,
33116,
18074,
225,
796,
18074,
225,
62,
11600,
8,
628,
220,
220,
220,
1303,
1100,
12,
259,
15558,
1366,
290,
900,
4238,
3815,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
902,
0,
7,
7890,
11,
13845,
81,
62,
6978,
11,
4036,
62,
1326,
292,
796,
2081,
8,
628,
220,
220,
220,
1366,
14692,
325,
62,
33692,
8973,
796,
360,
713,
90,
10100,
11,
7149,
92,
7203,
22213,
28019,
1,
5218,
366,
31653,
18809,
1600,
366,
411,
9948,
263,
1,
5218,
352,
8,
198,
220,
220,
220,
384,
62,
20274,
796,
4808,
5868,
35,
5188,
13,
82,
6442,
62,
330,
79,
62,
445,
62,
23209,
62,
325,
7,
7890,
11,
20966,
8738,
62,
82,
14375,
8,
628,
220,
220,
220,
2488,
9288,
4808,
5868,
35,
5188,
13,
1136,
62,
13500,
6037,
62,
1659,
62,
41295,
7,
7890,
8,
6624,
4974,
198,
220,
220,
220,
220,
198,
220,
220,
220,
33166,
62,
20274,
796,
4808,
5868,
35,
5188,
13,
1069,
2707,
82,
62,
11072,
62,
16485,
3565,
62,
400,
10126,
7,
325,
62,
20274,
11,
1366,
8,
198,
220,
220,
220,
2488,
9288,
33166,
62,
20274,
58,
16,
60,
6624,
3991,
220,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
11072,
62,
20274,
58,
17,
4357,
657,
13,
15,
11,
379,
349,
796,
352,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
11072,
62,
20274,
58,
18,
4357,
4764,
13,
1899,
11,
379,
349,
796,
352,
68,
12,
17,
8,
628,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
902,
0,
7,
7890,
11,
13845,
81,
62,
6978,
11,
4036,
62,
1326,
292,
796,
3991,
8,
198,
220,
220,
220,
384,
62,
20274,
796,
4808,
5868,
35,
5188,
13,
82,
6442,
62,
330,
79,
62,
445,
62,
23209,
62,
325,
7,
7890,
11,
20966,
8738,
62,
82,
14375,
8,
198,
220,
220,
220,
33166,
62,
20274,
796,
4808,
5868,
35,
5188,
13,
1069,
2707,
82,
62,
11072,
62,
16485,
3565,
62,
400,
10126,
7,
325,
62,
20274,
11,
1366,
8,
198,
220,
220,
220,
2488,
9288,
33166,
62,
20274,
58,
16,
60,
6624,
2081,
1303,
51,
3727,
46,
25,
612,
338,
645,
1103,
2089,
1366,
11,
2198,
1771,
612,
318,
257,
1917,
351,
3551,
62,
1326,
292,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
11072,
62,
20274,
58,
17,
4357,
860,
5066,
13,
2624,
11,
379,
349,
796,
352,
68,
12,
17,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
11072,
62,
20274,
58,
18,
4357,
4764,
13,
1899,
11,
379,
349,
796,
352,
68,
12,
17,
8,
198,
198,
437,
198,
198,
31,
9288,
2617,
366,
71,
62,
12543,
2733,
1,
2221,
628,
220,
220,
220,
1303,
41354,
25,
262,
4129,
357,
259,
2846,
286,
3951,
286,
2438,
8,
286,
428,
850,
12,
9288,
714,
14,
21754,
307,
5566,
1255,
475,
423,
645,
640,
783,
628,
220,
220,
220,
13845,
81,
62,
6978,
796,
4654,
6978,
7,
28015,
29510,
15908,
3419,
553,
29510,
13,
40664,
4943,
198,
220,
220,
220,
1366,
796,
4808,
5868,
35,
13,
29572,
62,
7753,
7,
22179,
6978,
7,
33,
11159,
62,
34720,
11,
366,
9288,
14,
7890,
14,
26086,
14,
3262,
5225,
14,
7442,
18,
62,
403,
27753,
13,
67,
824,
15341,
1366,
62,
19849,
28,
44,
12599,
3620,
1404,
20151,
8,
198,
220,
220,
220,
1303,
445,
7234,
10706,
198,
220,
220,
220,
685,
33678,
0,
7,
7890,
14692,
2220,
33116,
300,
8,
329,
357,
75,
11,
3440,
8,
287,
1366,
14692,
2220,
8973,
611,
300,
0,
2625,
16,
8973,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
445,
7234,
62,
29762,
62,
40715,
62,
2220,
65,
2664,
0,
7,
7890,
8,
220,
198,
220,
220,
220,
279,
69,
62,
20274,
796,
4808,
5868,
35,
13,
82,
6442,
62,
23209,
62,
79,
69,
7,
7890,
11,
4808,
5868,
35,
13,
2246,
5105,
13434,
17633,
11,
20966,
8738,
62,
82,
14375,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
13564,
62,
1326,
5015,
902,
0,
28264,
5868,
35,
13,
2246,
5105,
13434,
17633,
11,
1366,
11,
279,
69,
62,
20274,
11,
13845,
81,
62,
6978,
11,
19607,
796,
14631,
37020,
2430,
8903,
8973,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
902,
0,
7,
7890,
11,
13845,
81,
62,
6978,
11,
4036,
62,
1326,
292,
796,
2081,
8,
198,
220,
220,
220,
220,
198,
220,
220,
220,
1303,
1181,
318,
262,
1255,
286,
262,
1176,
5202,
198,
220,
220,
220,
410,
85,
796,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
10885,
8973,
198,
220,
220,
220,
1181,
796,
685,
410,
85,
14692,
19,
1,
7131,
1,
14761,
1,
7131,
16,
4357,
410,
85,
14692,
19,
1,
7131,
1,
14761,
1,
7131,
17,
4357,
410,
85,
14692,
19,
1,
7131,
1,
14761,
1,
7131,
18,
4357,
410,
85,
14692,
16,
1,
7131,
1,
14761,
1,
7131,
16,
4357,
410,
85,
14692,
16,
1,
7131,
1,
14761,
1,
7131,
17,
4357,
410,
85,
14692,
16,
1,
7131,
1,
14761,
1,
7131,
18,
4357,
410,
85,
14692,
17,
1,
7131,
1,
14761,
1,
7131,
16,
4357,
410,
85,
14692,
17,
1,
7131,
1,
14761,
1,
7131,
17,
4357,
410,
85,
14692,
17,
1,
7131,
1,
14761,
1,
7131,
18,
4357,
410,
85,
14692,
18,
1,
7131,
1,
14761,
1,
7131,
16,
4357,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
410,
85,
14692,
16,
1,
7131,
1,
6862,
1,
7131,
16,
4357,
410,
85,
14692,
16,
1,
7131,
1,
6862,
1,
7131,
17,
4357,
410,
85,
14692,
16,
1,
7131,
1,
6862,
1,
7131,
18,
4357,
410,
85,
14692,
17,
1,
7131,
1,
6862,
1,
7131,
16,
4357,
410,
85,
14692,
17,
1,
7131,
1,
6862,
1,
7131,
17,
4357,
410,
85,
14692,
17,
1,
7131,
1,
6862,
1,
7131,
18,
4357,
410,
85,
14692,
18,
1,
7131,
1,
6862,
1,
7131,
16,
60,
2361,
628,
220,
220,
220,
7885,
62,
11600,
796,
4808,
5868,
35,
5188,
13,
11249,
62,
45286,
62,
67,
14188,
7,
7890,
8,
198,
220,
220,
220,
1181,
62,
18747,
796,
4808,
5868,
35,
5188,
13,
11249,
62,
5219,
62,
18747,
7,
79,
69,
62,
20274,
11,
7885,
62,
11600,
8,
198,
220,
220,
220,
2488,
9288,
1181,
62,
18747,
6624,
1181,
628,
220,
220,
220,
1303,
4574,
289,
5499,
198,
220,
220,
220,
5499,
796,
17635,
198,
220,
220,
220,
1006,
62,
10885,
796,
604,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
30094,
11,
366,
19,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
80,
67,
11,
366,
20,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
6024,
11,
366,
16,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
80,
70,
11,
366,
17,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
14761,
11,
366,
18,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
14761,
11,
366,
21,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
628,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
16,
16151,
5219,
828,
532,
62,
35,
2257,
13,
32604,
7,
7890,
14692,
1326,
292,
1,
7131,
1,
19,
1,
7131,
1,
67,
301,
1,
7131,
16,
12962,
1267,
1303,
30094,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
17,
16151,
5219,
828,
532,
62,
35,
2257,
13,
32604,
7,
7890,
14692,
1326,
292,
1,
7131,
1,
20,
1,
7131,
1,
67,
301,
1,
7131,
16,
12962,
1267,
1303,
10662,
67,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
18,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
5235,
1,
7131,
1,
16,
1,
7131,
1,
6024,
1,
7131,
16,
4357,
379,
349,
28,
16,
68,
12,
23,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
19,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
5235,
1,
7131,
1,
16,
1,
7131,
1,
6024,
1,
7131,
17,
4357,
379,
349,
28,
16,
68,
12,
23,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
20,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
5235,
1,
7131,
1,
16,
1,
7131,
1,
6024,
1,
7131,
18,
4357,
379,
349,
28,
16,
68,
12,
23,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
21,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
5235,
1,
7131,
1,
16,
1,
7131,
1,
80,
70,
1,
7131,
16,
4357,
379,
349,
28,
16,
68,
12,
23,
220,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
22,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
5235,
1,
7131,
1,
16,
1,
7131,
1,
80,
70,
1,
7131,
17,
4357,
379,
349,
28,
16,
68,
12,
23,
220,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
23,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
5235,
1,
7131,
1,
16,
1,
7131,
1,
80,
70,
1,
7131,
18,
4357,
379,
349,
28,
16,
68,
12,
23,
220,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
24,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
10885,
1,
7131,
1,
19,
1,
7131,
1,
14761,
1,
7131,
16,
60,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
940,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
10885,
1,
7131,
1,
19,
1,
7131,
1,
14761,
1,
7131,
17,
60,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1157,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
10885,
1,
7131,
1,
19,
1,
7131,
1,
14761,
1,
7131,
18,
60,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1065,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
10885,
1,
7131,
1,
18,
1,
7131,
1,
14761,
1,
7131,
16,
60,
1267,
628,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
79,
11,
1058,
1671,
3702,
11,
352,
11,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
16,
1,
7131,
1,
457,
33116,
685,
15,
13,
830,
18,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
80,
11,
1058,
1671,
3702,
11,
513,
11,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
80,
69,
33116,
685,
15,
13,
830,
18,
11,
657,
13,
830,
18,
11,
657,
13,
830,
18,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
80,
11,
1058,
1671,
3702,
11,
352,
11,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
16,
1,
7131,
1,
80,
69,
33116,
685,
15,
13,
830,
18,
12962,
628,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
79,
11,
366,
22,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
80,
11,
366,
23,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
80,
11,
366,
24,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
628,
220,
220,
220,
12067,
18,
796,
19862,
17034,
12195,
79,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
79,
69,
1,
4083,
61,
17,
10,
79,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
80,
69,
1,
4083,
61,
17,
737,
29006,
79,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
10885,
1,
7131,
1,
19,
1,
7131,
1,
14761,
8973,
8,
198,
220,
220,
220,
12067,
16,
796,
19862,
17034,
7,
79,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
16,
1,
7131,
1,
79,
69,
1,
7131,
16,
60,
61,
17,
10,
79,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
16,
1,
7131,
1,
80,
69,
1,
7131,
16,
60,
61,
17,
20679,
7,
79,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
10885,
1,
7131,
1,
16,
1,
7131,
1,
14761,
1,
7131,
17,
12962,
628,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
11215,
11,
1058,
1671,
3702,
11,
513,
11,
12067,
18,
11,
685,
15,
13,
830,
18,
11,
657,
13,
830,
18,
11,
657,
13,
830,
18,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
11215,
11,
1058,
1671,
3702,
11,
352,
11,
685,
11215,
16,
4357,
685,
15,
13,
830,
18,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
6862,
11,
1058,
10885,
11,
362,
11,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
10885,
1,
7131,
1,
17,
1,
7131,
1,
6862,
33116,
685,
15,
13,
830,
18,
11,
657,
13,
830,
18,
11,
657,
13,
830,
18,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
11215,
11,
366,
940,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
11215,
11,
366,
1157,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
6862,
11,
366,
1065,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
220,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1485,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
16,
1,
7131,
1,
79,
69,
1,
7131,
16,
60,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1415,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
80,
69,
1,
7131,
16,
4357,
379,
349,
28,
16,
68,
12,
23,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1314,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
80,
69,
1,
7131,
17,
4357,
379,
349,
28,
16,
68,
12,
23,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1433,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
80,
69,
1,
7131,
18,
4357,
379,
349,
28,
16,
68,
12,
23,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1558,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
16,
1,
7131,
1,
80,
69,
1,
7131,
16,
60,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1507,
16151,
5219,
828,
12067,
18,
58,
16,
60,
837,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1129,
16151,
5219,
828,
12067,
18,
58,
17,
60,
837,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1238,
16151,
5219,
828,
12067,
18,
58,
18,
4357,
379,
349,
28,
16,
68,
12,
23,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2481,
16151,
5219,
828,
12067,
16,
1267,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1828,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
10885,
1,
7131,
1,
17,
1,
7131,
1,
6862,
1,
7131,
16,
12962,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1954,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
10885,
1,
7131,
1,
17,
1,
7131,
1,
6862,
1,
7131,
17,
12962,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1731,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
10885,
1,
7131,
1,
17,
1,
7131,
1,
6862,
1,
7131,
18,
12962,
628,
220,
220,
220,
279,
69,
62,
20274,
62,
452,
81,
796,
4808,
5868,
35,
13,
82,
6442,
62,
23209,
62,
79,
69,
7,
7890,
11,
4808,
5868,
35,
13,
3824,
49,
8577,
789,
17633,
11,
20966,
8738,
62,
82,
14375,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
6098,
11,
1058,
1671,
3702,
11,
513,
11,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
6098,
62,
8310,
33116,
685,
15,
13,
830,
18,
11,
657,
13,
830,
18,
11,
657,
13,
830,
18,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
979,
11,
1058,
1671,
3702,
11,
513,
11,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
979,
62,
8310,
33116,
685,
15,
13,
830,
18,
11,
657,
13,
830,
18,
11,
657,
13,
830,
18,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
66,
4372,
11,
1058,
1671,
3702,
11,
352,
11,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
2220,
1,
7131,
1,
16,
1,
7131,
1,
66,
4372,
62,
10885,
33116,
685,
15,
13,
830,
18,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
66,
312,
11,
1058,
1671,
3702,
11,
352,
11,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
2220,
1,
7131,
1,
16,
1,
7131,
1,
66,
312,
62,
10885,
33116,
685,
15,
13,
830,
18,
12962,
628,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
6098,
11,
366,
1485,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
979,
11,
366,
1415,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
66,
4372,
11,
366,
1314,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
66,
312,
11,
366,
1433,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
628,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1495,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
6098,
62,
8310,
1,
7131,
16,
4357,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2075,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
6098,
62,
8310,
1,
7131,
17,
4357,
379,
349,
28,
19,
68,
12,
20,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1983,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
6098,
62,
8310,
1,
7131,
18,
4357,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2078,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
979,
62,
8310,
1,
7131,
16,
4357,
379,
349,
28,
16,
68,
12,
20,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1959,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
979,
62,
8310,
1,
7131,
17,
4357,
379,
349,
28,
17,
68,
12,
20,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1270,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
18,
1,
7131,
1,
979,
62,
8310,
1,
7131,
18,
4357,
379,
349,
28,
17,
68,
12,
20,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
3132,
16151,
5219,
828,
532,
79,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
2220,
1,
7131,
1,
16,
1,
7131,
1,
66,
4372,
62,
10885,
1,
7131,
16,
4357,
379,
349,
28,
17,
68,
12,
19,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2624,
16151,
5219,
828,
532,
79,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
2220,
1,
7131,
1,
16,
1,
7131,
1,
66,
312,
62,
10885,
1,
7131,
16,
4357,
379,
349,
28,
17,
68,
12,
19,
8,
220,
220,
220,
220,
628,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
79,
11,
1058,
1671,
3702,
11,
362,
11,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
79,
69,
33116,
685,
15,
13,
830,
18,
11,
657,
13,
830,
18,
11,
657,
13,
830,
18,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
80,
11,
1058,
1671,
3702,
11,
362,
11,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
80,
69,
33116,
685,
15,
13,
830,
18,
11,
657,
13,
830,
18,
11,
657,
13,
830,
18,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
6098,
11,
1058,
1671,
3702,
11,
362,
11,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
6098,
62,
8310,
33116,
685,
15,
13,
830,
18,
11,
657,
13,
830,
18,
11,
657,
13,
830,
18,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
979,
11,
1058,
1671,
3702,
11,
362,
11,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
979,
62,
8310,
33116,
685,
15,
13,
830,
18,
11,
657,
13,
830,
18,
11,
657,
13,
830,
18,
12962,
198,
220,
220,
220,
12067,
8310,
796,
19862,
17034,
12195,
79,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
6098,
62,
8310,
1,
4083,
61,
17,
1343,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
979,
62,
8310,
1,
4083,
61,
17,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
434,
0,
7,
7890,
11,
1058,
11215,
11,
1058,
1671,
3702,
11,
362,
11,
12067,
8310,
11,
685,
15,
13,
830,
18,
11,
657,
13,
830,
18,
11,
657,
13,
830,
18,
12962,
628,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
79,
11,
366,
1558,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
80,
11,
366,
1507,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
6098,
11,
366,
1129,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
979,
11,
366,
1238,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
71,
62,
8818,
0,
7,
25,
11215,
11,
366,
2481,
1600,
1366,
11,
1006,
62,
10885,
11,
7885,
62,
11600,
11,
5499,
8,
628,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2091,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
79,
69,
1,
7131,
16,
4357,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2682,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
79,
69,
1,
7131,
17,
4357,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2327,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
79,
69,
1,
7131,
18,
4357,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2623,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
80,
69,
1,
7131,
16,
4357,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2718,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
80,
69,
1,
7131,
17,
4357,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2548,
16151,
5219,
828,
279,
69,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
80,
69,
1,
7131,
18,
4357,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2670,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
6098,
62,
8310,
1,
7131,
16,
4357,
379,
349,
28,
16,
68,
12,
19,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
1821,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
6098,
62,
8310,
1,
7131,
17,
4357,
379,
349,
28,
16,
68,
12,
19,
8,
220,
220,
220,
220,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
3901,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
6098,
62,
8310,
1,
7131,
18,
4357,
379,
349,
28,
16,
68,
12,
19,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
3682,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
979,
62,
8310,
1,
7131,
16,
4357,
379,
349,
28,
16,
68,
12,
19,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
3559,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
979,
62,
8310,
1,
7131,
17,
4357,
379,
349,
28,
16,
68,
12,
19,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2598,
16151,
5219,
828,
279,
69,
62,
20274,
62,
452,
81,
14692,
82,
2122,
1,
7131,
1,
1671,
3702,
1,
7131,
1,
17,
1,
7131,
1,
979,
62,
8310,
1,
7131,
18,
4357,
379,
349,
28,
16,
68,
12,
19,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2231,
16151,
5219,
828,
12067,
8310,
58,
16,
4357,
379,
349,
28,
16,
68,
12,
21,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
3510,
16151,
5219,
828,
12067,
8310,
58,
17,
4357,
379,
349,
28,
16,
68,
12,
21,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
5499,
58,
2857,
16151,
5219,
828,
12067,
8310,
58,
18,
4357,
379,
349,
28,
16,
68,
12,
21,
8,
198,
198,
437,
198,
198,
31,
9288,
2617,
366,
22069,
6601,
62,
6759,
45977,
62,
392,
62,
43,
24723,
1,
2221,
628,
220,
220,
220,
13845,
81,
62,
6978,
796,
4654,
6978,
7,
28015,
29510,
15908,
3419,
553,
29510,
13,
40664,
4943,
198,
220,
220,
220,
1366,
796,
4808,
5868,
35,
13,
29572,
62,
7753,
7,
22179,
6978,
7,
33,
11159,
62,
34720,
11,
366,
9288,
14,
7890,
14,
26086,
14,
3262,
5225,
14,
7442,
18,
62,
403,
27753,
13,
67,
824,
15341,
1366,
62,
19849,
28,
44,
12599,
3620,
1404,
20151,
8,
198,
220,
220,
220,
1303,
445,
7234,
10706,
198,
220,
220,
220,
685,
33678,
0,
7,
7890,
14692,
2220,
33116,
300,
8,
329,
357,
75,
11,
3440,
8,
287,
1366,
14692,
2220,
8973,
611,
300,
0,
2625,
16,
8973,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
445,
7234,
62,
29762,
62,
40715,
62,
2220,
65,
2664,
0,
7,
7890,
8,
220,
198,
220,
220,
220,
279,
69,
62,
20274,
796,
4808,
5868,
35,
13,
82,
6442,
62,
23209,
62,
79,
69,
7,
7890,
11,
4808,
5868,
35,
13,
2246,
5105,
13434,
17633,
11,
20966,
8738,
62,
82,
14375,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
13564,
62,
1326,
5015,
902,
0,
28264,
5868,
35,
13,
2246,
5105,
13434,
17633,
11,
1366,
11,
279,
69,
62,
20274,
11,
13845,
81,
62,
6978,
11,
19607,
796,
14631,
37020,
2430,
8903,
8973,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
1326,
5015,
902,
0,
7,
7890,
11,
13845,
81,
62,
6978,
11,
4036,
62,
1326,
292,
796,
2081,
8,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
562,
570,
62,
9688,
62,
1462,
62,
25641,
2977,
0,
7,
7890,
8,
628,
220,
220,
220,
1366,
14692,
325,
62,
33692,
8973,
796,
360,
713,
90,
10100,
11,
7149,
92,
7203,
22213,
28019,
1,
5218,
366,
86,
7278,
1600,
366,
411,
9948,
263,
1,
5218,
352,
8,
198,
220,
220,
220,
384,
62,
20274,
796,
4808,
5868,
35,
5188,
13,
82,
6442,
62,
330,
79,
62,
445,
62,
23209,
62,
325,
7,
7890,
11,
20966,
8738,
62,
82,
14375,
8,
198,
220,
220,
220,
220,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
89,
571,
62,
32844,
62,
1326,
292,
0,
7,
7890,
11,
657,
13,
10535,
486,
11,
19607,
796,
685,
17,
12962,
198,
220,
220,
220,
4808,
5868,
35,
5188,
13,
2860,
62,
89,
571,
62,
32844,
62,
411,
312,
723,
82,
0,
7,
325,
62,
20274,
11,
1366,
8,
628,
220,
220,
220,
7885,
62,
11600,
796,
4808,
5868,
35,
5188,
13,
11249,
62,
45286,
62,
67,
14188,
7,
7890,
8,
198,
220,
220,
220,
289,
62,
18747,
796,
4808,
5868,
35,
5188,
13,
11249,
62,
1326,
5015,
434,
62,
8818,
62,
18747,
7,
7890,
11,
7885,
62,
11600,
8,
198,
220,
220,
220,
1181,
62,
18747,
796,
4808,
5868,
35,
5188,
13,
11249,
62,
5219,
62,
18747,
7,
79,
69,
62,
20274,
11,
7885,
62,
11600,
8,
628,
220,
220,
220,
8574,
62,
39,
62,
6759,
8609,
796,
289,
20,
9654,
7,
22179,
6978,
7,
33,
11159,
62,
34720,
11,
366,
9288,
14,
7890,
14,
39,
62,
6759,
8609,
13,
71,
20,
12340,
366,
81,
4943,
466,
2393,
198,
220,
220,
220,
220,
220,
220,
220,
1100,
7,
7753,
11,
366,
39,
4943,
198,
220,
220,
220,
886,
628,
220,
220,
220,
8574,
62,
38,
62,
6759,
8609,
796,
289,
20,
9654,
7,
22179,
6978,
7,
33,
11159,
62,
34720,
11,
366,
9288,
14,
7890,
14,
38,
62,
6759,
8609,
13,
71,
20,
12340,
366,
81,
4943,
466,
2393,
198,
220,
220,
220,
220,
220,
220,
220,
1100,
7,
7753,
11,
366,
38,
4943,
198,
220,
220,
220,
886,
628,
220,
220,
220,
8574,
62,
49,
62,
6759,
8609,
796,
289,
20,
9654,
7,
22179,
6978,
7,
33,
11159,
62,
34720,
11,
366,
9288,
14,
7890,
14,
49,
62,
6759,
8609,
13,
71,
20,
12340,
366,
81,
4943,
466,
2393,
198,
220,
220,
220,
220,
220,
220,
220,
1100,
7,
7753,
11,
366,
49,
4943,
198,
220,
220,
220,
886,
628,
220,
220,
220,
8574,
62,
138,
102,
62,
6759,
8609,
796,
289,
20,
9654,
7,
22179,
6978,
7,
33,
11159,
62,
34720,
11,
366,
9288,
14,
7890,
14,
138,
102,
62,
6759,
8609,
13,
71,
20,
12340,
366,
81,
4943,
466,
2393,
198,
220,
220,
220,
220,
220,
220,
220,
1100,
7,
7753,
11,
366,
138,
102,
4943,
198,
220,
220,
220,
886,
628,
220,
220,
220,
367,
796,
4808,
5868,
35,
5188,
13,
11249,
62,
39,
62,
6759,
8609,
7,
71,
62,
18747,
11,
1181,
62,
18747,
8,
198,
220,
220,
220,
371,
796,
4808,
5868,
35,
5188,
13,
11249,
62,
49,
62,
6759,
8609,
7,
7890,
8,
198,
220,
220,
220,
402,
796,
4808,
5868,
35,
5188,
13,
11249,
62,
38,
62,
6759,
8609,
7,
301,
1850,
62,
39,
62,
6759,
8609,
11,
371,
8,
198,
220,
220,
220,
7377,
102,
796,
4808,
5868,
35,
5188,
13,
11249,
62,
462,
4908,
62,
6759,
8609,
7,
49,
11,
8574,
62,
39,
62,
6759,
8609,
11,
402,
8,
628,
220,
220,
220,
2488,
9288,
477,
7,
271,
1324,
13907,
12195,
39,
11,
8574,
62,
39,
62,
6759,
8609,
11,
379,
349,
28,
16,
4008,
198,
220,
220,
220,
2488,
9288,
477,
7,
271,
1324,
13907,
12195,
49,
11,
8574,
62,
49,
62,
6759,
8609,
11,
379,
349,
28,
16,
4008,
198,
220,
220,
220,
1303,
31,
9288,
477,
7,
271,
1324,
13907,
12195,
38,
11,
8574,
62,
38,
62,
6759,
8609,
11,
379,
349,
28,
16,
4008,
198,
220,
220,
220,
2488,
9288,
477,
7,
271,
1324,
13907,
12195,
138,
102,
11,
8574,
62,
138,
102,
62,
6759,
8609,
11,
379,
349,
28,
16,
4008,
628,
220,
220,
220,
4686,
62,
2100,
11,
2859,
796,
4808,
5868,
35,
5188,
13,
11265,
1143,
62,
411,
312,
723,
82,
7,
7890,
11,
384,
62,
20274,
11,
7377,
102,
8,
198,
220,
220,
220,
1303,
31,
9288,
5145,
41194,
198,
220,
220,
220,
1303,
31,
9288,
4686,
62,
2100,
58,
16,
60,
6624,
366,
18,
1,
198,
220,
220,
220,
1303,
31,
9288,
318,
1324,
13907,
7,
312,
62,
2100,
58,
17,
4357,
657,
13,
11442,
2327,
17430,
11,
379,
349,
28,
16,
68,
12,
23,
8,
628,
220,
220,
220,
4808,
5868,
35,
5188,
13,
36439,
62,
11265,
1143,
62,
411,
312,
723,
82,
7,
7890,
11,
384,
62,
20274,
11,
371,
8,
198,
220,
220,
220,
2488,
9288,
468,
2539,
7,
325,
62,
20274,
14692,
82,
2122,
1,
7131,
1,
1326,
292,
1,
7131,
1,
20,
33116,
366,
48624,
4943,
198,
437
] | 2.067679 | 6,915 |
module CUDNN
using CUDA
include("../libcudnn-5/libcudnn.jl")
include("../libcudnn-5/libcudnn_types.jl")
@windows? (
begin
const libcudnn = Libdl.find_library(["cudnn64_5"])
end : begin
const libcudnn = Libdl.find_library(["libcudnn"])
end)
isempty(libcudnn) && throw("CUDNN library cannot be found.")
function checkstatus(status)
if status != CUDNN_STATUS_SUCCESS
Base.show_backtrace(STDOUT, backtrace())
throw(bytestring(cudnnGetErrorString(status)))
end
end
datatype(::Type{Float32}) = CUDNN_DATA_FLOAT
datatype(::Type{Float64}) = CUDNN_DATA_DOUBLE
datatype(::Type{Float16}) = CUDNN_DATA_HALF
include("handle.jl")
include("tensor.jl")
include("activation.jl")
include("convolution.jl")
include("filter.jl")
include("softmax.jl")
end
| [
21412,
327,
8322,
6144,
198,
198,
3500,
29369,
5631,
198,
198,
17256,
7203,
40720,
8019,
66,
463,
20471,
12,
20,
14,
8019,
66,
463,
20471,
13,
20362,
4943,
198,
17256,
7203,
40720,
8019,
66,
463,
20471,
12,
20,
14,
8019,
66,
463,
20471,
62,
19199,
13,
20362,
4943,
198,
198,
31,
28457,
30,
357,
198,
220,
2221,
198,
220,
220,
220,
1500,
9195,
66,
463,
20471,
796,
7980,
25404,
13,
19796,
62,
32016,
7,
14692,
66,
463,
20471,
2414,
62,
20,
8973,
8,
198,
220,
886,
1058,
2221,
198,
220,
220,
220,
1500,
9195,
66,
463,
20471,
796,
7980,
25404,
13,
19796,
62,
32016,
7,
14692,
8019,
66,
463,
20471,
8973,
8,
198,
220,
886,
8,
198,
271,
28920,
7,
8019,
66,
463,
20471,
8,
11405,
3714,
7203,
34,
8322,
6144,
5888,
2314,
307,
1043,
19570,
198,
198,
8818,
2198,
13376,
7,
13376,
8,
198,
220,
611,
3722,
14512,
327,
8322,
6144,
62,
35744,
2937,
62,
12564,
4093,
7597,
198,
220,
220,
220,
7308,
13,
12860,
62,
1891,
40546,
7,
36886,
11,
736,
40546,
28955,
198,
220,
220,
220,
3714,
7,
1525,
9288,
1806,
7,
66,
463,
20471,
3855,
12331,
10100,
7,
13376,
22305,
198,
220,
886,
198,
437,
198,
198,
19608,
265,
2981,
7,
3712,
6030,
90,
43879,
2624,
30072,
796,
327,
8322,
6144,
62,
26947,
62,
3697,
46,
1404,
198,
19608,
265,
2981,
7,
3712,
6030,
90,
43879,
2414,
30072,
796,
327,
8322,
6144,
62,
26947,
62,
35,
2606,
19146,
198,
19608,
265,
2981,
7,
3712,
6030,
90,
43879,
1433,
30072,
796,
327,
8322,
6144,
62,
26947,
62,
39,
1847,
37,
198,
198,
17256,
7203,
28144,
13,
20362,
4943,
198,
17256,
7203,
83,
22854,
13,
20362,
4943,
198,
17256,
7203,
48545,
13,
20362,
4943,
198,
17256,
7203,
42946,
2122,
13,
20362,
4943,
198,
17256,
7203,
24455,
13,
20362,
4943,
198,
17256,
7203,
4215,
9806,
13,
20362,
4943,
198,
198,
437,
198
] | 2.453674 | 313 |
import Base: .+, .-, .*, ./, .^, max, min, .==, .>, .>=, .<, .<=, +, -
# Broadcasting binary functions (uses the same list as same size arrays)
cuda12 = cuda11
# Broadcast max/min haven't been defined:
max(a::Array,b::Array)=broadcast(max,a,b)
min(a::Array,b::Array)=broadcast(min,a,b)
function vbroadcast_shape(x,y)
nz = max(ndims(x),ndims(y))
dz = ones(Int,nz)
xdims = ydims = xsame = ysame = xlast = ylast = 0; zlen = 1
for i=1:nz
if size(x,i) > 1
xdims += 1; xlast = i
dz[i] = size(x,i)
end
if size(y,i) > 1
ydims += 1; ylast = i
if dz[i] == 1
dz[i] = size(y,i)
else
dz[i] == size(y,i) || throw(DimensionMismatch("arrays could not be broadcast to a common size"))
end
end
xsame += (dz[i] == size(x,i))
ysame += (dz[i] == size(y,i))
zlen *= dz[i]
end
xsame == nz || xdims <= 1 || error("Only vector broadcasting supported")
ysame == nz || ydims <= 1 || error("Only vector broadcasting supported")
if xdims == 0
sx = zlen; nx = 1
elseif xdims == 1
sx = prod(dz[1:xlast-1]); nx=dz[xlast]
elseif xsame == nz
sx = 1; nx=zlen
else
error("Broadcasting error")
end
if ydims == 0
sy = zlen; ny = 1
elseif ydims == 1
sy = prod(dz[1:ylast-1]); ny=dz[ylast]
elseif ysame == nz
sy = 1; ny=zlen
else
error("Broadcasting error")
end
return (tuple(dz...), sx, nx, sy, ny)
end
function cuda12def(f, j=f, o...)
J=Symbol(j)
for S in (32,64)
T = Symbol("Float$S")
F11 = "$(f)_$(S)_11"
F12 = "$(f)_$(S)_12"
@eval begin
function $J(x::KnetArray{$T},y::KnetArray{$T})
if size(x)==size(y)
z = similar(x)
ccall(($F11,$libknet8),Void,(Cint,$Ptr{$T},Ptr{$T},Ptr{$T}),length(z),x,y,z)
return z
else
(dz,sx,nx,sy,ny) = vbroadcast_shape(x,y)
z = similar(x,dz)
ccall(($F12,$libknet8),Void,(Cint,$Ptr{$T},Cint,Cint,Ptr{$T},Cint,Cint,Ptr{$T}),length(z),x,sx,nx,y,sy,ny,z)
return z
end
end
end
end
end
#if isdefined(:libknet8)
for f in cuda12
isa(f,Tuple) || (f=(f,))
cuda12def(f...)
end
#end
| [
11748,
7308,
25,
764,
28200,
764,
20995,
764,
25666,
24457,
11,
764,
61,
11,
3509,
11,
949,
11,
764,
855,
11,
764,
22330,
764,
29,
28,
11,
764,
27,
11,
764,
27,
28,
11,
1343,
11,
532,
198,
198,
2,
32250,
13934,
5499,
357,
2664,
262,
976,
1351,
355,
976,
2546,
26515,
8,
198,
66,
15339,
1065,
796,
269,
15339,
1157,
198,
198,
2,
44244,
3509,
14,
1084,
4398,
470,
587,
5447,
25,
198,
9806,
7,
64,
3712,
19182,
11,
65,
3712,
19182,
47505,
36654,
2701,
7,
9806,
11,
64,
11,
65,
8,
198,
1084,
7,
64,
3712,
19182,
11,
65,
3712,
19182,
47505,
36654,
2701,
7,
1084,
11,
64,
11,
65,
8,
198,
198,
8818,
410,
36654,
2701,
62,
43358,
7,
87,
11,
88,
8,
198,
220,
220,
220,
299,
89,
796,
3509,
7,
358,
12078,
7,
87,
828,
358,
12078,
7,
88,
4008,
198,
220,
220,
220,
288,
89,
796,
3392,
7,
5317,
11,
27305,
8,
198,
220,
220,
220,
2124,
67,
12078,
796,
331,
67,
12078,
796,
2124,
31642,
796,
331,
31642,
796,
2124,
12957,
796,
331,
12957,
796,
657,
26,
1976,
11925,
796,
352,
198,
220,
220,
220,
329,
1312,
28,
16,
25,
27305,
198,
220,
220,
220,
220,
220,
220,
220,
611,
2546,
7,
87,
11,
72,
8,
1875,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
67,
12078,
15853,
352,
26,
2124,
12957,
796,
1312,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
89,
58,
72,
60,
796,
2546,
7,
87,
11,
72,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
611,
2546,
7,
88,
11,
72,
8,
1875,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
331,
67,
12078,
15853,
352,
26,
331,
12957,
796,
1312,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
288,
89,
58,
72,
60,
6624,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
89,
58,
72,
60,
796,
2546,
7,
88,
11,
72,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
89,
58,
72,
60,
6624,
2546,
7,
88,
11,
72,
8,
8614,
3714,
7,
29271,
3004,
44,
1042,
963,
7203,
3258,
592,
714,
407,
307,
7025,
284,
257,
2219,
2546,
48774,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
2124,
31642,
15853,
357,
67,
89,
58,
72,
60,
6624,
2546,
7,
87,
11,
72,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
331,
31642,
15853,
357,
67,
89,
58,
72,
60,
6624,
2546,
7,
88,
11,
72,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
1976,
11925,
1635,
28,
288,
89,
58,
72,
60,
198,
220,
220,
220,
886,
198,
220,
220,
220,
2124,
31642,
6624,
299,
89,
8614,
2124,
67,
12078,
19841,
352,
8614,
4049,
7203,
10049,
15879,
22978,
4855,
4943,
198,
220,
220,
220,
331,
31642,
6624,
299,
89,
8614,
331,
67,
12078,
19841,
352,
8614,
4049,
7203,
10049,
15879,
22978,
4855,
4943,
198,
220,
220,
220,
611,
2124,
67,
12078,
6624,
657,
198,
220,
220,
220,
220,
220,
220,
220,
264,
87,
796,
1976,
11925,
26,
299,
87,
796,
352,
198,
220,
220,
220,
2073,
361,
2124,
67,
12078,
6624,
352,
198,
220,
220,
220,
220,
220,
220,
220,
264,
87,
796,
40426,
7,
67,
89,
58,
16,
25,
87,
12957,
12,
16,
36563,
299,
87,
28,
67,
89,
58,
87,
12957,
60,
198,
220,
220,
220,
2073,
361,
2124,
31642,
6624,
299,
89,
198,
220,
220,
220,
220,
220,
220,
220,
264,
87,
796,
352,
26,
299,
87,
28,
89,
11925,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
4049,
7203,
30507,
19913,
4049,
4943,
198,
220,
220,
220,
886,
198,
220,
220,
220,
611,
331,
67,
12078,
6624,
657,
198,
220,
220,
220,
220,
220,
220,
220,
827,
796,
1976,
11925,
26,
299,
88,
796,
352,
198,
220,
220,
220,
2073,
361,
331,
67,
12078,
6624,
352,
198,
220,
220,
220,
220,
220,
220,
220,
827,
796,
40426,
7,
67,
89,
58,
16,
25,
2645,
459,
12,
16,
36563,
299,
88,
28,
67,
89,
58,
2645,
459,
60,
198,
220,
220,
220,
2073,
361,
331,
31642,
6624,
299,
89,
198,
220,
220,
220,
220,
220,
220,
220,
827,
796,
352,
26,
299,
88,
28,
89,
11925,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
4049,
7203,
30507,
19913,
4049,
4943,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
357,
83,
29291,
7,
67,
89,
986,
828,
264,
87,
11,
299,
87,
11,
827,
11,
299,
88,
8,
198,
437,
198,
198,
8818,
269,
15339,
1065,
4299,
7,
69,
11,
474,
28,
69,
11,
267,
23029,
198,
220,
220,
220,
449,
28,
13940,
23650,
7,
73,
8,
198,
220,
220,
220,
329,
311,
287,
357,
2624,
11,
2414,
8,
198,
220,
220,
220,
220,
220,
220,
220,
309,
796,
38357,
7203,
43879,
3,
50,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
376,
1157,
796,
17971,
7,
69,
8,
62,
3,
7,
50,
8,
62,
1157,
1,
198,
220,
220,
220,
220,
220,
220,
220,
376,
1065,
796,
17971,
7,
69,
8,
62,
3,
7,
50,
8,
62,
1065,
1,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
18206,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2163,
720,
41,
7,
87,
3712,
42,
3262,
19182,
90,
3,
51,
5512,
88,
3712,
42,
3262,
19182,
90,
3,
51,
30072,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
2546,
7,
87,
8,
855,
7857,
7,
88,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
796,
2092,
7,
87,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
16763,
37,
1157,
11,
3,
8019,
74,
3262,
23,
828,
53,
1868,
11,
7,
34,
600,
11,
3,
46745,
90,
3,
51,
5512,
46745,
90,
3,
51,
5512,
46745,
90,
3,
51,
92,
828,
13664,
7,
89,
828,
87,
11,
88,
11,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
1976,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
67,
89,
11,
82,
87,
11,
77,
87,
11,
1837,
11,
3281,
8,
796,
410,
36654,
2701,
62,
43358,
7,
87,
11,
88,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
796,
2092,
7,
87,
11,
67,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
269,
13345,
7,
16763,
37,
1065,
11,
3,
8019,
74,
3262,
23,
828,
53,
1868,
11,
7,
34,
600,
11,
3,
46745,
90,
3,
51,
5512,
34,
600,
11,
34,
600,
11,
46745,
90,
3,
51,
5512,
34,
600,
11,
34,
600,
11,
46745,
90,
3,
51,
92,
828,
13664,
7,
89,
828,
87,
11,
82,
87,
11,
77,
87,
11,
88,
11,
1837,
11,
3281,
11,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
1976,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
437,
198,
220,
220,
220,
220,
198,
2,
361,
318,
23211,
7,
25,
8019,
74,
3262,
23,
8,
198,
220,
220,
220,
329,
277,
287,
269,
15339,
1065,
198,
220,
220,
220,
220,
220,
220,
220,
318,
64,
7,
69,
11,
51,
29291,
8,
8614,
357,
69,
16193,
69,
11,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
269,
15339,
1065,
4299,
7,
69,
23029,
198,
220,
220,
220,
886,
198,
2,
437,
198
] | 1.710306 | 1,436 |
@testset "8.8 Polylogarithm function" begin
(F, a, b, c, d, e, f, g, h, m, n, p, q, x, ) = @variables F a b c d e f g h m n p q x
#= ::Package:: =#
#= ::Title:: =#
#=Integration*Problems*Involving*the*Polylogarithm*Function=#
#= ::Section::Closed:: =#
#=Integrands*of*the*form*(d*x)^m*PolyLog(n, a*x^q)=#
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*x^m*PolyLog(n, a*x^q)=#
#= ::Subsubsection::Closed:: =#
#=q=1=#
@test_int [x^4*PolyLog(2, a*x), x, 4, -(x/(25*a^4)) - x^2/(50*a^3) - x^3/(75*a^2) - x^4/(100*a) - x^5/125 - log(1 - a*x)/(25*a^5) + (1/25)*x^5*log(1 - a*x) + (1/5)*x^5*PolyLog(2, a*x)]
@test_int [x^3*PolyLog(2, a*x), x, 4, -(x/(16*a^3)) - x^2/(32*a^2) - x^3/(48*a) - x^4/64 - log(1 - a*x)/(16*a^4) + (1/16)*x^4*log(1 - a*x) + (1/4)*x^4*PolyLog(2, a*x)]
@test_int [x^2*PolyLog(2, a*x), x, 4, -(x/(9*a^2)) - x^2/(18*a) - x^3/27 - log(1 - a*x)/(9*a^3) + (1/9)*x^3*log(1 - a*x) + (1/3)*x^3*PolyLog(2, a*x)]
@test_int [x^1*PolyLog(2, a*x), x, 4, -(x/(4*a)) - x^2/8 - log(1 - a*x)/(4*a^2) + (1/4)*x^2*log(1 - a*x) + (1/2)*x^2*PolyLog(2, a*x)]
@test_int [x^0*PolyLog(2, a*x), x, 3, -x - ((1 - a*x)*log(1 - a*x))/a + x*PolyLog(2, a*x)]
@test_int [PolyLog(2, a*x)/x^1, x, 1, PolyLog(3, a*x)]
@test_int [PolyLog(2, a*x)/x^2, x, 5, a*log(x) - a*log(1 - a*x) + log(1 - a*x)/x - PolyLog(2, a*x)/x]
@test_int [PolyLog(2, a*x)/x^3, x, 4, -(a/(4*x)) + (1/4)*a^2*log(x) - (1/4)*a^2*log(1 - a*x) + log(1 - a*x)/(4*x^2) - PolyLog(2, a*x)/(2*x^2)]
@test_int [PolyLog(2, a*x)/x^4, x, 4, -(a/(18*x^2)) - a^2/(9*x) + (1/9)*a^3*log(x) - (1/9)*a^3*log(1 - a*x) + log(1 - a*x)/(9*x^3) - PolyLog(2, a*x)/(3*x^3)]
@test_int [PolyLog(2, a*x)/x^5, x, 4, -(a/(48*x^3)) - a^2/(32*x^2) - a^3/(16*x) + (1/16)*a^4*log(x) - (1/16)*a^4*log(1 - a*x) + log(1 - a*x)/(16*x^4) - PolyLog(2, a*x)/(4*x^4)]
@test_int [x^3*PolyLog(3, a*x), x, 5, x/(64*a^3) + x^2/(128*a^2) + x^3/(192*a) + x^4/256 + log(1 - a*x)/(64*a^4) - (1/64)*x^4*log(1 - a*x) - (1/16)*x^4*PolyLog(2, a*x) + (1/4)*x^4*PolyLog(3, a*x)]
@test_int [x^2*PolyLog(3, a*x), x, 5, x/(27*a^2) + x^2/(54*a) + x^3/81 + log(1 - a*x)/(27*a^3) - (1/27)*x^3*log(1 - a*x) - (1/9)*x^3*PolyLog(2, a*x) + (1/3)*x^3*PolyLog(3, a*x)]
@test_int [x^1*PolyLog(3, a*x), x, 5, x/(8*a) + x^2/16 + log(1 - a*x)/(8*a^2) - (1/8)*x^2*log(1 - a*x) - (1/4)*x^2*PolyLog(2, a*x) + (1/2)*x^2*PolyLog(3, a*x)]
@test_int [x^0*PolyLog(3, a*x), x, 4, x + ((1 - a*x)*log(1 - a*x))/a - x*PolyLog(2, a*x) + x*PolyLog(3, a*x)]
@test_int [PolyLog(3, a*x)/x^1, x, 1, PolyLog(4, a*x)]
@test_int [PolyLog(3, a*x)/x^2, x, 6, a*log(x) - a*log(1 - a*x) + log(1 - a*x)/x - PolyLog(2, a*x)/x - PolyLog(3, a*x)/x]
@test_int [PolyLog(3, a*x)/x^3, x, 5, -(a/(8*x)) + (1/8)*a^2*log(x) - (1/8)*a^2*log(1 - a*x) + log(1 - a*x)/(8*x^2) - PolyLog(2, a*x)/(4*x^2) - PolyLog(3, a*x)/(2*x^2)]
@test_int [PolyLog(3, a*x)/x^4, x, 5, -(a/(54*x^2)) - a^2/(27*x) + (1/27)*a^3*log(x) - (1/27)*a^3*log(1 - a*x) + log(1 - a*x)/(27*x^3) - PolyLog(2, a*x)/(9*x^3) - PolyLog(3, a*x)/(3*x^3)]
#= ::Subsubsection::Closed:: =#
#=q=2=#
@test_int [x^5*PolyLog(2, a*x^2), x, 5, -(x^2/(18*a^2)) - x^4/(36*a) - x^6/54 - log(1 - a*x^2)/(18*a^3) + (1/18)*x^6*log(1 - a*x^2) + (1/6)*x^6*PolyLog(2, a*x^2)]
@test_int [x^3*PolyLog(2, a*x^2), x, 5, -(x^2/(8*a)) - x^4/16 - log(1 - a*x^2)/(8*a^2) + (1/8)*x^4*log(1 - a*x^2) + (1/4)*x^4*PolyLog(2, a*x^2)]
@test_int [x^1*PolyLog(2, a*x^2), x, 4, -(x^2/2) - ((1 - a*x^2)*log(1 - a*x^2))/(2*a) + (1/2)*x^2*PolyLog(2, a*x^2)]
@test_int [PolyLog(2, a*x^2)/x^1, x, 1, (1/2)*PolyLog(3, a*x^2)]
@test_int [PolyLog(2, a*x^2)/x^3, x, 6, a*log(x) - (1/2)*a*log(1 - a*x^2) + log(1 - a*x^2)/(2*x^2) - PolyLog(2, a*x^2)/(2*x^2)]
@test_int [PolyLog(2, a*x^2)/x^5, x, 5, -(a/(8*x^2)) + (1/4)*a^2*log(x) - (1/8)*a^2*log(1 - a*x^2) + log(1 - a*x^2)/(8*x^4) - PolyLog(2, a*x^2)/(4*x^4)]
@test_int [PolyLog(2, a*x^2)/x^7, x, 5, -(a/(36*x^4)) - a^2/(18*x^2) + (1/9)*a^3*log(x) - (1/18)*a^3*log(1 - a*x^2) + log(1 - a*x^2)/(18*x^6) - PolyLog(2, a*x^2)/(6*x^6)]
@test_int [x^4*PolyLog(2, a*x^2), x, 5, -((4*x)/(25*a^2)) - (4*x^3)/(75*a) - (4*x^5)/125 + (4*atanh(sqrt(a)*x))/(25*a^(5/2)) + (2/25)*x^5*log(1 - a*x^2) + (1/5)*x^5*PolyLog(2, a*x^2)]
@test_int [x^2*PolyLog(2, a*x^2), x, 5, -((4*x)/(9*a)) - (4*x^3)/27 + (4*atanh(sqrt(a)*x))/(9*a^(3/2)) + (2/9)*x^3*log(1 - a*x^2) + (1/3)*x^3*PolyLog(2, a*x^2)]
@test_int [x^0*PolyLog(2, a*x^2), x, 4, -4*x + (4*atanh(sqrt(a)*x))/sqrt(a) + 2*x*log(1 - a*x^2) + x*PolyLog(2, a*x^2)]
@test_int [PolyLog(2, a*x^2)/x^2, x, 3, 4*sqrt(a)*atanh(sqrt(a)*x) + (2*log(1 - a*x^2))/x - PolyLog(2, a*x^2)/x]
@test_int [PolyLog(2, a*x^2)/x^4, x, 4, -((4*a)/(9*x)) + (4/9)*a^(3/2)*atanh(sqrt(a)*x) + (2*log(1 - a*x^2))/(9*x^3) - PolyLog(2, a*x^2)/(3*x^3)]
@test_int [PolyLog(2, a*x^2)/x^6, x, 5, -((4*a)/(75*x^3)) - (4*a^2)/(25*x) + (4/25)*a^(5/2)*atanh(sqrt(a)*x) + (2*log(1 - a*x^2))/(25*x^5) - PolyLog(2, a*x^2)/(5*x^5)]
@test_int [x^5*PolyLog(3, a*x^2), x, 6, x^2/(54*a^2) + x^4/(108*a) + x^6/162 + log(1 - a*x^2)/(54*a^3) - (1/54)*x^6*log(1 - a*x^2) - (1/18)*x^6*PolyLog(2, a*x^2) + (1/6)*x^6*PolyLog(3, a*x^2)]
@test_int [x^3*PolyLog(3, a*x^2), x, 6, x^2/(16*a) + x^4/32 + log(1 - a*x^2)/(16*a^2) - (1/16)*x^4*log(1 - a*x^2) - (1/8)*x^4*PolyLog(2, a*x^2) + (1/4)*x^4*PolyLog(3, a*x^2)]
@test_int [x^1*PolyLog(3, a*x^2), x, 5, x^2/2 + ((1 - a*x^2)*log(1 - a*x^2))/(2*a) - (1/2)*x^2*PolyLog(2, a*x^2) + (1/2)*x^2*PolyLog(3, a*x^2)]
@test_int [PolyLog(3, a*x^2)/x^1, x, 1, (1/2)*PolyLog(4, a*x^2)]
@test_int [PolyLog(3, a*x^2)/x^3, x, 7, a*log(x) - (1/2)*a*log(1 - a*x^2) + log(1 - a*x^2)/(2*x^2) - PolyLog(2, a*x^2)/(2*x^2) - PolyLog(3, a*x^2)/(2*x^2)]
@test_int [PolyLog(3, a*x^2)/x^5, x, 6, -(a/(16*x^2)) + (1/8)*a^2*log(x) - (1/16)*a^2*log(1 - a*x^2) + log(1 - a*x^2)/(16*x^4) - PolyLog(2, a*x^2)/(8*x^4) - PolyLog(3, a*x^2)/(4*x^4)]
@test_int [PolyLog(3, a*x^2)/x^7, x, 6, -(a/(108*x^4)) - a^2/(54*x^2) + (1/27)*a^3*log(x) - (1/54)*a^3*log(1 - a*x^2) + log(1 - a*x^2)/(54*x^6) - PolyLog(2, a*x^2)/(18*x^6) - PolyLog(3, a*x^2)/(6*x^6)]
@test_int [x^4*PolyLog(3, a*x^2), x, 6, (8*x)/(125*a^2) + (8*x^3)/(375*a) + (8*x^5)/625 - (8*atanh(sqrt(a)*x))/(125*a^(5/2)) - (4/125)*x^5*log(1 - a*x^2) - (2/25)*x^5*PolyLog(2, a*x^2) + (1/5)*x^5*PolyLog(3, a*x^2)]
@test_int [x^2*PolyLog(3, a*x^2), x, 6, (8*x)/(27*a) + (8*x^3)/81 - (8*atanh(sqrt(a)*x))/(27*a^(3/2)) - (4/27)*x^3*log(1 - a*x^2) - (2/9)*x^3*PolyLog(2, a*x^2) + (1/3)*x^3*PolyLog(3, a*x^2)]
@test_int [x^0*PolyLog(3, a*x^2), x, 5, 8*x - (8*atanh(sqrt(a)*x))/sqrt(a) - 4*x*log(1 - a*x^2) - 2*x*PolyLog(2, a*x^2) + x*PolyLog(3, a*x^2)]
@test_int [PolyLog(3, a*x^2)/x^2, x, 4, 8*sqrt(a)*atanh(sqrt(a)*x) + (4*log(1 - a*x^2))/x - (2*PolyLog(2, a*x^2))/x - PolyLog(3, a*x^2)/x]
@test_int [PolyLog(3, a*x^2)/x^4, x, 5, -((8*a)/(27*x)) + (8/27)*a^(3/2)*atanh(sqrt(a)*x) + (4*log(1 - a*x^2))/(27*x^3) - (2*PolyLog(2, a*x^2))/(9*x^3) - PolyLog(3, a*x^2)/(3*x^3)]
@test_int [PolyLog(3, a*x^2)/x^6, x, 6, -((8*a)/(375*x^3)) - (8*a^2)/(125*x) + (8/125)*a^(5/2)*atanh(sqrt(a)*x) + (4*log(1 - a*x^2))/(125*x^5) - (2*PolyLog(2, a*x^2))/(25*x^5) - PolyLog(3, a*x^2)/(5*x^5)]
#= ::Subsubsection::Closed:: =#
#=q*symbolic=#
@test_int [x^2*PolyLog(2, a*x^q), x, 3, (a*q^2*x^(3 + q)*HypergeometricFunctions._₂F₁(1, (3 + q)/q, 2 + 3/q, a*x^q))/(9*(3 + q)) + (1/9)*q*x^3*log(1 - a*x^q) + (1/3)*x^3*PolyLog(2, a*x^q)]
@test_int [x^1*PolyLog(2, a*x^q), x, 3, (a*q^2*x^(2 + q)*HypergeometricFunctions._₂F₁(1, (2 + q)/q, 2*(1 + 1/q), a*x^q))/(4*(2 + q)) + (1/4)*q*x^2*log(1 - a*x^q) + (1/2)*x^2*PolyLog(2, a*x^q)]
@test_int [x^0*PolyLog(2, a*x^q), x, 3, (a*q^2*x^(1 + q)*HypergeometricFunctions._₂F₁(1, 1 + 1/q, 2 + 1/q, a*x^q))/(1 + q) + q*x*log(1 - a*x^q) + x*PolyLog(2, a*x^q)]
@test_int [PolyLog(2, a*x^q)/x^1, x, 1, PolyLog(3, a*x^q)/q]
@test_int [PolyLog(2, a*x^q)/x^2, x, 3, -((a*q^2*x^(-1 + q)*HypergeometricFunctions._₂F₁(1, -((1 - q)/q), 2 - 1/q, a*x^q))/(1 - q)) + (q*log(1 - a*x^q))/x - PolyLog(2, a*x^q)/x]
@test_int [PolyLog(2, a*x^q)/x^3, x, 3, -((a*q^2*x^(-2 + q)*HypergeometricFunctions._₂F₁(1, -((2 - q)/q), 2*(1 - 1/q), a*x^q))/(4*(2 - q))) + (q*log(1 - a*x^q))/(4*x^2) - PolyLog(2, a*x^q)/(2*x^2)]
@test_int [PolyLog(2, a*x^q)/x^4, x, 3, -((a*q^2*x^(-3 + q)*HypergeometricFunctions._₂F₁(1, -((3 - q)/q), 2 - 3/q, a*x^q))/(9*(3 - q))) + (q*log(1 - a*x^q))/(9*x^3) - PolyLog(2, a*x^q)/(3*x^3)]
@test_int [x^2*PolyLog(3, a*x^q), x, 4, -((a*q^3*x^(3 + q)*HypergeometricFunctions._₂F₁(1, (3 + q)/q, 2 + 3/q, a*x^q))/(27*(3 + q))) - (1/27)*q^2*x^3*log(1 - a*x^q) - (1/9)*q*x^3*PolyLog(2, a*x^q) + (1/3)*x^3*PolyLog(3, a*x^q)]
@test_int [x^1*PolyLog(3, a*x^q), x, 4, -((a*q^3*x^(2 + q)*HypergeometricFunctions._₂F₁(1, (2 + q)/q, 2*(1 + 1/q), a*x^q))/(8*(2 + q))) - (1/8)*q^2*x^2*log(1 - a*x^q) - (1/4)*q*x^2*PolyLog(2, a*x^q) + (1/2)*x^2*PolyLog(3, a*x^q)]
@test_int [x^0*PolyLog(3, a*x^q), x, 4, -((a*q^3*x^(1 + q)*HypergeometricFunctions._₂F₁(1, 1 + 1/q, 2 + 1/q, a*x^q))/(1 + q)) - q^2*x*log(1 - a*x^q) - q*x*PolyLog(2, a*x^q) + x*PolyLog(3, a*x^q)]
@test_int [PolyLog(3, a*x^q)/x^1, x, 1, PolyLog(4, a*x^q)/q]
@test_int [PolyLog(3, a*x^q)/x^2, x, 4, -((a*q^3*x^(-1 + q)*HypergeometricFunctions._₂F₁(1, -((1 - q)/q), 2 - 1/q, a*x^q))/(1 - q)) + (q^2*log(1 - a*x^q))/x - (q*PolyLog(2, a*x^q))/x - PolyLog(3, a*x^q)/x]
@test_int [PolyLog(3, a*x^q)/x^3, x, 4, -((a*q^3*x^(-2 + q)*HypergeometricFunctions._₂F₁(1, -((2 - q)/q), 2*(1 - 1/q), a*x^q))/(8*(2 - q))) + (q^2*log(1 - a*x^q))/(8*x^2) - (q*PolyLog(2, a*x^q))/(4*x^2) - PolyLog(3, a*x^q)/(2*x^2)]
@test_int [PolyLog(3, a*x^q)/x^4, x, 4, -((a*q^3*x^(-3 + q)*HypergeometricFunctions._₂F₁(1, -((3 - q)/q), 2 - 3/q, a*x^q))/(27*(3 - q))) + (q^2*log(1 - a*x^q))/(27*x^3) - (q*PolyLog(2, a*x^q))/(9*x^3) - PolyLog(3, a*x^q)/(3*x^3)]
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*(d*x)^(m/2)*PolyLog(n, a*x^q)=#
#= ::Subsubsection::Closed:: =#
#=q=1=#
@test_int [(d*x)^(3/2)*PolyLog(2, a*x), x, 7, -((8*d*sqrt(d*x))/(25*a^2)) - (8*(d*x)^(3/2))/(75*a) - (8*(d*x)^(5/2))/(125*d) + (8*d^(3/2)*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/(25*a^(5/2)) + (4*(d*x)^(5/2)*log(1 - a*x))/(25*d) + (2*(d*x)^(5/2)*PolyLog(2, a*x))/(5*d)]
@test_int [(d*x)^(1/2)*PolyLog(2, a*x), x, 6, -((8*sqrt(d*x))/(9*a)) - (8*(d*x)^(3/2))/(27*d) + (8*sqrt(d)*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/(9*a^(3/2)) + (4*(d*x)^(3/2)*log(1 - a*x))/(9*d) + (2*(d*x)^(3/2)*PolyLog(2, a*x))/(3*d)]
@test_int [PolyLog(2, a*x)/(d*x)^(1/2), x, 5, -((8*sqrt(d*x))/d) + (8*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/(sqrt(a)*sqrt(d)) + (4*sqrt(d*x)*log(1 - a*x))/d + (2*sqrt(d*x)*PolyLog(2, a*x))/d]
@test_int [PolyLog(2, a*x)/(d*x)^(3/2), x, 4, (8*sqrt(a)*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/d^(3/2) + (4*log(1 - a*x))/(d*sqrt(d*x)) - (2*PolyLog(2, a*x))/(d*sqrt(d*x))]
@test_int [PolyLog(2, a*x)/(d*x)^(5/2), x, 5, -((8*a)/(9*d^2*sqrt(d*x))) + (8*a^(3/2)*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/(9*d^(5/2)) + (4*log(1 - a*x))/(9*d*(d*x)^(3/2)) - (2*PolyLog(2, a*x))/(3*d*(d*x)^(3/2))]
@test_int [PolyLog(2, a*x)/(d*x)^(7/2), x, 6, -((8*a)/(75*d^2*(d*x)^(3/2))) - (8*a^2)/(25*d^3*sqrt(d*x)) + (8*a^(5/2)*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/(25*d^(7/2)) + (4*log(1 - a*x))/(25*d*(d*x)^(5/2)) - (2*PolyLog(2, a*x))/(5*d*(d*x)^(5/2))]
@test_int [(d*x)^(5/2)*PolyLog(3, a*x), x, 9, (16*d^2*sqrt(d*x))/(343*a^3) + (16*d*(d*x)^(3/2))/(1029*a^2) + (16*(d*x)^(5/2))/(1715*a) + (16*(d*x)^(7/2))/(2401*d) - (16*d^(5/2)*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/(343*a^(7/2)) - (8*(d*x)^(7/2)*log(1 - a*x))/(343*d) - (4*(d*x)^(7/2)*PolyLog(2, a*x))/(49*d) + (2*(d*x)^(7/2)*PolyLog(3, a*x))/(7*d)]
@test_int [(d*x)^(3/2)*PolyLog(3, a*x), x, 8, (16*d*sqrt(d*x))/(125*a^2) + (16*(d*x)^(3/2))/(375*a) + (16*(d*x)^(5/2))/(625*d) - (16*d^(3/2)*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/(125*a^(5/2)) - (8*(d*x)^(5/2)*log(1 - a*x))/(125*d) - (4*(d*x)^(5/2)*PolyLog(2, a*x))/(25*d) + (2*(d*x)^(5/2)*PolyLog(3, a*x))/(5*d)]
@test_int [(d*x)^(1/2)*PolyLog(3, a*x), x, 7, (16*sqrt(d*x))/(27*a) + (16*(d*x)^(3/2))/(81*d) - (16*sqrt(d)*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/(27*a^(3/2)) - (8*(d*x)^(3/2)*log(1 - a*x))/(27*d) - (4*(d*x)^(3/2)*PolyLog(2, a*x))/(9*d) + (2*(d*x)^(3/2)*PolyLog(3, a*x))/(3*d)]
@test_int [PolyLog(3, a*x)/(d*x)^(1/2), x, 6, (16*sqrt(d*x))/d - (16*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/(sqrt(a)*sqrt(d)) - (8*sqrt(d*x)*log(1 - a*x))/d - (4*sqrt(d*x)*PolyLog(2, a*x))/d + (2*sqrt(d*x)*PolyLog(3, a*x))/d]
@test_int [PolyLog(3, a*x)/(d*x)^(3/2), x, 5, (16*sqrt(a)*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/d^(3/2) + (8*log(1 - a*x))/(d*sqrt(d*x)) - (4*PolyLog(2, a*x))/(d*sqrt(d*x)) - (2*PolyLog(3, a*x))/(d*sqrt(d*x))]
@test_int [PolyLog(3, a*x)/(d*x)^(5/2), x, 6, -((16*a)/(27*d^2*sqrt(d*x))) + (16*a^(3/2)*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/(27*d^(5/2)) + (8*log(1 - a*x))/(27*d*(d*x)^(3/2)) - (4*PolyLog(2, a*x))/(9*d*(d*x)^(3/2)) - (2*PolyLog(3, a*x))/(3*d*(d*x)^(3/2))]
@test_int [PolyLog(3, a*x)/(d*x)^(7/2), x, 7, -((16*a)/(375*d^2*(d*x)^(3/2))) - (16*a^2)/(125*d^3*sqrt(d*x)) + (16*a^(5/2)*atanh((sqrt(a)*sqrt(d*x))/sqrt(d)))/(125*d^(7/2)) + (8*log(1 - a*x))/(125*d*(d*x)^(5/2)) - (4*PolyLog(2, a*x))/(25*d*(d*x)^(5/2)) - (2*PolyLog(3, a*x))/(5*d*(d*x)^(5/2))]
#= ::Subsubsection::Closed:: =#
#=q=2=#
@test_int [(d*x)^(3/2)*PolyLog(2, a*x^2), x, 9, -((32*d*sqrt(d*x))/(25*a)) - (32*(d*x)^(5/2))/(125*d) + (16*d^(3/2)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(25*a^(5/4)) + (16*d^(3/2)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(25*a^(5/4)) + (8*(d*x)^(5/2)*log(1 - a*x^2))/(25*d) + (2*(d*x)^(5/2)*PolyLog(2, a*x^2))/(5*d)]
@test_int [(d*x)^(1/2)*PolyLog(2, a*x^2), x, 8, -((32*(d*x)^(3/2))/(27*d)) - (16*sqrt(d)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(9*a^(3/4)) + (16*sqrt(d)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(9*a^(3/4)) + (8*(d*x)^(3/2)*log(1 - a*x^2))/(9*d) + (2*(d*x)^(3/2)*PolyLog(2, a*x^2))/(3*d)]
@test_int [PolyLog(2, a*x^2)/(d*x)^(1/2), x, 8, -((32*sqrt(d*x))/d) + (16*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(a^(1/4)*sqrt(d)) + (16*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(a^(1/4)*sqrt(d)) + (8*sqrt(d*x)*log(1 - a*x^2))/d + (2*sqrt(d*x)*PolyLog(2, a*x^2))/d]
@test_int [PolyLog(2, a*x^2)/(d*x)^(3/2), x, 7, -((16*a^(1/4)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/d^(3/2)) + (16*a^(1/4)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/d^(3/2) + (8*log(1 - a*x^2))/(d*sqrt(d*x)) - (2*PolyLog(2, a*x^2))/(d*sqrt(d*x))]
@test_int [PolyLog(2, a*x^2)/(d*x)^(5/2), x, 7, (16*a^(3/4)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(9*d^(5/2)) + (16*a^(3/4)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(9*d^(5/2)) + (8*log(1 - a*x^2))/(9*d*(d*x)^(3/2)) - (2*PolyLog(2, a*x^2))/(3*d*(d*x)^(3/2))]
@test_int [PolyLog(2, a*x^2)/(d*x)^(7/2), x, 8, -((32*a)/(25*d^3*sqrt(d*x))) - (16*a^(5/4)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(25*d^(7/2)) + (16*a^(5/4)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(25*d^(7/2)) + (8*log(1 - a*x^2))/(25*d*(d*x)^(5/2)) - (2*PolyLog(2, a*x^2))/(5*d*(d*x)^(5/2))]
@test_int [(d*x)^(5/2)*PolyLog(3, a*x^2), x, 10, (128*d*(d*x)^(3/2))/(1029*a) + (128*(d*x)^(7/2))/(2401*d) + (64*d^(5/2)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(343*a^(7/4)) - (64*d^(5/2)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(343*a^(7/4)) - (32*(d*x)^(7/2)*log(1 - a*x^2))/(343*d) - (8*(d*x)^(7/2)*PolyLog(2, a*x^2))/(49*d) + (2*(d*x)^(7/2)*PolyLog(3, a*x^2))/(7*d)]
@test_int [(d*x)^(3/2)*PolyLog(3, a*x^2), x, 10, (128*d*sqrt(d*x))/(125*a) + (128*(d*x)^(5/2))/(625*d) - (64*d^(3/2)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(125*a^(5/4)) - (64*d^(3/2)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(125*a^(5/4)) - (32*(d*x)^(5/2)*log(1 - a*x^2))/(125*d) - (8*(d*x)^(5/2)*PolyLog(2, a*x^2))/(25*d) + (2*(d*x)^(5/2)*PolyLog(3, a*x^2))/(5*d)]
@test_int [(d*x)^(1/2)*PolyLog(3, a*x^2), x, 9, (128*(d*x)^(3/2))/(81*d) + (64*sqrt(d)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(27*a^(3/4)) - (64*sqrt(d)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(27*a^(3/4)) - (32*(d*x)^(3/2)*log(1 - a*x^2))/(27*d) - (8*(d*x)^(3/2)*PolyLog(2, a*x^2))/(9*d) + (2*(d*x)^(3/2)*PolyLog(3, a*x^2))/(3*d)]
@test_int [PolyLog(3, a*x^2)/(d*x)^(1/2), x, 9, (128*sqrt(d*x))/d - (64*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(a^(1/4)*sqrt(d)) - (64*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(a^(1/4)*sqrt(d)) - (32*sqrt(d*x)*log(1 - a*x^2))/d - (8*sqrt(d*x)*PolyLog(2, a*x^2))/d + (2*sqrt(d*x)*PolyLog(3, a*x^2))/d]
@test_int [PolyLog(3, a*x^2)/(d*x)^(3/2), x, 8, -((64*a^(1/4)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/d^(3/2)) + (64*a^(1/4)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/d^(3/2) + (32*log(1 - a*x^2))/(d*sqrt(d*x)) - (8*PolyLog(2, a*x^2))/(d*sqrt(d*x)) - (2*PolyLog(3, a*x^2))/(d*sqrt(d*x))]
@test_int [PolyLog(3, a*x^2)/(d*x)^(5/2), x, 8, (64*a^(3/4)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(27*d^(5/2)) + (64*a^(3/4)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(27*d^(5/2)) + (32*log(1 - a*x^2))/(27*d*(d*x)^(3/2)) - (8*PolyLog(2, a*x^2))/(9*d*(d*x)^(3/2)) - (2*PolyLog(3, a*x^2))/(3*d*(d*x)^(3/2))]
@test_int [PolyLog(3, a*x^2)/(d*x)^(7/2), x, 9, -((128*a)/(125*d^3*sqrt(d*x))) - (64*a^(5/4)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(125*d^(7/2)) + (64*a^(5/4)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(125*d^(7/2)) + (32*log(1 - a*x^2))/(125*d*(d*x)^(5/2)) - (8*PolyLog(2, a*x^2))/(25*d*(d*x)^(5/2)) - (2*PolyLog(3, a*x^2))/(5*d*(d*x)^(5/2))]
@test_int [PolyLog(3, a*x^2)/(d*x)^(9/2), x, 9, -((128*a)/(1029*d^3*(d*x)^(3/2))) + (64*a^(7/4)*atan((a^(1/4)*sqrt(d*x))/sqrt(d)))/(343*d^(9/2)) + (64*a^(7/4)*atanh((a^(1/4)*sqrt(d*x))/sqrt(d)))/(343*d^(9/2)) + (32*log(1 - a*x^2))/(343*d*(d*x)^(7/2)) - (8*PolyLog(2, a*x^2))/(49*d*(d*x)^(7/2)) - (2*PolyLog(3, a*x^2))/(7*d*(d*x)^(7/2))]
#= ::Subsubsection::Closed:: =#
#=q*symbolic=#
@test_int [(d*x)^(3/2)*PolyLog(2, a*x^q), x, 4, (8*a*d*q^2*x^(2 + q)*sqrt(d*x)*HypergeometricFunctions._₂F₁(1, (5/2 + q)/q, (1/2)*(4 + 5/q), a*x^q))/(25*(5 + 2*q)) + (4*q*(d*x)^(5/2)*log(1 - a*x^q))/(25*d) + (2*(d*x)^(5/2)*PolyLog(2, a*x^q))/(5*d)]
@test_int [(d*x)^(1/2)*PolyLog(2, a*x^q), x, 4, (8*a*q^2*x^(1 + q)*sqrt(d*x)*HypergeometricFunctions._₂F₁(1, (3/2 + q)/q, (1/2)*(4 + 3/q), a*x^q))/(9*(3 + 2*q)) + (4*q*(d*x)^(3/2)*log(1 - a*x^q))/(9*d) + (2*(d*x)^(3/2)*PolyLog(2, a*x^q))/(3*d)]
@test_int [PolyLog(2, a*x^q)/(d*x)^(1/2), x, 4, (8*a*q^2*x^q*sqrt(d*x)*HypergeometricFunctions._₂F₁(1, (1/2 + q)/q, (1/2)*(4 + 1/q), a*x^q))/(d*(1 + 2*q)) + (4*q*sqrt(d*x)*log(1 - a*x^q))/d + (2*sqrt(d*x)*PolyLog(2, a*x^q))/d]
@test_int [PolyLog(2, a*x^q)/(d*x)^(3/2), x, 4, -((8*a*q^2*x^q*HypergeometricFunctions._₂F₁(1, (1/2)*(2 - 1/q), (1/2)*(4 - 1/q), a*x^q))/(d*(1 - 2*q)*sqrt(d*x))) + (4*q*log(1 - a*x^q))/(d*sqrt(d*x)) - (2*PolyLog(2, a*x^q))/(d*sqrt(d*x))]
@test_int [PolyLog(2, a*x^q)/(d*x)^(5/2), x, 4, -((8*a*q^2*x^(-1 + q)*HypergeometricFunctions._₂F₁(1, (1/2)*(2 - 3/q), (1/2)*(4 - 3/q), a*x^q))/(9*d^2*(3 - 2*q)*sqrt(d*x))) + (4*q*log(1 - a*x^q))/(9*d*(d*x)^(3/2)) - (2*PolyLog(2, a*x^q))/(3*d*(d*x)^(3/2))]
@test_int [(d*x)^(3/2)*PolyLog(3, a*x^q), x, 5, -((16*a*d*q^3*x^(2 + q)*sqrt(d*x)*HypergeometricFunctions._₂F₁(1, (5/2 + q)/q, (1/2)*(4 + 5/q), a*x^q))/(125*(5 + 2*q))) - (8*q^2*(d*x)^(5/2)*log(1 - a*x^q))/(125*d) - (4*q*(d*x)^(5/2)*PolyLog(2, a*x^q))/(25*d) + (2*(d*x)^(5/2)*PolyLog(3, a*x^q))/(5*d)]
@test_int [(d*x)^(1/2)*PolyLog(3, a*x^q), x, 5, -((16*a*q^3*x^(1 + q)*sqrt(d*x)*HypergeometricFunctions._₂F₁(1, (3/2 + q)/q, (1/2)*(4 + 3/q), a*x^q))/(27*(3 + 2*q))) - (8*q^2*(d*x)^(3/2)*log(1 - a*x^q))/(27*d) - (4*q*(d*x)^(3/2)*PolyLog(2, a*x^q))/(9*d) + (2*(d*x)^(3/2)*PolyLog(3, a*x^q))/(3*d)]
@test_int [PolyLog(3, a*x^q)/(d*x)^(1/2), x, 5, -((16*a*q^3*x^q*sqrt(d*x)*HypergeometricFunctions._₂F₁(1, (1/2 + q)/q, (1/2)*(4 + 1/q), a*x^q))/(d*(1 + 2*q))) - (8*q^2*sqrt(d*x)*log(1 - a*x^q))/d - (4*q*sqrt(d*x)*PolyLog(2, a*x^q))/d + (2*sqrt(d*x)*PolyLog(3, a*x^q))/d]
@test_int [PolyLog(3, a*x^q)/(d*x)^(3/2), x, 5, -((16*a*q^3*x^q*HypergeometricFunctions._₂F₁(1, (1/2)*(2 - 1/q), (1/2)*(4 - 1/q), a*x^q))/(d*(1 - 2*q)*sqrt(d*x))) + (8*q^2*log(1 - a*x^q))/(d*sqrt(d*x)) - (4*q*PolyLog(2, a*x^q))/(d*sqrt(d*x)) - (2*PolyLog(3, a*x^q))/(d*sqrt(d*x))]
@test_int [PolyLog(3, a*x^q)/(d*x)^(5/2), x, 5, -((16*a*q^3*x^(-1 + q)*HypergeometricFunctions._₂F₁(1, (1/2)*(2 - 3/q), (1/2)*(4 - 3/q), a*x^q))/(27*d^2*(3 - 2*q)*sqrt(d*x))) + (8*q^2*log(1 - a*x^q))/(27*d*(d*x)^(3/2)) - (4*q*PolyLog(2, a*x^q))/(9*d*(d*x)^(3/2)) - (2*PolyLog(3, a*x^q))/(3*d*(d*x)^(3/2))]
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*x^m*PolyLog(n/2, a*x^q)=#
@test_int [PolyLog(3/2, a*x), x, 2, (-x)*PolyLog(1/2, a*x) + x*PolyLog(3/2, a*x) + Unintegrable(PolyLog(-(1/2), a*x), x)]
@test_int [PolyLog(1/2, a*x), x, 1, x*PolyLog(1/2, a*x) - Unintegrable(PolyLog(-(1/2), a*x), x)]
@test_int [PolyLog(-1/2, a*x), x, 0, Unintegrable(PolyLog(-(1/2), a*x), x)]
@test_int [PolyLog(-3/2, a*x), x, 1, x*PolyLog(-(1/2), a*x) - Unintegrable(PolyLog(-(1/2), a*x), x)]
@test_int [PolyLog(-5/2, a*x), x, 2, x*PolyLog(-(3/2), a*x) - x*PolyLog(-(1/2), a*x) + Unintegrable(PolyLog(-(1/2), a*x), x)]
@test_int [PolyLog(-3/2, a*x) + PolyLog(-1/2, a*x), x, 2, x*PolyLog(-1/2, a*x)]
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*(d*x)^m*PolyLog(n, a*x^q)*with*m*symbolic=#
@test_int [(d*x)^m*PolyLog(2, a*x), x, 3, (a*(d*x)^(2 + m)*HypergeometricFunctions._₂F₁(1, 2 + m, 3 + m, a*x))/(d^2*(1 + m)^2*(2 + m)) + ((d*x)^(1 + m)*log(1 - a*x))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(2, a*x))/(d*(1 + m))]
@test_int [(d*x)^m*PolyLog(3, a*x), x, 4, -((a*(d*x)^(2 + m)*HypergeometricFunctions._₂F₁(1, 2 + m, 3 + m, a*x))/(d^2*(1 + m)^3*(2 + m))) - ((d*x)^(1 + m)*log(1 - a*x))/(d*(1 + m)^3) - ((d*x)^(1 + m)*PolyLog(2, a*x))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(3, a*x))/(d*(1 + m))]
@test_int [(d*x)^m*PolyLog(4, a*x), x, 5, (a*(d*x)^(2 + m)*HypergeometricFunctions._₂F₁(1, 2 + m, 3 + m, a*x))/(d^2*(1 + m)^4*(2 + m)) + ((d*x)^(1 + m)*log(1 - a*x))/(d*(1 + m)^4) + ((d*x)^(1 + m)*PolyLog(2, a*x))/(d*(1 + m)^3) - ((d*x)^(1 + m)*PolyLog(3, a*x))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(4, a*x))/(d*(1 + m))]
@test_int [(d*x)^m*PolyLog(2, a*x^2), x, 4, (4*a*(d*x)^(3 + m)*HypergeometricFunctions._₂F₁(1, (3 + m)/2, (5 + m)/2, a*x^2))/(d^3*(1 + m)^2*(3 + m)) + (2*(d*x)^(1 + m)*log(1 - a*x^2))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(2, a*x^2))/(d*(1 + m))]
@test_int [(d*x)^m*PolyLog(3, a*x^2), x, 5, -((8*a*(d*x)^(3 + m)*HypergeometricFunctions._₂F₁(1, (3 + m)/2, (5 + m)/2, a*x^2))/(d^3*(1 + m)^3*(3 + m))) - (4*(d*x)^(1 + m)*log(1 - a*x^2))/(d*(1 + m)^3) - (2*(d*x)^(1 + m)*PolyLog(2, a*x^2))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(3, a*x^2))/(d*(1 + m))]
@test_int [(d*x)^m*PolyLog(4, a*x^2), x, 6, (16*a*(d*x)^(3 + m)*HypergeometricFunctions._₂F₁(1, (3 + m)/2, (5 + m)/2, a*x^2))/(d^3*(1 + m)^4*(3 + m)) + (8*(d*x)^(1 + m)*log(1 - a*x^2))/(d*(1 + m)^4) + (4*(d*x)^(1 + m)*PolyLog(2, a*x^2))/(d*(1 + m)^3) - (2*(d*x)^(1 + m)*PolyLog(3, a*x^2))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(4, a*x^2))/(d*(1 + m))]
@test_int [(d*x)^m*PolyLog(2, a*x^3), x, 4, (9*a*(d*x)^(4 + m)*HypergeometricFunctions._₂F₁(1, (4 + m)/3, (7 + m)/3, a*x^3))/(d^4*(1 + m)^2*(4 + m)) + (3*(d*x)^(1 + m)*log(1 - a*x^3))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(2, a*x^3))/(d*(1 + m))]
@test_int [(d*x)^m*PolyLog(3, a*x^3), x, 5, -((27*a*(d*x)^(4 + m)*HypergeometricFunctions._₂F₁(1, (4 + m)/3, (7 + m)/3, a*x^3))/(d^4*(1 + m)^3*(4 + m))) - (9*(d*x)^(1 + m)*log(1 - a*x^3))/(d*(1 + m)^3) - (3*(d*x)^(1 + m)*PolyLog(2, a*x^3))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(3, a*x^3))/(d*(1 + m))]
@test_int [(d*x)^m*PolyLog(4, a*x^3), x, 6, (81*a*(d*x)^(4 + m)*HypergeometricFunctions._₂F₁(1, (4 + m)/3, (7 + m)/3, a*x^3))/(d^4*(1 + m)^4*(4 + m)) + (27*(d*x)^(1 + m)*log(1 - a*x^3))/(d*(1 + m)^4) + (9*(d*x)^(1 + m)*PolyLog(2, a*x^3))/(d*(1 + m)^3) - (3*(d*x)^(1 + m)*PolyLog(3, a*x^3))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(4, a*x^3))/(d*(1 + m))]
@test_int [(d*x)^m*PolyLog(2, a*x^q), x, 4, (a*q^2*x^(1 + q)*(d*x)^m*HypergeometricFunctions._₂F₁(1, (1 + m + q)/q, (1 + m + 2*q)/q, a*x^q))/((1 + m)^2*(1 + m + q)) + (q*(d*x)^(1 + m)*log(1 - a*x^q))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(2, a*x^q))/(d*(1 + m))]
@test_int [(d*x)^m*PolyLog(3, a*x^q), x, 5, -((a*q^3*x^(1 + q)*(d*x)^m*HypergeometricFunctions._₂F₁(1, (1 + m + q)/q, (1 + m + 2*q)/q, a*x^q))/((1 + m)^3*(1 + m + q))) - (q^2*(d*x)^(1 + m)*log(1 - a*x^q))/(d*(1 + m)^3) - (q*(d*x)^(1 + m)*PolyLog(2, a*x^q))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(3, a*x^q))/(d*(1 + m))]
@test_int [(d*x)^m*PolyLog(4, a*x^q), x, 6, (a*q^4*x^(1 + q)*(d*x)^m*HypergeometricFunctions._₂F₁(1, (1 + m + q)/q, (1 + m + 2*q)/q, a*x^q))/((1 + m)^4*(1 + m + q)) + (q^3*(d*x)^(1 + m)*log(1 - a*x^q))/(d*(1 + m)^4) + (q^2*(d*x)^(1 + m)*PolyLog(2, a*x^q))/(d*(1 + m)^3) - (q*(d*x)^(1 + m)*PolyLog(3, a*x^q))/(d*(1 + m)^2) + ((d*x)^(1 + m)*PolyLog(4, a*x^q))/(d*(1 + m))]
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*(d*x)^m*PolyLog(n, a*x^q)*with*n*symbolic=#
@test_int [x^1*PolyLog(n, a*x), x, 0, Unintegrable(x*PolyLog(n, a*x), x)]
@test_int [x^0*PolyLog(n, a*x), x, 0, Unintegrable(PolyLog(n, a*x), x)]
@test_int [PolyLog(n, a*x)/x^1, x, 1, PolyLog(1 + n, a*x)]
@test_int [PolyLog(n, a*x)/x^2, x, 0, Unintegrable(PolyLog(n, a*x)/x^2, x)]
@test_int [PolyLog(n, a*x)/x^3, x, 0, Unintegrable(PolyLog(n, a*x)/x^3, x)]
@test_int [x^1*PolyLog(n, a*x^q), x, 0, Unintegrable(x*PolyLog(n, a*x^q), x)]
@test_int [x^0*PolyLog(n, a*x^q), x, 0, Unintegrable(PolyLog(n, a*x^q), x)]
@test_int [PolyLog(n, a*x^q)/x^1, x, 1, PolyLog(1 + n, a*x^q)/q]
@test_int [PolyLog(n, a*x^q)/x^2, x, 0, Unintegrable(PolyLog(n, a*x^q)/x^2, x)]
@test_int [PolyLog(n, a*x^q)/x^3, x, 0, Unintegrable(PolyLog(n, a*x^q)/x^3, x)]
#= ::Section::Closed:: =#
#=Integrands*of*the*form*(d*x)^m*PolyLog(n, c*(a+b*x))=#
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*x^m*PolyLog(n, c*(a+b*x))=#
@test_int [x^2*PolyLog(2, c*(a + b*x)), x, 13, -((a^2*x)/(3*b^2)) + (a*(1 - a*c)*x)/(6*b^2*c) - ((1 - a*c)^2*x)/(9*b^2*c^2) + (a*x^2)/(12*b) - ((1 - a*c)*x^2)/(18*b*c) - x^3/27 + (a*(1 - a*c)^2*log(1 - a*c - b*c*x))/(6*b^3*c^2) - ((1 - a*c)^3*log(1 - a*c - b*c*x))/(9*b^3*c^3) - (a*x^2*log(1 - a*c - b*c*x))/(6*b) + (1/9)*x^3*log(1 - a*c - b*c*x) - (a^2*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(3*b^3*c) + (a^3*PolyLog(2, c*(a + b*x)))/(3*b^3) + (1/3)*x^3*PolyLog(2, c*(a + b*x))]
@test_int [x^1*PolyLog(2, c*(a + b*x)), x, 10, (a*x)/(2*b) - ((1 - a*c)*x)/(4*b*c) - x^2/8 - ((1 - a*c)^2*log(1 - a*c - b*c*x))/(4*b^2*c^2) + (1/4)*x^2*log(1 - a*c - b*c*x) + (a*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(2*b^2*c) - (a^2*PolyLog(2, c*(a + b*x)))/(2*b^2) + (1/2)*x^2*PolyLog(2, c*(a + b*x))]
@test_int [x^0*PolyLog(2, c*(a + b*x)), x, 7, -x - ((1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(b*c) + (a*PolyLog(2, c*(a + b*x)))/b + x*PolyLog(2, c*(a + b*x))]
@test_int [PolyLog(2, c*(a + b*x))/x^1, x, 3, log(x)*log(1 + (b*x)/a)*log(1 - c*(a + b*x)) + (1/2)*(log(1 + (b*x)/a) + log((1 - a*c)/(1 - c*(a + b*x))) - log(((1 - a*c)*(a + b*x))/(a*(1 - c*(a + b*x)))))*log(-((a*(1 - c*(a + b*x)))/(b*x)))^2 + (1/2)*(log(c*(a + b*x)) - log(1 + (b*x)/a))*(log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))^2 + (log(1 - c*(a + b*x)) - log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, -((b*x)/a)) + log(x)*PolyLog(2, c*(a + b*x)) + log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*x)/(a*(1 - c*(a + b*x))))) - log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*c*x)/(1 - c*(a + b*x)))) + (log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, 1 - c*(a + b*x)) - PolyLog(3, -((b*x)/a)) + PolyLog(3, -((b*x)/(a*(1 - c*(a + b*x))))) - PolyLog(3, -((b*c*x)/(1 - c*(a + b*x)))) - PolyLog(3, 1 - c*(a + b*x))]
@test_int [PolyLog(2, c*(a + b*x))/x^2, x, 7, -((b*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x))/a) - (b*PolyLog(2, c*(a + b*x)))/a - PolyLog(2, c*(a + b*x))/x - (b*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/a]
@test_int [PolyLog(2, c*(a + b*x))/x^3, x, 11, (b^2*c*log(x))/(2*a*(1 - a*c)) - (b^2*c*log(1 - a*c - b*c*x))/(2*a*(1 - a*c)) + (b*log(1 - a*c - b*c*x))/(2*a*x) + (b^2*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x))/(2*a^2) + (b^2*PolyLog(2, c*(a + b*x)))/(2*a^2) - PolyLog(2, c*(a + b*x))/(2*x^2) + (b^2*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(2*a^2)]
@test_int [PolyLog(2, c*(a + b*x))/x^4, x, 14, -((b^2*c)/(6*a*(1 - a*c)*x)) + (b^3*c^2*log(x))/(6*a*(1 - a*c)^2) - (b^3*c*log(x))/(3*a^2*(1 - a*c)) - (b^3*c^2*log(1 - a*c - b*c*x))/(6*a*(1 - a*c)^2) + (b^3*c*log(1 - a*c - b*c*x))/(3*a^2*(1 - a*c)) + (b*log(1 - a*c - b*c*x))/(6*a*x^2) - (b^2*log(1 - a*c - b*c*x))/(3*a^2*x) - (b^3*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x))/(3*a^3) - (b^3*PolyLog(2, c*(a + b*x)))/(3*a^3) - PolyLog(2, c*(a + b*x))/(3*x^3) - (b^3*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(3*a^3)]
@test_int [x^2*PolyLog(3, c*(a + b*x)), x, 33, (11*a^2*x)/(18*b^2) - (5*a*(1 - a*c)*x)/(36*b^2*c) + ((1 - a*c)^2*x)/(27*b^2*c^2) - (5*a*x^2)/(72*b) + ((1 - a*c)*x^2)/(54*b*c) + x^3/81 - (5*a*(1 - a*c)^2*log(1 - a*c - b*c*x))/(36*b^3*c^2) + ((1 - a*c)^3*log(1 - a*c - b*c*x))/(27*b^3*c^3) + (5*a*x^2*log(1 - a*c - b*c*x))/(36*b) - (1/27)*x^3*log(1 - a*c - b*c*x) + (11*a^2*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(18*b^3*c) - (11*a^3*PolyLog(2, c*(a + b*x)))/(18*b^3) - (a^2*x*PolyLog(2, c*(a + b*x)))/(3*b^2) + (a*x^2*PolyLog(2, c*(a + b*x)))/(6*b) - (1/9)*x^3*PolyLog(2, c*(a + b*x)) + (2*a^3*PolyLog(3, c*(a + b*x)))/(3*b^3) - ((a^3 - b^3*x^3)*PolyLog(3, c*(a + b*x)))/(3*b^3)]
@test_int [x^1*PolyLog(3, c*(a + b*x)), x, 19, -((3*a*x)/(4*b)) + ((1 - a*c)*x)/(8*b*c) + x^2/16 + ((1 - a*c)^2*log(1 - a*c - b*c*x))/(8*b^2*c^2) - (1/8)*x^2*log(1 - a*c - b*c*x) - (3*a*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(4*b^2*c) + (3*a^2*PolyLog(2, c*(a + b*x)))/(4*b^2) + (a*x*PolyLog(2, c*(a + b*x)))/(2*b) - (1/4)*x^2*PolyLog(2, c*(a + b*x)) - ((a^2 - b^2*x^2)*PolyLog(3, c*(a + b*x)))/(2*b^2)]
@test_int [x^0*PolyLog(3, c*(a + b*x)), x, 9, x + ((1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(b*c) - (a*PolyLog(2, c*(a + b*x)))/b - x*PolyLog(2, c*(a + b*x)) + (a*PolyLog(3, c*(a + b*x)))/b + x*PolyLog(3, c*(a + b*x))]
@test_int [PolyLog(3, c*(a + b*x))/x^1, x, 1, Int(PolyLog(3, a*c + b*c*x)/x, x)]
@test_int [PolyLog(3, c*(a + b*x))/x^2, x, 6, (b*log(x)*log(1 + (b*x)/a)*log(1 - c*(a + b*x)))/a + (b*(log(1 + (b*x)/a) + log((1 - a*c)/(1 - c*(a + b*x))) - log(((1 - a*c)*(a + b*x))/(a*(1 - c*(a + b*x)))))*log(-((a*(1 - c*(a + b*x)))/(b*x)))^2)/(2*a) + (b*(log(c*(a + b*x)) - log(1 + (b*x)/a))*(log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))^2)/(2*a) + (b*(log(1 - c*(a + b*x)) - log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, -((b*x)/a)))/a + (b*log(x)*PolyLog(2, c*(a + b*x)))/a + (b*log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*x)/(a*(1 - c*(a + b*x))))))/a - (b*log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*c*x)/(1 - c*(a + b*x)))))/a + (b*(log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, 1 - c*(a + b*x)))/a - (b*PolyLog(3, -((b*x)/a)))/a - (2*b*PolyLog(3, c*(a + b*x)))/a + ((b - a/x)*PolyLog(3, c*(a + b*x)))/a + (b*PolyLog(3, -((b*x)/(a*(1 - c*(a + b*x))))))/a - (b*PolyLog(3, -((b*c*x)/(1 - c*(a + b*x)))))/a - (b*PolyLog(3, 1 - c*(a + b*x)))/a]
@test_int [PolyLog(3, c*(a + b*x))/x^3, x, 12, -((b^2*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x))/(2*a^2)) - (b^2*log(x)*log(1 + (b*x)/a)*log(1 - c*(a + b*x)))/(2*a^2) - (b^2*(log(1 + (b*x)/a) + log((1 - a*c)/(1 - c*(a + b*x))) - log(((1 - a*c)*(a + b*x))/(a*(1 - c*(a + b*x)))))*log(-((a*(1 - c*(a + b*x)))/(b*x)))^2)/(4*a^2) - (b^2*(log(c*(a + b*x)) - log(1 + (b*x)/a))*(log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))^2)/(4*a^2) - (b^2*(log(1 - c*(a + b*x)) - log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, -((b*x)/a)))/(2*a^2) - (b^2*PolyLog(2, c*(a + b*x)))/(2*a^2) - (b*PolyLog(2, c*(a + b*x)))/(2*a*x) - (b^2*log(x)*PolyLog(2, c*(a + b*x)))/(2*a^2) - (b^2*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(2*a^2) - (b^2*log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*x)/(a*(1 - c*(a + b*x))))))/(2*a^2) + (b^2*log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*c*x)/(1 - c*(a + b*x)))))/(2*a^2) - (b^2*(log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, 1 - c*(a + b*x)))/(2*a^2) + (b^2*PolyLog(3, -((b*x)/a)))/(2*a^2) + ((b^2 - a^2/x^2)*PolyLog(3, c*(a + b*x)))/(2*a^2) - (b^2*PolyLog(3, -((b*x)/(a*(1 - c*(a + b*x))))))/(2*a^2) + (b^2*PolyLog(3, -((b*c*x)/(1 - c*(a + b*x)))))/(2*a^2) + (b^2*PolyLog(3, 1 - c*(a + b*x)))/(2*a^2)]
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*(d+e*x)^m*PolyLog(n,c*(a+b*x))=#
@test_int [PolyLog(2, c*(a + b*x))*(d + e*x)^3, x, 16, -(((b*d - a*e)^3*x)/(4*b^3)) - ((b*d - a*e)^2*(b*c*d + e - a*c*e)*x)/(8*b^3*c) - ((b*d - a*e)*(b*c*d + e - a*c*e)^2*x)/(12*b^3*c^2) - ((b*c*d + e - a*c*e)^3*x)/(16*b^3*c^3) - ((b*d - a*e)^2*(d + e*x)^2)/(16*b^2*e) - ((b*d - a*e)*(b*c*d + e - a*c*e)*(d + e*x)^2)/(24*b^2*c*e) - ((b*c*d + e - a*c*e)^2*(d + e*x)^2)/(32*b^2*c^2*e) - ((b*d - a*e)*(d + e*x)^3)/(36*b*e) - ((b*c*d + e - a*c*e)*(d + e*x)^3)/(48*b*c*e) - (d + e*x)^4/(64*e) - ((b*d - a*e)^2*(b*c*d + e - a*c*e)^2*log(1 - a*c - b*c*x))/(8*b^4*c^2*e) - ((b*d - a*e)*(b*c*d + e - a*c*e)^3*log(1 - a*c - b*c*x))/(12*b^4*c^3*e) - ((b*c*d + e - a*c*e)^4*log(1 - a*c - b*c*x))/(16*b^4*c^4*e) - ((b*d - a*e)^3*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(4*b^4*c) + ((b*d - a*e)^2*(d + e*x)^2*log(1 - a*c - b*c*x))/(8*b^2*e) + ((b*d - a*e)*(d + e*x)^3*log(1 - a*c - b*c*x))/(12*b*e) + ((d + e*x)^4*log(1 - a*c - b*c*x))/(16*e) - ((b*d - a*e)^4*PolyLog(2, c*(a + b*x)))/(4*b^4*e) + ((d + e*x)^4*PolyLog(2, c*(a + b*x)))/(4*e)]
@test_int [PolyLog(2, c*(a + b*x))*(d + e*x)^2, x, 13, -(((b*d - a*e)^2*x)/(3*b^2)) - ((b*d - a*e)*(b*c*d + e - a*c*e)*x)/(6*b^2*c) - ((b*c*d + e - a*c*e)^2*x)/(9*b^2*c^2) - ((b*d - a*e)*(d + e*x)^2)/(12*b*e) - ((b*c*d + e - a*c*e)*(d + e*x)^2)/(18*b*c*e) - (d + e*x)^3/(27*e) - ((b*d - a*e)*(b*c*d + e - a*c*e)^2*log(1 - a*c - b*c*x))/(6*b^3*c^2*e) - ((b*c*d + e - a*c*e)^3*log(1 - a*c - b*c*x))/(9*b^3*c^3*e) - ((b*d - a*e)^2*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(3*b^3*c) + ((b*d - a*e)*(d + e*x)^2*log(1 - a*c - b*c*x))/(6*b*e) + ((d + e*x)^3*log(1 - a*c - b*c*x))/(9*e) - ((b*d - a*e)^3*PolyLog(2, c*(a + b*x)))/(3*b^3*e) + ((d + e*x)^3*PolyLog(2, c*(a + b*x)))/(3*e)]
@test_int [PolyLog(2, c*(a + b*x))*(d + e*x)^1, x, 10, -(((b*d - a*e)*x)/(2*b)) - ((b*c*d + e - a*c*e)*x)/(4*b*c) - (d + e*x)^2/(8*e) - ((b*c*d + e - a*c*e)^2*log(1 - a*c - b*c*x))/(4*b^2*c^2*e) - ((b*d - a*e)*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(2*b^2*c) + ((d + e*x)^2*log(1 - a*c - b*c*x))/(4*e) - ((b*d - a*e)^2*PolyLog(2, c*(a + b*x)))/(2*b^2*e) + ((d + e*x)^2*PolyLog(2, c*(a + b*x)))/(2*e)]
@test_int [PolyLog(2, c*(a + b*x))*(d + e*x)^0, x, 7, -x - ((1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(b*c) + (a*PolyLog(2, c*(a + b*x)))/b + x*PolyLog(2, c*(a + b*x))]
@test_int [PolyLog(2, c*(a + b*x))/(d + e*x)^1, x, 3, ((log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(2*e) + (log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/e - ((log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(2*e) + (log(d + e*x)*PolyLog(2, c*(a + b*x)))/e + ((log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/e + ((log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/e - (log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/e + (log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/e - PolyLog(3, (b*(d + e*x))/(b*d - a*e))/e - PolyLog(3, 1 - c*(a + b*x))/e - PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x))))/e + PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x)))/e]
@test_int [PolyLog(2, c*(a + b*x))/(d + e*x)^2, x, 8, (b*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(e*(b*d - a*e)) + (b*PolyLog(2, c*(a + b*x)))/(e*(b*d - a*e)) - PolyLog(2, c*(a + b*x))/(e*(d + e*x)) + (b*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/(e*(b*d - a*e))]
@test_int [PolyLog(2, c*(a + b*x))/(d + e*x)^3, x, 12, (b^2*c*log(1 - a*c - b*c*x))/(2*e*(b*d - a*e)*(b*c*d + e - a*c*e)) - (b*log(1 - a*c - b*c*x))/(2*e*(b*d - a*e)*(d + e*x)) - (b^2*c*log(d + e*x))/(2*e*(b*d - a*e)*(b*c*d + e - a*c*e)) + (b^2*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(2*e*(b*d - a*e)^2) + (b^2*PolyLog(2, c*(a + b*x)))/(2*e*(b*d - a*e)^2) - PolyLog(2, c*(a + b*x))/(2*e*(d + e*x)^2) + (b^2*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/(2*e*(b*d - a*e)^2)]
@test_int [PolyLog(2, c*(a + b*x))/(d + e*x)^4, x, 15, (b^2*c)/(6*e*(b*d - a*e)*(b*c*d + e - a*c*e)*(d + e*x)) + (b^3*c^2*log(1 - a*c - b*c*x))/(6*e*(b*d - a*e)*(b*c*d + e - a*c*e)^2) + (b^3*c*log(1 - a*c - b*c*x))/(3*e*(b*d - a*e)^2*(b*c*d + e - a*c*e)) - (b*log(1 - a*c - b*c*x))/(6*e*(b*d - a*e)*(d + e*x)^2) - (b^2*log(1 - a*c - b*c*x))/(3*e*(b*d - a*e)^2*(d + e*x)) - (b^3*c^2*log(d + e*x))/(6*e*(b*d - a*e)*(b*c*d + e - a*c*e)^2) - (b^3*c*log(d + e*x))/(3*e*(b*d - a*e)^2*(b*c*d + e - a*c*e)) + (b^3*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(3*e*(b*d - a*e)^3) + (b^3*PolyLog(2, c*(a + b*x)))/(3*e*(b*d - a*e)^3) - PolyLog(2, c*(a + b*x))/(3*e*(d + e*x)^3) + (b^3*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/(3*e*(b*d - a*e)^3)]
#= Following*integrands*are*equal. =#
@test_int [PolyLog(2, x)/(-1 + x), x, 5, log(1-x)^2*log(x)+2*log(1-x)*PolyLog(2,1-x)+log(1-x)*PolyLog(2,x)-2*PolyLog(3,1-x)]
@test_int [-PolyLog(2, x)/(1 - x), x, 5, log(1-x)^2*log(x)+2*log(1-x)*PolyLog(2,1-x)+log(1-x)*PolyLog(2,x)-2*PolyLog(3,1-x)]
@test_int [PolyLog(2, x)/((-1 + x)*x), x, 8, log(1-x)^2*log(x)+2*log(1-x)*PolyLog(2,1-x)+log(1-x)*PolyLog(2,x)-2*PolyLog(3,1-x)-PolyLog(3,x)]
@test_int [-PolyLog(2, x)/((1 - x)*x), x, 8, log(1-x)^2*log(x)+2*log(1-x)*PolyLog(2,1-x)+log(1-x)*PolyLog(2,x)-2*PolyLog(3,1-x)-PolyLog(3,x)]
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*PolyLog(n, e*((a + b*x) / (c + d*x))^n) / ((a + b*x)*(c + d*x))=#
@test_int [PolyLog(n, e*((a + b*x)/(c + d*x))^n)/((a + b*x)*(c + d*x)), x, 1, PolyLog(1 + n, e*((a + b*x)/(c + d*x))^n)/((b*c - a*d)*n)]
@test_int [PolyLog(3, e*((a + b*x)/(c + d*x))^n)/((a + b*x)*(c + d*x)), x, 1, PolyLog(4, e*((a + b*x)/(c + d*x))^n)/(n*(b*c - a*d))]
@test_int [PolyLog(2, e*((a + b*x)/(c + d*x))^n)/((a + b*x)*(c + d*x)), x, 1, PolyLog(3, e*((a + b*x)/(c + d*x))^n)/(n*(b*c - a*d))]
@test_int [PolyLog(1, e*((a + b*x)/(c + d*x))^n)/((a + b*x)*(c + d*x)), x, 1, PolyLog(2, e*((a + b*x)/(c + d*x))^n)/(n*(b*c - a*d))]
@test_int [PolyLog(0, e*((a + b*x)/(c + d*x))^n)/((a + b*x)*(c + d*x)), x, 2, PolyLog(1, e*((a + b*x)/(c + d*x))^n)/(n*(b*c - a*d))]
@test_int [PolyLog(-1, e*((a + b*x)/(c + d*x))^n)/((a + b*x)*(c + d*x)), x, 2, 1/((b*c - a*d)*n*(1 - e*((a + b*x)/(c + d*x))^n))]
@test_int [PolyLog(-2, e*((a + b*x)/(c + d*x))^n)/((a + b*x)*(c + d*x)), x, 4, PolyLog(-1, e*((a + b*x)/(c + d*x))^n)/(n*(b*c - a*d))]
#= ::Section::Closed:: =#
#=Integrands*of*the*form*(d*x)^m*PolyLog(n, d*(F^(c*(a + b*x)))^p)=#
@test_int [x^3*PolyLog(n, d*(F^(c*(a + b*x)))^p), x, 5, (x^3*PolyLog(1 + n, d*(F^(c*(a + b*x)))^p))/(b*c*p*log(F)) - (3*x^2*PolyLog(2 + n, d*(F^(c*(a + b*x)))^p))/(b^2*c^2*p^2*log(F)^2) + (6*x*PolyLog(3 + n, d*(F^(c*(a + b*x)))^p))/(b^3*c^3*p^3*log(F)^3) - (6*PolyLog(4 + n, d*(F^(c*(a + b*x)))^p))/(b^4*c^4*p^4*log(F)^4)]
@test_int [x^2*PolyLog(n, d*(F^(c*(a + b*x)))^p), x, 4, (x^2*PolyLog(1 + n, d*(F^(c*(a + b*x)))^p))/(b*c*p*log(F)) - (2*x*PolyLog(2 + n, d*(F^(c*(a + b*x)))^p))/(b^2*c^2*p^2*log(F)^2) + (2*PolyLog(3 + n, d*(F^(c*(a + b*x)))^p))/(b^3*c^3*p^3*log(F)^3)]
@test_int [x^1*PolyLog(n, d*(F^(c*(a + b*x)))^p), x, 3, (x*PolyLog(1 + n, d*(F^(c*(a + b*x)))^p))/(b*c*p*log(F)) - PolyLog(2 + n, d*(F^(c*(a + b*x)))^p)/(b^2*c^2*p^2*log(F)^2)]
@test_int [x^0*PolyLog(n, d*(F^(c*(a + b*x)))^p), x, 2, PolyLog(1 + n, d*(F^(c*(a + b*x)))^p)/(b*c*p*log(F))]
@test_int [PolyLog(n, d*(F^(c*(a + b*x)))^p)/x^1, x, 1, CannotIntegrate(PolyLog(n, d*(F^(a*c + b*c*x))^p)/x, x)]
#= ::Section::Closed:: =#
#=Integrands*of*the*form*(d*x)^m*P(x)*(g+h*log(f*(d+e*x)^n))*PolyLog(2, c*(a+b*x))=#
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*x^m*log(1-c*x)*PolyLog(2, c*x)=#
@test_int [x^3*log(1 - c*x)*PolyLog(2, c*x), x, 38, (355*x)/(576*c^3) + (139*x^2)/(1152*c^2) + (67*x^3)/(1728*c) + (3*x^4)/256 + (139*log(1 - c*x))/(576*c^4) - (x^2*log(1 - c*x))/(8*c^2) - (5*x^3*log(1 - c*x))/(72*c) - (3/64)*x^4*log(1 - c*x) + (3*(1 - c*x)*log(1 - c*x))/(8*c^4) - log(1 - c*x)^2/(16*c^4) + (1/16)*x^4*log(1 - c*x)^2 - (log(c*x)*log(1 - c*x)^2)/(4*c^4) - (x*PolyLog(2, c*x))/(4*c^3) - (x^2*PolyLog(2, c*x))/(8*c^2) - (x^3*PolyLog(2, c*x))/(12*c) - (1/16)*x^4*PolyLog(2, c*x) - (log(1 - c*x)*PolyLog(2, c*x))/(4*c^4) + (1/4)*x^4*log(1 - c*x)*PolyLog(2, c*x) - (log(1 - c*x)*PolyLog(2, 1 - c*x))/(2*c^4) + PolyLog(3, 1 - c*x)/(2*c^4)]
@test_int [x^2*log(1 - c*x)*PolyLog(2, c*x), x, 31, (31*x)/(36*c^2) + (11*x^2)/(72*c) + x^3/27 + (11*log(1 - c*x))/(36*c^3) - (7*x^2*log(1 - c*x))/(36*c) - (1/9)*x^3*log(1 - c*x) + (5*(1 - c*x)*log(1 - c*x))/(9*c^3) - log(1 - c*x)^2/(9*c^3) + (1/9)*x^3*log(1 - c*x)^2 - (log(c*x)*log(1 - c*x)^2)/(3*c^3) - (x*PolyLog(2, c*x))/(3*c^2) - (x^2*PolyLog(2, c*x))/(6*c) - (1/9)*x^3*PolyLog(2, c*x) - (log(1 - c*x)*PolyLog(2, c*x))/(3*c^3) + (1/3)*x^3*log(1 - c*x)*PolyLog(2, c*x) - (2*log(1 - c*x)*PolyLog(2, 1 - c*x))/(3*c^3) + (2*PolyLog(3, 1 - c*x))/(3*c^3)]
@test_int [x^1*log(1 - c*x)*PolyLog(2, c*x), x, 22, (13*x)/(8*c) + x^2/16 + (1 - c*x)^2/(8*c^2) + log(1 - c*x)/(8*c^2) - (1/8)*x^2*log(1 - c*x) + (3*(1 - c*x)*log(1 - c*x))/(2*c^2) - ((1 - c*x)^2*log(1 - c*x))/(4*c^2) - ((1 - c*x)*log(1 - c*x)^2)/(2*c^2) + ((1 - c*x)^2*log(1 - c*x)^2)/(4*c^2) - (log(c*x)*log(1 - c*x)^2)/(2*c^2) - (x*PolyLog(2, c*x))/(2*c) - (1/4)*x^2*PolyLog(2, c*x) - (log(1 - c*x)*PolyLog(2, c*x))/(2*c^2) + (1/2)*x^2*log(1 - c*x)*PolyLog(2, c*x) - (log(1 - c*x)*PolyLog(2, 1 - c*x))/c^2 + PolyLog(3, 1 - c*x)/c^2]
@test_int [x^0*log(1 - c*x)*PolyLog(2, c*x), x, 15, 3*x + (3*(1 - c*x)*log(1 - c*x))/c - ((1 - c*x)*log(1 - c*x)^2)/c - (log(c*x)*log(1 - c*x)^2)/c - x*PolyLog(2, c*x) - (log(1 - c*x)*PolyLog(2, c*x))/c + x*log(1 - c*x)*PolyLog(2, c*x) - (2*log(1 - c*x)*PolyLog(2, 1 - c*x))/c + (2*PolyLog(3, 1 - c*x))/c]
@test_int [log(1 - c*x)*PolyLog(2, c*x)/x^1, x, 1, (-(1/2))*PolyLog(2, c*x)^2]
@test_int [log(1 - c*x)*PolyLog(2, c*x)/x^2, x, 10, ((1 - c*x)*log(1 - c*x)^2)/x + c*log(c*x)*log(1 - c*x)^2 - 2*c*PolyLog(2, c*x) + c*log(1 - c*x)*PolyLog(2, c*x) - (log(1 - c*x)*PolyLog(2, c*x))/x + 2*c*log(1 - c*x)*PolyLog(2, 1 - c*x) - c*PolyLog(3, c*x) - 2*c*PolyLog(3, 1 - c*x)]
@test_int [log(1 - c*x)*PolyLog(2, c*x)/x^3, x, 23, (-c^2)*log(x) + c^2*log(1 - c*x) - (c*log(1 - c*x))/x - (1/4)*c^2*log(1 - c*x)^2 + log(1 - c*x)^2/(4*x^2) + (1/2)*c^2*log(c*x)*log(1 - c*x)^2 - (1/2)*c^2*PolyLog(2, c*x) + (c*PolyLog(2, c*x))/(2*x) + (1/2)*c^2*log(1 - c*x)*PolyLog(2, c*x) - (log(1 - c*x)*PolyLog(2, c*x))/(2*x^2) + c^2*log(1 - c*x)*PolyLog(2, 1 - c*x) - (1/2)*c^2*PolyLog(3, c*x) - c^2*PolyLog(3, 1 - c*x)]
@test_int [log(1 - c*x)*PolyLog(2, c*x)/x^4, x, 30, (7*c^2)/(36*x) - (3/4)*c^3*log(x) + (3/4)*c^3*log(1 - c*x) - (7*c*log(1 - c*x))/(36*x^2) - (5*c^2*log(1 - c*x))/(9*x) - (1/9)*c^3*log(1 - c*x)^2 + log(1 - c*x)^2/(9*x^3) + (1/3)*c^3*log(c*x)*log(1 - c*x)^2 - (2/9)*c^3*PolyLog(2, c*x) + (c*PolyLog(2, c*x))/(6*x^2) + (c^2*PolyLog(2, c*x))/(3*x) + (1/3)*c^3*log(1 - c*x)*PolyLog(2, c*x) - (log(1 - c*x)*PolyLog(2, c*x))/(3*x^3) + (2/3)*c^3*log(1 - c*x)*PolyLog(2, 1 - c*x) - (1/3)*c^3*PolyLog(3, c*x) - (2/3)*c^3*PolyLog(3, 1 - c*x)]
@test_int [log(1 - c*x)*PolyLog(2, c*x)/x^5, x, 37, (5*c^2)/(144*x^2) + (7*c^3)/(36*x) - (41/72)*c^4*log(x) + (41/72)*c^4*log(1 - c*x) - (5*c*log(1 - c*x))/(72*x^3) - (c^2*log(1 - c*x))/(8*x^2) - (3*c^3*log(1 - c*x))/(8*x) - (1/16)*c^4*log(1 - c*x)^2 + log(1 - c*x)^2/(16*x^4) + (1/4)*c^4*log(c*x)*log(1 - c*x)^2 - (1/8)*c^4*PolyLog(2, c*x) + (c*PolyLog(2, c*x))/(12*x^3) + (c^2*PolyLog(2, c*x))/(8*x^2) + (c^3*PolyLog(2, c*x))/(4*x) + (1/4)*c^4*log(1 - c*x)*PolyLog(2, c*x) - (log(1 - c*x)*PolyLog(2, c*x))/(4*x^4) + (1/2)*c^4*log(1 - c*x)*PolyLog(2, 1 - c*x) - (1/4)*c^4*PolyLog(3, c*x) - (1/2)*c^4*PolyLog(3, 1 - c*x)]
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*x^m*(g+h*log(1-c*x))*PolyLog(2, c*x)=#
@test_int [x^2*(g + h*log(1 - c*x))*PolyLog(2, c*x), x, 25, (121*h*x)/(108*c^2) + (13*h*x^2)/(216*c) + (h*x^3)/81 + (h*(1 - c*x)^2)/(6*c^3) - (2*h*(1 - c*x)^3)/(81*c^3) + (13*h*log(1 - c*x))/(108*c^3) - (h*x^2*log(1 - c*x))/(12*c) - (1/27)*h*x^3*log(1 - c*x) + (h*(1 - c*x)*log(1 - c*x))/(3*c^3) + (h*log(1 - c*x)^2)/(9*c^3) - (h*log(c*x)*log(1 - c*x)^2)/(3*c^3) + (1/9)*x^3*log(1 - c*x)*(g + h*log(1 - c*x)) + ((1 - c*x)*(g + 2*h*log(1 - c*x)))/(3*c^3) - ((1 - c*x)^2*(g + 2*h*log(1 - c*x)))/(6*c^3) + ((1 - c*x)^3*(g + 2*h*log(1 - c*x)))/(27*c^3) - (log(1 - c*x)*(g + 2*h*log(1 - c*x)))/(9*c^3) - (h*x*PolyLog(2, c*x))/(3*c^2) - (h*x^2*PolyLog(2, c*x))/(6*c) - (1/9)*h*x^3*PolyLog(2, c*x) - (h*log(1 - c*x)*PolyLog(2, c*x))/(3*c^3) + (1/3)*x^3*(g + h*log(1 - c*x))*PolyLog(2, c*x) - (2*h*log(1 - c*x)*PolyLog(2, 1 - c*x))/(3*c^3) + (2*h*PolyLog(3, 1 - c*x))/(3*c^3)]
@test_int [x^1*(g + h*log(1 - c*x))*PolyLog(2, c*x), x, 21, (13*h*x)/(8*c) + (h*x^2)/16 + (h*(1 - c*x)^2)/(8*c^2) + (h*log(1 - c*x))/(8*c^2) - (1/8)*h*x^2*log(1 - c*x) + (h*(1 - c*x)*log(1 - c*x))/(2*c^2) + (h*log(1 - c*x)^2)/(4*c^2) - (h*log(c*x)*log(1 - c*x)^2)/(2*c^2) + (1/4)*x^2*log(1 - c*x)*(g + h*log(1 - c*x)) + ((1 - c*x)*(g + 2*h*log(1 - c*x)))/(2*c^2) - ((1 - c*x)^2*(g + 2*h*log(1 - c*x)))/(8*c^2) - (log(1 - c*x)*(g + 2*h*log(1 - c*x)))/(4*c^2) - (h*x*PolyLog(2, c*x))/(2*c) - (1/4)*h*x^2*PolyLog(2, c*x) - (h*log(1 - c*x)*PolyLog(2, c*x))/(2*c^2) + (1/2)*x^2*(g + h*log(1 - c*x))*PolyLog(2, c*x) - (h*log(1 - c*x)*PolyLog(2, 1 - c*x))/c^2 + (h*PolyLog(3, 1 - c*x))/c^2]
@test_int [x^0*(g + h*log(1 - c*x))*PolyLog(2, c*x), x, 18, (-g)*x + 3*h*x - (g*(1 - c*x)*log(1 - c*x))/c + (3*h*(1 - c*x)*log(1 - c*x))/c - (h*(1 - c*x)*log(1 - c*x)^2)/c - (h*log(c*x)*log(1 - c*x)^2)/c - h*x*PolyLog(2, c*x) - (h*log(1 - c*x)*PolyLog(2, c*x))/c + x*(g + h*log(1 - c*x))*PolyLog(2, c*x) - (2*h*log(1 - c*x)*PolyLog(2, 1 - c*x))/c + (2*h*PolyLog(3, 1 - c*x))/c]
@test_int [(g + h*log(1 - c*x))*PolyLog(2, c*x)/x^1, x, 3, (-(1/2))*h*PolyLog(2, c*x)^2 + g*PolyLog(3, c*x)]
@test_int [(g + h*log(1 - c*x))*PolyLog(2, c*x)/x^2, x, 12, c*h*log(c*x)*log(1 - c*x)^2 + (log(1 - c*x)*(g + h*log(1 - c*x)))/x + c*(g + 2*h*log(1 - c*x))*log(1 - 1/(1 - c*x)) + c*h*log(1 - c*x)*PolyLog(2, c*x) - ((g + h*log(1 - c*x))*PolyLog(2, c*x))/x - 2*c*h*PolyLog(2, 1/(1 - c*x)) + 2*c*h*log(1 - c*x)*PolyLog(2, 1 - c*x) - c*h*PolyLog(3, c*x) - 2*c*h*PolyLog(3, 1 - c*x)]
@test_int [(g + h*log(1 - c*x))*PolyLog(2, c*x)/x^3, x, 20, (-c^2)*h*log(x) + (1/2)*c^2*h*log(1 - c*x) - (c*h*log(1 - c*x))/(2*x) + (1/2)*c^2*h*log(c*x)*log(1 - c*x)^2 + (log(1 - c*x)*(g + h*log(1 - c*x)))/(4*x^2) - (c*(1 - c*x)*(g + 2*h*log(1 - c*x)))/(4*x) + (1/4)*c^2*(g + 2*h*log(1 - c*x))*log(1 - 1/(1 - c*x)) + (c*h*PolyLog(2, c*x))/(2*x) + (1/2)*c^2*h*log(1 - c*x)*PolyLog(2, c*x) - ((g + h*log(1 - c*x))*PolyLog(2, c*x))/(2*x^2) - (1/2)*c^2*h*PolyLog(2, 1/(1 - c*x)) + c^2*h*log(1 - c*x)*PolyLog(2, 1 - c*x) - (1/2)*c^2*h*PolyLog(3, c*x) - c^2*h*PolyLog(3, 1 - c*x)]
@test_int [(g + h*log(1 - c*x))*PolyLog(2, c*x)/x^4, x, 28, (7*c^2*h)/(36*x) - (3/4)*c^3*h*log(x) + (19/36)*c^3*h*log(1 - c*x) - (c*h*log(1 - c*x))/(12*x^2) - (c^2*h*log(1 - c*x))/(3*x) + (1/3)*c^3*h*log(c*x)*log(1 - c*x)^2 + (log(1 - c*x)*(g + h*log(1 - c*x)))/(9*x^3) - (c*(g + 2*h*log(1 - c*x)))/(18*x^2) - (c^2*(1 - c*x)*(g + 2*h*log(1 - c*x)))/(9*x) + (1/9)*c^3*(g + 2*h*log(1 - c*x))*log(1 - 1/(1 - c*x)) + (c*h*PolyLog(2, c*x))/(6*x^2) + (c^2*h*PolyLog(2, c*x))/(3*x) + (1/3)*c^3*h*log(1 - c*x)*PolyLog(2, c*x) - ((g + h*log(1 - c*x))*PolyLog(2, c*x))/(3*x^3) - (2/9)*c^3*h*PolyLog(2, 1/(1 - c*x)) + (2/3)*c^3*h*log(1 - c*x)*PolyLog(2, 1 - c*x) - (1/3)*c^3*h*PolyLog(3, c*x) - (2/3)*c^3*h*PolyLog(3, 1 - c*x)]
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*x^m*(g+h*log(f*(d+e*x)^n))*PolyLog(2, c*(a+b*x))=#
@test_int [x^2*(g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)), x, 108, -((a^2*g*x)/(3*b^2)) + (a*(1 - a*c)*g*x)/(6*b^2*c) - ((1 - a*c)^2*g*x)/(9*b^2*c^2) + (7*a^2*h*n*x)/(9*b^2) - (11*a*(1 - a*c)*h*n*x)/(36*b^2*c) + (5*(1 - a*c)^2*h*n*x)/(27*b^2*c^2) + (13*d^2*h*n*x)/(27*e^2) + (5*a*d*h*n*x)/(12*b*e) - (7*(1 - a*c)*d*h*n*x)/(36*b*c*e) - (a*h*n*x^2)/(9*b) + (7*(1 - a*c)*h*n*x^2)/(108*b*c) - (19*d*h*n*x^2)/(216*e) + (1/27)*h*n*x^3 - (5*a*(1 - a*c)^2*h*n*log(1 - a*c - b*c*x))/(36*b^3*c^2) + (2*(1 - a*c)^3*h*n*log(1 - a*c - b*c*x))/(27*b^3*c^3) - (5*(1 - a*c)^2*d*h*n*log(1 - a*c - b*c*x))/(36*b^2*c^2*e) + (5*a*h*n*x^2*log(1 - a*c - b*c*x))/(36*b) + (5*d*h*n*x^2*log(1 - a*c - b*c*x))/(36*e) - (2/27)*h*n*x^3*log(1 - a*c - b*c*x) + (4*a^2*h*n*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(9*b^3*c) + (4*d^2*h*n*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(9*b*c*e^2) + (a*d*h*n*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(3*b^2*c*e) - (d^3*h*n*log(d + e*x))/(27*e^3) - (a*d^2*h*n*log(d + e*x))/(12*b*e^2) + ((1 - a*c)*d^2*h*n*log(d + e*x))/(18*b*c*e^2) + (d^3*h*n*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(9*e^3) + (a*d^2*h*n*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(6*b*e^2) + (a^2*d*h*n*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(3*b^2*e) - (a^2*h*(d + e*x)*log(f*(d + e*x)^n))/(3*b^2*e) + (a*(1 - a*c)*h*(d + e*x)*log(f*(d + e*x)^n))/(6*b^2*c*e) - ((1 - a*c)^2*h*(d + e*x)*log(f*(d + e*x)^n))/(9*b^2*c^2*e) + (a*x^2*(g + h*log(f*(d + e*x)^n)))/(12*b) - ((1 - a*c)*x^2*(g + h*log(f*(d + e*x)^n)))/(18*b*c) - (1/27)*x^3*(g + h*log(f*(d + e*x)^n)) + (a^2*x*log(1 - a*c - b*c*x)*(g + h*log(f*(d + e*x)^n)))/(3*b^2) - (a*x^2*log(1 - a*c - b*c*x)*(g + h*log(f*(d + e*x)^n)))/(6*b) + (1/9)*x^3*log(1 - a*c - b*c*x)*(g + h*log(f*(d + e*x)^n)) - (a^2*(1 - a*c)*log((e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e))*(g + h*log(f*(d + e*x)^n)))/(3*b^3*c) + (a*(1 - a*c)^2*log((e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e))*(g + h*log(f*(d + e*x)^n)))/(6*b^3*c^2) - ((1 - a*c)^3*log((e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e))*(g + h*log(f*(d + e*x)^n)))/(9*b^3*c^3) - (a^3*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(6*b^3) + (d^3*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(6*e^3) - (a^3*h*n*log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/(3*b^3) + (d^3*h*n*log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/(3*e^3) + (a^3*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(6*b^3) - (d^3*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(6*e^3) + (a^3*g*PolyLog(2, c*(a + b*x)))/(3*b^3) - (a^3*h*n*PolyLog(2, c*(a + b*x)))/(9*b^3) - (a*d^2*h*n*PolyLog(2, c*(a + b*x)))/(3*b*e^2) - (a^2*d*h*n*PolyLog(2, c*(a + b*x)))/(6*b^2*e) - (d^2*h*n*x*PolyLog(2, c*(a + b*x)))/(3*e^2) + (d*h*n*x^2*PolyLog(2, c*(a + b*x)))/(6*e) - (1/9)*h*n*x^3*PolyLog(2, c*(a + b*x)) + (d^3*h*n*log(d + e*x)*PolyLog(2, c*(a + b*x)))/(3*e^3) - (a^3*h*(n*log(d + e*x) - log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)))/(3*b^3) + (1/3)*x^3*(g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)) + (d^3*h*n*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/(9*e^3) + (a*d^2*h*n*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/(6*b*e^2) + (a^2*d*h*n*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/(3*b^2*e) - (a^3*h*n*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/(3*b^3) + (d^3*h*n*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/(3*e^3) - (a^2*(1 - a*c)*h*n*PolyLog(2, (b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(3*b^3*c) + (a*(1 - a*c)^2*h*n*PolyLog(2, (b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(6*b^3*c^2) - ((1 - a*c)^3*h*n*PolyLog(2, (b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(9*b^3*c^3) - (a^3*h*n*(log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/(3*b^3) + (d^3*h*n*(log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/(3*e^3) + (a^3*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(3*b^3) - (d^3*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(3*e^3) - (a^3*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(3*b^3) + (d^3*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(3*e^3) + (a^3*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/(3*b^3) - (d^3*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/(3*e^3) + (a^3*h*n*PolyLog(3, 1 - c*(a + b*x)))/(3*b^3) - (d^3*h*n*PolyLog(3, 1 - c*(a + b*x)))/(3*e^3) + (a^3*h*n*PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(3*b^3) - (d^3*h*n*PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(3*e^3) - (a^3*h*n*PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(3*b^3) + (d^3*h*n*PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(3*e^3)]
@test_int [x^1*(g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)), x, 67, (a*g*x)/(2*b) - ((1 - a*c)*g*x)/(4*b*c) - (5*a*h*n*x)/(4*b) + ((1 - a*c)*h*n*x)/(2*b*c) - (7*d*h*n*x)/(8*e) + (3/16)*h*n*x^2 + ((1 - a*c)^2*h*n*log(1 - a*c - b*c*x))/(4*b^2*c^2) - (1/4)*h*n*x^2*log(1 - a*c - b*c*x) - (3*a*h*n*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(4*b^2*c) - (3*d*h*n*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(4*b*c*e) + (d^2*h*n*log(d + e*x))/(8*e^2) - (d^2*h*n*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(4*e^2) - (a*d*h*n*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(2*b*e) + (a*h*(d + e*x)*log(f*(d + e*x)^n))/(2*b*e) - ((1 - a*c)*h*(d + e*x)*log(f*(d + e*x)^n))/(4*b*c*e) - (1/8)*x^2*(g + h*log(f*(d + e*x)^n)) - (a*x*log(1 - a*c - b*c*x)*(g + h*log(f*(d + e*x)^n)))/(2*b) + (1/4)*x^2*log(1 - a*c - b*c*x)*(g + h*log(f*(d + e*x)^n)) + (a*(1 - a*c)*log((e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e))*(g + h*log(f*(d + e*x)^n)))/(2*b^2*c) - ((1 - a*c)^2*log((e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e))*(g + h*log(f*(d + e*x)^n)))/(4*b^2*c^2) + (a^2*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(4*b^2) - (d^2*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(4*e^2) + (a^2*h*n*log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/(2*b^2) - (d^2*h*n*log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/(2*e^2) - (a^2*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(4*b^2) + (d^2*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(4*e^2) - (a^2*g*PolyLog(2, c*(a + b*x)))/(2*b^2) + (a^2*h*n*PolyLog(2, c*(a + b*x)))/(4*b^2) + (a*d*h*n*PolyLog(2, c*(a + b*x)))/(2*b*e) + (d*h*n*x*PolyLog(2, c*(a + b*x)))/(2*e) - (1/4)*h*n*x^2*PolyLog(2, c*(a + b*x)) - (d^2*h*n*log(d + e*x)*PolyLog(2, c*(a + b*x)))/(2*e^2) + (a^2*h*(n*log(d + e*x) - log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)))/(2*b^2) + (1/2)*x^2*(g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)) - (d^2*h*n*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/(4*e^2) - (a*d*h*n*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/(2*b*e) + (a^2*h*n*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/(2*b^2) - (d^2*h*n*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/(2*e^2) + (a*(1 - a*c)*h*n*PolyLog(2, (b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(2*b^2*c) - ((1 - a*c)^2*h*n*PolyLog(2, (b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(4*b^2*c^2) + (a^2*h*n*(log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/(2*b^2) - (d^2*h*n*(log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/(2*e^2) - (a^2*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(2*b^2) + (d^2*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(2*e^2) + (a^2*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(2*b^2) - (d^2*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(2*e^2) - (a^2*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/(2*b^2) + (d^2*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/(2*e^2) - (a^2*h*n*PolyLog(3, 1 - c*(a + b*x)))/(2*b^2) + (d^2*h*n*PolyLog(3, 1 - c*(a + b*x)))/(2*e^2) - (a^2*h*n*PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(2*b^2) + (d^2*h*n*PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(2*e^2) + (a^2*h*n*PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(2*b^2) - (d^2*h*n*PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(2*e^2)]
@test_int [x^0*(g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)), x, 42, (-g)*x + 3*h*n*x - (g*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(b*c) + (2*h*n*(1 - a*c - b*c*x)*log(1 - a*c - b*c*x))/(b*c) + (d*h*n*log(c*(a + b*x))*log(1 - a*c - b*c*x)*log(-d - e*x))/e + (d*h*n*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/e + (d*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - a*c - b*c*x)))^2)/(2*e) - (d*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log(1 - a*c - b*c*x) + log((b*(d + e*x))/((b*d - a*e)*(1 - a*c - b*c*x))))^2)/(2*e) - (h*(d + e*x)*log(f*(d + e*x)^n))/e + h*x*log(1 - a*c - b*c*x)*log(f*(d + e*x)^n) - ((1 - a*c)*h*log((e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e))*log(f*(d + e*x)^n))/(b*c) - (a*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(2*b) - (a*h*n*log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/b + (a*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(2*b) + (a*g*PolyLog(2, c*(a + b*x)))/b - (a*h*n*PolyLog(2, c*(a + b*x)))/b - (a*h*(n*log(d + e*x) - log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)))/b + x*(g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)) + (d*h*n*(log(-d - e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - a*c - b*c*x))))*PolyLog(2, 1 - a*c - b*c*x))/e + (d*h*n*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/e - h*n*x*PolyLog(2, a*c + b*c*x) + (d*h*n*log(-d - e*x)*PolyLog(2, a*c + b*c*x))/e - (d*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - a*c - b*c*x)))*PolyLog(2, -((e*(1 - a*c - b*c*x))/(b*c*(d + e*x)))))/e + (d*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - a*c - b*c*x)))*PolyLog(2, ((b*d - a*e)*(1 - a*c - b*c*x))/(b*(d + e*x))))/e + (d*h*n*(log(1 - a*c - b*c*x) + log((b*(d + e*x))/((b*d - a*e)*(1 - a*c - b*c*x))))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/e - (a*h*n*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/b - ((1 - a*c)*h*n*PolyLog(2, (b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(b*c) - (a*h*n*(log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/b + (a*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/b - (a*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/b - (d*h*n*PolyLog(3, 1 - a*c - b*c*x))/e - (d*h*n*PolyLog(3, -((e*(1 - a*c - b*c*x))/(b*c*(d + e*x)))))/e + (d*h*n*PolyLog(3, ((b*d - a*e)*(1 - a*c - b*c*x))/(b*(d + e*x))))/e + (a*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/b - (d*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/e + (a*h*n*PolyLog(3, 1 - c*(a + b*x)))/b + (a*h*n*PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/b - (a*h*n*PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/b]
@test_int [(g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x))/x^1, x, 0, Unintegrable(((g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)))/x, x)]
@test_int [(g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x))/x^2, x, 22, -((b*g*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x))/a) - (b*h*n*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x)*log(d + e*x))/a - (b*h*n*(log((b*c*x)/(1 - a*c)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*x)/((1 - a*c)*(d + e*x))))*log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x)))^2)/(2*a) + (b*h*n*(log((b*c*x)/(1 - a*c)) - log(-((e*x)/d)))*(log(1 - a*c - b*c*x) + log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x))))^2)/(2*a) + (b*h*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x)*(n*log(d + e*x) - log(f*(d + e*x)^n)))/a + (b*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(2*a) - (e*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(2*d) + (e*h*n*log(x)*log(1 + (b*x)/a)*log(1 - c*(a + b*x)))/d + (b*h*n*log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/a - (e*h*n*log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/d - (b*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(2*a) + (e*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(2*d) + (e*h*n*(log(1 + (b*x)/a) + log((1 - a*c)/(1 - c*(a + b*x))) - log(((1 - a*c)*(a + b*x))/(a*(1 - c*(a + b*x)))))*log(-((a*(1 - c*(a + b*x)))/(b*x)))^2)/(2*d) + (e*h*n*(log(c*(a + b*x)) - log(1 + (b*x)/a))*(log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))^2)/(2*d) + (e*h*n*(log(1 - c*(a + b*x)) - log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, -((b*x)/a)))/d - (b*g*PolyLog(2, c*(a + b*x)))/a + (e*h*n*log(x)*PolyLog(2, c*(a + b*x)))/d - (e*h*n*log(d + e*x)*PolyLog(2, c*(a + b*x)))/d + (b*h*(n*log(d + e*x) - log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)))/a - ((g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)))/x - (b*g*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/a - (b*h*n*(log(d + e*x) - log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x))))*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/a + (b*h*(n*log(d + e*x) - log(f*(d + e*x)^n))*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/a - (b*h*n*log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x)))*PolyLog(2, (d*(1 - a*c - b*c*x))/((1 - a*c)*(d + e*x))))/a + (b*h*n*log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x)))*PolyLog(2, -((e*(1 - a*c - b*c*x))/(b*c*(d + e*x)))))/a + (b*h*n*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/a - (e*h*n*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/d - (b*h*n*(log(1 - a*c - b*c*x) + log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x))))*PolyLog(2, 1 + (e*x)/d))/a + (e*h*n*log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*x)/(a*(1 - c*(a + b*x))))))/d - (e*h*n*log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*c*x)/(1 - c*(a + b*x)))))/d + (b*h*n*(log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/a - (e*h*n*(log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/d + (e*h*n*(log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, 1 - c*(a + b*x)))/d - (b*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/a + (e*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/d + (b*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/a - (e*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/d - (e*h*n*PolyLog(3, -((b*x)/a)))/d + (b*h*n*PolyLog(3, 1 - (b*c*x)/(1 - a*c)))/a - (b*h*n*PolyLog(3, (d*(1 - a*c - b*c*x))/((1 - a*c)*(d + e*x))))/a + (b*h*n*PolyLog(3, -((e*(1 - a*c - b*c*x))/(b*c*(d + e*x)))))/a - (b*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/a + (e*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/d + (b*h*n*PolyLog(3, 1 + (e*x)/d))/a + (e*h*n*PolyLog(3, -((b*x)/(a*(1 - c*(a + b*x))))))/d - (e*h*n*PolyLog(3, -((b*c*x)/(1 - c*(a + b*x)))))/d - (b*h*n*PolyLog(3, 1 - c*(a + b*x)))/a - (b*h*n*PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/a + (e*h*n*PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/d + (b*h*n*PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/a - (e*h*n*PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/d]
@test_int [(g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x))/x^3, x, 44, (b^2*g*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x))/(2*a^2) - (b*e*h*n*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x))/(a*d) + (b^2*h*n*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x)*log(d + e*x))/(2*a^2) + (b*e*h*n*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(2*a*d) + (b^2*h*n*(log((b*c*x)/(1 - a*c)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*x)/((1 - a*c)*(d + e*x))))*log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x)))^2)/(4*a^2) - (b^2*h*n*(log((b*c*x)/(1 - a*c)) - log(-((e*x)/d)))*(log(1 - a*c - b*c*x) + log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x))))^2)/(4*a^2) - (b^2*h*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x)*(n*log(d + e*x) - log(f*(d + e*x)^n)))/(2*a^2) + (b^2*c*log(-((e*x)/d))*(g + h*log(f*(d + e*x)^n)))/(2*a*(1 - a*c)) + (b*log(1 - a*c - b*c*x)*(g + h*log(f*(d + e*x)^n)))/(2*a*x) - (b^2*c*log((e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e))*(g + h*log(f*(d + e*x)^n)))/(2*a*(1 - a*c)) - (b^2*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(4*a^2) + (e^2*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(4*d^2) - (e^2*h*n*log(x)*log(1 + (b*x)/a)*log(1 - c*(a + b*x)))/(2*d^2) - (b^2*h*n*log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/(2*a^2) + (e^2*h*n*log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/(2*d^2) + (b^2*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(4*a^2) - (e^2*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(4*d^2) - (e^2*h*n*(log(1 + (b*x)/a) + log((1 - a*c)/(1 - c*(a + b*x))) - log(((1 - a*c)*(a + b*x))/(a*(1 - c*(a + b*x)))))*log(-((a*(1 - c*(a + b*x)))/(b*x)))^2)/(4*d^2) - (e^2*h*n*(log(c*(a + b*x)) - log(1 + (b*x)/a))*(log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))^2)/(4*d^2) - (e^2*h*n*(log(1 - c*(a + b*x)) - log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, -((b*x)/a)))/(2*d^2) + (b^2*g*PolyLog(2, c*(a + b*x)))/(2*a^2) - (b*e*h*n*PolyLog(2, c*(a + b*x)))/(2*a*d) - (e*h*n*PolyLog(2, c*(a + b*x)))/(2*d*x) - (e^2*h*n*log(x)*PolyLog(2, c*(a + b*x)))/(2*d^2) + (e^2*h*n*log(d + e*x)*PolyLog(2, c*(a + b*x)))/(2*d^2) - (b^2*h*(n*log(d + e*x) - log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)))/(2*a^2) - ((g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)))/(2*x^2) + (b*e*h*n*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/(2*a*d) + (b^2*g*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(2*a^2) - (b*e*h*n*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(a*d) + (b^2*h*n*(log(d + e*x) - log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x))))*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(2*a^2) - (b^2*h*(n*log(d + e*x) - log(f*(d + e*x)^n))*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(2*a^2) + (b^2*h*n*log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x)))*PolyLog(2, (d*(1 - a*c - b*c*x))/((1 - a*c)*(d + e*x))))/(2*a^2) - (b^2*h*n*log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x)))*PolyLog(2, -((e*(1 - a*c - b*c*x))/(b*c*(d + e*x)))))/(2*a^2) - (b^2*h*n*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/(2*a^2) + (e^2*h*n*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/(2*d^2) - (b^2*c*h*n*PolyLog(2, (b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(2*a*(1 - a*c)) + (b^2*c*h*n*PolyLog(2, 1 + (e*x)/d))/(2*a*(1 - a*c)) + (b^2*h*n*(log(1 - a*c - b*c*x) + log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x))))*PolyLog(2, 1 + (e*x)/d))/(2*a^2) - (e^2*h*n*log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*x)/(a*(1 - c*(a + b*x))))))/(2*d^2) + (e^2*h*n*log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*c*x)/(1 - c*(a + b*x)))))/(2*d^2) - (b^2*h*n*(log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/(2*a^2) + (e^2*h*n*(log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/(2*d^2) - (e^2*h*n*(log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, 1 - c*(a + b*x)))/(2*d^2) + (b^2*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(2*a^2) - (e^2*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(2*d^2) - (b^2*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(2*a^2) + (e^2*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(2*d^2) + (e^2*h*n*PolyLog(3, -((b*x)/a)))/(2*d^2) - (b^2*h*n*PolyLog(3, 1 - (b*c*x)/(1 - a*c)))/(2*a^2) + (b^2*h*n*PolyLog(3, (d*(1 - a*c - b*c*x))/((1 - a*c)*(d + e*x))))/(2*a^2) - (b^2*h*n*PolyLog(3, -((e*(1 - a*c - b*c*x))/(b*c*(d + e*x)))))/(2*a^2) + (b^2*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/(2*a^2) - (e^2*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/(2*d^2) - (b^2*h*n*PolyLog(3, 1 + (e*x)/d))/(2*a^2) - (e^2*h*n*PolyLog(3, -((b*x)/(a*(1 - c*(a + b*x))))))/(2*d^2) + (e^2*h*n*PolyLog(3, -((b*c*x)/(1 - c*(a + b*x)))))/(2*d^2) + (b^2*h*n*PolyLog(3, 1 - c*(a + b*x)))/(2*a^2) + (b^2*h*n*PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(2*a^2) - (e^2*h*n*PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(2*d^2) - (b^2*h*n*PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(2*a^2) + (e^2*h*n*PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(2*d^2)]
@test_int [(g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x))/x^4, x, 78, (b^2*c*e*h*n*log(x))/(2*a*(1 - a*c)*d) - (b^2*c*e*h*n*log(1 - a*c - b*c*x))/(3*a*(1 - a*c)*d) + (b*e*h*n*log(1 - a*c - b*c*x))/(3*a*d*x) - (b^3*g*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x))/(3*a^3) + (b^2*e*h*n*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x))/(2*a^2*d) + (b*e^2*h*n*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x))/(2*a*d^2) - (b^2*c*e*h*n*log(d + e*x))/(6*a*(1 - a*c)*d) - (b^3*h*n*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x)*log(d + e*x))/(3*a^3) - (b^2*e*h*n*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(3*a^2*d) - (b*e^2*h*n*log(1 - a*c - b*c*x)*log((b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(6*a*d^2) - (b^3*h*n*(log((b*c*x)/(1 - a*c)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*x)/((1 - a*c)*(d + e*x))))*log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x)))^2)/(6*a^3) + (b^3*h*n*(log((b*c*x)/(1 - a*c)) - log(-((e*x)/d)))*(log(1 - a*c - b*c*x) + log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x))))^2)/(6*a^3) + (b^3*h*log((b*c*x)/(1 - a*c))*log(1 - a*c - b*c*x)*(n*log(d + e*x) - log(f*(d + e*x)^n)))/(3*a^3) - (b^2*c*(g + h*log(f*(d + e*x)^n)))/(6*a*(1 - a*c)*x) + (b^3*c^2*log(-((e*x)/d))*(g + h*log(f*(d + e*x)^n)))/(6*a*(1 - a*c)^2) - (b^3*c*log(-((e*x)/d))*(g + h*log(f*(d + e*x)^n)))/(3*a^2*(1 - a*c)) + (b*log(1 - a*c - b*c*x)*(g + h*log(f*(d + e*x)^n)))/(6*a*x^2) - (b^2*log(1 - a*c - b*c*x)*(g + h*log(f*(d + e*x)^n)))/(3*a^2*x) - (b^3*c^2*log((e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e))*(g + h*log(f*(d + e*x)^n)))/(6*a*(1 - a*c)^2) + (b^3*c*log((e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e))*(g + h*log(f*(d + e*x)^n)))/(3*a^2*(1 - a*c)) + (b^3*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(6*a^3) - (e^3*h*n*(log(c*(a + b*x)) + log((b*c*d + e - a*c*e)/(b*c*(d + e*x))) - log(((b*c*d + e - a*c*e)*(a + b*x))/(b*(d + e*x))))*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))^2)/(6*d^3) + (e^3*h*n*log(x)*log(1 + (b*x)/a)*log(1 - c*(a + b*x)))/(3*d^3) + (b^3*h*n*log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/(3*a^3) - (e^3*h*n*log(c*(a + b*x))*log(d + e*x)*log(1 - c*(a + b*x)))/(3*d^3) - (b^3*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(6*a^3) + (e^3*h*n*(log(c*(a + b*x)) - log(-((e*(a + b*x))/(b*d - a*e))))*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))^2)/(6*d^3) + (e^3*h*n*(log(1 + (b*x)/a) + log((1 - a*c)/(1 - c*(a + b*x))) - log(((1 - a*c)*(a + b*x))/(a*(1 - c*(a + b*x)))))*log(-((a*(1 - c*(a + b*x)))/(b*x)))^2)/(6*d^3) + (e^3*h*n*(log(c*(a + b*x)) - log(1 + (b*x)/a))*(log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))^2)/(6*d^3) + (e^3*h*n*(log(1 - c*(a + b*x)) - log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, -((b*x)/a)))/(3*d^3) - (b^3*g*PolyLog(2, c*(a + b*x)))/(3*a^3) + (b^2*e*h*n*PolyLog(2, c*(a + b*x)))/(6*a^2*d) + (b*e^2*h*n*PolyLog(2, c*(a + b*x)))/(3*a*d^2) - (e*h*n*PolyLog(2, c*(a + b*x)))/(6*d*x^2) + (e^2*h*n*PolyLog(2, c*(a + b*x)))/(3*d^2*x) + (e^3*h*n*log(x)*PolyLog(2, c*(a + b*x)))/(3*d^3) - (e^3*h*n*log(d + e*x)*PolyLog(2, c*(a + b*x)))/(3*d^3) + (b^3*h*(n*log(d + e*x) - log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)))/(3*a^3) - ((g + h*log(f*(d + e*x)^n))*PolyLog(2, c*(a + b*x)))/(3*x^3) - (b^2*e*h*n*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/(3*a^2*d) - (b*e^2*h*n*PolyLog(2, (e*(1 - a*c - b*c*x))/(b*c*d + e - a*c*e)))/(6*a*d^2) - (b^3*g*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(3*a^3) + (b^2*e*h*n*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(2*a^2*d) + (b*e^2*h*n*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(2*a*d^2) - (b^3*h*n*(log(d + e*x) - log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x))))*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(3*a^3) + (b^3*h*(n*log(d + e*x) - log(f*(d + e*x)^n))*PolyLog(2, 1 - (b*c*x)/(1 - a*c)))/(3*a^3) - (b^3*h*n*log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x)))*PolyLog(2, (d*(1 - a*c - b*c*x))/((1 - a*c)*(d + e*x))))/(3*a^3) + (b^3*h*n*log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x)))*PolyLog(2, -((e*(1 - a*c - b*c*x))/(b*c*(d + e*x)))))/(3*a^3) + (b^3*h*n*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/(3*a^3) - (e^3*h*n*(log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))) + log(1 - c*(a + b*x)))*PolyLog(2, (b*(d + e*x))/(b*d - a*e)))/(3*d^3) - (b^3*c^2*h*n*PolyLog(2, (b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(6*a*(1 - a*c)^2) + (b^3*c*h*n*PolyLog(2, (b*c*(d + e*x))/(b*c*d + e - a*c*e)))/(3*a^2*(1 - a*c)) + (b^3*c^2*h*n*PolyLog(2, 1 + (e*x)/d))/(6*a*(1 - a*c)^2) - (b^3*c*h*n*PolyLog(2, 1 + (e*x)/d))/(3*a^2*(1 - a*c)) - (b^3*h*n*(log(1 - a*c - b*c*x) + log(((1 - a*c)*(d + e*x))/(d*(1 - a*c - b*c*x))))*PolyLog(2, 1 + (e*x)/d))/(3*a^3) + (e^3*h*n*log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*x)/(a*(1 - c*(a + b*x))))))/(3*d^3) - (e^3*h*n*log(-((a*(1 - c*(a + b*x)))/(b*x)))*PolyLog(2, -((b*c*x)/(1 - c*(a + b*x)))))/(3*d^3) + (b^3*h*n*(log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/(3*a^3) - (e^3*h*n*(log(d + e*x) - log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x)))))*PolyLog(2, 1 - c*(a + b*x)))/(3*d^3) + (e^3*h*n*(log(x) + log(-((a*(1 - c*(a + b*x)))/(b*x))))*PolyLog(2, 1 - c*(a + b*x)))/(3*d^3) - (b^3*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(3*a^3) + (e^3*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(3*d^3) + (b^3*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(3*a^3) - (e^3*h*n*log((b*(d + e*x))/((b*d - a*e)*(1 - c*(a + b*x))))*PolyLog(2, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(3*d^3) - (e^3*h*n*PolyLog(3, -((b*x)/a)))/(3*d^3) + (b^3*h*n*PolyLog(3, 1 - (b*c*x)/(1 - a*c)))/(3*a^3) - (b^3*h*n*PolyLog(3, (d*(1 - a*c - b*c*x))/((1 - a*c)*(d + e*x))))/(3*a^3) + (b^3*h*n*PolyLog(3, -((e*(1 - a*c - b*c*x))/(b*c*(d + e*x)))))/(3*a^3) - (b^3*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/(3*a^3) + (e^3*h*n*PolyLog(3, (b*(d + e*x))/(b*d - a*e)))/(3*d^3) + (b^3*h*n*PolyLog(3, 1 + (e*x)/d))/(3*a^3) + (e^3*h*n*PolyLog(3, -((b*x)/(a*(1 - c*(a + b*x))))))/(3*d^3) - (e^3*h*n*PolyLog(3, -((b*c*x)/(1 - c*(a + b*x)))))/(3*d^3) - (b^3*h*n*PolyLog(3, 1 - c*(a + b*x)))/(3*a^3) - (b^3*h*n*PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(3*a^3) + (e^3*h*n*PolyLog(3, -((e*(1 - c*(a + b*x)))/(b*c*(d + e*x)))))/(3*d^3) + (b^3*h*n*PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(3*a^3) - (e^3*h*n*PolyLog(3, ((b*d - a*e)*(1 - c*(a + b*x)))/(b*(d + e*x))))/(3*d^3)]
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*x^m*(a+b*x)*log(1-c*x)*PolyLog(2, c*x)=#
@test_int [x^2*(a + b*x)*log(1 - c*x)*PolyLog(2, c*x), x, 52, (53*b*x)/(192*c^3) + (11*a*x)/(27*c^2) + (49*(3*b + 4*a*c)*x)/(432*c^3) + (29*b*x^2)/(384*c^2) + (5*a*x^2)/(54*c) + (13*(3*b + 4*a*c)*x^2)/(864*c^2) + (2*a*x^3)/81 + (17*b*x^3)/(576*c) + ((3*b + 4*a*c)*x^3)/(324*c) + (3*b*x^4)/256 + (29*b*log(1 - c*x))/(192*c^4) + (5*a*log(1 - c*x))/(27*c^3) + (13*(3*b + 4*a*c)*log(1 - c*x))/(432*c^4) - (b*x^2*log(1 - c*x))/(16*c^2) - (a*x^2*log(1 - c*x))/(9*c) - ((3*b + 4*a*c)*x^2*log(1 - c*x))/(48*c^2) - (2/27)*a*x^3*log(1 - c*x) - (b*x^3*log(1 - c*x))/(24*c) - ((3*b + 4*a*c)*x^3*log(1 - c*x))/(108*c) - (3/64)*b*x^4*log(1 - c*x) + (b*(1 - c*x)*log(1 - c*x))/(8*c^4) + (2*a*(1 - c*x)*log(1 - c*x))/(9*c^3) + ((3*b + 4*a*c)*(1 - c*x)*log(1 - c*x))/(12*c^4) - (b*log(1 - c*x)^2)/(16*c^4) - (a*log(1 - c*x)^2)/(9*c^3) + (1/9)*a*x^3*log(1 - c*x)^2 + (1/16)*b*x^4*log(1 - c*x)^2 - ((3*b + 4*a*c)*log(c*x)*log(1 - c*x)^2)/(12*c^4) - ((3*b + 4*a*c)*x*PolyLog(2, c*x))/(12*c^3) - ((3*b + 4*a*c)*x^2*PolyLog(2, c*x))/(24*c^2) - ((3*b + 4*a*c)*x^3*PolyLog(2, c*x))/(36*c) - (1/16)*b*x^4*PolyLog(2, c*x) - ((3*b + 4*a*c)*log(1 - c*x)*PolyLog(2, c*x))/(12*c^4) + (1/12)*(4*a*x^3 + 3*b*x^4)*log(1 - c*x)*PolyLog(2, c*x) - ((3*b + 4*a*c)*log(1 - c*x)*PolyLog(2, 1 - c*x))/(6*c^4) + ((3*b + 4*a*c)*PolyLog(3, 1 - c*x))/(6*c^4)]
@test_int [x^1*(a + b*x)*log(1 - c*x)*PolyLog(2, c*x), x, 40, (4*b*x)/(9*c^2) + (a*x)/c + (5*(2*b + 3*a*c)*x)/(24*c^2) + (b*x^2)/(9*c) + ((2*b + 3*a*c)*x^2)/(48*c) + (b*x^3)/27 + (a*(1 - c*x)^2)/(8*c^2) + (2*b*log(1 - c*x))/(9*c^3) + ((2*b + 3*a*c)*log(1 - c*x))/(24*c^3) - (b*x^2*log(1 - c*x))/(9*c) - ((2*b + 3*a*c)*x^2*log(1 - c*x))/(24*c) - (1/9)*b*x^3*log(1 - c*x) + (2*b*(1 - c*x)*log(1 - c*x))/(9*c^3) + (a*(1 - c*x)*log(1 - c*x))/c^2 + ((2*b + 3*a*c)*(1 - c*x)*log(1 - c*x))/(6*c^3) - (a*(1 - c*x)^2*log(1 - c*x))/(4*c^2) - (b*log(1 - c*x)^2)/(9*c^3) + (1/9)*b*x^3*log(1 - c*x)^2 - (a*(1 - c*x)*log(1 - c*x)^2)/(2*c^2) + (a*(1 - c*x)^2*log(1 - c*x)^2)/(4*c^2) - ((2*b + 3*a*c)*log(c*x)*log(1 - c*x)^2)/(6*c^3) - ((2*b + 3*a*c)*x*PolyLog(2, c*x))/(6*c^2) - ((2*b + 3*a*c)*x^2*PolyLog(2, c*x))/(12*c) - (1/9)*b*x^3*PolyLog(2, c*x) - ((2*b + 3*a*c)*log(1 - c*x)*PolyLog(2, c*x))/(6*c^3) + (1/6)*(3*a*x^2 + 2*b*x^3)*log(1 - c*x)*PolyLog(2, c*x) - ((2*b + 3*a*c)*log(1 - c*x)*PolyLog(2, 1 - c*x))/(3*c^3) + ((2*b + 3*a*c)*PolyLog(3, 1 - c*x))/(3*c^3)]
@test_int [x^0*(a + b*x)*log(1 - c*x)*PolyLog(2, c*x), x, 26, 2*a*x + (9*b*x)/(8*c) + ((b + 2*a*c)*x)/(2*c) + (b*x^2)/16 + (b*(1 - c*x)^2)/(8*c^2) + (b*log(1 - c*x))/(8*c^2) - (1/8)*b*x^2*log(1 - c*x) + (b*(1 - c*x)*log(1 - c*x))/c^2 + (2*a*(1 - c*x)*log(1 - c*x))/c + ((b + 2*a*c)*(1 - c*x)*log(1 - c*x))/(2*c^2) - (b*(1 - c*x)^2*log(1 - c*x))/(4*c^2) - (b*(1 - c*x)*log(1 - c*x)^2)/(2*c^2) - (a*(1 - c*x)*log(1 - c*x)^2)/c + (b*(1 - c*x)^2*log(1 - c*x)^2)/(4*c^2) - ((b + 2*a*c)*log(c*x)*log(1 - c*x)^2)/(2*c^2) - ((b + 2*a*c)*x*PolyLog(2, c*x))/(2*c) - (1/4)*b*x^2*PolyLog(2, c*x) - ((b + 2*a*c)*log(1 - c*x)*PolyLog(2, c*x))/(2*c^2) + (1/2)*(2*a*x + b*x^2)*log(1 - c*x)*PolyLog(2, c*x) - ((b + 2*a*c)*log(1 - c*x)*PolyLog(2, 1 - c*x))/c^2 + ((b + 2*a*c)*PolyLog(3, 1 - c*x))/c^2]
@test_int [(a + b*x)*log(1 - c*x)*PolyLog(2, c*x)/x^1, x, 18, 3*b*x + (3*b*(1 - c*x)*log(1 - c*x))/c - (b*(1 - c*x)*log(1 - c*x)^2)/c - (b*log(c*x)*log(1 - c*x)^2)/c - b*x*PolyLog(2, c*x) - (b*log(1 - c*x)*PolyLog(2, c*x))/c + b*x*log(1 - c*x)*PolyLog(2, c*x) - (1/2)*a*PolyLog(2, c*x)^2 - (2*b*log(1 - c*x)*PolyLog(2, 1 - c*x))/c + (2*b*PolyLog(3, 1 - c*x))/c]
@test_int [(a + b*x)*log(1 - c*x)*PolyLog(2, c*x)/x^2, x, 13, (a*(1 - c*x)*log(1 - c*x)^2)/x + a*c*log(c*x)*log(1 - c*x)^2 - 2*a*c*PolyLog(2, c*x) + a*c*log(1 - c*x)*PolyLog(2, c*x) - (a*log(1 - c*x)*PolyLog(2, c*x))/x - (1/2)*b*PolyLog(2, c*x)^2 + 2*a*c*log(1 - c*x)*PolyLog(2, 1 - c*x) - a*c*PolyLog(3, c*x) - 2*a*c*PolyLog(3, 1 - c*x)]
@test_int [(a + b*x)*log(1 - c*x)*PolyLog(2, c*x)/x^3, x, 30, (-a)*c^2*log(x) + a*c^2*log(1 - c*x) - (a*c*log(1 - c*x))/x - (1/4)*a*c^2*log(1 - c*x)^2 + (a*log(1 - c*x)^2)/(4*x^2) + (b*(1 - c*x)*log(1 - c*x)^2)/x - (b^2*log(c*x)*log(1 - c*x)^2)/(2*a) + ((b + a*c)^2*log(c*x)*log(1 - c*x)^2)/(2*a) - 2*b*c*PolyLog(2, c*x) - (1/2)*a*c^2*PolyLog(2, c*x) + (a*c*PolyLog(2, c*x))/(2*x) + ((b + a*c)^2*log(1 - c*x)*PolyLog(2, c*x))/(2*a) - ((a + b*x)^2*log(1 - c*x)*PolyLog(2, c*x))/(2*a*x^2) - (b^2*log(1 - c*x)*PolyLog(2, 1 - c*x))/a + ((b + a*c)^2*log(1 - c*x)*PolyLog(2, 1 - c*x))/a - (1/2)*c*(2*b + a*c)*PolyLog(3, c*x) + (b^2*PolyLog(3, 1 - c*x))/a - ((b + a*c)^2*PolyLog(3, 1 - c*x))/a]
@test_int [(a + b*x)*log(1 - c*x)*PolyLog(2, c*x)/x^4, x, 41, (7*a*c^2)/(36*x) - (1/2)*b*c^2*log(x) - (5/12)*a*c^3*log(x) - (1/6)*c^2*(3*b + 2*a*c)*log(x) + (1/2)*b*c^2*log(1 - c*x) + (5/12)*a*c^3*log(1 - c*x) + (1/6)*c^2*(3*b + 2*a*c)*log(1 - c*x) - (7*a*c*log(1 - c*x))/(36*x^2) - (b*c*log(1 - c*x))/(2*x) - (2*a*c^2*log(1 - c*x))/(9*x) - (c*(3*b + 2*a*c)*log(1 - c*x))/(6*x) - (1/4)*b*c^2*log(1 - c*x)^2 - (1/9)*a*c^3*log(1 - c*x)^2 + (a*log(1 - c*x)^2)/(9*x^3) + (b*log(1 - c*x)^2)/(4*x^2) + (1/6)*c^2*(3*b + 2*a*c)*log(c*x)*log(1 - c*x)^2 - (1/2)*b*c^2*PolyLog(2, c*x) - (2/9)*a*c^3*PolyLog(2, c*x) + (a*c*PolyLog(2, c*x))/(6*x^2) + (c*(3*b + 2*a*c)*PolyLog(2, c*x))/(6*x) + (1/6)*c^2*(3*b + 2*a*c)*log(1 - c*x)*PolyLog(2, c*x) - (1/6)*((2*a)/x^3 + (3*b)/x^2)*log(1 - c*x)*PolyLog(2, c*x) + (1/3)*c^2*(3*b + 2*a*c)*log(1 - c*x)*PolyLog(2, 1 - c*x) - (1/6)*c^2*(3*b + 2*a*c)*PolyLog(3, c*x) - (1/3)*c^2*(3*b + 2*a*c)*PolyLog(3, 1 - c*x)]
@test_int [(a + b*x)*log(1 - c*x)*PolyLog(2, c*x)/x^5, x, 51, (5*a*c^2)/(144*x^2) + (b*c^2)/(9*x) + (19*a*c^3)/(144*x) + (c^2*(4*b + 3*a*c))/(48*x) - (1/3)*b*c^3*log(x) - (37/144)*a*c^4*log(x) - (5/48)*c^3*(4*b + 3*a*c)*log(x) + (1/3)*b*c^3*log(1 - c*x) + (37/144)*a*c^4*log(1 - c*x) + (5/48)*c^3*(4*b + 3*a*c)*log(1 - c*x) - (5*a*c*log(1 - c*x))/(72*x^3) - (b*c*log(1 - c*x))/(9*x^2) - (a*c^2*log(1 - c*x))/(16*x^2) - (c*(4*b + 3*a*c)*log(1 - c*x))/(48*x^2) - (2*b*c^2*log(1 - c*x))/(9*x) - (a*c^3*log(1 - c*x))/(8*x) - (c^2*(4*b + 3*a*c)*log(1 - c*x))/(12*x) - (1/9)*b*c^3*log(1 - c*x)^2 - (1/16)*a*c^4*log(1 - c*x)^2 + (a*log(1 - c*x)^2)/(16*x^4) + (b*log(1 - c*x)^2)/(9*x^3) + (1/12)*c^3*(4*b + 3*a*c)*log(c*x)*log(1 - c*x)^2 - (2/9)*b*c^3*PolyLog(2, c*x) - (1/8)*a*c^4*PolyLog(2, c*x) + (a*c*PolyLog(2, c*x))/(12*x^3) + (c*(4*b + 3*a*c)*PolyLog(2, c*x))/(24*x^2) + (c^2*(4*b + 3*a*c)*PolyLog(2, c*x))/(12*x) + (1/12)*c^3*(4*b + 3*a*c)*log(1 - c*x)*PolyLog(2, c*x) - (1/12)*((3*a)/x^4 + (4*b)/x^3)*log(1 - c*x)*PolyLog(2, c*x) + (1/6)*c^3*(4*b + 3*a*c)*log(1 - c*x)*PolyLog(2, 1 - c*x) - (1/12)*c^3*(4*b + 3*a*c)*PolyLog(3, c*x) - (1/6)*c^3*(4*b + 3*a*c)*PolyLog(3, 1 - c*x)]
#= ::Subsection::Closed:: =#
#=Integrands*of*the*form*x^m*(a+b*x+c*x^2)*log(1-d*x)*PolyLog(2, d*x)=#
@test_int [x^1*(a + b*x + c*x^2)*log(1 - d*x)*PolyLog(2, d*x), x, 60, (53*c*x)/(192*d^3) + (11*b*x)/(27*d^2) + (a*x)/d + ((3*c + 4*b*d)*x)/(108*d^3) + (5*(3*c + 4*b*d + 6*a*d^2)*x)/(48*d^3) + (29*c*x^2)/(384*d^2) + (5*b*x^2)/(54*d) + ((3*c + 4*b*d)*x^2)/(216*d^2) + ((3*c + 4*b*d + 6*a*d^2)*x^2)/(96*d^2) + (2*b*x^3)/81 + (17*c*x^3)/(576*d) + ((3*c + 4*b*d)*x^3)/(324*d) + (3*c*x^4)/256 + (a*(1 - d*x)^2)/(8*d^2) + (29*c*log(1 - d*x))/(192*d^4) + (5*b*log(1 - d*x))/(27*d^3) + ((3*c + 4*b*d)*log(1 - d*x))/(108*d^4) + ((3*c + 4*b*d + 6*a*d^2)*log(1 - d*x))/(48*d^4) - (c*x^2*log(1 - d*x))/(16*d^2) - (b*x^2*log(1 - d*x))/(9*d) - ((3*c + 4*b*d + 6*a*d^2)*x^2*log(1 - d*x))/(48*d^2) - (2/27)*b*x^3*log(1 - d*x) - (c*x^3*log(1 - d*x))/(24*d) - ((3*c + 4*b*d)*x^3*log(1 - d*x))/(108*d) - (3/64)*c*x^4*log(1 - d*x) + (c*(1 - d*x)*log(1 - d*x))/(8*d^4) + (2*b*(1 - d*x)*log(1 - d*x))/(9*d^3) + (a*(1 - d*x)*log(1 - d*x))/d^2 + ((3*c + 4*b*d + 6*a*d^2)*(1 - d*x)*log(1 - d*x))/(12*d^4) - (a*(1 - d*x)^2*log(1 - d*x))/(4*d^2) - (c*log(1 - d*x)^2)/(16*d^4) - (b*log(1 - d*x)^2)/(9*d^3) + (1/9)*b*x^3*log(1 - d*x)^2 + (1/16)*c*x^4*log(1 - d*x)^2 - (a*(1 - d*x)*log(1 - d*x)^2)/(2*d^2) + (a*(1 - d*x)^2*log(1 - d*x)^2)/(4*d^2) - ((3*c + 4*b*d + 6*a*d^2)*log(d*x)*log(1 - d*x)^2)/(12*d^4) - ((3*c + 4*b*d + 6*a*d^2)*x*PolyLog(2, d*x))/(12*d^3) - ((3*c + 4*b*d + 6*a*d^2)*x^2*PolyLog(2, d*x))/(24*d^2) - ((3*c + 4*b*d)*x^3*PolyLog(2, d*x))/(36*d) - (1/16)*c*x^4*PolyLog(2, d*x) - ((3*c + 4*b*d + 6*a*d^2)*log(1 - d*x)*PolyLog(2, d*x))/(12*d^4) + (1/12)*(6*a*x^2 + 4*b*x^3 + 3*c*x^4)*log(1 - d*x)*PolyLog(2, d*x) - ((3*c + 4*b*d + 6*a*d^2)*log(1 - d*x)*PolyLog(2, 1 - d*x))/(6*d^4) + ((3*c + 4*b*d + 6*a*d^2)*PolyLog(3, 1 - d*x))/(6*d^4)]
@test_int [x^0*(a + b*x + c*x^2)*log(1 - d*x)*PolyLog(2, d*x), x, 43, 2*a*x + (4*c*x)/(9*d^2) + (b*x)/d + ((2*c + 3*b*d)*x)/(24*d^2) + ((2*c + 3*d*(b + 2*a*d))*x)/(6*d^2) + (c*x^2)/(9*d) + ((2*c + 3*b*d)*x^2)/(48*d) + (c*x^3)/27 + (b*(1 - d*x)^2)/(8*d^2) + (2*c*log(1 - d*x))/(9*d^3) + ((2*c + 3*b*d)*log(1 - d*x))/(24*d^3) - (c*x^2*log(1 - d*x))/(9*d) - ((2*c + 3*b*d)*x^2*log(1 - d*x))/(24*d) - (1/9)*c*x^3*log(1 - d*x) + (2*c*(1 - d*x)*log(1 - d*x))/(9*d^3) + (b*(1 - d*x)*log(1 - d*x))/d^2 + (2*a*(1 - d*x)*log(1 - d*x))/d + ((2*c + 3*d*(b + 2*a*d))*(1 - d*x)*log(1 - d*x))/(6*d^3) - (b*(1 - d*x)^2*log(1 - d*x))/(4*d^2) - (c*log(1 - d*x)^2)/(9*d^3) + (1/9)*c*x^3*log(1 - d*x)^2 - (b*(1 - d*x)*log(1 - d*x)^2)/(2*d^2) - (a*(1 - d*x)*log(1 - d*x)^2)/d + (b*(1 - d*x)^2*log(1 - d*x)^2)/(4*d^2) - ((2*c + 3*d*(b + 2*a*d))*log(d*x)*log(1 - d*x)^2)/(6*d^3) - ((2*c + 3*d*(b + 2*a*d))*x*PolyLog(2, d*x))/(6*d^2) - ((2*c + 3*b*d)*x^2*PolyLog(2, d*x))/(12*d) - (1/9)*c*x^3*PolyLog(2, d*x) - ((2*c + 3*d*(b + 2*a*d))*log(1 - d*x)*PolyLog(2, d*x))/(6*d^3) + (1/6)*(6*a*x + 3*b*x^2 + 2*c*x^3)*log(1 - d*x)*PolyLog(2, d*x) - ((2*c + 3*d*(b + 2*a*d))*log(1 - d*x)*PolyLog(2, 1 - d*x))/(3*d^3) + ((2*c + 3*d*(b + 2*a*d))*PolyLog(3, 1 - d*x))/(3*d^3)]
@test_int [(a + b*x + c*x^2)*log(1 - d*x)*PolyLog(2, d*x)/x^1, x, 29, 2*b*x + (9*c*x)/(8*d) + ((c + 2*b*d)*x)/(2*d) + (c*x^2)/16 + (c*(1 - d*x)^2)/(8*d^2) + (c*log(1 - d*x))/(8*d^2) - (1/8)*c*x^2*log(1 - d*x) + (c*(1 - d*x)*log(1 - d*x))/d^2 + (2*b*(1 - d*x)*log(1 - d*x))/d + ((c + 2*b*d)*(1 - d*x)*log(1 - d*x))/(2*d^2) - (c*(1 - d*x)^2*log(1 - d*x))/(4*d^2) - (c*(1 - d*x)*log(1 - d*x)^2)/(2*d^2) - (b*(1 - d*x)*log(1 - d*x)^2)/d + (c*(1 - d*x)^2*log(1 - d*x)^2)/(4*d^2) - ((c + 2*b*d)*log(d*x)*log(1 - d*x)^2)/(2*d^2) - ((c + 2*b*d)*x*PolyLog(2, d*x))/(2*d) - (1/4)*c*x^2*PolyLog(2, d*x) - ((c + 2*b*d)*log(1 - d*x)*PolyLog(2, d*x))/(2*d^2) + (1/2)*(2*b*x + c*x^2)*log(1 - d*x)*PolyLog(2, d*x) - (1/2)*a*PolyLog(2, d*x)^2 - ((c + 2*b*d)*log(1 - d*x)*PolyLog(2, 1 - d*x))/d^2 + ((c + 2*b*d)*PolyLog(3, 1 - d*x))/d^2]
@test_int [(a + b*x + c*x^2)*log(1 - d*x)*PolyLog(2, d*x)/x^2, x, 19, 3*c*x + (3*c*(1 - d*x)*log(1 - d*x))/d - (c*(1 - d*x)*log(1 - d*x)^2)/d + (a*(1 - d*x)*log(1 - d*x)^2)/x + (a - c/d^2)*d*log(d*x)*log(1 - d*x)^2 - 2*a*d*PolyLog(2, d*x) - c*x*PolyLog(2, d*x) + (a - c/d^2)*d*log(1 - d*x)*PolyLog(2, d*x) - (a/x - c*x)*log(1 - d*x)*PolyLog(2, d*x) - (1/2)*b*PolyLog(2, d*x)^2 + 2*(a - c/d^2)*d*log(1 - d*x)*PolyLog(2, 1 - d*x) - a*d*PolyLog(3, d*x) - 2*(a - c/d^2)*d*PolyLog(3, 1 - d*x)]
@test_int [(a + b*x + c*x^2)*log(1 - d*x)*PolyLog(2, d*x)/x^3, x, 32, (-a)*d^2*log(x) + a*d^2*log(1 - d*x) - (a*d*log(1 - d*x))/x - (1/4)*a*d^2*log(1 - d*x)^2 + (a*log(1 - d*x)^2)/(4*x^2) + (b*(1 - d*x)*log(1 - d*x)^2)/x - (b^2*log(d*x)*log(1 - d*x)^2)/(2*a) + ((b + a*d)^2*log(d*x)*log(1 - d*x)^2)/(2*a) - 2*b*d*PolyLog(2, d*x) - (1/2)*a*d^2*PolyLog(2, d*x) + (a*d*PolyLog(2, d*x))/(2*x) + ((b + a*d)^2*log(1 - d*x)*PolyLog(2, d*x))/(2*a) - ((a + b*x)^2*log(1 - d*x)*PolyLog(2, d*x))/(2*a*x^2) - (1/2)*c*PolyLog(2, d*x)^2 - (b^2*log(1 - d*x)*PolyLog(2, 1 - d*x))/a + ((b + a*d)^2*log(1 - d*x)*PolyLog(2, 1 - d*x))/a - (1/2)*d*(2*b + a*d)*PolyLog(3, d*x) + (b^2*PolyLog(3, 1 - d*x))/a - ((b + a*d)^2*PolyLog(3, 1 - d*x))/a]
@test_int [(a + b*x + c*x^2)*log(1 - d*x)*PolyLog(2, d*x)/x^4, x, 43, (7*a*d^2)/(36*x) - (1/2)*b*d^2*log(x) - (5/12)*a*d^3*log(x) - (1/6)*d^2*(3*b + 2*a*d)*log(x) + (1/2)*b*d^2*log(1 - d*x) + (5/12)*a*d^3*log(1 - d*x) + (1/6)*d^2*(3*b + 2*a*d)*log(1 - d*x) - (7*a*d*log(1 - d*x))/(36*x^2) - (b*d*log(1 - d*x))/(2*x) - (2*a*d^2*log(1 - d*x))/(9*x) - (d*(3*b + 2*a*d)*log(1 - d*x))/(6*x) - (1/4)*b*d^2*log(1 - d*x)^2 - (1/9)*a*d^3*log(1 - d*x)^2 + (a*log(1 - d*x)^2)/(9*x^3) + (b*log(1 - d*x)^2)/(4*x^2) + (c*(1 - d*x)*log(1 - d*x)^2)/x + (1/6)*d*(6*c + d*(3*b + 2*a*d))*log(d*x)*log(1 - d*x)^2 - 2*c*d*PolyLog(2, d*x) - (1/2)*b*d^2*PolyLog(2, d*x) - (2/9)*a*d^3*PolyLog(2, d*x) + (a*d*PolyLog(2, d*x))/(6*x^2) + (d*(3*b + 2*a*d)*PolyLog(2, d*x))/(6*x) + (1/6)*d*(6*c + d*(3*b + 2*a*d))*log(1 - d*x)*PolyLog(2, d*x) - (1/6)*((2*a)/x^3 + (3*b)/x^2 + (6*c)/x)*log(1 - d*x)*PolyLog(2, d*x) + (1/3)*d*(6*c + d*(3*b + 2*a*d))*log(1 - d*x)*PolyLog(2, 1 - d*x) - (1/6)*d*(6*c + d*(3*b + 2*a*d))*PolyLog(3, d*x) - (1/3)*d*(6*c + d*(3*b + 2*a*d))*PolyLog(3, 1 - d*x)]
@test_int [(a + b*x + c*x^2)*log(1 - d*x)*PolyLog(2, d*x)/x^5, x, 61, (5*a*d^2)/(144*x^2) + (b*d^2)/(9*x) + (19*a*d^3)/(144*x) + (d^2*(4*b + 3*a*d))/(48*x) - (1/2)*c*d^2*log(x) - (1/3)*b*d^3*log(x) - (37/144)*a*d^4*log(x) - (1/48)*d^3*(4*b + 3*a*d)*log(x) - (1/12)*d^2*(6*c + d*(4*b + 3*a*d))*log(x) + (1/2)*c*d^2*log(1 - d*x) + (1/3)*b*d^3*log(1 - d*x) + (37/144)*a*d^4*log(1 - d*x) + (1/48)*d^3*(4*b + 3*a*d)*log(1 - d*x) + (1/12)*d^2*(6*c + d*(4*b + 3*a*d))*log(1 - d*x) - (5*a*d*log(1 - d*x))/(72*x^3) - (b*d*log(1 - d*x))/(9*x^2) - (a*d^2*log(1 - d*x))/(16*x^2) - (d*(4*b + 3*a*d)*log(1 - d*x))/(48*x^2) - (c*d*log(1 - d*x))/(2*x) - (2*b*d^2*log(1 - d*x))/(9*x) - (a*d^3*log(1 - d*x))/(8*x) - (d*(6*c + d*(4*b + 3*a*d))*log(1 - d*x))/(12*x) - (1/4)*c*d^2*log(1 - d*x)^2 - (1/9)*b*d^3*log(1 - d*x)^2 - (1/16)*a*d^4*log(1 - d*x)^2 + (a*log(1 - d*x)^2)/(16*x^4) + (b*log(1 - d*x)^2)/(9*x^3) + (c*log(1 - d*x)^2)/(4*x^2) + (1/12)*d^2*(6*c + d*(4*b + 3*a*d))*log(d*x)*log(1 - d*x)^2 - (1/2)*c*d^2*PolyLog(2, d*x) - (2/9)*b*d^3*PolyLog(2, d*x) - (1/8)*a*d^4*PolyLog(2, d*x) + (a*d*PolyLog(2, d*x))/(12*x^3) + (d*(4*b + 3*a*d)*PolyLog(2, d*x))/(24*x^2) + (d*(6*c + d*(4*b + 3*a*d))*PolyLog(2, d*x))/(12*x) + (1/12)*d^2*(6*c + d*(4*b + 3*a*d))*log(1 - d*x)*PolyLog(2, d*x) - (1/12)*((3*a)/x^4 + (4*b)/x^3 + (6*c)/x^2)*log(1 - d*x)*PolyLog(2, d*x) + (1/6)*d^2*(6*c + d*(4*b + 3*a*d))*log(1 - d*x)*PolyLog(2, 1 - d*x) - (1/12)*d^2*(6*c + d*(4*b + 3*a*d))*PolyLog(3, d*x) - (1/6)*d^2*(6*c + d*(4*b + 3*a*d))*PolyLog(3, 1 - d*x)]
end
| [
31,
9288,
2617,
366,
23,
13,
23,
12280,
6404,
283,
342,
76,
2163,
1,
2221,
198,
220,
220,
220,
357,
37,
11,
257,
11,
275,
11,
269,
11,
288,
11,
304,
11,
277,
11,
308,
11,
289,
11,
285,
11,
299,
11,
279,
11,
10662,
11,
2124,
11,
1267,
796,
2488,
25641,
2977,
376,
257,
275,
269,
288,
304,
277,
308,
289,
285,
299,
279,
10662,
2124,
628,
220,
220,
220,
1303,
28,
7904,
27813,
3712,
796,
2,
628,
220,
220,
220,
1303,
28,
7904,
19160,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
1358,
9,
2964,
22143,
9,
818,
10396,
1075,
9,
1169,
9,
34220,
6404,
283,
342,
76,
9,
22203,
46249,
628,
198,
220,
220,
220,
1303,
28,
7904,
16375,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
7,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
8,
46249,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
87,
61,
76,
9,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
8,
46249,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
7266,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
80,
28,
16,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
19,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
828,
2124,
11,
604,
11,
532,
7,
87,
29006,
1495,
9,
64,
61,
19,
4008,
532,
2124,
61,
17,
29006,
1120,
9,
64,
61,
18,
8,
532,
2124,
61,
18,
29006,
2425,
9,
64,
61,
17,
8,
532,
2124,
61,
19,
29006,
3064,
9,
64,
8,
532,
2124,
61,
20,
14,
11623,
532,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
1495,
9,
64,
61,
20,
8,
1343,
357,
16,
14,
1495,
27493,
87,
61,
20,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
1343,
357,
16,
14,
20,
27493,
87,
61,
20,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
828,
2124,
11,
604,
11,
532,
7,
87,
29006,
1433,
9,
64,
61,
18,
4008,
532,
2124,
61,
17,
29006,
2624,
9,
64,
61,
17,
8,
532,
2124,
61,
18,
29006,
2780,
9,
64,
8,
532,
2124,
61,
19,
14,
2414,
532,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
1433,
9,
64,
61,
19,
8,
1343,
357,
16,
14,
1433,
27493,
87,
61,
19,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
1343,
357,
16,
14,
19,
27493,
87,
61,
19,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
828,
2124,
11,
604,
11,
532,
7,
87,
29006,
24,
9,
64,
61,
17,
4008,
532,
2124,
61,
17,
29006,
1507,
9,
64,
8,
532,
2124,
61,
18,
14,
1983,
532,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
24,
9,
64,
61,
18,
8,
1343,
357,
16,
14,
24,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
1343,
357,
16,
14,
18,
27493,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
828,
2124,
11,
604,
11,
532,
7,
87,
29006,
19,
9,
64,
4008,
532,
2124,
61,
17,
14,
23,
532,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
19,
9,
64,
61,
17,
8,
1343,
357,
16,
14,
19,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
1343,
357,
16,
14,
17,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
828,
2124,
11,
513,
11,
532,
87,
532,
14808,
16,
532,
257,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
14,
64,
1343,
2124,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
20679,
87,
61,
16,
11,
2124,
11,
352,
11,
12280,
11187,
7,
18,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
20679,
87,
61,
17,
11,
2124,
11,
642,
11,
257,
9,
6404,
7,
87,
8,
532,
257,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
20679,
87,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
20679,
87,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
20679,
87,
61,
18,
11,
2124,
11,
604,
11,
532,
7,
64,
29006,
19,
9,
87,
4008,
1343,
357,
16,
14,
19,
27493,
64,
61,
17,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
19,
27493,
64,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
19,
9,
87,
61,
17,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
20679,
7,
17,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
20679,
87,
61,
19,
11,
2124,
11,
604,
11,
532,
7,
64,
29006,
1507,
9,
87,
61,
17,
4008,
532,
257,
61,
17,
29006,
24,
9,
87,
8,
1343,
357,
16,
14,
24,
27493,
64,
61,
18,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
24,
27493,
64,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
24,
9,
87,
61,
18,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
20679,
7,
18,
9,
87,
61,
18,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
20679,
87,
61,
20,
11,
2124,
11,
604,
11,
532,
7,
64,
29006,
2780,
9,
87,
61,
18,
4008,
532,
257,
61,
17,
29006,
2624,
9,
87,
61,
17,
8,
532,
257,
61,
18,
29006,
1433,
9,
87,
8,
1343,
357,
16,
14,
1433,
27493,
64,
61,
19,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
1433,
27493,
64,
61,
19,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
1433,
9,
87,
61,
19,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
20679,
7,
19,
9,
87,
61,
19,
15437,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
18,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
828,
2124,
11,
642,
11,
2124,
29006,
2414,
9,
64,
61,
18,
8,
1343,
2124,
61,
17,
29006,
12762,
9,
64,
61,
17,
8,
1343,
2124,
61,
18,
29006,
17477,
9,
64,
8,
1343,
2124,
61,
19,
14,
11645,
1343,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
2414,
9,
64,
61,
19,
8,
532,
357,
16,
14,
2414,
27493,
87,
61,
19,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
532,
357,
16,
14,
1433,
27493,
87,
61,
19,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
8,
1343,
357,
16,
14,
19,
27493,
87,
61,
19,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
828,
2124,
11,
642,
11,
2124,
29006,
1983,
9,
64,
61,
17,
8,
1343,
2124,
61,
17,
29006,
4051,
9,
64,
8,
1343,
2124,
61,
18,
14,
6659,
1343,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
1983,
9,
64,
61,
18,
8,
532,
357,
16,
14,
1983,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
532,
357,
16,
14,
24,
27493,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
8,
1343,
357,
16,
14,
18,
27493,
87,
61,
18,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
828,
2124,
11,
642,
11,
2124,
29006,
23,
9,
64,
8,
1343,
2124,
61,
17,
14,
1433,
1343,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
23,
9,
64,
61,
17,
8,
532,
357,
16,
14,
23,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
532,
357,
16,
14,
19,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
8,
1343,
357,
16,
14,
17,
27493,
87,
61,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
828,
2124,
11,
604,
11,
2124,
1343,
14808,
16,
532,
257,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
14,
64,
532,
2124,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
8,
1343,
2124,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
20679,
87,
61,
16,
11,
2124,
11,
352,
11,
12280,
11187,
7,
19,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
20679,
87,
61,
17,
11,
2124,
11,
718,
11,
257,
9,
6404,
7,
87,
8,
532,
257,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
20679,
87,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
20679,
87,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
20679,
87,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
20679,
87,
61,
18,
11,
2124,
11,
642,
11,
532,
7,
64,
29006,
23,
9,
87,
4008,
1343,
357,
16,
14,
23,
27493,
64,
61,
17,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
23,
27493,
64,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
23,
9,
87,
61,
17,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
20679,
7,
19,
9,
87,
61,
17,
8,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
20679,
7,
17,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
20679,
87,
61,
19,
11,
2124,
11,
642,
11,
532,
7,
64,
29006,
4051,
9,
87,
61,
17,
4008,
532,
257,
61,
17,
29006,
1983,
9,
87,
8,
1343,
357,
16,
14,
1983,
27493,
64,
61,
18,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
1983,
27493,
64,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
87,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
20679,
7,
1983,
9,
87,
61,
18,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
20679,
7,
24,
9,
87,
61,
18,
8,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
20679,
7,
18,
9,
87,
61,
18,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
7266,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
80,
28,
17,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
20,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
642,
11,
532,
7,
87,
61,
17,
29006,
1507,
9,
64,
61,
17,
4008,
532,
2124,
61,
19,
29006,
2623,
9,
64,
8,
532,
2124,
61,
21,
14,
4051,
532,
2604,
7,
16,
532,
257,
9,
87,
61,
17,
20679,
7,
1507,
9,
64,
61,
18,
8,
1343,
357,
16,
14,
1507,
27493,
87,
61,
21,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
21,
27493,
87,
61,
21,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
642,
11,
532,
7,
87,
61,
17,
29006,
23,
9,
64,
4008,
532,
2124,
61,
19,
14,
1433,
532,
2604,
7,
16,
532,
257,
9,
87,
61,
17,
20679,
7,
23,
9,
64,
61,
17,
8,
1343,
357,
16,
14,
23,
27493,
87,
61,
19,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
19,
27493,
87,
61,
19,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
604,
11,
532,
7,
87,
61,
17,
14,
17,
8,
532,
14808,
16,
532,
257,
9,
87,
61,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
17,
9,
64,
8,
1343,
357,
16,
14,
17,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
16,
11,
2124,
11,
352,
11,
357,
16,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
18,
11,
2124,
11,
718,
11,
257,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
17,
27493,
64,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
61,
17,
20679,
7,
17,
9,
87,
61,
17,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
17,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
20,
11,
2124,
11,
642,
11,
532,
7,
64,
29006,
23,
9,
87,
61,
17,
4008,
1343,
357,
16,
14,
19,
27493,
64,
61,
17,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
23,
27493,
64,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
61,
17,
20679,
7,
23,
9,
87,
61,
19,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
19,
9,
87,
61,
19,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
22,
11,
2124,
11,
642,
11,
532,
7,
64,
29006,
2623,
9,
87,
61,
19,
4008,
532,
257,
61,
17,
29006,
1507,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
24,
27493,
64,
61,
18,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
1507,
27493,
64,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
61,
17,
20679,
7,
1507,
9,
87,
61,
21,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
21,
9,
87,
61,
21,
15437,
628,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
19,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
642,
11,
532,
19510,
19,
9,
87,
20679,
7,
1495,
9,
64,
61,
17,
4008,
532,
357,
19,
9,
87,
61,
18,
20679,
7,
2425,
9,
64,
8,
532,
357,
19,
9,
87,
61,
20,
20679,
11623,
1343,
357,
19,
9,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
4008,
29006,
1495,
9,
64,
61,
7,
20,
14,
17,
4008,
1343,
357,
17,
14,
1495,
27493,
87,
61,
20,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
20,
27493,
87,
61,
20,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
642,
11,
532,
19510,
19,
9,
87,
20679,
7,
24,
9,
64,
4008,
532,
357,
19,
9,
87,
61,
18,
20679,
1983,
1343,
357,
19,
9,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
4008,
29006,
24,
9,
64,
61,
7,
18,
14,
17,
4008,
1343,
357,
17,
14,
24,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
18,
27493,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
604,
11,
532,
19,
9,
87,
1343,
357,
19,
9,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
4008,
14,
31166,
17034,
7,
64,
8,
1343,
362,
9,
87,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
1343,
2124,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
17,
11,
2124,
11,
513,
11,
604,
9,
31166,
17034,
7,
64,
27493,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
8,
1343,
357,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
14,
87,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
87,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
19,
11,
2124,
11,
604,
11,
532,
19510,
19,
9,
64,
20679,
7,
24,
9,
87,
4008,
1343,
357,
19,
14,
24,
27493,
64,
61,
7,
18,
14,
17,
27493,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
8,
1343,
357,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
24,
9,
87,
61,
18,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
18,
9,
87,
61,
18,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
21,
11,
2124,
11,
642,
11,
532,
19510,
19,
9,
64,
20679,
7,
2425,
9,
87,
61,
18,
4008,
532,
357,
19,
9,
64,
61,
17,
20679,
7,
1495,
9,
87,
8,
1343,
357,
19,
14,
1495,
27493,
64,
61,
7,
20,
14,
17,
27493,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
8,
1343,
357,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
1495,
9,
87,
61,
20,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
20,
9,
87,
61,
20,
15437,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
20,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
718,
11,
2124,
61,
17,
29006,
4051,
9,
64,
61,
17,
8,
1343,
2124,
61,
19,
29006,
15711,
9,
64,
8,
1343,
2124,
61,
21,
14,
25061,
1343,
2604,
7,
16,
532,
257,
9,
87,
61,
17,
20679,
7,
4051,
9,
64,
61,
18,
8,
532,
357,
16,
14,
4051,
27493,
87,
61,
21,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
532,
357,
16,
14,
1507,
27493,
87,
61,
21,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
21,
27493,
87,
61,
21,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
18,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
718,
11,
2124,
61,
17,
29006,
1433,
9,
64,
8,
1343,
2124,
61,
19,
14,
2624,
1343,
2604,
7,
16,
532,
257,
9,
87,
61,
17,
20679,
7,
1433,
9,
64,
61,
17,
8,
532,
357,
16,
14,
1433,
27493,
87,
61,
19,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
532,
357,
16,
14,
23,
27493,
87,
61,
19,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
19,
27493,
87,
61,
19,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
642,
11,
2124,
61,
17,
14,
17,
1343,
14808,
16,
532,
257,
9,
87,
61,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
17,
9,
64,
8,
532,
357,
16,
14,
17,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
17,
27493,
87,
61,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
16,
11,
2124,
11,
352,
11,
357,
16,
14,
17,
27493,
34220,
11187,
7,
19,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
18,
11,
2124,
11,
767,
11,
257,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
17,
27493,
64,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
61,
17,
20679,
7,
17,
9,
87,
61,
17,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
17,
9,
87,
61,
17,
8,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
7,
17,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
20,
11,
2124,
11,
718,
11,
532,
7,
64,
29006,
1433,
9,
87,
61,
17,
4008,
1343,
357,
16,
14,
23,
27493,
64,
61,
17,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
1433,
27493,
64,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
61,
17,
20679,
7,
1433,
9,
87,
61,
19,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
23,
9,
87,
61,
19,
8,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
7,
19,
9,
87,
61,
19,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
22,
11,
2124,
11,
718,
11,
532,
7,
64,
29006,
15711,
9,
87,
61,
19,
4008,
532,
257,
61,
17,
29006,
4051,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
1983,
27493,
64,
61,
18,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
4051,
27493,
64,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
1343,
2604,
7,
16,
532,
257,
9,
87,
61,
17,
20679,
7,
4051,
9,
87,
61,
21,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
1507,
9,
87,
61,
21,
8,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
7,
21,
9,
87,
61,
21,
15437,
628,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
19,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
718,
11,
357,
23,
9,
87,
20679,
7,
11623,
9,
64,
61,
17,
8,
1343,
357,
23,
9,
87,
61,
18,
20679,
7,
22318,
9,
64,
8,
1343,
357,
23,
9,
87,
61,
20,
20679,
26704,
532,
357,
23,
9,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
4008,
29006,
11623,
9,
64,
61,
7,
20,
14,
17,
4008,
532,
357,
19,
14,
11623,
27493,
87,
61,
20,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
532,
357,
17,
14,
1495,
27493,
87,
61,
20,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
20,
27493,
87,
61,
20,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
718,
11,
357,
23,
9,
87,
20679,
7,
1983,
9,
64,
8,
1343,
357,
23,
9,
87,
61,
18,
20679,
6659,
532,
357,
23,
9,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
4008,
29006,
1983,
9,
64,
61,
7,
18,
14,
17,
4008,
532,
357,
19,
14,
1983,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
532,
357,
17,
14,
24,
27493,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
18,
27493,
87,
61,
18,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
642,
11,
807,
9,
87,
532,
357,
23,
9,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
4008,
14,
31166,
17034,
7,
64,
8,
532,
604,
9,
87,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
8,
532,
362,
9,
87,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
8,
1343,
2124,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
17,
11,
2124,
11,
604,
11,
807,
9,
31166,
17034,
7,
64,
27493,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
8,
1343,
357,
19,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
14,
87,
532,
357,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
14,
87,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
87,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
19,
11,
2124,
11,
642,
11,
532,
19510,
23,
9,
64,
20679,
7,
1983,
9,
87,
4008,
1343,
357,
23,
14,
1983,
27493,
64,
61,
7,
18,
14,
17,
27493,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
8,
1343,
357,
19,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
1983,
9,
87,
61,
18,
8,
532,
357,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
24,
9,
87,
61,
18,
8,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
7,
18,
9,
87,
61,
18,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
87,
61,
21,
11,
2124,
11,
718,
11,
532,
19510,
23,
9,
64,
20679,
7,
22318,
9,
87,
61,
18,
4008,
532,
357,
23,
9,
64,
61,
17,
20679,
7,
11623,
9,
87,
8,
1343,
357,
23,
14,
11623,
27493,
64,
61,
7,
20,
14,
17,
27493,
39036,
71,
7,
31166,
17034,
7,
64,
27493,
87,
8,
1343,
357,
19,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
11623,
9,
87,
61,
20,
8,
532,
357,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
1495,
9,
87,
61,
20,
8,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
7,
20,
9,
87,
61,
20,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
7266,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
80,
9,
1837,
2022,
4160,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
513,
11,
357,
64,
9,
80,
61,
17,
9,
87,
61,
7,
18,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
18,
1343,
10662,
20679,
80,
11,
362,
1343,
513,
14,
80,
11,
257,
9,
87,
61,
80,
4008,
29006,
24,
9,
7,
18,
1343,
10662,
4008,
1343,
357,
16,
14,
24,
27493,
80,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
8,
1343,
357,
16,
14,
18,
27493,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
513,
11,
357,
64,
9,
80,
61,
17,
9,
87,
61,
7,
17,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
17,
1343,
10662,
20679,
80,
11,
362,
9,
7,
16,
1343,
352,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
19,
9,
7,
17,
1343,
10662,
4008,
1343,
357,
16,
14,
19,
27493,
80,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
8,
1343,
357,
16,
14,
17,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
513,
11,
357,
64,
9,
80,
61,
17,
9,
87,
61,
7,
16,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
352,
1343,
352,
14,
80,
11,
362,
1343,
352,
14,
80,
11,
257,
9,
87,
61,
80,
4008,
29006,
16,
1343,
10662,
8,
1343,
10662,
9,
87,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
8,
1343,
2124,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
16,
11,
2124,
11,
352,
11,
12280,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
20679,
80,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
17,
11,
2124,
11,
513,
11,
532,
19510,
64,
9,
80,
61,
17,
9,
87,
61,
32590,
16,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
532,
19510,
16,
532,
10662,
20679,
80,
828,
362,
532,
352,
14,
80,
11,
257,
9,
87,
61,
80,
4008,
29006,
16,
532,
10662,
4008,
1343,
357,
80,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
14,
87,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
20679,
87,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
18,
11,
2124,
11,
513,
11,
532,
19510,
64,
9,
80,
61,
17,
9,
87,
61,
32590,
17,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
532,
19510,
17,
532,
10662,
20679,
80,
828,
362,
9,
7,
16,
532,
352,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
19,
9,
7,
17,
532,
10662,
22305,
1343,
357,
80,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
19,
9,
87,
61,
17,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
20679,
7,
17,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
19,
11,
2124,
11,
513,
11,
532,
19510,
64,
9,
80,
61,
17,
9,
87,
61,
32590,
18,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
532,
19510,
18,
532,
10662,
20679,
80,
828,
362,
532,
513,
14,
80,
11,
257,
9,
87,
61,
80,
4008,
29006,
24,
9,
7,
18,
532,
10662,
22305,
1343,
357,
80,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
24,
9,
87,
61,
18,
8,
532,
12280,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
20679,
7,
18,
9,
87,
61,
18,
15437,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
604,
11,
532,
19510,
64,
9,
80,
61,
18,
9,
87,
61,
7,
18,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
18,
1343,
10662,
20679,
80,
11,
362,
1343,
513,
14,
80,
11,
257,
9,
87,
61,
80,
4008,
29006,
1983,
9,
7,
18,
1343,
10662,
22305,
532,
357,
16,
14,
1983,
27493,
80,
61,
17,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
8,
532,
357,
16,
14,
24,
27493,
80,
9,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
8,
1343,
357,
16,
14,
18,
27493,
87,
61,
18,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
604,
11,
532,
19510,
64,
9,
80,
61,
18,
9,
87,
61,
7,
17,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
17,
1343,
10662,
20679,
80,
11,
362,
9,
7,
16,
1343,
352,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
23,
9,
7,
17,
1343,
10662,
22305,
532,
357,
16,
14,
23,
27493,
80,
61,
17,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
8,
532,
357,
16,
14,
19,
27493,
80,
9,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
8,
1343,
357,
16,
14,
17,
27493,
87,
61,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
604,
11,
532,
19510,
64,
9,
80,
61,
18,
9,
87,
61,
7,
16,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
352,
1343,
352,
14,
80,
11,
362,
1343,
352,
14,
80,
11,
257,
9,
87,
61,
80,
4008,
29006,
16,
1343,
10662,
4008,
532,
10662,
61,
17,
9,
87,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
8,
532,
10662,
9,
87,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
8,
1343,
2124,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
16,
11,
2124,
11,
352,
11,
12280,
11187,
7,
19,
11,
257,
9,
87,
61,
80,
20679,
80,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
17,
11,
2124,
11,
604,
11,
532,
19510,
64,
9,
80,
61,
18,
9,
87,
61,
32590,
16,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
532,
19510,
16,
532,
10662,
20679,
80,
828,
362,
532,
352,
14,
80,
11,
257,
9,
87,
61,
80,
4008,
29006,
16,
532,
10662,
4008,
1343,
357,
80,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
14,
87,
532,
357,
80,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
14,
87,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
20679,
87,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
18,
11,
2124,
11,
604,
11,
532,
19510,
64,
9,
80,
61,
18,
9,
87,
61,
32590,
17,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
532,
19510,
17,
532,
10662,
20679,
80,
828,
362,
9,
7,
16,
532,
352,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
23,
9,
7,
17,
532,
10662,
22305,
1343,
357,
80,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
23,
9,
87,
61,
17,
8,
532,
357,
80,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
19,
9,
87,
61,
17,
8,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
20679,
7,
17,
9,
87,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
19,
11,
2124,
11,
604,
11,
532,
19510,
64,
9,
80,
61,
18,
9,
87,
61,
32590,
18,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
532,
19510,
18,
532,
10662,
20679,
80,
828,
362,
532,
513,
14,
80,
11,
257,
9,
87,
61,
80,
4008,
29006,
1983,
9,
7,
18,
532,
10662,
22305,
1343,
357,
80,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
1983,
9,
87,
61,
18,
8,
532,
357,
80,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
24,
9,
87,
61,
18,
8,
532,
12280,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
20679,
7,
18,
9,
87,
61,
18,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
7,
67,
9,
87,
8,
61,
7,
76,
14,
17,
27493,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
8,
46249,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
7266,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
80,
28,
16,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
828,
2124,
11,
767,
11,
532,
19510,
23,
9,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
29006,
1495,
9,
64,
61,
17,
4008,
532,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
29006,
2425,
9,
64,
8,
532,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
29006,
11623,
9,
67,
8,
1343,
357,
23,
9,
67,
61,
7,
18,
14,
17,
27493,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1495,
9,
64,
61,
7,
20,
14,
17,
4008,
1343,
357,
19,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
1495,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
20,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
16,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
828,
2124,
11,
718,
11,
532,
19510,
23,
9,
31166,
17034,
7,
67,
9,
87,
4008,
29006,
24,
9,
64,
4008,
532,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
29006,
1983,
9,
67,
8,
1343,
357,
23,
9,
31166,
17034,
7,
67,
27493,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
24,
9,
64,
61,
7,
18,
14,
17,
4008,
1343,
357,
19,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
24,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
18,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
20679,
7,
67,
9,
87,
8,
61,
7,
16,
14,
17,
828,
2124,
11,
642,
11,
532,
19510,
23,
9,
31166,
17034,
7,
67,
9,
87,
4008,
14,
67,
8,
1343,
357,
23,
9,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
4008,
1343,
357,
19,
9,
31166,
17034,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
14,
67,
1343,
357,
17,
9,
31166,
17034,
7,
67,
9,
87,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
14,
67,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
20679,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
828,
2124,
11,
604,
11,
357,
23,
9,
31166,
17034,
7,
64,
27493,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
67,
61,
7,
18,
14,
17,
8,
1343,
357,
19,
9,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
532,
357,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
20679,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
828,
2124,
11,
642,
11,
532,
19510,
23,
9,
64,
20679,
7,
24,
9,
67,
61,
17,
9,
31166,
17034,
7,
67,
9,
87,
22305,
1343,
357,
23,
9,
64,
61,
7,
18,
14,
17,
27493,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
24,
9,
67,
61,
7,
20,
14,
17,
4008,
1343,
357,
19,
9,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
24,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
532,
357,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
18,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
20679,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
828,
2124,
11,
718,
11,
532,
19510,
23,
9,
64,
20679,
7,
2425,
9,
67,
61,
17,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
22305,
532,
357,
23,
9,
64,
61,
17,
20679,
7,
1495,
9,
67,
61,
18,
9,
31166,
17034,
7,
67,
9,
87,
4008,
1343,
357,
23,
9,
64,
61,
7,
20,
14,
17,
27493,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1495,
9,
67,
61,
7,
22,
14,
17,
4008,
1343,
357,
19,
9,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
1495,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
532,
357,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
20,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
60,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
828,
2124,
11,
860,
11,
357,
1433,
9,
67,
61,
17,
9,
31166,
17034,
7,
67,
9,
87,
4008,
29006,
32118,
9,
64,
61,
18,
8,
1343,
357,
1433,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
29006,
940,
1959,
9,
64,
61,
17,
8,
1343,
357,
1433,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
29006,
1558,
1314,
9,
64,
8,
1343,
357,
1433,
9,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
4008,
29006,
1731,
486,
9,
67,
8,
532,
357,
1433,
9,
67,
61,
7,
20,
14,
17,
27493,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
32118,
9,
64,
61,
7,
22,
14,
17,
4008,
532,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
32118,
9,
67,
8,
532,
357,
19,
9,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
2920,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
4008,
29006,
22,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
828,
2124,
11,
807,
11,
357,
1433,
9,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
29006,
11623,
9,
64,
61,
17,
8,
1343,
357,
1433,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
29006,
22318,
9,
64,
8,
1343,
357,
1433,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
29006,
26704,
9,
67,
8,
532,
357,
1433,
9,
67,
61,
7,
18,
14,
17,
27493,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
11623,
9,
64,
61,
7,
20,
14,
17,
4008,
532,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
11623,
9,
67,
8,
532,
357,
19,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
1495,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
4008,
29006,
20,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
16,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
828,
2124,
11,
767,
11,
357,
1433,
9,
31166,
17034,
7,
67,
9,
87,
4008,
29006,
1983,
9,
64,
8,
1343,
357,
1433,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
29006,
6659,
9,
67,
8,
532,
357,
1433,
9,
31166,
17034,
7,
67,
27493,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1983,
9,
64,
61,
7,
18,
14,
17,
4008,
532,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
1983,
9,
67,
8,
532,
357,
19,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
24,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
4008,
29006,
18,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
20679,
7,
67,
9,
87,
8,
61,
7,
16,
14,
17,
828,
2124,
11,
718,
11,
357,
1433,
9,
31166,
17034,
7,
67,
9,
87,
4008,
14,
67,
532,
357,
1433,
9,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
4008,
532,
357,
23,
9,
31166,
17034,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
14,
67,
532,
357,
19,
9,
31166,
17034,
7,
67,
9,
87,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
14,
67,
1343,
357,
17,
9,
31166,
17034,
7,
67,
9,
87,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
4008,
14,
67,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
20679,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
828,
2124,
11,
642,
11,
357,
1433,
9,
31166,
17034,
7,
64,
27493,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
67,
61,
7,
18,
14,
17,
8,
1343,
357,
23,
9,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
532,
357,
19,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
532,
357,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
20679,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
828,
2124,
11,
718,
11,
532,
19510,
1433,
9,
64,
20679,
7,
1983,
9,
67,
61,
17,
9,
31166,
17034,
7,
67,
9,
87,
22305,
1343,
357,
1433,
9,
64,
61,
7,
18,
14,
17,
27493,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1983,
9,
67,
61,
7,
20,
14,
17,
4008,
1343,
357,
23,
9,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
1983,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
532,
357,
19,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
24,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
532,
357,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
4008,
29006,
18,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
20679,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
828,
2124,
11,
767,
11,
532,
19510,
1433,
9,
64,
20679,
7,
22318,
9,
67,
61,
17,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
22305,
532,
357,
1433,
9,
64,
61,
17,
20679,
7,
11623,
9,
67,
61,
18,
9,
31166,
17034,
7,
67,
9,
87,
4008,
1343,
357,
1433,
9,
64,
61,
7,
20,
14,
17,
27493,
39036,
71,
19510,
31166,
17034,
7,
64,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
11623,
9,
67,
61,
7,
22,
14,
17,
4008,
1343,
357,
23,
9,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
11623,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
532,
357,
19,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
1495,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
532,
357,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
4008,
29006,
20,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
60,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
7266,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
80,
28,
17,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
860,
11,
532,
19510,
2624,
9,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
29006,
1495,
9,
64,
4008,
532,
357,
2624,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
29006,
11623,
9,
67,
8,
1343,
357,
1433,
9,
67,
61,
7,
18,
14,
17,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1495,
9,
64,
61,
7,
20,
14,
19,
4008,
1343,
357,
1433,
9,
67,
61,
7,
18,
14,
17,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1495,
9,
64,
61,
7,
20,
14,
19,
4008,
1343,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
1495,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
20,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
16,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
807,
11,
532,
19510,
2624,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
29006,
1983,
9,
67,
4008,
532,
357,
1433,
9,
31166,
17034,
7,
67,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
24,
9,
64,
61,
7,
18,
14,
19,
4008,
1343,
357,
1433,
9,
31166,
17034,
7,
67,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
24,
9,
64,
61,
7,
18,
14,
19,
4008,
1343,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
24,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
18,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
67,
9,
87,
8,
61,
7,
16,
14,
17,
828,
2124,
11,
807,
11,
532,
19510,
2624,
9,
31166,
17034,
7,
67,
9,
87,
4008,
14,
67,
8,
1343,
357,
1433,
9,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
4008,
1343,
357,
1433,
9,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
4008,
1343,
357,
23,
9,
31166,
17034,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
14,
67,
1343,
357,
17,
9,
31166,
17034,
7,
67,
9,
87,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
14,
67,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
828,
2124,
11,
767,
11,
532,
19510,
1433,
9,
64,
61,
7,
16,
14,
19,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
67,
61,
7,
18,
14,
17,
4008,
1343,
357,
1433,
9,
64,
61,
7,
16,
14,
19,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
67,
61,
7,
18,
14,
17,
8,
1343,
357,
23,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
532,
357,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
828,
2124,
11,
767,
11,
357,
1433,
9,
64,
61,
7,
18,
14,
19,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
24,
9,
67,
61,
7,
20,
14,
17,
4008,
1343,
357,
1433,
9,
64,
61,
7,
18,
14,
19,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
24,
9,
67,
61,
7,
20,
14,
17,
4008,
1343,
357,
23,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
24,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
532,
357,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
18,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
20679,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
828,
2124,
11,
807,
11,
532,
19510,
2624,
9,
64,
20679,
7,
1495,
9,
67,
61,
18,
9,
31166,
17034,
7,
67,
9,
87,
22305,
532,
357,
1433,
9,
64,
61,
7,
20,
14,
19,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1495,
9,
67,
61,
7,
22,
14,
17,
4008,
1343,
357,
1433,
9,
64,
61,
7,
20,
14,
19,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1495,
9,
67,
61,
7,
22,
14,
17,
4008,
1343,
357,
23,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
1495,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
532,
357,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
20,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
60,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
838,
11,
357,
12762,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
29006,
940,
1959,
9,
64,
8,
1343,
357,
12762,
9,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
4008,
29006,
1731,
486,
9,
67,
8,
1343,
357,
2414,
9,
67,
61,
7,
20,
14,
17,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
32118,
9,
64,
61,
7,
22,
14,
19,
4008,
532,
357,
2414,
9,
67,
61,
7,
20,
14,
17,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
32118,
9,
64,
61,
7,
22,
14,
19,
4008,
532,
357,
2624,
9,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
32118,
9,
67,
8,
532,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
2920,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
4008,
29006,
22,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
838,
11,
357,
12762,
9,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
29006,
11623,
9,
64,
8,
1343,
357,
12762,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
29006,
26704,
9,
67,
8,
532,
357,
2414,
9,
67,
61,
7,
18,
14,
17,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
11623,
9,
64,
61,
7,
20,
14,
19,
4008,
532,
357,
2414,
9,
67,
61,
7,
18,
14,
17,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
11623,
9,
64,
61,
7,
20,
14,
19,
4008,
532,
357,
2624,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
11623,
9,
67,
8,
532,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
1495,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
4008,
29006,
20,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
16,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
860,
11,
357,
12762,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
29006,
6659,
9,
67,
8,
1343,
357,
2414,
9,
31166,
17034,
7,
67,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1983,
9,
64,
61,
7,
18,
14,
19,
4008,
532,
357,
2414,
9,
31166,
17034,
7,
67,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1983,
9,
64,
61,
7,
18,
14,
19,
4008,
532,
357,
2624,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
1983,
9,
67,
8,
532,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
24,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
4008,
29006,
18,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
7,
67,
9,
87,
8,
61,
7,
16,
14,
17,
828,
2124,
11,
860,
11,
357,
12762,
9,
31166,
17034,
7,
67,
9,
87,
4008,
14,
67,
532,
357,
2414,
9,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
4008,
532,
357,
2414,
9,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
4008,
532,
357,
2624,
9,
31166,
17034,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
14,
67,
532,
357,
23,
9,
31166,
17034,
7,
67,
9,
87,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
14,
67,
1343,
357,
17,
9,
31166,
17034,
7,
67,
9,
87,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
4008,
14,
67,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
828,
2124,
11,
807,
11,
532,
19510,
2414,
9,
64,
61,
7,
16,
14,
19,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
67,
61,
7,
18,
14,
17,
4008,
1343,
357,
2414,
9,
64,
61,
7,
16,
14,
19,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
67,
61,
7,
18,
14,
17,
8,
1343,
357,
2624,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
532,
357,
23,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
532,
357,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
828,
2124,
11,
807,
11,
357,
2414,
9,
64,
61,
7,
18,
14,
19,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1983,
9,
67,
61,
7,
20,
14,
17,
4008,
1343,
357,
2414,
9,
64,
61,
7,
18,
14,
19,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
1983,
9,
67,
61,
7,
20,
14,
17,
4008,
1343,
357,
2624,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
1983,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
532,
357,
23,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
24,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
532,
357,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
4008,
29006,
18,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
828,
2124,
11,
860,
11,
532,
19510,
12762,
9,
64,
20679,
7,
11623,
9,
67,
61,
18,
9,
31166,
17034,
7,
67,
9,
87,
22305,
532,
357,
2414,
9,
64,
61,
7,
20,
14,
19,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
11623,
9,
67,
61,
7,
22,
14,
17,
4008,
1343,
357,
2414,
9,
64,
61,
7,
20,
14,
19,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
11623,
9,
67,
61,
7,
22,
14,
17,
4008,
1343,
357,
2624,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
11623,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
532,
357,
23,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
1495,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
532,
357,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
4008,
29006,
20,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
20679,
7,
67,
9,
87,
8,
61,
7,
24,
14,
17,
828,
2124,
11,
860,
11,
532,
19510,
12762,
9,
64,
20679,
7,
940,
1959,
9,
67,
61,
18,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
22305,
1343,
357,
2414,
9,
64,
61,
7,
22,
14,
19,
27493,
39036,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
32118,
9,
67,
61,
7,
24,
14,
17,
4008,
1343,
357,
2414,
9,
64,
61,
7,
22,
14,
19,
27493,
39036,
71,
19510,
64,
61,
7,
16,
14,
19,
27493,
31166,
17034,
7,
67,
9,
87,
4008,
14,
31166,
17034,
7,
67,
4008,
20679,
7,
32118,
9,
67,
61,
7,
24,
14,
17,
4008,
1343,
357,
2624,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
32118,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
4008,
532,
357,
23,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
2920,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
4008,
532,
357,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
4008,
29006,
22,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
22,
14,
17,
4008,
60,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
7266,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
80,
9,
1837,
2022,
4160,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
604,
11,
357,
23,
9,
64,
9,
67,
9,
80,
61,
17,
9,
87,
61,
7,
17,
1343,
10662,
27493,
31166,
17034,
7,
67,
9,
87,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
20,
14,
17,
1343,
10662,
20679,
80,
11,
357,
16,
14,
17,
27493,
7,
19,
1343,
642,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
1495,
9,
7,
20,
1343,
362,
9,
80,
4008,
1343,
357,
19,
9,
80,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
1495,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
20,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
16,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
604,
11,
357,
23,
9,
64,
9,
80,
61,
17,
9,
87,
61,
7,
16,
1343,
10662,
27493,
31166,
17034,
7,
67,
9,
87,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
18,
14,
17,
1343,
10662,
20679,
80,
11,
357,
16,
14,
17,
27493,
7,
19,
1343,
513,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
24,
9,
7,
18,
1343,
362,
9,
80,
4008,
1343,
357,
19,
9,
80,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
24,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
18,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
20679,
7,
67,
9,
87,
8,
61,
7,
16,
14,
17,
828,
2124,
11,
604,
11,
357,
23,
9,
64,
9,
80,
61,
17,
9,
87,
61,
80,
9,
31166,
17034,
7,
67,
9,
87,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
16,
14,
17,
1343,
10662,
20679,
80,
11,
357,
16,
14,
17,
27493,
7,
19,
1343,
352,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
1343,
362,
9,
80,
4008,
1343,
357,
19,
9,
80,
9,
31166,
17034,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
14,
67,
1343,
357,
17,
9,
31166,
17034,
7,
67,
9,
87,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
14,
67,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
20679,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
828,
2124,
11,
604,
11,
532,
19510,
23,
9,
64,
9,
80,
61,
17,
9,
87,
61,
80,
9,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
16,
14,
17,
27493,
7,
17,
532,
352,
14,
80,
828,
357,
16,
14,
17,
27493,
7,
19,
532,
352,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
532,
362,
9,
80,
27493,
31166,
17034,
7,
67,
9,
87,
22305,
1343,
357,
19,
9,
80,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
532,
357,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
20679,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
828,
2124,
11,
604,
11,
532,
19510,
23,
9,
64,
9,
80,
61,
17,
9,
87,
61,
32590,
16,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
16,
14,
17,
27493,
7,
17,
532,
513,
14,
80,
828,
357,
16,
14,
17,
27493,
7,
19,
532,
513,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
24,
9,
67,
61,
17,
9,
7,
18,
532,
362,
9,
80,
27493,
31166,
17034,
7,
67,
9,
87,
22305,
1343,
357,
19,
9,
80,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
24,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
532,
357,
17,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
18,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
60,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
642,
11,
532,
19510,
1433,
9,
64,
9,
67,
9,
80,
61,
18,
9,
87,
61,
7,
17,
1343,
10662,
27493,
31166,
17034,
7,
67,
9,
87,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
20,
14,
17,
1343,
10662,
20679,
80,
11,
357,
16,
14,
17,
27493,
7,
19,
1343,
642,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
11623,
9,
7,
20,
1343,
362,
9,
80,
22305,
532,
357,
23,
9,
80,
61,
17,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
11623,
9,
67,
8,
532,
357,
19,
9,
80,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
1495,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
4008,
29006,
20,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
7,
16,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
642,
11,
532,
19510,
1433,
9,
64,
9,
80,
61,
18,
9,
87,
61,
7,
16,
1343,
10662,
27493,
31166,
17034,
7,
67,
9,
87,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
18,
14,
17,
1343,
10662,
20679,
80,
11,
357,
16,
14,
17,
27493,
7,
19,
1343,
513,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
1983,
9,
7,
18,
1343,
362,
9,
80,
22305,
532,
357,
23,
9,
80,
61,
17,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
1983,
9,
67,
8,
532,
357,
19,
9,
80,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
24,
9,
67,
8,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
4008,
29006,
18,
9,
67,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
20679,
7,
67,
9,
87,
8,
61,
7,
16,
14,
17,
828,
2124,
11,
642,
11,
532,
19510,
1433,
9,
64,
9,
80,
61,
18,
9,
87,
61,
80,
9,
31166,
17034,
7,
67,
9,
87,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
16,
14,
17,
1343,
10662,
20679,
80,
11,
357,
16,
14,
17,
27493,
7,
19,
1343,
352,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
1343,
362,
9,
80,
22305,
532,
357,
23,
9,
80,
61,
17,
9,
31166,
17034,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
14,
67,
532,
357,
19,
9,
80,
9,
31166,
17034,
7,
67,
9,
87,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
14,
67,
1343,
357,
17,
9,
31166,
17034,
7,
67,
9,
87,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
4008,
14,
67,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
20679,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
828,
2124,
11,
642,
11,
532,
19510,
1433,
9,
64,
9,
80,
61,
18,
9,
87,
61,
80,
9,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
16,
14,
17,
27493,
7,
17,
532,
352,
14,
80,
828,
357,
16,
14,
17,
27493,
7,
19,
532,
352,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
532,
362,
9,
80,
27493,
31166,
17034,
7,
67,
9,
87,
22305,
1343,
357,
23,
9,
80,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
532,
357,
19,
9,
80,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
532,
357,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
31166,
17034,
7,
67,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
20679,
7,
67,
9,
87,
8,
61,
7,
20,
14,
17,
828,
2124,
11,
642,
11,
532,
19510,
1433,
9,
64,
9,
80,
61,
18,
9,
87,
61,
32590,
16,
1343,
10662,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
16,
14,
17,
27493,
7,
17,
532,
513,
14,
80,
828,
357,
16,
14,
17,
27493,
7,
19,
532,
513,
14,
80,
828,
257,
9,
87,
61,
80,
4008,
29006,
1983,
9,
67,
61,
17,
9,
7,
18,
532,
362,
9,
80,
27493,
31166,
17034,
7,
67,
9,
87,
22305,
1343,
357,
23,
9,
80,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
1983,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
532,
357,
19,
9,
80,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
24,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
532,
357,
17,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
4008,
29006,
18,
9,
67,
9,
7,
67,
9,
87,
8,
61,
7,
18,
14,
17,
4008,
60,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
87,
61,
76,
9,
34220,
11187,
7,
77,
14,
17,
11,
257,
9,
87,
61,
80,
8,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
14,
17,
11,
257,
9,
87,
828,
2124,
11,
362,
11,
13841,
87,
27493,
34220,
11187,
7,
16,
14,
17,
11,
257,
9,
87,
8,
1343,
2124,
9,
34220,
11187,
7,
18,
14,
17,
11,
257,
9,
87,
8,
1343,
791,
18908,
81,
540,
7,
34220,
11187,
7,
30420,
16,
14,
17,
828,
257,
9,
87,
828,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
16,
14,
17,
11,
257,
9,
87,
828,
2124,
11,
352,
11,
2124,
9,
34220,
11187,
7,
16,
14,
17,
11,
257,
9,
87,
8,
532,
791,
18908,
81,
540,
7,
34220,
11187,
7,
30420,
16,
14,
17,
828,
257,
9,
87,
828,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
32590,
16,
14,
17,
11,
257,
9,
87,
828,
2124,
11,
657,
11,
791,
18908,
81,
540,
7,
34220,
11187,
7,
30420,
16,
14,
17,
828,
257,
9,
87,
828,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
32590,
18,
14,
17,
11,
257,
9,
87,
828,
2124,
11,
352,
11,
2124,
9,
34220,
11187,
7,
30420,
16,
14,
17,
828,
257,
9,
87,
8,
532,
791,
18908,
81,
540,
7,
34220,
11187,
7,
30420,
16,
14,
17,
828,
257,
9,
87,
828,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
32590,
20,
14,
17,
11,
257,
9,
87,
828,
2124,
11,
362,
11,
2124,
9,
34220,
11187,
7,
30420,
18,
14,
17,
828,
257,
9,
87,
8,
532,
2124,
9,
34220,
11187,
7,
30420,
16,
14,
17,
828,
257,
9,
87,
8,
1343,
791,
18908,
81,
540,
7,
34220,
11187,
7,
30420,
16,
14,
17,
828,
257,
9,
87,
828,
2124,
15437,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
32590,
18,
14,
17,
11,
257,
9,
87,
8,
1343,
12280,
11187,
32590,
16,
14,
17,
11,
257,
9,
87,
828,
2124,
11,
362,
11,
2124,
9,
34220,
11187,
32590,
16,
14,
17,
11,
257,
9,
87,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
7,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
27493,
4480,
9,
76,
9,
1837,
2022,
4160,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
828,
2124,
11,
513,
11,
357,
64,
9,
7,
67,
9,
87,
8,
61,
7,
17,
1343,
285,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
362,
1343,
285,
11,
513,
1343,
285,
11,
257,
9,
87,
4008,
29006,
67,
61,
17,
9,
7,
16,
1343,
285,
8,
61,
17,
9,
7,
17,
1343,
285,
4008,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
828,
2124,
11,
604,
11,
532,
19510,
64,
9,
7,
67,
9,
87,
8,
61,
7,
17,
1343,
285,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
362,
1343,
285,
11,
513,
1343,
285,
11,
257,
9,
87,
4008,
29006,
67,
61,
17,
9,
7,
16,
1343,
285,
8,
61,
18,
9,
7,
17,
1343,
285,
22305,
532,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
18,
8,
532,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
19,
11,
257,
9,
87,
828,
2124,
11,
642,
11,
357,
64,
9,
7,
67,
9,
87,
8,
61,
7,
17,
1343,
285,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
362,
1343,
285,
11,
513,
1343,
285,
11,
257,
9,
87,
4008,
29006,
67,
61,
17,
9,
7,
16,
1343,
285,
8,
61,
19,
9,
7,
17,
1343,
285,
4008,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
19,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
18,
8,
532,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
19,
11,
257,
9,
87,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
604,
11,
357,
19,
9,
64,
9,
7,
67,
9,
87,
8,
61,
7,
18,
1343,
285,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
18,
1343,
285,
20679,
17,
11,
357,
20,
1343,
285,
20679,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
61,
18,
9,
7,
16,
1343,
285,
8,
61,
17,
9,
7,
18,
1343,
285,
4008,
1343,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
642,
11,
532,
19510,
23,
9,
64,
9,
7,
67,
9,
87,
8,
61,
7,
18,
1343,
285,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
18,
1343,
285,
20679,
17,
11,
357,
20,
1343,
285,
20679,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
61,
18,
9,
7,
16,
1343,
285,
8,
61,
18,
9,
7,
18,
1343,
285,
22305,
532,
357,
19,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
18,
8,
532,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
19,
11,
257,
9,
87,
61,
17,
828,
2124,
11,
718,
11,
357,
1433,
9,
64,
9,
7,
67,
9,
87,
8,
61,
7,
18,
1343,
285,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
18,
1343,
285,
20679,
17,
11,
357,
20,
1343,
285,
20679,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
61,
18,
9,
7,
16,
1343,
285,
8,
61,
19,
9,
7,
18,
1343,
285,
4008,
1343,
357,
23,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
19,
8,
1343,
357,
19,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
18,
8,
532,
357,
17,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
19,
11,
257,
9,
87,
61,
17,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
18,
828,
2124,
11,
604,
11,
357,
24,
9,
64,
9,
7,
67,
9,
87,
8,
61,
7,
19,
1343,
285,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
19,
1343,
285,
20679,
18,
11,
357,
22,
1343,
285,
20679,
18,
11,
257,
9,
87,
61,
18,
4008,
29006,
67,
61,
19,
9,
7,
16,
1343,
285,
8,
61,
17,
9,
7,
19,
1343,
285,
4008,
1343,
357,
18,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
18,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
18,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
18,
828,
2124,
11,
642,
11,
532,
19510,
1983,
9,
64,
9,
7,
67,
9,
87,
8,
61,
7,
19,
1343,
285,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
19,
1343,
285,
20679,
18,
11,
357,
22,
1343,
285,
20679,
18,
11,
257,
9,
87,
61,
18,
4008,
29006,
67,
61,
19,
9,
7,
16,
1343,
285,
8,
61,
18,
9,
7,
19,
1343,
285,
22305,
532,
357,
24,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
18,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
18,
8,
532,
357,
18,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
18,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
18,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
19,
11,
257,
9,
87,
61,
18,
828,
2124,
11,
718,
11,
357,
6659,
9,
64,
9,
7,
67,
9,
87,
8,
61,
7,
19,
1343,
285,
27493,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
19,
1343,
285,
20679,
18,
11,
357,
22,
1343,
285,
20679,
18,
11,
257,
9,
87,
61,
18,
4008,
29006,
67,
61,
19,
9,
7,
16,
1343,
285,
8,
61,
19,
9,
7,
19,
1343,
285,
4008,
1343,
357,
1983,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
18,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
19,
8,
1343,
357,
24,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
18,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
18,
8,
532,
357,
18,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
18,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
19,
11,
257,
9,
87,
61,
18,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
604,
11,
357,
64,
9,
80,
61,
17,
9,
87,
61,
7,
16,
1343,
10662,
27493,
7,
67,
9,
87,
8,
61,
76,
9,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
16,
1343,
285,
1343,
10662,
20679,
80,
11,
357,
16,
1343,
285,
1343,
362,
9,
80,
20679,
80,
11,
257,
9,
87,
61,
80,
4008,
14,
19510,
16,
1343,
285,
8,
61,
17,
9,
7,
16,
1343,
285,
1343,
10662,
4008,
1343,
357,
80,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
642,
11,
532,
19510,
64,
9,
80,
61,
18,
9,
87,
61,
7,
16,
1343,
10662,
27493,
7,
67,
9,
87,
8,
61,
76,
9,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
16,
1343,
285,
1343,
10662,
20679,
80,
11,
357,
16,
1343,
285,
1343,
362,
9,
80,
20679,
80,
11,
257,
9,
87,
61,
80,
4008,
14,
19510,
16,
1343,
285,
8,
61,
18,
9,
7,
16,
1343,
285,
1343,
10662,
22305,
532,
357,
80,
61,
17,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
18,
8,
532,
357,
80,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
19,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
718,
11,
357,
64,
9,
80,
61,
19,
9,
87,
61,
7,
16,
1343,
10662,
27493,
7,
67,
9,
87,
8,
61,
76,
9,
38197,
469,
16996,
24629,
2733,
13557,
158,
224,
224,
37,
158,
224,
223,
7,
16,
11,
357,
16,
1343,
285,
1343,
10662,
20679,
80,
11,
357,
16,
1343,
285,
1343,
362,
9,
80,
20679,
80,
11,
257,
9,
87,
61,
80,
4008,
14,
19510,
16,
1343,
285,
8,
61,
19,
9,
7,
16,
1343,
285,
1343,
10662,
4008,
1343,
357,
80,
61,
18,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
6404,
7,
16,
532,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
19,
8,
1343,
357,
80,
61,
17,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
17,
11,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
18,
8,
532,
357,
80,
9,
7,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
18,
11,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
1343,
285,
8,
61,
17,
8,
1343,
14808,
67,
9,
87,
8,
61,
7,
16,
1343,
285,
27493,
34220,
11187,
7,
19,
11,
257,
9,
87,
61,
80,
4008,
29006,
67,
9,
7,
16,
1343,
285,
4008,
60,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
7,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
27493,
4480,
9,
77,
9,
1837,
2022,
4160,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
34220,
11187,
7,
77,
11,
257,
9,
87,
828,
2124,
11,
657,
11,
791,
18908,
81,
540,
7,
87,
9,
34220,
11187,
7,
77,
11,
257,
9,
87,
828,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
34220,
11187,
7,
77,
11,
257,
9,
87,
828,
2124,
11,
657,
11,
791,
18908,
81,
540,
7,
34220,
11187,
7,
77,
11,
257,
9,
87,
828,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
77,
11,
257,
9,
87,
20679,
87,
61,
16,
11,
2124,
11,
352,
11,
12280,
11187,
7,
16,
1343,
299,
11,
257,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
77,
11,
257,
9,
87,
20679,
87,
61,
17,
11,
2124,
11,
657,
11,
791,
18908,
81,
540,
7,
34220,
11187,
7,
77,
11,
257,
9,
87,
20679,
87,
61,
17,
11,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
77,
11,
257,
9,
87,
20679,
87,
61,
18,
11,
2124,
11,
657,
11,
791,
18908,
81,
540,
7,
34220,
11187,
7,
77,
11,
257,
9,
87,
20679,
87,
61,
18,
11,
2124,
15437,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
657,
11,
791,
18908,
81,
540,
7,
87,
9,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
828,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
828,
2124,
11,
657,
11,
791,
18908,
81,
540,
7,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
828,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
16,
11,
2124,
11,
352,
11,
12280,
11187,
7,
16,
1343,
299,
11,
257,
9,
87,
61,
80,
20679,
80,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
17,
11,
2124,
11,
657,
11,
791,
18908,
81,
540,
7,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
17,
11,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
18,
11,
2124,
11,
657,
11,
791,
18908,
81,
540,
7,
34220,
11187,
7,
77,
11,
257,
9,
87,
61,
80,
20679,
87,
61,
18,
11,
2124,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
16375,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
7,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
77,
11,
269,
9,
7,
64,
10,
65,
9,
87,
4008,
46249,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
87,
61,
76,
9,
34220,
11187,
7,
77,
11,
269,
9,
7,
64,
10,
65,
9,
87,
4008,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
36911,
2124,
11,
1511,
11,
532,
19510,
64,
61,
17,
9,
87,
20679,
7,
18,
9,
65,
61,
17,
4008,
1343,
357,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
87,
20679,
7,
21,
9,
65,
61,
17,
9,
66,
8,
532,
14808,
16,
532,
257,
9,
66,
8,
61,
17,
9,
87,
20679,
7,
24,
9,
65,
61,
17,
9,
66,
61,
17,
8,
1343,
357,
64,
9,
87,
61,
17,
20679,
7,
1065,
9,
65,
8,
532,
14808,
16,
532,
257,
9,
66,
27493,
87,
61,
17,
20679,
7,
1507,
9,
65,
9,
66,
8,
532,
2124,
61,
18,
14,
1983,
1343,
357,
64,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
21,
9,
65,
61,
18,
9,
66,
61,
17,
8,
532,
14808,
16,
532,
257,
9,
66,
8,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
24,
9,
65,
61,
18,
9,
66,
61,
18,
8,
532,
357,
64,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
21,
9,
65,
8,
1343,
357,
16,
14,
24,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
532,
357,
64,
61,
17,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
18,
9,
65,
61,
18,
9,
66,
8,
1343,
357,
64,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
65,
61,
18,
8,
1343,
357,
16,
14,
18,
27493,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
36911,
2124,
11,
838,
11,
357,
64,
9,
87,
20679,
7,
17,
9,
65,
8,
532,
14808,
16,
532,
257,
9,
66,
27493,
87,
20679,
7,
19,
9,
65,
9,
66,
8,
532,
2124,
61,
17,
14,
23,
532,
14808,
16,
532,
257,
9,
66,
8,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
19,
9,
65,
61,
17,
9,
66,
61,
17,
8,
1343,
357,
16,
14,
19,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
1343,
357,
64,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
17,
9,
65,
61,
17,
9,
66,
8,
532,
357,
64,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
65,
61,
17,
8,
1343,
357,
16,
14,
17,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
36911,
2124,
11,
767,
11,
532,
87,
532,
14808,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
8,
1343,
357,
64,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
65,
1343,
2124,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
61,
16,
11,
2124,
11,
513,
11,
2604,
7,
87,
27493,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
357,
16,
14,
17,
27493,
7,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
8,
1343,
2604,
19510,
16,
532,
257,
9,
66,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
532,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
61,
17,
1343,
357,
16,
14,
17,
27493,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
4008,
9,
7,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
61,
17,
1343,
357,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
1343,
2604,
7,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
532,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
357,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
12280,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
1343,
12280,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
532,
12280,
11187,
7,
18,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
532,
12280,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
61,
17,
11,
2124,
11,
767,
11,
532,
19510,
65,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
14,
64,
8,
532,
357,
65,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
532,
12280,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
532,
357,
65,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
64,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
61,
18,
11,
2124,
11,
1367,
11,
357,
65,
61,
17,
9,
66,
9,
6404,
7,
87,
4008,
29006,
17,
9,
64,
9,
7,
16,
532,
257,
9,
66,
4008,
532,
357,
65,
61,
17,
9,
66,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
17,
9,
64,
9,
7,
16,
532,
257,
9,
66,
4008,
1343,
357,
65,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
17,
9,
64,
9,
87,
8,
1343,
357,
65,
61,
17,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
17,
9,
64,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
12280,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
17,
9,
87,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
17,
9,
64,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
61,
19,
11,
2124,
11,
1478,
11,
532,
19510,
65,
61,
17,
9,
66,
20679,
7,
21,
9,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
87,
4008,
1343,
357,
65,
61,
18,
9,
66,
61,
17,
9,
6404,
7,
87,
4008,
29006,
21,
9,
64,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
8,
532,
357,
65,
61,
18,
9,
66,
9,
6404,
7,
87,
4008,
29006,
18,
9,
64,
61,
17,
9,
7,
16,
532,
257,
9,
66,
4008,
532,
357,
65,
61,
18,
9,
66,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
21,
9,
64,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
8,
1343,
357,
65,
61,
18,
9,
66,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
18,
9,
64,
61,
17,
9,
7,
16,
532,
257,
9,
66,
4008,
1343,
357,
65,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
21,
9,
64,
9,
87,
61,
17,
8,
532,
357,
65,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
18,
9,
64,
61,
17,
9,
87,
8,
532,
357,
65,
61,
18,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
18,
9,
64,
61,
18,
8,
532,
357,
65,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
532,
12280,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
18,
9,
87,
61,
18,
8,
532,
357,
65,
61,
18,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
18,
9,
64,
61,
18,
15437,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
36911,
2124,
11,
4747,
11,
357,
1157,
9,
64,
61,
17,
9,
87,
20679,
7,
1507,
9,
65,
61,
17,
8,
532,
357,
20,
9,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
87,
20679,
7,
2623,
9,
65,
61,
17,
9,
66,
8,
1343,
14808,
16,
532,
257,
9,
66,
8,
61,
17,
9,
87,
20679,
7,
1983,
9,
65,
61,
17,
9,
66,
61,
17,
8,
532,
357,
20,
9,
64,
9,
87,
61,
17,
20679,
7,
4761,
9,
65,
8,
1343,
14808,
16,
532,
257,
9,
66,
27493,
87,
61,
17,
20679,
7,
4051,
9,
65,
9,
66,
8,
1343,
2124,
61,
18,
14,
6659,
532,
357,
20,
9,
64,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
2623,
9,
65,
61,
18,
9,
66,
61,
17,
8,
1343,
14808,
16,
532,
257,
9,
66,
8,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
1983,
9,
65,
61,
18,
9,
66,
61,
18,
8,
1343,
357,
20,
9,
64,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
2623,
9,
65,
8,
532,
357,
16,
14,
1983,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
1343,
357,
1157,
9,
64,
61,
17,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
1507,
9,
65,
61,
18,
9,
66,
8,
532,
357,
1157,
9,
64,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
1507,
9,
65,
61,
18,
8,
532,
357,
64,
61,
17,
9,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
65,
61,
17,
8,
1343,
357,
64,
9,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
21,
9,
65,
8,
532,
357,
16,
14,
24,
27493,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
357,
17,
9,
64,
61,
18,
9,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
65,
61,
18,
8,
532,
14808,
64,
61,
18,
532,
275,
61,
18,
9,
87,
61,
18,
27493,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
65,
61,
18,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
36911,
2124,
11,
678,
11,
532,
19510,
18,
9,
64,
9,
87,
20679,
7,
19,
9,
65,
4008,
1343,
14808,
16,
532,
257,
9,
66,
27493,
87,
20679,
7,
23,
9,
65,
9,
66,
8,
1343,
2124,
61,
17,
14,
1433,
1343,
14808,
16,
532,
257,
9,
66,
8,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
23,
9,
65,
61,
17,
9,
66,
61,
17,
8,
532,
357,
16,
14,
23,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
532,
357,
18,
9,
64,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
19,
9,
65,
61,
17,
9,
66,
8,
1343,
357,
18,
9,
64,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
19,
9,
65,
61,
17,
8,
1343,
357,
64,
9,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
65,
8,
532,
357,
16,
14,
19,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
14808,
64,
61,
17,
532,
275,
61,
17,
9,
87,
61,
17,
27493,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
65,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
36911,
2124,
11,
860,
11,
2124,
1343,
14808,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
8,
532,
357,
64,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
65,
532,
2124,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
357,
64,
9,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
65,
1343,
2124,
9,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
61,
16,
11,
2124,
11,
352,
11,
2558,
7,
34220,
11187,
7,
18,
11,
257,
9,
66,
1343,
275,
9,
66,
9,
87,
20679,
87,
11,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
61,
17,
11,
2124,
11,
718,
11,
357,
65,
9,
6404,
7,
87,
27493,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
1343,
357,
65,
9,
7,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
8,
1343,
2604,
19510,
16,
532,
257,
9,
66,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
532,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
61,
17,
20679,
7,
17,
9,
64,
8,
1343,
357,
65,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
4008,
9,
7,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
61,
17,
20679,
7,
17,
9,
64,
8,
1343,
357,
65,
9,
7,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
20679,
64,
1343,
357,
65,
9,
6404,
7,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
1343,
357,
65,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
4008,
14,
64,
532,
357,
65,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
20679,
64,
1343,
357,
65,
9,
7,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
532,
357,
65,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
20679,
64,
532,
357,
17,
9,
65,
9,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
1343,
14808,
65,
532,
257,
14,
87,
27493,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
1343,
357,
65,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
4008,
14,
64,
532,
357,
65,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
20679,
64,
532,
357,
65,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
61,
18,
11,
2124,
11,
1105,
11,
532,
19510,
65,
61,
17,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
17,
9,
64,
61,
17,
4008,
532,
357,
65,
61,
17,
9,
6404,
7,
87,
27493,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
7,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
8,
1343,
2604,
19510,
16,
532,
257,
9,
66,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
532,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
61,
17,
20679,
7,
19,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
4008,
9,
7,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
61,
17,
20679,
7,
19,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
7,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
65,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
9,
87,
8,
532,
357,
65,
61,
17,
9,
6404,
7,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
4008,
29006,
17,
9,
64,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
7,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
1343,
14808,
65,
61,
17,
532,
257,
61,
17,
14,
87,
61,
17,
27493,
34220,
11187,
7,
18,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
4008,
29006,
17,
9,
64,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
20679,
7,
17,
9,
64,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
7,
67,
10,
68,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
77,
11,
66,
9,
7,
64,
10,
65,
9,
87,
4008,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
18,
11,
2124,
11,
1467,
11,
532,
19510,
7,
65,
9,
67,
532,
257,
9,
68,
8,
61,
18,
9,
87,
20679,
7,
19,
9,
65,
61,
18,
4008,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
9,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
87,
20679,
7,
23,
9,
65,
61,
18,
9,
66,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
17,
9,
87,
20679,
7,
1065,
9,
65,
61,
18,
9,
66,
61,
17,
8,
532,
14808,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
18,
9,
87,
20679,
7,
1433,
9,
65,
61,
18,
9,
66,
61,
18,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
17,
20679,
7,
1433,
9,
65,
61,
17,
9,
68,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
67,
1343,
304,
9,
87,
8,
61,
17,
20679,
7,
1731,
9,
65,
61,
17,
9,
66,
9,
68,
8,
532,
14808,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
17,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
17,
20679,
7,
2624,
9,
65,
61,
17,
9,
66,
61,
17,
9,
68,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
67,
1343,
304,
9,
87,
8,
61,
18,
20679,
7,
2623,
9,
65,
9,
68,
8,
532,
14808,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
67,
1343,
304,
9,
87,
8,
61,
18,
20679,
7,
2780,
9,
65,
9,
66,
9,
68,
8,
532,
357,
67,
1343,
304,
9,
87,
8,
61,
19,
29006,
2414,
9,
68,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
9,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
23,
9,
65,
61,
19,
9,
66,
61,
17,
9,
68,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
1065,
9,
65,
61,
19,
9,
66,
61,
18,
9,
68,
8,
532,
14808,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
19,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
1433,
9,
65,
61,
19,
9,
66,
61,
19,
9,
68,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
8,
61,
18,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
19,
9,
65,
61,
19,
9,
66,
8,
1343,
14808,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
23,
9,
65,
61,
17,
9,
68,
8,
1343,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
67,
1343,
304,
9,
87,
8,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
1065,
9,
65,
9,
68,
8,
1343,
14808,
67,
1343,
304,
9,
87,
8,
61,
19,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
1433,
9,
68,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
8,
61,
19,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
19,
9,
65,
61,
19,
9,
68,
8,
1343,
14808,
67,
1343,
304,
9,
87,
8,
61,
19,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
19,
9,
68,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
17,
11,
2124,
11,
1511,
11,
532,
19510,
7,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
9,
87,
20679,
7,
18,
9,
65,
61,
17,
4008,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
87,
20679,
7,
21,
9,
65,
61,
17,
9,
66,
8,
532,
14808,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
17,
9,
87,
20679,
7,
24,
9,
65,
61,
17,
9,
66,
61,
17,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
67,
1343,
304,
9,
87,
8,
61,
17,
20679,
7,
1065,
9,
65,
9,
68,
8,
532,
14808,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
67,
1343,
304,
9,
87,
8,
61,
17,
20679,
7,
1507,
9,
65,
9,
66,
9,
68,
8,
532,
357,
67,
1343,
304,
9,
87,
8,
61,
18,
29006,
1983,
9,
68,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
21,
9,
65,
61,
18,
9,
66,
61,
17,
9,
68,
8,
532,
14808,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
24,
9,
65,
61,
18,
9,
66,
61,
18,
9,
68,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
18,
9,
65,
61,
18,
9,
66,
8,
1343,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
67,
1343,
304,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
21,
9,
65,
9,
68,
8,
1343,
14808,
67,
1343,
304,
9,
87,
8,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
24,
9,
68,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
8,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
65,
61,
18,
9,
68,
8,
1343,
14808,
67,
1343,
304,
9,
87,
8,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
68,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
16,
11,
2124,
11,
838,
11,
532,
19510,
7,
65,
9,
67,
532,
257,
9,
68,
27493,
87,
20679,
7,
17,
9,
65,
4008,
532,
14808,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
87,
20679,
7,
19,
9,
65,
9,
66,
8,
532,
357,
67,
1343,
304,
9,
87,
8,
61,
17,
29006,
23,
9,
68,
8,
532,
14808,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
19,
9,
65,
61,
17,
9,
66,
61,
17,
9,
68,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
17,
9,
65,
61,
17,
9,
66,
8,
1343,
14808,
67,
1343,
304,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
19,
9,
68,
8,
532,
14808,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
65,
61,
17,
9,
68,
8,
1343,
14808,
67,
1343,
304,
9,
87,
8,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
68,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
15,
11,
2124,
11,
767,
11,
532,
87,
532,
14808,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
8,
1343,
357,
64,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
65,
1343,
2124,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
67,
1343,
304,
9,
87,
8,
61,
16,
11,
2124,
11,
513,
11,
14808,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
17,
9,
68,
8,
1343,
357,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
68,
532,
14808,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
17,
9,
68,
8,
1343,
357,
6404,
7,
67,
1343,
304,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
68,
1343,
14808,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
68,
1343,
14808,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
68,
532,
357,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
68,
1343,
357,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
14,
68,
532,
12280,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
14,
68,
532,
12280,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
68,
532,
12280,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
14,
68,
1343,
12280,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
20679,
68,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
67,
1343,
304,
9,
87,
8,
61,
17,
11,
2124,
11,
807,
11,
357,
65,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
4008,
1343,
357,
65,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
4008,
532,
12280,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
68,
9,
7,
67,
1343,
304,
9,
87,
4008,
1343,
357,
65,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
67,
1343,
304,
9,
87,
8,
61,
18,
11,
2124,
11,
1105,
11,
357,
65,
61,
17,
9,
66,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
17,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
532,
357,
65,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
17,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
67,
1343,
304,
9,
87,
4008,
532,
357,
65,
61,
17,
9,
66,
9,
6404,
7,
67,
1343,
304,
9,
87,
4008,
29006,
17,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
1343,
357,
65,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
17,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
8,
532,
12280,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
17,
9,
68,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
17,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
67,
1343,
304,
9,
87,
8,
61,
19,
11,
2124,
11,
1315,
11,
357,
65,
61,
17,
9,
66,
20679,
7,
21,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
67,
1343,
304,
9,
87,
4008,
1343,
357,
65,
61,
18,
9,
66,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
21,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
17,
8,
1343,
357,
65,
61,
18,
9,
66,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
18,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
9,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
532,
357,
65,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
21,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
67,
1343,
304,
9,
87,
8,
61,
17,
8,
532,
357,
65,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
18,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
9,
7,
67,
1343,
304,
9,
87,
4008,
532,
357,
65,
61,
18,
9,
66,
61,
17,
9,
6404,
7,
67,
1343,
304,
9,
87,
4008,
29006,
21,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
8,
61,
17,
8,
532,
357,
65,
61,
18,
9,
66,
9,
6404,
7,
67,
1343,
304,
9,
87,
4008,
29006,
18,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
8,
61,
17,
9,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
1343,
357,
65,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
18,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
8,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
8,
61,
18,
8,
532,
12280,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
18,
9,
68,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
18,
9,
68,
9,
7,
65,
9,
67,
532,
257,
9,
68,
8,
61,
18,
15437,
628,
198,
220,
220,
220,
1303,
28,
14207,
9,
18908,
81,
1746,
9,
533,
9,
40496,
13,
796,
2,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
2124,
20679,
32590,
16,
1343,
2124,
828,
2124,
11,
642,
11,
2604,
7,
16,
12,
87,
8,
61,
17,
9,
6404,
7,
87,
47762,
17,
9,
6404,
7,
16,
12,
87,
27493,
34220,
11187,
7,
17,
11,
16,
12,
87,
47762,
6404,
7,
16,
12,
87,
27493,
34220,
11187,
7,
17,
11,
87,
13219,
17,
9,
34220,
11187,
7,
18,
11,
16,
12,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
25915,
34220,
11187,
7,
17,
11,
2124,
20679,
7,
16,
532,
2124,
828,
2124,
11,
642,
11,
2604,
7,
16,
12,
87,
8,
61,
17,
9,
6404,
7,
87,
47762,
17,
9,
6404,
7,
16,
12,
87,
27493,
34220,
11187,
7,
17,
11,
16,
12,
87,
47762,
6404,
7,
16,
12,
87,
27493,
34220,
11187,
7,
17,
11,
87,
13219,
17,
9,
34220,
11187,
7,
18,
11,
16,
12,
87,
15437,
628,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
2124,
20679,
19510,
12,
16,
1343,
2124,
27493,
87,
828,
2124,
11,
807,
11,
2604,
7,
16,
12,
87,
8,
61,
17,
9,
6404,
7,
87,
47762,
17,
9,
6404,
7,
16,
12,
87,
27493,
34220,
11187,
7,
17,
11,
16,
12,
87,
47762,
6404,
7,
16,
12,
87,
27493,
34220,
11187,
7,
17,
11,
87,
13219,
17,
9,
34220,
11187,
7,
18,
11,
16,
12,
87,
13219,
34220,
11187,
7,
18,
11,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
25915,
34220,
11187,
7,
17,
11,
2124,
20679,
19510,
16,
532,
2124,
27493,
87,
828,
2124,
11,
807,
11,
2604,
7,
16,
12,
87,
8,
61,
17,
9,
6404,
7,
87,
47762,
17,
9,
6404,
7,
16,
12,
87,
27493,
34220,
11187,
7,
17,
11,
16,
12,
87,
47762,
6404,
7,
16,
12,
87,
27493,
34220,
11187,
7,
17,
11,
87,
13219,
17,
9,
34220,
11187,
7,
18,
11,
16,
12,
87,
13219,
34220,
11187,
7,
18,
11,
87,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
34220,
11187,
7,
77,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
8,
1220,
357,
66,
1343,
288,
9,
87,
4008,
61,
77,
8,
1220,
14808,
64,
1343,
275,
9,
87,
27493,
7,
66,
1343,
288,
9,
87,
4008,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
77,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
19510,
64,
1343,
275,
9,
87,
27493,
7,
66,
1343,
288,
9,
87,
36911,
2124,
11,
352,
11,
12280,
11187,
7,
16,
1343,
299,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
19510,
65,
9,
66,
532,
257,
9,
67,
27493,
77,
15437,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
18,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
19510,
64,
1343,
275,
9,
87,
27493,
7,
66,
1343,
288,
9,
87,
36911,
2124,
11,
352,
11,
12280,
11187,
7,
19,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
7,
77,
9,
7,
65,
9,
66,
532,
257,
9,
67,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
17,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
19510,
64,
1343,
275,
9,
87,
27493,
7,
66,
1343,
288,
9,
87,
36911,
2124,
11,
352,
11,
12280,
11187,
7,
18,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
7,
77,
9,
7,
65,
9,
66,
532,
257,
9,
67,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
16,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
19510,
64,
1343,
275,
9,
87,
27493,
7,
66,
1343,
288,
9,
87,
36911,
2124,
11,
352,
11,
12280,
11187,
7,
17,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
7,
77,
9,
7,
65,
9,
66,
532,
257,
9,
67,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
15,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
19510,
64,
1343,
275,
9,
87,
27493,
7,
66,
1343,
288,
9,
87,
36911,
2124,
11,
362,
11,
12280,
11187,
7,
16,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
7,
77,
9,
7,
65,
9,
66,
532,
257,
9,
67,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
32590,
16,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
19510,
64,
1343,
275,
9,
87,
27493,
7,
66,
1343,
288,
9,
87,
36911,
2124,
11,
362,
11,
352,
14,
19510,
65,
9,
66,
532,
257,
9,
67,
27493,
77,
9,
7,
16,
532,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
32590,
17,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
19510,
64,
1343,
275,
9,
87,
27493,
7,
66,
1343,
288,
9,
87,
36911,
2124,
11,
604,
11,
12280,
11187,
32590,
16,
11,
304,
9,
19510,
64,
1343,
275,
9,
87,
20679,
7,
66,
1343,
288,
9,
87,
4008,
61,
77,
20679,
7,
77,
9,
7,
65,
9,
66,
532,
257,
9,
67,
4008,
60,
628,
198,
220,
220,
220,
1303,
28,
7904,
16375,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
7,
67,
9,
87,
8,
61,
76,
9,
34220,
11187,
7,
77,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
8,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
18,
9,
34220,
11187,
7,
77,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
828,
2124,
11,
642,
11,
357,
87,
61,
18,
9,
34220,
11187,
7,
16,
1343,
299,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
4008,
29006,
65,
9,
66,
9,
79,
9,
6404,
7,
37,
4008,
532,
357,
18,
9,
87,
61,
17,
9,
34220,
11187,
7,
17,
1343,
299,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
4008,
29006,
65,
61,
17,
9,
66,
61,
17,
9,
79,
61,
17,
9,
6404,
7,
37,
8,
61,
17,
8,
1343,
357,
21,
9,
87,
9,
34220,
11187,
7,
18,
1343,
299,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
4008,
29006,
65,
61,
18,
9,
66,
61,
18,
9,
79,
61,
18,
9,
6404,
7,
37,
8,
61,
18,
8,
532,
357,
21,
9,
34220,
11187,
7,
19,
1343,
299,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
4008,
29006,
65,
61,
19,
9,
66,
61,
19,
9,
79,
61,
19,
9,
6404,
7,
37,
8,
61,
19,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
34220,
11187,
7,
77,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
828,
2124,
11,
604,
11,
357,
87,
61,
17,
9,
34220,
11187,
7,
16,
1343,
299,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
4008,
29006,
65,
9,
66,
9,
79,
9,
6404,
7,
37,
4008,
532,
357,
17,
9,
87,
9,
34220,
11187,
7,
17,
1343,
299,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
4008,
29006,
65,
61,
17,
9,
66,
61,
17,
9,
79,
61,
17,
9,
6404,
7,
37,
8,
61,
17,
8,
1343,
357,
17,
9,
34220,
11187,
7,
18,
1343,
299,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
4008,
29006,
65,
61,
18,
9,
66,
61,
18,
9,
79,
61,
18,
9,
6404,
7,
37,
8,
61,
18,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
34220,
11187,
7,
77,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
828,
2124,
11,
513,
11,
357,
87,
9,
34220,
11187,
7,
16,
1343,
299,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
4008,
29006,
65,
9,
66,
9,
79,
9,
6404,
7,
37,
4008,
532,
12280,
11187,
7,
17,
1343,
299,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
20679,
7,
65,
61,
17,
9,
66,
61,
17,
9,
79,
61,
17,
9,
6404,
7,
37,
8,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
34220,
11187,
7,
77,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
828,
2124,
11,
362,
11,
12280,
11187,
7,
16,
1343,
299,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
20679,
7,
65,
9,
66,
9,
79,
9,
6404,
7,
37,
4008,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
34220,
11187,
7,
77,
11,
288,
9,
7,
37,
61,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
79,
20679,
87,
61,
16,
11,
2124,
11,
352,
11,
26003,
34500,
4873,
7,
34220,
11187,
7,
77,
11,
288,
9,
7,
37,
61,
7,
64,
9,
66,
1343,
275,
9,
66,
9,
87,
4008,
61,
79,
20679,
87,
11,
2124,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
16375,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
7,
67,
9,
87,
8,
61,
76,
9,
47,
7,
87,
27493,
7,
70,
10,
71,
9,
6404,
7,
69,
9,
7,
67,
10,
68,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
10,
65,
9,
87,
4008,
46249,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
87,
61,
76,
9,
6404,
7,
16,
12,
66,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
828,
2124,
11,
4353,
11,
357,
28567,
9,
87,
20679,
7,
37452,
9,
66,
61,
18,
8,
1343,
357,
20219,
9,
87,
61,
17,
20679,
7,
1157,
4309,
9,
66,
61,
17,
8,
1343,
357,
3134,
9,
87,
61,
18,
20679,
7,
1558,
2078,
9,
66,
8,
1343,
357,
18,
9,
87,
61,
19,
20679,
11645,
1343,
357,
20219,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
37452,
9,
66,
61,
19,
8,
532,
357,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
23,
9,
66,
61,
17,
8,
532,
357,
20,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
4761,
9,
66,
8,
532,
357,
18,
14,
2414,
27493,
87,
61,
19,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
18,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
23,
9,
66,
61,
19,
8,
532,
2604,
7,
16,
532,
269,
9,
87,
8,
61,
17,
29006,
1433,
9,
66,
61,
19,
8,
1343,
357,
16,
14,
1433,
27493,
87,
61,
19,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
357,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
66,
61,
19,
8,
532,
357,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
19,
9,
66,
61,
18,
8,
532,
357,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
23,
9,
66,
61,
17,
8,
532,
357,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
1065,
9,
66,
8,
532,
357,
16,
14,
1433,
27493,
87,
61,
19,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
19,
9,
66,
61,
19,
8,
1343,
357,
16,
14,
19,
27493,
87,
61,
19,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
29006,
17,
9,
66,
61,
19,
8,
1343,
12280,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
20679,
7,
17,
9,
66,
61,
19,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
828,
2124,
11,
3261,
11,
357,
3132,
9,
87,
20679,
7,
2623,
9,
66,
61,
17,
8,
1343,
357,
1157,
9,
87,
61,
17,
20679,
7,
4761,
9,
66,
8,
1343,
2124,
61,
18,
14,
1983,
1343,
357,
1157,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
2623,
9,
66,
61,
18,
8,
532,
357,
22,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
2623,
9,
66,
8,
532,
357,
16,
14,
24,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
20,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
24,
9,
66,
61,
18,
8,
532,
2604,
7,
16,
532,
269,
9,
87,
8,
61,
17,
29006,
24,
9,
66,
61,
18,
8,
1343,
357,
16,
14,
24,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
357,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
18,
9,
66,
61,
18,
8,
532,
357,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
18,
9,
66,
61,
17,
8,
532,
357,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
21,
9,
66,
8,
532,
357,
16,
14,
24,
27493,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
18,
9,
66,
61,
18,
8,
1343,
357,
16,
14,
18,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
29006,
18,
9,
66,
61,
18,
8,
1343,
357,
17,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
4008,
29006,
18,
9,
66,
61,
18,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
828,
2124,
11,
2534,
11,
357,
1485,
9,
87,
20679,
7,
23,
9,
66,
8,
1343,
2124,
61,
17,
14,
1433,
1343,
357,
16,
532,
269,
9,
87,
8,
61,
17,
29006,
23,
9,
66,
61,
17,
8,
1343,
2604,
7,
16,
532,
269,
9,
87,
20679,
7,
23,
9,
66,
61,
17,
8,
532,
357,
16,
14,
23,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
18,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
17,
9,
66,
61,
17,
8,
532,
14808,
16,
532,
269,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
19,
9,
66,
61,
17,
8,
532,
14808,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
66,
61,
17,
8,
1343,
14808,
16,
532,
269,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
66,
61,
17,
8,
532,
357,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
66,
61,
17,
8,
532,
357,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
66,
8,
532,
357,
16,
14,
19,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
66,
61,
17,
8,
1343,
357,
16,
14,
17,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
14,
66,
61,
17,
1343,
12280,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
20679,
66,
61,
17,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
828,
2124,
11,
1315,
11,
513,
9,
87,
1343,
357,
18,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
14,
66,
532,
14808,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
66,
532,
357,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
66,
532,
2124,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
14,
66,
1343,
2124,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
14,
66,
1343,
357,
17,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
4008,
14,
66,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
16,
11,
2124,
11,
352,
11,
13841,
7,
16,
14,
17,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
61,
17,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
17,
11,
2124,
11,
838,
11,
14808,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
87,
1343,
269,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
362,
9,
66,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
1343,
269,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
14,
87,
1343,
362,
9,
66,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
8,
532,
269,
9,
34220,
11187,
7,
18,
11,
269,
9,
87,
8,
532,
362,
9,
66,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
18,
11,
2124,
11,
2242,
11,
13841,
66,
61,
17,
27493,
6404,
7,
87,
8,
1343,
269,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
532,
357,
66,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
14,
87,
532,
357,
16,
14,
19,
27493,
66,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
1343,
2604,
7,
16,
532,
269,
9,
87,
8,
61,
17,
29006,
19,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
17,
27493,
66,
61,
17,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
357,
16,
14,
17,
27493,
66,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
1343,
357,
66,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
87,
8,
1343,
357,
16,
14,
17,
27493,
66,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
87,
61,
17,
8,
1343,
269,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
66,
61,
17,
9,
34220,
11187,
7,
18,
11,
269,
9,
87,
8,
532,
269,
61,
17,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
19,
11,
2124,
11,
1542,
11,
357,
22,
9,
66,
61,
17,
20679,
7,
2623,
9,
87,
8,
532,
357,
18,
14,
19,
27493,
66,
61,
18,
9,
6404,
7,
87,
8,
1343,
357,
18,
14,
19,
27493,
66,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
532,
357,
22,
9,
66,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
2623,
9,
87,
61,
17,
8,
532,
357,
20,
9,
66,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
24,
9,
87,
8,
532,
357,
16,
14,
24,
27493,
66,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
1343,
2604,
7,
16,
532,
269,
9,
87,
8,
61,
17,
29006,
24,
9,
87,
61,
18,
8,
1343,
357,
16,
14,
18,
27493,
66,
61,
18,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
357,
17,
14,
24,
27493,
66,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
1343,
357,
66,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
21,
9,
87,
61,
17,
8,
1343,
357,
66,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
18,
9,
87,
8,
1343,
357,
16,
14,
18,
27493,
66,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
18,
9,
87,
61,
18,
8,
1343,
357,
17,
14,
18,
27493,
66,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
8,
532,
357,
16,
14,
18,
27493,
66,
61,
18,
9,
34220,
11187,
7,
18,
11,
269,
9,
87,
8,
532,
357,
17,
14,
18,
27493,
66,
61,
18,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
20,
11,
2124,
11,
5214,
11,
357,
20,
9,
66,
61,
17,
20679,
7,
18444,
9,
87,
61,
17,
8,
1343,
357,
22,
9,
66,
61,
18,
20679,
7,
2623,
9,
87,
8,
532,
357,
3901,
14,
4761,
27493,
66,
61,
19,
9,
6404,
7,
87,
8,
1343,
357,
3901,
14,
4761,
27493,
66,
61,
19,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
532,
357,
20,
9,
66,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
4761,
9,
87,
61,
18,
8,
532,
357,
66,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
23,
9,
87,
61,
17,
8,
532,
357,
18,
9,
66,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
23,
9,
87,
8,
532,
357,
16,
14,
1433,
27493,
66,
61,
19,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
1343,
2604,
7,
16,
532,
269,
9,
87,
8,
61,
17,
29006,
1433,
9,
87,
61,
19,
8,
1343,
357,
16,
14,
19,
27493,
66,
61,
19,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
357,
16,
14,
23,
27493,
66,
61,
19,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
1343,
357,
66,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
1065,
9,
87,
61,
18,
8,
1343,
357,
66,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
23,
9,
87,
61,
17,
8,
1343,
357,
66,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
19,
9,
87,
8,
1343,
357,
16,
14,
19,
27493,
66,
61,
19,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
19,
9,
87,
61,
19,
8,
1343,
357,
16,
14,
17,
27493,
66,
61,
19,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
8,
532,
357,
16,
14,
19,
27493,
66,
61,
19,
9,
34220,
11187,
7,
18,
11,
269,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
66,
61,
19,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
87,
61,
76,
9,
7,
70,
10,
71,
9,
6404,
7,
16,
12,
66,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
7,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
828,
2124,
11,
1679,
11,
357,
19244,
9,
71,
9,
87,
20679,
7,
15711,
9,
66,
61,
17,
8,
1343,
357,
1485,
9,
71,
9,
87,
61,
17,
20679,
7,
20666,
9,
66,
8,
1343,
357,
71,
9,
87,
61,
18,
20679,
6659,
1343,
357,
71,
9,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
21,
9,
66,
61,
18,
8,
532,
357,
17,
9,
71,
9,
7,
16,
532,
269,
9,
87,
8,
61,
18,
20679,
7,
6659,
9,
66,
61,
18,
8,
1343,
357,
1485,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
15711,
9,
66,
61,
18,
8,
532,
357,
71,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
1065,
9,
66,
8,
532,
357,
16,
14,
1983,
27493,
71,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
71,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
18,
9,
66,
61,
18,
8,
1343,
357,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
24,
9,
66,
61,
18,
8,
532,
357,
71,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
18,
9,
66,
61,
18,
8,
1343,
357,
16,
14,
24,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
1343,
14808,
16,
532,
269,
9,
87,
27493,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
18,
9,
66,
61,
18,
8,
532,
14808,
16,
532,
269,
9,
87,
8,
61,
17,
9,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
21,
9,
66,
61,
18,
8,
1343,
14808,
16,
532,
269,
9,
87,
8,
61,
18,
9,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
1983,
9,
66,
61,
18,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
24,
9,
66,
61,
18,
8,
532,
357,
71,
9,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
18,
9,
66,
61,
17,
8,
532,
357,
71,
9,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
21,
9,
66,
8,
532,
357,
16,
14,
24,
27493,
71,
9,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
18,
9,
66,
61,
18,
8,
1343,
357,
16,
14,
18,
27493,
87,
61,
18,
9,
7,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
17,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
29006,
18,
9,
66,
61,
18,
8,
1343,
357,
17,
9,
71,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
4008,
29006,
18,
9,
66,
61,
18,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
7,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
828,
2124,
11,
2310,
11,
357,
1485,
9,
71,
9,
87,
20679,
7,
23,
9,
66,
8,
1343,
357,
71,
9,
87,
61,
17,
20679,
1433,
1343,
357,
71,
9,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
23,
9,
66,
61,
17,
8,
1343,
357,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
23,
9,
66,
61,
17,
8,
532,
357,
16,
14,
23,
27493,
71,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
71,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
17,
9,
66,
61,
17,
8,
1343,
357,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
66,
61,
17,
8,
532,
357,
71,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
66,
61,
17,
8,
1343,
357,
16,
14,
19,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
1343,
14808,
16,
532,
269,
9,
87,
27493,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
17,
9,
66,
61,
17,
8,
532,
14808,
16,
532,
269,
9,
87,
8,
61,
17,
9,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
23,
9,
66,
61,
17,
8,
532,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
19,
9,
66,
61,
17,
8,
532,
357,
71,
9,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
66,
8,
532,
357,
16,
14,
19,
27493,
71,
9,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
66,
61,
17,
8,
1343,
357,
16,
14,
17,
27493,
87,
61,
17,
9,
7,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
14,
66,
61,
17,
1343,
357,
71,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
4008,
14,
66,
61,
17,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
7,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
828,
2124,
11,
1248,
11,
13841,
70,
27493,
87,
1343,
513,
9,
71,
9,
87,
532,
357,
70,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
14,
66,
1343,
357,
18,
9,
71,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
14,
66,
532,
357,
71,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
66,
532,
357,
71,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
66,
532,
289,
9,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
14,
66,
1343,
2124,
9,
7,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
17,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
14,
66,
1343,
357,
17,
9,
71,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
4008,
14,
66,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
16,
11,
2124,
11,
513,
11,
13841,
7,
16,
14,
17,
4008,
9,
71,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
61,
17,
1343,
308,
9,
34220,
11187,
7,
18,
11,
269,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
17,
11,
2124,
11,
1105,
11,
269,
9,
71,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
1343,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
87,
1343,
269,
9,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
6404,
7,
16,
532,
352,
29006,
16,
532,
269,
9,
87,
4008,
1343,
269,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
14808,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
14,
87,
532,
362,
9,
66,
9,
71,
9,
34220,
11187,
7,
17,
11,
352,
29006,
16,
532,
269,
9,
87,
4008,
1343,
362,
9,
66,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
8,
532,
269,
9,
71,
9,
34220,
11187,
7,
18,
11,
269,
9,
87,
8,
532,
362,
9,
66,
9,
71,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
18,
11,
2124,
11,
1160,
11,
13841,
66,
61,
17,
27493,
71,
9,
6404,
7,
87,
8,
1343,
357,
16,
14,
17,
27493,
66,
61,
17,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
532,
357,
66,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
17,
9,
87,
8,
1343,
357,
16,
14,
17,
27493,
66,
61,
17,
9,
71,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
1343,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
19,
9,
87,
61,
17,
8,
532,
357,
66,
9,
7,
16,
532,
269,
9,
87,
27493,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
19,
9,
87,
8,
1343,
357,
16,
14,
19,
27493,
66,
61,
17,
9,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
6404,
7,
16,
532,
352,
29006,
16,
532,
269,
9,
87,
4008,
1343,
357,
66,
9,
71,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
87,
8,
1343,
357,
16,
14,
17,
27493,
66,
61,
17,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
14808,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
87,
61,
17,
8,
532,
357,
16,
14,
17,
27493,
66,
61,
17,
9,
71,
9,
34220,
11187,
7,
17,
11,
352,
29006,
16,
532,
269,
9,
87,
4008,
1343,
269,
61,
17,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
66,
61,
17,
9,
71,
9,
34220,
11187,
7,
18,
11,
269,
9,
87,
8,
532,
269,
61,
17,
9,
71,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
19,
11,
2124,
11,
2579,
11,
357,
22,
9,
66,
61,
17,
9,
71,
20679,
7,
2623,
9,
87,
8,
532,
357,
18,
14,
19,
27493,
66,
61,
18,
9,
71,
9,
6404,
7,
87,
8,
1343,
357,
1129,
14,
2623,
27493,
66,
61,
18,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
532,
357,
66,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
1065,
9,
87,
61,
17,
8,
532,
357,
66,
61,
17,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
18,
9,
87,
8,
1343,
357,
16,
14,
18,
27493,
66,
61,
18,
9,
71,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
1343,
357,
6404,
7,
16,
532,
269,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
24,
9,
87,
61,
18,
8,
532,
357,
66,
9,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
1507,
9,
87,
61,
17,
8,
532,
357,
66,
61,
17,
9,
7,
16,
532,
269,
9,
87,
27493,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
20679,
7,
24,
9,
87,
8,
1343,
357,
16,
14,
24,
27493,
66,
61,
18,
9,
7,
70,
1343,
362,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
6404,
7,
16,
532,
352,
29006,
16,
532,
269,
9,
87,
4008,
1343,
357,
66,
9,
71,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
21,
9,
87,
61,
17,
8,
1343,
357,
66,
61,
17,
9,
71,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
18,
9,
87,
8,
1343,
357,
16,
14,
18,
27493,
66,
61,
18,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
14808,
70,
1343,
289,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
18,
9,
87,
61,
18,
8,
532,
357,
17,
14,
24,
27493,
66,
61,
18,
9,
71,
9,
34220,
11187,
7,
17,
11,
352,
29006,
16,
532,
269,
9,
87,
4008,
1343,
357,
17,
14,
18,
27493,
66,
61,
18,
9,
71,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
8,
532,
357,
16,
14,
18,
27493,
66,
61,
18,
9,
71,
9,
34220,
11187,
7,
18,
11,
269,
9,
87,
8,
532,
357,
17,
14,
18,
27493,
66,
61,
18,
9,
71,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
87,
61,
76,
9,
7,
70,
10,
71,
9,
6404,
7,
69,
9,
7,
67,
10,
68,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
10,
65,
9,
87,
4008,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
36911,
2124,
11,
15495,
11,
532,
19510,
64,
61,
17,
9,
70,
9,
87,
20679,
7,
18,
9,
65,
61,
17,
4008,
1343,
357,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
70,
9,
87,
20679,
7,
21,
9,
65,
61,
17,
9,
66,
8,
532,
14808,
16,
532,
257,
9,
66,
8,
61,
17,
9,
70,
9,
87,
20679,
7,
24,
9,
65,
61,
17,
9,
66,
61,
17,
8,
1343,
357,
22,
9,
64,
61,
17,
9,
71,
9,
77,
9,
87,
20679,
7,
24,
9,
65,
61,
17,
8,
532,
357,
1157,
9,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
71,
9,
77,
9,
87,
20679,
7,
2623,
9,
65,
61,
17,
9,
66,
8,
1343,
357,
20,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
9,
71,
9,
77,
9,
87,
20679,
7,
1983,
9,
65,
61,
17,
9,
66,
61,
17,
8,
1343,
357,
1485,
9,
67,
61,
17,
9,
71,
9,
77,
9,
87,
20679,
7,
1983,
9,
68,
61,
17,
8,
1343,
357,
20,
9,
64,
9,
67,
9,
71,
9,
77,
9,
87,
20679,
7,
1065,
9,
65,
9,
68,
8,
532,
357,
22,
9,
7,
16,
532,
257,
9,
66,
27493,
67,
9,
71,
9,
77,
9,
87,
20679,
7,
2623,
9,
65,
9,
66,
9,
68,
8,
532,
357,
64,
9,
71,
9,
77,
9,
87,
61,
17,
20679,
7,
24,
9,
65,
8,
1343,
357,
22,
9,
7,
16,
532,
257,
9,
66,
27493,
71,
9,
77,
9,
87,
61,
17,
20679,
7,
15711,
9,
65,
9,
66,
8,
532,
357,
1129,
9,
67,
9,
71,
9,
77,
9,
87,
61,
17,
20679,
7,
20666,
9,
68,
8,
1343,
357,
16,
14,
1983,
27493,
71,
9,
77,
9,
87,
61,
18,
532,
357,
20,
9,
64,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
2623,
9,
65,
61,
18,
9,
66,
61,
17,
8,
1343,
357,
17,
9,
7,
16,
532,
257,
9,
66,
8,
61,
18,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
1983,
9,
65,
61,
18,
9,
66,
61,
18,
8,
532,
357,
20,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
9,
67,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
2623,
9,
65,
61,
17,
9,
66,
61,
17,
9,
68,
8,
1343,
357,
20,
9,
64,
9,
71,
9,
77,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
2623,
9,
65,
8,
1343,
357,
20,
9,
67,
9,
71,
9,
77,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
2623,
9,
68,
8,
532,
357,
17,
14,
1983,
27493,
71,
9,
77,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
1343,
357,
19,
9,
64,
61,
17,
9,
71,
9,
77,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
24,
9,
65,
61,
18,
9,
66,
8,
1343,
357,
19,
9,
67,
61,
17,
9,
71,
9,
77,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
24,
9,
65,
9,
66,
9,
68,
61,
17,
8,
1343,
357,
64,
9,
67,
9,
71,
9,
77,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
18,
9,
65,
61,
17,
9,
66,
9,
68,
8,
532,
357,
67,
61,
18,
9,
71,
9,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
4008,
29006,
1983,
9,
68,
61,
18,
8,
532,
357,
64,
9,
67,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
4008,
29006,
1065,
9,
65,
9,
68,
61,
17,
8,
1343,
14808,
16,
532,
257,
9,
66,
27493,
67,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
4008,
29006,
1507,
9,
65,
9,
66,
9,
68,
61,
17,
8,
1343,
357,
67,
61,
18,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
24,
9,
68,
61,
18,
8,
1343,
357,
64,
9,
67,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
21,
9,
65,
9,
68,
61,
17,
8,
1343,
357,
64,
61,
17,
9,
67,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
18,
9,
65,
61,
17,
9,
68,
8,
532,
357,
64,
61,
17,
9,
71,
9,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
29006,
18,
9,
65,
61,
17,
9,
68,
8,
1343,
357,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
71,
9,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
29006,
21,
9,
65,
61,
17,
9,
66,
9,
68,
8,
532,
14808,
16,
532,
257,
9,
66,
8,
61,
17,
9,
71,
9,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
29006,
24,
9,
65,
61,
17,
9,
66,
61,
17,
9,
68,
8,
1343,
357,
64,
9,
87,
61,
17,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
1065,
9,
65,
8,
532,
14808,
16,
532,
257,
9,
66,
27493,
87,
61,
17,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
1507,
9,
65,
9,
66,
8,
532,
357,
16,
14,
1983,
27493,
87,
61,
18,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
1343,
357,
64,
61,
17,
9,
87,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
18,
9,
65,
61,
17,
8,
532,
357,
64,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
21,
9,
65,
8,
1343,
357,
16,
14,
24,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
532,
357,
64,
61,
17,
9,
7,
16,
532,
257,
9,
66,
27493,
6404,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
18,
9,
65,
61,
18,
9,
66,
8,
1343,
357,
64,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
9,
6404,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
21,
9,
65,
61,
18,
9,
66,
61,
17,
8,
532,
14808,
16,
532,
257,
9,
66,
8,
61,
18,
9,
6404,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
24,
9,
65,
61,
18,
9,
66,
61,
18,
8,
532,
357,
64,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
21,
9,
65,
61,
18,
8,
1343,
357,
67,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
21,
9,
68,
61,
18,
8,
532,
357,
64,
61,
18,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
65,
61,
18,
8,
1343,
357,
67,
61,
18,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
68,
61,
18,
8,
1343,
357,
64,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
21,
9,
65,
61,
18,
8,
532,
357,
67,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
21,
9,
68,
61,
18,
8,
1343,
357,
64,
61,
18,
9,
70,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
65,
61,
18,
8,
532,
357,
64,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
24,
9,
65,
61,
18,
8,
532,
357,
64,
9,
67,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
65,
9,
68,
61,
17,
8,
532,
357,
64,
61,
17,
9,
67,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
21,
9,
65,
61,
17,
9,
68,
8,
532,
357,
67,
61,
17,
9,
71,
9,
77,
9,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
68,
61,
17,
8,
1343,
357,
67,
9,
71,
9,
77,
9,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
21,
9,
68,
8,
532,
357,
16,
14,
24,
27493,
71,
9,
77,
9,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
357,
67,
61,
18,
9,
71,
9,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
68,
61,
18,
8,
532,
357,
64,
61,
18,
9,
71,
9,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
65,
61,
18,
8,
1343,
357,
16,
14,
18,
27493,
87,
61,
18,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
357,
67,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
24,
9,
68,
61,
18,
8,
1343,
357,
64,
9,
67,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
21,
9,
65,
9,
68,
61,
17,
8,
1343,
357,
64,
61,
17,
9,
67,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
18,
9,
65,
61,
17,
9,
68,
8,
532,
357,
64,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
18,
9,
65,
61,
18,
8,
1343,
357,
67,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
18,
9,
68,
61,
18,
8,
532,
357,
64,
61,
17,
9,
7,
16,
532,
257,
9,
66,
27493,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
18,
9,
65,
61,
18,
9,
66,
8,
1343,
357,
64,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
21,
9,
65,
61,
18,
9,
66,
61,
17,
8,
532,
14808,
16,
532,
257,
9,
66,
8,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
24,
9,
65,
61,
18,
9,
66,
61,
18,
8,
532,
357,
64,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
65,
61,
18,
8,
1343,
357,
67,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
68,
61,
18,
8,
1343,
357,
64,
61,
18,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
18,
9,
65,
61,
18,
8,
532,
357,
67,
61,
18,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
18,
9,
68,
61,
18,
8,
532,
357,
64,
61,
18,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
18,
9,
65,
61,
18,
8,
1343,
357,
67,
61,
18,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
18,
9,
68,
61,
18,
8,
1343,
357,
64,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
18,
9,
65,
61,
18,
8,
532,
357,
67,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
18,
9,
68,
61,
18,
8,
1343,
357,
64,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
65,
61,
18,
8,
532,
357,
67,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
68,
61,
18,
8,
1343,
357,
64,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
18,
9,
65,
61,
18,
8,
532,
357,
67,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
18,
9,
68,
61,
18,
8,
532,
357,
64,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
18,
9,
65,
61,
18,
8,
1343,
357,
67,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
18,
9,
68,
61,
18,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
36911,
2124,
11,
8275,
11,
357,
64,
9,
70,
9,
87,
20679,
7,
17,
9,
65,
8,
532,
14808,
16,
532,
257,
9,
66,
27493,
70,
9,
87,
20679,
7,
19,
9,
65,
9,
66,
8,
532,
357,
20,
9,
64,
9,
71,
9,
77,
9,
87,
20679,
7,
19,
9,
65,
8,
1343,
14808,
16,
532,
257,
9,
66,
27493,
71,
9,
77,
9,
87,
20679,
7,
17,
9,
65,
9,
66,
8,
532,
357,
22,
9,
67,
9,
71,
9,
77,
9,
87,
20679,
7,
23,
9,
68,
8,
1343,
357,
18,
14,
1433,
27493,
71,
9,
77,
9,
87,
61,
17,
1343,
14808,
16,
532,
257,
9,
66,
8,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
19,
9,
65,
61,
17,
9,
66,
61,
17,
8,
532,
357,
16,
14,
19,
27493,
71,
9,
77,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
532,
357,
18,
9,
64,
9,
71,
9,
77,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
19,
9,
65,
61,
17,
9,
66,
8,
532,
357,
18,
9,
67,
9,
71,
9,
77,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
19,
9,
65,
9,
66,
9,
68,
8,
1343,
357,
67,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
4008,
29006,
23,
9,
68,
61,
17,
8,
532,
357,
67,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
19,
9,
68,
61,
17,
8,
532,
357,
64,
9,
67,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
17,
9,
65,
9,
68,
8,
1343,
357,
64,
9,
71,
9,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
29006,
17,
9,
65,
9,
68,
8,
532,
14808,
16,
532,
257,
9,
66,
27493,
71,
9,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
29006,
19,
9,
65,
9,
66,
9,
68,
8,
532,
357,
16,
14,
23,
27493,
87,
61,
17,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
532,
357,
64,
9,
87,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
17,
9,
65,
8,
1343,
357,
16,
14,
19,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
1343,
357,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
6404,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
17,
9,
65,
61,
17,
9,
66,
8,
532,
14808,
16,
532,
257,
9,
66,
8,
61,
17,
9,
6404,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
19,
9,
65,
61,
17,
9,
66,
61,
17,
8,
1343,
357,
64,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
19,
9,
65,
61,
17,
8,
532,
357,
67,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
19,
9,
68,
61,
17,
8,
1343,
357,
64,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
65,
61,
17,
8,
532,
357,
67,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
68,
61,
17,
8,
532,
357,
64,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
19,
9,
65,
61,
17,
8,
1343,
357,
67,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
19,
9,
68,
61,
17,
8,
532,
357,
64,
61,
17,
9,
70,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
65,
61,
17,
8,
1343,
357,
64,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
19,
9,
65,
61,
17,
8,
1343,
357,
64,
9,
67,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
65,
9,
68,
8,
1343,
357,
67,
9,
71,
9,
77,
9,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
68,
8,
532,
357,
16,
14,
19,
27493,
71,
9,
77,
9,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
357,
67,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
68,
61,
17,
8,
1343,
357,
64,
61,
17,
9,
71,
9,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
65,
61,
17,
8,
1343,
357,
16,
14,
17,
27493,
87,
61,
17,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
357,
67,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
19,
9,
68,
61,
17,
8,
532,
357,
64,
9,
67,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
17,
9,
65,
9,
68,
8,
1343,
357,
64,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
17,
9,
65,
61,
17,
8,
532,
357,
67,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
17,
9,
68,
61,
17,
8,
1343,
357,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
17,
9,
65,
61,
17,
9,
66,
8,
532,
14808,
16,
532,
257,
9,
66,
8,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
19,
9,
65,
61,
17,
9,
66,
61,
17,
8,
1343,
357,
64,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
65,
61,
17,
8,
532,
357,
67,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
68,
61,
17,
8,
532,
357,
64,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
17,
9,
65,
61,
17,
8,
1343,
357,
67,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
17,
9,
68,
61,
17,
8,
1343,
357,
64,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
17,
9,
65,
61,
17,
8,
532,
357,
67,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
17,
9,
68,
61,
17,
8,
532,
357,
64,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
17,
9,
65,
61,
17,
8,
1343,
357,
67,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
17,
9,
68,
61,
17,
8,
532,
357,
64,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
65,
61,
17,
8,
1343,
357,
67,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
68,
61,
17,
8,
532,
357,
64,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
17,
9,
65,
61,
17,
8,
1343,
357,
67,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
17,
9,
68,
61,
17,
8,
1343,
357,
64,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
17,
9,
65,
61,
17,
8,
532,
357,
67,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
17,
9,
68,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
36911,
2124,
11,
5433,
11,
13841,
70,
27493,
87,
1343,
513,
9,
71,
9,
77,
9,
87,
532,
357,
70,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
8,
1343,
357,
17,
9,
71,
9,
77,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
8,
1343,
357,
67,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
32590,
67,
532,
304,
9,
87,
4008,
14,
68,
1343,
357,
67,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
68,
1343,
357,
67,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
61,
17,
20679,
7,
17,
9,
68,
8,
532,
357,
67,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
1343,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
61,
17,
20679,
7,
17,
9,
68,
8,
532,
357,
71,
9,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
14,
68,
1343,
289,
9,
87,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
8,
532,
14808,
16,
532,
257,
9,
66,
27493,
71,
9,
6404,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
29006,
65,
9,
66,
8,
532,
357,
64,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
17,
9,
65,
8,
532,
357,
64,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
65,
1343,
357,
64,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
17,
9,
65,
8,
1343,
357,
64,
9,
70,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
65,
532,
357,
64,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
65,
532,
357,
64,
9,
71,
9,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
65,
1343,
2124,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
357,
67,
9,
71,
9,
77,
9,
7,
6404,
32590,
67,
532,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
14,
68,
1343,
357,
67,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
68,
532,
289,
9,
77,
9,
87,
9,
34220,
11187,
7,
17,
11,
257,
9,
66,
1343,
275,
9,
66,
9,
87,
8,
1343,
357,
67,
9,
71,
9,
77,
9,
6404,
32590,
67,
532,
304,
9,
87,
27493,
34220,
11187,
7,
17,
11,
257,
9,
66,
1343,
275,
9,
66,
9,
87,
4008,
14,
68,
532,
357,
67,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
68,
1343,
357,
67,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
14,
68,
1343,
357,
67,
9,
71,
9,
77,
9,
7,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
1343,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
68,
532,
357,
64,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
65,
532,
14808,
16,
532,
257,
9,
66,
27493,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
65,
9,
66,
8,
532,
357,
64,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
65,
1343,
357,
64,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
65,
532,
357,
64,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
14,
65,
532,
357,
67,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
14,
68,
532,
357,
67,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
68,
1343,
357,
67,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
14,
68,
1343,
357,
64,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
65,
532,
357,
67,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
68,
1343,
357,
64,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
65,
1343,
357,
64,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
65,
532,
357,
64,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
14,
65,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
61,
16,
11,
2124,
11,
657,
11,
791,
18908,
81,
540,
19510,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
87,
11,
2124,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
61,
17,
11,
2124,
11,
2534,
11,
532,
19510,
65,
9,
70,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
14,
64,
8,
532,
357,
65,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
67,
1343,
304,
9,
87,
4008,
14,
64,
532,
357,
65,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
87,
20679,
19510,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
61,
17,
20679,
7,
17,
9,
64,
8,
1343,
357,
65,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
532,
2604,
32590,
19510,
68,
9,
87,
20679,
67,
22305,
9,
7,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
1343,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
61,
17,
20679,
7,
17,
9,
64,
8,
1343,
357,
65,
9,
71,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
64,
1343,
357,
65,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
17,
9,
64,
8,
532,
357,
68,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
17,
9,
67,
8,
1343,
357,
68,
9,
71,
9,
77,
9,
6404,
7,
87,
27493,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
67,
1343,
357,
65,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
532,
357,
68,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
67,
532,
357,
65,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
17,
9,
64,
8,
1343,
357,
68,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
17,
9,
67,
8,
1343,
357,
68,
9,
71,
9,
77,
9,
7,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
8,
1343,
2604,
19510,
16,
532,
257,
9,
66,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
532,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
61,
17,
20679,
7,
17,
9,
67,
8,
1343,
357,
68,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
4008,
9,
7,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
61,
17,
20679,
7,
17,
9,
67,
8,
1343,
357,
68,
9,
71,
9,
77,
9,
7,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
20679,
67,
532,
357,
65,
9,
70,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
1343,
357,
68,
9,
71,
9,
77,
9,
6404,
7,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
67,
532,
357,
68,
9,
71,
9,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
67,
1343,
357,
65,
9,
71,
9,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
532,
14808,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
87,
532,
357,
65,
9,
70,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
64,
532,
357,
65,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
64,
1343,
357,
65,
9,
71,
9,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
64,
532,
357,
65,
9,
71,
9,
77,
9,
6404,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
14,
19510,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
35514,
14,
64,
1343,
357,
65,
9,
71,
9,
77,
9,
6404,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
64,
1343,
357,
65,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
64,
532,
357,
68,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
67,
532,
357,
65,
9,
71,
9,
77,
9,
7,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
1343,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
1343,
357,
68,
9,
87,
20679,
67,
4008,
14,
64,
1343,
357,
68,
9,
71,
9,
77,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
4008,
14,
67,
532,
357,
68,
9,
71,
9,
77,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
20679,
67,
1343,
357,
65,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
532,
357,
68,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
67,
1343,
357,
68,
9,
71,
9,
77,
9,
7,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
67,
532,
357,
65,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
64,
1343,
357,
68,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
67,
1343,
357,
65,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
14,
64,
532,
357,
68,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
14,
67,
532,
357,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
20679,
67,
1343,
357,
65,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
64,
532,
357,
65,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
14,
19510,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
35514,
14,
64,
1343,
357,
65,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
64,
532,
357,
65,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
64,
1343,
357,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
67,
1343,
357,
65,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
1343,
357,
68,
9,
87,
20679,
67,
4008,
14,
64,
1343,
357,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
4008,
14,
67,
532,
357,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
20679,
67,
532,
357,
65,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
64,
532,
357,
65,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
64,
1343,
357,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
67,
1343,
357,
65,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
14,
64,
532,
357,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
14,
67,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
61,
18,
11,
2124,
11,
5846,
11,
357,
65,
61,
17,
9,
70,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
17,
9,
64,
61,
17,
8,
532,
357,
65,
9,
68,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
64,
9,
67,
8,
1343,
357,
65,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
67,
1343,
304,
9,
87,
4008,
29006,
17,
9,
64,
61,
17,
8,
1343,
357,
65,
9,
68,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
17,
9,
64,
9,
67,
8,
1343,
357,
65,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
87,
20679,
19510,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
61,
17,
20679,
7,
19,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
532,
2604,
32590,
19510,
68,
9,
87,
20679,
67,
22305,
9,
7,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
1343,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
61,
17,
20679,
7,
19,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
66,
9,
6404,
32590,
19510,
68,
9,
87,
20679,
67,
4008,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
17,
9,
64,
9,
7,
16,
532,
257,
9,
66,
4008,
1343,
357,
65,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
17,
9,
64,
9,
87,
8,
532,
357,
65,
61,
17,
9,
66,
9,
6404,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
17,
9,
64,
9,
7,
16,
532,
257,
9,
66,
4008,
532,
357,
65,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
19,
9,
64,
61,
17,
8,
1343,
357,
68,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
19,
9,
67,
61,
17,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
87,
27493,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
1343,
357,
68,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
67,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
19,
9,
64,
61,
17,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
19,
9,
67,
61,
17,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
8,
1343,
2604,
19510,
16,
532,
257,
9,
66,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
532,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
61,
17,
20679,
7,
19,
9,
67,
61,
17,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
4008,
9,
7,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
61,
17,
20679,
7,
19,
9,
67,
61,
17,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
20679,
7,
17,
9,
67,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
70,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
65,
9,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
9,
67,
8,
532,
357,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
67,
9,
87,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
67,
61,
17,
8,
1343,
357,
68,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
14808,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
87,
61,
17,
8,
1343,
357,
65,
9,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
17,
9,
64,
9,
67,
8,
1343,
357,
65,
61,
17,
9,
70,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
65,
9,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
64,
9,
67,
8,
1343,
357,
65,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
14,
19510,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
35514,
29006,
17,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
1343,
357,
68,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
357,
65,
61,
17,
9,
66,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
17,
9,
64,
9,
7,
16,
532,
257,
9,
66,
4008,
1343,
357,
65,
61,
17,
9,
66,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
352,
1343,
357,
68,
9,
87,
20679,
67,
4008,
29006,
17,
9,
64,
9,
7,
16,
532,
257,
9,
66,
4008,
1343,
357,
65,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
1343,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
1343,
357,
68,
9,
87,
20679,
67,
4008,
29006,
17,
9,
64,
61,
17,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
4008,
29006,
17,
9,
67,
61,
17,
8,
1343,
357,
68,
61,
17,
9,
71,
9,
77,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
1343,
357,
68,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
7,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
67,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
17,
9,
64,
61,
17,
8,
1343,
357,
68,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
17,
9,
67,
61,
17,
8,
1343,
357,
68,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
14,
19510,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
35514,
29006,
17,
9,
64,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
17,
9,
64,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
1343,
357,
68,
9,
87,
20679,
67,
4008,
29006,
17,
9,
64,
61,
17,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
4008,
29006,
17,
9,
67,
61,
17,
8,
1343,
357,
68,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
20679,
7,
17,
9,
67,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
17,
9,
64,
61,
17,
8,
1343,
357,
65,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
17,
9,
64,
61,
17,
8,
532,
357,
68,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
357,
65,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
17,
9,
64,
61,
17,
8,
1343,
357,
68,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
17,
9,
67,
61,
17,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
14,
87,
61,
19,
11,
2124,
11,
8699,
11,
357,
65,
61,
17,
9,
66,
9,
68,
9,
71,
9,
77,
9,
6404,
7,
87,
4008,
29006,
17,
9,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
67,
8,
532,
357,
65,
61,
17,
9,
66,
9,
68,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
18,
9,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
67,
8,
1343,
357,
65,
9,
68,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
18,
9,
64,
9,
67,
9,
87,
8,
532,
357,
65,
61,
18,
9,
70,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
18,
9,
64,
61,
18,
8,
1343,
357,
65,
61,
17,
9,
68,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
17,
9,
64,
61,
17,
9,
67,
8,
1343,
357,
65,
9,
68,
61,
17,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
17,
9,
64,
9,
67,
61,
17,
8,
532,
357,
65,
61,
17,
9,
66,
9,
68,
9,
71,
9,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
4008,
29006,
21,
9,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
67,
8,
532,
357,
65,
61,
18,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
7,
67,
1343,
304,
9,
87,
4008,
29006,
18,
9,
64,
61,
18,
8,
532,
357,
65,
61,
17,
9,
68,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
18,
9,
64,
61,
17,
9,
67,
8,
532,
357,
65,
9,
68,
61,
17,
9,
71,
9,
77,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
6404,
19510,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
21,
9,
64,
9,
67,
61,
17,
8,
532,
357,
65,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
87,
20679,
19510,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
61,
17,
20679,
7,
21,
9,
64,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
532,
2604,
32590,
19510,
68,
9,
87,
20679,
67,
22305,
9,
7,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
1343,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
61,
17,
20679,
7,
21,
9,
64,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
6404,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
532,
357,
65,
61,
17,
9,
66,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
21,
9,
64,
9,
7,
16,
532,
257,
9,
66,
27493,
87,
8,
1343,
357,
65,
61,
18,
9,
66,
61,
17,
9,
6404,
32590,
19510,
68,
9,
87,
20679,
67,
4008,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
21,
9,
64,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
8,
532,
357,
65,
61,
18,
9,
66,
9,
6404,
32590,
19510,
68,
9,
87,
20679,
67,
4008,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
18,
9,
64,
61,
17,
9,
7,
16,
532,
257,
9,
66,
4008,
1343,
357,
65,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
21,
9,
64,
9,
87,
61,
17,
8,
532,
357,
65,
61,
17,
9,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
27493,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
18,
9,
64,
61,
17,
9,
87,
8,
532,
357,
65,
61,
18,
9,
66,
61,
17,
9,
6404,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
21,
9,
64,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
8,
1343,
357,
65,
61,
18,
9,
66,
9,
6404,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
9,
7,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
20679,
7,
18,
9,
64,
61,
17,
9,
7,
16,
532,
257,
9,
66,
4008,
1343,
357,
65,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
21,
9,
64,
61,
18,
8,
532,
357,
68,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
1343,
2604,
19510,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
22305,
532,
2604,
19510,
7,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
61,
17,
20679,
7,
21,
9,
67,
61,
18,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
6404,
7,
87,
27493,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
67,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
532,
357,
68,
61,
18,
9,
71,
9,
77,
9,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
67,
61,
18,
8,
532,
357,
65,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
21,
9,
64,
61,
18,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
68,
9,
7,
64,
1343,
275,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
35514,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
61,
17,
20679,
7,
21,
9,
67,
61,
18,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
8,
1343,
2604,
19510,
16,
532,
257,
9,
66,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
532,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
64,
1343,
275,
9,
87,
4008,
29006,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
61,
17,
20679,
7,
21,
9,
67,
61,
18,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
66,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
7,
16,
1343,
357,
65,
9,
87,
20679,
64,
4008,
9,
7,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
61,
17,
20679,
7,
21,
9,
67,
61,
18,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
532,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
20679,
7,
18,
9,
67,
61,
18,
8,
532,
357,
65,
61,
18,
9,
70,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
1343,
357,
65,
61,
17,
9,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
21,
9,
64,
61,
17,
9,
67,
8,
1343,
357,
65,
9,
68,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
64,
9,
67,
61,
17,
8,
532,
357,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
21,
9,
67,
9,
87,
61,
17,
8,
1343,
357,
68,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
67,
61,
17,
9,
87,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
6404,
7,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
67,
61,
18,
8,
532,
357,
68,
61,
18,
9,
71,
9,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
67,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
532,
14808,
70,
1343,
289,
9,
6404,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
87,
61,
18,
8,
532,
357,
65,
61,
17,
9,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
18,
9,
64,
61,
17,
9,
67,
8,
532,
357,
65,
9,
68,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
21,
9,
64,
9,
67,
61,
17,
8,
532,
357,
65,
61,
18,
9,
70,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
1343,
357,
65,
61,
17,
9,
68,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
17,
9,
64,
61,
17,
9,
67,
8,
1343,
357,
65,
9,
68,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
17,
9,
64,
9,
67,
61,
17,
8,
532,
357,
65,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
7,
77,
9,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
7,
69,
9,
7,
67,
1343,
304,
9,
87,
8,
61,
77,
4008,
9,
34220,
11187,
7,
17,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
532,
357,
65,
61,
18,
9,
71,
9,
77,
9,
6404,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
14,
19510,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
35514,
29006,
18,
9,
64,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
77,
9,
6404,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
18,
9,
64,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
532,
357,
68,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
1343,
2604,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
18,
9,
67,
61,
18,
8,
532,
357,
65,
61,
18,
9,
66,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
21,
9,
64,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
8,
1343,
357,
65,
61,
18,
9,
66,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
357,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
66,
9,
67,
1343,
304,
532,
257,
9,
66,
9,
68,
4008,
20679,
7,
18,
9,
64,
61,
17,
9,
7,
16,
532,
257,
9,
66,
4008,
1343,
357,
65,
61,
18,
9,
66,
61,
17,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
352,
1343,
357,
68,
9,
87,
20679,
67,
4008,
29006,
21,
9,
64,
9,
7,
16,
532,
257,
9,
66,
8,
61,
17,
8,
532,
357,
65,
61,
18,
9,
66,
9,
71,
9,
77,
9,
34220,
11187,
7,
17,
11,
352,
1343,
357,
68,
9,
87,
20679,
67,
4008,
29006,
18,
9,
64,
61,
17,
9,
7,
16,
532,
257,
9,
66,
4008,
532,
357,
65,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
8,
1343,
2604,
19510,
7,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
4008,
29006,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
1343,
357,
68,
9,
87,
20679,
67,
4008,
29006,
18,
9,
64,
61,
18,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
4008,
29006,
18,
9,
67,
61,
18,
8,
532,
357,
68,
61,
18,
9,
71,
9,
77,
9,
6404,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
22305,
9,
34220,
11187,
7,
17,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
20679,
7,
18,
9,
67,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
532,
357,
68,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
67,
1343,
304,
9,
87,
8,
532,
2604,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
22305,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
67,
61,
18,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
7,
6404,
7,
87,
8,
1343,
2604,
32590,
19510,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
67,
61,
18,
8,
532,
357,
65,
61,
18,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
18,
9,
64,
61,
18,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
18,
9,
67,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
18,
9,
64,
61,
18,
8,
532,
357,
68,
61,
18,
9,
71,
9,
77,
9,
6404,
19510,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
14,
19510,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
9,
34220,
11187,
7,
17,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
18,
9,
67,
61,
18,
8,
532,
357,
68,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
64,
4008,
20679,
7,
18,
9,
67,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
357,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
257,
9,
66,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
532,
357,
65,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
67,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
14,
19510,
16,
532,
257,
9,
66,
27493,
7,
67,
1343,
304,
9,
87,
35514,
29006,
18,
9,
64,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
257,
9,
66,
532,
275,
9,
66,
9,
87,
4008,
29006,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
18,
9,
64,
61,
18,
8,
532,
357,
65,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
357,
65,
9,
7,
67,
1343,
304,
9,
87,
4008,
29006,
65,
9,
67,
532,
257,
9,
68,
4008,
20679,
7,
18,
9,
67,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
1343,
357,
68,
9,
87,
20679,
67,
4008,
29006,
18,
9,
64,
61,
18,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
87,
20679,
7,
64,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
4008,
29006,
18,
9,
67,
61,
18,
8,
532,
357,
68,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
65,
9,
66,
9,
87,
20679,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
35514,
20679,
7,
18,
9,
67,
61,
18,
8,
532,
357,
65,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
18,
9,
64,
61,
18,
8,
532,
357,
65,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
18,
9,
64,
61,
18,
8,
1343,
357,
68,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
532,
19510,
68,
9,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
66,
9,
7,
67,
1343,
304,
9,
87,
35514,
20679,
7,
18,
9,
67,
61,
18,
8,
1343,
357,
65,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
18,
9,
64,
61,
18,
8,
532,
357,
68,
61,
18,
9,
71,
9,
77,
9,
34220,
11187,
7,
18,
11,
14808,
65,
9,
67,
532,
257,
9,
68,
27493,
7,
16,
532,
269,
9,
7,
64,
1343,
275,
9,
87,
4008,
20679,
7,
65,
9,
7,
67,
1343,
304,
9,
87,
35514,
29006,
18,
9,
67,
61,
18,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
87,
61,
76,
9,
7,
64,
10,
65,
9,
87,
27493,
6404,
7,
16,
12,
66,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
17,
9,
7,
64,
1343,
275,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
828,
2124,
11,
6740,
11,
357,
4310,
9,
65,
9,
87,
20679,
7,
17477,
9,
66,
61,
18,
8,
1343,
357,
1157,
9,
64,
9,
87,
20679,
7,
1983,
9,
66,
61,
17,
8,
1343,
357,
2920,
9,
7,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
87,
20679,
7,
45331,
9,
66,
61,
18,
8,
1343,
357,
1959,
9,
65,
9,
87,
61,
17,
20679,
7,
22842,
9,
66,
61,
17,
8,
1343,
357,
20,
9,
64,
9,
87,
61,
17,
20679,
7,
4051,
9,
66,
8,
1343,
357,
1485,
9,
7,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
87,
61,
17,
20679,
7,
39570,
9,
66,
61,
17,
8,
1343,
357,
17,
9,
64,
9,
87,
61,
18,
20679,
6659,
1343,
357,
1558,
9,
65,
9,
87,
61,
18,
20679,
7,
37452,
9,
66,
8,
1343,
14808,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
87,
61,
18,
20679,
7,
33916,
9,
66,
8,
1343,
357,
18,
9,
65,
9,
87,
61,
19,
20679,
11645,
1343,
357,
1959,
9,
65,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
17477,
9,
66,
61,
19,
8,
1343,
357,
20,
9,
64,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
1983,
9,
66,
61,
18,
8,
1343,
357,
1485,
9,
7,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
45331,
9,
66,
61,
19,
8,
532,
357,
65,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
1433,
9,
66,
61,
17,
8,
532,
357,
64,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
24,
9,
66,
8,
532,
14808,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
2780,
9,
66,
61,
17,
8,
532,
357,
17,
14,
1983,
27493,
64,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
532,
357,
65,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
1731,
9,
66,
8,
532,
14808,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
15711,
9,
66,
8,
532,
357,
18,
14,
2414,
27493,
65,
9,
87,
61,
19,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
65,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
23,
9,
66,
61,
19,
8,
1343,
357,
17,
9,
64,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
24,
9,
66,
61,
18,
8,
1343,
14808,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
1065,
9,
66,
61,
19,
8,
532,
357,
65,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
1433,
9,
66,
61,
19,
8,
532,
357,
64,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
24,
9,
66,
61,
18,
8,
1343,
357,
16,
14,
24,
27493,
64,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
1343,
357,
16,
14,
1433,
27493,
65,
9,
87,
61,
19,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
14808,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
1065,
9,
66,
61,
19,
8,
532,
14808,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
1065,
9,
66,
61,
18,
8,
532,
14808,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
1731,
9,
66,
61,
17,
8,
532,
14808,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
2623,
9,
66,
8,
532,
357,
16,
14,
1433,
27493,
65,
9,
87,
61,
19,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
14808,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
1065,
9,
66,
61,
19,
8,
1343,
357,
16,
14,
1065,
27493,
7,
19,
9,
64,
9,
87,
61,
18,
1343,
513,
9,
65,
9,
87,
61,
19,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
14808,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
29006,
21,
9,
66,
61,
19,
8,
1343,
14808,
18,
9,
65,
1343,
604,
9,
64,
9,
66,
27493,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
4008,
29006,
21,
9,
66,
61,
19,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
7,
64,
1343,
275,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
828,
2124,
11,
2319,
11,
357,
19,
9,
65,
9,
87,
20679,
7,
24,
9,
66,
61,
17,
8,
1343,
357,
64,
9,
87,
20679,
66,
1343,
357,
20,
9,
7,
17,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
87,
20679,
7,
1731,
9,
66,
61,
17,
8,
1343,
357,
65,
9,
87,
61,
17,
20679,
7,
24,
9,
66,
8,
1343,
14808,
17,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
87,
61,
17,
20679,
7,
2780,
9,
66,
8,
1343,
357,
65,
9,
87,
61,
18,
20679,
1983,
1343,
357,
64,
9,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
23,
9,
66,
61,
17,
8,
1343,
357,
17,
9,
65,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
24,
9,
66,
61,
18,
8,
1343,
14808,
17,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
1731,
9,
66,
61,
18,
8,
532,
357,
65,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
24,
9,
66,
8,
532,
14808,
17,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
1731,
9,
66,
8,
532,
357,
16,
14,
24,
27493,
65,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
17,
9,
65,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
24,
9,
66,
61,
18,
8,
1343,
357,
64,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
14,
66,
61,
17,
1343,
14808,
17,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
21,
9,
66,
61,
18,
8,
532,
357,
64,
9,
7,
16,
532,
269,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
19,
9,
66,
61,
17,
8,
532,
357,
65,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
24,
9,
66,
61,
18,
8,
1343,
357,
16,
14,
24,
27493,
65,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
357,
64,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
66,
61,
17,
8,
1343,
357,
64,
9,
7,
16,
532,
269,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
66,
61,
17,
8,
532,
14808,
17,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
21,
9,
66,
61,
18,
8,
532,
14808,
17,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
21,
9,
66,
61,
17,
8,
532,
14808,
17,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
1065,
9,
66,
8,
532,
357,
16,
14,
24,
27493,
65,
9,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
14808,
17,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
21,
9,
66,
61,
18,
8,
1343,
357,
16,
14,
21,
27493,
7,
18,
9,
64,
9,
87,
61,
17,
1343,
362,
9,
65,
9,
87,
61,
18,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
14808,
17,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
29006,
18,
9,
66,
61,
18,
8,
1343,
14808,
17,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
4008,
29006,
18,
9,
66,
61,
18,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
7,
64,
1343,
275,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
828,
2124,
11,
2608,
11,
362,
9,
64,
9,
87,
1343,
357,
24,
9,
65,
9,
87,
20679,
7,
23,
9,
66,
8,
1343,
14808,
65,
1343,
362,
9,
64,
9,
66,
27493,
87,
20679,
7,
17,
9,
66,
8,
1343,
357,
65,
9,
87,
61,
17,
20679,
1433,
1343,
357,
65,
9,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
23,
9,
66,
61,
17,
8,
1343,
357,
65,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
23,
9,
66,
61,
17,
8,
532,
357,
16,
14,
23,
27493,
65,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
65,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
14,
66,
61,
17,
1343,
357,
17,
9,
64,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
14,
66,
1343,
14808,
65,
1343,
362,
9,
64,
9,
66,
27493,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
17,
9,
66,
61,
17,
8,
532,
357,
65,
9,
7,
16,
532,
269,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
19,
9,
66,
61,
17,
8,
532,
357,
65,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
66,
61,
17,
8,
532,
357,
64,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
66,
1343,
357,
65,
9,
7,
16,
532,
269,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
66,
61,
17,
8,
532,
14808,
65,
1343,
362,
9,
64,
9,
66,
27493,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
66,
61,
17,
8,
532,
14808,
65,
1343,
362,
9,
64,
9,
66,
27493,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
66,
8,
532,
357,
16,
14,
19,
27493,
65,
9,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
14808,
65,
1343,
362,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
66,
61,
17,
8,
1343,
357,
16,
14,
17,
27493,
7,
17,
9,
64,
9,
87,
1343,
275,
9,
87,
61,
17,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
14808,
65,
1343,
362,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
14,
66,
61,
17,
1343,
14808,
65,
1343,
362,
9,
64,
9,
66,
27493,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
4008,
14,
66,
61,
17,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
64,
1343,
275,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
16,
11,
2124,
11,
1248,
11,
513,
9,
65,
9,
87,
1343,
357,
18,
9,
65,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
14,
66,
532,
357,
65,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
66,
532,
357,
65,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
66,
532,
275,
9,
87,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
65,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
14,
66,
1343,
275,
9,
87,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
64,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
61,
17,
532,
357,
17,
9,
65,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
14,
66,
1343,
357,
17,
9,
65,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
4008,
14,
66,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
64,
1343,
275,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
17,
11,
2124,
11,
1511,
11,
357,
64,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
87,
1343,
257,
9,
66,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
362,
9,
64,
9,
66,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
1343,
257,
9,
66,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
64,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
14,
87,
532,
357,
16,
14,
17,
27493,
65,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
61,
17,
1343,
362,
9,
64,
9,
66,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
8,
532,
257,
9,
66,
9,
34220,
11187,
7,
18,
11,
269,
9,
87,
8,
532,
362,
9,
64,
9,
66,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
64,
1343,
275,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
18,
11,
2124,
11,
1542,
11,
13841,
64,
27493,
66,
61,
17,
9,
6404,
7,
87,
8,
1343,
257,
9,
66,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
532,
357,
64,
9,
66,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
14,
87,
532,
357,
16,
14,
19,
27493,
64,
9,
66,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
1343,
357,
64,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
87,
61,
17,
8,
1343,
357,
65,
9,
7,
16,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
87,
532,
357,
65,
61,
17,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
64,
8,
1343,
14808,
65,
1343,
257,
9,
66,
8,
61,
17,
9,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
64,
8,
532,
362,
9,
65,
9,
66,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
64,
9,
66,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
1343,
357,
64,
9,
66,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
87,
8,
1343,
14808,
65,
1343,
257,
9,
66,
8,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
64,
8,
532,
14808,
64,
1343,
275,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
17,
9,
64,
9,
87,
61,
17,
8,
532,
357,
65,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
14,
64,
1343,
14808,
65,
1343,
257,
9,
66,
8,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
4008,
14,
64,
532,
357,
16,
14,
17,
27493,
66,
9,
7,
17,
9,
65,
1343,
257,
9,
66,
27493,
34220,
11187,
7,
18,
11,
269,
9,
87,
8,
1343,
357,
65,
61,
17,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
4008,
14,
64,
532,
14808,
65,
1343,
257,
9,
66,
8,
61,
17,
9,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
4008,
14,
64,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
64,
1343,
275,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
19,
11,
2124,
11,
6073,
11,
357,
22,
9,
64,
9,
66,
61,
17,
20679,
7,
2623,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
65,
9,
66,
61,
17,
9,
6404,
7,
87,
8,
532,
357,
20,
14,
1065,
27493,
64,
9,
66,
61,
18,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
21,
27493,
66,
61,
17,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
66,
27493,
6404,
7,
87,
8,
1343,
357,
16,
14,
17,
27493,
65,
9,
66,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
20,
14,
1065,
27493,
64,
9,
66,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
16,
14,
21,
27493,
66,
61,
17,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
532,
357,
22,
9,
64,
9,
66,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
2623,
9,
87,
61,
17,
8,
532,
357,
65,
9,
66,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
17,
9,
87,
8,
532,
357,
17,
9,
64,
9,
66,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
24,
9,
87,
8,
532,
357,
66,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
21,
9,
87,
8,
532,
357,
16,
14,
19,
27493,
65,
9,
66,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
357,
16,
14,
24,
27493,
64,
9,
66,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
1343,
357,
64,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
24,
9,
87,
61,
18,
8,
1343,
357,
65,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
21,
27493,
66,
61,
17,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
66,
27493,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
357,
16,
14,
17,
27493,
65,
9,
66,
61,
17,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
17,
14,
24,
27493,
64,
9,
66,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
1343,
357,
64,
9,
66,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
21,
9,
87,
61,
17,
8,
1343,
357,
66,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
66,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
21,
9,
87,
8,
1343,
357,
16,
14,
21,
27493,
66,
61,
17,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
16,
14,
21,
27493,
19510,
17,
9,
64,
20679,
87,
61,
18,
1343,
357,
18,
9,
65,
20679,
87,
61,
17,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
1343,
357,
16,
14,
18,
27493,
66,
61,
17,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
8,
532,
357,
16,
14,
21,
27493,
66,
61,
17,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
66,
27493,
34220,
11187,
7,
18,
11,
269,
9,
87,
8,
532,
357,
16,
14,
18,
27493,
66,
61,
17,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
66,
27493,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
64,
1343,
275,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
20679,
87,
61,
20,
11,
2124,
11,
6885,
11,
357,
20,
9,
64,
9,
66,
61,
17,
20679,
7,
18444,
9,
87,
61,
17,
8,
1343,
357,
65,
9,
66,
61,
17,
20679,
7,
24,
9,
87,
8,
1343,
357,
1129,
9,
64,
9,
66,
61,
18,
20679,
7,
18444,
9,
87,
8,
1343,
357,
66,
61,
17,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
4008,
29006,
2780,
9,
87,
8,
532,
357,
16,
14,
18,
27493,
65,
9,
66,
61,
18,
9,
6404,
7,
87,
8,
532,
357,
2718,
14,
18444,
27493,
64,
9,
66,
61,
19,
9,
6404,
7,
87,
8,
532,
357,
20,
14,
2780,
27493,
66,
61,
18,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
6404,
7,
87,
8,
1343,
357,
16,
14,
18,
27493,
65,
9,
66,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
2718,
14,
18444,
27493,
64,
9,
66,
61,
19,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
1343,
357,
20,
14,
2780,
27493,
66,
61,
18,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
532,
357,
20,
9,
64,
9,
66,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
4761,
9,
87,
61,
18,
8,
532,
357,
65,
9,
66,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
24,
9,
87,
61,
17,
8,
532,
357,
64,
9,
66,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
1433,
9,
87,
61,
17,
8,
532,
357,
66,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
2780,
9,
87,
61,
17,
8,
532,
357,
17,
9,
65,
9,
66,
61,
17,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
24,
9,
87,
8,
532,
357,
64,
9,
66,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
23,
9,
87,
8,
532,
357,
66,
61,
17,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
4008,
29006,
1065,
9,
87,
8,
532,
357,
16,
14,
24,
27493,
65,
9,
66,
61,
18,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
357,
16,
14,
1433,
27493,
64,
9,
66,
61,
19,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
1343,
357,
64,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
1433,
9,
87,
61,
19,
8,
1343,
357,
65,
9,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
20679,
7,
24,
9,
87,
61,
18,
8,
1343,
357,
16,
14,
1065,
27493,
66,
61,
18,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
6404,
7,
66,
9,
87,
27493,
6404,
7,
16,
532,
269,
9,
87,
8,
61,
17,
532,
357,
17,
14,
24,
27493,
65,
9,
66,
61,
18,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
16,
14,
23,
27493,
64,
9,
66,
61,
19,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
1343,
357,
64,
9,
66,
9,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
1065,
9,
87,
61,
18,
8,
1343,
357,
66,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
1731,
9,
87,
61,
17,
8,
1343,
357,
66,
61,
17,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
4008,
29006,
1065,
9,
87,
8,
1343,
357,
16,
14,
1065,
27493,
66,
61,
18,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
532,
357,
16,
14,
1065,
27493,
19510,
18,
9,
64,
20679,
87,
61,
19,
1343,
357,
19,
9,
65,
20679,
87,
61,
18,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
269,
9,
87,
8,
1343,
357,
16,
14,
21,
27493,
66,
61,
18,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
6404,
7,
16,
532,
269,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
269,
9,
87,
8,
532,
357,
16,
14,
1065,
27493,
66,
61,
18,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
34220,
11187,
7,
18,
11,
269,
9,
87,
8,
532,
357,
16,
14,
21,
27493,
66,
61,
18,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
66,
27493,
34220,
11187,
7,
18,
11,
352,
532,
269,
9,
87,
15437,
628,
198,
220,
220,
220,
1303,
28,
7904,
7004,
5458,
3712,
2601,
1335,
3712,
796,
2,
198,
220,
220,
220,
1303,
28,
34500,
81,
1746,
9,
1659,
9,
1169,
9,
687,
9,
87,
61,
76,
9,
7,
64,
10,
65,
9,
87,
10,
66,
9,
87,
61,
17,
27493,
6404,
7,
16,
12,
67,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
46249,
628,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
16,
9,
7,
64,
1343,
275,
9,
87,
1343,
269,
9,
87,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
828,
2124,
11,
3126,
11,
357,
4310,
9,
66,
9,
87,
20679,
7,
17477,
9,
67,
61,
18,
8,
1343,
357,
1157,
9,
65,
9,
87,
20679,
7,
1983,
9,
67,
61,
17,
8,
1343,
357,
64,
9,
87,
20679,
67,
1343,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
27493,
87,
20679,
7,
15711,
9,
67,
61,
18,
8,
1343,
357,
20,
9,
7,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
1343,
718,
9,
64,
9,
67,
61,
17,
27493,
87,
20679,
7,
2780,
9,
67,
61,
18,
8,
1343,
357,
1959,
9,
66,
9,
87,
61,
17,
20679,
7,
22842,
9,
67,
61,
17,
8,
1343,
357,
20,
9,
65,
9,
87,
61,
17,
20679,
7,
4051,
9,
67,
8,
1343,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
27493,
87,
61,
17,
20679,
7,
20666,
9,
67,
61,
17,
8,
1343,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
1343,
718,
9,
64,
9,
67,
61,
17,
27493,
87,
61,
17,
20679,
7,
4846,
9,
67,
61,
17,
8,
1343,
357,
17,
9,
65,
9,
87,
61,
18,
20679,
6659,
1343,
357,
1558,
9,
66,
9,
87,
61,
18,
20679,
7,
37452,
9,
67,
8,
1343,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
27493,
87,
61,
18,
20679,
7,
33916,
9,
67,
8,
1343,
357,
18,
9,
66,
9,
87,
61,
19,
20679,
11645,
1343,
357,
64,
9,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
23,
9,
67,
61,
17,
8,
1343,
357,
1959,
9,
66,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
17477,
9,
67,
61,
19,
8,
1343,
357,
20,
9,
65,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
1983,
9,
67,
61,
18,
8,
1343,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
15711,
9,
67,
61,
19,
8,
1343,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
1343,
718,
9,
64,
9,
67,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
2780,
9,
67,
61,
19,
8,
532,
357,
66,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
1433,
9,
67,
61,
17,
8,
532,
357,
65,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
24,
9,
67,
8,
532,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
1343,
718,
9,
64,
9,
67,
61,
17,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
2780,
9,
67,
61,
17,
8,
532,
357,
17,
14,
1983,
27493,
65,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
532,
357,
66,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
1731,
9,
67,
8,
532,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
27493,
87,
61,
18,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
15711,
9,
67,
8,
532,
357,
18,
14,
2414,
27493,
66,
9,
87,
61,
19,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
1343,
357,
66,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
23,
9,
67,
61,
19,
8,
1343,
357,
17,
9,
65,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
24,
9,
67,
61,
18,
8,
1343,
357,
64,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
14,
67,
61,
17,
1343,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
1343,
718,
9,
64,
9,
67,
61,
17,
27493,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
1065,
9,
67,
61,
19,
8,
532,
357,
64,
9,
7,
16,
532,
288,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
19,
9,
67,
61,
17,
8,
532,
357,
66,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
1433,
9,
67,
61,
19,
8,
532,
357,
65,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
24,
9,
67,
61,
18,
8,
1343,
357,
16,
14,
24,
27493,
65,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
1343,
357,
16,
14,
1433,
27493,
66,
9,
87,
61,
19,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
532,
357,
64,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
67,
61,
17,
8,
1343,
357,
64,
9,
7,
16,
532,
288,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
67,
61,
17,
8,
532,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
1343,
718,
9,
64,
9,
67,
61,
17,
27493,
6404,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
1065,
9,
67,
61,
19,
8,
532,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
1343,
718,
9,
64,
9,
67,
61,
17,
27493,
87,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
1065,
9,
67,
61,
18,
8,
532,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
1343,
718,
9,
64,
9,
67,
61,
17,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
1731,
9,
67,
61,
17,
8,
532,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
27493,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
2623,
9,
67,
8,
532,
357,
16,
14,
1433,
27493,
66,
9,
87,
61,
19,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
1343,
718,
9,
64,
9,
67,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
1065,
9,
67,
61,
19,
8,
1343,
357,
16,
14,
1065,
27493,
7,
21,
9,
64,
9,
87,
61,
17,
1343,
604,
9,
65,
9,
87,
61,
18,
1343,
513,
9,
66,
9,
87,
61,
19,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
1343,
718,
9,
64,
9,
67,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
288,
9,
87,
4008,
29006,
21,
9,
67,
61,
19,
8,
1343,
14808,
18,
9,
66,
1343,
604,
9,
65,
9,
67,
1343,
718,
9,
64,
9,
67,
61,
17,
27493,
34220,
11187,
7,
18,
11,
352,
532,
288,
9,
87,
4008,
29006,
21,
9,
67,
61,
19,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
685,
87,
61,
15,
9,
7,
64,
1343,
275,
9,
87,
1343,
269,
9,
87,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
828,
2124,
11,
5946,
11,
362,
9,
64,
9,
87,
1343,
357,
19,
9,
66,
9,
87,
20679,
7,
24,
9,
67,
61,
17,
8,
1343,
357,
65,
9,
87,
20679,
67,
1343,
14808,
17,
9,
66,
1343,
513,
9,
65,
9,
67,
27493,
87,
20679,
7,
1731,
9,
67,
61,
17,
8,
1343,
14808,
17,
9,
66,
1343,
513,
9,
67,
9,
7,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
87,
20679,
7,
21,
9,
67,
61,
17,
8,
1343,
357,
66,
9,
87,
61,
17,
20679,
7,
24,
9,
67,
8,
1343,
14808,
17,
9,
66,
1343,
513,
9,
65,
9,
67,
27493,
87,
61,
17,
20679,
7,
2780,
9,
67,
8,
1343,
357,
66,
9,
87,
61,
18,
20679,
1983,
1343,
357,
65,
9,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
23,
9,
67,
61,
17,
8,
1343,
357,
17,
9,
66,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
24,
9,
67,
61,
18,
8,
1343,
14808,
17,
9,
66,
1343,
513,
9,
65,
9,
67,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
1731,
9,
67,
61,
18,
8,
532,
357,
66,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
24,
9,
67,
8,
532,
14808,
17,
9,
66,
1343,
513,
9,
65,
9,
67,
27493,
87,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
1731,
9,
67,
8,
532,
357,
16,
14,
24,
27493,
66,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
1343,
357,
17,
9,
66,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
24,
9,
67,
61,
18,
8,
1343,
357,
65,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
14,
67,
61,
17,
1343,
357,
17,
9,
64,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
14,
67,
1343,
14808,
17,
9,
66,
1343,
513,
9,
67,
9,
7,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
21,
9,
67,
61,
18,
8,
532,
357,
65,
9,
7,
16,
532,
288,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
19,
9,
67,
61,
17,
8,
532,
357,
66,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
24,
9,
67,
61,
18,
8,
1343,
357,
16,
14,
24,
27493,
66,
9,
87,
61,
18,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
532,
357,
65,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
357,
64,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
67,
1343,
357,
65,
9,
7,
16,
532,
288,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
67,
61,
17,
8,
532,
14808,
17,
9,
66,
1343,
513,
9,
67,
9,
7,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
6404,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
21,
9,
67,
61,
18,
8,
532,
14808,
17,
9,
66,
1343,
513,
9,
67,
9,
7,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
87,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
21,
9,
67,
61,
17,
8,
532,
14808,
17,
9,
66,
1343,
513,
9,
65,
9,
67,
27493,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
1065,
9,
67,
8,
532,
357,
16,
14,
24,
27493,
66,
9,
87,
61,
18,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
14808,
17,
9,
66,
1343,
513,
9,
67,
9,
7,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
21,
9,
67,
61,
18,
8,
1343,
357,
16,
14,
21,
27493,
7,
21,
9,
64,
9,
87,
1343,
513,
9,
65,
9,
87,
61,
17,
1343,
362,
9,
66,
9,
87,
61,
18,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
14808,
17,
9,
66,
1343,
513,
9,
67,
9,
7,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
288,
9,
87,
4008,
29006,
18,
9,
67,
61,
18,
8,
1343,
14808,
17,
9,
66,
1343,
513,
9,
67,
9,
7,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
34220,
11187,
7,
18,
11,
352,
532,
288,
9,
87,
4008,
29006,
18,
9,
67,
61,
18,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
64,
1343,
275,
9,
87,
1343,
269,
9,
87,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
20679,
87,
61,
16,
11,
2124,
11,
2808,
11,
362,
9,
65,
9,
87,
1343,
357,
24,
9,
66,
9,
87,
20679,
7,
23,
9,
67,
8,
1343,
14808,
66,
1343,
362,
9,
65,
9,
67,
27493,
87,
20679,
7,
17,
9,
67,
8,
1343,
357,
66,
9,
87,
61,
17,
20679,
1433,
1343,
357,
66,
9,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
23,
9,
67,
61,
17,
8,
1343,
357,
66,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
23,
9,
67,
61,
17,
8,
532,
357,
16,
14,
23,
27493,
66,
9,
87,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
1343,
357,
66,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
14,
67,
61,
17,
1343,
357,
17,
9,
65,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
14,
67,
1343,
14808,
66,
1343,
362,
9,
65,
9,
67,
27493,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
17,
9,
67,
61,
17,
8,
532,
357,
66,
9,
7,
16,
532,
288,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
19,
9,
67,
61,
17,
8,
532,
357,
66,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
357,
65,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
67,
1343,
357,
66,
9,
7,
16,
532,
288,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
67,
61,
17,
8,
532,
14808,
66,
1343,
362,
9,
65,
9,
67,
27493,
6404,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
67,
61,
17,
8,
532,
14808,
66,
1343,
362,
9,
65,
9,
67,
27493,
87,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
17,
9,
67,
8,
532,
357,
16,
14,
19,
27493,
66,
9,
87,
61,
17,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
14808,
66,
1343,
362,
9,
65,
9,
67,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
17,
9,
67,
61,
17,
8,
1343,
357,
16,
14,
17,
27493,
7,
17,
9,
65,
9,
87,
1343,
269,
9,
87,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
64,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
61,
17,
532,
14808,
66,
1343,
362,
9,
65,
9,
67,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
288,
9,
87,
4008,
14,
67,
61,
17,
1343,
14808,
66,
1343,
362,
9,
65,
9,
67,
27493,
34220,
11187,
7,
18,
11,
352,
532,
288,
9,
87,
4008,
14,
67,
61,
17,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
64,
1343,
275,
9,
87,
1343,
269,
9,
87,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
20679,
87,
61,
17,
11,
2124,
11,
678,
11,
513,
9,
66,
9,
87,
1343,
357,
18,
9,
66,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
14,
67,
532,
357,
66,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
67,
1343,
357,
64,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
87,
1343,
357,
64,
532,
269,
14,
67,
61,
17,
27493,
67,
9,
6404,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
532,
362,
9,
64,
9,
67,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
269,
9,
87,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
1343,
357,
64,
532,
269,
14,
67,
61,
17,
27493,
67,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
357,
64,
14,
87,
532,
269,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
65,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
61,
17,
1343,
362,
9,
7,
64,
532,
269,
14,
67,
61,
17,
27493,
67,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
288,
9,
87,
8,
532,
257,
9,
67,
9,
34220,
11187,
7,
18,
11,
288,
9,
87,
8,
532,
362,
9,
7,
64,
532,
269,
14,
67,
61,
17,
27493,
67,
9,
34220,
11187,
7,
18,
11,
352,
532,
288,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
64,
1343,
275,
9,
87,
1343,
269,
9,
87,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
20679,
87,
61,
18,
11,
2124,
11,
3933,
11,
13841,
64,
27493,
67,
61,
17,
9,
6404,
7,
87,
8,
1343,
257,
9,
67,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
532,
357,
64,
9,
67,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
14,
87,
532,
357,
16,
14,
19,
27493,
64,
9,
67,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
1343,
357,
64,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
87,
61,
17,
8,
1343,
357,
65,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
87,
532,
357,
65,
61,
17,
9,
6404,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
64,
8,
1343,
14808,
65,
1343,
257,
9,
67,
8,
61,
17,
9,
6404,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
17,
9,
64,
8,
532,
362,
9,
65,
9,
67,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
64,
9,
67,
61,
17,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
1343,
357,
64,
9,
67,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
17,
9,
87,
8,
1343,
14808,
65,
1343,
257,
9,
67,
8,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
17,
9,
64,
8,
532,
14808,
64,
1343,
275,
9,
87,
8,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
17,
9,
64,
9,
87,
61,
17,
8,
532,
357,
16,
14,
17,
27493,
66,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
61,
17,
532,
357,
65,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
288,
9,
87,
4008,
14,
64,
1343,
14808,
65,
1343,
257,
9,
67,
8,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
288,
9,
87,
4008,
14,
64,
532,
357,
16,
14,
17,
27493,
67,
9,
7,
17,
9,
65,
1343,
257,
9,
67,
27493,
34220,
11187,
7,
18,
11,
288,
9,
87,
8,
1343,
357,
65,
61,
17,
9,
34220,
11187,
7,
18,
11,
352,
532,
288,
9,
87,
4008,
14,
64,
532,
14808,
65,
1343,
257,
9,
67,
8,
61,
17,
9,
34220,
11187,
7,
18,
11,
352,
532,
288,
9,
87,
4008,
14,
64,
60,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
64,
1343,
275,
9,
87,
1343,
269,
9,
87,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
20679,
87,
61,
19,
11,
2124,
11,
5946,
11,
357,
22,
9,
64,
9,
67,
61,
17,
20679,
7,
2623,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
65,
9,
67,
61,
17,
9,
6404,
7,
87,
8,
532,
357,
20,
14,
1065,
27493,
64,
9,
67,
61,
18,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
21,
27493,
67,
61,
17,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
67,
27493,
6404,
7,
87,
8,
1343,
357,
16,
14,
17,
27493,
65,
9,
67,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
1343,
357,
20,
14,
1065,
27493,
64,
9,
67,
61,
18,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
1343,
357,
16,
14,
21,
27493,
67,
61,
17,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
67,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
532,
357,
22,
9,
64,
9,
67,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
2623,
9,
87,
61,
17,
8,
532,
357,
65,
9,
67,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
17,
9,
87,
8,
532,
357,
17,
9,
64,
9,
67,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
24,
9,
87,
8,
532,
357,
67,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
67,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
21,
9,
87,
8,
532,
357,
16,
14,
19,
27493,
65,
9,
67,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
532,
357,
16,
14,
24,
27493,
64,
9,
67,
61,
18,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
1343,
357,
64,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
24,
9,
87,
61,
18,
8,
1343,
357,
65,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
87,
61,
17,
8,
1343,
357,
66,
9,
7,
16,
532,
288,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
87,
1343,
357,
16,
14,
21,
27493,
67,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
6404,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
532,
362,
9,
66,
9,
67,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
65,
9,
67,
61,
17,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
357,
17,
14,
24,
27493,
64,
9,
67,
61,
18,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
1343,
357,
64,
9,
67,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
21,
9,
87,
61,
17,
8,
1343,
357,
67,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
67,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
21,
9,
87,
8,
1343,
357,
16,
14,
21,
27493,
67,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
357,
16,
14,
21,
27493,
19510,
17,
9,
64,
20679,
87,
61,
18,
1343,
357,
18,
9,
65,
20679,
87,
61,
17,
1343,
357,
21,
9,
66,
20679,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
1343,
357,
16,
14,
18,
27493,
67,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
288,
9,
87,
8,
532,
357,
16,
14,
21,
27493,
67,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
34220,
11187,
7,
18,
11,
288,
9,
87,
8,
532,
357,
16,
14,
18,
27493,
67,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
18,
9,
65,
1343,
362,
9,
64,
9,
67,
4008,
9,
34220,
11187,
7,
18,
11,
352,
532,
288,
9,
87,
15437,
198,
220,
220,
220,
2488,
9288,
62,
600,
47527,
64,
1343,
275,
9,
87,
1343,
269,
9,
87,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
20679,
87,
61,
20,
11,
2124,
11,
8454,
11,
357,
20,
9,
64,
9,
67,
61,
17,
20679,
7,
18444,
9,
87,
61,
17,
8,
1343,
357,
65,
9,
67,
61,
17,
20679,
7,
24,
9,
87,
8,
1343,
357,
1129,
9,
64,
9,
67,
61,
18,
20679,
7,
18444,
9,
87,
8,
1343,
357,
67,
61,
17,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
4008,
29006,
2780,
9,
87,
8,
532,
357,
16,
14,
17,
27493,
66,
9,
67,
61,
17,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
18,
27493,
65,
9,
67,
61,
18,
9,
6404,
7,
87,
8,
532,
357,
2718,
14,
18444,
27493,
64,
9,
67,
61,
19,
9,
6404,
7,
87,
8,
532,
357,
16,
14,
2780,
27493,
67,
61,
18,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
27493,
6404,
7,
87,
8,
532,
357,
16,
14,
1065,
27493,
67,
61,
17,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
4008,
9,
6404,
7,
87,
8,
1343,
357,
16,
14,
17,
27493,
66,
9,
67,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
1343,
357,
16,
14,
18,
27493,
65,
9,
67,
61,
18,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
1343,
357,
2718,
14,
18444,
27493,
64,
9,
67,
61,
19,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
1343,
357,
16,
14,
2780,
27493,
67,
61,
18,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
1343,
357,
16,
14,
1065,
27493,
67,
61,
17,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
4008,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
532,
357,
20,
9,
64,
9,
67,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
4761,
9,
87,
61,
18,
8,
532,
357,
65,
9,
67,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
24,
9,
87,
61,
17,
8,
532,
357,
64,
9,
67,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
1433,
9,
87,
61,
17,
8,
532,
357,
67,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
27493,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
2780,
9,
87,
61,
17,
8,
532,
357,
66,
9,
67,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
17,
9,
87,
8,
532,
357,
17,
9,
65,
9,
67,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
24,
9,
87,
8,
532,
357,
64,
9,
67,
61,
18,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
23,
9,
87,
8,
532,
357,
67,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
4008,
9,
6404,
7,
16,
532,
288,
9,
87,
4008,
29006,
1065,
9,
87,
8,
532,
357,
16,
14,
19,
27493,
66,
9,
67,
61,
17,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
532,
357,
16,
14,
24,
27493,
65,
9,
67,
61,
18,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
532,
357,
16,
14,
1433,
27493,
64,
9,
67,
61,
19,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
1343,
357,
64,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
1433,
9,
87,
61,
19,
8,
1343,
357,
65,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
24,
9,
87,
61,
18,
8,
1343,
357,
66,
9,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
20679,
7,
19,
9,
87,
61,
17,
8,
1343,
357,
16,
14,
1065,
27493,
67,
61,
17,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
4008,
9,
6404,
7,
67,
9,
87,
27493,
6404,
7,
16,
532,
288,
9,
87,
8,
61,
17,
532,
357,
16,
14,
17,
27493,
66,
9,
67,
61,
17,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
357,
17,
14,
24,
27493,
65,
9,
67,
61,
18,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
357,
16,
14,
23,
27493,
64,
9,
67,
61,
19,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
1343,
357,
64,
9,
67,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
1065,
9,
87,
61,
18,
8,
1343,
357,
67,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
1731,
9,
87,
61,
17,
8,
1343,
357,
67,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
4008,
9,
34220,
11187,
7,
17,
11,
288,
9,
87,
4008,
29006,
1065,
9,
87,
8,
1343,
357,
16,
14,
1065,
27493,
67,
61,
17,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
4008,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
532,
357,
16,
14,
1065,
27493,
19510,
18,
9,
64,
20679,
87,
61,
19,
1343,
357,
19,
9,
65,
20679,
87,
61,
18,
1343,
357,
21,
9,
66,
20679,
87,
61,
17,
27493,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
288,
9,
87,
8,
1343,
357,
16,
14,
21,
27493,
67,
61,
17,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
4008,
9,
6404,
7,
16,
532,
288,
9,
87,
27493,
34220,
11187,
7,
17,
11,
352,
532,
288,
9,
87,
8,
532,
357,
16,
14,
1065,
27493,
67,
61,
17,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
4008,
9,
34220,
11187,
7,
18,
11,
288,
9,
87,
8,
532,
357,
16,
14,
21,
27493,
67,
61,
17,
9,
7,
21,
9,
66,
1343,
288,
9,
7,
19,
9,
65,
1343,
513,
9,
64,
9,
67,
4008,
9,
34220,
11187,
7,
18,
11,
352,
532,
288,
9,
87,
15437,
198,
220,
220,
220,
886,
198
] | 1.464519 | 63,541 |
import MixedModels: LinearMixedModel,
setθ!,
updateL!
import RCall: rcopy,
RClass,
rcopytype,
reval,
S4Sxp,
sexp,
protect,
unprotect,
sexpclass,
@rput,
@rget,
@R_str
# if RCall is available, then so is DataFrames
import DataFrames: DataFrame
import Tables: ColumnTable
# from R
# note that weights are not extracted
# TODO: document weights issue and warn
function rcopy(::Type{LinearMixedModel}, s::Ptr{S4Sxp})
# these try blocks should probably be changed to an examination of the indices
# this only extracts the name within the call, not the actual weights
try
wts = rcopy(s[:call][:weights])
@error "weights are not supported"
catch err
if !isa(err, BoundsError) # this is the error we were expecting
rethrow(err)
end
# no weights defined, we continue on our way
end
try
contrasts = rcopy(s[:call][:contrasts])
@error "Contrasts must be specified in the dataframe, not the lmer() call"
catch err
if !isa(err, BoundsError) # this is the error we were expecting
rethrow(err)
end
# no extra contrasts defined, we continue on our way
end
# for some reason this doesn't always give a formula with lmerTest
#f = rcopy(s[:call][:formula])
f = rcopy(R"as.formula($(s)@call$formula)")
data = rcopy(s[:frame])
contrasts = get_r_contrasts(s[:frame])
θ = rcopyarray(s[:theta])
reml = rcopy(s[:devcomp][:dims][:REML]) ≠ 0
m = LinearMixedModel(f, data, contrasts=contrasts)
if length(θ) != length(m.θ)
@error """You're probably using || in R with a categorical variable,
whose translation is currently unsupported with MixedModels 3.0."""
throw(ArgumentError("Parameter vectors in R and Julia are different sizes."))
end
θ = _reorder_theta_from_lme4(θ, m)
m.optsum.REML = reml
m.optsum.feval = rcopy(s[:optinfo][:feval])
# I'm wondering if this be filled in from the Julia side
m.optsum.final = rcopyarray(s[:optinfo][:val])
m.optsum.optimizer = Symbol("$(rcopy(s[:optinfo][:optimizer])) (lme4)")
m.optsum.returnvalue = rcopy(s[:optinfo][:conv][:opt]) == 0 ? :FAILURE : :SUCCESS
m.optsum.fmin = reml ? rcopy(s[:devcomp][:cmp][:REML]) : rcopy(s[:devcomp][:cmp][:dev])
updateL!(setθ!(m, θ))
end
rcopytype(::Type{RClass{:lmerMod}}, s::Ptr{S4Sxp}) = LinearMixedModel
# add lmerTest::lmer and afex::lmer_alt support
rcopytype(::Type{RClass{:lmerModLmerTest}}, s::Ptr{S4Sxp}) = LinearMixedModel
# TODO: fix some conversions -- Julia->R->Julia roundtrip currently due to
# ERROR: REvalError: Error in function (x, value, pos = -1, envir = as.environment(pos), inherits = FALSE, :
# SET_VECTOR_ELT() can only be applied to a 'list', not a 'character'
function sexp(::Type{RClass{:lmerMod}}, x::Tuple{LinearMixedModel{T}, DataFrame}) where T
m, tbl = x
if !isempty(m.sqrtwts)
@error "weights are not currently supported"
end
m.optsum.feval > 0 || throw(ArgumentError("Model must be fitted"))
jellyme4_data = tbl
formula = convert_julia_to_r(m.formula)
θ = m.θ
rsteps = 1
REML = m.optsum.REML ? "TRUE" : "FALSE"
jellyme4_theta = _reorder_theta_to_lme4(m)
fval = m.optsum.fmin
feval = m.optsum.feval
conv = m.optsum.returnvalue == :SUCCESS ? 0 : 1
optimizer = String(m.optsum.optimizer)
message = "fit with MixedModels.jl"
@rput jellyme4_data
@rput jellyme4_theta
set_r_contrasts!("jellyme4_data", m.formula)
r = """
jellyme4_mod <- $LMER(formula = $(formula),
data=jellyme4_data,
REML=$(REML),
control=lme4::lmerControl(optimizer="nloptwrap",
optCtrl=list(maxeval=$(rsteps)),
calc.derivs=FALSE,
check.nobs.vs.nRE= "warning"),
start=list(theta=jellyme4_theta))
jellyme4_mod@optinfo\$feval <- $(feval)
jellyme4_mod@optinfo\$message <- "$(message)"
jellyme4_mod@optinfo\$optimizer <- "$(optimizer)"
jellyme4_mod
"""
r = reval(r)
r = protect(sexp(r))
unprotect(1)
r
end
sexpclass(x::Tuple{LinearMixedModel{T}, DataFrame}) where T = LMER in ("afex::lmer_alt", "lmer_alt") ? RClass{:lmerModLmerTest} : RClass{:lmerMod}
sexp(::Type{RClass{:lmerModLmerTest}}, x::Tuple{LinearMixedModel{T}, DataFrame}) where T = sexp(RClass{:lmerMod}, x)
# generalize to ColumnTable, which is what MixedModels actually requires
function sexp(ss::Type{RClass{:lmerMod}}, x::Tuple{LinearMixedModel{T}, ColumnTable}) where T
m, t = x
sexp(ss, (m, DataFrame(t)))
end
sexpclass(x::Tuple{LinearMixedModel{T}, ColumnTable}) where T = RClass{:lmerMod}
| [
11748,
35250,
5841,
1424,
25,
44800,
44,
2966,
17633,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
900,
138,
116,
28265,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4296,
43,
0,
198,
11748,
13987,
439,
25,
374,
30073,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
371,
9487,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
374,
30073,
4906,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
302,
2100,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
311,
19,
50,
42372,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1714,
79,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1805,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
555,
35499,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1714,
79,
4871,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
81,
1996,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
81,
1136,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
49,
62,
2536,
198,
198,
2,
611,
13987,
439,
318,
1695,
11,
788,
523,
318,
6060,
35439,
198,
11748,
6060,
35439,
25,
6060,
19778,
198,
11748,
33220,
25,
29201,
10962,
198,
198,
2,
422,
371,
198,
2,
3465,
326,
19590,
389,
407,
21242,
198,
2,
16926,
46,
25,
3188,
19590,
2071,
290,
9828,
198,
8818,
374,
30073,
7,
3712,
6030,
90,
14993,
451,
44,
2966,
17633,
5512,
264,
3712,
46745,
90,
50,
19,
50,
42372,
30072,
628,
220,
220,
220,
1303,
777,
1949,
7021,
815,
2192,
307,
3421,
284,
281,
12452,
286,
262,
36525,
198,
220,
220,
220,
1303,
428,
691,
32139,
262,
1438,
1626,
262,
869,
11,
407,
262,
4036,
19590,
198,
220,
220,
220,
1949,
198,
220,
220,
220,
220,
220,
220,
220,
266,
912,
796,
374,
30073,
7,
82,
58,
25,
13345,
7131,
25,
43775,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
18224,
366,
43775,
389,
407,
4855,
1,
198,
220,
220,
220,
4929,
11454,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
9160,
7,
8056,
11,
347,
3733,
12331,
8,
1303,
428,
318,
262,
4049,
356,
547,
12451,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
302,
16939,
7,
8056,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
645,
19590,
5447,
11,
356,
2555,
319,
674,
835,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1949,
198,
220,
220,
220,
220,
220,
220,
220,
39469,
796,
374,
30073,
7,
82,
58,
25,
13345,
7131,
25,
3642,
5685,
82,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
18224,
366,
4264,
5685,
82,
1276,
307,
7368,
287,
262,
1366,
14535,
11,
407,
262,
300,
647,
3419,
869,
1,
198,
220,
220,
220,
4929,
11454,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
9160,
7,
8056,
11,
347,
3733,
12331,
8,
1303,
428,
318,
262,
4049,
356,
547,
12451,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
302,
16939,
7,
8056,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
645,
3131,
39469,
5447,
11,
356,
2555,
319,
674,
835,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
329,
617,
1738,
428,
1595,
470,
1464,
1577,
257,
10451,
351,
300,
647,
14402,
198,
220,
220,
220,
1303,
69,
796,
374,
30073,
7,
82,
58,
25,
13345,
7131,
25,
687,
4712,
12962,
198,
220,
220,
220,
277,
796,
374,
30073,
7,
49,
1,
292,
13,
687,
4712,
16763,
7,
82,
8,
31,
13345,
3,
687,
4712,
8,
4943,
198,
220,
220,
220,
1366,
796,
374,
30073,
7,
82,
58,
25,
14535,
12962,
198,
220,
220,
220,
39469,
796,
651,
62,
81,
62,
3642,
5685,
82,
7,
82,
58,
25,
14535,
12962,
198,
220,
220,
220,
7377,
116,
796,
374,
30073,
18747,
7,
82,
58,
25,
1169,
8326,
12962,
198,
220,
220,
220,
816,
75,
796,
374,
30073,
7,
82,
58,
25,
7959,
5589,
7131,
25,
67,
12078,
7131,
25,
2200,
5805,
12962,
15139,
254,
657,
628,
220,
220,
220,
285,
796,
44800,
44,
2966,
17633,
7,
69,
11,
1366,
11,
39469,
28,
3642,
5685,
82,
8,
628,
220,
220,
220,
611,
4129,
7,
138,
116,
8,
14512,
4129,
7,
76,
13,
138,
116,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
18224,
37227,
1639,
821,
2192,
1262,
8614,
287,
371,
351,
257,
4253,
12409,
7885,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3025,
11059,
318,
3058,
24222,
351,
35250,
5841,
1424,
513,
13,
15,
526,
15931,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
28100,
1713,
12331,
7203,
36301,
30104,
287,
371,
290,
22300,
389,
1180,
10620,
526,
4008,
198,
220,
220,
220,
886,
628,
220,
220,
220,
7377,
116,
796,
4808,
260,
2875,
62,
1169,
8326,
62,
6738,
62,
75,
1326,
19,
7,
138,
116,
11,
285,
8,
628,
220,
220,
220,
285,
13,
404,
912,
388,
13,
2200,
5805,
796,
816,
75,
198,
220,
220,
220,
285,
13,
404,
912,
388,
13,
69,
18206,
796,
374,
30073,
7,
82,
58,
25,
8738,
10951,
7131,
25,
69,
18206,
12962,
198,
220,
220,
220,
1303,
314,
1101,
11263,
611,
428,
307,
5901,
287,
422,
262,
22300,
1735,
198,
220,
220,
220,
285,
13,
404,
912,
388,
13,
20311,
796,
374,
30073,
18747,
7,
82,
58,
25,
8738,
10951,
7131,
25,
2100,
12962,
198,
220,
220,
220,
285,
13,
404,
912,
388,
13,
40085,
7509,
796,
38357,
7203,
3,
7,
6015,
11081,
7,
82,
58,
25,
8738,
10951,
7131,
25,
40085,
7509,
60,
4008,
357,
75,
1326,
19,
8,
4943,
198,
220,
220,
220,
285,
13,
404,
912,
388,
13,
7783,
8367,
796,
374,
30073,
7,
82,
58,
25,
8738,
10951,
7131,
25,
42946,
7131,
25,
8738,
12962,
6624,
657,
5633,
1058,
7708,
4146,
11335,
1058,
1058,
12564,
4093,
7597,
198,
220,
220,
220,
285,
13,
404,
912,
388,
13,
69,
1084,
796,
816,
75,
5633,
374,
30073,
7,
82,
58,
25,
7959,
5589,
7131,
25,
48991,
7131,
25,
2200,
5805,
12962,
1058,
374,
30073,
7,
82,
58,
25,
7959,
5589,
7131,
25,
48991,
7131,
25,
7959,
12962,
198,
220,
220,
220,
4296,
43,
0,
7,
2617,
138,
116,
0,
7,
76,
11,
7377,
116,
4008,
198,
437,
198,
198,
6015,
11081,
4906,
7,
3712,
6030,
90,
49,
9487,
90,
25,
75,
647,
5841,
92,
5512,
264,
3712,
46745,
90,
50,
19,
50,
42372,
30072,
796,
44800,
44,
2966,
17633,
198,
198,
2,
751,
300,
647,
14402,
3712,
75,
647,
290,
6580,
1069,
3712,
75,
647,
62,
2501,
1104,
198,
6015,
11081,
4906,
7,
3712,
6030,
90,
49,
9487,
90,
25,
75,
647,
5841,
43,
647,
14402,
92,
5512,
264,
3712,
46745,
90,
50,
19,
50,
42372,
30072,
796,
44800,
44,
2966,
17633,
198,
198,
2,
16926,
46,
25,
4259,
617,
32626,
1377,
22300,
3784,
49,
3784,
16980,
544,
2835,
39813,
3058,
2233,
284,
198,
2,
220,
220,
220,
220,
220,
220,
220,
33854,
25,
4526,
2100,
12331,
25,
13047,
287,
2163,
357,
87,
11,
1988,
11,
1426,
796,
532,
16,
11,
17365,
343,
796,
355,
13,
38986,
7,
1930,
828,
10639,
896,
796,
26563,
11,
220,
1058,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
220,
25823,
62,
53,
9782,
1581,
62,
3698,
51,
3419,
460,
691,
307,
5625,
284,
257,
705,
4868,
3256,
407,
257,
705,
22769,
6,
198,
8818,
1714,
79,
7,
3712,
6030,
90,
49,
9487,
90,
25,
75,
647,
5841,
92,
5512,
2124,
3712,
51,
29291,
90,
14993,
451,
44,
2966,
17633,
90,
51,
5512,
6060,
19778,
30072,
810,
309,
198,
220,
220,
220,
285,
11,
256,
2436,
796,
2124,
198,
220,
220,
220,
611,
5145,
271,
28920,
7,
76,
13,
31166,
81,
4246,
912,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
18224,
366,
43775,
389,
407,
3058,
4855,
1,
198,
220,
220,
220,
886,
628,
220,
220,
220,
285,
13,
404,
912,
388,
13,
69,
18206,
1875,
657,
8614,
3714,
7,
28100,
1713,
12331,
7203,
17633,
1276,
307,
18235,
48774,
628,
220,
220,
220,
27644,
1326,
19,
62,
7890,
796,
256,
2436,
198,
220,
220,
220,
10451,
796,
10385,
62,
73,
43640,
62,
1462,
62,
81,
7,
76,
13,
687,
4712,
8,
628,
220,
220,
220,
7377,
116,
796,
285,
13,
138,
116,
198,
220,
220,
220,
374,
20214,
796,
352,
198,
220,
220,
220,
22657,
43,
796,
285,
13,
404,
912,
388,
13,
2200,
5805,
5633,
366,
5446,
8924,
1,
1058,
366,
37,
23719,
1,
198,
220,
220,
220,
27644,
1326,
19,
62,
1169,
8326,
796,
4808,
260,
2875,
62,
1169,
8326,
62,
1462,
62,
75,
1326,
19,
7,
76,
8,
198,
220,
220,
220,
277,
2100,
796,
285,
13,
404,
912,
388,
13,
69,
1084,
198,
220,
220,
220,
730,
2100,
796,
285,
13,
404,
912,
388,
13,
69,
18206,
198,
220,
220,
220,
3063,
796,
285,
13,
404,
912,
388,
13,
7783,
8367,
6624,
1058,
12564,
4093,
7597,
5633,
657,
1058,
352,
198,
220,
220,
220,
6436,
7509,
796,
10903,
7,
76,
13,
404,
912,
388,
13,
40085,
7509,
8,
198,
220,
220,
220,
3275,
796,
366,
11147,
351,
35250,
5841,
1424,
13,
20362,
1,
198,
220,
220,
220,
2488,
81,
1996,
27644,
1326,
19,
62,
7890,
198,
220,
220,
220,
2488,
81,
1996,
27644,
1326,
19,
62,
1169,
8326,
628,
220,
220,
220,
900,
62,
81,
62,
3642,
5685,
82,
0,
7203,
73,
6148,
1326,
19,
62,
7890,
1600,
285,
13,
687,
4712,
8,
628,
220,
220,
220,
374,
796,
37227,
198,
220,
220,
220,
27644,
1326,
19,
62,
4666,
24293,
720,
43,
29296,
7,
687,
4712,
796,
29568,
687,
4712,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1366,
28,
73,
6148,
1326,
19,
62,
7890,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
22657,
43,
43641,
7,
2200,
5805,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1630,
28,
75,
1326,
19,
3712,
75,
647,
15988,
7,
40085,
7509,
2625,
21283,
404,
4246,
2416,
1600,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2172,
40069,
28,
4868,
7,
9806,
18206,
43641,
7,
81,
20214,
36911,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
42302,
13,
1082,
452,
82,
28,
37,
23719,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2198,
13,
77,
8158,
13,
14259,
13,
77,
2200,
28,
366,
43917,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
923,
28,
4868,
7,
1169,
8326,
28,
73,
6148,
1326,
19,
62,
1169,
8326,
4008,
198,
220,
220,
220,
220,
27644,
1326,
19,
62,
4666,
31,
8738,
10951,
59,
3,
69,
18206,
24293,
29568,
69,
18206,
8,
198,
220,
220,
220,
220,
27644,
1326,
19,
62,
4666,
31,
8738,
10951,
59,
3,
20500,
24293,
17971,
7,
20500,
16725,
198,
220,
220,
220,
220,
27644,
1326,
19,
62,
4666,
31,
8738,
10951,
59,
3,
40085,
7509,
24293,
17971,
7,
40085,
7509,
16725,
198,
220,
220,
220,
220,
27644,
1326,
19,
62,
4666,
198,
220,
220,
220,
37227,
198,
220,
220,
220,
374,
796,
302,
2100,
7,
81,
8,
198,
220,
220,
220,
374,
796,
1805,
7,
8044,
79,
7,
81,
4008,
198,
220,
220,
220,
555,
35499,
7,
16,
8,
198,
220,
220,
220,
374,
198,
437,
198,
198,
8044,
79,
4871,
7,
87,
3712,
51,
29291,
90,
14993,
451,
44,
2966,
17633,
90,
51,
5512,
6060,
19778,
30072,
810,
309,
796,
406,
29296,
287,
5855,
1878,
1069,
3712,
75,
647,
62,
2501,
1600,
366,
75,
647,
62,
2501,
4943,
5633,
371,
9487,
90,
25,
75,
647,
5841,
43,
647,
14402,
92,
1058,
371,
9487,
90,
25,
75,
647,
5841,
92,
198,
8044,
79,
7,
3712,
6030,
90,
49,
9487,
90,
25,
75,
647,
5841,
43,
647,
14402,
92,
5512,
2124,
3712,
51,
29291,
90,
14993,
451,
44,
2966,
17633,
90,
51,
5512,
6060,
19778,
30072,
810,
309,
796,
1714,
79,
7,
49,
9487,
90,
25,
75,
647,
5841,
5512,
2124,
8,
198,
198,
2,
2276,
1096,
284,
29201,
10962,
11,
543,
318,
644,
35250,
5841,
1424,
1682,
4433,
198,
8818,
1714,
79,
7,
824,
3712,
6030,
90,
49,
9487,
90,
25,
75,
647,
5841,
92,
5512,
2124,
3712,
51,
29291,
90,
14993,
451,
44,
2966,
17633,
90,
51,
5512,
29201,
10962,
30072,
810,
309,
198,
220,
220,
220,
285,
11,
256,
220,
796,
2124,
198,
220,
220,
220,
1714,
79,
7,
824,
11,
357,
76,
11,
6060,
19778,
7,
83,
22305,
198,
437,
198,
198,
8044,
79,
4871,
7,
87,
3712,
51,
29291,
90,
14993,
451,
44,
2966,
17633,
90,
51,
5512,
29201,
10962,
30072,
810,
309,
796,
371,
9487,
90,
25,
75,
647,
5841,
92,
198
] | 2.123685 | 2,377 |
# Raytracer.jl
# Raytracing for the generation of photorealistic images in Julia
# Copyright (c) 2021 Samuele Colombo, Paolo Galli
# Point light sources used by point-light tracer
@doc raw"""
PointLight
A point light (used by [`PointLightRenderer`](@ref)).
This type holds information about a point light.
# Fields
- `position::Point`: a [`Point`](@ref) object holding the position of the point light in 3D space.
- `color::RGB{Float32}`: the color of the point light.
- `linear_radius::Float32`: radius of the source, used to compute solid angle subtended by the light.
If `linear_radius` is non-zero, it is used to compute the solid angle subtended by the light at a given
distance `d` through the formula:
```math
\left(\frac{\mathrm{linear\_radius}}{d}\right)^2
```
"""
Base.@kwdef struct PointLight
position::Point = ORIGIN
color::RGB{Float32} = WHITE
linear_radius::Float32 = 0f0
end
@doc """
PointLight(position::Point, color::RGB{Float32}, linear_radius::Float32)
Constructor for a [`PointLight`](@ref) instance.
""" PointLight(::Point, ::RGB{Float32}, ::Float32)
@doc """
PointLight(; position::Point = ORIGIN,
color::RGB{Float32} = WHITE,
linear_radius::Float32 = 0f0)
Constructor for a [`PointLight`](@ref) instance.
If no parameter is specified, it return a white point light in the origin with no radius.
""" PointLight(; ::Point, ::RGB{Float32}, ::Float32)
"""
Lights
Alias of `Vector{PointLight}`, to store a list of [`PointLight`](@ref) sources.
"""
const Lights = Vector{PointLight}
| [
2,
7760,
2213,
11736,
13,
20362,
198,
2,
7760,
2213,
4092,
329,
262,
5270,
286,
2825,
39396,
2569,
4263,
287,
22300,
198,
2,
15069,
357,
66,
8,
33448,
3409,
518,
293,
1623,
47265,
11,
11243,
14057,
7096,
72,
198,
198,
2,
6252,
1657,
4237,
973,
416,
966,
12,
2971,
491,
11736,
628,
198,
31,
15390,
8246,
37811,
198,
220,
220,
220,
6252,
15047,
198,
198,
32,
966,
1657,
357,
1484,
416,
685,
63,
12727,
15047,
49,
437,
11882,
63,
16151,
31,
5420,
29720,
198,
198,
1212,
2099,
6622,
1321,
546,
257,
966,
1657,
13,
198,
198,
2,
23948,
198,
198,
12,
4600,
9150,
3712,
12727,
63,
25,
257,
685,
63,
12727,
63,
16151,
31,
5420,
8,
2134,
4769,
262,
2292,
286,
262,
966,
1657,
287,
513,
35,
2272,
13,
198,
12,
4600,
8043,
3712,
36982,
90,
43879,
2624,
92,
63,
25,
262,
3124,
286,
262,
966,
1657,
13,
198,
12,
4600,
29127,
62,
42172,
3712,
43879,
2624,
63,
25,
16874,
286,
262,
2723,
11,
973,
284,
24061,
4735,
9848,
13284,
1631,
416,
262,
1657,
13,
198,
198,
1532,
4600,
29127,
62,
42172,
63,
318,
1729,
12,
22570,
11,
340,
318,
973,
284,
24061,
262,
4735,
9848,
13284,
1631,
416,
262,
1657,
379,
257,
1813,
198,
30246,
4600,
67,
63,
832,
262,
10451,
25,
198,
198,
15506,
63,
11018,
198,
59,
9464,
38016,
31944,
31478,
11018,
26224,
90,
29127,
59,
62,
42172,
11709,
90,
67,
32239,
3506,
8,
61,
17,
198,
15506,
63,
198,
37811,
198,
14881,
13,
31,
46265,
4299,
2878,
6252,
15047,
198,
220,
220,
220,
2292,
3712,
12727,
796,
43901,
1268,
198,
220,
220,
220,
3124,
3712,
36982,
90,
43879,
2624,
92,
796,
44925,
198,
220,
220,
220,
14174,
62,
42172,
3712,
43879,
2624,
796,
657,
69,
15,
198,
437,
198,
198,
31,
15390,
37227,
198,
220,
220,
220,
6252,
15047,
7,
9150,
3712,
12727,
11,
3124,
3712,
36982,
90,
43879,
2624,
5512,
14174,
62,
42172,
3712,
43879,
2624,
8,
198,
198,
42316,
273,
329,
257,
685,
63,
12727,
15047,
63,
16151,
31,
5420,
8,
4554,
13,
198,
37811,
6252,
15047,
7,
3712,
12727,
11,
7904,
36982,
90,
43879,
2624,
5512,
7904,
43879,
2624,
8,
198,
198,
31,
15390,
37227,
198,
220,
220,
220,
6252,
15047,
7,
26,
2292,
3712,
12727,
796,
43901,
1268,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3124,
3712,
36982,
90,
43879,
2624,
92,
796,
44925,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
14174,
62,
42172,
3712,
43879,
2624,
796,
657,
69,
15,
8,
198,
198,
42316,
273,
329,
257,
685,
63,
12727,
15047,
63,
16151,
31,
5420,
8,
4554,
13,
198,
198,
1532,
645,
11507,
318,
7368,
11,
340,
1441,
257,
2330,
966,
1657,
287,
262,
8159,
351,
645,
16874,
13,
198,
37811,
6252,
15047,
7,
26,
7904,
12727,
11,
7904,
36982,
90,
43879,
2624,
5512,
7904,
43879,
2624,
8,
628,
198,
37811,
198,
220,
220,
220,
22661,
198,
198,
40489,
286,
4600,
38469,
90,
12727,
15047,
92,
47671,
284,
3650,
257,
1351,
286,
685,
63,
12727,
15047,
63,
16151,
31,
5420,
8,
4237,
13,
198,
37811,
198,
9979,
22661,
796,
20650,
90,
12727,
15047,
92,
198
] | 2.945896 | 536 |
using MagneticLocSuchowiak
using Test
@testset "MagneticLocSuchowiak.jl" begin
# Write your tests here.
end
| [
3500,
44629,
33711,
16678,
322,
32994,
198,
3500,
6208,
198,
198,
31,
9288,
2617,
366,
13436,
9833,
33711,
16678,
322,
32994,
13,
20362,
1,
2221,
198,
220,
220,
220,
1303,
19430,
534,
5254,
994,
13,
198,
437,
198
] | 2.973684 | 38 |
# syntax: proto3
using ProtoBuf
import ProtoBuf.meta
mutable struct MultilineChartContent <: ProtoType
__protobuf_jl_internal_meta::ProtoMeta
__protobuf_jl_internal_values::Dict{Symbol,Any}
__protobuf_jl_internal_defaultset::Set{Symbol}
function MultilineChartContent(; kwargs...)
obj = new(meta(MultilineChartContent), Dict{Symbol,Any}(), Set{Symbol}())
values = obj.__protobuf_jl_internal_values
symdict = obj.__protobuf_jl_internal_meta.symdict
for nv in kwargs
fldname, fldval = nv
fldtype = symdict[fldname].jtyp
(fldname in keys(symdict)) || error(string(typeof(obj), " has no field with name ", fldname))
values[fldname] = isa(fldval, fldtype) ? fldval : convert(fldtype, fldval)
end
obj
end
end # mutable struct MultilineChartContent
const __meta_MultilineChartContent = Ref{ProtoMeta}()
function meta(::Type{MultilineChartContent})
ProtoBuf.metalock() do
if !isassigned(__meta_MultilineChartContent)
__meta_MultilineChartContent[] = target = ProtoMeta(MultilineChartContent)
allflds = Pair{Symbol,Union{Type,String}}[:tag => Base.Vector{AbstractString}]
meta(target, MultilineChartContent, allflds, ProtoBuf.DEF_REQ, ProtoBuf.DEF_FNUM, ProtoBuf.DEF_VAL, ProtoBuf.DEF_PACK, ProtoBuf.DEF_WTYPES, ProtoBuf.DEF_ONEOFS, ProtoBuf.DEF_ONEOF_NAMES)
end
__meta_MultilineChartContent[]
end
end
function Base.getproperty(obj::MultilineChartContent, name::Symbol)
if name === :tag
return (obj.__protobuf_jl_internal_values[name])::Base.Vector{AbstractString}
else
getfield(obj, name)
end
end
mutable struct MarginChartContent_Series <: ProtoType
__protobuf_jl_internal_meta::ProtoMeta
__protobuf_jl_internal_values::Dict{Symbol,Any}
__protobuf_jl_internal_defaultset::Set{Symbol}
function MarginChartContent_Series(; kwargs...)
obj = new(meta(MarginChartContent_Series), Dict{Symbol,Any}(), Set{Symbol}())
values = obj.__protobuf_jl_internal_values
symdict = obj.__protobuf_jl_internal_meta.symdict
for nv in kwargs
fldname, fldval = nv
fldtype = symdict[fldname].jtyp
(fldname in keys(symdict)) || error(string(typeof(obj), " has no field with name ", fldname))
values[fldname] = isa(fldval, fldtype) ? fldval : convert(fldtype, fldval)
end
obj
end
end # mutable struct MarginChartContent_Series
const __meta_MarginChartContent_Series = Ref{ProtoMeta}()
function meta(::Type{MarginChartContent_Series})
ProtoBuf.metalock() do
if !isassigned(__meta_MarginChartContent_Series)
__meta_MarginChartContent_Series[] = target = ProtoMeta(MarginChartContent_Series)
allflds = Pair{Symbol,Union{Type,String}}[:value => AbstractString, :lower => AbstractString, :upper => AbstractString]
meta(target, MarginChartContent_Series, allflds, ProtoBuf.DEF_REQ, ProtoBuf.DEF_FNUM, ProtoBuf.DEF_VAL, ProtoBuf.DEF_PACK, ProtoBuf.DEF_WTYPES, ProtoBuf.DEF_ONEOFS, ProtoBuf.DEF_ONEOF_NAMES)
end
__meta_MarginChartContent_Series[]
end
end
function Base.getproperty(obj::MarginChartContent_Series, name::Symbol)
if name === :value
return (obj.__protobuf_jl_internal_values[name])::AbstractString
elseif name === :lower
return (obj.__protobuf_jl_internal_values[name])::AbstractString
elseif name === :upper
return (obj.__protobuf_jl_internal_values[name])::AbstractString
else
getfield(obj, name)
end
end
mutable struct MarginChartContent <: ProtoType
__protobuf_jl_internal_meta::ProtoMeta
__protobuf_jl_internal_values::Dict{Symbol,Any}
__protobuf_jl_internal_defaultset::Set{Symbol}
function MarginChartContent(; kwargs...)
obj = new(meta(MarginChartContent), Dict{Symbol,Any}(), Set{Symbol}())
values = obj.__protobuf_jl_internal_values
symdict = obj.__protobuf_jl_internal_meta.symdict
for nv in kwargs
fldname, fldval = nv
fldtype = symdict[fldname].jtyp
(fldname in keys(symdict)) || error(string(typeof(obj), " has no field with name ", fldname))
values[fldname] = isa(fldval, fldtype) ? fldval : convert(fldtype, fldval)
end
obj
end
end # mutable struct MarginChartContent
const __meta_MarginChartContent = Ref{ProtoMeta}()
function meta(::Type{MarginChartContent})
ProtoBuf.metalock() do
if !isassigned(__meta_MarginChartContent)
__meta_MarginChartContent[] = target = ProtoMeta(MarginChartContent)
allflds = Pair{Symbol,Union{Type,String}}[:series => Base.Vector{MarginChartContent_Series}]
meta(target, MarginChartContent, allflds, ProtoBuf.DEF_REQ, ProtoBuf.DEF_FNUM, ProtoBuf.DEF_VAL, ProtoBuf.DEF_PACK, ProtoBuf.DEF_WTYPES, ProtoBuf.DEF_ONEOFS, ProtoBuf.DEF_ONEOF_NAMES)
end
__meta_MarginChartContent[]
end
end
function Base.getproperty(obj::MarginChartContent, name::Symbol)
if name === :series
return (obj.__protobuf_jl_internal_values[name])::Base.Vector{MarginChartContent_Series}
else
getfield(obj, name)
end
end
mutable struct Chart <: ProtoType
__protobuf_jl_internal_meta::ProtoMeta
__protobuf_jl_internal_values::Dict{Symbol,Any}
__protobuf_jl_internal_defaultset::Set{Symbol}
function Chart(; kwargs...)
obj = new(meta(Chart), Dict{Symbol,Any}(), Set{Symbol}())
values = obj.__protobuf_jl_internal_values
symdict = obj.__protobuf_jl_internal_meta.symdict
for nv in kwargs
fldname, fldval = nv
fldtype = symdict[fldname].jtyp
(fldname in keys(symdict)) || error(string(typeof(obj), " has no field with name ", fldname))
values[fldname] = isa(fldval, fldtype) ? fldval : convert(fldtype, fldval)
end
obj
end
end # mutable struct Chart
const __meta_Chart = Ref{ProtoMeta}()
function meta(::Type{Chart})
ProtoBuf.metalock() do
if !isassigned(__meta_Chart)
__meta_Chart[] = target = ProtoMeta(Chart)
allflds = Pair{Symbol,Union{Type,String}}[:title => AbstractString, :multiline => MultilineChartContent, :margin => MarginChartContent]
oneofs = Int[0,1,1]
oneof_names = Symbol[Symbol("content")]
meta(target, Chart, allflds, ProtoBuf.DEF_REQ, ProtoBuf.DEF_FNUM, ProtoBuf.DEF_VAL, ProtoBuf.DEF_PACK, ProtoBuf.DEF_WTYPES, oneofs, oneof_names)
end
__meta_Chart[]
end
end
function Base.getproperty(obj::Chart, name::Symbol)
if name === :title
return (obj.__protobuf_jl_internal_values[name])::AbstractString
elseif name === :multiline
return (obj.__protobuf_jl_internal_values[name])::MultilineChartContent
elseif name === :margin
return (obj.__protobuf_jl_internal_values[name])::MarginChartContent
else
getfield(obj, name)
end
end
mutable struct Category <: ProtoType
__protobuf_jl_internal_meta::ProtoMeta
__protobuf_jl_internal_values::Dict{Symbol,Any}
__protobuf_jl_internal_defaultset::Set{Symbol}
function Category(; kwargs...)
obj = new(meta(Category), Dict{Symbol,Any}(), Set{Symbol}())
values = obj.__protobuf_jl_internal_values
symdict = obj.__protobuf_jl_internal_meta.symdict
for nv in kwargs
fldname, fldval = nv
fldtype = symdict[fldname].jtyp
(fldname in keys(symdict)) || error(string(typeof(obj), " has no field with name ", fldname))
values[fldname] = isa(fldval, fldtype) ? fldval : convert(fldtype, fldval)
end
obj
end
end # mutable struct Category
const __meta_Category = Ref{ProtoMeta}()
function meta(::Type{Category})
ProtoBuf.metalock() do
if !isassigned(__meta_Category)
__meta_Category[] = target = ProtoMeta(Category)
allflds = Pair{Symbol,Union{Type,String}}[:title => AbstractString, :chart => Base.Vector{Chart}, :closed => Bool]
meta(target, Category, allflds, ProtoBuf.DEF_REQ, ProtoBuf.DEF_FNUM, ProtoBuf.DEF_VAL, ProtoBuf.DEF_PACK, ProtoBuf.DEF_WTYPES, ProtoBuf.DEF_ONEOFS, ProtoBuf.DEF_ONEOF_NAMES)
end
__meta_Category[]
end
end
function Base.getproperty(obj::Category, name::Symbol)
if name === :title
return (obj.__protobuf_jl_internal_values[name])::AbstractString
elseif name === :chart
return (obj.__protobuf_jl_internal_values[name])::Base.Vector{Chart}
elseif name === :closed
return (obj.__protobuf_jl_internal_values[name])::Bool
else
getfield(obj, name)
end
end
mutable struct Layout <: ProtoType
__protobuf_jl_internal_meta::ProtoMeta
__protobuf_jl_internal_values::Dict{Symbol,Any}
__protobuf_jl_internal_defaultset::Set{Symbol}
function Layout(; kwargs...)
obj = new(meta(Layout), Dict{Symbol,Any}(), Set{Symbol}())
values = obj.__protobuf_jl_internal_values
symdict = obj.__protobuf_jl_internal_meta.symdict
for nv in kwargs
fldname, fldval = nv
fldtype = symdict[fldname].jtyp
(fldname in keys(symdict)) || error(string(typeof(obj), " has no field with name ", fldname))
values[fldname] = isa(fldval, fldtype) ? fldval : convert(fldtype, fldval)
end
obj
end
end # mutable struct Layout
const __meta_Layout = Ref{ProtoMeta}()
function meta(::Type{Layout})
ProtoBuf.metalock() do
if !isassigned(__meta_Layout)
__meta_Layout[] = target = ProtoMeta(Layout)
allflds = Pair{Symbol,Union{Type,String}}[:version => Int32, :category => Base.Vector{Category}]
meta(target, Layout, allflds, ProtoBuf.DEF_REQ, ProtoBuf.DEF_FNUM, ProtoBuf.DEF_VAL, ProtoBuf.DEF_PACK, ProtoBuf.DEF_WTYPES, ProtoBuf.DEF_ONEOFS, ProtoBuf.DEF_ONEOF_NAMES)
end
__meta_Layout[]
end
end
function Base.getproperty(obj::Layout, name::Symbol)
if name === :version
return (obj.__protobuf_jl_internal_values[name])::Int32
elseif name === :category
return (obj.__protobuf_jl_internal_values[name])::Base.Vector{Category}
else
getfield(obj, name)
end
end
export Chart, MultilineChartContent, MarginChartContent_Series, MarginChartContent, Category, Layout
| [
2,
15582,
25,
44876,
18,
198,
3500,
45783,
33,
3046,
198,
11748,
45783,
33,
3046,
13,
28961,
198,
198,
76,
18187,
2878,
7854,
346,
500,
45488,
19746,
1279,
25,
45783,
6030,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
3712,
2964,
1462,
48526,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
3712,
35,
713,
90,
13940,
23650,
11,
7149,
92,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
12286,
2617,
3712,
7248,
90,
13940,
23650,
92,
628,
220,
220,
220,
2163,
7854,
346,
500,
45488,
19746,
7,
26,
479,
86,
22046,
23029,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
796,
649,
7,
28961,
7,
15205,
346,
500,
45488,
19746,
828,
360,
713,
90,
13940,
23650,
11,
7149,
92,
22784,
5345,
90,
13940,
23650,
92,
28955,
198,
220,
220,
220,
220,
220,
220,
220,
3815,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
198,
220,
220,
220,
220,
220,
220,
220,
5659,
11600,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
13,
1837,
9132,
713,
198,
220,
220,
220,
220,
220,
220,
220,
329,
299,
85,
287,
479,
86,
22046,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
3672,
11,
277,
335,
2100,
796,
299,
85,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
4906,
796,
5659,
11600,
58,
69,
335,
3672,
4083,
73,
28004,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
69,
335,
3672,
287,
8251,
7,
1837,
9132,
713,
4008,
8614,
4049,
7,
8841,
7,
4906,
1659,
7,
26801,
828,
366,
468,
645,
2214,
351,
1438,
33172,
277,
335,
3672,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3815,
58,
69,
335,
3672,
60,
796,
318,
64,
7,
69,
335,
2100,
11,
277,
335,
4906,
8,
5633,
277,
335,
2100,
1058,
10385,
7,
69,
335,
4906,
11,
277,
335,
2100,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
198,
220,
220,
220,
886,
198,
437,
1303,
4517,
540,
2878,
7854,
346,
500,
45488,
19746,
198,
9979,
11593,
28961,
62,
15205,
346,
500,
45488,
19746,
796,
6524,
90,
2964,
1462,
48526,
92,
3419,
198,
8818,
13634,
7,
3712,
6030,
90,
15205,
346,
500,
45488,
19746,
30072,
198,
220,
220,
220,
45783,
33,
3046,
13,
28469,
735,
3419,
466,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
562,
3916,
7,
834,
28961,
62,
15205,
346,
500,
45488,
19746,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
15205,
346,
500,
45488,
19746,
21737,
796,
2496,
796,
45783,
48526,
7,
15205,
346,
500,
45488,
19746,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
477,
69,
335,
82,
796,
39645,
90,
13940,
23650,
11,
38176,
90,
6030,
11,
10100,
11709,
58,
25,
12985,
5218,
7308,
13,
38469,
90,
23839,
10100,
92,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
13634,
7,
16793,
11,
7854,
346,
500,
45488,
19746,
11,
477,
69,
335,
82,
11,
45783,
33,
3046,
13,
32988,
62,
2200,
48,
11,
45783,
33,
3046,
13,
32988,
62,
37,
41359,
11,
45783,
33,
3046,
13,
32988,
62,
23428,
11,
45783,
33,
3046,
13,
32988,
62,
47,
8120,
11,
45783,
33,
3046,
13,
32988,
62,
54,
9936,
47,
1546,
11,
45783,
33,
3046,
13,
32988,
62,
1340,
4720,
10652,
11,
45783,
33,
3046,
13,
32988,
62,
1340,
4720,
37,
62,
45,
29559,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
15205,
346,
500,
45488,
19746,
21737,
198,
220,
220,
220,
886,
198,
437,
198,
8818,
7308,
13,
1136,
26745,
7,
26801,
3712,
15205,
346,
500,
45488,
19746,
11,
1438,
3712,
13940,
23650,
8,
198,
220,
220,
220,
611,
1438,
24844,
1058,
12985,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
14881,
13,
38469,
90,
23839,
10100,
92,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
651,
3245,
7,
26801,
11,
1438,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
76,
18187,
2878,
11899,
259,
45488,
19746,
62,
27996,
1279,
25,
45783,
6030,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
3712,
2964,
1462,
48526,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
3712,
35,
713,
90,
13940,
23650,
11,
7149,
92,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
12286,
2617,
3712,
7248,
90,
13940,
23650,
92,
628,
220,
220,
220,
2163,
11899,
259,
45488,
19746,
62,
27996,
7,
26,
479,
86,
22046,
23029,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
796,
649,
7,
28961,
7,
24428,
259,
45488,
19746,
62,
27996,
828,
360,
713,
90,
13940,
23650,
11,
7149,
92,
22784,
5345,
90,
13940,
23650,
92,
28955,
198,
220,
220,
220,
220,
220,
220,
220,
3815,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
198,
220,
220,
220,
220,
220,
220,
220,
5659,
11600,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
13,
1837,
9132,
713,
198,
220,
220,
220,
220,
220,
220,
220,
329,
299,
85,
287,
479,
86,
22046,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
3672,
11,
277,
335,
2100,
796,
299,
85,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
4906,
796,
5659,
11600,
58,
69,
335,
3672,
4083,
73,
28004,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
69,
335,
3672,
287,
8251,
7,
1837,
9132,
713,
4008,
8614,
4049,
7,
8841,
7,
4906,
1659,
7,
26801,
828,
366,
468,
645,
2214,
351,
1438,
33172,
277,
335,
3672,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3815,
58,
69,
335,
3672,
60,
796,
318,
64,
7,
69,
335,
2100,
11,
277,
335,
4906,
8,
5633,
277,
335,
2100,
1058,
10385,
7,
69,
335,
4906,
11,
277,
335,
2100,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
198,
220,
220,
220,
886,
198,
437,
1303,
4517,
540,
2878,
11899,
259,
45488,
19746,
62,
27996,
198,
9979,
11593,
28961,
62,
24428,
259,
45488,
19746,
62,
27996,
796,
6524,
90,
2964,
1462,
48526,
92,
3419,
198,
8818,
13634,
7,
3712,
6030,
90,
24428,
259,
45488,
19746,
62,
27996,
30072,
198,
220,
220,
220,
45783,
33,
3046,
13,
28469,
735,
3419,
466,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
562,
3916,
7,
834,
28961,
62,
24428,
259,
45488,
19746,
62,
27996,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
24428,
259,
45488,
19746,
62,
27996,
21737,
796,
2496,
796,
45783,
48526,
7,
24428,
259,
45488,
19746,
62,
27996,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
477,
69,
335,
82,
796,
39645,
90,
13940,
23650,
11,
38176,
90,
6030,
11,
10100,
11709,
58,
25,
8367,
5218,
27741,
10100,
11,
1058,
21037,
5218,
27741,
10100,
11,
1058,
45828,
5218,
27741,
10100,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
13634,
7,
16793,
11,
11899,
259,
45488,
19746,
62,
27996,
11,
477,
69,
335,
82,
11,
45783,
33,
3046,
13,
32988,
62,
2200,
48,
11,
45783,
33,
3046,
13,
32988,
62,
37,
41359,
11,
45783,
33,
3046,
13,
32988,
62,
23428,
11,
45783,
33,
3046,
13,
32988,
62,
47,
8120,
11,
45783,
33,
3046,
13,
32988,
62,
54,
9936,
47,
1546,
11,
45783,
33,
3046,
13,
32988,
62,
1340,
4720,
10652,
11,
45783,
33,
3046,
13,
32988,
62,
1340,
4720,
37,
62,
45,
29559,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
24428,
259,
45488,
19746,
62,
27996,
21737,
198,
220,
220,
220,
886,
198,
437,
198,
8818,
7308,
13,
1136,
26745,
7,
26801,
3712,
24428,
259,
45488,
19746,
62,
27996,
11,
1438,
3712,
13940,
23650,
8,
198,
220,
220,
220,
611,
1438,
24844,
1058,
8367,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
23839,
10100,
198,
220,
220,
220,
2073,
361,
1438,
24844,
1058,
21037,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
23839,
10100,
198,
220,
220,
220,
2073,
361,
1438,
24844,
1058,
45828,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
23839,
10100,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
651,
3245,
7,
26801,
11,
1438,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
76,
18187,
2878,
11899,
259,
45488,
19746,
1279,
25,
45783,
6030,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
3712,
2964,
1462,
48526,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
3712,
35,
713,
90,
13940,
23650,
11,
7149,
92,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
12286,
2617,
3712,
7248,
90,
13940,
23650,
92,
628,
220,
220,
220,
2163,
11899,
259,
45488,
19746,
7,
26,
479,
86,
22046,
23029,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
796,
649,
7,
28961,
7,
24428,
259,
45488,
19746,
828,
360,
713,
90,
13940,
23650,
11,
7149,
92,
22784,
5345,
90,
13940,
23650,
92,
28955,
198,
220,
220,
220,
220,
220,
220,
220,
3815,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
198,
220,
220,
220,
220,
220,
220,
220,
5659,
11600,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
13,
1837,
9132,
713,
198,
220,
220,
220,
220,
220,
220,
220,
329,
299,
85,
287,
479,
86,
22046,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
3672,
11,
277,
335,
2100,
796,
299,
85,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
4906,
796,
5659,
11600,
58,
69,
335,
3672,
4083,
73,
28004,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
69,
335,
3672,
287,
8251,
7,
1837,
9132,
713,
4008,
8614,
4049,
7,
8841,
7,
4906,
1659,
7,
26801,
828,
366,
468,
645,
2214,
351,
1438,
33172,
277,
335,
3672,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3815,
58,
69,
335,
3672,
60,
796,
318,
64,
7,
69,
335,
2100,
11,
277,
335,
4906,
8,
5633,
277,
335,
2100,
1058,
10385,
7,
69,
335,
4906,
11,
277,
335,
2100,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
198,
220,
220,
220,
886,
198,
437,
1303,
4517,
540,
2878,
11899,
259,
45488,
19746,
198,
9979,
11593,
28961,
62,
24428,
259,
45488,
19746,
796,
6524,
90,
2964,
1462,
48526,
92,
3419,
198,
8818,
13634,
7,
3712,
6030,
90,
24428,
259,
45488,
19746,
30072,
198,
220,
220,
220,
45783,
33,
3046,
13,
28469,
735,
3419,
466,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
562,
3916,
7,
834,
28961,
62,
24428,
259,
45488,
19746,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
24428,
259,
45488,
19746,
21737,
796,
2496,
796,
45783,
48526,
7,
24428,
259,
45488,
19746,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
477,
69,
335,
82,
796,
39645,
90,
13940,
23650,
11,
38176,
90,
6030,
11,
10100,
11709,
58,
25,
25076,
5218,
7308,
13,
38469,
90,
24428,
259,
45488,
19746,
62,
27996,
92,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
13634,
7,
16793,
11,
11899,
259,
45488,
19746,
11,
477,
69,
335,
82,
11,
45783,
33,
3046,
13,
32988,
62,
2200,
48,
11,
45783,
33,
3046,
13,
32988,
62,
37,
41359,
11,
45783,
33,
3046,
13,
32988,
62,
23428,
11,
45783,
33,
3046,
13,
32988,
62,
47,
8120,
11,
45783,
33,
3046,
13,
32988,
62,
54,
9936,
47,
1546,
11,
45783,
33,
3046,
13,
32988,
62,
1340,
4720,
10652,
11,
45783,
33,
3046,
13,
32988,
62,
1340,
4720,
37,
62,
45,
29559,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
24428,
259,
45488,
19746,
21737,
198,
220,
220,
220,
886,
198,
437,
198,
8818,
7308,
13,
1136,
26745,
7,
26801,
3712,
24428,
259,
45488,
19746,
11,
1438,
3712,
13940,
23650,
8,
198,
220,
220,
220,
611,
1438,
24844,
1058,
25076,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
14881,
13,
38469,
90,
24428,
259,
45488,
19746,
62,
27996,
92,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
651,
3245,
7,
26801,
11,
1438,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
76,
18187,
2878,
22086,
1279,
25,
45783,
6030,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
3712,
2964,
1462,
48526,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
3712,
35,
713,
90,
13940,
23650,
11,
7149,
92,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
12286,
2617,
3712,
7248,
90,
13940,
23650,
92,
628,
220,
220,
220,
2163,
22086,
7,
26,
479,
86,
22046,
23029,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
796,
649,
7,
28961,
7,
45488,
828,
360,
713,
90,
13940,
23650,
11,
7149,
92,
22784,
5345,
90,
13940,
23650,
92,
28955,
198,
220,
220,
220,
220,
220,
220,
220,
3815,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
198,
220,
220,
220,
220,
220,
220,
220,
5659,
11600,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
13,
1837,
9132,
713,
198,
220,
220,
220,
220,
220,
220,
220,
329,
299,
85,
287,
479,
86,
22046,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
3672,
11,
277,
335,
2100,
796,
299,
85,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
4906,
796,
5659,
11600,
58,
69,
335,
3672,
4083,
73,
28004,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
69,
335,
3672,
287,
8251,
7,
1837,
9132,
713,
4008,
8614,
4049,
7,
8841,
7,
4906,
1659,
7,
26801,
828,
366,
468,
645,
2214,
351,
1438,
33172,
277,
335,
3672,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3815,
58,
69,
335,
3672,
60,
796,
318,
64,
7,
69,
335,
2100,
11,
277,
335,
4906,
8,
5633,
277,
335,
2100,
1058,
10385,
7,
69,
335,
4906,
11,
277,
335,
2100,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
198,
220,
220,
220,
886,
198,
437,
1303,
4517,
540,
2878,
22086,
198,
9979,
11593,
28961,
62,
45488,
796,
6524,
90,
2964,
1462,
48526,
92,
3419,
198,
8818,
13634,
7,
3712,
6030,
90,
45488,
30072,
198,
220,
220,
220,
45783,
33,
3046,
13,
28469,
735,
3419,
466,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
562,
3916,
7,
834,
28961,
62,
45488,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
45488,
21737,
796,
2496,
796,
45783,
48526,
7,
45488,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
477,
69,
335,
82,
796,
39645,
90,
13940,
23650,
11,
38176,
90,
6030,
11,
10100,
11709,
58,
25,
7839,
5218,
27741,
10100,
11,
1058,
16680,
346,
500,
5218,
7854,
346,
500,
45488,
19746,
11,
1058,
36153,
5218,
11899,
259,
45488,
19746,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
530,
1659,
82,
796,
2558,
58,
15,
11,
16,
11,
16,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
530,
1659,
62,
14933,
796,
38357,
58,
13940,
23650,
7203,
11299,
4943,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
13634,
7,
16793,
11,
22086,
11,
477,
69,
335,
82,
11,
45783,
33,
3046,
13,
32988,
62,
2200,
48,
11,
45783,
33,
3046,
13,
32988,
62,
37,
41359,
11,
45783,
33,
3046,
13,
32988,
62,
23428,
11,
45783,
33,
3046,
13,
32988,
62,
47,
8120,
11,
45783,
33,
3046,
13,
32988,
62,
54,
9936,
47,
1546,
11,
530,
1659,
82,
11,
530,
1659,
62,
14933,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
45488,
21737,
198,
220,
220,
220,
886,
198,
437,
198,
8818,
7308,
13,
1136,
26745,
7,
26801,
3712,
45488,
11,
1438,
3712,
13940,
23650,
8,
198,
220,
220,
220,
611,
1438,
24844,
1058,
7839,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
23839,
10100,
198,
220,
220,
220,
2073,
361,
1438,
24844,
1058,
16680,
346,
500,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
15205,
346,
500,
45488,
19746,
198,
220,
220,
220,
2073,
361,
1438,
24844,
1058,
36153,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
24428,
259,
45488,
19746,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
651,
3245,
7,
26801,
11,
1438,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
76,
18187,
2878,
21743,
1279,
25,
45783,
6030,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
3712,
2964,
1462,
48526,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
3712,
35,
713,
90,
13940,
23650,
11,
7149,
92,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
12286,
2617,
3712,
7248,
90,
13940,
23650,
92,
628,
220,
220,
220,
2163,
21743,
7,
26,
479,
86,
22046,
23029,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
796,
649,
7,
28961,
7,
27313,
828,
360,
713,
90,
13940,
23650,
11,
7149,
92,
22784,
5345,
90,
13940,
23650,
92,
28955,
198,
220,
220,
220,
220,
220,
220,
220,
3815,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
198,
220,
220,
220,
220,
220,
220,
220,
5659,
11600,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
13,
1837,
9132,
713,
198,
220,
220,
220,
220,
220,
220,
220,
329,
299,
85,
287,
479,
86,
22046,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
3672,
11,
277,
335,
2100,
796,
299,
85,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
4906,
796,
5659,
11600,
58,
69,
335,
3672,
4083,
73,
28004,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
69,
335,
3672,
287,
8251,
7,
1837,
9132,
713,
4008,
8614,
4049,
7,
8841,
7,
4906,
1659,
7,
26801,
828,
366,
468,
645,
2214,
351,
1438,
33172,
277,
335,
3672,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3815,
58,
69,
335,
3672,
60,
796,
318,
64,
7,
69,
335,
2100,
11,
277,
335,
4906,
8,
5633,
277,
335,
2100,
1058,
10385,
7,
69,
335,
4906,
11,
277,
335,
2100,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
198,
220,
220,
220,
886,
198,
437,
1303,
4517,
540,
2878,
21743,
198,
9979,
11593,
28961,
62,
27313,
796,
6524,
90,
2964,
1462,
48526,
92,
3419,
198,
8818,
13634,
7,
3712,
6030,
90,
27313,
30072,
198,
220,
220,
220,
45783,
33,
3046,
13,
28469,
735,
3419,
466,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
562,
3916,
7,
834,
28961,
62,
27313,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
27313,
21737,
796,
2496,
796,
45783,
48526,
7,
27313,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
477,
69,
335,
82,
796,
39645,
90,
13940,
23650,
11,
38176,
90,
6030,
11,
10100,
11709,
58,
25,
7839,
5218,
27741,
10100,
11,
1058,
40926,
5218,
7308,
13,
38469,
90,
45488,
5512,
1058,
20225,
5218,
347,
970,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
13634,
7,
16793,
11,
21743,
11,
477,
69,
335,
82,
11,
45783,
33,
3046,
13,
32988,
62,
2200,
48,
11,
45783,
33,
3046,
13,
32988,
62,
37,
41359,
11,
45783,
33,
3046,
13,
32988,
62,
23428,
11,
45783,
33,
3046,
13,
32988,
62,
47,
8120,
11,
45783,
33,
3046,
13,
32988,
62,
54,
9936,
47,
1546,
11,
45783,
33,
3046,
13,
32988,
62,
1340,
4720,
10652,
11,
45783,
33,
3046,
13,
32988,
62,
1340,
4720,
37,
62,
45,
29559,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
27313,
21737,
198,
220,
220,
220,
886,
198,
437,
198,
8818,
7308,
13,
1136,
26745,
7,
26801,
3712,
27313,
11,
1438,
3712,
13940,
23650,
8,
198,
220,
220,
220,
611,
1438,
24844,
1058,
7839,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
23839,
10100,
198,
220,
220,
220,
2073,
361,
1438,
24844,
1058,
40926,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
14881,
13,
38469,
90,
45488,
92,
198,
220,
220,
220,
2073,
361,
1438,
24844,
1058,
20225,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
33,
970,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
651,
3245,
7,
26801,
11,
1438,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
76,
18187,
2878,
47639,
1279,
25,
45783,
6030,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
3712,
2964,
1462,
48526,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
3712,
35,
713,
90,
13940,
23650,
11,
7149,
92,
198,
220,
220,
220,
11593,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
12286,
2617,
3712,
7248,
90,
13940,
23650,
92,
628,
220,
220,
220,
2163,
47639,
7,
26,
479,
86,
22046,
23029,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
796,
649,
7,
28961,
7,
32517,
828,
360,
713,
90,
13940,
23650,
11,
7149,
92,
22784,
5345,
90,
13940,
23650,
92,
28955,
198,
220,
220,
220,
220,
220,
220,
220,
3815,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
198,
220,
220,
220,
220,
220,
220,
220,
5659,
11600,
796,
26181,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
28961,
13,
1837,
9132,
713,
198,
220,
220,
220,
220,
220,
220,
220,
329,
299,
85,
287,
479,
86,
22046,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
3672,
11,
277,
335,
2100,
796,
299,
85,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
277,
335,
4906,
796,
5659,
11600,
58,
69,
335,
3672,
4083,
73,
28004,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
69,
335,
3672,
287,
8251,
7,
1837,
9132,
713,
4008,
8614,
4049,
7,
8841,
7,
4906,
1659,
7,
26801,
828,
366,
468,
645,
2214,
351,
1438,
33172,
277,
335,
3672,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3815,
58,
69,
335,
3672,
60,
796,
318,
64,
7,
69,
335,
2100,
11,
277,
335,
4906,
8,
5633,
277,
335,
2100,
1058,
10385,
7,
69,
335,
4906,
11,
277,
335,
2100,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
26181,
198,
220,
220,
220,
886,
198,
437,
1303,
4517,
540,
2878,
47639,
198,
9979,
11593,
28961,
62,
32517,
796,
6524,
90,
2964,
1462,
48526,
92,
3419,
198,
8818,
13634,
7,
3712,
6030,
90,
32517,
30072,
198,
220,
220,
220,
45783,
33,
3046,
13,
28469,
735,
3419,
466,
198,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
271,
562,
3916,
7,
834,
28961,
62,
32517,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
32517,
21737,
796,
2496,
796,
45783,
48526,
7,
32517,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
477,
69,
335,
82,
796,
39645,
90,
13940,
23650,
11,
38176,
90,
6030,
11,
10100,
11709,
58,
25,
9641,
5218,
2558,
2624,
11,
1058,
22872,
5218,
7308,
13,
38469,
90,
27313,
92,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
13634,
7,
16793,
11,
47639,
11,
477,
69,
335,
82,
11,
45783,
33,
3046,
13,
32988,
62,
2200,
48,
11,
45783,
33,
3046,
13,
32988,
62,
37,
41359,
11,
45783,
33,
3046,
13,
32988,
62,
23428,
11,
45783,
33,
3046,
13,
32988,
62,
47,
8120,
11,
45783,
33,
3046,
13,
32988,
62,
54,
9936,
47,
1546,
11,
45783,
33,
3046,
13,
32988,
62,
1340,
4720,
10652,
11,
45783,
33,
3046,
13,
32988,
62,
1340,
4720,
37,
62,
45,
29559,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
11593,
28961,
62,
32517,
21737,
198,
220,
220,
220,
886,
198,
437,
198,
8818,
7308,
13,
1136,
26745,
7,
26801,
3712,
32517,
11,
1438,
3712,
13940,
23650,
8,
198,
220,
220,
220,
611,
1438,
24844,
1058,
9641,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
5317,
2624,
198,
220,
220,
220,
2073,
361,
1438,
24844,
1058,
22872,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
357,
26801,
13,
834,
11235,
672,
3046,
62,
20362,
62,
32538,
62,
27160,
58,
3672,
60,
2599,
25,
14881,
13,
38469,
90,
27313,
92,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
651,
3245,
7,
26801,
11,
1438,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
39344,
22086,
11,
7854,
346,
500,
45488,
19746,
11,
11899,
259,
45488,
19746,
62,
27996,
11,
11899,
259,
45488,
19746,
11,
21743,
11,
47639,
198
] | 2.290506 | 4,561 |
include("model.jl")
# particle marginal metropolis-hastings
@compiled @gen function var_proposal(prev)
var_x::Float64 = get_assignment(prev)[:var_x]
var_y::Float64 = get_assignment(prev)[:var_y]
#@addr(normal(var_x, sqrt(0.15)), :var_x)
#@addr(normal(var_y, sqrt(0.08)), :var_y)
@addr(normal(var_x, sqrt(0.5)), :var_x)
@addr(normal(var_y, sqrt(0.5)), :var_y)
end
@gen function observer(ys)
for (i, y) in enumerate(ys)
@addr(dirac(y), :hmm => :y => i)
end
end
load_generated_functions()
##########
function strip_lineinfo(expr::Expr)
@assert !(expr.head == :line)
new_args = []
for arg in expr.args
if (isa(arg, Expr) && arg.head == :line) || isa(arg, LineNumberNode)
elseif isa(arg, Expr) && arg.head == :block
stripped = strip_lineinfo(arg)
append!(new_args, stripped.args)
else
push!(new_args, strip_lineinfo(arg))
end
end
Expr(expr.head, new_args...)
end
function strip_lineinfo(expr)
expr
end
println("\n######################################################################\n")
obs = get_assignment(simulate(obs_sub, (1.2,)))
#println(strip_lineinfo(
#Gen.codegen_generate(typeof(kernel), Tuple{Int,State,Params}, typeof(obs), Nothing)))
import InteractiveUtils
InteractiveUtils.code_warntype(
generate,
(typeof(kernel), Tuple{Int,State,Params}, typeof(obs), Nothing))
println("\n######################################################################\n")
function initial_collapsed_trace(ys)
T = length(ys)
constraints = get_assignment(simulate(observer, (ys,)))
(trace, weight) = generate(model_collapsed, (T,), constraints)
trace
end
import Random
Random.seed!(1)
# generate synthetic dataset
T = 100 # was 500
(xs_sim, ys_sim) = hmm(10., 1., T)
# do inference
function do_inference(n)
trace = initial_collapsed_trace(ys_sim)
for iter=1:n
score = get_call_record(trace).score
println("score: $score")
trace = mh(model_collapsed, var_proposal, (), trace)
choices = get_assignment(trace)
println("var_x: $(choices[:var_x]), var_y: $(choices[:var_y])")
end
end
import Profile
@time do_inference(2)
@time do_inference(100)
#Profile.@profile do_inference(17)
#Profile.print(format=:flat, sortedby=:count)
#Profile.print(mincount=10)
| [
17256,
7203,
19849,
13,
20362,
4943,
628,
198,
2,
18758,
14461,
1138,
25986,
12,
71,
459,
654,
198,
198,
31,
5589,
3902,
2488,
5235,
2163,
1401,
62,
1676,
40007,
7,
47050,
8,
198,
220,
220,
220,
1401,
62,
87,
3712,
43879,
2414,
796,
651,
62,
562,
16747,
7,
47050,
38381,
25,
7785,
62,
87,
60,
198,
220,
220,
220,
1401,
62,
88,
3712,
43879,
2414,
796,
651,
62,
562,
16747,
7,
47050,
38381,
25,
7785,
62,
88,
60,
198,
220,
220,
220,
1303,
31,
29851,
7,
11265,
7,
7785,
62,
87,
11,
19862,
17034,
7,
15,
13,
1314,
36911,
1058,
7785,
62,
87,
8,
198,
220,
220,
220,
1303,
31,
29851,
7,
11265,
7,
7785,
62,
88,
11,
19862,
17034,
7,
15,
13,
2919,
36911,
1058,
7785,
62,
88,
8,
198,
220,
220,
220,
2488,
29851,
7,
11265,
7,
7785,
62,
87,
11,
19862,
17034,
7,
15,
13,
20,
36911,
1058,
7785,
62,
87,
8,
198,
220,
220,
220,
2488,
29851,
7,
11265,
7,
7785,
62,
88,
11,
19862,
17034,
7,
15,
13,
20,
36911,
1058,
7785,
62,
88,
8,
198,
437,
198,
198,
31,
5235,
2163,
22890,
7,
893,
8,
198,
220,
220,
220,
329,
357,
72,
11,
331,
8,
287,
27056,
378,
7,
893,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
29851,
7,
15908,
330,
7,
88,
828,
1058,
71,
3020,
5218,
1058,
88,
5218,
1312,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
2220,
62,
27568,
62,
12543,
2733,
3419,
628,
198,
198,
7804,
2235,
198,
8818,
10283,
62,
1370,
10951,
7,
31937,
3712,
3109,
1050,
8,
198,
220,
220,
220,
2488,
30493,
5145,
7,
31937,
13,
2256,
6624,
1058,
1370,
8,
198,
220,
220,
220,
649,
62,
22046,
796,
17635,
198,
220,
220,
220,
329,
1822,
287,
44052,
13,
22046,
198,
220,
220,
220,
220,
220,
220,
220,
611,
357,
9160,
7,
853,
11,
1475,
1050,
8,
11405,
1822,
13,
2256,
6624,
1058,
1370,
8,
8614,
318,
64,
7,
853,
11,
6910,
15057,
19667,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
361,
318,
64,
7,
853,
11,
1475,
1050,
8,
11405,
1822,
13,
2256,
6624,
1058,
9967,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
18818,
796,
10283,
62,
1370,
10951,
7,
853,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
24443,
0,
7,
3605,
62,
22046,
11,
18818,
13,
22046,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4574,
0,
7,
3605,
62,
22046,
11,
10283,
62,
1370,
10951,
7,
853,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1475,
1050,
7,
31937,
13,
2256,
11,
649,
62,
22046,
23029,
198,
437,
198,
198,
8818,
10283,
62,
1370,
10951,
7,
31937,
8,
198,
220,
220,
220,
44052,
198,
437,
198,
198,
35235,
7203,
59,
77,
29113,
29113,
4242,
2235,
59,
77,
4943,
198,
8158,
796,
651,
62,
562,
16747,
7,
14323,
5039,
7,
8158,
62,
7266,
11,
357,
16,
13,
17,
11,
22305,
198,
2,
35235,
7,
36311,
62,
1370,
10951,
7,
198,
220,
220,
220,
1303,
13746,
13,
8189,
5235,
62,
8612,
378,
7,
4906,
1659,
7,
33885,
828,
309,
29291,
90,
5317,
11,
9012,
11,
10044,
4105,
5512,
2099,
1659,
7,
8158,
828,
10528,
22305,
198,
11748,
21365,
18274,
4487,
198,
220,
220,
220,
21365,
18274,
4487,
13,
8189,
62,
5767,
429,
2981,
7,
198,
220,
220,
220,
220,
220,
220,
220,
7716,
11,
198,
220,
220,
220,
220,
220,
220,
220,
357,
4906,
1659,
7,
33885,
828,
309,
29291,
90,
5317,
11,
9012,
11,
10044,
4105,
5512,
2099,
1659,
7,
8158,
828,
10528,
4008,
198,
35235,
7203,
59,
77,
29113,
29113,
4242,
2235,
59,
77,
4943,
628,
628,
198,
198,
8818,
4238,
62,
26000,
28361,
62,
40546,
7,
893,
8,
198,
220,
220,
220,
309,
796,
4129,
7,
893,
8,
198,
220,
220,
220,
17778,
796,
651,
62,
562,
16747,
7,
14323,
5039,
7,
672,
15388,
11,
357,
893,
11,
22305,
198,
220,
220,
220,
357,
40546,
11,
3463,
8,
796,
7716,
7,
19849,
62,
26000,
28361,
11,
357,
51,
11,
828,
17778,
8,
198,
220,
220,
220,
12854,
198,
437,
198,
198,
11748,
14534,
198,
29531,
13,
28826,
0,
7,
16,
8,
198,
198,
2,
7716,
18512,
27039,
198,
51,
796,
1802,
1303,
373,
5323,
198,
7,
34223,
62,
14323,
11,
331,
82,
62,
14323,
8,
796,
289,
3020,
7,
940,
1539,
352,
1539,
309,
8,
198,
198,
2,
466,
32278,
198,
8818,
466,
62,
259,
4288,
7,
77,
8,
198,
220,
220,
220,
12854,
796,
4238,
62,
26000,
28361,
62,
40546,
7,
893,
62,
14323,
8,
198,
220,
220,
220,
329,
11629,
28,
16,
25,
77,
198,
220,
220,
220,
220,
220,
220,
220,
4776,
796,
651,
62,
13345,
62,
22105,
7,
40546,
737,
26675,
198,
220,
220,
220,
220,
220,
220,
220,
44872,
7203,
26675,
25,
720,
26675,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
12854,
796,
285,
71,
7,
19849,
62,
26000,
28361,
11,
1401,
62,
1676,
40007,
11,
29994,
12854,
8,
198,
220,
220,
220,
220,
220,
220,
220,
7747,
796,
651,
62,
562,
16747,
7,
40546,
8,
198,
197,
220,
220,
220,
44872,
7203,
7785,
62,
87,
25,
29568,
6679,
1063,
58,
25,
7785,
62,
87,
46570,
1401,
62,
88,
25,
29568,
6679,
1063,
58,
25,
7785,
62,
88,
12962,
4943,
198,
220,
220,
220,
886,
198,
437,
198,
198,
11748,
13118,
198,
198,
31,
2435,
466,
62,
259,
4288,
7,
17,
8,
198,
31,
2435,
466,
62,
259,
4288,
7,
3064,
8,
198,
198,
2,
37046,
13,
31,
13317,
466,
62,
259,
4288,
7,
1558,
8,
198,
198,
2,
37046,
13,
4798,
7,
18982,
28,
25,
38568,
11,
23243,
1525,
28,
25,
9127,
8,
198,
2,
37046,
13,
4798,
7,
1084,
9127,
28,
940,
8,
198
] | 2.414213 | 985 |
module TestDistance
using ParallelKMeans: pairwise!, SingleThread, MultiThread
using Test
@testset "naive singlethread pairwise" begin
X = [1.0 2.0; 3.0 5.0; 4.0 6.0]
y = [1.0 2.0; ]
r = Array{Float64, 2}(undef, 3, 1)
pairwise!(r, X, y)
@test all(r .≈ [0.0, 13.0, 25.0])
end
@testset "multithread pairwise" begin
X = [1.0 2.0; 3.0 5.0; 4.0 6.0]
y = [1.0 2.0; ]
r = Array{Float64, 2}(undef, 3, 1)
pairwise!(r, X, y, MultiThread())
@test all(r .≈ [0.0, 13.0, 25.0])
end
end # module
| [
21412,
6208,
45767,
198,
3500,
42945,
42,
5308,
504,
25,
5166,
3083,
28265,
14206,
16818,
11,
15237,
16818,
198,
3500,
6208,
198,
198,
31,
9288,
2617,
366,
2616,
425,
2060,
16663,
5166,
3083,
1,
2221,
198,
220,
220,
220,
1395,
796,
685,
16,
13,
15,
362,
13,
15,
26,
513,
13,
15,
642,
13,
15,
26,
604,
13,
15,
718,
13,
15,
60,
198,
220,
220,
220,
331,
796,
685,
16,
13,
15,
362,
13,
15,
26,
2361,
198,
220,
220,
220,
374,
796,
15690,
90,
43879,
2414,
11,
362,
92,
7,
917,
891,
11,
513,
11,
352,
8,
628,
220,
220,
220,
5166,
3083,
0,
7,
81,
11,
1395,
11,
331,
8,
198,
220,
220,
220,
2488,
9288,
477,
7,
81,
764,
35705,
230,
685,
15,
13,
15,
11,
1511,
13,
15,
11,
1679,
13,
15,
12962,
198,
437,
198,
198,
31,
9288,
2617,
366,
16680,
342,
961,
5166,
3083,
1,
2221,
198,
220,
220,
220,
1395,
796,
685,
16,
13,
15,
362,
13,
15,
26,
513,
13,
15,
642,
13,
15,
26,
604,
13,
15,
718,
13,
15,
60,
198,
220,
220,
220,
331,
796,
685,
16,
13,
15,
362,
13,
15,
26,
2361,
198,
220,
220,
220,
374,
796,
15690,
90,
43879,
2414,
11,
362,
92,
7,
917,
891,
11,
513,
11,
352,
8,
628,
220,
220,
220,
5166,
3083,
0,
7,
81,
11,
1395,
11,
331,
11,
15237,
16818,
28955,
198,
220,
220,
220,
2488,
9288,
477,
7,
81,
764,
35705,
230,
685,
15,
13,
15,
11,
1511,
13,
15,
11,
1679,
13,
15,
12962,
198,
437,
628,
198,
437,
1303,
8265,
198
] | 1.973783 | 267 |
# ------------------------------------------------------------------------------------------
# # Condicionales
#
# En Julia, la sintaxis
#
# ```julia
# if *condición 1*
# *opción 1*
# elseif *condición 2*
# *opción 2*
# else
# *opción 3*
# end
# ```
#
# Nos permite eventualmente evaluar una de nuestras opciones.
# <br><br>
# Por ejemplo, tal vez queremos implementar la prueba de FizzBuzz: Dado un número N, imprime
# "Fizz" si N es divisible entre 3, "Buzz" si N es divisible entre 5, y "FizzBuzz" si N es
# divisible entre ambos 3 y 5. En cualquier otro caso, imprimo el número mismo.
# ------------------------------------------------------------------------------------------
N =
if (N % 3 == 0) & (N % 5 == 0)
println("FizzBuzz")
elseif N % 3 == 0
println("Fizz")
elseif N % 5 == 0
println("Buzz")
else
println(N)
end
# ------------------------------------------------------------------------------------------
# Ahora digamos que queremos regresar el mayor número de ambos. Escoge tus propios x y y
# ------------------------------------------------------------------------------------------
x =
y =
if x > y
x
else
y
end
# ------------------------------------------------------------------------------------------
# Para el último bloque, podemos usar el operador ternario, con la sintaxis
#
# ```julia
# a ? b : c
# ```
#
# que equivale a
#
# ```julia
# if a
# b
# else
# c
# end
# ```
# ------------------------------------------------------------------------------------------
(x > y) ? x : y
# ------------------------------------------------------------------------------------------
# Un truco relacionado es la evaluación de corto-circuito
#
# ```julia
# a && b
# ```
# ------------------------------------------------------------------------------------------
(x > y) && println(x)
(x < y) && println(y)
# ------------------------------------------------------------------------------------------
# Cuando escribimos `a && b`, `b` se ejecuta sólo si `a` se evalúa a `true`.
# <br>
# Si `a` se evalúa a `false`, la expresión `a && b` regresa `false`
# ------------------------------------------------------------------------------------------
# ------------------------------------------------------------------------------------------
# ### Ejercicios
#
# 5.1 Reescribe FizzBuzz sin usar `elseif`.
# ------------------------------------------------------------------------------------------
# ------------------------------------------------------------------------------------------
# 5.2 Reescribe FizzBuzz usando el operador ternario.
# ------------------------------------------------------------------------------------------
| [
2,
16529,
22369,
438,
198,
2,
1303,
9724,
291,
1538,
274,
198,
2,
198,
2,
2039,
22300,
11,
8591,
264,
600,
22704,
198,
2,
198,
2,
7559,
63,
73,
43640,
198,
2,
611,
1635,
17561,
44070,
18840,
352,
9,
198,
2,
220,
220,
220,
220,
1635,
404,
979,
18840,
352,
9,
198,
2,
2073,
361,
1635,
17561,
44070,
18840,
362,
9,
198,
2,
220,
220,
220,
220,
1635,
404,
979,
18840,
362,
9,
198,
2,
2073,
198,
2,
220,
220,
220,
220,
1635,
404,
979,
18840,
513,
9,
198,
2,
886,
198,
2,
7559,
63,
198,
2,
198,
2,
32798,
9943,
578,
19657,
434,
68,
5418,
84,
283,
555,
64,
390,
14364,
395,
8847,
1034,
66,
295,
274,
13,
198,
2,
1279,
1671,
6927,
1671,
29,
198,
2,
20139,
304,
73,
18856,
78,
11,
3305,
1569,
89,
627,
567,
16785,
3494,
283,
8591,
778,
518,
7012,
390,
376,
6457,
48230,
25,
360,
4533,
555,
299,
21356,
647,
78,
399,
11,
848,
81,
524,
198,
2,
366,
37,
6457,
1,
33721,
399,
1658,
2659,
12843,
920,
260,
513,
11,
366,
48230,
1,
33721,
399,
1658,
2659,
12843,
920,
260,
642,
11,
331,
366,
37,
6457,
48230,
1,
33721,
399,
1658,
198,
2,
2659,
12843,
920,
260,
4915,
418,
513,
331,
642,
13,
2039,
269,
723,
421,
959,
267,
23528,
6124,
78,
11,
848,
3036,
78,
1288,
299,
21356,
647,
78,
32691,
78,
13,
198,
2,
16529,
22369,
438,
198,
198,
45,
796,
220,
198,
198,
361,
357,
45,
4064,
513,
6624,
657,
8,
1222,
357,
45,
4064,
642,
6624,
657,
8,
198,
220,
220,
220,
44872,
7203,
37,
6457,
48230,
4943,
198,
17772,
361,
399,
4064,
513,
6624,
657,
198,
220,
220,
220,
44872,
7203,
37,
6457,
4943,
198,
17772,
361,
399,
4064,
642,
6624,
657,
198,
220,
220,
220,
44872,
7203,
48230,
4943,
198,
17772,
198,
220,
220,
220,
44872,
7,
45,
8,
198,
437,
198,
198,
2,
16529,
22369,
438,
198,
2,
7900,
5799,
3100,
321,
418,
8358,
627,
567,
16785,
842,
411,
283,
1288,
9591,
299,
21356,
647,
78,
390,
4915,
418,
13,
8678,
1073,
469,
256,
385,
2632,
4267,
2124,
331,
331,
198,
2,
16529,
22369,
438,
198,
198,
87,
796,
220,
198,
88,
796,
220,
198,
198,
361,
2124,
1875,
331,
198,
220,
220,
220,
2124,
198,
17772,
198,
220,
220,
220,
331,
198,
437,
198,
198,
2,
16529,
22369,
438,
198,
2,
2547,
64,
1288,
6184,
118,
2528,
25147,
24924,
4188,
11,
24573,
368,
418,
514,
283,
1288,
1515,
7079,
1059,
77,
4982,
11,
369,
8591,
264,
600,
22704,
198,
2,
198,
2,
7559,
63,
73,
43640,
198,
2,
257,
5633,
275,
1058,
269,
198,
2,
7559,
63,
198,
2,
198,
2,
8358,
1602,
452,
1000,
257,
198,
2,
198,
2,
7559,
63,
73,
43640,
198,
2,
611,
257,
198,
2,
220,
220,
220,
220,
275,
198,
2,
2073,
198,
2,
220,
220,
220,
220,
269,
198,
2,
886,
198,
2,
7559,
63,
198,
2,
16529,
22369,
438,
198,
198,
7,
87,
1875,
331,
8,
5633,
2124,
1058,
331,
198,
198,
2,
16529,
22369,
438,
198,
2,
791,
45768,
1073,
823,
49443,
4533,
1658,
8591,
5418,
84,
32009,
18840,
390,
12794,
78,
12,
21170,
5013,
78,
198,
2,
198,
2,
7559,
63,
73,
43640,
198,
2,
257,
11405,
275,
198,
2,
7559,
63,
198,
2,
16529,
22369,
438,
198,
198,
7,
87,
1875,
331,
8,
11405,
44872,
7,
87,
8,
198,
198,
7,
87,
1279,
331,
8,
11405,
44872,
7,
88,
8,
198,
198,
2,
16529,
22369,
438,
198,
2,
14496,
25440,
3671,
822,
320,
418,
4600,
64,
11405,
275,
47671,
4600,
65,
63,
384,
304,
73,
721,
29822,
264,
10205,
5439,
33721,
4600,
64,
63,
384,
5418,
21356,
64,
257,
4600,
7942,
44646,
198,
2,
1279,
1671,
29,
198,
2,
15638,
4600,
64,
63,
384,
5418,
21356,
64,
257,
4600,
9562,
47671,
8591,
1033,
411,
72,
18840,
4600,
64,
11405,
275,
63,
842,
14625,
4600,
9562,
63,
198,
2,
16529,
22369,
438,
198,
198,
2,
16529,
22369,
438,
198,
2,
44386,
412,
73,
2798,
291,
4267,
198,
2,
198,
2,
642,
13,
16,
797,
3798,
4892,
376,
6457,
48230,
7813,
514,
283,
4600,
17772,
361,
44646,
198,
2,
16529,
22369,
438,
628,
198,
198,
2,
16529,
22369,
438,
198,
2,
642,
13,
17,
797,
3798,
4892,
376,
6457,
48230,
514,
25440,
1288,
1515,
7079,
1059,
77,
4982,
13,
198,
2,
16529,
22369,
438,
628,
198
] | 3.709986 | 731 |
module RandomVariates
export
# SEED, A, C, MOD,
bernoulli_rng,
beta_rng,
binomial_rng,
erlang_rng,
expon_rng,
gamma_rng,
geometric_rng,
neg_binomial_rng,
conv_neg_binomial_rng,
normal_rng,
lognormal_rng,
mv_normal_rng,
poisson_rng,
uniform_rng,
weibull_rng,
tausworthe_rng,
triag_rng
include("uniform.jl")
include("exponential.jl")
include("erlang.jl")
include("weibull.jl")
include("bernoulli.jl")
include("geometric.jl")
include("poisson.jl")
include("binomial.jl")
include("neg_binomial.jl")
include("normal.jl")
include("gamma.jl")
include("beta.jl")
include("tausworthe.jl")
include("triangular.jl")
using Dates
global SEED = Dates.value(Dates.now()) # Use current epoch time as default seed
# using POSIX params for LCG
# https://en.wikipedia.org/wiki/Linear_congruential_generator#Parameters_in_common_use
const A = 25214903917
const C = 11
const MOD = 2^48
"""
set_seed(seed::Int)
Set the global `SEED` variable.
"""
function set_seed(seed::Int)
global SEED = seed
end
"""
set_user_seed(seed::Int)
Set a user-defined seed as global `SEED` variable.
"""
function set_user_seed(seed::Int)
global SEED = seed * 7856209
end
"""
seed_setter(seed::Union{Int, Nothing}=nothing)
Set a user defined seed, if given.
"""
function seed_setter(seed::Union{Int, Nothing}=nothing)
if !isnothing(seed)
set_user_seed(seed) # only set user seed once so we get new seed in subsequent calls
end
end
"""
get_seed()
Get the global `SEED` variable.
"""
function get_seed()
return SEED
end
"""
check_p(p::Real)
Check that parameter `p` falls between 0 and 1.
"""
function check_p(p::Real)
if (p > 1) || (p < 0)
throw(ArgumentError("Parameter `p` must fall between 0 and 1."))
end
end
# End of Module
end
| [
21412,
14534,
23907,
689,
198,
198,
39344,
198,
2,
7946,
1961,
11,
317,
11,
327,
11,
19164,
11,
198,
33900,
280,
15516,
62,
81,
782,
11,
198,
31361,
62,
81,
782,
11,
198,
8800,
49070,
62,
81,
782,
11,
198,
263,
17204,
62,
81,
782,
11,
198,
11201,
261,
62,
81,
782,
11,
198,
28483,
2611,
62,
81,
782,
11,
198,
469,
16996,
62,
81,
782,
11,
198,
12480,
62,
8800,
49070,
62,
81,
782,
11,
198,
42946,
62,
12480,
62,
8800,
49070,
62,
81,
782,
11,
198,
11265,
62,
81,
782,
11,
198,
75,
2360,
6636,
62,
81,
782,
11,
198,
76,
85,
62,
11265,
62,
81,
782,
11,
198,
7501,
30927,
62,
81,
782,
11,
198,
403,
6933,
62,
81,
782,
11,
198,
732,
571,
724,
62,
81,
782,
11,
198,
8326,
385,
86,
419,
258,
62,
81,
782,
11,
198,
28461,
363,
62,
81,
782,
198,
198,
17256,
7203,
403,
6933,
13,
20362,
4943,
198,
17256,
7203,
11201,
35470,
13,
20362,
4943,
198,
17256,
7203,
263,
17204,
13,
20362,
4943,
198,
17256,
7203,
732,
571,
724,
13,
20362,
4943,
198,
17256,
7203,
33900,
280,
15516,
13,
20362,
4943,
198,
17256,
7203,
469,
16996,
13,
20362,
4943,
198,
17256,
7203,
7501,
30927,
13,
20362,
4943,
198,
17256,
7203,
8800,
49070,
13,
20362,
4943,
198,
17256,
7203,
12480,
62,
8800,
49070,
13,
20362,
4943,
198,
17256,
7203,
11265,
13,
20362,
4943,
198,
17256,
7203,
28483,
2611,
13,
20362,
4943,
198,
17256,
7203,
31361,
13,
20362,
4943,
198,
17256,
7203,
8326,
385,
86,
419,
258,
13,
20362,
4943,
198,
17256,
7203,
28461,
21413,
13,
20362,
4943,
198,
198,
3500,
44712,
198,
198,
20541,
7946,
1961,
796,
44712,
13,
8367,
7,
35,
689,
13,
2197,
28955,
220,
1303,
5765,
1459,
36835,
640,
355,
4277,
9403,
198,
198,
2,
1262,
28069,
10426,
42287,
329,
22228,
38,
198,
2,
3740,
1378,
268,
13,
31266,
13,
2398,
14,
15466,
14,
14993,
451,
62,
36801,
622,
1843,
62,
8612,
1352,
2,
48944,
62,
259,
62,
11321,
62,
1904,
198,
9979,
317,
796,
1679,
22291,
3829,
2670,
1558,
198,
9979,
327,
796,
1367,
198,
9979,
19164,
796,
362,
61,
2780,
198,
198,
37811,
198,
220,
220,
220,
900,
62,
28826,
7,
28826,
3712,
5317,
8,
198,
198,
7248,
262,
3298,
4600,
5188,
1961,
63,
7885,
13,
198,
37811,
198,
8818,
900,
62,
28826,
7,
28826,
3712,
5317,
8,
198,
220,
220,
220,
3298,
7946,
1961,
796,
9403,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
900,
62,
7220,
62,
28826,
7,
28826,
3712,
5317,
8,
198,
198,
7248,
257,
2836,
12,
23211,
9403,
355,
3298,
4600,
5188,
1961,
63,
7885,
13,
198,
37811,
198,
8818,
900,
62,
7220,
62,
28826,
7,
28826,
3712,
5317,
8,
198,
220,
220,
220,
3298,
7946,
1961,
796,
9403,
1635,
8699,
3980,
22567,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
9403,
62,
2617,
353,
7,
28826,
3712,
38176,
90,
5317,
11,
10528,
92,
28,
22366,
8,
198,
198,
7248,
257,
2836,
5447,
9403,
11,
611,
1813,
13,
198,
37811,
198,
8818,
9403,
62,
2617,
353,
7,
28826,
3712,
38176,
90,
5317,
11,
10528,
92,
28,
22366,
8,
198,
220,
220,
220,
611,
5145,
271,
22366,
7,
28826,
8,
198,
220,
220,
220,
220,
220,
220,
220,
900,
62,
7220,
62,
28826,
7,
28826,
8,
220,
1303,
691,
900,
2836,
9403,
1752,
523,
356,
651,
649,
9403,
287,
8840,
3848,
198,
220,
220,
220,
886,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
651,
62,
28826,
3419,
198,
198,
3855,
262,
3298,
4600,
5188,
1961,
63,
7885,
13,
198,
37811,
198,
8818,
651,
62,
28826,
3419,
198,
197,
7783,
7946,
1961,
198,
437,
628,
198,
37811,
198,
220,
220,
220,
2198,
62,
79,
7,
79,
3712,
15633,
8,
198,
9787,
326,
11507,
4600,
79,
63,
8953,
1022,
657,
290,
352,
13,
198,
37811,
198,
8818,
2198,
62,
79,
7,
79,
3712,
15633,
8,
198,
220,
220,
220,
611,
357,
79,
1875,
352,
8,
8614,
357,
79,
1279,
657,
8,
198,
220,
220,
220,
220,
220,
220,
220,
3714,
7,
28100,
1713,
12331,
7203,
36301,
4600,
79,
63,
1276,
2121,
1022,
657,
290,
352,
526,
4008,
198,
220,
220,
220,
886,
198,
437,
628,
198,
2,
5268,
286,
19937,
198,
437,
198
] | 2.517781 | 703 |
# Don't modify this, it's just there to make the tests work.
module MLJTutorials
end
| [
2,
2094,
470,
13096,
428,
11,
340,
338,
655,
612,
284,
787,
262,
5254,
670,
13,
198,
21412,
10373,
41,
51,
44917,
82,
198,
437,
198
] | 3.269231 | 26 |
### Generic MUSE code
abstract type AbstractMuseProblem end
## interface to be implemented by specific problem types
function ∇θ_logLike end
function logLike_and_∇z_logLike end
function sample_x_z end
logPriorθ(prob::AbstractMuseProblem, θ) = 0
standardizeθ(prob::AbstractMuseProblem, θ) = θ
# this can also be overriden by specific problems
# the default does LBFGS using the provided logLike_and_∇z_logLike
function ẑ_at_θ(prob::AbstractMuseProblem, x, z₀, θ; ∇z_logLike_atol)
soln = optimize(Optim.only_fg(z -> .-logLike_and_∇z_logLike(prob, x, z, θ)), z₀, Optim.LBFGS(), Optim.Options(g_tol=∇z_logLike_atol))
soln.minimizer, soln
end
### MUSE result
@doc doc"""
Stores the result of a MUSE run. Can be constructed by-hand as
`MuseResult()` and passed to any of the inplace `muse!`, `get_J!`, or
`get_H!`.
Fields:
* `θ` — The estimate of the $\theta$ parameters.
* `Σ, Σ⁻¹` — The approximate covariance of $\theta$ and its inverse.
* `H, J` — The $H$ and $J$ matrices which form the covariance (see
[Millea & Seljak, 2021](https://arxiv.org/abs/2112.09354))
* `gs` — The MAP gradient sims used to compute `J`.
* `Hs` — The jacobian sims used to compute `H`.
* `dist` — A `Normal` or `MvNormal` built from `θ` and `Σ`, for
convenience.
* `history` — Internal diagnostic info from the run.
* `rng` — RNG used to generate sims for this run (so the same sims can
be reused if resuming later).
* `time` — Total `Millisecond` wall-time spent computing the result.
"""
Base.@kwdef mutable struct MuseResult
θ = nothing
H = nothing
J = nothing
Σ⁻¹ = nothing
Σ = nothing
dist = nothing
history = []
gs = []
Hs = []
rng = nothing
time = Millisecond(0)
end
### MUSE solver
@doc doc"""
muse(prob::AbstractMuseProblem, θ₀; kwargs...)
muse!(result::MuseResult, prob::AbstractMuseProblem, [θ₀=nothing]; kwargs...)
Run the MUSE estimate. The `muse!` form resumes an existing result. If the
`muse` form is used instead, `θ₀` must give a starting guess for $\theta$.
See [`MuseResult`](@ref) for description of return value.
Optional keyword arguments:
* `rng` — Random number generator to use. Taken from `result.rng` or `Random.default_rng()` if not passed.
* `z₀` — Starting guess for the latent space MAP.
* `maxsteps = 50` — Maximum number of iterations.
* `θ_rtol = 1e-1` — Error tolerance on $\theta$ relative to its standard deviation.
* `∇z_logLike_atol = 1e-2` — Absolute tolerance on the $z$-gradient at the MAP solution.
* `nsims = 100` — Number of simulations.
* `α = 0.7` — Step size for root-finder.
* `progress = false` — Show progress bar.
* `pmap` — Parallel map function.
* `regularize = identity` — Apply some regularization after each step.
* `H⁻¹_like = nothing` — Initial guess for the inverse Jacobian of $s^{\rm MUSE}(\theta)$
* `H⁻¹_update` — How to update `H⁻¹_like`. Should be `:sims`, `:broyden`, or `:diagonal_broyden`.
* `broyden_memory = Inf` — How many past steps to keep for Broyden updates.
* `checkpoint_filename = nothing` — Save result to a file after each iteration.
* `get_covariance = false` — Also call `get_H` and `get_J` to get the full covariance.
"""
muse(args...; kwargs...) = muse!(MuseResult(), args...; kwargs...)
function muse!(
result :: MuseResult,
prob :: AbstractMuseProblem,
θ₀ = nothing;
rng = nothing,
z₀ = nothing,
maxsteps = 50,
θ_rtol = 1e-1,
∇z_logLike_atol = 1e-2,
nsims = 100,
α = 0.7,
progress = false,
pmap = _map,
batch_size = 1,
regularize = identity,
H⁻¹_like = nothing,
H⁻¹_update = :sims,
broyden_memory = Inf,
checkpoint_filename = nothing,
get_covariance = false
)
rng = @something(rng, result.rng, copy(Random.default_rng()))
θunreg = θ = θ₀ = standardizeθ(prob, @something(result.θ, θ₀))
z₀ = @something(z₀, sample_x_z(prob, copy(rng), θ₀).z)
local H⁻¹_post, g_like_sims
history = result.history
result.rng = _rng = copy(rng)
xz_sims = [sample_x_z(prob, _rng, θ) for i=1:nsims]
xs = [[prob.x]; getindex.(xz_sims, :x)]
ẑs = [[z₀]; getindex.(xz_sims, :z)]
# set up progress bar
pbar = progress ? RemoteProgress((maxsteps-length(result.history))*(nsims+1)÷batch_size, 0.1, "MUSE: ") : nothing
try
for i = (length(result.history)+1):maxsteps
t₀ = now()
if i > 1
_rng = copy(rng)
xs = [[prob.x]; [sample_x_z(prob, _rng, θ).x for i=1:nsims]]
end
if i > 2
Δθ = history[end].θ - history[end-1].θ
norm(Δθ ./ θ) < θ_rtol && break
end
# MUSE gradient
gẑs = pmap(xs, ẑs, fill(θ,length(xs)); batch_size) do x, ẑ_prev, θ
local ẑ, history = ẑ_at_θ(prob, x, ẑ_prev, θ; ∇z_logLike_atol)
g = ∇θ_logLike(prob, x, ẑ, θ)
progress && ProgressMeter.next!(pbar)
(;g, ẑ, history)
end
ẑs = getindex.(gẑs, :ẑ)
ẑ_history_dat, ẑ_history_sims = peel(getindex.(gẑs, :history))
g_like_dat, g_like_sims = peel(getindex.(gẑs, :g))
g_like = g_like_dat .- mean(g_like_sims)
g_prior = AD.gradient(AD.ForwardDiffBackend(), θ -> logPriorθ(prob, θ), θ)[1]
g_post = g_like .+ g_prior
# Jacobian
h⁻¹_like_sims = -1 ./ var(collect(g_like_sims))
H⁻¹_like_sims = h⁻¹_like_sims isa Number ? h⁻¹_like_sims : Diagonal(h⁻¹_like_sims)
if (H⁻¹_like == nothing) || (H⁻¹_update == :sims)
H⁻¹_like = H⁻¹_like_sims
elseif i > 2 && (H⁻¹_update in [:broyden, :diagonal_broyden])
# on subsequent steps, do a Broyden's update using at
# most the previous `broyden_memory` steps
j₀ = Int(max(2, i - broyden_memory))
H⁻¹_like = history[j₀-1].H⁻¹_like_sims
for j = j₀:i-1
Δθ = history[j].θ - history[j-1].θ
Δg_like = history[j].g_like - history[j-1].g_like
H⁻¹_like = H⁻¹_like + ((Δθ - H⁻¹_like * Δg_like) / (Δθ' * H⁻¹_like * Δg_like)) * Δθ' * H⁻¹_like
if H⁻¹_update == :diagonal_broyden
H⁻¹_like = Diagonal(H⁻¹_like)
end
end
end
H_prior = AD.hessian(AD.ForwardDiffBackend(), θ -> logPriorθ(prob, θ), θ)[1]
H⁻¹_post = inv(inv(H⁻¹_like) + H_prior)
t = now() - t₀
push!(
history,
(;θ, θunreg,
g_like_dat, g_like_sims, g_like, g_prior, g_post,
H⁻¹_post, H_prior, H⁻¹_like, H⁻¹_like_sims,
ẑ_history_dat, ẑ_history_sims, t)
)
# Newton-Rhapson step
θunreg = θ .- α .* (H⁻¹_post * g_post)
θ = regularize(θunreg)
(checkpoint_filename != nothing) && save(checkpoint_filename, "result", result)
end
finally
progress && ProgressMeter.finish!(pbar)
end
result.time += sum(getindex.(history,:t))
result.θ = θunreg
result.gs = collect(g_like_sims)
if get_covariance
get_J!(result, prob)
get_H!(result, prob)
end
result
end
function get_H!(
result :: MuseResult,
prob :: AbstractMuseProblem,
θ₀ = result.θ;
fdm :: FiniteDifferenceMethod = central_fdm(3,1),
∇z_logLike_atol = 1e-8,
rng = Random.default_rng(),
nsims = 10,
step = nothing,
pmap = _map,
batch_size = 1,
pmap_over = :auto,
progress = false,
skip_errors = false,
)
θ₀ = standardizeθ(prob, @something(θ₀, result.θ))
nsims_remaining = nsims - length(result.Hs)
(nsims_remaining <= 0) && return
pbar = progress ? RemoteProgress(nsims_remaining*(1+length(θ₀))÷batch_size, 0.1, "get_H: ") : nothing
t₀ = now()
# generate simulation locally, advancing rng, and saving rng state to be reused remotely
xs_zs_rngs = map(1:nsims_remaining) do i
_rng = copy(rng)
(x, z) = sample_x_z(prob, rng, θ₀)
(x, z, _rng)
end
# initial fit at fiducial, used at starting points for finite difference below
ẑ₀s_rngs = pmap(xs_zs_rngs; batch_size) do (x, z, rng)
ẑ, = ẑ_at_θ(prob, x, z, θ₀; ∇z_logLike_atol)
progress && ProgressMeter.next!(pbar)
(ẑ, rng)
end
# finite difference Jacobian
pmap_sims, pmap_jac = (pmap_over == :jac || (pmap_over == :auto && length(θ₀) > nsims_remaining)) ? (_map, pmap) : (pmap, _map)
append!(result.Hs, skipmissing(pmap_sims(ẑ₀s_rngs; batch_size) do (ẑ₀, rng)
try
return first(pjacobian(fdm, θ₀, step; pmap=pmap_jac, batch_size, pbar) do θ
x, = sample_x_z(prob, copy(rng), θ)
ẑ, = ẑ_at_θ(prob, x, ẑ₀, θ₀; ∇z_logLike_atol)
∇θ_logLike(prob, x, ẑ, θ₀)
end)
catch err
if skip_errors && !(err isa InterruptException)
@warn err
return missing
else
rethrow(err)
end
end
end))
result.H = (θ₀ isa Number) ? mean(first.(result.Hs)) : mean(result.Hs)
result.time += now() - t₀
finalize_result!(result, prob)
end
function get_J!(
result :: MuseResult,
prob :: AbstractMuseProblem,
θ₀ = nothing;
∇z_logLike_atol = 1e-1,
rng = Random.default_rng(),
nsims = 100,
pmap = _map,
batch_size = 1,
progress = false,
skip_errors = false,
covariance_method = LinearShrinkage(target=DiagonalCommonVariance(), shrinkage=:rblw),
)
θ₀ = standardizeθ(prob, @something(θ₀, result.θ))
nsims_remaining = nsims - length(result.gs)
if nsims_remaining > 0
pbar = progress ? RemoteProgress(nsims_remaining÷batch_size, 0.1, "get_J: ") : nothing
(xs, zs) = map(Base.vect, map(1:nsims_remaining) do i
sample_x_z(prob, rng, θ₀)
end...)
append!(result.gs, skipmissing(pmap(xs, zs, fill(θ₀,length(xs)); batch_size) do x, z, θ₀
try
ẑ, = ẑ_at_θ(prob, x, z, θ₀; ∇z_logLike_atol)
g = ∇θ_logLike(prob, x, ẑ, θ₀)
progress && ProgressMeter.next!(pbar)
return g
catch err
if skip_errors && !(err isa InterruptException)
@warn err
return missing
else
rethrow(err)
end
end
end))
end
result.J = (θ₀ isa Number) ? var(result.gs) : cov(covariance_method, identity.(result.gs))
finalize_result!(result, prob)
end
function finalize_result!(result::MuseResult, prob::AbstractMuseProblem)
@unpack H, J = result
if H != nothing && J != nothing
H_prior = -AD.hessian(AD.ForwardDiffBackend(), θ -> logPriorθ(prob, θ), result.θ)[1]
result.Σ⁻¹ = H' * inv(J) * H + H_prior
result.Σ = inv(result.Σ⁻¹)
if length(result.θ) == 1
result.dist = Normal(result.θ[1], sqrt(result.Σ[1]))
else
result.dist = MvNormal(result.θ, result.Σ)
end
end
result
end
| [
198,
21017,
42044,
337,
19108,
2438,
198,
198,
397,
8709,
2099,
27741,
44,
1904,
40781,
886,
628,
198,
2235,
7071,
284,
307,
9177,
416,
2176,
1917,
3858,
198,
198,
8818,
18872,
229,
138,
116,
62,
6404,
7594,
886,
198,
8818,
2604,
7594,
62,
392,
62,
24861,
229,
89,
62,
6404,
7594,
886,
198,
8818,
6291,
62,
87,
62,
89,
886,
198,
6404,
22442,
138,
116,
7,
1676,
65,
3712,
23839,
44,
1904,
40781,
11,
7377,
116,
8,
796,
657,
198,
20307,
1096,
138,
116,
7,
1676,
65,
3712,
23839,
44,
1904,
40781,
11,
7377,
116,
8,
796,
7377,
116,
628,
198,
2,
428,
460,
635,
307,
625,
6058,
268,
416,
2176,
2761,
198,
2,
262,
4277,
857,
22199,
37,
14313,
1262,
262,
2810,
2604,
7594,
62,
392,
62,
24861,
229,
89,
62,
6404,
7594,
198,
8818,
1976,
136,
224,
62,
265,
62,
138,
116,
7,
1676,
65,
3712,
23839,
44,
1904,
40781,
11,
2124,
11,
1976,
158,
224,
222,
11,
7377,
116,
26,
18872,
229,
89,
62,
6404,
7594,
62,
265,
349,
8,
198,
220,
220,
220,
1540,
77,
796,
27183,
7,
27871,
320,
13,
8807,
62,
40616,
7,
89,
4613,
764,
12,
6404,
7594,
62,
392,
62,
24861,
229,
89,
62,
6404,
7594,
7,
1676,
65,
11,
2124,
11,
1976,
11,
7377,
116,
36911,
1976,
158,
224,
222,
11,
30011,
13,
43,
29499,
14313,
22784,
30011,
13,
29046,
7,
70,
62,
83,
349,
28,
24861,
229,
89,
62,
6404,
7594,
62,
265,
349,
4008,
198,
220,
220,
220,
1540,
77,
13,
1084,
320,
7509,
11,
1540,
77,
198,
437,
628,
198,
21017,
337,
19108,
1255,
198,
198,
31,
15390,
2205,
37811,
198,
198,
1273,
2850,
262,
1255,
286,
257,
337,
19108,
1057,
13,
1680,
307,
12006,
416,
12,
4993,
355,
198,
63,
44,
1904,
23004,
3419,
63,
290,
3804,
284,
597,
286,
262,
287,
5372,
4600,
76,
1904,
0,
47671,
4600,
1136,
62,
41,
0,
47671,
393,
198,
63,
1136,
62,
39,
0,
44646,
198,
198,
15878,
82,
25,
198,
198,
9,
4600,
138,
116,
63,
851,
383,
8636,
286,
262,
39280,
1169,
8326,
3,
10007,
13,
220,
198,
9,
4600,
138,
96,
11,
7377,
96,
46256,
119,
126,
117,
63,
851,
383,
27665,
44829,
590,
286,
39280,
1169,
8326,
3,
290,
663,
34062,
13,
220,
198,
9,
4600,
39,
11,
449,
63,
851,
383,
720,
39,
3,
290,
720,
41,
3,
2603,
45977,
543,
1296,
262,
44829,
590,
357,
3826,
198,
220,
685,
44,
8270,
64,
1222,
15300,
73,
461,
11,
33448,
16151,
5450,
1378,
283,
87,
452,
13,
2398,
14,
8937,
14,
2481,
1065,
13,
2931,
32182,
4008,
198,
9,
4600,
14542,
63,
851,
383,
34645,
31312,
985,
82,
973,
284,
24061,
4600,
41,
44646,
198,
9,
4600,
39,
82,
63,
851,
383,
474,
330,
672,
666,
985,
82,
973,
284,
24061,
4600,
39,
44646,
220,
198,
9,
4600,
17080,
63,
851,
317,
4600,
26447,
63,
393,
4600,
44,
85,
26447,
63,
3170,
422,
4600,
138,
116,
63,
290,
4600,
138,
96,
47671,
329,
198,
220,
15607,
13,
220,
198,
9,
4600,
23569,
63,
851,
18628,
23584,
7508,
422,
262,
1057,
13,
220,
198,
9,
4600,
81,
782,
63,
851,
371,
10503,
973,
284,
7716,
985,
82,
329,
428,
1057,
357,
568,
262,
976,
985,
82,
460,
198,
220,
307,
46823,
611,
581,
12595,
1568,
737,
198,
9,
4600,
2435,
63,
851,
7472,
4600,
22603,
27866,
623,
63,
3355,
12,
2435,
3377,
14492,
262,
1255,
13,
198,
198,
37811,
198,
14881,
13,
31,
46265,
4299,
4517,
540,
2878,
32887,
23004,
198,
220,
220,
220,
7377,
116,
796,
2147,
198,
220,
220,
220,
367,
796,
2147,
198,
220,
220,
220,
449,
796,
2147,
198,
220,
220,
220,
7377,
96,
46256,
119,
126,
117,
796,
2147,
198,
220,
220,
220,
7377,
96,
796,
2147,
198,
220,
220,
220,
1233,
796,
2147,
198,
220,
220,
220,
2106,
796,
17635,
198,
220,
220,
220,
308,
82,
796,
17635,
198,
220,
220,
220,
367,
82,
796,
17635,
198,
220,
220,
220,
374,
782,
796,
2147,
198,
220,
220,
220,
640,
796,
9212,
27866,
623,
7,
15,
8,
198,
437,
628,
198,
21017,
337,
19108,
1540,
332,
198,
198,
31,
15390,
2205,
37811,
628,
220,
220,
220,
26817,
7,
1676,
65,
3712,
23839,
44,
1904,
40781,
11,
7377,
116,
158,
224,
222,
26,
479,
86,
22046,
23029,
198,
220,
220,
220,
26817,
0,
7,
20274,
3712,
44,
1904,
23004,
11,
1861,
3712,
23839,
44,
1904,
40781,
11,
685,
138,
116,
158,
224,
222,
28,
22366,
11208,
479,
86,
22046,
23029,
198,
198,
10987,
262,
337,
19108,
8636,
13,
383,
4600,
76,
1904,
0,
63,
1296,
42626,
281,
4683,
1255,
13,
1002,
262,
220,
198,
63,
76,
1904,
63,
1296,
318,
973,
2427,
11,
4600,
138,
116,
158,
224,
222,
63,
1276,
1577,
257,
3599,
4724,
329,
39280,
1169,
8326,
35307,
198,
198,
6214,
685,
63,
44,
1904,
23004,
63,
16151,
31,
5420,
8,
329,
6764,
286,
1441,
1988,
13,
220,
198,
198,
30719,
21179,
7159,
25,
198,
198,
9,
4600,
81,
782,
63,
851,
14534,
1271,
17301,
284,
779,
13,
30222,
422,
4600,
20274,
13,
81,
782,
63,
393,
4600,
29531,
13,
12286,
62,
81,
782,
3419,
63,
611,
407,
3804,
13,
220,
198,
9,
4600,
89,
158,
224,
222,
63,
851,
17962,
4724,
329,
262,
41270,
2272,
34645,
13,
198,
9,
4600,
9806,
20214,
796,
2026,
63,
851,
22246,
1271,
286,
34820,
13,
220,
198,
9,
4600,
138,
116,
62,
17034,
349,
796,
352,
68,
12,
16,
63,
851,
13047,
15621,
319,
39280,
1169,
8326,
3,
3585,
284,
663,
3210,
28833,
13,
198,
9,
4600,
24861,
229,
89,
62,
6404,
7594,
62,
265,
349,
796,
352,
68,
12,
17,
63,
851,
36532,
15621,
319,
262,
720,
89,
3,
12,
49607,
379,
262,
34645,
4610,
13,
220,
198,
9,
4600,
5907,
12078,
796,
1802,
63,
851,
7913,
286,
27785,
13,
220,
198,
9,
4600,
17394,
796,
657,
13,
22,
63,
851,
5012,
2546,
329,
6808,
12,
22805,
13,
220,
198,
9,
4600,
33723,
796,
3991,
63,
851,
5438,
4371,
2318,
13,
198,
9,
4600,
4426,
499,
63,
851,
42945,
3975,
2163,
13,
220,
198,
9,
4600,
16338,
1096,
796,
5369,
63,
851,
27967,
617,
3218,
1634,
706,
1123,
2239,
13,
220,
198,
9,
4600,
39,
46256,
119,
126,
117,
62,
2339,
796,
2147,
63,
851,
20768,
4724,
329,
262,
34062,
12806,
666,
286,
720,
82,
61,
31478,
26224,
337,
19108,
92,
38016,
1169,
8326,
8,
3,
198,
9,
4600,
39,
46256,
119,
126,
117,
62,
19119,
63,
851,
1374,
284,
4296,
4600,
39,
46256,
119,
126,
117,
62,
2339,
44646,
10358,
307,
4600,
25,
82,
12078,
47671,
4600,
25,
65,
3287,
6559,
47671,
393,
4600,
25,
10989,
27923,
62,
65,
3287,
6559,
44646,
220,
198,
9,
4600,
65,
3287,
6559,
62,
31673,
796,
4806,
63,
851,
1374,
867,
1613,
4831,
284,
1394,
329,
2806,
43955,
5992,
13,
220,
198,
9,
4600,
9122,
4122,
62,
34345,
796,
2147,
63,
851,
12793,
1255,
284,
257,
2393,
706,
1123,
24415,
13,
220,
198,
9,
4600,
1136,
62,
66,
709,
2743,
590,
796,
3991,
63,
851,
4418,
869,
4600,
1136,
62,
39,
63,
290,
4600,
1136,
62,
41,
63,
284,
651,
262,
1336,
44829,
590,
13,
198,
198,
37811,
198,
76,
1904,
7,
22046,
986,
26,
479,
86,
22046,
23029,
796,
26817,
0,
7,
44,
1904,
23004,
22784,
26498,
986,
26,
479,
86,
22046,
23029,
198,
198,
8818,
26817,
0,
7,
198,
220,
220,
220,
1255,
7904,
32887,
23004,
11,
198,
220,
220,
220,
1861,
7904,
27741,
44,
1904,
40781,
11,
220,
198,
220,
220,
220,
7377,
116,
158,
224,
222,
796,
2147,
26,
198,
220,
220,
220,
374,
782,
796,
2147,
11,
198,
220,
220,
220,
1976,
158,
224,
222,
796,
2147,
11,
198,
220,
220,
220,
3509,
20214,
796,
2026,
11,
198,
220,
220,
220,
7377,
116,
62,
17034,
349,
796,
352,
68,
12,
16,
11,
198,
220,
220,
220,
18872,
229,
89,
62,
6404,
7594,
62,
265,
349,
796,
352,
68,
12,
17,
11,
198,
220,
220,
220,
36545,
12078,
796,
1802,
11,
198,
220,
220,
220,
26367,
796,
657,
13,
22,
11,
198,
220,
220,
220,
4371,
796,
3991,
11,
198,
220,
220,
220,
279,
8899,
796,
4808,
8899,
11,
198,
220,
220,
220,
15458,
62,
7857,
796,
352,
11,
198,
220,
220,
220,
3218,
1096,
796,
5369,
11,
198,
220,
220,
220,
367,
46256,
119,
126,
117,
62,
2339,
796,
2147,
11,
198,
220,
220,
220,
367,
46256,
119,
126,
117,
62,
19119,
796,
1058,
82,
12078,
11,
198,
220,
220,
220,
1379,
43955,
62,
31673,
796,
4806,
11,
198,
220,
220,
220,
26954,
62,
34345,
796,
2147,
11,
198,
220,
220,
220,
651,
62,
66,
709,
2743,
590,
796,
3991,
198,
8,
628,
220,
220,
220,
374,
782,
796,
2488,
18927,
7,
81,
782,
11,
1255,
13,
81,
782,
11,
4866,
7,
29531,
13,
12286,
62,
81,
782,
3419,
4008,
198,
220,
220,
220,
7377,
116,
403,
2301,
796,
7377,
116,
796,
7377,
116,
158,
224,
222,
796,
3210,
1096,
138,
116,
7,
1676,
65,
11,
2488,
18927,
7,
20274,
13,
138,
116,
11,
7377,
116,
158,
224,
222,
4008,
198,
220,
220,
220,
1976,
158,
224,
222,
796,
2488,
18927,
7,
89,
158,
224,
222,
11,
6291,
62,
87,
62,
89,
7,
1676,
65,
11,
4866,
7,
81,
782,
828,
7377,
116,
158,
224,
222,
737,
89,
8,
198,
220,
220,
220,
1957,
367,
46256,
119,
126,
117,
62,
7353,
11,
308,
62,
2339,
62,
82,
12078,
198,
220,
220,
220,
2106,
796,
1255,
13,
23569,
198,
220,
220,
220,
220,
198,
220,
220,
220,
1255,
13,
81,
782,
796,
4808,
81,
782,
796,
4866,
7,
81,
782,
8,
198,
220,
220,
220,
2124,
89,
62,
82,
12078,
796,
685,
39873,
62,
87,
62,
89,
7,
1676,
65,
11,
4808,
81,
782,
11,
7377,
116,
8,
329,
1312,
28,
16,
25,
5907,
12078,
60,
198,
220,
220,
220,
2124,
82,
796,
16410,
1676,
65,
13,
87,
11208,
220,
651,
9630,
12195,
87,
89,
62,
82,
12078,
11,
1058,
87,
15437,
198,
220,
220,
220,
1976,
136,
224,
82,
796,
16410,
89,
158,
224,
222,
11208,
220,
220,
220,
220,
220,
651,
9630,
12195,
87,
89,
62,
82,
12078,
11,
1058,
89,
15437,
628,
220,
220,
220,
1303,
900,
510,
4371,
2318,
198,
220,
220,
220,
279,
5657,
796,
4371,
5633,
21520,
32577,
19510,
9806,
20214,
12,
13664,
7,
20274,
13,
23569,
4008,
9,
7,
5907,
12078,
10,
16,
8,
127,
115,
43501,
62,
7857,
11,
657,
13,
16,
11,
366,
44,
19108,
25,
366,
8,
1058,
2147,
628,
220,
220,
220,
1949,
198,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
796,
357,
13664,
7,
20274,
13,
23569,
47762,
16,
2599,
9806,
20214,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
256,
158,
224,
222,
796,
783,
3419,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
1312,
1875,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4808,
81,
782,
796,
4866,
7,
81,
782,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
82,
796,
16410,
1676,
65,
13,
87,
11208,
685,
39873,
62,
87,
62,
89,
7,
1676,
65,
11,
4808,
81,
782,
11,
7377,
116,
737,
87,
329,
1312,
28,
16,
25,
5907,
12078,
11907,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
1312,
1875,
362,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
37455,
138,
116,
796,
2106,
58,
437,
4083,
138,
116,
532,
2106,
58,
437,
12,
16,
4083,
138,
116,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2593,
7,
138,
242,
138,
116,
24457,
7377,
116,
8,
1279,
7377,
116,
62,
17034,
349,
11405,
2270,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
337,
19108,
31312,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
308,
89,
136,
224,
82,
796,
279,
8899,
7,
34223,
11,
1976,
136,
224,
82,
11,
6070,
7,
138,
116,
11,
13664,
7,
34223,
18125,
15458,
62,
7857,
8,
466,
2124,
11,
1976,
136,
224,
62,
47050,
11,
7377,
116,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1957,
1976,
136,
224,
11,
2106,
796,
1976,
136,
224,
62,
265,
62,
138,
116,
7,
1676,
65,
11,
2124,
11,
1976,
136,
224,
62,
47050,
11,
7377,
116,
26,
18872,
229,
89,
62,
6404,
7594,
62,
265,
349,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
308,
796,
18872,
229,
138,
116,
62,
6404,
7594,
7,
1676,
65,
11,
2124,
11,
1976,
136,
224,
11,
7377,
116,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4371,
11405,
18387,
44,
2357,
13,
19545,
0,
7,
79,
5657,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
26,
70,
11,
1976,
136,
224,
11,
2106,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
136,
224,
82,
796,
651,
9630,
12195,
34586,
136,
224,
82,
11,
1058,
89,
136,
224,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
136,
224,
62,
23569,
62,
19608,
11,
1976,
136,
224,
62,
23569,
62,
82,
12078,
796,
31738,
7,
1136,
9630,
12195,
34586,
136,
224,
82,
11,
1058,
23569,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
308,
62,
2339,
62,
19608,
11,
308,
62,
2339,
62,
82,
12078,
796,
31738,
7,
1136,
9630,
12195,
34586,
136,
224,
82,
11,
1058,
70,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
308,
62,
2339,
796,
308,
62,
2339,
62,
19608,
764,
12,
1612,
7,
70,
62,
2339,
62,
82,
12078,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
308,
62,
3448,
273,
796,
5984,
13,
49607,
7,
2885,
13,
39746,
28813,
7282,
437,
22784,
7377,
116,
4613,
2604,
22442,
138,
116,
7,
1676,
65,
11,
7377,
116,
828,
7377,
116,
38381,
16,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
308,
62,
7353,
796,
308,
62,
2339,
764,
10,
308,
62,
3448,
273,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
12806,
666,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
289,
46256,
119,
126,
117,
62,
2339,
62,
82,
12078,
796,
532,
16,
24457,
1401,
7,
33327,
7,
70,
62,
2339,
62,
82,
12078,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
367,
46256,
119,
126,
117,
62,
2339,
62,
82,
12078,
796,
289,
46256,
119,
126,
117,
62,
2339,
62,
82,
12078,
318,
64,
7913,
5633,
289,
46256,
119,
126,
117,
62,
2339,
62,
82,
12078,
1058,
6031,
27923,
7,
71,
46256,
119,
126,
117,
62,
2339,
62,
82,
12078,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
357,
39,
46256,
119,
126,
117,
62,
2339,
6624,
2147,
8,
8614,
357,
39,
46256,
119,
126,
117,
62,
19119,
6624,
1058,
82,
12078,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
367,
46256,
119,
126,
117,
62,
2339,
796,
367,
46256,
119,
126,
117,
62,
2339,
62,
82,
12078,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
361,
1312,
1875,
362,
11405,
357,
39,
46256,
119,
126,
117,
62,
19119,
287,
685,
25,
65,
3287,
6559,
11,
1058,
10989,
27923,
62,
65,
3287,
6559,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
319,
8840,
4831,
11,
466,
257,
2806,
43955,
338,
4296,
1262,
379,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
749,
262,
2180,
4600,
65,
3287,
6559,
62,
31673,
63,
4831,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
474,
158,
224,
222,
796,
2558,
7,
9806,
7,
17,
11,
1312,
532,
1379,
43955,
62,
31673,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
367,
46256,
119,
126,
117,
62,
2339,
796,
2106,
58,
73,
158,
224,
222,
12,
16,
4083,
39,
46256,
119,
126,
117,
62,
2339,
62,
82,
12078,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
474,
796,
474,
158,
224,
222,
25,
72,
12,
16,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
37455,
138,
116,
220,
220,
220,
220,
220,
796,
2106,
58,
73,
4083,
138,
116,
220,
220,
220,
220,
220,
532,
2106,
58,
73,
12,
16,
4083,
138,
116,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
37455,
70,
62,
2339,
796,
2106,
58,
73,
4083,
70,
62,
2339,
532,
2106,
58,
73,
12,
16,
4083,
70,
62,
2339,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
367,
46256,
119,
126,
117,
62,
2339,
796,
367,
46256,
119,
126,
117,
62,
2339,
1343,
14808,
138,
242,
138,
116,
532,
367,
46256,
119,
126,
117,
62,
2339,
1635,
37455,
70,
62,
2339,
8,
1220,
357,
138,
242,
138,
116,
6,
1635,
367,
46256,
119,
126,
117,
62,
2339,
1635,
37455,
70,
62,
2339,
4008,
1635,
37455,
138,
116,
6,
1635,
367,
46256,
119,
126,
117,
62,
2339,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
367,
46256,
119,
126,
117,
62,
19119,
6624,
1058,
10989,
27923,
62,
65,
3287,
6559,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
367,
46256,
119,
126,
117,
62,
2339,
796,
6031,
27923,
7,
39,
46256,
119,
126,
117,
62,
2339,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
367,
62,
3448,
273,
796,
5984,
13,
33979,
666,
7,
2885,
13,
39746,
28813,
7282,
437,
22784,
7377,
116,
4613,
2604,
22442,
138,
116,
7,
1676,
65,
11,
7377,
116,
828,
7377,
116,
38381,
16,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
367,
46256,
119,
126,
117,
62,
7353,
796,
800,
7,
16340,
7,
39,
46256,
119,
126,
117,
62,
2339,
8,
1343,
367,
62,
3448,
273,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
256,
796,
783,
3419,
532,
256,
158,
224,
222,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4574,
0,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2106,
11,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
26,
138,
116,
11,
7377,
116,
403,
2301,
11,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
308,
62,
2339,
62,
19608,
11,
308,
62,
2339,
62,
82,
12078,
11,
308,
62,
2339,
11,
308,
62,
3448,
273,
11,
308,
62,
7353,
11,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
367,
46256,
119,
126,
117,
62,
7353,
11,
367,
62,
3448,
273,
11,
367,
46256,
119,
126,
117,
62,
2339,
11,
367,
46256,
119,
126,
117,
62,
2339,
62,
82,
12078,
11,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
136,
224,
62,
23569,
62,
19608,
11,
1976,
136,
224,
62,
23569,
62,
82,
12078,
11,
256,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1267,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
17321,
12,
38576,
499,
1559,
2239,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
7377,
116,
403,
2301,
796,
7377,
116,
764,
12,
26367,
764,
9,
357,
39,
46256,
119,
126,
117,
62,
7353,
1635,
308,
62,
7353,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
7377,
116,
796,
3218,
1096,
7,
138,
116,
403,
2301,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
9122,
4122,
62,
34345,
14512,
2147,
8,
11405,
3613,
7,
9122,
4122,
62,
34345,
11,
366,
20274,
1600,
1255,
8,
628,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
3443,
628,
220,
220,
220,
220,
220,
220,
220,
4371,
11405,
18387,
44,
2357,
13,
15643,
680,
0,
7,
79,
5657,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
886,
198,
220,
220,
220,
220,
198,
220,
220,
220,
1255,
13,
2435,
15853,
2160,
7,
1136,
9630,
12195,
23569,
11,
25,
83,
4008,
198,
220,
220,
220,
1255,
13,
138,
116,
796,
7377,
116,
403,
2301,
198,
220,
220,
220,
1255,
13,
14542,
796,
2824,
7,
70,
62,
2339,
62,
82,
12078,
8,
198,
220,
220,
220,
611,
651,
62,
66,
709,
2743,
590,
198,
220,
220,
220,
220,
220,
220,
220,
651,
62,
41,
0,
7,
20274,
11,
1861,
8,
198,
220,
220,
220,
220,
220,
220,
220,
651,
62,
39,
0,
7,
20274,
11,
1861,
8,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1255,
198,
198,
437,
628,
198,
198,
8818,
651,
62,
39,
0,
7,
198,
220,
220,
220,
1255,
7904,
32887,
23004,
11,
198,
220,
220,
220,
1861,
7904,
27741,
44,
1904,
40781,
11,
220,
198,
220,
220,
220,
7377,
116,
158,
224,
222,
796,
1255,
13,
138,
116,
26,
198,
220,
220,
220,
277,
36020,
7904,
4463,
578,
28813,
1945,
17410,
796,
4318,
62,
16344,
76,
7,
18,
11,
16,
828,
198,
220,
220,
220,
18872,
229,
89,
62,
6404,
7594,
62,
265,
349,
796,
352,
68,
12,
23,
11,
198,
220,
220,
220,
374,
782,
796,
14534,
13,
12286,
62,
81,
782,
22784,
198,
220,
220,
220,
36545,
12078,
796,
838,
11,
220,
198,
220,
220,
220,
2239,
796,
2147,
11,
220,
198,
220,
220,
220,
279,
8899,
796,
4808,
8899,
11,
198,
220,
220,
220,
15458,
62,
7857,
796,
352,
11,
198,
220,
220,
220,
279,
8899,
62,
2502,
796,
1058,
23736,
11,
198,
220,
220,
220,
4371,
796,
3991,
11,
198,
220,
220,
220,
14267,
62,
48277,
796,
3991,
11,
198,
8,
628,
220,
220,
220,
7377,
116,
158,
224,
222,
796,
3210,
1096,
138,
116,
7,
1676,
65,
11,
2488,
18927,
7,
138,
116,
158,
224,
222,
11,
1255,
13,
138,
116,
4008,
198,
220,
220,
220,
36545,
12078,
62,
2787,
1397,
796,
36545,
12078,
532,
4129,
7,
20274,
13,
39,
82,
8,
198,
220,
220,
220,
357,
5907,
12078,
62,
2787,
1397,
19841,
657,
8,
11405,
1441,
198,
220,
220,
220,
279,
5657,
796,
4371,
5633,
21520,
32577,
7,
5907,
12078,
62,
2787,
1397,
9,
7,
16,
10,
13664,
7,
138,
116,
158,
224,
222,
4008,
127,
115,
43501,
62,
7857,
11,
657,
13,
16,
11,
366,
1136,
62,
39,
25,
366,
8,
1058,
2147,
198,
220,
220,
220,
256,
158,
224,
222,
796,
783,
3419,
628,
220,
220,
220,
1303,
7716,
18640,
15726,
11,
19988,
374,
782,
11,
290,
8914,
374,
782,
1181,
284,
307,
46823,
19863,
198,
220,
220,
220,
2124,
82,
62,
89,
82,
62,
81,
782,
82,
796,
3975,
7,
16,
25,
5907,
12078,
62,
2787,
1397,
8,
466,
1312,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
81,
782,
796,
4866,
7,
81,
782,
8,
198,
220,
220,
220,
220,
220,
220,
220,
357,
87,
11,
1976,
8,
796,
6291,
62,
87,
62,
89,
7,
1676,
65,
11,
374,
782,
11,
7377,
116,
158,
224,
222,
8,
198,
220,
220,
220,
220,
220,
220,
220,
357,
87,
11,
1976,
11,
4808,
81,
782,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
4238,
4197,
379,
49909,
1229,
498,
11,
973,
379,
3599,
2173,
329,
27454,
3580,
2174,
198,
220,
220,
220,
1976,
136,
224,
158,
224,
222,
82,
62,
81,
782,
82,
796,
279,
8899,
7,
34223,
62,
89,
82,
62,
81,
782,
82,
26,
15458,
62,
7857,
8,
466,
357,
87,
11,
1976,
11,
374,
782,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1976,
136,
224,
11,
796,
1976,
136,
224,
62,
265,
62,
138,
116,
7,
1676,
65,
11,
2124,
11,
1976,
11,
7377,
116,
158,
224,
222,
26,
18872,
229,
89,
62,
6404,
7594,
62,
265,
349,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4371,
11405,
18387,
44,
2357,
13,
19545,
0,
7,
79,
5657,
8,
198,
220,
220,
220,
220,
220,
220,
220,
357,
89,
136,
224,
11,
374,
782,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
27454,
3580,
12806,
666,
198,
220,
220,
220,
279,
8899,
62,
82,
12078,
11,
279,
8899,
62,
30482,
796,
357,
4426,
499,
62,
2502,
6624,
1058,
30482,
8614,
357,
4426,
499,
62,
2502,
6624,
1058,
23736,
11405,
4129,
7,
138,
116,
158,
224,
222,
8,
1875,
36545,
12078,
62,
2787,
1397,
4008,
5633,
44104,
8899,
11,
279,
8899,
8,
1058,
357,
4426,
499,
11,
4808,
8899,
8,
198,
220,
220,
220,
24443,
0,
7,
20274,
13,
39,
82,
11,
14267,
45688,
7,
4426,
499,
62,
82,
12078,
7,
89,
136,
224,
158,
224,
222,
82,
62,
81,
782,
82,
26,
15458,
62,
7857,
8,
466,
357,
89,
136,
224,
158,
224,
222,
11,
374,
782,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1949,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
717,
7,
79,
30482,
672,
666,
7,
16344,
76,
11,
7377,
116,
158,
224,
222,
11,
2239,
26,
279,
8899,
28,
4426,
499,
62,
30482,
11,
15458,
62,
7857,
11,
279,
5657,
8,
466,
7377,
116,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
11,
796,
6291,
62,
87,
62,
89,
7,
1676,
65,
11,
4866,
7,
81,
782,
828,
7377,
116,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
136,
224,
11,
796,
1976,
136,
224,
62,
265,
62,
138,
116,
7,
1676,
65,
11,
2124,
11,
1976,
136,
224,
158,
224,
222,
11,
7377,
116,
158,
224,
222,
26,
18872,
229,
89,
62,
6404,
7594,
62,
265,
349,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
18872,
229,
138,
116,
62,
6404,
7594,
7,
1676,
65,
11,
2124,
11,
1976,
136,
224,
11,
7377,
116,
158,
224,
222,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4929,
11454,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
14267,
62,
48277,
11405,
5145,
7,
8056,
318,
64,
4225,
3622,
16922,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
40539,
11454,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
4814,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
302,
16939,
7,
8056,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
4008,
198,
220,
198,
220,
220,
220,
1255,
13,
39,
796,
357,
138,
116,
158,
224,
222,
318,
64,
7913,
8,
5633,
1612,
7,
11085,
12195,
20274,
13,
39,
82,
4008,
1058,
220,
1612,
7,
20274,
13,
39,
82,
8,
198,
220,
220,
220,
1255,
13,
2435,
15853,
783,
3419,
532,
256,
158,
224,
222,
198,
220,
220,
220,
2457,
1096,
62,
20274,
0,
7,
20274,
11,
1861,
8,
198,
198,
437,
628,
198,
8818,
651,
62,
41,
0,
7,
198,
220,
220,
220,
1255,
7904,
32887,
23004,
11,
198,
220,
220,
220,
1861,
7904,
27741,
44,
1904,
40781,
11,
220,
198,
220,
220,
220,
7377,
116,
158,
224,
222,
796,
2147,
26,
220,
198,
220,
220,
220,
18872,
229,
89,
62,
6404,
7594,
62,
265,
349,
796,
352,
68,
12,
16,
11,
198,
220,
220,
220,
374,
782,
796,
14534,
13,
12286,
62,
81,
782,
22784,
198,
220,
220,
220,
36545,
12078,
796,
1802,
11,
220,
198,
220,
220,
220,
279,
8899,
796,
4808,
8899,
11,
198,
220,
220,
220,
15458,
62,
7857,
796,
352,
11,
198,
220,
220,
220,
4371,
796,
3991,
11,
220,
198,
220,
220,
220,
14267,
62,
48277,
796,
3991,
11,
198,
220,
220,
220,
44829,
590,
62,
24396,
796,
44800,
2484,
81,
676,
496,
7,
16793,
28,
18683,
27923,
17227,
23907,
590,
22784,
22085,
496,
28,
25,
81,
2436,
86,
828,
198,
8,
628,
220,
220,
220,
7377,
116,
158,
224,
222,
796,
3210,
1096,
138,
116,
7,
1676,
65,
11,
2488,
18927,
7,
138,
116,
158,
224,
222,
11,
1255,
13,
138,
116,
4008,
198,
220,
220,
220,
36545,
12078,
62,
2787,
1397,
796,
36545,
12078,
532,
4129,
7,
20274,
13,
14542,
8,
628,
220,
220,
220,
611,
36545,
12078,
62,
2787,
1397,
1875,
657,
628,
220,
220,
220,
220,
220,
220,
220,
279,
5657,
796,
4371,
5633,
21520,
32577,
7,
5907,
12078,
62,
2787,
1397,
127,
115,
43501,
62,
7857,
11,
657,
13,
16,
11,
366,
1136,
62,
41,
25,
366,
8,
1058,
2147,
628,
220,
220,
220,
220,
220,
220,
220,
357,
34223,
11,
1976,
82,
8,
796,
3975,
7,
14881,
13,
303,
310,
11,
3975,
7,
16,
25,
5907,
12078,
62,
2787,
1397,
8,
466,
1312,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6291,
62,
87,
62,
89,
7,
1676,
65,
11,
374,
782,
11,
7377,
116,
158,
224,
222,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
23029,
628,
220,
220,
220,
220,
220,
220,
220,
24443,
0,
7,
20274,
13,
14542,
11,
14267,
45688,
7,
4426,
499,
7,
34223,
11,
1976,
82,
11,
6070,
7,
138,
116,
158,
224,
222,
11,
13664,
7,
34223,
18125,
15458,
62,
7857,
8,
466,
2124,
11,
1976,
11,
7377,
116,
158,
224,
222,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1949,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
136,
224,
11,
796,
1976,
136,
224,
62,
265,
62,
138,
116,
7,
1676,
65,
11,
2124,
11,
1976,
11,
7377,
116,
158,
224,
222,
26,
18872,
229,
89,
62,
6404,
7594,
62,
265,
349,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
308,
796,
18872,
229,
138,
116,
62,
6404,
7594,
7,
1676,
65,
11,
2124,
11,
1976,
136,
224,
11,
7377,
116,
158,
224,
222,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4371,
11405,
18387,
44,
2357,
13,
19545,
0,
7,
79,
5657,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
308,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4929,
11454,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
14267,
62,
48277,
11405,
5145,
7,
8056,
318,
64,
4225,
3622,
16922,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
40539,
11454,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
4814,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
302,
16939,
7,
8056,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
4008,
628,
220,
220,
220,
886,
628,
220,
220,
220,
1255,
13,
41,
796,
357,
138,
116,
158,
224,
222,
318,
64,
7913,
8,
5633,
1401,
7,
20274,
13,
14542,
8,
1058,
39849,
7,
66,
709,
2743,
590,
62,
24396,
11,
5369,
12195,
20274,
13,
14542,
4008,
198,
220,
220,
220,
2457,
1096,
62,
20274,
0,
7,
20274,
11,
1861,
8,
198,
198,
437,
628,
198,
8818,
2457,
1096,
62,
20274,
0,
7,
20274,
3712,
44,
1904,
23004,
11,
1861,
3712,
23839,
44,
1904,
40781,
8,
198,
220,
220,
220,
2488,
403,
8002,
367,
11,
449,
796,
1255,
198,
220,
220,
220,
611,
367,
14512,
2147,
11405,
449,
14512,
2147,
198,
220,
220,
220,
220,
220,
220,
220,
367,
62,
3448,
273,
796,
532,
2885,
13,
33979,
666,
7,
2885,
13,
39746,
28813,
7282,
437,
22784,
7377,
116,
4613,
2604,
22442,
138,
116,
7,
1676,
65,
11,
7377,
116,
828,
1255,
13,
138,
116,
38381,
16,
60,
198,
220,
220,
220,
220,
220,
220,
220,
1255,
13,
138,
96,
46256,
119,
126,
117,
796,
367,
6,
1635,
800,
7,
41,
8,
1635,
367,
1343,
367,
62,
3448,
273,
198,
220,
220,
220,
220,
220,
220,
220,
1255,
13,
138,
96,
796,
800,
7,
20274,
13,
138,
96,
46256,
119,
126,
117,
8,
198,
220,
220,
220,
220,
220,
220,
220,
611,
4129,
7,
20274,
13,
138,
116,
8,
6624,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1255,
13,
17080,
796,
14435,
7,
20274,
13,
138,
116,
58,
16,
4357,
19862,
17034,
7,
20274,
13,
138,
96,
58,
16,
60,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1255,
13,
17080,
796,
337,
85,
26447,
7,
20274,
13,
138,
116,
11,
1255,
13,
138,
96,
8,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1255,
198,
437,
198
] | 1.931469 | 5,866 |
using GeometricBase
using Test
dt = Float64
nt = 10
@testset "$(rpad("Dataseries 1d (scalar data)",80))" begin
nd = 1
ni = 1
ds = DataSeries(rand(dt), nt)
@test typeof(ds) == typeof(DataSeries{dt,1}(nt, ni))
@test typeof(ds) <: AbstractArray{dt,1}
@test firstindex(ds) == 0
@test firstindex(ds,1) == firstindex(ds.d,1) - 1
@test firstindex(ds,2) == 1
@test lastindex(ds) == nt
@test lastindex(ds,1) == lastindex(ds.d,1) - 1
@test lastindex(ds,2) == 1
@test strides(ds) == (1,)
@test stride(ds,1) == 1
@test axes(ds) == (0:nt,)
@test axes(ds,1) == 0:nt
@test axes(ds,2) == 1:1
@test size(ds.d) == (nt+1,)
@test size(ds.d) == size(ds)
@test size(ds.d,1) == nt+1
@test ndims(ds) == 1
@test eltype(ds) == dt
@test parent(ds) == ds.d
@test eachindex(ds) == 0:nt
@test eachindex(IndexLinear(), ds) == 0:nt
@test eachindex(IndexCartesian(), ds) == CartesianIndices((0:nt,))
for i in 0:nt
ds[i] = i
end
@test ds.d[1] == ds[0]
@test ds.d[end] == ds[nt]
@test ds.d[end] == ds[end]
@test ds.d == collect(0:nt)
@test parent(ds)[:] == parent(ds[:])
reset!(ds)
@test ds[0] == ds[end]
d = rand(nt+1)
ds = DataSeries(d)
@test ds.d == d
@test similar(ds).d == zero(d)
for i in 0:nt
set_data!(ds, dt(i), i)
end
@test ds.d == collect(0:nt)
end
@testset "$(rpad("Dataseries 1d (vector-valued data)",80))" begin
nd = 2
ni = 1
ds = DataSeries(rand(dt, nd), nt)
@test typeof(ds) == typeof(DataSeries{Vector{dt},1}(nt, ni))
@test typeof(ds) <: AbstractArray{Vector{dt},1}
@test firstindex(ds) == 0
@test firstindex(ds,1) == firstindex(ds.d,1) - 1
@test firstindex(ds,2) == 1
@test lastindex(ds) == nt
@test lastindex(ds,1) == lastindex(ds.d,1) - 1
@test lastindex(ds,2) == 1
@test strides(ds) == (1,)
@test stride(ds,1) == 1
@test axes(ds) == (0:nt,)
@test axes(ds,1) == 0:nt
@test axes(ds,2) == 1:1
@test size(ds.d) == (nt+1,)
@test size(ds.d) == size(ds)
@test size(ds.d,1) == nt+1
@test ndims(ds) == 1
@test eltype(ds) == Vector{dt}
@test parent(ds) == ds.d
@test eachindex(ds) == 0:nt
@test eachindex(IndexLinear(), ds) == 0:nt
@test eachindex(IndexCartesian(), ds) == CartesianIndices((0:nt,))
for i in 0:nt
ds[i] = [i, i^2]
end
@test ds.d[1] == ds[0]
@test ds.d[end] == ds[nt]
@test ds.d[end] == ds[end]
@test ds.d == [Vector{dt}([i, i^2]) for i in 0:nt]
@test parent(ds)[:] == parent(ds[:])
reset!(ds)
@test ds[0] == ds[end]
d = rand(nt+1)
ds = DataSeries(d)
@test ds.d == d
@test similar(ds).d == zero(d)
for i in 0:nt
set_data!(ds, dt(i), i)
end
@test ds.d == collect(0:nt)
end
@testset "$(rpad("Dataseries 2d (scalar data)",80))" begin
ni = 2
ds = DataSeries(rand(dt, ni), nt, ni)
@test typeof(ds) == typeof(DataSeries{dt,2}(nt, ni))
@test typeof(ds) <: AbstractArray{dt,2}
@test firstindex(ds) == firstindex(ds.d)
@test firstindex(ds,1) == firstindex(ds.d,1) - 1
@test firstindex(ds,2) == 1
@test lastindex(ds) == lastindex(ds.d)
@test lastindex(ds,1) == lastindex(ds.d,1) - 1
@test lastindex(ds,2) == lastindex(ds.d,2)
@test strides(ds) == (1,nt+1)
@test stride(ds,1) == 1
@test stride(ds,2) == nt+1
@test axes(ds) == (0:nt, 1:ni)
@test axes(ds,1) == 0:nt
@test axes(ds,2) == 1:2
@test size(ds.d) == (nt+1, ni)
@test size(ds.d) == size(ds)
@test size(ds.d,1) == nt+1
@test size(ds.d,2) == ni
@test ndims(ds) == 2
@test eltype(ds) == dt
@test parent(ds) == ds.d
for i in 0:nt
set_data!(ds, dt(i), i, 1)
set_data!(ds, dt(i)^2, i, 2)
end
@test ds.d[:,1] == collect(0:nt)
@test ds.d[:,2] == collect(0:nt) .^ 2
@test ds.d[1,1] == ds[0,1]
@test ds.d[1,1:ni] == ds[0,1:nsamples(ds)]
@test ds[end,1] == ds.d[end,1]
@test ds[end,1] == ds[nt,1]
@test ds[end,1:nsamples(ds)] == ds[nt,1:ni]
@test ds.d[1,:] == ds[0,:]
@test ds.d[:,1] == parent(ds[:,1])
@test ds.d[:,:] == parent(ds[:,:])
reset!(ds)
@test ds[0,1] == ds[end,1]
# tx = rand(nd)
# ds[:,0] .= tx
# @test ds.d[:,1] == tx
d = rand(nt+1,ni)
ds = DataSeries(d)
@test ds.d == d
@test similar(ds).d == zero(d)
end
@testset "$(rpad("Dataseries 2d (vector-valued data)",80))" begin
nd = 2
ni = 5
ds = DataSeries([rand(dt, nd) for i in 1:ni], nt)
@test typeof(ds) == typeof(DataSeries{Vector{dt},2}(nt, ni))
@test typeof(ds) <: AbstractArray{Vector{dt},2}
@test firstindex(ds) == firstindex(ds.d)
@test firstindex(ds,1) == firstindex(ds.d,1) - 1
@test firstindex(ds,2) == 1
@test lastindex(ds) == lastindex(ds.d)
@test lastindex(ds,1) == lastindex(ds.d,1) - 1
@test lastindex(ds,2) == lastindex(ds.d,2)
@test strides(ds) == (1,nt+1)
@test stride(ds,1) == 1
@test stride(ds,2) == nt+1
@test axes(ds) == (0:nt, 1:ni)
@test axes(ds,1) == 0:nt
@test axes(ds,2) == 1:ni
@test size(ds.d) == (nt+1, ni)
@test size(ds.d) == size(ds)
@test size(ds.d,1) == nt+1
@test size(ds.d,2) == ni
@test ndims(ds) == 2
@test eltype(ds) == Vector{dt}
@test parent(ds) == ds.d
for k in 1:ni
for i in 0:nt
ds[i,k][1] = k*i
ds[i,k][2] = k*i^2
end
end
tx = zeros(dt, nd)
for k in 1:ni
for i in 0:nt
get_data!(ds, tx, i, k)
@test tx == Array{eltype(tx)}(k .* [i, i^2])
end
end
@test ds.d[1,1] == ds[0,1]
@test ds.d[1,1:ni] == ds[0,1:nsamples(ds)]
@test ds[end,1] == ds.d[end,1]
@test ds[end,1] == ds[nt,1]
@test ds[end,1:nsamples(ds)] == ds[nt,1:ni]
@test ds.d[1,:] == ds[0,:]
@test ds.d[:,1] == parent(ds[:,1])
@test ds.d[:,:] == parent(ds[:,:])
reset!(ds)
@test ds[0,1] == ds[end,1]
# tx = rand(nd)
# ds[:,0] .= tx
# @test ds.d[:,1] == tx
d = rand(nt+1,ni)
ds = DataSeries(d)
@test ds.d == d
@test similar(ds).d == zero(d)
end
# TODO: Add tests for array-valued data
# @testset "$(rpad("Dataseries 3d",80))" begin
# nd = 2
# ni = 2
# ds = DataSeries(dt, nd, nt, ni)
# @test typeof(ds) <: AbstractArray{dt,3}
# @test firstindex(ds) == firstindex(ds.d)
# @test firstindex(ds,1) == firstindex(ds.d,1)
# @test firstindex(ds,2) == firstindex(ds.d,2) - 1
# @test firstindex(ds,3) == firstindex(ds.d,3)
# @test firstindex(ds,4) == 1
# @test lastindex(ds) == lastindex(ds.d)
# @test lastindex(ds,1) == lastindex(ds.d,1)
# @test lastindex(ds,2) == lastindex(ds.d,2) - 1
# @test lastindex(ds,3) == lastindex(ds.d,3)
# @test lastindex(ds,4) == 1
# @test strides(ds) == (1,nd,nd*(nt+1))
# @test stride(ds,1) == 1
# @test stride(ds,2) == nd
# @test axes(ds) == (1:nd, 0:nt, 1:ni)
# @test axes(ds,1) == 1:nd
# @test axes(ds,2) == 0:nt
# @test axes(ds,3) == 1:ni
# @test axes(ds,4) == 1:1
# @test size(ds.d) == (nd, nt+1, ni)
# @test size(ds.d) == size(ds)
# @test size(ds.d,1) == nd
# @test size(ds.d,2) == nt+1
# @test size(ds.d,3) == ni
# @test ndims(ds) == 3
# @test eltype(ds) == dt
# @test parent(ds) == ds.d
# for j in 1:ni
# for i in 1:nt
# ds[1,i,j] = j*i
# ds[2,i,j] = j*i^2
# end
# end
# tx = zeros(nd)
# ty = zeros(nd,ni)
# tz = zeros(nd,ni)
# for i in 1:nt
# for j in 1:ni
# get_data!(ds, tx, i, j)
# @test tx == Array{eltype(tx)}([j*i, j*i^2])
# tz[1,j] = j*i
# tz[2,j] = j*i^2
# end
# get_data!(ds, ty, i)
# @test ty == tz
# end
# @test ds.d[1,1,1] == ds[1,0,1]
# @test ds.d[1:ds.nd,1,1] == ds[1:ds.nd,0,1]
# @test ds[1,end,1] == ds.d[1,end,1]
# @test ds[1,nt,1] == ds[1,end,1]
# @test ds[1:ds.nd,nt,1] == ds[1:ds.nd,end,1]
# @test ds.d[:,1,1] == ds[:,0,1]
# @test ds.d[:,1,:] == ds[:,0,:]
# reset!(ds)
# @test ds[1,0,1] == ds[1,end,1]
# tx = rand(nd)
# ds[:,0,1] .= tx
# @test ds.d[:,1,1] == tx
# d = rand(nd,nt+1,ni)
# ds = DataSeries(d)
# @test ds.d == d
# @test similar(ds).d == zero(d)
# end
| [
198,
3500,
2269,
16996,
14881,
198,
3500,
6208,
628,
198,
28664,
796,
48436,
2414,
198,
429,
796,
838,
198,
198,
31,
9288,
2617,
17971,
7,
81,
15636,
7203,
27354,
6005,
444,
352,
67,
357,
1416,
282,
283,
1366,
42501,
1795,
4008,
1,
2221,
198,
220,
220,
220,
299,
67,
796,
352,
198,
220,
220,
220,
37628,
796,
352,
628,
220,
220,
220,
288,
82,
796,
6060,
27996,
7,
25192,
7,
28664,
828,
299,
83,
8,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
9310,
8,
6624,
2099,
1659,
7,
6601,
27996,
90,
28664,
11,
16,
92,
7,
429,
11,
37628,
4008,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
9310,
8,
1279,
25,
27741,
19182,
90,
28664,
11,
16,
92,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
8,
220,
220,
6624,
657,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
16,
8,
6624,
717,
9630,
7,
9310,
13,
67,
11,
16,
8,
532,
352,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
17,
8,
6624,
352,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
8,
220,
220,
220,
6624,
299,
83,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
16,
8,
220,
6624,
938,
9630,
7,
9310,
13,
67,
11,
16,
8,
532,
352,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
17,
8,
220,
6624,
352,
198,
220,
220,
220,
2488,
9288,
35002,
7,
9310,
8,
220,
220,
220,
220,
220,
6624,
357,
16,
35751,
198,
220,
220,
220,
2488,
9288,
33769,
7,
9310,
11,
16,
8,
220,
220,
220,
220,
6624,
352,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
8,
220,
220,
6624,
357,
15,
25,
429,
35751,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
16,
8,
6624,
657,
25,
429,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
17,
8,
6624,
352,
25,
16,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
8,
6624,
357,
429,
10,
16,
35751,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
8,
6624,
2546,
7,
9310,
8,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
11,
16,
8,
6624,
299,
83,
10,
16,
198,
220,
220,
220,
2488,
9288,
299,
67,
12078,
7,
9310,
8,
220,
6624,
352,
198,
220,
220,
220,
2488,
9288,
1288,
4906,
7,
9310,
8,
6624,
288,
83,
198,
220,
220,
220,
2488,
9288,
2560,
7,
9310,
8,
6624,
288,
82,
13,
67,
628,
220,
220,
220,
2488,
9288,
1123,
9630,
7,
9310,
8,
6624,
657,
25,
429,
198,
220,
220,
220,
2488,
9288,
1123,
9630,
7,
15732,
14993,
451,
22784,
288,
82,
8,
6624,
657,
25,
429,
198,
220,
220,
220,
2488,
9288,
1123,
9630,
7,
15732,
43476,
35610,
22784,
288,
82,
8,
6624,
13690,
35610,
5497,
1063,
19510,
15,
25,
429,
11,
4008,
628,
220,
220,
220,
329,
1312,
287,
657,
25,
429,
198,
220,
220,
220,
220,
220,
220,
220,
288,
82,
58,
72,
60,
796,
1312,
198,
220,
220,
220,
886,
628,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
16,
60,
6624,
288,
82,
58,
15,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
437,
60,
6624,
288,
82,
58,
429,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
437,
60,
6624,
288,
82,
58,
437,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
6624,
2824,
7,
15,
25,
429,
8,
198,
220,
220,
220,
2488,
9288,
2560,
7,
9310,
38381,
47715,
6624,
2560,
7,
9310,
58,
25,
12962,
628,
220,
220,
220,
13259,
0,
7,
9310,
8,
198,
220,
220,
220,
2488,
9288,
288,
82,
58,
15,
60,
6624,
288,
82,
58,
437,
60,
628,
220,
220,
220,
288,
796,
43720,
7,
429,
10,
16,
8,
198,
220,
220,
220,
288,
82,
796,
6060,
27996,
7,
67,
8,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
6624,
288,
628,
220,
220,
220,
2488,
9288,
2092,
7,
9310,
737,
67,
6624,
6632,
7,
67,
8,
628,
220,
220,
220,
329,
1312,
287,
657,
25,
429,
198,
220,
220,
220,
220,
220,
220,
220,
900,
62,
7890,
0,
7,
9310,
11,
288,
83,
7,
72,
828,
1312,
8,
198,
220,
220,
220,
886,
628,
220,
220,
2488,
9288,
288,
82,
13,
67,
6624,
2824,
7,
15,
25,
429,
8,
198,
437,
628,
198,
31,
9288,
2617,
17971,
7,
81,
15636,
7203,
27354,
6005,
444,
352,
67,
357,
31364,
12,
39728,
1366,
42501,
1795,
4008,
1,
2221,
198,
220,
220,
220,
299,
67,
796,
362,
198,
220,
220,
220,
37628,
796,
352,
628,
220,
220,
220,
288,
82,
796,
6060,
27996,
7,
25192,
7,
28664,
11,
299,
67,
828,
299,
83,
8,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
9310,
8,
6624,
2099,
1659,
7,
6601,
27996,
90,
38469,
90,
28664,
5512,
16,
92,
7,
429,
11,
37628,
4008,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
9310,
8,
1279,
25,
27741,
19182,
90,
38469,
90,
28664,
5512,
16,
92,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
8,
220,
220,
6624,
657,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
16,
8,
6624,
717,
9630,
7,
9310,
13,
67,
11,
16,
8,
532,
352,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
17,
8,
6624,
352,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
8,
220,
220,
220,
6624,
299,
83,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
16,
8,
220,
6624,
938,
9630,
7,
9310,
13,
67,
11,
16,
8,
532,
352,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
17,
8,
220,
6624,
352,
198,
220,
220,
220,
2488,
9288,
35002,
7,
9310,
8,
220,
220,
220,
220,
220,
6624,
357,
16,
35751,
198,
220,
220,
220,
2488,
9288,
33769,
7,
9310,
11,
16,
8,
220,
220,
220,
220,
6624,
352,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
8,
220,
220,
6624,
357,
15,
25,
429,
35751,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
16,
8,
6624,
657,
25,
429,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
17,
8,
6624,
352,
25,
16,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
8,
6624,
357,
429,
10,
16,
35751,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
8,
6624,
2546,
7,
9310,
8,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
11,
16,
8,
6624,
299,
83,
10,
16,
198,
220,
220,
220,
2488,
9288,
299,
67,
12078,
7,
9310,
8,
220,
6624,
352,
198,
220,
220,
220,
2488,
9288,
1288,
4906,
7,
9310,
8,
6624,
20650,
90,
28664,
92,
198,
220,
220,
220,
2488,
9288,
2560,
7,
9310,
8,
6624,
288,
82,
13,
67,
628,
220,
220,
220,
2488,
9288,
1123,
9630,
7,
9310,
8,
6624,
657,
25,
429,
198,
220,
220,
220,
2488,
9288,
1123,
9630,
7,
15732,
14993,
451,
22784,
288,
82,
8,
6624,
657,
25,
429,
198,
220,
220,
220,
2488,
9288,
1123,
9630,
7,
15732,
43476,
35610,
22784,
288,
82,
8,
6624,
13690,
35610,
5497,
1063,
19510,
15,
25,
429,
11,
4008,
628,
220,
220,
220,
329,
1312,
287,
657,
25,
429,
198,
220,
220,
220,
220,
220,
220,
220,
288,
82,
58,
72,
60,
796,
685,
72,
11,
1312,
61,
17,
60,
198,
220,
220,
220,
886,
628,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
16,
60,
6624,
288,
82,
58,
15,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
437,
60,
6624,
288,
82,
58,
429,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
437,
60,
6624,
288,
82,
58,
437,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
6624,
685,
38469,
90,
28664,
92,
26933,
72,
11,
1312,
61,
17,
12962,
329,
1312,
287,
657,
25,
429,
60,
198,
220,
220,
220,
2488,
9288,
2560,
7,
9310,
38381,
47715,
6624,
2560,
7,
9310,
58,
25,
12962,
198,
220,
220,
220,
220,
198,
220,
220,
220,
13259,
0,
7,
9310,
8,
198,
220,
220,
220,
2488,
9288,
288,
82,
58,
15,
60,
6624,
288,
82,
58,
437,
60,
628,
220,
220,
220,
288,
796,
43720,
7,
429,
10,
16,
8,
198,
220,
220,
220,
288,
82,
796,
6060,
27996,
7,
67,
8,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
6624,
288,
628,
220,
220,
220,
2488,
9288,
2092,
7,
9310,
737,
67,
6624,
6632,
7,
67,
8,
628,
220,
220,
220,
329,
1312,
287,
657,
25,
429,
198,
220,
220,
220,
220,
220,
220,
220,
900,
62,
7890,
0,
7,
9310,
11,
288,
83,
7,
72,
828,
1312,
8,
198,
220,
220,
220,
886,
628,
220,
220,
2488,
9288,
288,
82,
13,
67,
6624,
2824,
7,
15,
25,
429,
8,
198,
437,
628,
198,
31,
9288,
2617,
17971,
7,
81,
15636,
7203,
27354,
6005,
444,
362,
67,
357,
1416,
282,
283,
1366,
42501,
1795,
4008,
1,
2221,
198,
220,
220,
220,
37628,
796,
362,
628,
220,
220,
220,
288,
82,
796,
6060,
27996,
7,
25192,
7,
28664,
11,
37628,
828,
299,
83,
11,
37628,
8,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
9310,
8,
6624,
2099,
1659,
7,
6601,
27996,
90,
28664,
11,
17,
92,
7,
429,
11,
37628,
4008,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
9310,
8,
1279,
25,
27741,
19182,
90,
28664,
11,
17,
92,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
8,
220,
220,
6624,
717,
9630,
7,
9310,
13,
67,
8,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
16,
8,
6624,
717,
9630,
7,
9310,
13,
67,
11,
16,
8,
532,
352,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
17,
8,
6624,
352,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
8,
220,
220,
220,
6624,
938,
9630,
7,
9310,
13,
67,
8,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
16,
8,
220,
6624,
938,
9630,
7,
9310,
13,
67,
11,
16,
8,
532,
352,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
17,
8,
220,
6624,
938,
9630,
7,
9310,
13,
67,
11,
17,
8,
198,
220,
220,
220,
2488,
9288,
35002,
7,
9310,
8,
220,
220,
220,
220,
220,
6624,
357,
16,
11,
429,
10,
16,
8,
198,
220,
220,
220,
2488,
9288,
33769,
7,
9310,
11,
16,
8,
220,
220,
220,
220,
6624,
352,
198,
220,
220,
220,
2488,
9288,
33769,
7,
9310,
11,
17,
8,
220,
220,
220,
220,
6624,
299,
83,
10,
16,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
8,
220,
220,
6624,
357,
15,
25,
429,
11,
352,
25,
8461,
8,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
16,
8,
6624,
657,
25,
429,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
17,
8,
6624,
352,
25,
17,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
8,
6624,
357,
429,
10,
16,
11,
37628,
8,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
8,
6624,
2546,
7,
9310,
8,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
11,
16,
8,
6624,
299,
83,
10,
16,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
11,
17,
8,
6624,
37628,
198,
220,
220,
220,
2488,
9288,
299,
67,
12078,
7,
9310,
8,
220,
6624,
362,
198,
220,
220,
220,
2488,
9288,
1288,
4906,
7,
9310,
8,
6624,
288,
83,
198,
220,
220,
220,
2488,
9288,
2560,
7,
9310,
8,
6624,
288,
82,
13,
67,
628,
220,
220,
220,
329,
1312,
287,
657,
25,
429,
198,
220,
220,
220,
220,
220,
220,
220,
900,
62,
7890,
0,
7,
9310,
11,
288,
83,
7,
72,
828,
1312,
11,
352,
8,
198,
220,
220,
220,
220,
220,
220,
220,
900,
62,
7890,
0,
7,
9310,
11,
288,
83,
7,
72,
8,
61,
17,
11,
1312,
11,
362,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
45299,
16,
60,
6624,
2824,
7,
15,
25,
429,
8,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
45299,
17,
60,
6624,
2824,
7,
15,
25,
429,
8,
764,
61,
362,
628,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
16,
11,
16,
60,
6624,
288,
82,
58,
15,
11,
16,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
16,
11,
16,
25,
8461,
60,
6624,
288,
82,
58,
15,
11,
16,
25,
5907,
12629,
7,
9310,
15437,
628,
220,
220,
220,
2488,
9288,
288,
82,
58,
437,
11,
16,
60,
6624,
288,
82,
13,
67,
58,
437,
11,
16,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
58,
437,
11,
16,
60,
6624,
288,
82,
58,
429,
11,
16,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
58,
437,
11,
16,
25,
5907,
12629,
7,
9310,
15437,
6624,
288,
82,
58,
429,
11,
16,
25,
8461,
60,
628,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
16,
11,
47715,
6624,
288,
82,
58,
15,
11,
47715,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
45299,
16,
60,
6624,
2560,
7,
9310,
58,
45299,
16,
12962,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
45299,
47715,
6624,
2560,
7,
9310,
58,
45299,
25,
12962,
628,
220,
220,
220,
13259,
0,
7,
9310,
8,
198,
220,
220,
220,
2488,
9288,
288,
82,
58,
15,
11,
16,
60,
6624,
288,
82,
58,
437,
11,
16,
60,
628,
220,
220,
220,
1303,
27765,
796,
43720,
7,
358,
8,
198,
220,
220,
220,
1303,
288,
82,
58,
45299,
15,
60,
764,
28,
27765,
198,
220,
220,
220,
1303,
2488,
9288,
288,
82,
13,
67,
58,
45299,
16,
60,
6624,
27765,
628,
220,
220,
220,
288,
796,
43720,
7,
429,
10,
16,
11,
8461,
8,
198,
220,
220,
220,
288,
82,
796,
6060,
27996,
7,
67,
8,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
6624,
288,
628,
220,
220,
220,
2488,
9288,
2092,
7,
9310,
737,
67,
6624,
6632,
7,
67,
8,
198,
437,
628,
198,
31,
9288,
2617,
17971,
7,
81,
15636,
7203,
27354,
6005,
444,
362,
67,
357,
31364,
12,
39728,
1366,
42501,
1795,
4008,
1,
2221,
198,
220,
220,
220,
299,
67,
796,
362,
198,
220,
220,
220,
37628,
796,
642,
628,
220,
220,
220,
288,
82,
796,
6060,
27996,
26933,
25192,
7,
28664,
11,
299,
67,
8,
329,
1312,
287,
352,
25,
8461,
4357,
299,
83,
8,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
9310,
8,
6624,
2099,
1659,
7,
6601,
27996,
90,
38469,
90,
28664,
5512,
17,
92,
7,
429,
11,
37628,
4008,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
9310,
8,
1279,
25,
27741,
19182,
90,
38469,
90,
28664,
5512,
17,
92,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
8,
220,
220,
6624,
717,
9630,
7,
9310,
13,
67,
8,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
16,
8,
6624,
717,
9630,
7,
9310,
13,
67,
11,
16,
8,
532,
352,
198,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
17,
8,
6624,
352,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
8,
220,
220,
220,
6624,
938,
9630,
7,
9310,
13,
67,
8,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
16,
8,
220,
6624,
938,
9630,
7,
9310,
13,
67,
11,
16,
8,
532,
352,
198,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
17,
8,
220,
6624,
938,
9630,
7,
9310,
13,
67,
11,
17,
8,
198,
220,
220,
220,
2488,
9288,
35002,
7,
9310,
8,
220,
220,
220,
220,
220,
6624,
357,
16,
11,
429,
10,
16,
8,
198,
220,
220,
220,
2488,
9288,
33769,
7,
9310,
11,
16,
8,
220,
220,
220,
220,
6624,
352,
198,
220,
220,
220,
2488,
9288,
33769,
7,
9310,
11,
17,
8,
220,
220,
220,
220,
6624,
299,
83,
10,
16,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
8,
220,
220,
6624,
357,
15,
25,
429,
11,
352,
25,
8461,
8,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
16,
8,
6624,
657,
25,
429,
198,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
17,
8,
6624,
352,
25,
8461,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
8,
6624,
357,
429,
10,
16,
11,
37628,
8,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
8,
6624,
2546,
7,
9310,
8,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
11,
16,
8,
6624,
299,
83,
10,
16,
198,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
11,
17,
8,
6624,
37628,
198,
220,
220,
220,
2488,
9288,
299,
67,
12078,
7,
9310,
8,
220,
6624,
362,
198,
220,
220,
220,
2488,
9288,
1288,
4906,
7,
9310,
8,
6624,
20650,
90,
28664,
92,
198,
220,
220,
220,
2488,
9288,
2560,
7,
9310,
8,
6624,
288,
82,
13,
67,
628,
220,
220,
220,
329,
479,
287,
352,
25,
8461,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
657,
25,
429,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
82,
58,
72,
11,
74,
7131,
16,
60,
796,
479,
9,
72,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
82,
58,
72,
11,
74,
7131,
17,
60,
796,
479,
9,
72,
61,
17,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
27765,
796,
1976,
27498,
7,
28664,
11,
299,
67,
8,
198,
220,
220,
220,
329,
479,
287,
352,
25,
8461,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
657,
25,
429,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
651,
62,
7890,
0,
7,
9310,
11,
27765,
11,
1312,
11,
479,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
27765,
6624,
15690,
90,
417,
4906,
7,
17602,
38165,
7,
74,
764,
9,
685,
72,
11,
1312,
61,
17,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
16,
11,
16,
60,
6624,
288,
82,
58,
15,
11,
16,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
16,
11,
16,
25,
8461,
60,
6624,
288,
82,
58,
15,
11,
16,
25,
5907,
12629,
7,
9310,
15437,
628,
220,
220,
220,
2488,
9288,
288,
82,
58,
437,
11,
16,
60,
6624,
288,
82,
13,
67,
58,
437,
11,
16,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
58,
437,
11,
16,
60,
6624,
288,
82,
58,
429,
11,
16,
60,
198,
220,
220,
220,
2488,
9288,
288,
82,
58,
437,
11,
16,
25,
5907,
12629,
7,
9310,
15437,
6624,
288,
82,
58,
429,
11,
16,
25,
8461,
60,
628,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
16,
11,
47715,
6624,
288,
82,
58,
15,
11,
47715,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
45299,
16,
60,
6624,
2560,
7,
9310,
58,
45299,
16,
12962,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
45299,
47715,
6624,
2560,
7,
9310,
58,
45299,
25,
12962,
628,
220,
220,
220,
13259,
0,
7,
9310,
8,
198,
220,
220,
220,
2488,
9288,
288,
82,
58,
15,
11,
16,
60,
6624,
288,
82,
58,
437,
11,
16,
60,
628,
220,
220,
220,
1303,
27765,
796,
43720,
7,
358,
8,
198,
220,
220,
220,
1303,
288,
82,
58,
45299,
15,
60,
764,
28,
27765,
198,
220,
220,
220,
1303,
2488,
9288,
288,
82,
13,
67,
58,
45299,
16,
60,
6624,
27765,
628,
220,
220,
220,
288,
796,
43720,
7,
429,
10,
16,
11,
8461,
8,
198,
220,
220,
220,
288,
82,
796,
6060,
27996,
7,
67,
8,
198,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
6624,
288,
628,
220,
220,
220,
2488,
9288,
2092,
7,
9310,
737,
67,
6624,
6632,
7,
67,
8,
198,
437,
628,
198,
198,
2,
16926,
46,
25,
3060,
5254,
329,
7177,
12,
39728,
1366,
628,
198,
198,
2,
2488,
9288,
2617,
17971,
7,
81,
15636,
7203,
27354,
6005,
444,
513,
67,
1600,
1795,
4008,
1,
2221,
198,
2,
220,
220,
220,
220,
299,
67,
796,
362,
198,
2,
220,
220,
220,
220,
37628,
796,
362,
198,
198,
2,
220,
220,
220,
220,
288,
82,
796,
6060,
27996,
7,
28664,
11,
299,
67,
11,
299,
83,
11,
37628,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
9310,
8,
1279,
25,
27741,
19182,
90,
28664,
11,
18,
92,
198,
2,
220,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
8,
220,
220,
6624,
717,
9630,
7,
9310,
13,
67,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
16,
8,
6624,
717,
9630,
7,
9310,
13,
67,
11,
16,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
17,
8,
6624,
717,
9630,
7,
9310,
13,
67,
11,
17,
8,
532,
352,
198,
2,
220,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
18,
8,
6624,
717,
9630,
7,
9310,
13,
67,
11,
18,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
717,
9630,
7,
9310,
11,
19,
8,
6624,
352,
198,
2,
220,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
8,
220,
220,
220,
6624,
938,
9630,
7,
9310,
13,
67,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
16,
8,
220,
6624,
938,
9630,
7,
9310,
13,
67,
11,
16,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
17,
8,
220,
6624,
938,
9630,
7,
9310,
13,
67,
11,
17,
8,
532,
352,
198,
2,
220,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
18,
8,
220,
6624,
938,
9630,
7,
9310,
13,
67,
11,
18,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
938,
9630,
7,
9310,
11,
19,
8,
220,
6624,
352,
198,
2,
220,
220,
220,
220,
2488,
9288,
35002,
7,
9310,
8,
220,
220,
220,
220,
220,
6624,
357,
16,
11,
358,
11,
358,
9,
7,
429,
10,
16,
4008,
198,
2,
220,
220,
220,
220,
2488,
9288,
33769,
7,
9310,
11,
16,
8,
220,
220,
220,
220,
6624,
352,
198,
2,
220,
220,
220,
220,
2488,
9288,
33769,
7,
9310,
11,
17,
8,
220,
220,
220,
220,
6624,
299,
67,
198,
2,
220,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
8,
220,
220,
6624,
357,
16,
25,
358,
11,
657,
25,
429,
11,
352,
25,
8461,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
16,
8,
6624,
352,
25,
358,
198,
2,
220,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
17,
8,
6624,
657,
25,
429,
198,
2,
220,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
18,
8,
6624,
352,
25,
8461,
198,
2,
220,
220,
220,
220,
2488,
9288,
34197,
7,
9310,
11,
19,
8,
6624,
352,
25,
16,
198,
2,
220,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
8,
6624,
357,
358,
11,
299,
83,
10,
16,
11,
37628,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
8,
6624,
2546,
7,
9310,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
11,
16,
8,
6624,
299,
67,
198,
2,
220,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
11,
17,
8,
6624,
299,
83,
10,
16,
198,
2,
220,
220,
220,
220,
2488,
9288,
2546,
7,
9310,
13,
67,
11,
18,
8,
6624,
37628,
198,
2,
220,
220,
220,
220,
2488,
9288,
299,
67,
12078,
7,
9310,
8,
220,
6624,
513,
198,
2,
220,
220,
220,
220,
2488,
9288,
1288,
4906,
7,
9310,
8,
6624,
288,
83,
198,
2,
220,
220,
220,
220,
2488,
9288,
2560,
7,
9310,
8,
6624,
288,
82,
13,
67,
198,
198,
2,
220,
220,
220,
220,
329,
474,
287,
352,
25,
8461,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
352,
25,
429,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
82,
58,
16,
11,
72,
11,
73,
60,
796,
474,
9,
72,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
82,
58,
17,
11,
72,
11,
73,
60,
796,
474,
9,
72,
61,
17,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
2,
220,
220,
220,
220,
886,
198,
198,
2,
220,
220,
220,
220,
27765,
796,
1976,
27498,
7,
358,
8,
198,
2,
220,
220,
220,
220,
1259,
796,
1976,
27498,
7,
358,
11,
8461,
8,
198,
2,
220,
220,
220,
220,
256,
89,
796,
1976,
27498,
7,
358,
11,
8461,
8,
198,
2,
220,
220,
220,
220,
329,
1312,
287,
352,
25,
429,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
329,
474,
287,
352,
25,
8461,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
651,
62,
7890,
0,
7,
9310,
11,
27765,
11,
1312,
11,
474,
8,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
27765,
6624,
15690,
90,
417,
4906,
7,
17602,
38165,
26933,
73,
9,
72,
11,
474,
9,
72,
61,
17,
12962,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
256,
89,
58,
16,
11,
73,
60,
796,
474,
9,
72,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
256,
89,
58,
17,
11,
73,
60,
796,
474,
9,
72,
61,
17,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
651,
62,
7890,
0,
7,
9310,
11,
1259,
11,
1312,
8,
198,
2,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
1259,
6624,
256,
89,
198,
2,
220,
220,
220,
220,
886,
198,
198,
2,
220,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
16,
11,
16,
11,
16,
60,
6624,
288,
82,
58,
16,
11,
15,
11,
16,
60,
198,
2,
220,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
16,
25,
9310,
13,
358,
11,
16,
11,
16,
60,
6624,
288,
82,
58,
16,
25,
9310,
13,
358,
11,
15,
11,
16,
60,
198,
198,
2,
220,
220,
220,
220,
2488,
9288,
288,
82,
58,
16,
11,
437,
11,
16,
60,
6624,
288,
82,
13,
67,
58,
16,
11,
437,
11,
16,
60,
198,
2,
220,
220,
220,
220,
2488,
9288,
288,
82,
58,
16,
11,
429,
11,
16,
60,
6624,
288,
82,
58,
16,
11,
437,
11,
16,
60,
198,
2,
220,
220,
220,
220,
2488,
9288,
288,
82,
58,
16,
25,
9310,
13,
358,
11,
429,
11,
16,
60,
6624,
288,
82,
58,
16,
25,
9310,
13,
358,
11,
437,
11,
16,
60,
198,
198,
2,
220,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
45299,
16,
11,
16,
60,
6624,
288,
82,
58,
45299,
15,
11,
16,
60,
198,
2,
220,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
45299,
16,
11,
47715,
6624,
288,
82,
58,
45299,
15,
11,
47715,
198,
198,
2,
220,
220,
220,
220,
13259,
0,
7,
9310,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
288,
82,
58,
16,
11,
15,
11,
16,
60,
6624,
288,
82,
58,
16,
11,
437,
11,
16,
60,
198,
198,
2,
220,
220,
220,
220,
27765,
796,
43720,
7,
358,
8,
198,
2,
220,
220,
220,
220,
288,
82,
58,
45299,
15,
11,
16,
60,
764,
28,
27765,
198,
2,
220,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
58,
45299,
16,
11,
16,
60,
6624,
27765,
198,
198,
2,
220,
220,
220,
220,
288,
796,
43720,
7,
358,
11,
429,
10,
16,
11,
8461,
8,
198,
2,
220,
220,
220,
220,
288,
82,
796,
6060,
27996,
7,
67,
8,
198,
2,
220,
220,
220,
220,
2488,
9288,
288,
82,
13,
67,
6624,
288,
198,
198,
2,
220,
220,
220,
220,
2488,
9288,
2092,
7,
9310,
737,
67,
6624,
6632,
7,
67,
8,
198,
2,
886,
198
] | 1.788502 | 4,766 |
module COFF
using StructIO
# Bring in ObjectFile definitions
using ObjectFile
import ObjectFile: DynamicLink, DynamicLinks, RPath, ObjectHandle, Section, Sections, SectionRef,
Segment, Segments, SegmentRef, StrTab, Symbols, SymtabEntry, SymbolRef,
getindex, length, lastindex, iterate, keys, eltype, handle, header, path,
rpaths, canonical_rpaths, find_library, readmeta, seek, seekstart, skip,
iostream, position, read, readuntil, eof, endianness, is64bit, isrelocatable,
isexecutable, islibrary, isdynamic, mangle_section_name, mangle_symbol_name,
format_string, section_header_offset, section_header_size, section_header_type,
segment_header_offset, segment_header_size, segment_header_type, startaddr,
symtab_entry_offset, symtab_entry_size, symtab_entry_type, find_libraries,
findfirst, deref, section_name, section_size,
section_offset, section_address, section_number, segment_name, segment_offset,
segment_file_size, segment_memory_size, segment_address, strtab_lookup,
symbol_name, symbol_value, isundef, isglobal, islocal, isweak, symbol_number
# Load in imported C #define constants
include("constants.jl")
# Start to bring in concrete types, in the order they're needed
include("COFFHeader.jl")
include("COFFOptionalHeader.jl")
include("COFFHandle.jl")
include("COFFSection.jl")
include("COFFStrTab.jl")
include("COFFSymbol.jl")
include("COFFDynamicLink.jl")
end # module COFF
| [
21412,
7375,
5777,
198,
198,
3500,
32112,
9399,
198,
198,
2,
24347,
287,
9515,
8979,
17336,
198,
3500,
9515,
8979,
198,
11748,
9515,
8979,
25,
26977,
11280,
11,
26977,
31815,
11,
371,
15235,
11,
9515,
37508,
11,
7275,
11,
37703,
11,
7275,
8134,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1001,
5154,
11,
1001,
11726,
11,
1001,
5154,
8134,
11,
4285,
33349,
11,
41327,
10220,
11,
15845,
8658,
30150,
11,
38357,
8134,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
651,
9630,
11,
4129,
11,
938,
9630,
11,
11629,
378,
11,
8251,
11,
1288,
4906,
11,
5412,
11,
13639,
11,
3108,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
374,
6978,
82,
11,
40091,
62,
81,
6978,
82,
11,
1064,
62,
32016,
11,
1100,
28961,
11,
5380,
11,
5380,
9688,
11,
14267,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1312,
455,
1476,
11,
2292,
11,
1100,
11,
1100,
28446,
11,
304,
1659,
11,
886,
666,
1108,
11,
318,
2414,
2545,
11,
318,
2411,
420,
21156,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
318,
18558,
18187,
11,
318,
32016,
11,
318,
67,
28995,
11,
45663,
293,
62,
5458,
62,
3672,
11,
45663,
293,
62,
1837,
23650,
62,
3672,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5794,
62,
8841,
11,
2665,
62,
25677,
62,
28968,
11,
2665,
62,
25677,
62,
7857,
11,
2665,
62,
25677,
62,
4906,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10618,
62,
25677,
62,
28968,
11,
10618,
62,
25677,
62,
7857,
11,
10618,
62,
25677,
62,
4906,
11,
923,
29851,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5659,
8658,
62,
13000,
62,
28968,
11,
5659,
8658,
62,
13000,
62,
7857,
11,
5659,
8658,
62,
13000,
62,
4906,
11,
1064,
62,
75,
11127,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1064,
11085,
11,
390,
5420,
11,
2665,
62,
3672,
11,
2665,
62,
7857,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2665,
62,
28968,
11,
2665,
62,
21975,
11,
2665,
62,
17618,
11,
10618,
62,
3672,
11,
10618,
62,
28968,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10618,
62,
7753,
62,
7857,
11,
10618,
62,
31673,
62,
7857,
11,
10618,
62,
21975,
11,
965,
8658,
62,
5460,
929,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6194,
62,
3672,
11,
6194,
62,
8367,
11,
318,
917,
891,
11,
318,
20541,
11,
318,
12001,
11,
318,
38695,
11,
6194,
62,
17618,
198,
2,
8778,
287,
17392,
327,
1303,
13086,
38491,
198,
17256,
7203,
9979,
1187,
13,
20362,
4943,
198,
198,
2,
7253,
284,
2222,
287,
10017,
3858,
11,
287,
262,
1502,
484,
821,
2622,
198,
17256,
7203,
8220,
5777,
39681,
13,
20362,
4943,
198,
17256,
7203,
8220,
5777,
30719,
39681,
13,
20362,
4943,
198,
17256,
7203,
8220,
5777,
37508,
13,
20362,
4943,
198,
17256,
7203,
8220,
5777,
16375,
13,
20362,
4943,
198,
17256,
7203,
8220,
5777,
13290,
33349,
13,
20362,
4943,
198,
17256,
7203,
8220,
5777,
13940,
23650,
13,
20362,
4943,
198,
17256,
7203,
8220,
5777,
44090,
11280,
13,
20362,
4943,
198,
198,
437,
1303,
8265,
7375,
5777,
198
] | 2.490015 | 651 |
# Test Interpolation
@testset "lagrange order 1" begin
order = 1
ip = Lagrange{1,RefLine,order}()
bf = getnbasefunctions(ip)
nv = CGMethod1D.nvertexdofs(ip)
@test isapprox(bf, order+1, atol=1e-8)
@test isapprox(nv, 1, atol=1e-8)
end
@testset "lagrange order 2" begin
order = 2
ip = Lagrange{1,RefLine,order}()
bf = getnbasefunctions(ip)
nv = CGMethod1D.nvertexdofs(ip)
@test isapprox(bf, order+1, atol=1e-8)
@test isapprox(nv, 1, atol=1e-8)
end
@testset "value order 1" begin
order = 1
ip = Lagrange{1,RefLine,order}()
i1 = 1
i2 = 2
ξ = Vec{1}((-1.0,))
N1 = value(ip, i1, ξ)
N2 = value(ip, i2, ξ)
println("N1:$N1; N2:$N2")
@test isapprox(N1+N2, 1, atol=1e-8)
end
@testset "value order 2" begin
order = 2
ip = Lagrange{1,RefLine,order}()
i1 = 1
i2 = 2
i3 = 3
ξ = Vec{1}((-1.0,))
N1 = value(ip, i1, ξ)
N2 = value(ip, i2, ξ)
N3 = value(ip, i3, ξ)
println("N1:$N1; N2:$N2; N3:$N3")
@test isapprox(N1+N2+N3, 1, atol=1e-8)
end
@testset "reference_coordinates order 1" begin
order = 1; n = order+1;
ip = Lagrange{1,RefLine,order}()
coords = reference_coordinates(ip)
println(coords)
ξ_vec = collect(range(-1, stop=1, length=n))
for (idx,val) in enumerate(ξ_vec)
@test coords[idx][1] in ξ_vec
end
@test coords[1][1] == -1.0
@test coords[2][1] == 1.0
@test issorted(coords[3:end-1])
end
@testset "reference_coordinates order 2" begin
order = 20; n = order+1;
ip = Lagrange{1,RefLine,order}()
coords = reference_coordinates(ip)
println(coords)
ξ_vec = collect(range(-1, stop=1, length=n))
for (idx,val) in enumerate(ξ_vec)
@test coords[idx][1] in ξ_vec
end
@test coords[1][1] == -1.0
@test coords[2][1] == 1.0
@test issorted(coords[3:end-1])
end
@testset "Ferrite 1D order 1" begin
order = 1
i1 = 1
i2 = 2
ξ = Vec{1}((0.25,))
ip_F = Lagrange{1,RefCube,order}()
bf_F = getnbasefunctions(ip_F)
ip_C = Lagrange{1,RefLine,order}()
bf_C = getnbasefunctions(ip_C)
N1_F = value(ip_F, i1, ξ)
N2_F = value(ip_F, i2, ξ)
N1_C = value(ip_C, i1, ξ)
N2_C = value(ip_C, i2, ξ)
@test isapprox(bf_F, bf_C, atol=1e-8)
@test isapprox(N1_F, N1_C, atol=1e-8)
@test isapprox(N2_F, N2_C, atol=1e-8)
end
@testset "Ferrite 1D order 2" begin
order = 2
i1 = 1
i2 = 2
i3 = 3
ξ = Vec{1}((0.25,))
ip_F = Lagrange{1,RefCube,order}()
bf_F = getnbasefunctions(ip_F)
ip_C = Lagrange{1,RefLine,order}()
bf_C = getnbasefunctions(ip_C)
N1_F = value(ip_F, i1, ξ)
N2_F = value(ip_F, i2, ξ)
N3_F = value(ip_F, i3, ξ)
N1_C = value(ip_C, i1, ξ)
N2_C = value(ip_C, i2, ξ)
N3_C = value(ip_C, i3, ξ)
@test isapprox(bf_F, bf_C, atol=1e-8)
@test isapprox(N1_F, N1_C, atol=1e-8)
@test isapprox(N2_F, N2_C, atol=1e-8)
@test isapprox(N3_F, N3_C, atol=1e-8)
end | [
2,
6208,
4225,
16104,
341,
198,
31,
9288,
2617,
366,
30909,
9521,
1502,
352,
1,
2221,
198,
220,
220,
220,
1502,
796,
352,
198,
220,
220,
220,
20966,
796,
21003,
9521,
90,
16,
11,
8134,
13949,
11,
2875,
92,
3419,
198,
220,
220,
220,
275,
69,
796,
651,
77,
8692,
12543,
2733,
7,
541,
8,
198,
220,
220,
220,
299,
85,
796,
29925,
17410,
16,
35,
13,
77,
332,
16886,
67,
1659,
82,
7,
541,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
19881,
11,
1502,
10,
16,
11,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
48005,
11,
352,
11,
379,
349,
28,
16,
68,
12,
23,
8,
220,
198,
437,
628,
198,
31,
9288,
2617,
366,
30909,
9521,
1502,
362,
1,
2221,
198,
220,
220,
220,
1502,
796,
362,
198,
220,
220,
220,
20966,
796,
21003,
9521,
90,
16,
11,
8134,
13949,
11,
2875,
92,
3419,
198,
220,
220,
220,
275,
69,
796,
651,
77,
8692,
12543,
2733,
7,
541,
8,
198,
220,
220,
220,
299,
85,
796,
29925,
17410,
16,
35,
13,
77,
332,
16886,
67,
1659,
82,
7,
541,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
19881,
11,
1502,
10,
16,
11,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
48005,
11,
352,
11,
379,
349,
28,
16,
68,
12,
23,
8,
220,
198,
437,
628,
198,
31,
9288,
2617,
366,
8367,
1502,
352,
1,
2221,
198,
220,
220,
220,
1502,
796,
352,
198,
220,
220,
220,
20966,
796,
21003,
9521,
90,
16,
11,
8134,
13949,
11,
2875,
92,
3419,
198,
220,
220,
220,
1312,
16,
796,
352,
198,
220,
220,
220,
1312,
17,
796,
362,
198,
220,
220,
220,
7377,
122,
796,
38692,
90,
16,
92,
19510,
12,
16,
13,
15,
11,
4008,
198,
220,
220,
220,
399,
16,
796,
1988,
7,
541,
11,
1312,
16,
11,
7377,
122,
8,
198,
220,
220,
220,
399,
17,
796,
1988,
7,
541,
11,
1312,
17,
11,
7377,
122,
8,
198,
220,
220,
220,
44872,
7203,
45,
16,
25,
3,
45,
16,
26,
399,
17,
25,
3,
45,
17,
4943,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
45,
16,
10,
45,
17,
11,
352,
11,
379,
349,
28,
16,
68,
12,
23,
8,
220,
198,
437,
628,
198,
31,
9288,
2617,
366,
8367,
1502,
362,
1,
2221,
198,
220,
220,
220,
1502,
796,
362,
198,
220,
220,
220,
20966,
796,
21003,
9521,
90,
16,
11,
8134,
13949,
11,
2875,
92,
3419,
198,
220,
220,
220,
1312,
16,
796,
352,
198,
220,
220,
220,
1312,
17,
796,
362,
198,
220,
220,
220,
1312,
18,
796,
513,
198,
220,
220,
220,
7377,
122,
796,
38692,
90,
16,
92,
19510,
12,
16,
13,
15,
11,
4008,
198,
220,
220,
220,
399,
16,
796,
1988,
7,
541,
11,
1312,
16,
11,
7377,
122,
8,
198,
220,
220,
220,
399,
17,
796,
1988,
7,
541,
11,
1312,
17,
11,
7377,
122,
8,
198,
220,
220,
220,
399,
18,
796,
1988,
7,
541,
11,
1312,
18,
11,
7377,
122,
8,
198,
220,
220,
220,
44872,
7203,
45,
16,
25,
3,
45,
16,
26,
399,
17,
25,
3,
45,
17,
26,
399,
18,
25,
3,
45,
18,
4943,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
45,
16,
10,
45,
17,
10,
45,
18,
11,
352,
11,
379,
349,
28,
16,
68,
12,
23,
8,
220,
198,
437,
628,
198,
31,
9288,
2617,
366,
35790,
62,
37652,
17540,
1502,
352,
1,
2221,
198,
220,
220,
220,
1502,
796,
352,
26,
299,
796,
1502,
10,
16,
26,
198,
220,
220,
220,
20966,
796,
21003,
9521,
90,
16,
11,
8134,
13949,
11,
2875,
92,
3419,
198,
220,
220,
220,
763,
3669,
796,
4941,
62,
37652,
17540,
7,
541,
8,
198,
220,
220,
220,
44872,
7,
1073,
3669,
8,
198,
220,
220,
220,
7377,
122,
62,
35138,
796,
2824,
7,
9521,
32590,
16,
11,
2245,
28,
16,
11,
4129,
28,
77,
4008,
198,
220,
220,
220,
329,
357,
312,
87,
11,
2100,
8,
287,
27056,
378,
7,
138,
122,
62,
35138,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
763,
3669,
58,
312,
87,
7131,
16,
60,
287,
7377,
122,
62,
35138,
198,
220,
220,
220,
886,
220,
198,
220,
220,
220,
2488,
9288,
763,
3669,
58,
16,
7131,
16,
60,
6624,
532,
16,
13,
15,
198,
220,
220,
220,
2488,
9288,
763,
3669,
58,
17,
7131,
16,
60,
6624,
352,
13,
15,
198,
220,
220,
220,
2488,
9288,
1189,
9741,
7,
1073,
3669,
58,
18,
25,
437,
12,
16,
12962,
198,
437,
628,
198,
31,
9288,
2617,
366,
35790,
62,
37652,
17540,
1502,
362,
1,
2221,
198,
220,
220,
220,
1502,
796,
1160,
26,
299,
796,
1502,
10,
16,
26,
198,
220,
220,
220,
20966,
796,
21003,
9521,
90,
16,
11,
8134,
13949,
11,
2875,
92,
3419,
198,
220,
220,
220,
763,
3669,
796,
4941,
62,
37652,
17540,
7,
541,
8,
198,
220,
220,
220,
44872,
7,
1073,
3669,
8,
198,
220,
220,
220,
7377,
122,
62,
35138,
796,
2824,
7,
9521,
32590,
16,
11,
2245,
28,
16,
11,
4129,
28,
77,
4008,
198,
220,
220,
220,
329,
357,
312,
87,
11,
2100,
8,
287,
27056,
378,
7,
138,
122,
62,
35138,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
763,
3669,
58,
312,
87,
7131,
16,
60,
287,
7377,
122,
62,
35138,
198,
220,
220,
220,
886,
220,
198,
220,
220,
220,
2488,
9288,
763,
3669,
58,
16,
7131,
16,
60,
6624,
532,
16,
13,
15,
198,
220,
220,
220,
2488,
9288,
763,
3669,
58,
17,
7131,
16,
60,
6624,
352,
13,
15,
198,
220,
220,
220,
2488,
9288,
1189,
9741,
7,
1073,
3669,
58,
18,
25,
437,
12,
16,
12962,
198,
437,
628,
198,
31,
9288,
2617,
366,
43362,
6525,
352,
35,
1502,
352,
1,
2221,
198,
220,
220,
220,
1502,
796,
352,
198,
220,
220,
220,
1312,
16,
796,
352,
198,
220,
220,
220,
1312,
17,
796,
362,
198,
220,
220,
220,
7377,
122,
796,
38692,
90,
16,
92,
19510,
15,
13,
1495,
11,
4008,
198,
220,
220,
220,
20966,
62,
37,
796,
21003,
9521,
90,
16,
11,
8134,
29071,
11,
2875,
92,
3419,
198,
220,
220,
220,
275,
69,
62,
37,
796,
651,
77,
8692,
12543,
2733,
7,
541,
62,
37,
8,
198,
220,
220,
220,
20966,
62,
34,
796,
21003,
9521,
90,
16,
11,
8134,
13949,
11,
2875,
92,
3419,
198,
220,
220,
220,
275,
69,
62,
34,
796,
651,
77,
8692,
12543,
2733,
7,
541,
62,
34,
8,
198,
220,
220,
220,
399,
16,
62,
37,
796,
1988,
7,
541,
62,
37,
11,
1312,
16,
11,
7377,
122,
8,
198,
220,
220,
220,
399,
17,
62,
37,
796,
1988,
7,
541,
62,
37,
11,
1312,
17,
11,
7377,
122,
8,
198,
220,
220,
220,
399,
16,
62,
34,
796,
1988,
7,
541,
62,
34,
11,
1312,
16,
11,
7377,
122,
8,
198,
220,
220,
220,
399,
17,
62,
34,
796,
1988,
7,
541,
62,
34,
11,
1312,
17,
11,
7377,
122,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
19881,
62,
37,
11,
275,
69,
62,
34,
11,
379,
349,
28,
16,
68,
12,
23,
8,
220,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
45,
16,
62,
37,
11,
399,
16,
62,
34,
11,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
45,
17,
62,
37,
11,
399,
17,
62,
34,
11,
379,
349,
28,
16,
68,
12,
23,
8,
220,
198,
437,
628,
198,
31,
9288,
2617,
366,
43362,
6525,
352,
35,
1502,
362,
1,
2221,
198,
220,
220,
220,
1502,
796,
362,
198,
220,
220,
220,
1312,
16,
796,
352,
198,
220,
220,
220,
1312,
17,
796,
362,
198,
220,
220,
220,
1312,
18,
796,
513,
198,
220,
220,
220,
7377,
122,
796,
38692,
90,
16,
92,
19510,
15,
13,
1495,
11,
4008,
198,
220,
220,
220,
20966,
62,
37,
796,
21003,
9521,
90,
16,
11,
8134,
29071,
11,
2875,
92,
3419,
198,
220,
220,
220,
275,
69,
62,
37,
796,
651,
77,
8692,
12543,
2733,
7,
541,
62,
37,
8,
198,
220,
220,
220,
20966,
62,
34,
796,
21003,
9521,
90,
16,
11,
8134,
13949,
11,
2875,
92,
3419,
198,
220,
220,
220,
275,
69,
62,
34,
796,
651,
77,
8692,
12543,
2733,
7,
541,
62,
34,
8,
198,
220,
220,
220,
399,
16,
62,
37,
796,
1988,
7,
541,
62,
37,
11,
1312,
16,
11,
7377,
122,
8,
198,
220,
220,
220,
399,
17,
62,
37,
796,
1988,
7,
541,
62,
37,
11,
1312,
17,
11,
7377,
122,
8,
198,
220,
220,
220,
399,
18,
62,
37,
796,
1988,
7,
541,
62,
37,
11,
1312,
18,
11,
7377,
122,
8,
198,
220,
220,
220,
399,
16,
62,
34,
796,
1988,
7,
541,
62,
34,
11,
1312,
16,
11,
7377,
122,
8,
198,
220,
220,
220,
399,
17,
62,
34,
796,
1988,
7,
541,
62,
34,
11,
1312,
17,
11,
7377,
122,
8,
198,
220,
220,
220,
399,
18,
62,
34,
796,
1988,
7,
541,
62,
34,
11,
1312,
18,
11,
7377,
122,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
19881,
62,
37,
11,
275,
69,
62,
34,
11,
379,
349,
28,
16,
68,
12,
23,
8,
220,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
45,
16,
62,
37,
11,
399,
16,
62,
34,
11,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
45,
17,
62,
37,
11,
399,
17,
62,
34,
11,
379,
349,
28,
16,
68,
12,
23,
8,
198,
220,
220,
220,
2488,
9288,
318,
1324,
13907,
7,
45,
18,
62,
37,
11,
399,
18,
62,
34,
11,
379,
349,
28,
16,
68,
12,
23,
8,
220,
198,
437
] | 1.803021 | 1,655 |
using MicroCoverage
using Test
module MicroCoverageTestSuite
using MicroCoverage
using Test
function get_test_directory()::String
return dirname(@__FILE__)
end
function get_filename(parts...)::String
return joinpath(get_test_directory(), parts...)
end
function readstring_filename(parts...)::String
_filename = get_filename(parts...)
return read(_filename, String)
end
@testset "MicroCoverage.jl" begin
@testset "assert.jl" begin
@test MicroCoverage.always_assert(true, "") == nothing
@test_throws MicroCoverage.AlwaysAssertionError MicroCoverage.always_assert(false, "")
end
@testset "instrument.jl" begin
MicroCoverage.instrument("", Expr(:block), Val(:block)) == Expr(:block)
end
@testset "public_interface.jl" begin
MicroCoverage.with_temp_dir() do tmp_depot
MicroCoverage.with_temp_dir() do tmp_src_directory
nonexistent_filename = joinpath(tmp_src_directory, "nonexistent.jl")
foo_jl_filename = joinpath(tmp_src_directory, "foo.jl")
test_foo_jl_filename = joinpath(tmp_src_directory, "test_foo.jl")
foo_jl_microcov_filename = joinpath(tmp_src_directory, "foo.jl.microcov")
bar_jl_filename = joinpath(tmp_src_directory, "bar.jl")
test_bar_jl_filename = joinpath(tmp_src_directory, "test_bar.jl")
bar_jl_microcov_filename = joinpath(tmp_src_directory, "bar.jl.microcov")
open(foo_jl_filename, "w") do io
print(io, readstring_filename("inputs", "foo.jl"))
end
open(test_foo_jl_filename, "w") do io
print(io, readstring_filename("inputs", "test_foo.jl"))
end
open(bar_jl_filename, "w") do io
print(io, readstring_filename("inputs", "bar.jl"))
end
open(test_bar_jl_filename, "w") do io
print(io, readstring_filename("inputs", "test_bar.jl"))
end
@test_throws ArgumentError MicroCoverage.start(nonexistent_filename)
@test_throws ArgumentError MicroCoverage.clean(nonexistent_filename)
MicroCoverage.start(strip(foo_jl_filename))
MicroCoverage.start(bar_jl_filename)
MicroCoverage.preview_coverage(; dump_coverage_io = devnull)
include(foo_jl_filename)
MicroCoverage.preview_coverage(; dump_coverage_io = devnull)
include(bar_jl_filename)
MicroCoverage.preview_coverage(; dump_coverage_io = devnull)
include(test_foo_jl_filename)
MicroCoverage.preview_coverage(; dump_coverage_io = devnull)
include(test_bar_jl_filename)
MicroCoverage.preview_coverage(; dump_coverage_io = devnull)
@test !isfile(foo_jl_microcov_filename)
@test !ispath(foo_jl_microcov_filename)
@test !isfile(bar_jl_microcov_filename)
@test !ispath(bar_jl_microcov_filename)
MicroCoverage.stop(; dump_coverage = true, dump_coverage_io = devnull)
@test isfile(foo_jl_microcov_filename)
@test ispath(foo_jl_microcov_filename)
@test isfile(bar_jl_microcov_filename)
@test ispath(bar_jl_microcov_filename)
if Sys.iswindows()
@test chomp(read(foo_jl_microcov_filename, String)) == chomp(readstring_filename("expected_outputs", "foo.jl.microcov.expected"))
@test chomp(read(bar_jl_microcov_filename, String)) == chomp(readstring_filename("expected_outputs", "bar.jl.microcov.expected"))
else
@test read(foo_jl_microcov_filename, String) == readstring_filename("expected_outputs", "foo.jl.microcov.expected")
@test read(bar_jl_microcov_filename, String) == readstring_filename("expected_outputs", "bar.jl.microcov.expected")
end
touch(foo_jl_microcov_filename)
MicroCoverage.clean(foo_jl_filename)
touch(foo_jl_microcov_filename)
MicroCoverage.clean(tmp_src_directory)
end
end
end
end
end # end module MicroCoverageTestSuite
| [
3500,
4527,
7222,
1857,
198,
3500,
6208,
198,
198,
21412,
4527,
7222,
1857,
14402,
5606,
578,
198,
198,
3500,
4527,
7222,
1857,
198,
3500,
6208,
198,
198,
8818,
651,
62,
9288,
62,
34945,
33529,
25,
10100,
198,
220,
220,
220,
1441,
26672,
3672,
7,
31,
834,
25664,
834,
8,
198,
437,
198,
198,
8818,
651,
62,
34345,
7,
42632,
986,
2599,
25,
10100,
198,
220,
220,
220,
1441,
4654,
6978,
7,
1136,
62,
9288,
62,
34945,
22784,
3354,
23029,
198,
437,
198,
198,
8818,
1100,
8841,
62,
34345,
7,
42632,
986,
2599,
25,
10100,
198,
220,
220,
220,
4808,
34345,
796,
651,
62,
34345,
7,
42632,
23029,
198,
220,
220,
220,
1441,
1100,
28264,
34345,
11,
10903,
8,
198,
437,
198,
198,
31,
9288,
2617,
366,
13031,
7222,
1857,
13,
20362,
1,
2221,
198,
220,
220,
220,
2488,
9288,
2617,
366,
30493,
13,
20362,
1,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
4527,
7222,
1857,
13,
33770,
62,
30493,
7,
7942,
11,
366,
4943,
6624,
2147,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
62,
400,
8516,
4527,
7222,
1857,
13,
30374,
8021,
861,
295,
12331,
4527,
7222,
1857,
13,
33770,
62,
30493,
7,
9562,
11,
366,
4943,
198,
220,
220,
220,
886,
198,
220,
220,
220,
2488,
9288,
2617,
366,
259,
43872,
13,
20362,
1,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
259,
43872,
7203,
1600,
1475,
1050,
7,
25,
9967,
828,
3254,
7,
25,
9967,
4008,
6624,
1475,
1050,
7,
25,
9967,
8,
198,
220,
220,
220,
886,
198,
220,
220,
220,
2488,
9288,
2617,
366,
11377,
62,
39994,
13,
20362,
1,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
4480,
62,
29510,
62,
15908,
3419,
466,
45218,
62,
10378,
313,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
4480,
62,
29510,
62,
15908,
3419,
466,
45218,
62,
10677,
62,
34945,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
42601,
62,
34345,
796,
4654,
6978,
7,
22065,
62,
10677,
62,
34945,
11,
366,
23108,
87,
7609,
13,
20362,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
22944,
62,
20362,
62,
34345,
796,
4654,
6978,
7,
22065,
62,
10677,
62,
34945,
11,
366,
21943,
13,
20362,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1332,
62,
21943,
62,
20362,
62,
34345,
796,
4654,
6978,
7,
22065,
62,
10677,
62,
34945,
11,
366,
9288,
62,
21943,
13,
20362,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
22944,
62,
20362,
62,
24055,
66,
709,
62,
34345,
796,
4654,
6978,
7,
22065,
62,
10677,
62,
34945,
11,
366,
21943,
13,
20362,
13,
24055,
66,
709,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2318,
62,
20362,
62,
34345,
796,
4654,
6978,
7,
22065,
62,
10677,
62,
34945,
11,
366,
5657,
13,
20362,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1332,
62,
5657,
62,
20362,
62,
34345,
796,
4654,
6978,
7,
22065,
62,
10677,
62,
34945,
11,
366,
9288,
62,
5657,
13,
20362,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2318,
62,
20362,
62,
24055,
66,
709,
62,
34345,
796,
4654,
6978,
7,
22065,
62,
10677,
62,
34945,
11,
366,
5657,
13,
20362,
13,
24055,
66,
709,
4943,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1280,
7,
21943,
62,
20362,
62,
34345,
11,
366,
86,
4943,
466,
33245,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3601,
7,
952,
11,
1100,
8841,
62,
34345,
7203,
15414,
82,
1600,
366,
21943,
13,
20362,
48774,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1280,
7,
9288,
62,
21943,
62,
20362,
62,
34345,
11,
366,
86,
4943,
466,
33245,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3601,
7,
952,
11,
1100,
8841,
62,
34345,
7203,
15414,
82,
1600,
366,
9288,
62,
21943,
13,
20362,
48774,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1280,
7,
5657,
62,
20362,
62,
34345,
11,
366,
86,
4943,
466,
33245,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3601,
7,
952,
11,
1100,
8841,
62,
34345,
7203,
15414,
82,
1600,
366,
5657,
13,
20362,
48774,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1280,
7,
9288,
62,
5657,
62,
20362,
62,
34345,
11,
366,
86,
4943,
466,
33245,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3601,
7,
952,
11,
1100,
8841,
62,
34345,
7203,
15414,
82,
1600,
366,
9288,
62,
5657,
13,
20362,
48774,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
62,
400,
8516,
45751,
12331,
4527,
7222,
1857,
13,
9688,
7,
23108,
87,
7609,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
62,
400,
8516,
45751,
12331,
4527,
7222,
1857,
13,
27773,
7,
23108,
87,
7609,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
9688,
7,
36311,
7,
21943,
62,
20362,
62,
34345,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
9688,
7,
5657,
62,
20362,
62,
34345,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
3866,
1177,
62,
1073,
1857,
7,
26,
10285,
62,
1073,
1857,
62,
952,
796,
1614,
8423,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2291,
7,
21943,
62,
20362,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
3866,
1177,
62,
1073,
1857,
7,
26,
10285,
62,
1073,
1857,
62,
952,
796,
1614,
8423,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2291,
7,
5657,
62,
20362,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
3866,
1177,
62,
1073,
1857,
7,
26,
10285,
62,
1073,
1857,
62,
952,
796,
1614,
8423,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2291,
7,
9288,
62,
21943,
62,
20362,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
3866,
1177,
62,
1073,
1857,
7,
26,
10285,
62,
1073,
1857,
62,
952,
796,
1614,
8423,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2291,
7,
9288,
62,
5657,
62,
20362,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
3866,
1177,
62,
1073,
1857,
7,
26,
10285,
62,
1073,
1857,
62,
952,
796,
1614,
8423,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
5145,
4468,
576,
7,
21943,
62,
20362,
62,
24055,
66,
709,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
5145,
271,
6978,
7,
21943,
62,
20362,
62,
24055,
66,
709,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
5145,
4468,
576,
7,
5657,
62,
20362,
62,
24055,
66,
709,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
5145,
271,
6978,
7,
5657,
62,
20362,
62,
24055,
66,
709,
62,
34345,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
11338,
7,
26,
10285,
62,
1073,
1857,
796,
2081,
11,
10285,
62,
1073,
1857,
62,
952,
796,
1614,
8423,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
318,
7753,
7,
21943,
62,
20362,
62,
24055,
66,
709,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
318,
6978,
7,
21943,
62,
20362,
62,
24055,
66,
709,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
318,
7753,
7,
5657,
62,
20362,
62,
24055,
66,
709,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
318,
6978,
7,
5657,
62,
20362,
62,
24055,
66,
709,
62,
34345,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
311,
893,
13,
271,
28457,
3419,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
442,
3361,
7,
961,
7,
21943,
62,
20362,
62,
24055,
66,
709,
62,
34345,
11,
10903,
4008,
6624,
442,
3361,
7,
961,
8841,
62,
34345,
7203,
40319,
62,
22915,
82,
1600,
366,
21943,
13,
20362,
13,
24055,
66,
709,
13,
40319,
48774,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
442,
3361,
7,
961,
7,
5657,
62,
20362,
62,
24055,
66,
709,
62,
34345,
11,
10903,
4008,
6624,
442,
3361,
7,
961,
8841,
62,
34345,
7203,
40319,
62,
22915,
82,
1600,
366,
5657,
13,
20362,
13,
24055,
66,
709,
13,
40319,
48774,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
1100,
7,
21943,
62,
20362,
62,
24055,
66,
709,
62,
34345,
11,
10903,
8,
6624,
1100,
8841,
62,
34345,
7203,
40319,
62,
22915,
82,
1600,
366,
21943,
13,
20362,
13,
24055,
66,
709,
13,
40319,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
1100,
7,
5657,
62,
20362,
62,
24055,
66,
709,
62,
34345,
11,
10903,
8,
6624,
1100,
8841,
62,
34345,
7203,
40319,
62,
22915,
82,
1600,
366,
5657,
13,
20362,
13,
24055,
66,
709,
13,
40319,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3638,
7,
21943,
62,
20362,
62,
24055,
66,
709,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
27773,
7,
21943,
62,
20362,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3638,
7,
21943,
62,
20362,
62,
24055,
66,
709,
62,
34345,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4527,
7222,
1857,
13,
27773,
7,
22065,
62,
10677,
62,
34945,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
437,
198,
198,
437,
1303,
886,
8265,
4527,
7222,
1857,
14402,
5606,
578,
198
] | 2.075095 | 2,104 |
@testset "wiener" begin
k_1 = WienerKernel(i=-1)
@test typeof(k_1) <: WhiteKernel
k0 = WienerKernel()
@test typeof(k0) <: WienerKernel{0}
k1 = WienerKernel(i=1)
@test typeof(k1) <: WienerKernel{1}
k2 = WienerKernel(i=2)
@test typeof(k2) <: WienerKernel{2}
k3 = WienerKernel(i=3)
@test typeof(k3) <: WienerKernel{3}
@test_throws AssertionError WienerKernel(i=4)
@test_throws AssertionError WienerKernel(i=-2)
v1 = rand(4)
v2 = rand(4)
X = sqrt(sum(abs2, v1))
Y = sqrt(sum(abs2, v2))
minXY = min(X, Y)
@test k0(v1, v2) ≈ minXY
@test k1(v1, v2) ≈ 1 / 3 * minXY^3 + 1 / 2 * minXY^2 * euclidean(v1, v2)
@test k2(v1, v2) ≈ 1 / 20 * minXY^5 + 1 / 12 * minXY^3 * euclidean(v1, v2) *
( X + Y - 1 / 2 * minXY )
@test k3(v1, v2) ≈ 1 / 252 * minXY^7 + 1 / 720 * minXY^4 * euclidean(v1, v2) *
( 5 * max(X, Y)^2 + 2 * X * Y + 3 * minXY^2 )
# kernelmatrix tests
m1 = rand(3,4)
m2 = rand(3,4)
@test kernelmatrix(k0, m1, m1) ≈ kernelmatrix(k0, m1) atol=1e-5
K = zeros(4,4)
kernelmatrix!(K,k0,m1,m2)
@test K ≈ kernelmatrix(k0, m1, m2) atol=1e-5
V = zeros(4)
kerneldiagmatrix!(V,k0,m1)
@test V ≈ kerneldiagmatrix(k0,m1) atol=1e-5
x1 = rand()
x2 = rand()
@test kernelmatrix(k0, x1*ones(1,1), x2*ones(1,1))[1] ≈ k0(x1, x2) atol=1e-5
@test kernelmatrix(k1, x1*ones(1,1), x2*ones(1,1))[1] ≈ k1(x1, x2) atol=1e-5
@test kernelmatrix(k2, x1*ones(1,1), x2*ones(1,1))[1] ≈ k2(x1, x2) atol=1e-5
@test kernelmatrix(k3, x1*ones(1,1), x2*ones(1,1))[1] ≈ k3(x1, x2) atol=1e-5
# test_ADs(()->WienerKernel(i=1))
@test_broken "No tests passing"
end
| [
31,
9288,
2617,
366,
37686,
877,
1,
2221,
198,
220,
220,
220,
479,
62,
16,
796,
11759,
877,
42,
7948,
7,
72,
10779,
16,
8,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
74,
62,
16,
8,
1279,
25,
2635,
42,
7948,
628,
220,
220,
220,
479,
15,
796,
11759,
877,
42,
7948,
3419,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
74,
15,
8,
1279,
25,
11759,
877,
42,
7948,
90,
15,
92,
628,
220,
220,
220,
479,
16,
796,
11759,
877,
42,
7948,
7,
72,
28,
16,
8,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
74,
16,
8,
1279,
25,
11759,
877,
42,
7948,
90,
16,
92,
628,
220,
220,
220,
479,
17,
796,
11759,
877,
42,
7948,
7,
72,
28,
17,
8,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
74,
17,
8,
1279,
25,
11759,
877,
42,
7948,
90,
17,
92,
628,
220,
220,
220,
479,
18,
796,
11759,
877,
42,
7948,
7,
72,
28,
18,
8,
198,
220,
220,
220,
2488,
9288,
2099,
1659,
7,
74,
18,
8,
1279,
25,
11759,
877,
42,
7948,
90,
18,
92,
628,
220,
220,
220,
2488,
9288,
62,
400,
8516,
2195,
861,
295,
12331,
11759,
877,
42,
7948,
7,
72,
28,
19,
8,
198,
220,
220,
220,
2488,
9288,
62,
400,
8516,
2195,
861,
295,
12331,
11759,
877,
42,
7948,
7,
72,
10779,
17,
8,
628,
220,
220,
220,
410,
16,
796,
43720,
7,
19,
8,
198,
220,
220,
220,
410,
17,
796,
43720,
7,
19,
8,
628,
220,
220,
220,
1395,
796,
19862,
17034,
7,
16345,
7,
8937,
17,
11,
410,
16,
4008,
198,
220,
220,
220,
575,
796,
19862,
17034,
7,
16345,
7,
8937,
17,
11,
410,
17,
4008,
198,
220,
220,
220,
949,
34278,
796,
949,
7,
55,
11,
575,
8,
628,
220,
220,
220,
2488,
9288,
479,
15,
7,
85,
16,
11,
410,
17,
8,
15139,
230,
949,
34278,
198,
220,
220,
220,
2488,
9288,
479,
16,
7,
85,
16,
11,
410,
17,
8,
15139,
230,
352,
1220,
513,
1635,
949,
34278,
61,
18,
1343,
352,
1220,
362,
1635,
949,
34278,
61,
17,
1635,
304,
36616,
485,
272,
7,
85,
16,
11,
410,
17,
8,
198,
220,
220,
220,
2488,
9288,
479,
17,
7,
85,
16,
11,
410,
17,
8,
15139,
230,
352,
1220,
1160,
1635,
949,
34278,
61,
20,
1343,
352,
1220,
1105,
1635,
949,
34278,
61,
18,
1635,
304,
36616,
485,
272,
7,
85,
16,
11,
410,
17,
8,
1635,
198,
220,
220,
220,
220,
220,
220,
220,
357,
1395,
1343,
575,
532,
352,
1220,
362,
1635,
949,
34278,
1267,
198,
220,
220,
220,
2488,
9288,
479,
18,
7,
85,
16,
11,
410,
17,
8,
15139,
230,
352,
1220,
25264,
1635,
949,
34278,
61,
22,
1343,
352,
1220,
26250,
1635,
949,
34278,
61,
19,
1635,
304,
36616,
485,
272,
7,
85,
16,
11,
410,
17,
8,
1635,
198,
220,
220,
220,
220,
220,
220,
220,
357,
642,
1635,
3509,
7,
55,
11,
575,
8,
61,
17,
1343,
362,
1635,
1395,
1635,
575,
1343,
513,
1635,
949,
34278,
61,
17,
1267,
628,
220,
220,
220,
1303,
9720,
6759,
8609,
5254,
198,
220,
220,
220,
285,
16,
796,
43720,
7,
18,
11,
19,
8,
198,
220,
220,
220,
285,
17,
796,
43720,
7,
18,
11,
19,
8,
198,
220,
220,
220,
2488,
9288,
9720,
6759,
8609,
7,
74,
15,
11,
285,
16,
11,
285,
16,
8,
15139,
230,
9720,
6759,
8609,
7,
74,
15,
11,
285,
16,
8,
379,
349,
28,
16,
68,
12,
20,
628,
220,
220,
220,
509,
796,
1976,
27498,
7,
19,
11,
19,
8,
198,
220,
220,
220,
9720,
6759,
8609,
0,
7,
42,
11,
74,
15,
11,
76,
16,
11,
76,
17,
8,
198,
220,
220,
220,
2488,
9288,
509,
15139,
230,
9720,
6759,
8609,
7,
74,
15,
11,
285,
16,
11,
285,
17,
8,
379,
349,
28,
16,
68,
12,
20,
628,
220,
220,
220,
569,
796,
1976,
27498,
7,
19,
8,
198,
220,
220,
220,
41927,
710,
335,
72,
363,
6759,
8609,
0,
7,
53,
11,
74,
15,
11,
76,
16,
8,
198,
220,
220,
220,
2488,
9288,
569,
15139,
230,
41927,
710,
335,
72,
363,
6759,
8609,
7,
74,
15,
11,
76,
16,
8,
379,
349,
28,
16,
68,
12,
20,
628,
220,
220,
220,
2124,
16,
796,
43720,
3419,
198,
220,
220,
220,
2124,
17,
796,
43720,
3419,
198,
220,
220,
220,
2488,
9288,
9720,
6759,
8609,
7,
74,
15,
11,
2124,
16,
9,
1952,
7,
16,
11,
16,
828,
2124,
17,
9,
1952,
7,
16,
11,
16,
4008,
58,
16,
60,
15139,
230,
479,
15,
7,
87,
16,
11,
2124,
17,
8,
379,
349,
28,
16,
68,
12,
20,
198,
220,
220,
220,
2488,
9288,
9720,
6759,
8609,
7,
74,
16,
11,
2124,
16,
9,
1952,
7,
16,
11,
16,
828,
2124,
17,
9,
1952,
7,
16,
11,
16,
4008,
58,
16,
60,
15139,
230,
479,
16,
7,
87,
16,
11,
2124,
17,
8,
379,
349,
28,
16,
68,
12,
20,
198,
220,
220,
220,
2488,
9288,
9720,
6759,
8609,
7,
74,
17,
11,
2124,
16,
9,
1952,
7,
16,
11,
16,
828,
2124,
17,
9,
1952,
7,
16,
11,
16,
4008,
58,
16,
60,
15139,
230,
479,
17,
7,
87,
16,
11,
2124,
17,
8,
379,
349,
28,
16,
68,
12,
20,
198,
220,
220,
220,
2488,
9288,
9720,
6759,
8609,
7,
74,
18,
11,
2124,
16,
9,
1952,
7,
16,
11,
16,
828,
2124,
17,
9,
1952,
7,
16,
11,
16,
4008,
58,
16,
60,
15139,
230,
479,
18,
7,
87,
16,
11,
2124,
17,
8,
379,
349,
28,
16,
68,
12,
20,
628,
220,
220,
220,
1303,
1332,
62,
2885,
82,
7,
3419,
3784,
31294,
877,
42,
7948,
7,
72,
28,
16,
4008,
198,
220,
220,
220,
2488,
9288,
62,
25826,
366,
2949,
5254,
6427,
1,
198,
437,
198
] | 1.746914 | 972 |
module Data
export List, Fun
include("TypedFn.jl")
@info TypedFn
using MLStyle.Data.TypedFn
include("List.jl")
end
| [
21412,
6060,
198,
39344,
7343,
11,
11138,
198,
17256,
7203,
31467,
276,
37,
77,
13,
20362,
4943,
198,
31,
10951,
17134,
276,
37,
77,
198,
3500,
13981,
774,
293,
13,
6601,
13,
31467,
276,
37,
77,
198,
198,
17256,
7203,
8053,
13,
20362,
4943,
198,
437,
198
] | 2.468085 | 47 |
#*****************************************************************************
# Written by Ritchie Lee, [email protected]
# *****************************************************************************
# Copyright ã 2015, United States Government, as represented by the
# Administrator of the National Aeronautics and Space Administration. All
# rights reserved. The Reinforcement Learning Encounter Simulator (RLES)
# platform is licensed under the Apache License, Version 2.0 (the "License");
# you may not use this file except in compliance with the License. You
# may obtain a copy of the License at
# http://www.apache.org/licenses/LICENSE-2.0. Unless required by applicable
# law or agreed to in writing, software distributed under the License is
# distributed on an "AS IS" BASIS, WITHOUT WARRANTIES OR CONDITIONS OF ANY
# KIND, either express or implied. See the License for the specific language
# governing permissions and limitations under the License.
# _____________________________________________________________________________
# Reinforcement Learning Encounter Simulator (RLES) includes the following
# third party software. The SISLES.jl package is licensed under the MIT Expat
# License: Copyright (c) 2014: Youngjun Kim.
# Permission is hereby granted, free of charge, to any person obtaining a copy
# of this software and associated documentation files (the "Software"), to
# deal in the Software without restriction, including without limitation the
# rights to use, copy, modify, merge, publish, distribute, sublicense, and/or
# sell copies of the Software, and to permit persons to whom the Software is
# furnished to do so, subject to the following conditions:
# The above copyright notice and this permission notice shall be included in
# all copies or substantial portions of the Software. THE SOFTWARE IS PROVIDED
# "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLIED, INCLUDING BUT
# NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, FITNESS FOR A PARTICULAR
# PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT
# HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN
# ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN
# CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE.
# *****************************************************************************
using TensorFlow
import TensorFlow.API: shape, gather, concat, expand_dims, div_
type Normalizer{T<:AbstractFloat}
ndim::Int64
maxes::Array{T}
mins::Array{T}
end
function Normalizer(data::TFDataset; converttype::Union{Type,Void}=nothing)
N = ndims(data.X)
rmdims = collect(1:N-1)
#find max/mins per column over entire dataset
maxes = maximum(data.X, rmdims)
mins = minimum(data.X, rmdims)
if converttype != nothing
maxes = convert(Array{converttype}, maxes)
mins = convert(Array{converttype}, mins)
end
norm = Normalizer(N, maxes, mins)
norm
end
#"""
#"""
function normalize01(norm::Normalizer, Xin::Tensor)
N = norm.ndim
maxes = constant(norm.maxes)
mins = constant(norm.mins)
tileshape = concat(Tensor(0), Tensor([gather(shape(Xin), Tensor(collect(0:N-2))); Tensor([1])]))
tiledmaxes = tile(maxes, tileshape)
tiledmins = tile(mins, tileshape)
Xout = div_((Xin - tiledmins), (tiledmaxes - tiledmins))
Xout
end
function normalize(norm::Normalizer, Xin::Tensor, minval::AbstractFloat=-1.0,
maxval::AbstractFloat=1.0)
X01 = normalize(Xin)
max = constant(maxval)
min = constant(minval)
shape = get_shape(Xin)
tiledmax = tile(max, Tensor(shape))
tiledmin = tile(min, Tensor(shape))
Xout = X01 * (tiledmax - tiledmin) + tiledmin
Xout
end
| [
2,
17174,
17174,
4557,
35625,
198,
2,
22503,
416,
371,
48423,
5741,
11,
374,
48423,
13,
7197,
31,
21370,
13,
11215,
84,
13,
15532,
198,
2,
41906,
17174,
4557,
35625,
198,
2,
15069,
6184,
96,
1853,
11,
1578,
1829,
5070,
11,
355,
7997,
416,
262,
198,
2,
22998,
286,
262,
2351,
15781,
261,
2306,
873,
290,
4687,
8694,
13,
1439,
198,
2,
2489,
10395,
13,
220,
383,
22299,
13442,
18252,
40998,
13942,
357,
7836,
1546,
8,
198,
2,
3859,
318,
11971,
739,
262,
24843,
13789,
11,
10628,
362,
13,
15,
357,
1169,
366,
34156,
15341,
198,
2,
345,
743,
407,
779,
428,
2393,
2845,
287,
11846,
351,
262,
13789,
13,
921,
198,
2,
743,
7330,
257,
4866,
286,
262,
13789,
379,
198,
2,
2638,
1378,
2503,
13,
43073,
13,
2398,
14,
677,
4541,
14,
43,
2149,
24290,
12,
17,
13,
15,
13,
17486,
2672,
416,
9723,
198,
2,
1099,
393,
4987,
284,
287,
3597,
11,
3788,
9387,
739,
262,
13789,
318,
198,
2,
9387,
319,
281,
366,
1921,
3180,
1,
29809,
1797,
11,
42881,
34764,
11015,
6375,
7102,
49828,
11053,
3963,
15529,
198,
2,
509,
12115,
11,
2035,
4911,
393,
17142,
13,
4091,
262,
13789,
329,
262,
2176,
3303,
198,
2,
15030,
21627,
290,
11247,
739,
262,
13789,
13,
198,
2,
220,
27193,
2602,
29343,
198,
2,
22299,
13442,
18252,
40998,
13942,
357,
7836,
1546,
8,
3407,
262,
1708,
198,
2,
2368,
2151,
3788,
13,
383,
311,
1797,
28378,
13,
20362,
5301,
318,
11971,
739,
262,
17168,
5518,
265,
198,
2,
13789,
25,
15069,
357,
66,
8,
1946,
25,
6960,
29741,
6502,
13,
198,
2,
2448,
3411,
318,
29376,
7520,
11,
1479,
286,
3877,
11,
284,
597,
1048,
16727,
257,
4866,
198,
2,
286,
428,
3788,
290,
3917,
10314,
3696,
357,
1169,
366,
25423,
12340,
284,
198,
2,
1730,
287,
262,
10442,
1231,
17504,
11,
1390,
1231,
17385,
262,
198,
2,
2489,
284,
779,
11,
4866,
11,
13096,
11,
20121,
11,
7715,
11,
14983,
11,
850,
43085,
11,
290,
14,
273,
198,
2,
3677,
9088,
286,
262,
10442,
11,
290,
284,
8749,
6506,
284,
4150,
262,
10442,
318,
198,
2,
30760,
284,
466,
523,
11,
2426,
284,
262,
1708,
3403,
25,
198,
2,
383,
2029,
6634,
4003,
290,
428,
7170,
4003,
2236,
307,
3017,
287,
198,
2,
477,
9088,
393,
8904,
16690,
286,
262,
10442,
13,
3336,
47466,
3180,
36592,
2389,
1961,
198,
2,
366,
1921,
3180,
1600,
42881,
34764,
56,
3963,
15529,
509,
12115,
11,
7788,
32761,
6375,
8959,
49094,
11,
47783,
2751,
21728,
198,
2,
5626,
40880,
5390,
3336,
34764,
11015,
3963,
34482,
3398,
1565,
5603,
25382,
11,
376,
46144,
7473,
317,
16652,
2149,
37232,
198,
2,
33079,
48933,
5357,
44521,
1268,
10913,
2751,
12529,
13,
3268,
8005,
49261,
50163,
3336,
37195,
20673,
6375,
27975,
38162,
9947,
198,
2,
367,
15173,
4877,
9348,
43031,
19146,
7473,
15529,
47666,
3955,
11,
29506,
25552,
6375,
25401,
43031,
25382,
11,
7655,
2767,
16879,
3268,
3537,
198,
2,
40282,
3963,
27342,
10659,
11,
309,
9863,
6375,
25401,
54,
24352,
11,
5923,
1797,
2751,
16034,
11,
16289,
3963,
6375,
3268,
198,
2,
7102,
45,
24565,
13315,
3336,
47466,
6375,
3336,
23210,
6375,
25401,
5550,
1847,
20754,
3268,
3336,
47466,
13,
198,
2,
41906,
17174,
4557,
35625,
198,
198,
3500,
309,
22854,
37535,
198,
11748,
309,
22854,
37535,
13,
17614,
25,
5485,
11,
6431,
11,
1673,
265,
11,
4292,
62,
67,
12078,
11,
2659,
62,
198,
198,
4906,
14435,
7509,
90,
51,
27,
25,
23839,
43879,
92,
198,
220,
220,
220,
299,
27740,
3712,
5317,
2414,
198,
220,
220,
220,
3509,
274,
3712,
19182,
90,
51,
92,
198,
220,
220,
220,
23550,
3712,
19182,
90,
51,
92,
198,
437,
198,
198,
8818,
14435,
7509,
7,
7890,
3712,
10234,
27354,
292,
316,
26,
10385,
4906,
3712,
38176,
90,
6030,
11,
53,
1868,
92,
28,
22366,
8,
198,
220,
220,
220,
399,
796,
299,
67,
12078,
7,
7890,
13,
55,
8,
198,
220,
220,
220,
374,
9132,
12078,
796,
2824,
7,
16,
25,
45,
12,
16,
8,
198,
220,
220,
220,
1303,
19796,
3509,
14,
42951,
583,
5721,
625,
2104,
27039,
198,
220,
220,
220,
3509,
274,
796,
5415,
7,
7890,
13,
55,
11,
374,
9132,
12078,
8,
198,
220,
220,
220,
23550,
796,
5288,
7,
7890,
13,
55,
11,
374,
9132,
12078,
8,
198,
220,
220,
220,
611,
10385,
4906,
14512,
2147,
198,
220,
220,
220,
220,
220,
220,
220,
3509,
274,
796,
10385,
7,
19182,
90,
1102,
1851,
4906,
5512,
3509,
274,
8,
198,
220,
220,
220,
220,
220,
220,
220,
23550,
796,
10385,
7,
19182,
90,
1102,
1851,
4906,
5512,
23550,
8,
198,
220,
220,
220,
886,
198,
220,
220,
220,
2593,
796,
14435,
7509,
7,
45,
11,
3509,
274,
11,
23550,
8,
198,
220,
220,
220,
2593,
198,
437,
198,
198,
2,
37811,
198,
2,
37811,
198,
8818,
3487,
1096,
486,
7,
27237,
3712,
26447,
7509,
11,
25426,
3712,
51,
22854,
8,
198,
220,
220,
220,
399,
796,
2593,
13,
358,
320,
198,
220,
220,
220,
3509,
274,
796,
6937,
7,
27237,
13,
9806,
274,
8,
198,
220,
220,
220,
23550,
796,
6937,
7,
27237,
13,
42951,
8,
198,
220,
220,
220,
19867,
71,
1758,
796,
1673,
265,
7,
51,
22854,
7,
15,
828,
309,
22854,
26933,
70,
1032,
7,
43358,
7,
55,
259,
828,
309,
22854,
7,
33327,
7,
15,
25,
45,
12,
17,
4008,
1776,
309,
22854,
26933,
16,
12962,
60,
4008,
198,
220,
220,
220,
256,
3902,
9806,
274,
796,
17763,
7,
9806,
274,
11,
19867,
71,
1758,
8,
198,
220,
220,
220,
256,
3902,
42951,
796,
17763,
7,
42951,
11,
19867,
71,
1758,
8,
198,
220,
220,
220,
1395,
448,
796,
2659,
62,
19510,
55,
259,
532,
256,
3902,
42951,
828,
357,
83,
3902,
9806,
274,
532,
256,
3902,
42951,
4008,
198,
220,
220,
220,
1395,
448,
198,
437,
198,
198,
8818,
3487,
1096,
7,
27237,
3712,
26447,
7509,
11,
25426,
3712,
51,
22854,
11,
949,
2100,
3712,
23839,
43879,
10779,
16,
13,
15,
11,
220,
198,
220,
220,
220,
3509,
2100,
3712,
23839,
43879,
28,
16,
13,
15,
8,
198,
220,
220,
220,
220,
198,
220,
220,
220,
1395,
486,
796,
3487,
1096,
7,
55,
259,
8,
198,
220,
220,
220,
3509,
796,
6937,
7,
9806,
2100,
8,
198,
220,
220,
220,
949,
796,
6937,
7,
1084,
2100,
8,
198,
220,
220,
220,
5485,
796,
651,
62,
43358,
7,
55,
259,
8,
198,
220,
220,
220,
256,
3902,
9806,
796,
17763,
7,
9806,
11,
309,
22854,
7,
43358,
4008,
198,
220,
220,
220,
256,
3902,
1084,
796,
17763,
7,
1084,
11,
309,
22854,
7,
43358,
4008,
198,
220,
220,
220,
1395,
448,
796,
1395,
486,
1635,
357,
83,
3902,
9806,
532,
256,
3902,
1084,
8,
1343,
256,
3902,
1084,
198,
220,
220,
220,
1395,
448,
198,
437,
628
] | 3.349688 | 1,121 |
"""
Contains some functions for calculating cross-correlations, autocorrelations,
and Pearson correlations among rate units in a rate network
"""
using Statistics
import DSP.xcorr
"""
xcorr_unbiased(x::Vector, y::Vector, maxlag::Int64)
Returns the cross-correlation of two signals normalized by the length of the
available convolution window.
Written by Rainer Engelken ([email protected]).
"""
function xcorr_unbiased(x, y, maxlag)
l = length(x) # we assume same length for x and y
lags = -maxlag:maxlag
scale = l .- abs.(lags)
scale[scale .<= 0] .= 1 # avoid zero division
xcorr(x, y)[l .+ lags] ./ scale
end
"""
avg_autocorrs(A::Matrix{T}, maxlag::Int64, wait::Int64=0) where T <: AbstractFloat
Returns the average autocorrelation for the activity of each unit described in
the `N x NT` matrix `A`.
Note the autocorrelations are not mean-subtracted. The `maxlag` parameter
gives the maximum shift of the signal, and the `wait` parameter gives the number
of timesteps in the beginning to disregard.
"""
function avg_autocorrs(A::Matrix{T}, maxlag::Int64, wait::Int64=0) where T <: AbstractFloat
(N, NT) = size(A)
unit_autocorrs = mapslices(view(A, :, (wait + 1):NT), dims=2) do x
return xcorr_unbiased(x, x, maxlag)
end
return vec(mean(unit_autocorrs, dims=1))
end
| [
37811,
198,
4264,
1299,
617,
5499,
329,
26019,
3272,
12,
10215,
39468,
11,
1960,
420,
273,
39468,
11,
198,
392,
31074,
35811,
1871,
2494,
4991,
287,
257,
2494,
3127,
198,
37811,
198,
198,
3500,
14370,
198,
11748,
360,
4303,
13,
87,
10215,
81,
628,
198,
37811,
198,
197,
87,
10215,
81,
62,
403,
38002,
7,
87,
3712,
38469,
11,
331,
3712,
38469,
11,
3509,
30909,
3712,
5317,
2414,
8,
198,
198,
35561,
262,
3272,
12,
10215,
49501,
286,
734,
10425,
39279,
416,
262,
4129,
286,
262,
198,
15182,
3063,
2122,
4324,
13,
198,
198,
25354,
416,
10301,
263,
46073,
3464,
357,
260,
1954,
2996,
31,
4033,
2178,
544,
13,
15532,
737,
198,
37811,
198,
8818,
2124,
10215,
81,
62,
403,
38002,
7,
87,
11,
331,
11,
3509,
30909,
8,
198,
197,
75,
796,
4129,
7,
87,
8,
1303,
356,
7048,
976,
4129,
329,
2124,
290,
331,
198,
197,
75,
3775,
796,
532,
9806,
30909,
25,
9806,
30909,
198,
197,
9888,
796,
300,
764,
12,
2352,
12195,
75,
3775,
8,
198,
197,
9888,
58,
9888,
764,
27,
28,
657,
60,
764,
28,
352,
1303,
3368,
6632,
7297,
198,
220,
220,
220,
2124,
10215,
81,
7,
87,
11,
331,
38381,
75,
764,
10,
300,
3775,
60,
24457,
5046,
198,
437,
628,
198,
198,
37811,
198,
197,
615,
70,
62,
2306,
420,
273,
3808,
7,
32,
3712,
46912,
90,
51,
5512,
3509,
30909,
3712,
5317,
2414,
11,
4043,
3712,
5317,
2414,
28,
15,
8,
810,
309,
1279,
25,
27741,
43879,
198,
198,
35561,
262,
2811,
1960,
420,
273,
49501,
329,
262,
3842,
286,
1123,
4326,
3417,
287,
198,
1169,
4600,
45,
2124,
24563,
63,
17593,
4600,
32,
44646,
198,
198,
6425,
262,
1960,
420,
273,
39468,
389,
407,
1612,
12,
7266,
83,
20216,
13,
383,
4600,
9806,
30909,
63,
11507,
198,
70,
1083,
262,
5415,
6482,
286,
262,
6737,
11,
290,
262,
4600,
17077,
63,
11507,
3607,
262,
1271,
198,
1659,
4628,
395,
25386,
287,
262,
3726,
284,
25070,
13,
198,
37811,
198,
8818,
42781,
62,
2306,
420,
273,
3808,
7,
32,
3712,
46912,
90,
51,
5512,
3509,
30909,
3712,
5317,
2414,
11,
4043,
3712,
5317,
2414,
28,
15,
8,
810,
309,
1279,
25,
27741,
43879,
628,
197,
7,
45,
11,
24563,
8,
796,
2546,
7,
32,
8,
628,
197,
20850,
62,
2306,
420,
273,
3808,
796,
8739,
677,
274,
7,
1177,
7,
32,
11,
1058,
11,
357,
17077,
1343,
352,
2599,
11251,
828,
5391,
82,
28,
17,
8,
466,
2124,
198,
197,
197,
7783,
2124,
10215,
81,
62,
403,
38002,
7,
87,
11,
2124,
11,
3509,
30909,
8,
198,
197,
437,
628,
197,
7783,
43030,
7,
32604,
7,
20850,
62,
2306,
420,
273,
3808,
11,
5391,
82,
28,
16,
4008,
198,
437,
198
] | 2.878049 | 451 |
function mnistgrid(images, nrow, filename=nothing)
yy = reshape(images, 28, 28, size(images)[end])
yy = permutedims(yy, (2,1,3))
yy = Images.imresize(yy, 40, 40)
yy = Gray.(mosaicview(yy, 0.5f0, nrow=nrow, npad=1, rowmajor=true))
if filename == nothing
display(yy)
else
save(filename, yy)
end
end
| [
8818,
285,
77,
396,
25928,
7,
17566,
11,
299,
808,
11,
29472,
28,
22366,
8,
198,
220,
220,
220,
331,
88,
796,
27179,
1758,
7,
17566,
11,
2579,
11,
2579,
11,
2546,
7,
17566,
38381,
437,
12962,
198,
220,
220,
220,
331,
88,
796,
9943,
7241,
12078,
7,
22556,
11,
357,
17,
11,
16,
11,
18,
4008,
198,
220,
220,
220,
331,
88,
796,
5382,
13,
320,
411,
1096,
7,
22556,
11,
2319,
11,
2319,
8,
198,
220,
220,
220,
331,
88,
796,
12723,
12195,
76,
8546,
291,
1177,
7,
22556,
11,
657,
13,
20,
69,
15,
11,
299,
808,
28,
77,
808,
11,
299,
15636,
28,
16,
11,
5752,
22478,
28,
7942,
4008,
198,
220,
220,
220,
611,
29472,
6624,
2147,
198,
220,
220,
220,
220,
220,
220,
220,
3359,
7,
22556,
8,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
3613,
7,
34345,
11,
331,
88,
8,
198,
220,
220,
220,
886,
198,
437,
198
] | 2.104938 | 162 |
using Random, LightGraphs, SimpleWeightedGraphs
@testset "Testing local_search.jl" begin
@testset "Testing pearson_correlation" begin
# Check equal
b1 = [i/6 for i in 1:6]
b2 = [i/6 for i in 1:6]
@test AbrkgaObop.pearson_correlation(b1,b2,6) == 1.0
# Check reverse
b3 = reverse(b1)
@test AbrkgaObop.pearson_correlation(b1,b3,6) ≈ -1.0
end;
@testset "Testing weighted_label_propagation" begin
Random.seed!(0)
keys = [0.16666666666666666 0.159 0.84;
0.3333333333333333 0.32 0.82;
0.5 0.49 0.65;
0.6666666666666666 0.65 0.49;
0.8333333333333334 0.82 0.32;
1.0 0.84 0.159]
# Create weighted graph
sigma = 0.7 # Used to make graph sparse
n_itens = size(keys,1)
n_voters = size(keys,2)
graph = SimpleWeightedGraph(n_voters)
for i in 1:n_voters-1
for j in i+1:n_voters
weight = AbrkgaObop.pearson_correlation(keys[:,i],keys[:,j],n_itens)
if weight >= sigma
add_edge!(graph, i, j, weight)
end
end
end
# Return the index of the chromosomes that the LS will be applied
index_local_search = AbrkgaObop.weighted_label_propagation(graph)
@test index_local_search == [1,3]
end
@testset "Testing objective_partial" begin
instance = read_dataset("datasets/movie.toi")
bucket = [0 0;
0 0;
0 0;
0 0;
0 0;
0 0]
keys = [0.16666666666666666 0.159;
0.3333333333333333 0.32;
0.5 0.49;
0.6666666666666666 0.65;
0.8333333333333334 0.82;
1.0 0.84]
fitness = [0,0]
AbrkgaObop.decoder!(1,bucket,keys)
AbrkgaObop.objective!(1,bucket,fitness,instance)
# Check i -> j
fitness_from_i_j = AbrkgaObop.objective_partial(bucket[:,1], fitness[1], 1, 1, 6, instance)
@test fitness_from_i_j == 32
# Check j -> i
fitness_from_j_i = AbrkgaObop.objective_partial(bucket[:,1], fitness_from_i_j, 1, 6, 1, instance)
@test fitness_from_j_i == fitness[1]
# Compare with another bucket with same bucket order
AbrkgaObop.decoder!(2,bucket,keys)
AbrkgaObop.objective!(2,bucket,fitness,instance)
@test fitness_from_i_j == AbrkgaObop.objective_partial(bucket[:,2], fitness[2], 1, 1, 6, instance)
end
@testset "Testing local_search" begin
Random.seed!(0)
instance = read_dataset("datasets/movie.toi")
bucket = [0 0;
0 0;
0 0;
0 0;
0 0;
0 0]
keys = [0.16666666666666666 0.159;
0.3333333333333333 0.32;
0.5 0.49;
0.6666666666666666 0.65;
0.8333333333333334 0.82;
1.0 0.84]
fitness = [0,0]
statistics = AbrkgaObop.OBOPStatistics([],[],[],[],[],[],0.0,0.0,0,0)
AbrkgaObop.decoder!(1,bucket,keys)
AbrkgaObop.objective!(1,bucket,fitness,instance)
best_solution = AbrkgaObop.OBOPSolution(instance.total_itens,time())
AbrkgaObop.local_search!(1,keys,bucket,fitness,instance,best_solution,1,statistics)
@test best_solution.objective == 72
@test best_solution.bucket == [1,1,1,2,2,3]
end
@testset "Testing local_search_parallel" begin
Random.seed!(0)
instance = read_dataset("datasets/movie.toi")
bucket = [0 0;
0 0;
0 0;
0 0;
0 0;
0 0]
keys = [0.16666666666666666 0.159;
0.3333333333333333 0.32;
0.5 0.49;
0.6666666666666666 0.65;
0.8333333333333334 0.82;
1.0 0.84]
fitness = [0,0]
statistics = AbrkgaObop.OBOPStatistics([],[],[],[],[],[],0.0,0.0,0,0)
AbrkgaObop.decoder!(1,bucket,keys)
AbrkgaObop.objective!(1,bucket,fitness,instance)
best_solution = AbrkgaObop.OBOPSolution(instance.total_itens,time())
AbrkgaObop.local_search_parallel!(1,keys,bucket,fitness,instance,best_solution,1,statistics)
@test best_solution.objective == 72
@test best_solution.bucket == [1,1,1,2,2,3]
end
#=
@testset "Testing clustering_search" begin
Random.seed!(0)
instance = read_dataset("datasets/movie.toi")
bucket = [0 0;
0 0;
0 0;
0 0;
0 0;
0 0]
keys = [0.16666666666666666 0.159;
0.3333333333333333 0.32;
0.5 0.49;
0.6666666666666666 0.65;
0.8333333333333334 0.82;
1.0 0.84]
fitness = [0,0]
AbrkgaObop.decoder!(1,bucket,keys)
AbrkgaObop.objective!(1,bucket,fitness,instance)
AbrkgaObop.decoder!(2,bucket,keys)
AbrkgaObop.objective!(2,bucket,fitness,instance)
best_solution = AbrkgaObop.OBOPSolution(instance.total_itens,time())
statistics = AbrkgaObop.OBOPStatistics([],[],[],[],[],[],0.0,0.0,0,0)
AbrkgaObop.clustering_search(2,
[1,2],
keys,
bucket,
fitness,
instance,
best_solution,
1,
statistics)
@test best_solution.objective == 72
@test best_solution.bucket == [1,1,1,2,2,3]
end
=#
end | [
3500,
14534,
11,
4401,
37065,
82,
11,
17427,
25844,
276,
37065,
82,
198,
198,
31,
9288,
2617,
366,
44154,
1957,
62,
12947,
13,
20362,
1,
2221,
628,
220,
220,
220,
2488,
9288,
2617,
366,
44154,
25286,
1559,
62,
10215,
49501,
1,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
6822,
4961,
198,
220,
220,
220,
220,
220,
220,
220,
275,
16,
796,
685,
72,
14,
21,
329,
1312,
287,
352,
25,
21,
60,
198,
220,
220,
220,
220,
220,
220,
220,
275,
17,
796,
685,
72,
14,
21,
329,
1312,
287,
352,
25,
21,
60,
628,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
317,
1671,
74,
4908,
5944,
404,
13,
431,
12613,
62,
10215,
49501,
7,
65,
16,
11,
65,
17,
11,
21,
8,
6624,
352,
13,
15,
198,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
6822,
9575,
198,
220,
220,
220,
220,
220,
220,
220,
275,
18,
796,
9575,
7,
65,
16,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
317,
1671,
74,
4908,
5944,
404,
13,
431,
12613,
62,
10215,
49501,
7,
65,
16,
11,
65,
18,
11,
21,
8,
15139,
230,
532,
16,
13,
15,
198,
220,
220,
220,
886,
26,
628,
220,
220,
220,
2488,
9288,
2617,
366,
44154,
26356,
62,
18242,
62,
22930,
363,
341,
1,
2221,
628,
220,
220,
220,
220,
220,
220,
220,
14534,
13,
28826,
0,
7,
15,
8,
628,
220,
220,
220,
220,
220,
220,
220,
8251,
796,
685,
15,
13,
1433,
41977,
19060,
27310,
657,
13,
19707,
657,
13,
5705,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
24840,
24840,
24840,
24840,
220,
657,
13,
2624,
220,
657,
13,
6469,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
20,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
2920,
220,
657,
13,
2996,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
41977,
41977,
220,
657,
13,
2996,
220,
657,
13,
2920,
26,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
23,
24840,
24840,
24840,
31380,
220,
657,
13,
6469,
220,
657,
13,
2624,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
5705,
220,
657,
13,
19707,
60,
198,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
1303,
13610,
26356,
4823,
198,
220,
220,
220,
220,
220,
220,
220,
264,
13495,
796,
657,
13,
22,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
16718,
284,
787,
4823,
29877,
198,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
299,
62,
270,
641,
796,
2546,
7,
13083,
11,
16,
8,
198,
220,
220,
220,
220,
220,
220,
220,
299,
62,
85,
26008,
796,
2546,
7,
13083,
11,
17,
8,
628,
220,
220,
220,
220,
220,
220,
220,
4823,
796,
17427,
25844,
276,
37065,
7,
77,
62,
85,
26008,
8,
198,
220,
220,
220,
220,
220,
220,
220,
329,
1312,
287,
352,
25,
77,
62,
85,
26008,
12,
16,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
474,
287,
1312,
10,
16,
25,
77,
62,
85,
26008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3463,
796,
317,
1671,
74,
4908,
5944,
404,
13,
431,
12613,
62,
10215,
49501,
7,
13083,
58,
45299,
72,
4357,
13083,
58,
45299,
73,
4357,
77,
62,
270,
641,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
3463,
18189,
264,
13495,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
751,
62,
14907,
0,
7,
34960,
11,
1312,
11,
474,
11,
3463,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
8229,
262,
6376,
286,
262,
42742,
326,
262,
30948,
481,
307,
5625,
198,
220,
220,
220,
220,
220,
220,
220,
6376,
62,
12001,
62,
12947,
796,
317,
1671,
74,
4908,
5944,
404,
13,
6551,
276,
62,
18242,
62,
22930,
363,
341,
7,
34960,
8,
628,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
6376,
62,
12001,
62,
12947,
6624,
685,
16,
11,
18,
60,
628,
220,
220,
220,
886,
628,
220,
220,
220,
2488,
9288,
2617,
366,
44154,
9432,
62,
47172,
1,
2221,
628,
220,
220,
220,
220,
220,
220,
220,
4554,
796,
1100,
62,
19608,
292,
316,
7203,
19608,
292,
1039,
14,
41364,
13,
1462,
72,
4943,
628,
220,
220,
220,
220,
220,
220,
220,
19236,
796,
685,
15,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
60,
198,
220,
220,
220,
220,
220,
220,
220,
8251,
796,
685,
15,
13,
1433,
41977,
19060,
27310,
657,
13,
19707,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
24840,
24840,
24840,
24840,
220,
657,
13,
2624,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
20,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
2920,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
41977,
41977,
220,
657,
13,
2996,
26,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
23,
24840,
24840,
24840,
31380,
220,
657,
13,
6469,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
5705,
60,
198,
220,
220,
220,
220,
220,
220,
220,
13547,
796,
685,
15,
11,
15,
60,
198,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
12501,
12342,
0,
7,
16,
11,
27041,
316,
11,
13083,
8,
198,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
15252,
425,
0,
7,
16,
11,
27041,
316,
11,
69,
3659,
11,
39098,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
6822,
1312,
4613,
474,
198,
220,
220,
220,
220,
220,
220,
220,
13547,
62,
6738,
62,
72,
62,
73,
796,
317,
1671,
74,
4908,
5944,
404,
13,
15252,
425,
62,
47172,
7,
27041,
316,
58,
45299,
16,
4357,
13547,
58,
16,
4357,
352,
11,
352,
11,
718,
11,
4554,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
13547,
62,
6738,
62,
72,
62,
73,
6624,
3933,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
6822,
474,
4613,
1312,
198,
220,
220,
220,
220,
220,
220,
220,
13547,
62,
6738,
62,
73,
62,
72,
796,
317,
1671,
74,
4908,
5944,
404,
13,
15252,
425,
62,
47172,
7,
27041,
316,
58,
45299,
16,
4357,
13547,
62,
6738,
62,
72,
62,
73,
11,
352,
11,
718,
11,
352,
11,
4554,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
13547,
62,
6738,
62,
73,
62,
72,
6624,
13547,
58,
16,
60,
628,
220,
220,
220,
220,
220,
220,
220,
1303,
27814,
351,
1194,
19236,
351,
976,
19236,
1502,
198,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
12501,
12342,
0,
7,
17,
11,
27041,
316,
11,
13083,
8,
198,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
15252,
425,
0,
7,
17,
11,
27041,
316,
11,
69,
3659,
11,
39098,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
13547,
62,
6738,
62,
72,
62,
73,
6624,
317,
1671,
74,
4908,
5944,
404,
13,
15252,
425,
62,
47172,
7,
27041,
316,
58,
45299,
17,
4357,
13547,
58,
17,
4357,
352,
11,
352,
11,
718,
11,
4554,
8,
628,
220,
220,
220,
886,
628,
220,
220,
220,
2488,
9288,
2617,
366,
44154,
1957,
62,
12947,
1,
2221,
628,
220,
220,
220,
220,
220,
220,
220,
14534,
13,
28826,
0,
7,
15,
8,
628,
220,
220,
220,
220,
220,
220,
220,
4554,
796,
1100,
62,
19608,
292,
316,
7203,
19608,
292,
1039,
14,
41364,
13,
1462,
72,
4943,
628,
220,
220,
220,
220,
220,
220,
220,
19236,
796,
685,
15,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
60,
198,
220,
220,
220,
220,
220,
220,
220,
8251,
796,
685,
15,
13,
1433,
41977,
19060,
27310,
657,
13,
19707,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
24840,
24840,
24840,
24840,
220,
657,
13,
2624,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
20,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
2920,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
41977,
41977,
220,
657,
13,
2996,
26,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
23,
24840,
24840,
24840,
31380,
220,
657,
13,
6469,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
5705,
60,
198,
220,
220,
220,
220,
220,
220,
220,
13547,
796,
685,
15,
11,
15,
60,
628,
220,
220,
220,
220,
220,
220,
220,
7869,
796,
317,
1671,
74,
4908,
5944,
404,
13,
9864,
3185,
48346,
26933,
38430,
38430,
38430,
38430,
38430,
4357,
15,
13,
15,
11,
15,
13,
15,
11,
15,
11,
15,
8,
628,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
12501,
12342,
0,
7,
16,
11,
27041,
316,
11,
13083,
8,
198,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
15252,
425,
0,
7,
16,
11,
27041,
316,
11,
69,
3659,
11,
39098,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1266,
62,
82,
2122,
796,
317,
1671,
74,
4908,
5944,
404,
13,
9864,
30737,
2122,
7,
39098,
13,
23350,
62,
270,
641,
11,
2435,
28955,
628,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
12001,
62,
12947,
0,
7,
16,
11,
13083,
11,
27041,
316,
11,
69,
3659,
11,
39098,
11,
13466,
62,
82,
2122,
11,
16,
11,
14269,
3969,
8,
628,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
1266,
62,
82,
2122,
13,
15252,
425,
6624,
7724,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
1266,
62,
82,
2122,
13,
27041,
316,
6624,
685,
16,
11,
16,
11,
16,
11,
17,
11,
17,
11,
18,
60,
628,
220,
220,
220,
886,
628,
220,
220,
220,
2488,
9288,
2617,
366,
44154,
1957,
62,
12947,
62,
1845,
29363,
1,
2221,
628,
220,
220,
220,
220,
220,
220,
220,
14534,
13,
28826,
0,
7,
15,
8,
628,
220,
220,
220,
220,
220,
220,
220,
4554,
796,
1100,
62,
19608,
292,
316,
7203,
19608,
292,
1039,
14,
41364,
13,
1462,
72,
4943,
628,
220,
220,
220,
220,
220,
220,
220,
19236,
796,
685,
15,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
60,
198,
220,
220,
220,
220,
220,
220,
220,
8251,
796,
685,
15,
13,
1433,
41977,
19060,
27310,
657,
13,
19707,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
24840,
24840,
24840,
24840,
220,
657,
13,
2624,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
20,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
2920,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
41977,
41977,
220,
657,
13,
2996,
26,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
23,
24840,
24840,
24840,
31380,
220,
657,
13,
6469,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
5705,
60,
198,
220,
220,
220,
220,
220,
220,
220,
13547,
796,
685,
15,
11,
15,
60,
628,
220,
220,
220,
220,
220,
220,
220,
7869,
796,
317,
1671,
74,
4908,
5944,
404,
13,
9864,
3185,
48346,
26933,
38430,
38430,
38430,
38430,
38430,
4357,
15,
13,
15,
11,
15,
13,
15,
11,
15,
11,
15,
8,
628,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
12501,
12342,
0,
7,
16,
11,
27041,
316,
11,
13083,
8,
198,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
15252,
425,
0,
7,
16,
11,
27041,
316,
11,
69,
3659,
11,
39098,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1266,
62,
82,
2122,
796,
317,
1671,
74,
4908,
5944,
404,
13,
9864,
30737,
2122,
7,
39098,
13,
23350,
62,
270,
641,
11,
2435,
28955,
628,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
12001,
62,
12947,
62,
1845,
29363,
0,
7,
16,
11,
13083,
11,
27041,
316,
11,
69,
3659,
11,
39098,
11,
13466,
62,
82,
2122,
11,
16,
11,
14269,
3969,
8,
628,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
1266,
62,
82,
2122,
13,
15252,
425,
6624,
7724,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
1266,
62,
82,
2122,
13,
27041,
316,
6624,
685,
16,
11,
16,
11,
16,
11,
17,
11,
17,
11,
18,
60,
628,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
28,
198,
220,
220,
220,
2488,
9288,
2617,
366,
44154,
32966,
1586,
62,
12947,
1,
2221,
628,
220,
220,
220,
220,
220,
220,
220,
14534,
13,
28826,
0,
7,
15,
8,
628,
220,
220,
220,
220,
220,
220,
220,
4554,
796,
1100,
62,
19608,
292,
316,
7203,
19608,
292,
1039,
14,
41364,
13,
1462,
72,
4943,
628,
220,
220,
220,
220,
220,
220,
220,
19236,
796,
685,
15,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
657,
60,
198,
220,
220,
220,
220,
220,
220,
220,
8251,
796,
685,
15,
13,
1433,
41977,
19060,
27310,
657,
13,
19707,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
24840,
24840,
24840,
24840,
220,
657,
13,
2624,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
20,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
2920,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
41977,
41977,
220,
657,
13,
2996,
26,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
23,
24840,
24840,
24840,
31380,
220,
657,
13,
6469,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
352,
13,
15,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
5705,
60,
198,
220,
220,
220,
220,
220,
220,
220,
13547,
796,
685,
15,
11,
15,
60,
198,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
12501,
12342,
0,
7,
16,
11,
27041,
316,
11,
13083,
8,
198,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
15252,
425,
0,
7,
16,
11,
27041,
316,
11,
69,
3659,
11,
39098,
8,
198,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
12501,
12342,
0,
7,
17,
11,
27041,
316,
11,
13083,
8,
198,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
15252,
425,
0,
7,
17,
11,
27041,
316,
11,
69,
3659,
11,
39098,
8,
628,
220,
220,
220,
220,
220,
220,
220,
1266,
62,
82,
2122,
796,
317,
1671,
74,
4908,
5944,
404,
13,
9864,
30737,
2122,
7,
39098,
13,
23350,
62,
270,
641,
11,
2435,
28955,
628,
220,
220,
220,
220,
220,
220,
220,
7869,
796,
317,
1671,
74,
4908,
5944,
404,
13,
9864,
3185,
48346,
26933,
38430,
38430,
38430,
38430,
38430,
4357,
15,
13,
15,
11,
15,
13,
15,
11,
15,
11,
15,
8,
628,
220,
220,
220,
220,
220,
220,
220,
317,
1671,
74,
4908,
5944,
404,
13,
565,
436,
1586,
62,
12947,
7,
17,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
685,
16,
11,
17,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
8251,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
19236,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
13547,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4554,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1266,
62,
82,
2122,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
352,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
7869,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
1266,
62,
82,
2122,
13,
15252,
425,
6624,
7724,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
1266,
62,
82,
2122,
13,
27041,
316,
6624,
685,
16,
11,
16,
11,
16,
11,
17,
11,
17,
11,
18,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
886,
198,
220,
220,
220,
796,
2,
198,
198,
437
] | 1.672326 | 3,711 |
@testset "utilities.jl" begin
f_test(x, a, b) = a .* x .+ b
@test EasyPhys.number_of_arguments(f_test) == 3
@test EasyPhys.argument_names(f_test) == [:x, :a, :b]
EasyPhys.@partially_applicable g_test(x, a, b; kwargs...) = (a * x + b)
for x in 1:5, a in 6:10, b in 1:10
@test g_test(x, a, b; test=true) == x |> g_test(a, b; test=false) == a * x + b
end
EasyPhys.@partially_applicable g_test(x; kwargs...) = (println(kwargs); 5*x)
@test g_test(2; test=:somearg) == (2::Int) |> g_test(test=:someotherarg) == 10
end
| [
198,
31,
9288,
2617,
366,
315,
2410,
13,
20362,
1,
2221,
198,
198,
69,
62,
9288,
7,
87,
11,
257,
11,
275,
8,
796,
257,
764,
9,
2124,
764,
10,
275,
198,
198,
31,
9288,
16789,
43215,
13,
17618,
62,
1659,
62,
853,
2886,
7,
69,
62,
9288,
8,
6624,
513,
198,
198,
31,
9288,
16789,
43215,
13,
49140,
62,
14933,
7,
69,
62,
9288,
8,
6624,
685,
25,
87,
11,
1058,
64,
11,
1058,
65,
60,
628,
198,
28406,
43215,
13,
31,
3911,
1927,
62,
1324,
677,
540,
308,
62,
9288,
7,
87,
11,
257,
11,
275,
26,
479,
86,
22046,
23029,
796,
357,
64,
1635,
2124,
1343,
275,
8,
198,
1640,
2124,
287,
352,
25,
20,
11,
257,
287,
718,
25,
940,
11,
275,
287,
352,
25,
940,
198,
220,
220,
220,
2488,
9288,
308,
62,
9288,
7,
87,
11,
257,
11,
275,
26,
1332,
28,
7942,
8,
6624,
2124,
930,
29,
308,
62,
9288,
7,
64,
11,
275,
26,
1332,
28,
9562,
8,
6624,
257,
1635,
2124,
1343,
275,
198,
437,
198,
198,
28406,
43215,
13,
31,
3911,
1927,
62,
1324,
677,
540,
308,
62,
9288,
7,
87,
26,
479,
86,
22046,
23029,
796,
357,
35235,
7,
46265,
22046,
1776,
642,
9,
87,
8,
198,
31,
9288,
308,
62,
9288,
7,
17,
26,
1332,
28,
25,
82,
296,
451,
70,
8,
6624,
357,
17,
3712,
5317,
8,
930,
29,
308,
62,
9288,
7,
9288,
28,
25,
11246,
847,
853,
8,
6624,
838,
198,
198,
437,
198
] | 2.104418 | 249 |
abstract AbstractNoiseModel
noise(s::Symbol,args...) = _noise(Val{s},args...)
noisemodelname(::AbstractNoiseModel) = "AbstractNoiseModel"
function show(io::IO,n::AbstractNoiseModel)
println(io,noisemodelname(n))
for f in fieldnames(n)
print(io," ",f,": ",typeof(getfield(n,f)))
println(io)
end
nothing
end
| [
397,
8709,
27741,
2949,
786,
17633,
198,
198,
3919,
786,
7,
82,
3712,
13940,
23650,
11,
22046,
23029,
796,
4808,
3919,
786,
7,
7762,
90,
82,
5512,
22046,
23029,
198,
3919,
271,
368,
375,
417,
3672,
7,
3712,
23839,
2949,
786,
17633,
8,
796,
366,
23839,
2949,
786,
17633,
1,
198,
198,
8818,
905,
7,
952,
3712,
9399,
11,
77,
3712,
23839,
2949,
786,
17633,
8,
198,
220,
44872,
7,
952,
11,
3919,
271,
368,
375,
417,
3672,
7,
77,
4008,
198,
220,
329,
277,
287,
2214,
14933,
7,
77,
8,
198,
220,
220,
220,
3601,
7,
952,
553,
33172,
69,
553,
25,
33172,
4906,
1659,
7,
1136,
3245,
7,
77,
11,
69,
22305,
198,
220,
220,
220,
44872,
7,
952,
8,
198,
220,
886,
198,
220,
2147,
198,
437,
628
] | 2.480916 | 131 |
# License for this file: MIT (expat)
# Copyright 2017-2018, DLR Institute of System Dynamics and Control
#
# This file is part of module
# ModiaMath.SimulationEngine(ModiaMath/SimulationEngine/_module.jl)
#
# Methods that involve IDA UserData
#=
"KLU sparse matrix type"
type SlsMat
M::Cint # number of rows
N::Cint # number of columns
NNZ::Cint # maximum number of nonzero entries in the matrix
data::Ptr{Sundials.realtype} # data[NNZ] - value of nonzero entries
rowvals::Ptr{Cint} # rowvals[NNZ] - row indices of data (index starts at zero)
colptrs::Ptr{Cint} # colptrs[N+1] - index of the first column entry into the
# data and rowvals arrays (index starts at zero)
# The last entry contains the total number of nonzero values
# in the matrix and hence points one past the end
# of the active data in the data and rowvals arrays.
end
const SlsMat_Ptr = Ptr{SlsMat}
"""
CSCtoSlsMat!(mat, matKLU)
Copy SparseMatrixCSC mat to SlsMat data structure matKLU
(storage for both objects are provided in the calling program)
"""
function CSCtoSlsMat!(mat::SparseMatrixCSC{Float64,Cint}, matKLU::SlsMat)
for i = 1:length(mat.nzval)
unsafe_store!(matKLU.data , mat.nzval[i], i)
unsafe_store!(matKLU.rowvals, mat.rowval[i]-1, i)
end
for i = 1:length(mat.colptr)
unsafe_store!(matKLU.colptrs, mat.colptr[i]-1, i)
end
end
=#
##################################################################
#
# Wrappers to IDA code
#
##################################################################
function sol_f!(simModel::IntegratorData, sim, t::Float64, _y::Vector{Float64}, _yp::Vector{Float64}, r::Vector{Float64}, hcur)
stat = simModel.statistics
stat.hMin = min(stat.hMin, simModel.hcur[1])
stat.hMax = max(stat.hMax, simModel.hcur[1])
stat.orderMax = max(stat.orderMax, simModel.order[1])
stat.nResidues += 1
sim = simModel.simulationState
sim.time = t
simModel.last_t = t
simModel.last_norm_y = norm(simModel.y, Inf)
ModiaMath.DAE.getResidues!(simModel.model, sim, t, _y, _yp, r, hcur)
#println(_y, _yp, t, r, hcur )
return nothing
end
#------- full jacobian
function sol_fulljac(t::Float64, cj::Float64, _y::Vector{Float64}, _yp::Vector{Float64}, _r::Vector{Float64},
_fulljac::Array{Float64}, simModel::IntegratorData,
tmp1::Vector{Float64}, tmp2::Vector{Float64}, tmp3::Vector{Float64})
# Compute full Jacobian
sim = simModel.simulationState
sim.time = t
simModel.hcur[1] = simModel.sol_data.hcur
simModel.eweight = simModel.sol_data.weights
simModel.y = _y
simModel.yp = _yp
r = _r
ModiaMath.DAE.computeJacobian!(simModel.model, sim, t, y, yp, r, simModel.fulljac, simModel.hcur[1], cj, simModel.eweight)
simModel.statistics += sim.nx
return 0 # indicates normal return
end
function find_roots(t::Array{Float64, 1}, ys::Array{Array{Float64, 1}, 1}, yps::Array{Array{Float64,1},1}, simModel::IntegratorData, resprob!, abstol::Float64, reltol::Array{Float64,1})
#solve again with better precision to be sure
FTOL=eps(Float64)^(1 / 3)
sim = simModel.simulationState
nsol_f!(r, y) = ModiaMath.DAE.getResidues!(simModel.model, sim, t[1], ys[1], yps[1], r, simModel.hcur[1])
nsol = nlsolve(nsol_f!, ys[1], ftol=FTOL)
y = nsol.zero
prob = DAEProblem{true}(resprob!, yps[1], y, (t[1], t[end]), differential_vars=[true,true,false])
sol = solve(prob, dassl(), reltol = reltol, abstol = abstol/100)
return sol.t[end], sol.u[end], sol.du[end]
end
| [
2,
13789,
329,
428,
2393,
25,
17168,
357,
1069,
8071,
8,
198,
2,
15069,
2177,
12,
7908,
11,
23641,
49,
5136,
286,
4482,
33806,
290,
6779,
198,
2,
198,
2,
770,
2393,
318,
636,
286,
8265,
198,
2,
220,
220,
3401,
544,
37372,
13,
8890,
1741,
13798,
7,
5841,
544,
37372,
14,
8890,
1741,
13798,
47835,
21412,
13,
20362,
8,
198,
2,
198,
198,
2,
25458,
326,
6211,
4522,
32,
11787,
6601,
628,
198,
2,
28,
198,
1,
42,
41596,
29877,
17593,
2099,
1,
198,
4906,
3454,
82,
19044,
198,
220,
220,
337,
3712,
34,
600,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
1271,
286,
15274,
198,
220,
220,
399,
3712,
34,
600,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
1271,
286,
15180,
198,
220,
220,
399,
37371,
3712,
34,
600,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
5415,
1271,
286,
1729,
22570,
12784,
287,
262,
17593,
198,
220,
220,
1366,
3712,
46745,
90,
20602,
8231,
13,
5305,
4906,
92,
220,
220,
1303,
1366,
58,
6144,
57,
60,
220,
220,
220,
532,
1988,
286,
1729,
22570,
12784,
198,
220,
220,
5752,
12786,
3712,
46745,
90,
34,
600,
92,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
5752,
12786,
58,
6144,
57,
60,
532,
5752,
36525,
286,
1366,
357,
9630,
4940,
379,
6632,
8,
198,
220,
220,
951,
457,
3808,
3712,
46745,
90,
34,
600,
92,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
951,
457,
3808,
58,
45,
10,
16,
60,
532,
6376,
286,
262,
717,
5721,
5726,
656,
262,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1366,
290,
5752,
12786,
26515,
357,
9630,
4940,
379,
6632,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
383,
938,
5726,
4909,
262,
2472,
1271,
286,
1729,
22570,
3815,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
287,
262,
17593,
290,
12891,
2173,
530,
1613,
262,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1303,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
286,
262,
4075,
1366,
287,
262,
1366,
290,
5752,
12786,
26515,
13,
198,
437,
198,
198,
9979,
3454,
82,
19044,
62,
46745,
796,
350,
2213,
90,
50,
7278,
19044,
92,
628,
198,
37811,
198,
220,
220,
220,
327,
6173,
1462,
50,
7278,
19044,
0,
7,
6759,
11,
2603,
42,
41596,
8,
198,
198,
29881,
1338,
17208,
46912,
34,
6173,
2603,
284,
3454,
82,
19044,
1366,
4645,
2603,
42,
41596,
198,
7,
35350,
329,
1111,
5563,
389,
2810,
287,
262,
4585,
1430,
8,
198,
37811,
198,
8818,
327,
6173,
1462,
50,
7278,
19044,
0,
7,
6759,
3712,
50,
29572,
46912,
34,
6173,
90,
43879,
2414,
11,
34,
600,
5512,
2603,
42,
41596,
3712,
50,
7278,
19044,
8,
198,
220,
220,
329,
1312,
796,
352,
25,
13664,
7,
6759,
13,
27305,
2100,
8,
198,
220,
220,
220,
220,
220,
21596,
62,
8095,
0,
7,
6759,
42,
41596,
13,
7890,
220,
220,
837,
2603,
13,
27305,
2100,
58,
72,
4357,
1312,
8,
198,
220,
220,
220,
220,
220,
21596,
62,
8095,
0,
7,
6759,
42,
41596,
13,
808,
12786,
11,
2603,
13,
808,
2100,
58,
72,
45297,
16,
11,
1312,
8,
198,
220,
220,
886,
628,
220,
220,
329,
1312,
796,
352,
25,
13664,
7,
6759,
13,
4033,
20692,
8,
198,
220,
220,
220,
220,
220,
21596,
62,
8095,
0,
7,
6759,
42,
41596,
13,
4033,
457,
3808,
11,
2603,
13,
4033,
20692,
58,
72,
45297,
16,
11,
1312,
8,
198,
220,
220,
886,
198,
437,
198,
46249,
628,
198,
198,
29113,
29113,
2235,
198,
2,
198,
2,
27323,
11799,
284,
4522,
32,
2438,
198,
2,
198,
29113,
29113,
2235,
628,
198,
8818,
1540,
62,
69,
0,
7,
14323,
17633,
3712,
34500,
12392,
6601,
11,
985,
11,
256,
3712,
43879,
2414,
11,
4808,
88,
3712,
38469,
90,
43879,
2414,
5512,
4808,
4464,
3712,
38469,
90,
43879,
2414,
5512,
374,
3712,
38469,
90,
43879,
2414,
5512,
289,
22019,
8,
628,
220,
220,
220,
1185,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
796,
985,
17633,
13,
14269,
3969,
198,
220,
220,
220,
1185,
13,
71,
9452,
220,
220,
220,
220,
220,
796,
949,
7,
14269,
13,
71,
9452,
11,
985,
17633,
13,
71,
22019,
58,
16,
12962,
198,
220,
220,
220,
1185,
13,
71,
11518,
220,
220,
220,
220,
220,
796,
3509,
7,
14269,
13,
71,
11518,
11,
985,
17633,
13,
71,
22019,
58,
16,
12962,
198,
220,
220,
220,
1185,
13,
2875,
11518,
220,
796,
3509,
7,
14269,
13,
2875,
11518,
11,
985,
17633,
13,
2875,
58,
16,
12962,
198,
220,
220,
220,
1185,
13,
77,
4965,
312,
947,
15853,
352,
628,
198,
220,
220,
220,
985,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
796,
985,
17633,
13,
14323,
1741,
9012,
198,
220,
220,
220,
985,
13,
2435,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
796,
256,
198,
220,
220,
220,
985,
17633,
13,
12957,
62,
83,
220,
220,
220,
220,
220,
796,
256,
198,
220,
220,
220,
985,
17633,
13,
12957,
62,
27237,
62,
88,
796,
2593,
7,
14323,
17633,
13,
88,
11,
4806,
8,
628,
628,
220,
220,
220,
3401,
544,
37372,
13,
5631,
36,
13,
1136,
4965,
312,
947,
0,
7,
14323,
17633,
13,
19849,
11,
985,
11,
256,
11,
4808,
88,
11,
4808,
4464,
11,
374,
11,
289,
22019,
8,
198,
220,
220,
220,
1303,
35235,
28264,
88,
11,
4808,
4464,
11,
256,
11,
374,
11,
289,
22019,
1267,
198,
220,
220,
220,
1441,
2147,
198,
437,
628,
198,
2,
26866,
1336,
474,
330,
672,
666,
198,
8818,
1540,
62,
12853,
30482,
7,
83,
3712,
43879,
2414,
11,
269,
73,
3712,
43879,
2414,
11,
4808,
88,
3712,
38469,
90,
43879,
2414,
5512,
4808,
4464,
3712,
38469,
90,
43879,
2414,
5512,
4808,
81,
3712,
38469,
90,
43879,
2414,
5512,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4808,
12853,
30482,
3712,
19182,
90,
43879,
2414,
5512,
985,
17633,
3712,
34500,
12392,
6601,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
45218,
16,
3712,
38469,
90,
43879,
2414,
5512,
45218,
17,
3712,
38469,
90,
43879,
2414,
5512,
45218,
18,
3712,
38469,
90,
43879,
2414,
30072,
198,
220,
220,
220,
1303,
3082,
1133,
1336,
12806,
666,
198,
220,
220,
220,
985,
220,
220,
220,
220,
220,
796,
985,
17633,
13,
14323,
1741,
9012,
198,
220,
220,
220,
985,
13,
2435,
796,
256,
198,
220,
220,
220,
985,
17633,
13,
71,
22019,
58,
16,
60,
796,
985,
17633,
13,
34453,
62,
7890,
13,
71,
22019,
198,
220,
220,
220,
985,
17633,
13,
413,
26022,
796,
985,
17633,
13,
34453,
62,
7890,
13,
43775,
628,
198,
220,
220,
220,
985,
17633,
13,
88,
796,
4808,
88,
628,
220,
220,
220,
985,
17633,
13,
4464,
796,
4808,
4464,
628,
220,
220,
220,
374,
796,
4808,
81,
198,
220,
220,
220,
3401,
544,
37372,
13,
5631,
36,
13,
5589,
1133,
46751,
666,
0,
7,
14323,
17633,
13,
19849,
11,
985,
11,
256,
11,
331,
11,
331,
79,
11,
374,
11,
985,
17633,
13,
12853,
30482,
11,
985,
17633,
13,
71,
22019,
58,
16,
4357,
269,
73,
11,
985,
17633,
13,
413,
26022,
8,
198,
220,
220,
220,
985,
17633,
13,
14269,
3969,
15853,
985,
13,
77,
87,
628,
220,
220,
220,
1441,
657,
220,
220,
1303,
9217,
3487,
1441,
198,
437,
628,
628,
198,
8818,
1064,
62,
19150,
7,
83,
3712,
19182,
90,
43879,
2414,
11,
352,
5512,
331,
82,
3712,
19182,
90,
19182,
90,
43879,
2414,
11,
352,
5512,
352,
5512,
331,
862,
3712,
19182,
90,
19182,
90,
43879,
2414,
11,
16,
5512,
16,
5512,
985,
17633,
3712,
34500,
12392,
6601,
11,
220,
1217,
22609,
28265,
16552,
349,
3712,
43879,
2414,
11,
823,
83,
349,
3712,
19182,
90,
43879,
2414,
11,
16,
30072,
198,
220,
220,
220,
1303,
82,
6442,
757,
351,
1365,
15440,
284,
307,
1654,
198,
220,
220,
220,
19446,
3535,
28,
25386,
7,
43879,
2414,
8,
61,
7,
16,
1220,
513,
8,
198,
220,
220,
220,
985,
796,
985,
17633,
13,
14323,
1741,
9012,
198,
220,
220,
220,
299,
34453,
62,
69,
0,
7,
81,
11,
331,
8,
796,
3401,
544,
37372,
13,
5631,
36,
13,
1136,
4965,
312,
947,
0,
7,
14323,
17633,
13,
19849,
11,
985,
11,
256,
58,
16,
4357,
331,
82,
58,
16,
4357,
331,
862,
58,
16,
4357,
374,
11,
985,
17633,
13,
71,
22019,
58,
16,
12962,
198,
220,
220,
220,
299,
34453,
796,
299,
7278,
6442,
7,
5907,
349,
62,
69,
28265,
331,
82,
58,
16,
4357,
10117,
349,
28,
9792,
3535,
8,
198,
220,
220,
220,
331,
796,
299,
34453,
13,
22570,
198,
220,
220,
220,
1861,
796,
360,
14242,
40781,
90,
7942,
92,
7,
411,
1676,
65,
28265,
331,
862,
58,
16,
4357,
331,
11,
357,
83,
58,
16,
4357,
256,
58,
437,
46570,
22577,
62,
85,
945,
41888,
7942,
11,
7942,
11,
9562,
12962,
198,
220,
220,
220,
1540,
796,
8494,
7,
1676,
65,
11,
288,
562,
75,
22784,
823,
83,
349,
796,
823,
83,
349,
11,
16552,
349,
796,
16552,
349,
14,
3064,
8,
628,
198,
220,
220,
220,
1441,
1540,
13,
83,
58,
437,
4357,
1540,
13,
84,
58,
437,
4357,
1540,
13,
646,
58,
437,
60,
198,
437,
198
] | 2.226426 | 1,771 |
using Dash
using DashCoreComponents
using DashHtmlComponents
using PlotlyJS
include("IntegralUtils.jl")
include("GraphingUtils.jl")
using .IntegralUtils
using .GraphingUtils
mathjax = "https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.4/MathJax.js?config=TeX-MML-AM_CHTML"
app = dash(external_stylesheets=["https://codepen.io/chriddyp/pen/bWLwgP.css"],
assets_folder="assets",
external_scripts=[mathjax])
options_ = ["S: r(u, v)", "S: z = f(x, y), y = g(x)"]
app.layout = html_div() do
html_div(children = [
html_h1("\$\$\\text{Surface integrals calculator}\$\$", style=Dict("textAlign" => "center", "margin" => "3%")),
html_div(id="header",
children=[
html_h3(id="header_h3", "\$\$ \\text{Hello, let the fun begin!}\$\$")
]
),
html_hr(style=Dict("borderTop" => "1px dashed #d69c2f")),
html_div(id="surface", children=[
html_label(id="surface_label", "\$\$\\text{Choose the way of defining the surface:}\$\$"),
dcc_dropdown(
id = "dropdown",
options = [(label = i, value = i) for i in options_],
value = options_[1],
),
]),
html_hr(style=Dict("borderTop" => "1px dashed #d69c2f")),
html_div(id="main", children=[
html_div(id="inputs", children=[
html_label(id="vector_field_l", "\$\$\\text{Enter your vector field formula}\$\$"),
html_div(id="field", children=[
html_label(id="mFx", "\$\$\\vec{F}\\cdot\\hat{i}\$\$"),
dcc_input(id="Fx", type="text", value="x"),
html_label(id="mFy", "\$\$\\vec{F}\\cdot\\hat{j}\$\$"),
dcc_input(id="Fy", type="text", value="y"),
html_label(id="mFz", "\$\$\\vec{F}\\cdot\\hat{k}\$\$"),
dcc_input(id="Fz", type="text", value="z"),
]
),
html_label(id="method_dropdown", "\$\$\\text{Choose method of numeric integration:}\$\$"),
dcc_dropdown(
id = "method",
options = [(label = i, value = i) for i in ("Simpson", "Monte Carlo")],
value = "Simpson"
),
html_label(id="accurary", "\$\$\\text{Choose the accuracy of numeric integration:}\$\$"),
dcc_slider(
id = "integral_accuracy",
min = 10,
max = 100,
marks = Dict([Symbol(v) => Symbol(v) for v in 10:10:100]),
value = 10,
step = 10,
),
html_div(id="parametric_bounds", children=[
html_label(id="r1lab", "\$\$\\vec{r}(u, v)\\cdot\\hat{i} =\$\$"),
dcc_input(id="r1", type="text", value="sqrt(1/4 + u^2) * cos(v)"),
html_label(id="r2lab", "\$\$\\vec{r}(u, v)\\cdot\\hat{j} =\$\$"),
dcc_input(id="r2", type="text", value="sqrt(1/4 + u^2) * sin(v)"),
html_label(id="r3lab", "\$\$\\vec{r}(u, v)\\cdot\\hat{k} =\$\$"),
dcc_input(id="r3", type="text", value="u"),
html_label(id="u_range1", "\$\$u_{min} =\$\$"),
dcc_input(id="u_range1i", type="text", value="-1"),
html_label(id="u_range2", "\$\$u_{max} =\$\$"),
dcc_input(id="u_range2i", type="text", value="1"),
html_label(id="v_range1", "\$\$\\phi(u) =\$\$"),
dcc_input(id="v_range1i", type="text", value="0"),
html_label(id="v_range2", "\$\$\\theta(u) =\$\$"),
dcc_input(id="v_range2i", type="text", value="2pi")
], style=Dict("display" => "grid")
),
html_div(id="fxy_bounds", children=[
html_label(id="x_range1", "\$\$x_{\\text{min}} =\$\$"),
dcc_input(id="x_range1i", type="text", value="-2"),
html_label(id="x_range2", "\$\$ x_{\\text{max}} =\$\$"),
dcc_input(id="x_range2i", type="text", value="3"),
html_label(id="y_range1", "\$\$ \\zeta(x) =\$\$"),
dcc_input(id="y_range1i", type="text", value="-2"),
html_label(id="y_range2", "\$\$ \\eta(x) =\$\$"),
dcc_input(id="y_range2i", type="text", value="2"),
html_label(id="z_range1", "\$\$ f(x, y) =\$\$"),
dcc_input(id="z_range1i", type="text", value="-(x^2 + y^2)"),
html_label(id="z_range2", "\$\$ g(x, y) =\$\$"),
dcc_input(id="z_range2i", type="text", value="x^2+y^2"),
], style=Dict("display" => "none")
), html_button(id = "submit-button-state", children = "submit", n_clicks = 0),
html_div(id="output_")
]),
html_div(id="graphing", children=[
dcc_graph(
id = "surface_plot",
figure = (
data = [
(x = [0],
y = [0],
z = [[0], [0]],
type = "surface")
],
layout = (
autosize=false,
width=600,
height=600
)
)
),
]
),
]),
html_div(id="plot_attributes",
children=[
html_label(id="field_density_lab", "\$\$\\text{Choose the density of the vector field.}\$\$"),
dcc_slider(
id = "field_density",
min = 0,
max = ,10
marks = Dict([Symbol(v) => Symbol(v) for v in 0:1:10]),
value = 5,
step = 1,
),
html_label(id="graph_accuracy_lab", "\$\$\\text{Choose the accuracy of plotting.}\$\$"),
dcc_slider(
id = "graph_accuracy",
min = 10,
max = 100,
marks = Dict([Symbol(v) => Symbol(v) for v in 10:10:100]),
value = 20,
step = 10,
)
]
), html_footer("\$\$\\text{MIT License}. \\ \\text{MM, ML, MK.}\$\$", style=Dict("marginTop" => "3em", "textAlign" => "center"))
])
end
callback!(app,
Output("parametric_bounds", "style"),
Output("fxy_bounds", "style"),
Input("dropdown", "value")
) do user_choice
if user_choice == options_[1]
return Dict("display" => "grid"), Dict("display" => "none")
else
return Dict("display" => "none"), Dict("display" => "grid")
end
end
callback!(app,
Output("output_", "children"),
Input("submit-button-state", "n_clicks"),
State("dropdown", "value"),
State("r1", "value"),
State("r2", "value"),
State("r3", "value"),
State("Fx", "value"),
State("Fy", "value"),
State("Fz", "value"),
State("method", "value"),
State("integral_accuracy", "value"),
State("u_range1i", "value"),
State("u_range2i", "value"),
State("v_range1i", "value"),
State("v_range2i", "value"),
State("x_range1i", "value"),
State("x_range2i", "value"),
State("y_range1i", "value"),
State("y_range2i", "value"),
State("z_range1i", "value"),
State("z_range2i", "value")
) do n_clicks, dropdown_value, r1, r2, r3, Fx, Fy, Fz, technique, n, u_min, u_max,
v_min, v_max, x_min, x_max, y_min, y_max, z_min, z_max
if dropdown_value == options_[1]
try
u_min, u_max = parse_num.([u_min, u_max])
p = parse_function(join(["[" * r1, r2, r3 *"]" ], ", "), :u, :v)
q = parse_function(join(["[" * Fx, Fy, Fz * "]"], ", "), :x, :y, :z)
ϕ = parse_function(v_min, :u)
ψ = parse_function(v_max, :u)
value(f, g, a, b) = round_float(Φ(f, g, (u_min, u_max), a, b; N = Int(n ÷ 2), technique = technique), 1e-3)
value_ = @eval abs(($value($q, $p, $ϕ, $ψ)))
return html_h5("|Φ| = $(value_).", style=Dict("textAlign" => "center"))
catch e
return html_h5("\$\$\\text{Wrong input. Try again.}\$\$", style=Dict("textAlign" => "center"))
end
else
try
x_min, x_max = parse_num.([x_min, x_max])
q = parse_function(join(["[" * Fx, Fy, Fz * "]"], ", "), :x, :y, :z)
ϕ = parse_function(y_min, :x)
ψ = parse_function(y_max, :x)
ρ = parse_function(z_min, :x, :y)
η = parse_function(z_max, :x, :y)
value(f, a, b, c, d) = round_float(Φ(f, (x_min, x_max), a, b, c, d; N = Int(n ÷ 2), technique = technique), 1e-3)
value_ = @eval abs(($value($q, $ρ, $η, $ϕ, $ψ)))
return html_h5("|Φ| = $(value_).", style=Dict("textAlign" => "center"))
catch e
return html_h5("\$\$ \\text{Wrong input. Try again.} \$\$", style=Dict("textAlign" => "center"))
end
end
end
callback!(app,
Output("surface_plot", "figure"),
Input("submit-button-state", "n_clicks"),
State("r1", "value"),
State("r2", "value"),
State("r3", "value"),
State("dropdown", "value"),
State("graph_accuracy", "value"),
State("u_range1i", "value"),
State("u_range2i", "value"),
State("v_range1i", "value"),
State("v_range2i", "value"),
State("x_range1i", "value"),
State("x_range2i", "value"),
State("y_range1i", "value"),
State("y_range2i", "value"),
State("z_range1i", "value"),
State("z_range2i", "value"),
State("Fx", "value"),
State("Fy", "value"),
State("Fz","value"),
State("field_density", "value")
) do n_clicks, r1, r2, r3, dropdown_value, N, u_min, u_max, v_min, v_max,
x_min, x_max, y_min, y_max, z_min, z_max, F1, F2, F3, density
if dropdown_value == options_[1] # _______________parametric
try
u_min = parse_num(u_min)
u_max = parse_num(u_max)
v_min = parse_function(v_min, :u)
v_max = parse_function(v_max, :u)
catch e
u_min = -1
u_max = 1
v_min = parse_function("0", :u)
v_max = parse_function("2pi", :u)
end
if false
return Plot(surface(;
x = [0],
y = [0],
z = [[0], [0]]))
else
Fx = Fy = Fz = "_"
X(u, v) = 0
Y(u, v) = 0
Z(u, v) = 0
try
X = parse_function(r1, :u, :v)
Y = parse_function(r2, :u, :v)
Z = parse_function(r3, :u, :v)
Fx = parse_function(F1, :x, :y, :z)
Fy = parse_function(F2, :x, :y, :z)
Fz = parse_function(F3, :x, :y, :z)
@eval ($X(-2, 3), $Y(-2, 3), $Z(-2, 3))
@eval (isa($X(-2, 3), Array{Float64, 1}))
@eval (isa($Y(-2, 3), Array{Float64, 1}))
@eval (isa($Z(-2, 3), Array{Float64, 1}))
@eval (isa($Fx(-2, -2, -2), Number))
@eval (isa($Fy(-2, -2, -2), Number))
@eval (isa($Fz(-2, -2, -2), Number))
catch e
X = parse_function("0", :u, :v)
Y = parse_function("0", :u, :v)
Z = parse_function("0", :u, :v)
Fx = parse_function("0", :x, :y, :z)
Fy = parse_function("0", :x, :y, :z)
Fz = parse_function("0", :x, :y, :z)
end
us = LinRange(u_min, u_max, N)
value_(g, u::LinRange) = g.(u)
value_(g, u::Number) = g(u)
vs = @eval (LinRange(minimum($value_($v_min, $us)), maximum($value_($v_max, $us)), $N))
check(u, v, f) = @eval($value_($v_min, $u) <= $v && $value_($v_max, $u) >= $v ? $f($u, $v) : NaN)
value(g) = check.(us', vs, g)
x1 = @eval ($value($X))
y1 = @eval ($value($Y))
z1 = @eval ($value($Z))
return @eval($graph_all($x1, $y1, $z1, $Fx, $Fy, $Fz,
minimum(filter(!isnan, $x1)), maximum(filter(!isnan, $x1)),
minimum(filter(!isnan, $y1)), maximum(filter(!isnan, $y1)),
minimum(filter(!isnan, $z1)), maximum(filter(!isnan, $z1)), $density))
end
else # ______________________________________________f(x,y)
Fx = Fy = Fz = "_"
try
x_min = parse_num(x_min)
x_max = parse_num(x_max)
y_min = parse_function(y_min, :x)
y_max = parse_function(y_max, :x)
z_min = parse_function(z_min, :x, :y)
z_max = parse_function(z_max, :x, :y)
Fx = parse_function(F1, :x, :y, :z)
Fy = parse_function(F2, :x, :y, :z)
Fz = parse_function(F3, :x, :y, :z)
@eval (isa($Fx(-2, -2, -2), Number))
@eval (isa($Fy(-2, -2, -2), Number))
@eval (isa($Fz(-2, -2, -2), Number))
catch e
x_min = -2
y_min = parse_function("-2", :x)
z_min = parse_function("-2", :x, :y)
x_max = 2
y_max = parse_function("2", :x)
z_max = parse_function("2", :x, :y)
Fx = parse_function("0", :x, :y, :z)
Fy = parse_function("0", :x, :y, :z)
Fz = parse_function("0", :x, :y, :z)
end
if false #(x_min > x_max) | (y_min > y_max) | (z_min > z_max)
return Plot(surface(;
x = [0],
y = [0],
z = [[0], [0]]))
else
xs = LinRange(x_min, x_max, N)
value2_(g::Function, x::LinRange{Float64}) = g.(x)
value2_(g::Function, x::Number) = g(x)
ys = @eval (LinRange(minimum($value2_($y_min, $xs)), maximum($value2_($y_max, $xs)), $N))
check2(x::Number, y::Number, h::Function)::Float64 = @eval($value2_($y_min, $x) <= $y && $value2_($y_max, $x) >= $y ? $h($x, $y) : NaN)
value2(g) = check2.(xs', ys, g)
zs = @eval($value2($z_max))
z₀ = @eval($value2($z_min))
temp = deepcopy(zs)
zs[zs .< z₀] .= NaN
z₀[z₀ .> temp] .= NaN
return @eval($graph_all($xs, $ys, $zs, $Fx, $Fy, $Fz,
minimum($xs), maximum($xs),
minimum(filter(!isnan, $ys)), maximum(filter(!isnan, $ys)),
minimum(filter(!isnan, $z₀)), maximum(filter(!isnan, $zs)), $density, $z₀))
end
end
end
run_server(app, "0.0.0.0")
| [
3500,
16189,
198,
3500,
16189,
14055,
7293,
3906,
198,
3500,
16189,
39,
20369,
7293,
3906,
198,
3500,
28114,
306,
20120,
198,
17256,
7203,
34500,
1373,
18274,
4487,
13,
20362,
4943,
198,
17256,
7203,
38,
2416,
722,
18274,
4487,
13,
20362,
4943,
198,
3500,
764,
34500,
1373,
18274,
4487,
198,
3500,
764,
38,
2416,
722,
18274,
4487,
628,
198,
11018,
73,
897,
796,
366,
5450,
1378,
32341,
8457,
13,
17721,
2704,
533,
13,
785,
14,
1228,
897,
14,
8019,
82,
14,
11018,
73,
897,
14,
17,
13,
22,
13,
19,
14,
37372,
41,
897,
13,
8457,
30,
11250,
28,
49568,
12,
44,
5805,
12,
2390,
62,
3398,
51,
5805,
1,
198,
1324,
796,
14470,
7,
22615,
62,
47720,
258,
1039,
28,
14692,
5450,
1378,
19815,
538,
268,
13,
952,
14,
354,
81,
1638,
4464,
14,
3617,
14,
65,
54,
43,
86,
70,
47,
13,
25471,
33116,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6798,
62,
43551,
2625,
19668,
1600,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
7097,
62,
46521,
41888,
11018,
73,
897,
12962,
198,
198,
25811,
62,
796,
14631,
50,
25,
374,
7,
84,
11,
410,
42501,
366,
50,
25,
1976,
796,
277,
7,
87,
11,
331,
828,
331,
796,
308,
7,
87,
8,
8973,
628,
198,
1324,
13,
39786,
796,
27711,
62,
7146,
3419,
466,
198,
220,
220,
220,
27711,
62,
7146,
7,
17197,
796,
685,
198,
220,
220,
220,
27711,
62,
71,
16,
7203,
59,
3,
59,
3,
6852,
5239,
90,
14214,
2550,
4132,
30691,
28260,
32239,
3,
59,
3,
1600,
3918,
28,
35,
713,
7203,
5239,
2348,
570,
1,
5218,
366,
16159,
1600,
366,
36153,
1,
5218,
366,
18,
4,
4943,
828,
198,
220,
220,
220,
27711,
62,
7146,
7,
312,
2625,
25677,
1600,
198,
220,
220,
220,
220,
220,
220,
220,
1751,
41888,
198,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
71,
18,
7,
312,
2625,
25677,
62,
71,
18,
1600,
37082,
3,
59,
3,
26867,
5239,
90,
15496,
11,
1309,
262,
1257,
2221,
0,
32239,
3,
59,
3,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2361,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10612,
198,
220,
220,
220,
27711,
62,
11840,
7,
7635,
28,
35,
713,
7203,
20192,
9126,
1,
5218,
366,
16,
8416,
37901,
1303,
67,
3388,
66,
17,
69,
4943,
828,
198,
220,
220,
220,
27711,
62,
7146,
7,
312,
2625,
42029,
1600,
1751,
41888,
198,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
42029,
62,
18242,
1600,
37082,
3,
59,
3,
6852,
5239,
90,
31851,
262,
835,
286,
16215,
262,
4417,
25,
32239,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
14781,
2902,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4686,
796,
366,
14781,
2902,
1600,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3689,
796,
47527,
18242,
796,
1312,
11,
1988,
796,
1312,
8,
329,
1312,
287,
3689,
62,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
796,
3689,
62,
58,
16,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10612,
198,
220,
220,
220,
2361,
828,
198,
220,
220,
220,
27711,
62,
11840,
7,
7635,
28,
35,
713,
7203,
20192,
9126,
1,
5218,
366,
16,
8416,
37901,
1303,
67,
3388,
66,
17,
69,
4943,
828,
198,
220,
220,
220,
27711,
62,
7146,
7,
312,
2625,
12417,
1600,
1751,
41888,
198,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
7146,
7,
312,
2625,
15414,
82,
1600,
1751,
41888,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
31364,
62,
3245,
62,
75,
1600,
37082,
3,
59,
3,
6852,
5239,
90,
17469,
534,
15879,
2214,
10451,
32239,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
7146,
7,
312,
2625,
3245,
1600,
1751,
41888,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
76,
37,
87,
1600,
37082,
3,
59,
3,
6852,
35138,
90,
37,
92,
6852,
10210,
313,
6852,
5183,
90,
72,
32239,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
37,
87,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
87,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
76,
37,
88,
1600,
37082,
3,
59,
3,
6852,
35138,
90,
37,
92,
6852,
10210,
313,
6852,
5183,
90,
73,
32239,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
37,
88,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
88,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
76,
37,
89,
1600,
37082,
3,
59,
3,
6852,
35138,
90,
37,
92,
6852,
10210,
313,
6852,
5183,
90,
74,
32239,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
37,
89,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
89,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2361,
198,
220,
220,
220,
220,
220,
220,
220,
10612,
198,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
24396,
62,
14781,
2902,
1600,
37082,
3,
59,
3,
6852,
5239,
90,
31851,
2446,
286,
35575,
11812,
25,
32239,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
14781,
2902,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4686,
796,
366,
24396,
1600,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3689,
796,
47527,
18242,
796,
1312,
11,
1988,
796,
1312,
8,
329,
1312,
287,
5855,
8890,
8430,
1600,
366,
9069,
660,
40089,
4943,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
796,
366,
8890,
8430,
1,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10612,
198,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
4134,
333,
560,
1600,
37082,
3,
59,
3,
6852,
5239,
90,
31851,
262,
9922,
286,
35575,
11812,
25,
32239,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
6649,
1304,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4686,
796,
366,
18908,
1373,
62,
4134,
23843,
1600,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
949,
796,
838,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3509,
796,
1802,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
8849,
796,
360,
713,
26933,
13940,
23650,
7,
85,
8,
5218,
38357,
7,
85,
8,
329,
410,
287,
838,
25,
940,
25,
3064,
46570,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
796,
838,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2239,
796,
838,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10612,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
7146,
7,
312,
2625,
17143,
19482,
62,
65,
3733,
1600,
1751,
41888,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
81,
16,
23912,
1600,
37082,
3,
59,
3,
6852,
35138,
90,
81,
92,
7,
84,
11,
410,
8,
6852,
10210,
313,
6852,
5183,
90,
72,
92,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
81,
16,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
31166,
17034,
7,
16,
14,
19,
1343,
334,
61,
17,
8,
1635,
8615,
7,
85,
8,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
81,
17,
23912,
1600,
37082,
3,
59,
3,
6852,
35138,
90,
81,
92,
7,
84,
11,
410,
8,
6852,
10210,
313,
6852,
5183,
90,
73,
92,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
81,
17,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
31166,
17034,
7,
16,
14,
19,
1343,
334,
61,
17,
8,
1635,
7813,
7,
85,
8,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
81,
18,
23912,
1600,
37082,
3,
59,
3,
6852,
35138,
90,
81,
92,
7,
84,
11,
410,
8,
6852,
10210,
313,
6852,
5183,
90,
74,
92,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
81,
18,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
84,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
84,
62,
9521,
16,
1600,
37082,
3,
59,
3,
84,
23330,
1084,
92,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
84,
62,
9521,
16,
72,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
12,
16,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
84,
62,
9521,
17,
1600,
37082,
3,
59,
3,
84,
23330,
9806,
92,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
84,
62,
9521,
17,
72,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
16,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
85,
62,
9521,
16,
1600,
37082,
3,
59,
3,
6852,
34846,
7,
84,
8,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
85,
62,
9521,
16,
72,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
15,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
85,
62,
9521,
17,
1600,
37082,
3,
59,
3,
6852,
1169,
8326,
7,
84,
8,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
85,
62,
9521,
17,
72,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
17,
14415,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
16589,
3918,
28,
35,
713,
7203,
13812,
1,
5218,
366,
25928,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10612,
198,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
7146,
7,
312,
2625,
69,
5431,
62,
65,
3733,
1600,
1751,
41888,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
87,
62,
9521,
16,
1600,
37082,
3,
59,
3,
87,
23330,
6852,
5239,
90,
1084,
11709,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
87,
62,
9521,
16,
72,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
12,
17,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
87,
62,
9521,
17,
1600,
37082,
3,
59,
3,
2124,
23330,
6852,
5239,
90,
9806,
11709,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
87,
62,
9521,
17,
72,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
18,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
88,
62,
9521,
16,
1600,
37082,
3,
59,
3,
26867,
89,
17167,
7,
87,
8,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
88,
62,
9521,
16,
72,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
12,
17,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
88,
62,
9521,
17,
1600,
37082,
3,
59,
3,
26867,
17167,
7,
87,
8,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
88,
62,
9521,
17,
72,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
17,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
89,
62,
9521,
16,
1600,
37082,
3,
59,
3,
277,
7,
87,
11,
331,
8,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
89,
62,
9521,
16,
72,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
30420,
87,
61,
17,
1343,
331,
61,
17,
8,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
89,
62,
9521,
17,
1600,
37082,
3,
59,
3,
308,
7,
87,
11,
331,
8,
796,
59,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
15414,
7,
312,
2625,
89,
62,
9521,
17,
72,
1600,
2099,
2625,
5239,
1600,
1988,
2625,
87,
61,
17,
10,
88,
61,
17,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
16589,
3918,
28,
35,
713,
7203,
13812,
1,
5218,
366,
23108,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10612,
27711,
62,
16539,
7,
312,
796,
366,
46002,
12,
16539,
12,
5219,
1600,
1751,
796,
366,
46002,
1600,
299,
62,
565,
3378,
796,
657,
828,
198,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
7146,
7,
312,
2625,
22915,
62,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
2361,
828,
198,
220,
220,
220,
27711,
62,
7146,
7,
312,
2625,
70,
2416,
722,
1600,
1751,
41888,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
34960,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4686,
796,
366,
42029,
62,
29487,
1600,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3785,
796,
357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1366,
796,
685,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
357,
87,
796,
685,
15,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
331,
796,
685,
15,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
796,
16410,
15,
4357,
685,
15,
60,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2099,
796,
366,
42029,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
16589,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
12461,
796,
357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
44619,
1096,
28,
9562,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
9647,
28,
8054,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6001,
28,
8054,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1267,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1267,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10612,
198,
220,
220,
220,
220,
220,
220,
220,
2361,
198,
220,
220,
220,
10612,
198,
46570,
198,
6494,
62,
7146,
7,
312,
2625,
29487,
62,
1078,
7657,
1600,
198,
220,
220,
220,
1751,
41888,
198,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
3245,
62,
43337,
62,
23912,
1600,
37082,
3,
59,
3,
6852,
5239,
90,
31851,
262,
12109,
286,
262,
15879,
2214,
13,
32239,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
6649,
1304,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4686,
796,
366,
3245,
62,
43337,
1600,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
949,
796,
657,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3509,
796,
837,
940,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
8849,
796,
360,
713,
26933,
13940,
23650,
7,
85,
8,
5218,
38357,
7,
85,
8,
329,
410,
287,
657,
25,
16,
25,
940,
46570,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
796,
642,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2239,
796,
352,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10612,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
27711,
62,
18242,
7,
312,
2625,
34960,
62,
4134,
23843,
62,
23912,
1600,
37082,
3,
59,
3,
6852,
5239,
90,
31851,
262,
9922,
286,
29353,
13,
32239,
3,
59,
3,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
288,
535,
62,
6649,
1304,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4686,
796,
366,
34960,
62,
4134,
23843,
1600,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
949,
796,
838,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3509,
796,
1802,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
8849,
796,
360,
713,
26933,
13940,
23650,
7,
85,
8,
5218,
38357,
7,
85,
8,
329,
410,
287,
838,
25,
940,
25,
3064,
46570,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
796,
1160,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2239,
796,
838,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1267,
198,
220,
220,
220,
2361,
198,
828,
27711,
62,
5898,
263,
7203,
59,
3,
59,
3,
6852,
5239,
90,
36393,
13789,
27422,
26867,
26867,
5239,
90,
12038,
11,
10373,
11,
20553,
13,
32239,
3,
59,
3,
1600,
3918,
28,
35,
713,
7203,
36153,
9126,
1,
5218,
366,
18,
368,
1600,
366,
5239,
2348,
570,
1,
5218,
366,
16159,
48774,
198,
12962,
198,
437,
198,
198,
47423,
0,
7,
1324,
11,
198,
220,
220,
220,
220,
220,
220,
220,
25235,
7203,
17143,
19482,
62,
65,
3733,
1600,
366,
7635,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
25235,
7203,
69,
5431,
62,
65,
3733,
1600,
366,
7635,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
23412,
7203,
14781,
2902,
1600,
366,
8367,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
1267,
466,
2836,
62,
25541,
198,
220,
220,
220,
220,
220,
220,
220,
611,
2836,
62,
25541,
6624,
3689,
62,
58,
16,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
360,
713,
7203,
13812,
1,
5218,
366,
25928,
12340,
360,
713,
7203,
13812,
1,
5218,
366,
23108,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
360,
713,
7203,
13812,
1,
5218,
366,
23108,
12340,
360,
713,
7203,
13812,
1,
5218,
366,
25928,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
437,
628,
198,
47423,
0,
7,
1324,
11,
198,
220,
220,
220,
220,
220,
220,
220,
25235,
7203,
22915,
62,
1600,
366,
17197,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
23412,
7203,
46002,
12,
16539,
12,
5219,
1600,
366,
77,
62,
565,
3378,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
14781,
2902,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
81,
16,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
81,
17,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
81,
18,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
37,
87,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
37,
88,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
37,
89,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
24396,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
18908,
1373,
62,
4134,
23843,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
84,
62,
9521,
16,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
84,
62,
9521,
17,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
85,
62,
9521,
16,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
85,
62,
9521,
17,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
87,
62,
9521,
16,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
87,
62,
9521,
17,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
88,
62,
9521,
16,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
88,
62,
9521,
17,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
89,
62,
9521,
16,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
89,
62,
9521,
17,
72,
1600,
366,
8367,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
1267,
466,
299,
62,
565,
3378,
11,
4268,
2902,
62,
8367,
11,
374,
16,
11,
374,
17,
11,
374,
18,
11,
376,
87,
11,
376,
88,
11,
376,
89,
11,
8173,
11,
299,
11,
334,
62,
1084,
11,
334,
62,
9806,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
410,
62,
1084,
11,
410,
62,
9806,
11,
2124,
62,
1084,
11,
2124,
62,
9806,
11,
331,
62,
1084,
11,
331,
62,
9806,
11,
1976,
62,
1084,
11,
1976,
62,
9806,
198,
220,
220,
220,
220,
220,
220,
220,
611,
4268,
2902,
62,
8367,
6624,
3689,
62,
58,
16,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1949,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
62,
1084,
11,
334,
62,
9806,
796,
21136,
62,
22510,
12195,
58,
84,
62,
1084,
11,
334,
62,
9806,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
279,
796,
21136,
62,
8818,
7,
22179,
7,
14692,
14692,
1635,
374,
16,
11,
374,
17,
11,
374,
18,
1635,
8973,
1,
16589,
33172,
366,
828,
1058,
84,
11,
1058,
85,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10662,
796,
21136,
62,
8818,
7,
22179,
7,
14692,
14692,
1635,
376,
87,
11,
376,
88,
11,
376,
89,
1635,
366,
30866,
4357,
33172,
366,
828,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
18074,
243,
796,
21136,
62,
8818,
7,
85,
62,
1084,
11,
1058,
84,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
18074,
230,
796,
21136,
62,
8818,
7,
85,
62,
9806,
11,
1058,
84,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
7,
69,
11,
308,
11,
257,
11,
275,
8,
796,
2835,
62,
22468,
7,
138,
99,
7,
69,
11,
308,
11,
357,
84,
62,
1084,
11,
334,
62,
9806,
828,
257,
11,
275,
26,
399,
796,
2558,
7,
77,
6184,
115,
362,
828,
8173,
796,
8173,
828,
352,
68,
12,
18,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
62,
796,
2488,
18206,
2352,
7,
16763,
8367,
16763,
80,
11,
720,
79,
11,
720,
139,
243,
11,
720,
139,
230,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
27711,
62,
71,
20,
7203,
91,
138,
99,
91,
796,
29568,
8367,
62,
21387,
11,
3918,
28,
35,
713,
7203,
5239,
2348,
570,
1,
5218,
366,
16159,
48774,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4929,
304,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
27711,
62,
71,
20,
7203,
59,
3,
59,
3,
6852,
5239,
90,
39213,
506,
5128,
13,
9993,
757,
13,
32239,
3,
59,
3,
1600,
3918,
28,
35,
713,
7203,
5239,
2348,
570,
1,
5218,
366,
16159,
48774,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1949,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
62,
1084,
11,
2124,
62,
9806,
796,
21136,
62,
22510,
12195,
58,
87,
62,
1084,
11,
2124,
62,
9806,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10662,
796,
21136,
62,
8818,
7,
22179,
7,
14692,
14692,
1635,
376,
87,
11,
376,
88,
11,
376,
89,
1635,
366,
30866,
4357,
33172,
366,
828,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
18074,
243,
796,
21136,
62,
8818,
7,
88,
62,
1084,
11,
1058,
87,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
18074,
230,
796,
21136,
62,
8818,
7,
88,
62,
9806,
11,
1058,
87,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
18074,
223,
796,
21136,
62,
8818,
7,
89,
62,
1084,
11,
1058,
87,
11,
1058,
88,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
7377,
115,
796,
21136,
62,
8818,
7,
89,
62,
9806,
11,
1058,
87,
11,
1058,
88,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
7,
69,
11,
257,
11,
275,
11,
269,
11,
288,
8,
796,
2835,
62,
22468,
7,
138,
99,
7,
69,
11,
357,
87,
62,
1084,
11,
2124,
62,
9806,
828,
257,
11,
275,
11,
269,
11,
288,
26,
399,
796,
2558,
7,
77,
6184,
115,
362,
828,
8173,
796,
8173,
828,
352,
68,
12,
18,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
62,
796,
2488,
18206,
2352,
7,
16763,
8367,
16763,
80,
11,
720,
33643,
11,
720,
138,
115,
11,
720,
139,
243,
11,
720,
139,
230,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
27711,
62,
71,
20,
7203,
91,
138,
99,
91,
796,
29568,
8367,
62,
21387,
11,
3918,
28,
35,
713,
7203,
5239,
2348,
570,
1,
5218,
366,
16159,
48774,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4929,
304,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
27711,
62,
71,
20,
7203,
59,
3,
59,
3,
26867,
5239,
90,
39213,
506,
5128,
13,
9993,
757,
44587,
3467,
3,
59,
3,
1600,
3918,
28,
35,
713,
7203,
5239,
2348,
570,
1,
5218,
366,
16159,
48774,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
437,
628,
198,
47423,
0,
7,
1324,
11,
198,
220,
220,
220,
220,
220,
220,
220,
25235,
7203,
42029,
62,
29487,
1600,
366,
26875,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
23412,
7203,
46002,
12,
16539,
12,
5219,
1600,
366,
77,
62,
565,
3378,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
81,
16,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
81,
17,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
81,
18,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
14781,
2902,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
34960,
62,
4134,
23843,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
84,
62,
9521,
16,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
84,
62,
9521,
17,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
85,
62,
9521,
16,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
85,
62,
9521,
17,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
87,
62,
9521,
16,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
87,
62,
9521,
17,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
88,
62,
9521,
16,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
88,
62,
9521,
17,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
89,
62,
9521,
16,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
89,
62,
9521,
17,
72,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
37,
87,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
37,
88,
1600,
366,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
37,
89,
2430,
8367,
12340,
198,
220,
220,
220,
220,
220,
220,
220,
1812,
7203,
3245,
62,
43337,
1600,
366,
8367,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
1267,
466,
299,
62,
565,
3378,
11,
374,
16,
11,
374,
17,
11,
374,
18,
11,
4268,
2902,
62,
8367,
11,
399,
11,
334,
62,
1084,
11,
334,
62,
9806,
11,
410,
62,
1084,
11,
410,
62,
9806,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
62,
1084,
11,
2124,
62,
9806,
11,
331,
62,
1084,
11,
331,
62,
9806,
11,
1976,
62,
1084,
11,
1976,
62,
9806,
11,
376,
16,
11,
376,
17,
11,
376,
18,
11,
12109,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
4268,
2902,
62,
8367,
6624,
3689,
62,
58,
16,
60,
1303,
220,
2602,
37405,
17143,
19482,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1949,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
62,
1084,
796,
21136,
62,
22510,
7,
84,
62,
1084,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
62,
9806,
796,
21136,
62,
22510,
7,
84,
62,
9806,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
410,
62,
1084,
796,
21136,
62,
8818,
7,
85,
62,
1084,
11,
1058,
84,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
410,
62,
9806,
796,
21136,
62,
8818,
7,
85,
62,
9806,
11,
1058,
84,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4929,
304,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
62,
1084,
796,
532,
16,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
334,
62,
9806,
796,
352,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
410,
62,
1084,
796,
21136,
62,
8818,
7203,
15,
1600,
1058,
84,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
410,
62,
9806,
796,
21136,
62,
8818,
7203,
17,
14415,
1600,
1058,
84,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
3991,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
28114,
7,
42029,
7,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
796,
685,
15,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
331,
796,
685,
15,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
796,
16410,
15,
4357,
685,
15,
11907,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
87,
796,
376,
88,
796,
376,
89,
796,
45434,
1,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1395,
7,
84,
11,
410,
8,
796,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
575,
7,
84,
11,
410,
8,
796,
657,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1168,
7,
84,
11,
410,
8,
796,
657,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1949,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1395,
796,
21136,
62,
8818,
7,
81,
16,
11,
1058,
84,
11,
1058,
85,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
575,
796,
21136,
62,
8818,
7,
81,
17,
11,
1058,
84,
11,
1058,
85,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1168,
796,
21136,
62,
8818,
7,
81,
18,
11,
1058,
84,
11,
1058,
85,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
87,
796,
21136,
62,
8818,
7,
37,
16,
11,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
88,
796,
21136,
62,
8818,
7,
37,
17,
11,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
89,
796,
21136,
62,
8818,
7,
37,
18,
11,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
18206,
7198,
55,
32590,
17,
11,
513,
828,
720,
56,
32590,
17,
11,
513,
828,
720,
57,
32590,
17,
11,
513,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
18206,
357,
9160,
16763,
55,
32590,
17,
11,
513,
828,
15690,
90,
43879,
2414,
11,
352,
92,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
18206,
357,
9160,
16763,
56,
32590,
17,
11,
513,
828,
15690,
90,
43879,
2414,
11,
352,
92,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
18206,
357,
9160,
16763,
57,
32590,
17,
11,
513,
828,
15690,
90,
43879,
2414,
11,
352,
92,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
18206,
357,
9160,
16763,
37,
87,
32590,
17,
11,
532,
17,
11,
532,
17,
828,
7913,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
18206,
357,
9160,
16763,
37,
88,
32590,
17,
11,
532,
17,
11,
532,
17,
828,
7913,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
18206,
357,
9160,
16763,
37,
89,
32590,
17,
11,
532,
17,
11,
532,
17,
828,
7913,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4929,
304,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1395,
796,
21136,
62,
8818,
7203,
15,
1600,
1058,
84,
11,
1058,
85,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
575,
796,
21136,
62,
8818,
7203,
15,
1600,
1058,
84,
11,
1058,
85,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1168,
796,
21136,
62,
8818,
7203,
15,
1600,
1058,
84,
11,
1058,
85,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
87,
796,
21136,
62,
8818,
7203,
15,
1600,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
88,
796,
21136,
62,
8818,
7203,
15,
1600,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
89,
796,
21136,
62,
8818,
7203,
15,
1600,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
514,
796,
5164,
17257,
7,
84,
62,
1084,
11,
334,
62,
9806,
11,
399,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
41052,
70,
11,
334,
3712,
14993,
17257,
8,
796,
308,
12195,
84,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
41052,
70,
11,
334,
3712,
15057,
8,
796,
308,
7,
84,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
3691,
796,
2488,
18206,
357,
14993,
17257,
7,
39504,
16763,
8367,
62,
16763,
85,
62,
1084,
11,
720,
385,
36911,
5415,
16763,
8367,
62,
16763,
85,
62,
9806,
11,
720,
385,
36911,
720,
45,
4008,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2198,
7,
84,
11,
410,
11,
277,
8,
796,
2488,
18206,
16763,
8367,
62,
16763,
85,
62,
1084,
11,
720,
84,
8,
19841,
720,
85,
11405,
720,
8367,
62,
16763,
85,
62,
9806,
11,
720,
84,
8,
18189,
720,
85,
5633,
720,
69,
16763,
84,
11,
720,
85,
8,
1058,
11013,
45,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
7,
70,
8,
796,
2198,
12195,
385,
3256,
3691,
11,
308,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
16,
796,
2488,
18206,
7198,
8367,
16763,
55,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
331,
16,
796,
2488,
18206,
7198,
8367,
16763,
56,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
16,
796,
2488,
18206,
7198,
8367,
16763,
57,
4008,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
2488,
18206,
16763,
34960,
62,
439,
16763,
87,
16,
11,
720,
88,
16,
11,
720,
89,
16,
11,
720,
37,
87,
11,
720,
37,
88,
11,
720,
37,
89,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5288,
7,
24455,
7,
0,
271,
12647,
11,
720,
87,
16,
36911,
5415,
7,
24455,
7,
0,
271,
12647,
11,
720,
87,
16,
36911,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5288,
7,
24455,
7,
0,
271,
12647,
11,
720,
88,
16,
36911,
5415,
7,
24455,
7,
0,
271,
12647,
11,
720,
88,
16,
36911,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5288,
7,
24455,
7,
0,
271,
12647,
11,
720,
89,
16,
36911,
5415,
7,
24455,
7,
0,
271,
12647,
11,
720,
89,
16,
36911,
720,
43337,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
220,
1303,
220,
10221,
2602,
25947,
69,
7,
87,
11,
88,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
87,
796,
376,
88,
796,
376,
89,
796,
45434,
1,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1949,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
62,
1084,
796,
21136,
62,
22510,
7,
87,
62,
1084,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
62,
9806,
796,
21136,
62,
22510,
7,
87,
62,
9806,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
331,
62,
1084,
796,
21136,
62,
8818,
7,
88,
62,
1084,
11,
1058,
87,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
331,
62,
9806,
796,
21136,
62,
8818,
7,
88,
62,
9806,
11,
1058,
87,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
62,
1084,
796,
21136,
62,
8818,
7,
89,
62,
1084,
11,
1058,
87,
11,
1058,
88,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
62,
9806,
796,
21136,
62,
8818,
7,
89,
62,
9806,
11,
1058,
87,
11,
1058,
88,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
87,
796,
21136,
62,
8818,
7,
37,
16,
11,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
88,
796,
21136,
62,
8818,
7,
37,
17,
11,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
89,
796,
21136,
62,
8818,
7,
37,
18,
11,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
18206,
357,
9160,
16763,
37,
87,
32590,
17,
11,
532,
17,
11,
532,
17,
828,
7913,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
18206,
357,
9160,
16763,
37,
88,
32590,
17,
11,
532,
17,
11,
532,
17,
828,
7913,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
18206,
357,
9160,
16763,
37,
89,
32590,
17,
11,
532,
17,
11,
532,
17,
828,
7913,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4929,
304,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
62,
1084,
796,
532,
17,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
331,
62,
1084,
796,
21136,
62,
8818,
7203,
12,
17,
1600,
1058,
87,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
62,
1084,
796,
21136,
62,
8818,
7203,
12,
17,
1600,
1058,
87,
11,
1058,
88,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
62,
9806,
796,
362,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
331,
62,
9806,
796,
21136,
62,
8818,
7203,
17,
1600,
1058,
87,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
62,
9806,
796,
21136,
62,
8818,
7203,
17,
1600,
1058,
87,
11,
1058,
88,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
87,
796,
21136,
62,
8818,
7203,
15,
1600,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
88,
796,
21136,
62,
8818,
7203,
15,
1600,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
376,
89,
796,
21136,
62,
8818,
7203,
15,
1600,
1058,
87,
11,
1058,
88,
11,
1058,
89,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
3991,
220,
1303,
7,
87,
62,
1084,
1875,
2124,
62,
9806,
8,
930,
357,
88,
62,
1084,
1875,
331,
62,
9806,
8,
930,
357,
89,
62,
1084,
1875,
1976,
62,
9806,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
28114,
7,
42029,
7,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
796,
685,
15,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
331,
796,
685,
15,
4357,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
796,
16410,
15,
4357,
685,
15,
11907,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2124,
82,
796,
5164,
17257,
7,
87,
62,
1084,
11,
2124,
62,
9806,
11,
399,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
17,
41052,
70,
3712,
22203,
11,
2124,
3712,
14993,
17257,
90,
43879,
2414,
30072,
796,
308,
12195,
87,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
17,
41052,
70,
3712,
22203,
11,
2124,
3712,
15057,
8,
796,
308,
7,
87,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
331,
82,
796,
2488,
18206,
357,
14993,
17257,
7,
39504,
16763,
8367,
17,
62,
16763,
88,
62,
1084,
11,
720,
34223,
36911,
5415,
16763,
8367,
17,
62,
16763,
88,
62,
9806,
11,
720,
34223,
36911,
720,
45,
4008,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2198,
17,
7,
87,
3712,
15057,
11,
331,
3712,
15057,
11,
289,
3712,
22203,
2599,
25,
43879,
2414,
796,
2488,
18206,
16763,
8367,
17,
62,
16763,
88,
62,
1084,
11,
720,
87,
8,
19841,
720,
88,
11405,
720,
8367,
17,
62,
16763,
88,
62,
9806,
11,
720,
87,
8,
18189,
720,
88,
5633,
720,
71,
16763,
87,
11,
720,
88,
8,
1058,
11013,
45,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1988,
17,
7,
70,
8,
796,
2198,
17,
12195,
34223,
3256,
331,
82,
11,
308,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
82,
796,
2488,
18206,
16763,
8367,
17,
16763,
89,
62,
9806,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
158,
224,
222,
796,
2488,
18206,
16763,
8367,
17,
16763,
89,
62,
1084,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
20218,
796,
2769,
30073,
7,
89,
82,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
82,
58,
89,
82,
764,
27,
1976,
158,
224,
222,
60,
764,
28,
11013,
45,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1976,
158,
224,
222,
58,
89,
158,
224,
222,
764,
29,
20218,
60,
764,
28,
11013,
45,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
2488,
18206,
16763,
34960,
62,
439,
16763,
34223,
11,
720,
893,
11,
720,
89,
82,
11,
720,
37,
87,
11,
720,
37,
88,
11,
720,
37,
89,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5288,
16763,
34223,
828,
5415,
16763,
34223,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5288,
7,
24455,
7,
0,
271,
12647,
11,
720,
893,
36911,
5415,
7,
24455,
7,
0,
271,
12647,
11,
720,
893,
36911,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
5288,
7,
24455,
7,
0,
271,
12647,
11,
720,
89,
158,
224,
222,
36911,
5415,
7,
24455,
7,
0,
271,
12647,
11,
720,
89,
82,
36911,
720,
43337,
11,
720,
89,
158,
224,
222,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
628,
198,
5143,
62,
15388,
7,
1324,
11,
366,
15,
13,
15,
13,
15,
13,
15,
4943,
198
] | 1.663592 | 9,432 |
using SigmaRidgeRegression
using Test
using Random
import StatsBase
ar1_design = BlockCovarianceDesign([
AR1Design(;ρ=0.8),
AR1Design(;ρ=0.5)])
id_design = BlockCovarianceDesign([
IdentityCovarianceDesign(),
IdentityCovarianceDesign()])
grp1 = GroupedFeatures([2000,4000])
grp2 = GroupedFeatures([800,500])
for grp in [grp1; grp2]
for _design in [ar1_design; id_design]
_design = set_groups(_design, grp)
_n = 2000
_γs = grp.ps ./ _n
_λs = [2.0; 0.4]
_αs = [1.0; 7.0]
theory_risk = @show SigmaRidgeRegression.risk_formula(spectrum.(_design.blocks), _γs, _αs, _λs)
_ridge_sim = GroupRidgeSimulationSettings(;
groups=grp,
ntrain=_n,
ntest=20_000,
Σ=_design,
response_model=RandomLinearResponseModel(; αs=_αs, grp=grp),
)
Random.seed!(1)
_sim_res = simulate(_ridge_sim)
_X_train = _sim_res.X[_sim_res.resampling_idx[1][1],:]
_Y_train = _sim_res.Y[_sim_res.resampling_idx[1][1]]
_X_test = _sim_res.X[_sim_res.resampling_idx[1][2],:]
_Y_test = _sim_res.Y[_sim_res.resampling_idx[1][2]]
ridge_risk = mse_ridge(
StatsBase.fit(
MultiGroupRidgeRegressor(; groups=grp, λs=_λs, center=false, scale=false),
_X_train,
_Y_train,
grp,
),
_X_test,
_Y_test,
)
@test ridge_risk ≈ theory_risk atol =1.0
end
end
| [
3500,
31669,
49,
3130,
8081,
2234,
198,
3500,
6208,
198,
3500,
14534,
198,
11748,
20595,
14881,
198,
198,
283,
16,
62,
26124,
796,
9726,
34,
709,
2743,
590,
23067,
26933,
198,
220,
220,
220,
5923,
16,
23067,
7,
26,
33643,
28,
15,
13,
23,
828,
198,
220,
220,
220,
5923,
16,
23067,
7,
26,
33643,
28,
15,
13,
20,
8,
12962,
198,
198,
312,
62,
26124,
796,
9726,
34,
709,
2743,
590,
23067,
26933,
198,
220,
220,
220,
220,
220,
220,
220,
27207,
34,
709,
2743,
590,
23067,
22784,
198,
220,
220,
220,
220,
220,
220,
220,
27207,
34,
709,
2743,
590,
23067,
3419,
12962,
198,
198,
2164,
79,
16,
796,
4912,
276,
23595,
26933,
11024,
11,
27559,
12962,
198,
2164,
79,
17,
796,
4912,
276,
23595,
26933,
7410,
11,
4059,
12962,
198,
198,
1640,
1036,
79,
287,
685,
2164,
79,
16,
26,
1036,
79,
17,
60,
198,
220,
220,
220,
329,
4808,
26124,
287,
685,
283,
16,
62,
26124,
26,
4686,
62,
26124,
60,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
26124,
796,
900,
62,
24432,
28264,
26124,
11,
1036,
79,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
77,
796,
4751,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
42063,
82,
796,
1036,
79,
13,
862,
24457,
4808,
77,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
39377,
82,
796,
685,
17,
13,
15,
26,
657,
13,
19,
60,
628,
220,
220,
220,
220,
220,
220,
220,
4808,
17394,
82,
796,
685,
16,
13,
15,
26,
767,
13,
15,
60,
628,
220,
220,
220,
220,
220,
220,
220,
4583,
62,
19121,
796,
2488,
12860,
31669,
49,
3130,
8081,
2234,
13,
19121,
62,
687,
4712,
7,
4443,
6582,
12195,
62,
26124,
13,
27372,
828,
4808,
42063,
82,
11,
4808,
17394,
82,
11,
4808,
39377,
82,
8,
628,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
12818,
62,
14323,
796,
4912,
49,
3130,
8890,
1741,
26232,
7,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2628,
28,
2164,
79,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
299,
27432,
28,
62,
77,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
299,
9288,
28,
1238,
62,
830,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
7377,
96,
28,
62,
26124,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2882,
62,
19849,
28,
29531,
14993,
451,
31077,
17633,
7,
26,
26367,
82,
28,
62,
17394,
82,
11,
1036,
79,
28,
2164,
79,
828,
198,
220,
220,
220,
220,
220,
220,
220,
1267,
198,
220,
220,
220,
220,
220,
220,
220,
14534,
13,
28826,
0,
7,
16,
8,
628,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
14323,
62,
411,
796,
29308,
28264,
12818,
62,
14323,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
55,
62,
27432,
796,
4808,
14323,
62,
411,
13,
55,
29795,
14323,
62,
411,
13,
411,
321,
11347,
62,
312,
87,
58,
16,
7131,
16,
4357,
47715,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
56,
62,
27432,
796,
4808,
14323,
62,
411,
13,
56,
29795,
14323,
62,
411,
13,
411,
321,
11347,
62,
312,
87,
58,
16,
7131,
16,
11907,
628,
220,
220,
220,
220,
220,
220,
220,
4808,
55,
62,
9288,
796,
4808,
14323,
62,
411,
13,
55,
29795,
14323,
62,
411,
13,
411,
321,
11347,
62,
312,
87,
58,
16,
7131,
17,
4357,
47715,
198,
220,
220,
220,
220,
220,
220,
220,
4808,
56,
62,
9288,
796,
4808,
14323,
62,
411,
13,
56,
29795,
14323,
62,
411,
13,
411,
321,
11347,
62,
312,
87,
58,
16,
7131,
17,
11907,
628,
220,
220,
220,
220,
220,
220,
220,
32525,
62,
19121,
796,
285,
325,
62,
12818,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
20595,
14881,
13,
11147,
7,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
15237,
13247,
49,
3130,
8081,
44292,
7,
26,
2628,
28,
2164,
79,
11,
7377,
119,
82,
28,
62,
39377,
82,
11,
3641,
28,
9562,
11,
5046,
28,
9562,
828,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4808,
55,
62,
27432,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4808,
56,
62,
27432,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1036,
79,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
10612,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4808,
55,
62,
9288,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4808,
56,
62,
9288,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1267,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
32525,
62,
19121,
15139,
230,
4583,
62,
19121,
379,
349,
796,
16,
13,
15,
198,
220,
220,
220,
886,
198,
437,
198
] | 1.789354 | 883 |
"""
AbstractLattice
Contains information about a crystal lattice.
"""
abstract type AbstractLattice
end
"""
RealLattice{N}
Describes an N-dimensional real space crystal lattice, with an associated primitive and
conventional lattice. These lattices may be the same depending on the lattice type.
"""
struct RealLattice{N} <: AbstractLattice
# Primitive and conventional lattice vectors are stored together
prim::SVector{N,SVector{N,Float64}}
conv::SVector{N,SVector{N,Float64}}
end
# TODO: Implement lattice checking and conversion
# Some of this functionality might already be present in Crystalline.jl
# However, we need to be able to recognize primitive lattices with their own unique conditions
"""
nuniqlen(basis::AbstractVector{<:AbstractVector{<:Real}}) -> Int
Returns the number of vectors that are the same length.
"""
function nuniqlen(basis::AbstractVector{<:AbstractVector{<:Real}})
# unique!() does better than unique() here (per @btime)
return length(unique!(norm.(basis)))
end
# Same thing for matrices
nuniqlen(basis::AbstractMatrix{<:Real}) = nuniqlen(_tovectors(basis))
"""
northog(basis::AbstractVector{<:AbstractVector{<:Real}}) -> Int
Returns the number of pairs of orthogonal vectors.
"""
function northog(basis::AbstractVector{<:AbstractVector{<:Real}})
# FIXME: This doesn't work for arbitrary dimensions
# It needs to use the upper portion of the dot product matrix
return count(iszero, dot.(basis, basis[circshift(1:length(basis), 1)]))
end
northog(basis::AbstractMatrix{<:Real}) = northog(_tovectors(basis))
# TODO: Write a number of tests for checking if lattices meet certain criteria
#=
Criteria for primitive unit cells in 3 dimensions:
aP: 6 parameters (a, b, c, α, β, γ)
mP: 4 parameters (a, b, c, β), α = γ = 90°
mS: 4 parameters (a, c, α, γ), a = b, α = β
oP: 3 parameters (a, b, c), α = β = γ = 90°
oS: 3 parameters (a, c, γ), a = b, α = β = 90°
oI: 3 parameters (a, α, γ), a = b = c, |cos(α)| + |cos(β)| + |cos(γ)| = 1
oF: 3 parameters (a, b, c), sin(α)/a = sin(β)/b = sin(γ)/c, α + β + γ = 180°
3 parameters (a, c, γ), [forgot the rest of this alternate test]
tP: 2 parameters (a, c), a = b, α = β = γ = 90°
tI: 2 parameters (a, α), a = b = c, |cos(α)| + |cos(β)| + |cos(γ)| = 1
hP: 2 parameters (a, c), a = b, α = β = 90°, γ = 120°
hR: 2 parameters (a, α), a = b = c, α = β = γ
cP: 1 parameter (a), a = b = c, α = β = γ = 90°
cI: 1 parameter (a), a = b = c, α = β = γ = arccos(-1/3)°
cF: 1 parameter (a), a = b = c, α = β = γ = 60°
Rules that need to be checked:
Number of unique lengths
Number of orthogonal vectors
Number of unique angles
Cosine rule: |cos(α)| + |cos(β)| + |cos(γ)| = 1
Sine rule: sin(α)/a = sin(β)/b = sin(γ)/c, α + β + γ = 180°
The last three are probably going to be trickier to implement, or at the very least there
might be some unintuitive linear algebra tricks to make those checks happen faster.
=#
# TODO: what are the crtieria for a "good" lattice basis?
# Potentially worth looking at the Niggli reduction algorithm to do this
# TODO: Tools for working with reciprocal space lattices | [
37811,
198,
220,
220,
220,
27741,
43,
1078,
501,
198,
198,
4264,
1299,
1321,
546,
257,
15121,
47240,
501,
13,
198,
37811,
198,
397,
8709,
2099,
27741,
43,
1078,
501,
198,
437,
198,
198,
37811,
198,
220,
220,
220,
6416,
43,
1078,
501,
90,
45,
92,
198,
198,
24564,
22090,
281,
399,
12,
19577,
1103,
2272,
15121,
47240,
501,
11,
351,
281,
3917,
20049,
290,
220,
198,
1102,
20405,
47240,
501,
13,
2312,
47240,
1063,
743,
307,
262,
976,
6906,
319,
262,
47240,
501,
2099,
13,
198,
37811,
198,
7249,
6416,
43,
1078,
501,
90,
45,
92,
1279,
25,
27741,
43,
1078,
501,
198,
220,
220,
220,
1303,
11460,
1800,
290,
10224,
47240,
501,
30104,
389,
8574,
1978,
198,
220,
220,
220,
2684,
3712,
50,
38469,
90,
45,
11,
50,
38469,
90,
45,
11,
43879,
2414,
11709,
198,
220,
220,
220,
3063,
3712,
50,
38469,
90,
45,
11,
50,
38469,
90,
45,
11,
43879,
2414,
11709,
198,
437,
198,
198,
2,
16926,
46,
25,
48282,
47240,
501,
10627,
290,
11315,
198,
2,
2773,
286,
428,
11244,
1244,
1541,
307,
1944,
287,
8152,
32989,
500,
13,
20362,
198,
2,
2102,
11,
356,
761,
284,
307,
1498,
284,
7564,
20049,
47240,
1063,
351,
511,
898,
3748,
3403,
198,
198,
37811,
198,
220,
220,
220,
48157,
25011,
11925,
7,
12093,
271,
3712,
23839,
38469,
90,
27,
25,
23839,
38469,
90,
27,
25,
15633,
11709,
8,
4613,
2558,
198,
198,
35561,
262,
1271,
286,
30104,
326,
389,
262,
976,
4129,
13,
198,
37811,
198,
8818,
48157,
25011,
11925,
7,
12093,
271,
3712,
23839,
38469,
90,
27,
25,
23839,
38469,
90,
27,
25,
15633,
11709,
8,
198,
220,
220,
220,
1303,
3748,
0,
3419,
857,
1365,
621,
3748,
3419,
994,
357,
525,
2488,
65,
2435,
8,
198,
220,
220,
220,
1441,
4129,
7,
34642,
0,
7,
27237,
12195,
12093,
271,
22305,
198,
437,
198,
198,
2,
16766,
1517,
329,
2603,
45977,
198,
77,
403,
25011,
11925,
7,
12093,
271,
3712,
23839,
46912,
90,
27,
25,
15633,
30072,
796,
48157,
25011,
11925,
28264,
83,
659,
5217,
7,
12093,
271,
4008,
198,
198,
37811,
198,
220,
220,
220,
5093,
519,
7,
12093,
271,
3712,
23839,
38469,
90,
27,
25,
23839,
38469,
90,
27,
25,
15633,
11709,
8,
4613,
2558,
198,
198,
35561,
262,
1271,
286,
14729,
286,
29617,
519,
20996,
30104,
13,
198,
37811,
198,
8818,
5093,
519,
7,
12093,
271,
3712,
23839,
38469,
90,
27,
25,
23839,
38469,
90,
27,
25,
15633,
11709,
8,
198,
220,
220,
220,
1303,
44855,
11682,
25,
770,
1595,
470,
670,
329,
14977,
15225,
198,
220,
220,
220,
1303,
632,
2476,
284,
779,
262,
6727,
6903,
286,
262,
16605,
1720,
17593,
198,
220,
220,
220,
1441,
954,
7,
271,
22570,
11,
16605,
12195,
12093,
271,
11,
4308,
58,
21170,
30846,
7,
16,
25,
13664,
7,
12093,
271,
828,
352,
15437,
4008,
198,
437,
198,
198,
43588,
519,
7,
12093,
271,
3712,
23839,
46912,
90,
27,
25,
15633,
30072,
796,
5093,
519,
28264,
83,
659,
5217,
7,
12093,
271,
4008,
198,
198,
2,
16926,
46,
25,
19430,
257,
1271,
286,
5254,
329,
10627,
611,
47240,
1063,
1826,
1728,
9987,
198,
198,
2,
28,
198,
18559,
5142,
329,
20049,
4326,
4778,
287,
513,
15225,
25,
198,
220,
220,
220,
257,
47,
25,
718,
10007,
357,
64,
11,
275,
11,
269,
11,
26367,
11,
27169,
11,
7377,
111,
8,
198,
220,
220,
220,
285,
47,
25,
604,
10007,
357,
64,
11,
275,
11,
269,
11,
27169,
828,
26367,
796,
7377,
111,
796,
4101,
7200,
198,
220,
220,
220,
285,
50,
25,
604,
10007,
357,
64,
11,
269,
11,
26367,
11,
7377,
111,
828,
257,
796,
275,
11,
26367,
796,
27169,
198,
220,
220,
220,
267,
47,
25,
513,
10007,
357,
64,
11,
275,
11,
269,
828,
26367,
796,
27169,
796,
7377,
111,
796,
4101,
7200,
198,
220,
220,
220,
267,
50,
25,
513,
10007,
357,
64,
11,
269,
11,
7377,
111,
828,
257,
796,
275,
11,
26367,
796,
27169,
796,
4101,
7200,
198,
220,
220,
220,
267,
40,
25,
513,
10007,
357,
64,
11,
26367,
11,
7377,
111,
828,
257,
796,
275,
796,
269,
11,
930,
6966,
7,
17394,
14726,
1343,
930,
6966,
7,
26638,
14726,
1343,
930,
6966,
7,
42063,
14726,
796,
352,
198,
220,
220,
220,
267,
37,
25,
513,
10007,
357,
64,
11,
275,
11,
269,
828,
7813,
7,
17394,
20679,
64,
796,
7813,
7,
26638,
20679,
65,
796,
7813,
7,
42063,
20679,
66,
11,
26367,
1343,
27169,
1343,
7377,
111,
796,
11546,
7200,
198,
220,
220,
220,
220,
220,
220,
220,
513,
10007,
357,
64,
11,
269,
11,
7377,
111,
828,
685,
1640,
23442,
262,
1334,
286,
428,
13527,
1332,
60,
198,
220,
220,
220,
256,
47,
25,
362,
10007,
357,
64,
11,
269,
828,
257,
796,
275,
11,
26367,
796,
27169,
796,
7377,
111,
796,
4101,
7200,
198,
220,
220,
220,
256,
40,
25,
362,
10007,
357,
64,
11,
26367,
828,
257,
796,
275,
796,
269,
11,
930,
6966,
7,
17394,
14726,
1343,
930,
6966,
7,
26638,
14726,
1343,
930,
6966,
7,
42063,
14726,
796,
352,
198,
220,
220,
220,
289,
47,
25,
362,
10007,
357,
64,
11,
269,
828,
257,
796,
275,
11,
26367,
796,
27169,
796,
4101,
7200,
11,
7377,
111,
796,
7982,
7200,
198,
220,
220,
220,
289,
49,
25,
362,
10007,
357,
64,
11,
26367,
828,
257,
796,
275,
796,
269,
11,
26367,
796,
27169,
796,
7377,
111,
198,
220,
220,
220,
269,
47,
25,
352,
11507,
357,
64,
828,
257,
796,
275,
796,
269,
11,
26367,
796,
27169,
796,
7377,
111,
796,
4101,
7200,
198,
220,
220,
220,
269,
40,
25,
352,
11507,
357,
64,
828,
257,
796,
275,
796,
269,
11,
26367,
796,
27169,
796,
7377,
111,
796,
610,
535,
418,
32590,
16,
14,
18,
8,
7200,
198,
220,
220,
220,
269,
37,
25,
352,
11507,
357,
64,
828,
257,
796,
275,
796,
269,
11,
26367,
796,
27169,
796,
7377,
111,
796,
3126,
7200,
198,
198,
37766,
326,
761,
284,
307,
10667,
25,
198,
220,
220,
220,
7913,
286,
3748,
20428,
198,
220,
220,
220,
7913,
286,
29617,
519,
20996,
30104,
198,
220,
220,
220,
7913,
286,
3748,
18333,
198,
220,
220,
220,
10437,
500,
3896,
25,
930,
6966,
7,
17394,
14726,
1343,
930,
6966,
7,
26638,
14726,
1343,
930,
6966,
7,
42063,
14726,
796,
352,
198,
220,
220,
220,
311,
500,
3896,
25,
7813,
7,
17394,
20679,
64,
796,
7813,
7,
26638,
20679,
65,
796,
7813,
7,
42063,
20679,
66,
11,
26367,
1343,
27169,
1343,
7377,
111,
796,
11546,
7200,
198,
220,
220,
220,
220,
198,
220,
220,
220,
383,
938,
1115,
389,
2192,
1016,
284,
307,
6908,
959,
284,
3494,
11,
393,
379,
262,
845,
1551,
612,
198,
220,
220,
220,
1244,
307,
617,
17679,
33740,
14174,
37139,
15910,
284,
787,
883,
8794,
1645,
5443,
13,
198,
46249,
628,
198,
198,
2,
16926,
46,
25,
644,
389,
262,
1067,
24948,
544,
329,
257,
366,
11274,
1,
47240,
501,
4308,
30,
198,
2,
6902,
3746,
2861,
2045,
379,
262,
399,
6950,
4528,
7741,
11862,
284,
466,
428,
198,
198,
2,
16926,
46,
25,
20003,
329,
1762,
351,
48135,
2272,
47240,
1063
] | 2.726039 | 1,179 |
# # Singular Integrals
# This example shows how to use the `Integration` module for computing
# quadrature rules for functions with point singularities (such as those
# appearing in the numerical discretization of boundary integral equations).
# ## Change of variables
# The first set of *tricks* revolve a round a simple change of variables. We
# focus first on the one-dimensional case, where we wish to integrate
```math
\int_0^1 f(x) dx,
```
# and where the function ``f`` can have an integrable singularity at
using WaveProp.Geometry
using WaveProp.Integration
using WaveProp.Integration
using QuadGK
f = (x) -> x==0 ? 0.0 : log(abs(x))*cos(x)
I,_ = quadgk(f,0,1,rtol=1e-16)
rows = GaussLegendre.([5,10,20,40,80])
cols = [identity,IMT{1,2}(),Kress{8}(), Window{1,1,7}()]
ee = []
for qstd in rows
for shandler in cols
q = SingularQuadratureRule(qstd,shandler)
Is = integrate(f,q)
er = abs(I-Is)
push!(ee,er)
end
end
using NamedArrays
ee = reshape(ee,length(cols),length(rows)) |> transpose |> NamedArray
setnames!(ee,string.(rows),1)
setnames!(ee,string.(cols),2)
setdimnames!(ee,["Base quadrature","Singularity handler"])
show(ee)
# ##
# using Plots
# qstd = GaussLegendre(10)
# x̂,ŵ = qstd()
# cols = [IMT{1,2}(),Kress{8}(), Window{0.5,1,7}()]
# fig = plot()
# for shandler in cols
# phi = shandler.(x̂)
# phip = [jacobian(shandler,x)[1] for x in x̂]
# plot!(fig,x̂,f.(phi) .* phip,label=string(shandler),m=:x)
# end
# display(fig)
| [
2,
1303,
5573,
934,
15995,
30691,
198,
198,
2,
770,
1672,
2523,
703,
284,
779,
262,
4600,
34500,
1358,
63,
8265,
329,
14492,
198,
2,
15094,
81,
1300,
3173,
329,
5499,
351,
966,
18032,
871,
357,
10508,
355,
883,
198,
2,
12655,
287,
262,
29052,
1221,
1186,
1634,
286,
18645,
19287,
27490,
737,
198,
198,
2,
22492,
9794,
286,
9633,
198,
198,
2,
383,
717,
900,
286,
1635,
83,
23706,
9,
2710,
6442,
257,
2835,
257,
2829,
1487,
286,
9633,
13,
775,
198,
2,
2962,
717,
319,
262,
530,
12,
19577,
1339,
11,
810,
356,
4601,
284,
19386,
220,
198,
15506,
63,
11018,
198,
220,
220,
220,
3467,
600,
62,
15,
61,
16,
277,
7,
87,
8,
44332,
11,
198,
15506,
63,
198,
2,
290,
810,
262,
2163,
7559,
69,
15506,
460,
423,
281,
4132,
81,
540,
18032,
414,
379,
220,
198,
198,
3500,
17084,
24331,
13,
10082,
15748,
198,
3500,
17084,
24331,
13,
34500,
1358,
198,
3500,
17084,
24331,
13,
34500,
1358,
198,
3500,
20648,
38,
42,
198,
198,
69,
220,
220,
220,
220,
220,
220,
220,
796,
357,
87,
8,
4613,
2124,
855,
15,
5633,
657,
13,
15,
1058,
2604,
7,
8937,
7,
87,
4008,
9,
6966,
7,
87,
8,
198,
40,
11,
62,
220,
220,
220,
220,
220,
220,
220,
796,
15094,
70,
74,
7,
69,
11,
15,
11,
16,
11,
17034,
349,
28,
16,
68,
12,
1433,
8,
198,
198,
8516,
796,
12822,
1046,
21351,
260,
12195,
58,
20,
11,
940,
11,
1238,
11,
1821,
11,
1795,
12962,
198,
4033,
82,
796,
685,
738,
414,
11,
3955,
51,
90,
16,
11,
17,
92,
22784,
42,
601,
90,
23,
92,
22784,
26580,
90,
16,
11,
16,
11,
22,
92,
3419,
60,
220,
220,
220,
220,
198,
1453,
220,
220,
796,
17635,
198,
1640,
10662,
19282,
287,
15274,
198,
220,
220,
220,
329,
427,
392,
1754,
287,
951,
82,
198,
220,
220,
220,
220,
220,
220,
220,
10662,
220,
220,
220,
220,
220,
220,
220,
796,
5573,
934,
4507,
41909,
1300,
31929,
7,
80,
19282,
11,
1477,
392,
1754,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1148,
220,
220,
220,
220,
220,
220,
796,
19386,
7,
69,
11,
80,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1931,
220,
220,
220,
220,
220,
220,
796,
2352,
7,
40,
12,
3792,
8,
198,
220,
220,
220,
220,
220,
220,
220,
4574,
0,
7,
1453,
11,
263,
8,
198,
220,
220,
220,
886,
220,
220,
220,
220,
198,
437,
198,
198,
3500,
34441,
3163,
20477,
198,
1453,
796,
27179,
1758,
7,
1453,
11,
13664,
7,
4033,
82,
828,
13664,
7,
8516,
4008,
930,
29,
1007,
3455,
930,
29,
34441,
19182,
198,
2617,
14933,
0,
7,
1453,
11,
8841,
12195,
8516,
828,
16,
8,
198,
2617,
14933,
0,
7,
1453,
11,
8841,
12195,
4033,
82,
828,
17,
8,
198,
2617,
27740,
14933,
0,
7,
1453,
11,
14692,
14881,
15094,
81,
1300,
2430,
29974,
33737,
21360,
8973,
8,
198,
12860,
7,
1453,
8,
198,
198,
2,
22492,
220,
198,
2,
1262,
1345,
1747,
198,
2,
10662,
19282,
796,
12822,
1046,
21351,
260,
7,
940,
8,
198,
2,
2124,
136,
224,
11,
86,
136,
224,
220,
796,
10662,
19282,
3419,
198,
2,
951,
82,
796,
685,
3955,
51,
90,
16,
11,
17,
92,
22784,
42,
601,
90,
23,
92,
22784,
26580,
90,
15,
13,
20,
11,
16,
11,
22,
92,
3419,
60,
220,
220,
220,
220,
198,
2,
2336,
796,
7110,
3419,
198,
2,
329,
427,
392,
1754,
287,
951,
82,
198,
2,
220,
220,
220,
220,
872,
72,
220,
220,
220,
220,
220,
220,
796,
427,
392,
1754,
12195,
87,
136,
224,
8,
198,
2,
220,
220,
220,
220,
872,
541,
220,
220,
220,
220,
220,
796,
685,
30482,
672,
666,
7,
1477,
392,
1754,
11,
87,
38381,
16,
60,
329,
2124,
287,
2124,
136,
224,
60,
198,
2,
220,
220,
220,
220,
7110,
0,
7,
5647,
11,
87,
136,
224,
11,
69,
12195,
34846,
8,
764,
9,
872,
541,
11,
18242,
28,
8841,
7,
1477,
392,
1754,
828,
76,
28,
25,
87,
8,
198,
2,
886,
220,
198,
2,
3359,
7,
5647,
8,
220,
220,
220,
628
] | 2.278665 | 689 |
struct Acronym
word::String
components::Vector{Union{String, Nothing}}
nvals::Vector{Int}
end
struct AcronymFamily
word::String
n_max::Int
components::Matrix{Vector{String}}
end
Base.show(io::IO, af::AcronymFamily) = print(io, typeof(af), "(\"", af.word, "\", ", af.n_max, ", ...)")
function _family_traces(af::AcronymFamily)
max_n, l = size(af.components)
a = [Vector{Tuple{Int, Int}}[] for _ in af.components]
for i in l:-1:1, n in 1:max_n
n > 1 && isempty(af.components[n, i]) && continue # No components
ind = (i, n)
next = i + n
if next == l + 1 # Last
push!(a[n, i], [ind])
elseif next <= l
for nexttraces in a[:, next]
for nexttrace in nexttraces
push!(a[n, i], vcat(ind, nexttrace))
end
end
end
end
return vcat(a[:, 1]...)
end
function acronyms(af::AcronymFamily, trace::AbstractVector{NTuple{2, Int}})
comp_lists = [af.components[n, i] for (i, n) in trace]
nvals = last.(trace)
comps_iter = Iterators.product((isempty(c) ? [nothing] : c for c in comp_lists)...)
return (Acronym(af.word, collect(comp), nvals) for comp in comps_iter)
end
acronyms(af::AcronymFamily) = Iterators.flatten(acronyms(af, trace) for trace in _family_traces(af))
function generate_acronyms(word::String, max_n::Int, prefix_map::Dict)
word = lowercase(word)
l = length(word)
components = Matrix{Vector{String}}(undef, max_n, l)
for i in 1:l
for j in 1:max_n
if i + j - 1 > l
components[j, i] = String[]
else
prefix = word[i:(i + j - 1)]
components[j, i] = get(prefix_map, prefix, String[])
end
end
end
return AcronymFamily(word, max_n, components)
end
| [
7249,
4013,
1313,
4948,
198,
220,
220,
220,
1573,
3712,
10100,
198,
220,
220,
220,
6805,
3712,
38469,
90,
38176,
90,
10100,
11,
10528,
11709,
198,
220,
220,
220,
299,
12786,
3712,
38469,
90,
5317,
92,
198,
437,
628,
198,
7249,
4013,
1313,
4948,
24094,
198,
220,
220,
220,
1573,
3712,
10100,
198,
220,
220,
220,
299,
62,
9806,
3712,
5317,
198,
220,
220,
220,
6805,
3712,
46912,
90,
38469,
90,
10100,
11709,
198,
437,
628,
198,
14881,
13,
12860,
7,
952,
3712,
9399,
11,
6580,
3712,
12832,
1313,
4948,
24094,
8,
796,
3601,
7,
952,
11,
2099,
1659,
7,
1878,
828,
30629,
7879,
1600,
6580,
13,
4775,
11,
366,
34607,
33172,
6580,
13,
77,
62,
9806,
11,
33172,
2644,
8,
4943,
628,
198,
8818,
4808,
17989,
62,
2213,
2114,
7,
1878,
3712,
12832,
1313,
4948,
24094,
8,
198,
220,
220,
220,
3509,
62,
77,
11,
300,
796,
2546,
7,
1878,
13,
5589,
3906,
8,
198,
220,
220,
220,
257,
796,
685,
38469,
90,
51,
29291,
90,
5317,
11,
2558,
11709,
21737,
329,
4808,
287,
6580,
13,
5589,
3906,
60,
198,
220,
220,
220,
220,
198,
220,
220,
220,
329,
1312,
287,
300,
21912,
16,
25,
16,
11,
299,
287,
352,
25,
9806,
62,
77,
198,
220,
220,
220,
220,
220,
220,
220,
299,
1875,
352,
11405,
318,
28920,
7,
1878,
13,
5589,
3906,
58,
77,
11,
1312,
12962,
11405,
2555,
220,
1303,
1400,
6805,
198,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
773,
796,
357,
72,
11,
299,
8,
198,
220,
220,
220,
220,
220,
220,
220,
1306,
796,
1312,
1343,
299,
198,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
611,
1306,
6624,
300,
1343,
352,
220,
1303,
4586,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4574,
0,
7,
64,
58,
77,
11,
1312,
4357,
685,
521,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
2073,
361,
1306,
19841,
300,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
1306,
2213,
2114,
287,
257,
58,
45299,
1306,
60,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
329,
1306,
40546,
287,
1306,
2213,
2114,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
4574,
0,
7,
64,
58,
77,
11,
1312,
4357,
410,
9246,
7,
521,
11,
1306,
40546,
4008,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
886,
198,
220,
220,
220,
220,
198,
220,
220,
220,
1441,
410,
9246,
7,
64,
58,
45299,
352,
60,
23029,
198,
437,
628,
198,
8818,
33898,
88,
907,
7,
1878,
3712,
12832,
1313,
4948,
24094,
11,
12854,
3712,
23839,
38469,
90,
11251,
29291,
90,
17,
11,
2558,
11709,
8,
198,
220,
220,
220,
552,
62,
20713,
796,
685,
1878,
13,
5589,
3906,
58,
77,
11,
1312,
60,
329,
357,
72,
11,
299,
8,
287,
12854,
60,
198,
220,
220,
220,
299,
12786,
796,
938,
12195,
40546,
8,
198,
220,
220,
220,
552,
82,
62,
2676,
796,
40806,
2024,
13,
11167,
19510,
271,
28920,
7,
66,
8,
5633,
685,
22366,
60,
1058,
269,
329,
269,
287,
552,
62,
20713,
8,
23029,
198,
220,
220,
220,
1441,
357,
12832,
1313,
4948,
7,
1878,
13,
4775,
11,
2824,
7,
5589,
828,
299,
12786,
8,
329,
552,
287,
552,
82,
62,
2676,
8,
198,
437,
628,
198,
330,
1313,
88,
907,
7,
1878,
3712,
12832,
1313,
4948,
24094,
8,
796,
40806,
2024,
13,
2704,
41769,
7,
330,
1313,
88,
907,
7,
1878,
11,
12854,
8,
329,
12854,
287,
4808,
17989,
62,
2213,
2114,
7,
1878,
4008,
628,
198,
8818,
7716,
62,
330,
1313,
88,
907,
7,
4775,
3712,
10100,
11,
3509,
62,
77,
3712,
5317,
11,
21231,
62,
8899,
3712,
35,
713,
8,
198,
220,
220,
220,
1573,
796,
2793,
7442,
7,
4775,
8,
198,
220,
220,
220,
300,
796,
4129,
7,
4775,
8,
198,
220,
220,
220,
220,
198,
220,
220,
220,
6805,
796,
24936,
90,
38469,
90,
10100,
11709,
7,
917,
891,
11,
3509,
62,
77,
11,
300,
8,
198,
220,
220,
220,
220,
198,
220,
220,
220,
329,
1312,
287,
352,
25,
75,
198,
220,
220,
220,
220,
220,
220,
220,
329,
474,
287,
352,
25,
9806,
62,
77,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
1312,
1343,
474,
532,
352,
1875,
300,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6805,
58,
73,
11,
1312,
60,
796,
10903,
21737,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
21231,
796,
1573,
58,
72,
37498,
72,
1343,
474,
532,
352,
15437,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
6805,
58,
73,
11,
1312,
60,
796,
651,
7,
40290,
62,
8899,
11,
21231,
11,
10903,
58,
12962,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
198,
220,
220,
220,
220,
198,
220,
220,
220,
1441,
4013,
1313,
4948,
24094,
7,
4775,
11,
3509,
62,
77,
11,
6805,
8,
198,
437,
198
] | 2.015528 | 966 |
module VoronoiCells
# We do not compile
# 1. VoronoiDelaunay is not compiled.
# 2. VoronoiCells itself loads in about 100ms
include("voronoi_cells.jl")
include("store_cells.jl")
end # module
| [
21412,
44143,
261,
23013,
34,
19187,
198,
198,
2,
775,
466,
407,
17632,
198,
2,
352,
13,
44143,
261,
23013,
13856,
1942,
323,
318,
407,
14102,
13,
198,
2,
362,
13,
44143,
261,
23013,
34,
19187,
2346,
15989,
287,
546,
1802,
907,
198,
198,
17256,
7203,
20867,
261,
23013,
62,
46342,
13,
20362,
4943,
198,
17256,
7203,
8095,
62,
46342,
13,
20362,
4943,
198,
198,
437,
1303,
8265,
198
] | 2.811594 | 69 |
# breadth first search
function bfs(goal, start)
reset_timer!(to::TimerOutput)
node = createtree(start)
if node.state == goal
return node
end
frontier = [node]
reached = [node.state]
while !isempty(frontier)
@timeit to "Moves" acts = moves(node.state)
@timeit to "Pop" node = popfirst!(frontier)
@timeit to "Expand" states = expansion(node.state)
for (currentstate, currentaction) in zip(states, acts)
if currentstate == goal
sovle = addnode(currentaction, node, currentstate)
displaysolution(sovle)
return sovle
end
if !in(currentstate, reached)
@timeit to "Node Creation" currentnode = addnode(currentaction, node, currentstate)
@timeit to "Push" push!(frontier, currentnode)
end
end
end
println("No solutions found!"^10)
return nothing
end | [
198,
2,
220,
32483,
717,
2989,
220,
220,
220,
198,
8818,
275,
9501,
7,
35231,
11,
923,
8,
198,
220,
220,
220,
13259,
62,
45016,
0,
7,
1462,
3712,
48801,
26410,
8,
198,
220,
220,
220,
10139,
796,
1827,
316,
631,
7,
9688,
8,
198,
220,
220,
220,
611,
10139,
13,
5219,
6624,
3061,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
10139,
198,
220,
220,
220,
886,
198,
220,
220,
220,
27580,
796,
685,
17440,
60,
198,
220,
220,
220,
4251,
796,
685,
17440,
13,
5219,
60,
198,
220,
220,
220,
981,
5145,
271,
28920,
7,
8534,
959,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
2435,
270,
284,
366,
44,
5241,
1,
6529,
796,
6100,
7,
17440,
13,
5219,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
2435,
270,
284,
366,
16979,
1,
10139,
796,
1461,
11085,
0,
7,
8534,
959,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
2435,
270,
284,
366,
16870,
392,
1,
2585,
796,
7118,
7,
17440,
13,
5219,
8,
628,
220,
220,
220,
220,
220,
220,
220,
329,
357,
14421,
5219,
11,
1459,
2673,
8,
287,
19974,
7,
27219,
11,
6529,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
1459,
5219,
6624,
3061,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
523,
85,
293,
796,
751,
17440,
7,
14421,
2673,
11,
10139,
11,
1459,
5219,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
11298,
2122,
7,
47272,
293,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
1441,
523,
85,
293,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
611,
5145,
259,
7,
14421,
5219,
11,
4251,
8,
628,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
2435,
270,
284,
366,
19667,
21582,
1,
1459,
17440,
796,
751,
17440,
7,
14421,
2673,
11,
10139,
11,
1459,
5219,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
2488,
2435,
270,
284,
366,
49222,
1,
4574,
0,
7,
8534,
959,
11,
1459,
17440,
8,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
44872,
7203,
2949,
8136,
1043,
2474,
61,
940,
8,
198,
220,
220,
220,
1441,
2147,
198,
437
] | 2.205479 | 438 |
push!(ARGS, "../../input_files/dynamic/basin_switching/8GPa/switch2.dat")
include("../../Basin.jl")
pop!(ARGS)
#=
push!(ARGS, "../../input_files/dynamic/basin_switching/8GPa/switch3.dat")
include("../../Basin.jl")
pop!(ARGS)
push!(ARGS, "../../input_files/dynamic/basin_switching/8GPa/switch3.dat")
include("../../Basin.jl")
pop!(ARGS)
push!(ARGS, "../../input_files/dynamic/basin_switching/8GPa/switch4.dat")
include("../../Basin.jl")
pop!(ARGS)
push!(ARGS, "../../input_files/dynamic/basin_switching/8GPa/switch5.dat")
include("../../Basin.jl")
pop!(ARGS)
=#
| [
14689,
0,
7,
1503,
14313,
11,
366,
40720,
40720,
15414,
62,
16624,
14,
67,
28995,
14,
12093,
259,
62,
2032,
19811,
14,
23,
16960,
64,
14,
31943,
17,
13,
19608,
4943,
198,
17256,
7203,
40720,
40720,
15522,
259,
13,
20362,
4943,
198,
12924,
0,
7,
1503,
14313,
8,
198,
2,
28,
198,
14689,
0,
7,
1503,
14313,
11,
366,
40720,
40720,
15414,
62,
16624,
14,
67,
28995,
14,
12093,
259,
62,
2032,
19811,
14,
23,
16960,
64,
14,
31943,
18,
13,
19608,
4943,
198,
17256,
7203,
40720,
40720,
15522,
259,
13,
20362,
4943,
198,
12924,
0,
7,
1503,
14313,
8,
198,
14689,
0,
7,
1503,
14313,
11,
366,
40720,
40720,
15414,
62,
16624,
14,
67,
28995,
14,
12093,
259,
62,
2032,
19811,
14,
23,
16960,
64,
14,
31943,
18,
13,
19608,
4943,
198,
17256,
7203,
40720,
40720,
15522,
259,
13,
20362,
4943,
198,
12924,
0,
7,
1503,
14313,
8,
198,
14689,
0,
7,
1503,
14313,
11,
366,
40720,
40720,
15414,
62,
16624,
14,
67,
28995,
14,
12093,
259,
62,
2032,
19811,
14,
23,
16960,
64,
14,
31943,
19,
13,
19608,
4943,
198,
17256,
7203,
40720,
40720,
15522,
259,
13,
20362,
4943,
198,
12924,
0,
7,
1503,
14313,
8,
198,
14689,
0,
7,
1503,
14313,
11,
366,
40720,
40720,
15414,
62,
16624,
14,
67,
28995,
14,
12093,
259,
62,
2032,
19811,
14,
23,
16960,
64,
14,
31943,
20,
13,
19608,
4943,
198,
17256,
7203,
40720,
40720,
15522,
259,
13,
20362,
4943,
198,
12924,
0,
7,
1503,
14313,
8,
198,
46249,
198
] | 2.244 | 250 |
using Base: Broadcast.DefaultArrayStyle, AbstractUnitRange
_broadcasted(style, f, x, r::AbstractRange) = invoke(Base.Broadcast.broadcasted, Tuple{typeof(style),typeof(f),Any,typeof(r)}, style, f, x, r)
_broadcasted(style, f, r::AbstractRange, x) = invoke(Base.Broadcast.broadcasted, Tuple{typeof(style),typeof(f),typeof(r),Any}, style, f, r, x)
for f in (+, -, *, /, \), R in (AbstractRange, AbstractUnitRange, StepRangeLen)
@eval begin
Base.Broadcast.broadcasted(style::DefaultArrayStyle{1}, ::typeof($f), x::Measurement, r::$R) = _broadcasted(style, $f, x, r)
Base.Broadcast.broadcasted(style::DefaultArrayStyle{1}, ::typeof($f), r::$R, x::Measurement) = _broadcasted(style, $f, r, x)
end
end
| [
3500,
7308,
25,
44244,
13,
19463,
19182,
21466,
11,
27741,
26453,
17257,
198,
198,
62,
36654,
2701,
276,
7,
7635,
11,
277,
11,
2124,
11,
374,
3712,
23839,
17257,
8,
796,
26342,
7,
14881,
13,
30507,
2701,
13,
36654,
2701,
276,
11,
309,
29291,
90,
4906,
1659,
7,
7635,
828,
4906,
1659,
7,
69,
828,
7149,
11,
4906,
1659,
7,
81,
8,
5512,
3918,
11,
277,
11,
2124,
11,
374,
8,
198,
62,
36654,
2701,
276,
7,
7635,
11,
277,
11,
374,
3712,
23839,
17257,
11,
2124,
8,
796,
26342,
7,
14881,
13,
30507,
2701,
13,
36654,
2701,
276,
11,
309,
29291,
90,
4906,
1659,
7,
7635,
828,
4906,
1659,
7,
69,
828,
4906,
1659,
7,
81,
828,
7149,
5512,
3918,
11,
277,
11,
374,
11,
2124,
8,
198,
198,
1640,
277,
287,
11502,
11,
532,
11,
1635,
11,
1220,
11,
3467,
828,
371,
287,
357,
23839,
17257,
11,
27741,
26453,
17257,
11,
5012,
17257,
30659,
8,
198,
220,
220,
220,
2488,
18206,
2221,
198,
220,
220,
220,
220,
220,
220,
220,
7308,
13,
30507,
2701,
13,
36654,
2701,
276,
7,
7635,
3712,
19463,
19182,
21466,
90,
16,
5512,
7904,
4906,
1659,
16763,
69,
828,
2124,
3712,
47384,
434,
11,
374,
3712,
3,
49,
8,
796,
4808,
36654,
2701,
276,
7,
7635,
11,
720,
69,
11,
2124,
11,
374,
8,
198,
220,
220,
220,
220,
220,
220,
220,
7308,
13,
30507,
2701,
13,
36654,
2701,
276,
7,
7635,
3712,
19463,
19182,
21466,
90,
16,
5512,
7904,
4906,
1659,
16763,
69,
828,
374,
3712,
3,
49,
11,
2124,
3712,
47384,
434,
8,
796,
4808,
36654,
2701,
276,
7,
7635,
11,
720,
69,
11,
374,
11,
2124,
8,
198,
220,
220,
220,
886,
198,
437,
198
] | 2.538732 | 284 |
# Testing the Small Demo
# Copyright (c) 2015 Harold Soh
# based on MATLAB code by Mark Schmidt
# For more details, see: http://www.cs.ubc.ca/~schmidtm/Software/UGM/small.html
include("../src/UGM.jl")
using UGM
using Base.Test
include("testUtils.jl")
# ======================================
# Simple Independent Node Test
# ======================================
srand(0)
nodepot = [ 1 3;
9 1;
1 3;
9 1 ]
nsamples = 100;
samples = zeros(4, nsamples)
for i = 1:4
for s = 1:nsamples
samples[i,s] = sampleDiscrete(nodepot[i,:]/sum(nodepot[i,:]));
end
end
sum_samples = sum(samples,2)
println("Sum Samples: ", sum_samples')
gold_result = [172; 107; 168; 110] # at seed 0
@test all(sum_samples .== gold_result)
print("Independent Nodes Test: ")
printPassed()
# ======================================
# Set up Dependent Nodes
# ======================================
nnodes = 4
nstates = 2
edgelist = [ 1 2;
2 1;
2 3;
3 2;
3 4;
4 3]
# Make Edge Structure
es = EdgeStruct(edgelist = edgelist, nstates = nstates, maxiter = 25)
# edgestruct tests
@test es.edgeends == [1 2; 2 3; 3 4]
@test es.edgedict[1] == Set([2])
@test es.edgedict[2] == Set([1,3])
@test es.edgedict[3] == Set([2,4])
@test es.edgedict[4] == Set([3])
@test es.nnodes == 4
@test es.nedges == 3
@test all(es.nstates .== [2.0; 2.0; 2.0; 2.0])
@test es.maxiter == 25
print("Edge Structure Test: ")
printPassed()
# Node potentials
nodepot = [1 3;
9 1;
1 3;
9 1]
# Edge potentials
maxstate = maximum(es.nstates);
edgepot = zeros( int(maxstate), int(maxstate), int(es.nedges));
for e = 1:es.nedges
edgepot[:,:,e] = [2 1 ; 1 2];
end
# ======================================
# Decoding
# ======================================
optdecoding = decodeExact(nodepot,edgepot,es)
println("Optimal Decoding: ", optdecoding')
@test all(optdecoding .== [2.0; 1.0; 1.0; 1.0])
print("Exact Decoding Test: ")
printPassed()
# ======================================
# Inference
# ======================================
nodebel,edgebel,logZ,Z = inferExact(nodepot,edgepot,es)
@test nodebel == [0.3596306068601583 0.6403693931398416
0.8430079155672823 0.15699208443271767
0.4862796833773087 0.5137203166226912
0.8810026385224274 0.11899736147757256]
@test edgebel[:,:,1] == [0.33720316622691293 0.022427440633245383
0.5058047493403693 0.1345646437994723]
@test edgebel[:,:,2] == [0.45118733509234826 0.391820580474934
0.03509234828496042 0.12189973614775726]
@test edgebel[:,:,3] == [0.46068601583113455 0.02559366754617414
0.4203166226912929 0.09340369393139841]
@test_approx_eq_eps(logZ, 8.240121298, 1e-8)
print("Exact Inference Test: ")
printPassed()
# ======================================
# Sampling Test
# ======================================
es.maxiter = 100
samples = sampleExact(nodepot,edgepot,es)
@test all(samples[1,:] .== [2.0 1.0 2.0 2.0])
@test all(samples[4,:] .== [2.0 2.0 2.0 1.0])
@test all(samples[100,:] .== [2.0 1.0 2.0 1.0])
print("Exact Sampling Test: ")
printPassed()
# println(samples)
# using Gadfly
# spy(samples)
| [
2,
23983,
262,
10452,
34588,
198,
2,
15069,
357,
66,
8,
1853,
23987,
311,
1219,
198,
198,
2,
1912,
319,
36775,
48780,
2438,
416,
2940,
24740,
198,
2,
1114,
517,
3307,
11,
766,
25,
2638,
1378,
2503,
13,
6359,
13,
549,
66,
13,
6888,
14,
93,
20601,
13602,
17209,
14,
25423,
14,
7340,
44,
14,
17470,
13,
6494,
198,
198,
17256,
7203,
40720,
10677,
14,
7340,
44,
13,
20362,
4943,
198,
198,
3500,
471,
15548,
198,
3500,
7308,
13,
14402,
198,
198,
17256,
7203,
9288,
18274,
4487,
13,
20362,
4943,
198,
198,
2,
46111,
1421,
28,
198,
2,
17427,
13362,
19081,
6208,
198,
2,
46111,
1421,
28,
198,
82,
25192,
7,
15,
8,
198,
77,
375,
538,
313,
796,
685,
352,
513,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
860,
352,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
352,
513,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
860,
352,
2361,
198,
198,
5907,
12629,
796,
1802,
26,
198,
82,
12629,
796,
1976,
27498,
7,
19,
11,
36545,
12629,
8,
198,
1640,
1312,
796,
352,
25,
19,
198,
220,
329,
264,
796,
352,
25,
5907,
12629,
198,
220,
220,
220,
8405,
58,
72,
11,
82,
60,
796,
6291,
15642,
8374,
7,
77,
375,
538,
313,
58,
72,
11,
47715,
14,
16345,
7,
77,
375,
538,
313,
58,
72,
11,
25,
12962,
1776,
198,
220,
886,
198,
437,
198,
198,
16345,
62,
82,
12629,
796,
2160,
7,
82,
12629,
11,
17,
8,
198,
35235,
7203,
13065,
3409,
2374,
25,
33172,
2160,
62,
82,
12629,
11537,
198,
24267,
62,
20274,
796,
685,
23628,
26,
16226,
26,
23378,
26,
9796,
60,
1303,
379,
9403,
657,
198,
31,
9288,
477,
7,
16345,
62,
82,
12629,
764,
855,
3869,
62,
20274,
8,
198,
4798,
7203,
40566,
399,
4147,
6208,
25,
366,
8,
198,
4798,
14478,
276,
3419,
198,
198,
2,
46111,
1421,
28,
198,
2,
5345,
510,
37947,
298,
399,
4147,
198,
2,
46111,
1421,
28,
198,
20471,
4147,
796,
604,
198,
77,
27219,
796,
362,
198,
198,
276,
25280,
396,
796,
220,
685,
352,
362,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
362,
352,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
362,
513,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
513,
362,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
513,
604,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
604,
513,
60,
198,
198,
2,
6889,
13113,
32522,
198,
274,
796,
13113,
44909,
7,
276,
25280,
396,
796,
1225,
25280,
396,
11,
299,
27219,
796,
299,
27219,
11,
3509,
2676,
796,
1679,
8,
198,
198,
2,
1225,
3495,
1356,
5254,
198,
31,
9288,
1658,
13,
14907,
2412,
6624,
685,
16,
362,
26,
362,
513,
26,
513,
604,
60,
198,
31,
9288,
1658,
13,
48916,
713,
58,
16,
60,
6624,
5345,
26933,
17,
12962,
198,
31,
9288,
1658,
13,
48916,
713,
58,
17,
60,
6624,
5345,
26933,
16,
11,
18,
12962,
198,
31,
9288,
1658,
13,
48916,
713,
58,
18,
60,
6624,
5345,
26933,
17,
11,
19,
12962,
198,
31,
9288,
1658,
13,
48916,
713,
58,
19,
60,
6624,
5345,
26933,
18,
12962,
198,
31,
9288,
1658,
13,
20471,
4147,
6624,
604,
198,
31,
9288,
1658,
13,
2817,
3212,
6624,
513,
198,
31,
9288,
477,
7,
274,
13,
77,
27219,
764,
855,
685,
17,
13,
15,
26,
362,
13,
15,
26,
362,
13,
15,
26,
362,
13,
15,
12962,
198,
31,
9288,
1658,
13,
9806,
2676,
6624,
1679,
198,
4798,
7203,
37021,
32522,
6208,
25,
366,
8,
198,
4798,
14478,
276,
3419,
198,
198,
2,
19081,
2785,
82,
198,
77,
375,
538,
313,
796,
685,
16,
513,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
860,
352,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
352,
513,
26,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
860,
352,
60,
198,
198,
2,
13113,
2785,
82,
198,
9806,
5219,
796,
5415,
7,
274,
13,
77,
27219,
1776,
198,
14907,
13059,
796,
1976,
27498,
7,
493,
7,
9806,
5219,
828,
493,
7,
9806,
5219,
828,
493,
7,
274,
13,
2817,
3212,
18125,
198,
1640,
304,
796,
352,
25,
274,
13,
2817,
3212,
198,
220,
220,
5743,
13059,
58,
45299,
45299,
68,
60,
796,
685,
17,
352,
2162,
352,
362,
11208,
198,
437,
198,
198,
2,
46111,
1421,
28,
198,
2,
4280,
7656,
198,
2,
46111,
1421,
28,
198,
404,
8671,
721,
7656,
796,
36899,
3109,
529,
7,
77,
375,
538,
313,
11,
14907,
13059,
11,
274,
8,
198,
35235,
7203,
27871,
4402,
4280,
7656,
25,
33172,
2172,
12501,
7656,
11537,
198,
31,
9288,
477,
7,
404,
8671,
721,
7656,
764,
855,
685,
17,
13,
15,
26,
352,
13,
15,
26,
352,
13,
15,
26,
352,
13,
15,
12962,
198,
4798,
7203,
3109,
529,
4280,
7656,
6208,
25,
366,
8,
198,
4798,
14478,
276,
3419,
198,
198,
2,
46111,
1421,
28,
198,
2,
554,
4288,
198,
2,
46111,
1421,
28,
198,
17440,
6667,
11,
14907,
6667,
11,
6404,
57,
11,
57,
796,
13249,
3109,
529,
7,
77,
375,
538,
313,
11,
14907,
13059,
11,
274,
8,
198,
198,
31,
9288,
10139,
6667,
6624,
685,
15,
13,
2327,
4846,
1270,
1899,
33808,
486,
46239,
657,
13,
31102,
30803,
2670,
25838,
4089,
35218,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
23,
3559,
405,
3720,
18742,
3134,
2078,
1954,
657,
13,
21599,
2079,
21315,
2598,
34159,
1558,
3134,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
34251,
26050,
3104,
2091,
3324,
1270,
5774,
657,
13,
20,
19708,
22416,
23055,
1828,
3388,
1065,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
3459,
3064,
2075,
2548,
4309,
1731,
28857,
657,
13,
16817,
39647,
2623,
20198,
39251,
11645,
60,
198,
198,
31,
9288,
5743,
6667,
58,
45299,
45299,
16,
60,
6624,
685,
15,
13,
31496,
22416,
23055,
1828,
3388,
1065,
6052,
657,
13,
2999,
1731,
1983,
25644,
21,
2091,
22995,
34741,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
31654,
1795,
2857,
2920,
23601,
2623,
6052,
657,
13,
1485,
2231,
2414,
2414,
2718,
2079,
2857,
1954,
60,
198,
198,
31,
9288,
5743,
6667,
58,
45299,
45299,
17,
60,
6624,
220,
685,
15,
13,
2231,
1157,
5774,
2091,
29022,
1954,
2780,
2075,
657,
13,
2670,
1507,
21261,
1795,
2857,
2920,
2682,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
3070,
29022,
1954,
2780,
2078,
2920,
1899,
3682,
657,
13,
1065,
1507,
39647,
2623,
20198,
39251,
2075,
60,
198,
198,
31,
9288,
5743,
6667,
58,
45299,
45299,
18,
60,
6624,
685,
15,
13,
34716,
33808,
486,
46239,
16616,
30505,
657,
13,
36629,
3270,
32459,
2425,
3510,
22985,
1415,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
657,
13,
19,
22416,
23055,
1828,
3388,
18741,
1959,
657,
13,
2931,
23601,
30803,
2670,
25838,
4089,
3901,
60,
198,
198,
31,
9288,
62,
1324,
13907,
62,
27363,
62,
25386,
7,
6404,
57,
11,
807,
13,
1731,
486,
21777,
4089,
11,
352,
68,
12,
23,
8,
198,
4798,
7203,
3109,
529,
554,
4288,
6208,
25,
366,
8,
198,
4798,
14478,
276,
3419,
198,
198,
2,
46111,
1421,
28,
198,
2,
3409,
11347,
6208,
198,
2,
46111,
1421,
28,
198,
274,
13,
9806,
2676,
796,
1802,
198,
82,
12629,
796,
6291,
3109,
529,
7,
77,
375,
538,
313,
11,
14907,
13059,
11,
274,
8,
198,
31,
9288,
477,
7,
82,
12629,
58,
16,
11,
47715,
764,
855,
685,
17,
13,
15,
352,
13,
15,
362,
13,
15,
362,
13,
15,
12962,
198,
31,
9288,
477,
7,
82,
12629,
58,
19,
11,
47715,
764,
855,
685,
17,
13,
15,
362,
13,
15,
362,
13,
15,
352,
13,
15,
12962,
198,
31,
9288,
477,
7,
82,
12629,
58,
3064,
11,
47715,
764,
855,
685,
17,
13,
15,
352,
13,
15,
362,
13,
15,
352,
13,
15,
12962,
198,
4798,
7203,
3109,
529,
3409,
11347,
6208,
25,
366,
8,
198,
4798,
14478,
276,
3419,
198,
198,
2,
44872,
7,
82,
12629,
8,
198,
2,
1262,
20925,
12254,
198,
2,
13997,
7,
82,
12629,
8,
198
] | 2.24846 | 1,461 |
using DelimitedFiles
function solve(input)
raw = vcat(readdlm(input,Int16)...)
p1 = process(copy(raw),aggregate)
@show p1
p2 = process(copy(raw),findRootValue)
@show p2
end
function process(list, f)
numChildren = popfirst!(list)
numMeta = popfirst!(list)
return f(ntimes(numChildren,list,f), splice!(list,1:numMeta))
end
function ntimes(n,list, f)
result = Int16[]
for i in 1:n
push!(result,process(list,f))
end
return result
end
function aggregate(child,metadata)
return sum(child) + sum(metadata)
end
function childValue((child,value),index)
if length(child)>index
value+=child[index+1]
else
value+= 0
end
return (child,value)
end
function findRootValue(child,metadata)
pushfirst!(child,0)
if length(child) == 1
return sum(metadata)
else
return reduce(childValue,metadata,init=(child,0))[2]
end
end
solve("input.txt")
| [
3500,
4216,
320,
863,
25876,
198,
198,
8818,
8494,
7,
15414,
8,
198,
220,
220,
220,
8246,
796,
410,
9246,
7,
961,
25404,
76,
7,
15414,
11,
5317,
1433,
8,
23029,
198,
220,
220,
220,
279,
16,
796,
1429,
7,
30073,
7,
1831,
828,
9460,
49373,
8,
198,
220,
220,
220,
2488,
12860,
279,
16,
198,
220,
220,
220,
279,
17,
796,
1429,
7,
30073,
7,
1831,
828,
19796,
30016,
11395,
8,
198,
220,
220,
220,
2488,
12860,
279,
17,
198,
198,
437,
198,
198,
8818,
1429,
7,
4868,
11,
277,
8,
198,
220,
220,
220,
997,
26829,
796,
1461,
11085,
0,
7,
4868,
8,
198,
220,
220,
220,
997,
48526,
796,
1461,
11085,
0,
7,
4868,
8,
198,
220,
220,
220,
1441,
277,
7,
429,
999,
7,
22510,
26829,
11,
4868,
11,
69,
828,
4328,
501,
0,
7,
4868,
11,
16,
25,
22510,
48526,
4008,
198,
437,
198,
198,
8818,
299,
22355,
7,
77,
11,
4868,
11,
277,
8,
198,
220,
220,
220,
1255,
796,
2558,
1433,
21737,
198,
220,
220,
220,
329,
1312,
287,
352,
25,
77,
198,
220,
220,
220,
220,
220,
220,
220,
4574,
0,
7,
20274,
11,
14681,
7,
4868,
11,
69,
4008,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
1255,
198,
437,
198,
198,
8818,
19406,
7,
9410,
11,
38993,
8,
198,
220,
220,
220,
1441,
2160,
7,
9410,
8,
1343,
2160,
7,
38993,
8,
198,
437,
628,
198,
198,
8818,
1200,
11395,
19510,
9410,
11,
8367,
828,
9630,
8,
198,
220,
220,
220,
611,
4129,
7,
9410,
8,
29,
9630,
198,
220,
220,
220,
220,
220,
220,
220,
1988,
47932,
9410,
58,
9630,
10,
16,
60,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
1988,
47932,
657,
198,
220,
220,
220,
886,
198,
220,
220,
220,
1441,
357,
9410,
11,
8367,
8,
198,
437,
198,
198,
8818,
1064,
30016,
11395,
7,
9410,
11,
38993,
8,
198,
220,
220,
220,
4574,
11085,
0,
7,
9410,
11,
15,
8,
198,
220,
220,
220,
611,
4129,
7,
9410,
8,
6624,
352,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
2160,
7,
38993,
8,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
1441,
4646,
7,
9410,
11395,
11,
38993,
11,
15003,
16193,
9410,
11,
15,
4008,
58,
17,
60,
198,
220,
220,
220,
886,
198,
437,
198,
198,
82,
6442,
7203,
15414,
13,
14116,
4943,
198
] | 2.367246 | 403 |
function runSimulation(p::precipParam)
doInitialPrinting(p)
if p.runID == 1
mainDriver(p::precipParam)
elseif p.runID == 2
pureDiffusionOneChemicalTestDriver(p)
elseif p.runID == 3
pureAdvectionOneChemicalTestDriver(p)
elseif p.runID == 4
AdvectionDiffusionOneChemicalTestDriver(p)
elseif p.runID == 5
MultiphaseBrinkmanTestDriver(p)
elseif p.runID == 6
DiffusionAndReactionTwoChemicalTestDriver(p)
elseif p.runID == 7
pureReactionTestDriver(p)
else
println("runID of ",p.runID," not recognized.")
println("runID 1-7 required")
end
nothing
end
function mainDriver(p::precipParam)
timer, mesh, soln, tsoln, prob = initializeData(p)
# initial brinkman
mpbparam = BrinkmanMPParam(1.0,mpbFriction(soln.θf.u),soln.θf.u)
sol = solve(prob.fluid,mesh.fMesh,mpbparam)
tsoln.fluid.u = sol.u
tsoln.fluid.v = sol.v
tsoln.fluid.p = sol.p
intializeTimeSteppingTimer!(timer)
doPrinting!(timer,p,mesh,tsoln)
while timer.simulationTime < timer.finalTime
#Ninterp = 80
#interpVals = zeros(Ninterp,6)
#surf = mySurface([0.5,0.37],[0.5,-0.37])
# reaction
computeReaction!(p,tsoln)
soln.θs.u = tsoln.θs.u
soln.θf.u = tsoln.θf.u
θfn = normalize_thetaf(tsoln.θf.u)
peAnormalized = p.PeA./(θfn .+ 0.0 .*(1 .- θfn)) # 0.0 -> 0.5
peBnormalized = p.PeB./(θfn .+ 0.0 .*(1 .- θfn)) # 0.0 -> 0.25
ψAParam = AdvDiffParam(tsoln.fluid.u,tsoln.fluid.v,peAnormalized)
ψBParam = AdvDiffParam(tsoln.fluid.u,tsoln.fluid.v,peBnormalized)
ψCParam = AdvDiffParam(tsoln.fluid.u,tsoln.fluid.v,p.PeC./θfn)
# advection-diffusion
M = generateMassMatrixWScalar(mesh.sMesh,θfn)
StiffA = GenerateSystem(mesh.sMesh,prob.ψA,ψAParam)
ApplyBC!(StiffA,mesh.sMesh,prob.ψA,ψAParam,prob.ψA.OperatorType)
StiffB = GenerateSystem(mesh.sMesh,prob.ψB,ψBParam)
ApplyBC!(StiffB,mesh.sMesh,prob.ψB,ψBParam,prob.ψB.OperatorType)
StiffC = GenerateSystem(mesh.sMesh,prob.ψC,ψCParam)
ApplyBC!(StiffC,mesh.sMesh,prob.ψC,ψCParam,prob.ψC.OperatorType)
if timer.stepIndex < 5
soln.ψA.u = updateChemical(M,StiffA,tsoln.ψA.u,p;solver=:backwardeuler)
soln.ψB.u = updateChemical(M,StiffB,tsoln.ψB.u,p;solver=:backwardeuler)
soln.ψC.u = updateChemical(M,StiffC,tsoln.ψC.u,p;solver=:backwardeuler)
else
soln.ψA.u = updateChemical(M,StiffA,tsoln.ψA.u,p;solver=p.integrator)
soln.ψB.u = updateChemical(M,StiffB,tsoln.ψB.u,p;solver=p.integrator)
soln.ψC.u = updateChemical(M,StiffC,tsoln.ψC.u,p;solver=p.integrator)
end
# scrub scalars so they don't go below zero.
for i=1:length(soln.ψA.u)
if soln.ψA.u[i] < 0
soln.ψA.u[i] = 0.0
end
if soln.ψB.u[i] < 0
soln.ψB.u[i] = 0.0
end
if soln.ψC.u[i] < 0
soln.ψC.u[i] = 0.0
end
end
# brinkman
# normalize thetaf
mpbparam = BrinkmanMPParam(1.0,mpbFriction(θfn),θfn)
sol = solve(prob.fluid,mesh.fMesh,mpbparam)
soln.fluid.u = sol.u
soln.fluid.v = sol.v
soln.fluid.p = sol.p
# inteprolate values
#xvals = zeros(length(mesh.sMesh.xy))
#yvals = zeros(length(mesh.sMesh.xy))
#for i=1:length(mesh.sMesh.xy)
# xvals[i] = mesh.sMesh.xy[i].x
# yvals[i] = mesh.sMesh.xy[i].y
#end
#vmag = sqrt.(soln.fluid.u.^2 + soln.fluid.v.^2)
#interpVals[:,1] = SurfaceInterp(mesh.sMesh,xvals,surf,Ninterp-1)
#interpVals[:,2] = SurfaceInterp(mesh.sMesh,yvals,surf,Ninterp-1)
#interpVals[:,3] = SurfaceInterp(mesh.sMesh,soln.ψA.u,surf,Ninterp-1)
#interpVals[:,4] = SurfaceInterp(mesh.sMesh,soln.ψB.u,surf,Ninterp-1)
#interpVals[:,5] = SurfaceInterp(mesh.sMesh,soln.θs.u,surf,Ninterp-1)
#interpVals[:,6] = SurfaceInterp(mesh.fMesh,vmag,surf,Ninterp-1)
tsoln = deepcopy(soln)
if isPrintIndex(timer)
# save interpolated values
#savefile = string(p.SaveFolder,"/interpVals_",timer.printIndex,".jld2")
#save(savefile, "time", timer.simulationTime, "interpVals", interpVals)
# ordinary printing
doPrinting!(timer,p,mesh,soln)
end
updateSimulationTime!(timer)
updateStepIndex!(timer)
end
printSimulationFinishedMessage(timer)
nothing
end
function normalize_thetaf(θf::Vector{T}) where T<:Real
N=length(θf)
θf_normalized = zeros(T,N)
TOL = 0.1
for i=1:N
if θf[i] < TOL
θf_normalized[i] = TOL
else
θf_normalized[i] = θf[i]
end
end
return θf_normalized
end
function pureDiffusionOneChemicalTestDriver(p::precipParam)
timer, mesh, soln, tsoln, prob = initializeData(p)
ψAParam = PoissonParam(p.κA)
for i=1:length(soln.θf.u)
soln.θf.u[i] = 0.1
end
M = generateMassMatrixWScalar(mesh.sMesh,soln.θf.u)
StiffA = GenerateSystem(mesh.sMesh,prob.ψA,ψAParam)
ApplyBC!(StiffA,mesh.sMesh,prob.ψA,ψAParam,prob.ψA.OperatorType)
intializeTimeSteppingTimer!(timer)
doPrinting!(timer,p,mesh,soln)
while timer.simulationTime < timer.finalTime
if timer.stepIndex < 5
soln.ψA.u = updateChemical(M,StiffA,tsoln.ψA.u,p;solver=:backwardeuler)
else
soln.ψA.u = updateChemical(M,StiffA,tsoln.ψA.u,p;solver=p.integrator)
end
tsoln = deepcopy(soln)
if isPrintIndex(timer)
doPrinting!(timer,p,mesh,soln)
end
updateSimulationTime!(timer)
updateStepIndex!(timer)
end
printSimulationFinishedMessage(timer)
nothing
end
function pureAdvectionOneChemicalTestDriver(p::precipParam)
println("pure advection test driver isn't programmed yet")
nothing
end
function AdvectionDiffusionOneChemicalTestDriver(p::precipParam)
println("advection-diffusion test driver isn't programmed yet")
nothing
end
function MultiphaseBrinkmanTestDriver(p::precipParam)
function computeNorms(N)
start = time()
# load mesh
mesh = squareMeshFluid([-2,2,-1,1],N)
α1(x,y) = 1.0
α2(x,y) = 0.5+0.4*cos(3*x*y)
α3(x,y) = 0.5+0.4*sin(7*x*y)
xm = [i.x for i in mesh.xy]
ym = [i.y for i in mesh.xy]
α1arr = [α1(xm[i],ym[i]) for i=1:length(mesh.xy)]
α2arr = [α2(xm[i],ym[i]) for i=1:length(mesh.xy)]
α3arr = [α3(xm[i],ym[i]) for i=1:length(mesh.xy)]
param = BrinkmanMPParam(α1arr,α2arr,α3arr)
OperatorType = :BrinkmanMP2D
dNodes = Dirichlet(:left,:top,:bottom,:right)
Nodes = [dNodes]
u(x,y) = -x^4*y^2
v(x,y) = 4x^3*y^3/3
dUBCf = Dirichlet( (x,y) -> u(x,y) )
dVBCf = Dirichlet( (x,y) -> v(x,y) )
d2dudx(x,y) = -12*x^2*y^2; d2dudy(x,y) = -2*x^4
d2dvdx(x,y) = 8*x*y^3; d2dvdy(x,y) = 8*x^3*y
lapu(x,y) = d2dudx(x,y) + d2dudy(x,y)
lapv(x,y) = d2dvdx(x,y) + d2dvdy(x,y)
dpdx(x,y) = 3*x^2*y^3; dpdy(x,y) = 3*x^3*y^2
Fx(x,y) = -α1(x,y)*lapu(x,y) + α2(x,y)*u(x,y) + α3(x,y)*dpdx(x,y)
Fy(x,y) = -α1(x,y)*lapv(x,y) + α2(x,y)*v(x,y) + α3(x,y)*dpdy(x,y)
ffx = Forcing(Fx)
ffy = Forcing(Fy)
bcfun = [dUBCf,dVBCf,ffx,ffy]
prob = Problem(mesh,Nodes,bcfun,OperatorType)
sol = solve(prob,mesh,param)
elapsed = time()-start
# compute condition number of operator matrix
#LinOp = GenerateSystem(mesh,prob,param)
#ApplyBC!(LinOp,mesh,prob,param,OperatorType)
#κ = cond(Array(LinOp.Op),2)
κ = 0.5
# compute mesh h
h = hCalc(mesh)
# generate exact solution
Uexact(x,y) = dUBCf.f(x,y)
Vexact(x,y) = dVBCf.f(x,y)
Pexact(x,y) = x^3*y^3
UexactArr = [Uexact.(mesh.xy[i].x,mesh.xy[i].y) for i=1:length(mesh.xy)]
VexactArr = [Vexact.(mesh.xy[i].x,mesh.xy[i].y) for i=1:length(mesh.xy)]
PexactArr = [Pexact.(mesh.xyp[i].x,mesh.xyp[i].y) for i=1:length(mesh.xyp)]
# compute difference
velErr = sqrt.((sol.u - UexactArr).^2 + (sol.v -VexactArr).^2)
presErr = sol.p - PexactArr
# compute Li norm
L1v = DomainNorm(mesh.xy,mesh.cm,velErr;normID="1")
L2v = DomainNorm(mesh.xy,mesh.cm,velErr;normID="2")
Linfv = DomainNorm(mesh.xy,mesh.cm,velErr;normID="Inf")
L1p = DomainNorm(mesh.xyp,mesh.cmp,presErr;normID="1")
L2p = DomainNorm(mesh.xyp,mesh.cmp,presErr;normID="2")
Linfp = DomainNorm(mesh.xyp,mesh.cmp,presErr;normID="Inf")
# plot solution
sD = ScalarData(sol.p,α1arr,α2arr,α3arr)
sN = ScalarNames("pressure","alpha_1","alpha_2","alpha_3")
vD = VectorData([sol.u,sol.v])
vN = VectorNames("velocity")
fn = Path("solution_var")
vtksave(mesh,sD,sN,vD,vN,fn)
# plot solution
sD = ScalarData(PexactArr)
sN = ScalarNames("pressure")
vD = VectorData([UexactArr,VexactArr])
vN = VectorNames("velocity")
fn = Path("exact_var")
vtksave(mesh,sD,sN,vD,vN,fn)
return κ,h,L1v,L2v,Linfv,L1p,L2p,Linfp,elapsed
end
Narr = [4,4,8,16,32,64]#,96]
N = length(Narr)
harr = zeros(N)
L1arrV = zeros(N)
L2arrV = zeros(N)
LInfarrV = zeros(N)
L1arrP = zeros(N)
L2arrP = zeros(N)
LInfarrP = zeros(N)
timearr = zeros(N)
κarr = zeros(N)
for i=1:N
n = Narr[i]
κarr[i],harr[i],L1arrV[i],L2arrV[i],LInfarrV[i],
L1arrP[i],L2arrP[i],LInfarrP[i],timearr[i] =
computeNorms(n)
println("completed N=$(n)")
end
κarr = κarr[2:end]
harr = harr[2:end]
L1arrV = L1arrV[2:end]
L2arrV = L2arrV[2:end]
LInfarrV = LInfarrV[2:end]
L1arrP = L1arrP[2:end]
L2arrP = L2arrP[2:end]
LInfarrP = LInfarrP[2:end]
timearr = timearr[2:end]
# export output to *.jld file
run(`mkdir -p data`)
save("data/TEMP_mpb2D_validation.jld", "harr",harr,
"VL1arr", L1arrV,
"VL2arr", L2arrV,
"VLInfarr",LInfarrV,
"PL1arr", L1arrP,
"PL2arr", L2arrP,
"PLInfarr",LInfarrP,
"timearr",timearr,
"κarr",κarr)
nothing
end
function DiffusionAndReactionTwoChemicalTestDriver(p::precipParam)
timer, mesh, soln, tsoln, prob = initializeData(p)
ψAParam = PoissonParam(p.κA)
ψBParam = PoissonParam(p.κB)
ψCParam = PoissonParam(p.κC)
M = generateMassMatrix(mesh.sMesh)
StiffA = GenerateSystem(mesh.sMesh,prob.ψA,ψAParam)
ApplyBC!(StiffA,mesh.sMesh,prob.ψA,ψAParam,prob.ψA.OperatorType)
StiffB = GenerateSystem(mesh.sMesh,prob.ψB,ψBParam)
ApplyBC!(StiffB,mesh.sMesh,prob.ψB,ψBParam,prob.ψB.OperatorType)
StiffC = GenerateSystem(mesh.sMesh,prob.ψC,ψCParam)
ApplyBC!(StiffC,mesh.sMesh,prob.ψC,ψCParam,prob.ψC.OperatorType)
intializeTimeSteppingTimer!(timer)
doPrinting!(timer,p,mesh,soln)
while timer.simulationTime < timer.finalTime
println("i1=",timer.stepIndex," ",computeTotalMass(p,mesh.sMesh,soln))
if timer.stepIndex < 5
soln.ψA.u = updateChemical(M,StiffA,tsoln.ψA.u,p;solver=:backwardeuler)
soln.ψB.u = updateChemical(M,StiffB,tsoln.ψB.u,p;solver=:backwardeuler)
soln.ψC.u = updateChemical(M,StiffC,tsoln.ψC.u,p;solver=:backwardeuler)
else
soln.ψA.u = updateChemical(M,StiffA,tsoln.ψA.u,p;solver=p.integrator)
soln.ψB.u = updateChemical(M,StiffB,tsoln.ψB.u,p;solver=p.integrator)
soln.ψC.u = updateChemical(M,StiffC,tsoln.ψC.u,p;solver=p.integrator)
end
println("i2=",timer.stepIndex," ",computeTotalMass(p,mesh.sMesh,soln))
computeReaction!(p,soln)
println("i3=",timer.stepIndex," ",computeTotalMass(p,mesh.sMesh,soln))
println()
tsoln = deepcopy(soln)
if isPrintIndex(timer)
doPrinting!(timer,p,mesh,soln)
end
updateSimulationTime!(timer)
updateStepIndex!(timer)
end
printSimulationFinishedMessage(timer)
nothing
end
function pureReactionTestDriver(p::precipParam)
timer, mesh, soln, tsoln, prob = initializeData(p)
randomizeScalarSolutions!(soln)
intializeTimeSteppingTimer!(timer)
doPrinting!(timer,p,mesh,soln)
while timer.simulationTime < timer.finalTime
computeReaction!(p,soln)
if isPrintIndex(timer)
doPrinting!(timer,p,mesh,soln)
end
tsoln = deepcopy(soln)
# step time
updateSimulationTime!(timer)
updateStepIndex!(timer)
end
printSimulationFinishedMessage(timer)
nothing
end
function initializeData(p::precipParam)
timer = initializeTimer(p)
mesh = initializeMeshes(p)
soln = initializeSolution(p)
tsoln = initializeSolution(p)
prob = defineProblems(p,mesh)
return timer, mesh, soln, tsoln, prob
end
function mpbFriction(θf::Vector{T}) where T<:Real
N = length(θf)
friction = zeros(N)
K=0.5
n=2
ξstar = 30.0
θstar = 0.5
h = 1000.0#computeH(ξstar,θstar,K,n)
for i=1:N
friction[i] = h*frictionKernel(θf[i],K,n)
end
return friction
end
function frictionKernel(θf,K,n)
θs = (1.0-θf)
return θs^n/(K^n + θs^n)
end
function computeH(ξstar,θstar,K,n)
return ξstar/frictionKernel(θstar,K,n)
end
| [
8818,
1057,
8890,
1741,
7,
79,
3712,
3866,
66,
541,
22973,
8,
198,
220,
466,
24243,
18557,
278,
7,
79,
8,
198,
220,
611,
279,
13,
5143,
2389,
6624,
352,
198,
220,
220,
220,
1388,
32103,
7,
79,
3712,
3866,
66,
541,
22973,
8,
198,
220,
2073,
361,
279,
13,
5143,
2389,
6624,
362,
198,
220,
220,
220,
5899,
28813,
4241,
3198,
41829,
605,
14402,
32103,
7,
79,
8,
198,
220,
2073,
361,
279,
13,
5143,
2389,
6624,
513,
198,
220,
220,
220,
5899,
2782,
303,
596,
3198,
41829,
605,
14402,
32103,
7,
79,
8,
198,
220,
2073,
361,
279,
13,
5143,
2389,
6624,
604,
198,
220,
220,
220,
1215,
303,
596,
28813,
4241,
3198,
41829,
605,
14402,
32103,
7,
79,
8,
198,
220,
2073,
361,
279,
13,
5143,
2389,
6624,
642,
198,
220,
220,
220,
7854,
13323,
589,
9414,
676,
805,
14402,
32103,
7,
79,
8,
198,
220,
2073,
361,
279,
13,
5143,
2389,
6624,
718,
198,
220,
220,
220,
10631,
4241,
1870,
3041,
2673,
7571,
41829,
605,
14402,
32103,
7,
79,
8,
198,
220,
2073,
361,
279,
13,
5143,
2389,
6624,
767,
198,
220,
220,
220,
5899,
3041,
2673,
14402,
32103,
7,
79,
8,
198,
220,
2073,
198,
220,
220,
220,
44872,
7203,
5143,
2389,
286,
33172,
79,
13,
5143,
2389,
553,
407,
8018,
19570,
198,
220,
220,
220,
44872,
7203,
5143,
2389,
352,
12,
22,
2672,
4943,
198,
220,
886,
628,
220,
2147,
198,
437,
198,
198,
8818,
1388,
32103,
7,
79,
3712,
3866,
66,
541,
22973,
8,
198,
220,
19781,
11,
19609,
11,
1540,
77,
11,
40379,
10875,
11,
1861,
796,
41216,
6601,
7,
79,
8,
628,
220,
1303,
4238,
29585,
805,
198,
220,
29034,
65,
17143,
796,
1709,
676,
805,
7378,
22973,
7,
16,
13,
15,
11,
3149,
65,
37,
46214,
7,
82,
10875,
13,
138,
116,
69,
13,
84,
828,
82,
10875,
13,
138,
116,
69,
13,
84,
8,
198,
220,
1540,
796,
8494,
7,
1676,
65,
13,
35522,
312,
11,
76,
5069,
13,
69,
37031,
11,
3149,
65,
17143,
8,
198,
220,
40379,
10875,
13,
35522,
312,
13,
84,
796,
1540,
13,
84,
198,
220,
40379,
10875,
13,
35522,
312,
13,
85,
796,
1540,
13,
85,
198,
220,
40379,
10875,
13,
35522,
312,
13,
79,
796,
1540,
13,
79,
628,
220,
493,
498,
1096,
7575,
7447,
2105,
48801,
0,
7,
45016,
8,
198,
220,
466,
18557,
278,
0,
7,
45016,
11,
79,
11,
76,
5069,
11,
912,
10875,
8,
198,
220,
981,
19781,
13,
14323,
1741,
7575,
1279,
19781,
13,
20311,
7575,
198,
220,
220,
220,
1303,
45,
3849,
79,
796,
4019,
198,
220,
220,
220,
1303,
3849,
79,
53,
874,
796,
1976,
27498,
7,
45,
3849,
79,
11,
21,
8,
198,
220,
220,
220,
1303,
11793,
69,
796,
616,
14214,
2550,
26933,
15,
13,
20,
11,
15,
13,
2718,
38430,
15,
13,
20,
12095,
15,
13,
2718,
12962,
628,
220,
220,
220,
1303,
6317,
198,
220,
220,
220,
24061,
3041,
2673,
0,
7,
79,
11,
912,
10875,
8,
198,
220,
220,
220,
1540,
77,
13,
138,
116,
82,
13,
84,
796,
40379,
10875,
13,
138,
116,
82,
13,
84,
198,
220,
220,
220,
1540,
77,
13,
138,
116,
69,
13,
84,
796,
40379,
10875,
13,
138,
116,
69,
13,
84,
628,
220,
220,
220,
7377,
116,
22184,
796,
3487,
1096,
62,
1169,
83,
1878,
7,
912,
10875,
13,
138,
116,
69,
13,
84,
8,
198,
220,
220,
220,
613,
2025,
6636,
1143,
796,
279,
13,
6435,
32,
19571,
7,
138,
116,
22184,
764,
10,
657,
13,
15,
764,
9,
7,
16,
764,
12,
7377,
116,
22184,
4008,
220,
220,
220,
220,
220,
220,
220,
1303,
657,
13,
15,
4613,
657,
13,
20,
198,
220,
220,
220,
613,
33,
11265,
1143,
796,
279,
13,
6435,
33,
19571,
7,
138,
116,
22184,
764,
10,
657,
13,
15,
764,
9,
7,
16,
764,
12,
7377,
116,
22184,
4008,
220,
220,
220,
220,
220,
220,
220,
1303,
657,
13,
15,
4613,
657,
13,
1495,
198,
220,
220,
220,
18074,
230,
2969,
41158,
796,
8007,
28813,
22973,
7,
912,
10875,
13,
35522,
312,
13,
84,
11,
912,
10875,
13,
35522,
312,
13,
85,
11,
431,
2025,
6636,
1143,
8,
198,
220,
220,
220,
18074,
230,
33,
22973,
796,
8007,
28813,
22973,
7,
912,
10875,
13,
35522,
312,
13,
84,
11,
912,
10875,
13,
35522,
312,
13,
85,
11,
431,
33,
11265,
1143,
8,
198,
220,
220,
220,
18074,
230,
8697,
41158,
796,
8007,
28813,
22973,
7,
912,
10875,
13,
35522,
312,
13,
84,
11,
912,
10875,
13,
35522,
312,
13,
85,
11,
79,
13,
6435,
34,
19571,
138,
116,
22184,
8,
628,
220,
220,
220,
1303,
512,
303,
596,
12,
26069,
4241,
198,
220,
220,
220,
337,
796,
7716,
20273,
46912,
54,
3351,
282,
283,
7,
76,
5069,
13,
82,
37031,
11,
138,
116,
22184,
8,
628,
220,
220,
220,
520,
733,
32,
796,
2980,
378,
11964,
7,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
32,
11,
139,
230,
2969,
41158,
8,
198,
220,
220,
220,
27967,
2749,
0,
7,
1273,
733,
32,
11,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
32,
11,
139,
230,
2969,
41158,
11,
1676,
65,
13,
139,
230,
32,
13,
18843,
1352,
6030,
8,
628,
220,
220,
220,
520,
733,
33,
796,
2980,
378,
11964,
7,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
33,
11,
139,
230,
33,
22973,
8,
198,
220,
220,
220,
27967,
2749,
0,
7,
1273,
733,
33,
11,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
33,
11,
139,
230,
33,
22973,
11,
1676,
65,
13,
139,
230,
33,
13,
18843,
1352,
6030,
8,
628,
220,
220,
220,
520,
733,
34,
796,
2980,
378,
11964,
7,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
34,
11,
139,
230,
8697,
41158,
8,
198,
220,
220,
220,
27967,
2749,
0,
7,
1273,
733,
34,
11,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
34,
11,
139,
230,
8697,
41158,
11,
1676,
65,
13,
139,
230,
34,
13,
18843,
1352,
6030,
8,
628,
220,
220,
220,
611,
19781,
13,
9662,
15732,
1279,
642,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
32,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
32,
11,
912,
10875,
13,
139,
230,
32,
13,
84,
11,
79,
26,
82,
14375,
28,
25,
1891,
904,
68,
18173,
8,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
33,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
33,
11,
912,
10875,
13,
139,
230,
33,
13,
84,
11,
79,
26,
82,
14375,
28,
25,
1891,
904,
68,
18173,
8,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
34,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
34,
11,
912,
10875,
13,
139,
230,
34,
13,
84,
11,
79,
26,
82,
14375,
28,
25,
1891,
904,
68,
18173,
8,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
32,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
32,
11,
912,
10875,
13,
139,
230,
32,
13,
84,
11,
79,
26,
82,
14375,
28,
79,
13,
18908,
12392,
8,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
33,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
33,
11,
912,
10875,
13,
139,
230,
33,
13,
84,
11,
79,
26,
82,
14375,
28,
79,
13,
18908,
12392,
8,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
34,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
34,
11,
912,
10875,
13,
139,
230,
34,
13,
84,
11,
79,
26,
82,
14375,
28,
79,
13,
18908,
12392,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
27268,
16578,
945,
523,
484,
836,
470,
467,
2174,
6632,
13,
198,
220,
220,
220,
329,
1312,
28,
16,
25,
13664,
7,
82,
10875,
13,
139,
230,
32,
13,
84,
8,
198,
220,
220,
220,
220,
220,
611,
1540,
77,
13,
139,
230,
32,
13,
84,
58,
72,
60,
1279,
657,
198,
220,
220,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
32,
13,
84,
58,
72,
60,
796,
657,
13,
15,
198,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
611,
1540,
77,
13,
139,
230,
33,
13,
84,
58,
72,
60,
1279,
657,
198,
220,
220,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
33,
13,
84,
58,
72,
60,
796,
657,
13,
15,
198,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
611,
1540,
77,
13,
139,
230,
34,
13,
84,
58,
72,
60,
1279,
657,
198,
220,
220,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
34,
13,
84,
58,
72,
60,
796,
657,
13,
15,
198,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
886,
628,
220,
220,
220,
1303,
29585,
805,
198,
220,
220,
220,
1303,
3487,
1096,
262,
83,
1878,
198,
220,
220,
220,
29034,
65,
17143,
796,
1709,
676,
805,
7378,
22973,
7,
16,
13,
15,
11,
3149,
65,
37,
46214,
7,
138,
116,
22184,
828,
138,
116,
22184,
8,
198,
220,
220,
220,
1540,
796,
8494,
7,
1676,
65,
13,
35522,
312,
11,
76,
5069,
13,
69,
37031,
11,
3149,
65,
17143,
8,
198,
220,
220,
220,
1540,
77,
13,
35522,
312,
13,
84,
796,
1540,
13,
84,
198,
220,
220,
220,
1540,
77,
13,
35522,
312,
13,
85,
796,
1540,
13,
85,
198,
220,
220,
220,
1540,
77,
13,
35522,
312,
13,
79,
796,
1540,
13,
79,
628,
220,
220,
220,
1303,
493,
538,
3225,
378,
3815,
198,
220,
220,
220,
1303,
87,
12786,
796,
1976,
27498,
7,
13664,
7,
76,
5069,
13,
82,
37031,
13,
5431,
4008,
198,
220,
220,
220,
1303,
88,
12786,
796,
1976,
27498,
7,
13664,
7,
76,
5069,
13,
82,
37031,
13,
5431,
4008,
198,
220,
220,
220,
1303,
1640,
1312,
28,
16,
25,
13664,
7,
76,
5069,
13,
82,
37031,
13,
5431,
8,
198,
220,
220,
220,
1303,
220,
2124,
12786,
58,
72,
60,
796,
19609,
13,
82,
37031,
13,
5431,
58,
72,
4083,
87,
198,
220,
220,
220,
1303,
220,
331,
12786,
58,
72,
60,
796,
19609,
13,
82,
37031,
13,
5431,
58,
72,
4083,
88,
198,
220,
220,
220,
1303,
437,
198,
220,
220,
220,
1303,
14761,
363,
796,
19862,
17034,
12195,
82,
10875,
13,
35522,
312,
13,
84,
13,
61,
17,
1343,
1540,
77,
13,
35522,
312,
13,
85,
13,
61,
17,
8,
198,
220,
220,
220,
1303,
3849,
79,
53,
874,
58,
45299,
16,
60,
796,
20321,
9492,
79,
7,
76,
5069,
13,
82,
37031,
11,
87,
12786,
11,
11793,
69,
11,
45,
3849,
79,
12,
16,
8,
198,
220,
220,
220,
1303,
3849,
79,
53,
874,
58,
45299,
17,
60,
796,
20321,
9492,
79,
7,
76,
5069,
13,
82,
37031,
11,
88,
12786,
11,
11793,
69,
11,
45,
3849,
79,
12,
16,
8,
198,
220,
220,
220,
1303,
3849,
79,
53,
874,
58,
45299,
18,
60,
796,
20321,
9492,
79,
7,
76,
5069,
13,
82,
37031,
11,
82,
10875,
13,
139,
230,
32,
13,
84,
11,
11793,
69,
11,
45,
3849,
79,
12,
16,
8,
198,
220,
220,
220,
1303,
3849,
79,
53,
874,
58,
45299,
19,
60,
796,
20321,
9492,
79,
7,
76,
5069,
13,
82,
37031,
11,
82,
10875,
13,
139,
230,
33,
13,
84,
11,
11793,
69,
11,
45,
3849,
79,
12,
16,
8,
198,
220,
220,
220,
1303,
3849,
79,
53,
874,
58,
45299,
20,
60,
796,
20321,
9492,
79,
7,
76,
5069,
13,
82,
37031,
11,
82,
10875,
13,
138,
116,
82,
13,
84,
11,
11793,
69,
11,
45,
3849,
79,
12,
16,
8,
198,
220,
220,
220,
1303,
3849,
79,
53,
874,
58,
45299,
21,
60,
796,
20321,
9492,
79,
7,
76,
5069,
13,
69,
37031,
11,
14761,
363,
11,
11793,
69,
11,
45,
3849,
79,
12,
16,
8,
628,
220,
220,
220,
40379,
10875,
796,
2769,
30073,
7,
82,
10875,
8,
198,
220,
220,
220,
611,
318,
18557,
15732,
7,
45016,
8,
198,
220,
220,
220,
220,
220,
1303,
3613,
39555,
515,
3815,
198,
220,
220,
220,
220,
220,
1303,
21928,
7753,
796,
4731,
7,
79,
13,
16928,
41092,
553,
14,
3849,
79,
53,
874,
62,
1600,
45016,
13,
4798,
15732,
553,
13,
73,
335,
17,
4943,
198,
220,
220,
220,
220,
220,
1303,
21928,
7,
21928,
7753,
11,
366,
2435,
1600,
19781,
13,
14323,
1741,
7575,
11,
366,
3849,
79,
53,
874,
1600,
987,
79,
53,
874,
8,
628,
220,
220,
220,
220,
220,
1303,
8850,
13570,
198,
220,
220,
220,
220,
220,
466,
18557,
278,
0,
7,
45016,
11,
79,
11,
76,
5069,
11,
82,
10875,
8,
198,
220,
220,
220,
886,
198,
220,
220,
220,
4296,
8890,
1741,
7575,
0,
7,
45016,
8,
198,
220,
220,
220,
4296,
8600,
15732,
0,
7,
45016,
8,
198,
220,
886,
628,
220,
3601,
8890,
1741,
18467,
1348,
12837,
7,
45016,
8,
628,
220,
2147,
198,
437,
198,
198,
8818,
3487,
1096,
62,
1169,
83,
1878,
7,
138,
116,
69,
3712,
38469,
90,
51,
30072,
810,
309,
27,
25,
15633,
198,
220,
399,
28,
13664,
7,
138,
116,
69,
8,
198,
220,
7377,
116,
69,
62,
11265,
1143,
796,
1976,
27498,
7,
51,
11,
45,
8,
198,
220,
309,
3535,
796,
657,
13,
16,
628,
220,
329,
1312,
28,
16,
25,
45,
198,
220,
220,
220,
611,
7377,
116,
69,
58,
72,
60,
1279,
309,
3535,
198,
220,
220,
220,
220,
220,
7377,
116,
69,
62,
11265,
1143,
58,
72,
60,
796,
309,
3535,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
7377,
116,
69,
62,
11265,
1143,
58,
72,
60,
796,
7377,
116,
69,
58,
72,
60,
198,
220,
220,
220,
886,
198,
220,
886,
628,
220,
1441,
7377,
116,
69,
62,
11265,
1143,
198,
437,
198,
198,
8818,
5899,
28813,
4241,
3198,
41829,
605,
14402,
32103,
7,
79,
3712,
3866,
66,
541,
22973,
8,
198,
220,
220,
220,
19781,
11,
19609,
11,
1540,
77,
11,
40379,
10875,
11,
1861,
796,
41216,
6601,
7,
79,
8,
628,
220,
220,
220,
18074,
230,
2969,
41158,
796,
7695,
30927,
22973,
7,
79,
13,
43000,
32,
8,
628,
220,
220,
220,
329,
1312,
28,
16,
25,
13664,
7,
82,
10875,
13,
138,
116,
69,
13,
84,
8,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
138,
116,
69,
13,
84,
58,
72,
60,
796,
657,
13,
16,
198,
220,
220,
220,
886,
628,
220,
220,
220,
337,
796,
7716,
20273,
46912,
54,
3351,
282,
283,
7,
76,
5069,
13,
82,
37031,
11,
82,
10875,
13,
138,
116,
69,
13,
84,
8,
198,
220,
220,
220,
520,
733,
32,
796,
2980,
378,
11964,
7,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
32,
11,
139,
230,
2969,
41158,
8,
198,
220,
220,
220,
27967,
2749,
0,
7,
1273,
733,
32,
11,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
32,
11,
139,
230,
2969,
41158,
11,
1676,
65,
13,
139,
230,
32,
13,
18843,
1352,
6030,
8,
628,
220,
220,
220,
493,
498,
1096,
7575,
7447,
2105,
48801,
0,
7,
45016,
8,
198,
220,
220,
220,
466,
18557,
278,
0,
7,
45016,
11,
79,
11,
76,
5069,
11,
82,
10875,
8,
198,
220,
220,
220,
981,
19781,
13,
14323,
1741,
7575,
1279,
19781,
13,
20311,
7575,
198,
220,
220,
220,
220,
220,
611,
19781,
13,
9662,
15732,
1279,
642,
198,
220,
220,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
32,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
32,
11,
912,
10875,
13,
139,
230,
32,
13,
84,
11,
79,
26,
82,
14375,
28,
25,
1891,
904,
68,
18173,
8,
198,
220,
220,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
32,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
32,
11,
912,
10875,
13,
139,
230,
32,
13,
84,
11,
79,
26,
82,
14375,
28,
79,
13,
18908,
12392,
8,
198,
220,
220,
220,
220,
220,
886,
628,
220,
220,
220,
220,
220,
40379,
10875,
796,
2769,
30073,
7,
82,
10875,
8,
198,
220,
220,
220,
220,
220,
611,
318,
18557,
15732,
7,
45016,
8,
198,
220,
220,
220,
220,
220,
220,
220,
466,
18557,
278,
0,
7,
45016,
11,
79,
11,
76,
5069,
11,
82,
10875,
8,
198,
220,
220,
220,
220,
220,
886,
198,
220,
220,
220,
220,
220,
4296,
8890,
1741,
7575,
0,
7,
45016,
8,
198,
220,
220,
220,
220,
220,
4296,
8600,
15732,
0,
7,
45016,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
3601,
8890,
1741,
18467,
1348,
12837,
7,
45016,
8,
628,
220,
220,
220,
2147,
198,
437,
198,
198,
8818,
5899,
2782,
303,
596,
3198,
41829,
605,
14402,
32103,
7,
79,
3712,
3866,
66,
541,
22973,
8,
198,
220,
44872,
7203,
37424,
512,
303,
596,
1332,
4639,
2125,
470,
27402,
1865,
4943,
198,
220,
2147,
198,
437,
198,
198,
8818,
1215,
303,
596,
28813,
4241,
3198,
41829,
605,
14402,
32103,
7,
79,
3712,
3866,
66,
541,
22973,
8,
198,
220,
44872,
7203,
324,
303,
596,
12,
26069,
4241,
1332,
4639,
2125,
470,
27402,
1865,
4943,
198,
220,
2147,
198,
437,
198,
198,
8818,
7854,
13323,
589,
9414,
676,
805,
14402,
32103,
7,
79,
3712,
3866,
66,
541,
22973,
8,
198,
220,
2163,
24061,
35393,
82,
7,
45,
8,
198,
220,
220,
220,
923,
796,
640,
3419,
198,
220,
220,
220,
1303,
3440,
19609,
198,
220,
220,
220,
19609,
796,
6616,
37031,
37,
2290,
312,
26933,
12,
17,
11,
17,
12095,
16,
11,
16,
4357,
45,
8,
628,
220,
220,
220,
26367,
16,
7,
87,
11,
88,
8,
796,
352,
13,
15,
198,
220,
220,
220,
26367,
17,
7,
87,
11,
88,
8,
796,
657,
13,
20,
10,
15,
13,
19,
9,
6966,
7,
18,
9,
87,
9,
88,
8,
198,
220,
220,
220,
26367,
18,
7,
87,
11,
88,
8,
796,
657,
13,
20,
10,
15,
13,
19,
9,
31369,
7,
22,
9,
87,
9,
88,
8,
628,
220,
220,
220,
2124,
76,
796,
685,
72,
13,
87,
329,
1312,
287,
19609,
13,
5431,
60,
198,
220,
220,
220,
331,
76,
796,
685,
72,
13,
88,
329,
1312,
287,
19609,
13,
5431,
60,
198,
220,
220,
220,
26367,
16,
3258,
796,
685,
17394,
16,
7,
87,
76,
58,
72,
4357,
4948,
58,
72,
12962,
329,
1312,
28,
16,
25,
13664,
7,
76,
5069,
13,
5431,
15437,
198,
220,
220,
220,
26367,
17,
3258,
796,
685,
17394,
17,
7,
87,
76,
58,
72,
4357,
4948,
58,
72,
12962,
329,
1312,
28,
16,
25,
13664,
7,
76,
5069,
13,
5431,
15437,
198,
220,
220,
220,
26367,
18,
3258,
796,
685,
17394,
18,
7,
87,
76,
58,
72,
4357,
4948,
58,
72,
12962,
329,
1312,
28,
16,
25,
13664,
7,
76,
5069,
13,
5431,
15437,
628,
220,
220,
220,
5772,
220,
796,
1709,
676,
805,
7378,
22973,
7,
17394,
16,
3258,
11,
17394,
17,
3258,
11,
17394,
18,
3258,
8,
628,
220,
220,
220,
35946,
6030,
796,
1058,
9414,
676,
805,
7378,
17,
35,
628,
220,
220,
220,
288,
45,
4147,
796,
36202,
488,
1616,
7,
25,
9464,
11,
25,
4852,
11,
25,
22487,
11,
25,
3506,
8,
198,
220,
220,
220,
399,
4147,
796,
685,
67,
45,
4147,
60,
628,
220,
220,
220,
334,
7,
87,
11,
88,
8,
796,
532,
87,
61,
19,
9,
88,
61,
17,
198,
220,
220,
220,
410,
7,
87,
11,
88,
8,
796,
604,
87,
61,
18,
9,
88,
61,
18,
14,
18,
628,
220,
220,
220,
288,
52,
2749,
69,
796,
36202,
488,
1616,
7,
357,
87,
11,
88,
8,
4613,
334,
7,
87,
11,
88,
8,
1267,
198,
220,
220,
220,
288,
53,
2749,
69,
796,
36202,
488,
1616,
7,
357,
87,
11,
88,
8,
4613,
410,
7,
87,
11,
88,
8,
1267,
628,
220,
220,
220,
288,
17,
67,
463,
87,
7,
87,
11,
88,
8,
796,
532,
1065,
9,
87,
61,
17,
9,
88,
61,
17,
26,
288,
17,
67,
463,
88,
7,
87,
11,
88,
8,
796,
532,
17,
9,
87,
61,
19,
198,
220,
220,
220,
288,
17,
67,
20306,
87,
7,
87,
11,
88,
8,
796,
807,
9,
87,
9,
88,
61,
18,
26,
220,
220,
220,
220,
288,
17,
67,
85,
9892,
7,
87,
11,
88,
8,
796,
807,
9,
87,
61,
18,
9,
88,
198,
220,
220,
220,
14779,
84,
7,
87,
11,
88,
8,
796,
288,
17,
67,
463,
87,
7,
87,
11,
88,
8,
1343,
288,
17,
67,
463,
88,
7,
87,
11,
88,
8,
198,
220,
220,
220,
14779,
85,
7,
87,
11,
88,
8,
796,
288,
17,
67,
20306,
87,
7,
87,
11,
88,
8,
1343,
288,
17,
67,
85,
9892,
7,
87,
11,
88,
8,
628,
220,
220,
220,
288,
30094,
87,
7,
87,
11,
88,
8,
796,
513,
9,
87,
61,
17,
9,
88,
61,
18,
26,
288,
79,
9892,
7,
87,
11,
88,
8,
796,
513,
9,
87,
61,
18,
9,
88,
61,
17,
628,
220,
220,
220,
376,
87,
7,
87,
11,
88,
8,
796,
532,
17394,
16,
7,
87,
11,
88,
27493,
37796,
84,
7,
87,
11,
88,
8,
1343,
26367,
17,
7,
87,
11,
88,
27493,
84,
7,
87,
11,
88,
8,
1343,
26367,
18,
7,
87,
11,
88,
27493,
26059,
34350,
7,
87,
11,
88,
8,
198,
220,
220,
220,
376,
88,
7,
87,
11,
88,
8,
796,
532,
17394,
16,
7,
87,
11,
88,
27493,
37796,
85,
7,
87,
11,
88,
8,
1343,
26367,
17,
7,
87,
11,
88,
27493,
85,
7,
87,
11,
88,
8,
1343,
26367,
18,
7,
87,
11,
88,
27493,
26059,
9892,
7,
87,
11,
88,
8,
628,
220,
220,
220,
277,
21373,
220,
220,
796,
1114,
2259,
7,
37,
87,
8,
198,
220,
220,
220,
277,
24928,
220,
220,
796,
1114,
2259,
7,
37,
88,
8,
198,
220,
220,
220,
47125,
12543,
796,
685,
67,
52,
2749,
69,
11,
67,
53,
2749,
69,
11,
487,
87,
11,
487,
88,
60,
628,
220,
220,
220,
1861,
796,
20647,
7,
76,
5069,
11,
45,
4147,
11,
15630,
12543,
11,
18843,
1352,
6030,
8,
198,
220,
220,
220,
1540,
796,
8494,
7,
1676,
65,
11,
76,
5069,
11,
17143,
8,
628,
220,
220,
220,
42118,
796,
640,
3419,
12,
9688,
628,
220,
220,
220,
1303,
24061,
4006,
1271,
286,
10088,
17593,
198,
220,
220,
220,
1303,
14993,
18257,
796,
2980,
378,
11964,
7,
76,
5069,
11,
1676,
65,
11,
17143,
8,
198,
220,
220,
220,
1303,
44836,
2749,
0,
7,
14993,
18257,
11,
76,
5069,
11,
1676,
65,
11,
17143,
11,
18843,
1352,
6030,
8,
198,
220,
220,
220,
1303,
43000,
796,
1779,
7,
19182,
7,
14993,
18257,
13,
18257,
828,
17,
8,
198,
220,
220,
220,
7377,
118,
796,
657,
13,
20,
628,
220,
220,
220,
1303,
24061,
19609,
289,
198,
220,
220,
220,
289,
796,
289,
9771,
66,
7,
76,
5069,
8,
628,
220,
220,
220,
1303,
7716,
2748,
4610,
198,
220,
220,
220,
471,
1069,
529,
7,
87,
11,
88,
8,
796,
288,
52,
2749,
69,
13,
69,
7,
87,
11,
88,
8,
198,
220,
220,
220,
569,
1069,
529,
7,
87,
11,
88,
8,
796,
288,
53,
2749,
69,
13,
69,
7,
87,
11,
88,
8,
198,
220,
220,
220,
350,
1069,
529,
7,
87,
11,
88,
8,
796,
2124,
61,
18,
9,
88,
61,
18,
198,
220,
220,
220,
471,
1069,
529,
3163,
81,
796,
685,
52,
1069,
529,
12195,
76,
5069,
13,
5431,
58,
72,
4083,
87,
11,
76,
5069,
13,
5431,
58,
72,
4083,
88,
8,
329,
1312,
28,
16,
25,
13664,
7,
76,
5069,
13,
5431,
15437,
198,
220,
220,
220,
569,
1069,
529,
3163,
81,
796,
685,
53,
1069,
529,
12195,
76,
5069,
13,
5431,
58,
72,
4083,
87,
11,
76,
5069,
13,
5431,
58,
72,
4083,
88,
8,
329,
1312,
28,
16,
25,
13664,
7,
76,
5069,
13,
5431,
15437,
198,
220,
220,
220,
350,
1069,
529,
3163,
81,
796,
685,
47,
1069,
529,
12195,
76,
5069,
13,
87,
4464,
58,
72,
4083,
87,
11,
76,
5069,
13,
87,
4464,
58,
72,
4083,
88,
8,
329,
1312,
28,
16,
25,
13664,
7,
76,
5069,
13,
87,
4464,
15437,
628,
220,
220,
220,
1303,
24061,
3580,
198,
220,
220,
220,
11555,
9139,
81,
796,
19862,
17034,
12195,
7,
34453,
13,
84,
532,
471,
1069,
529,
3163,
81,
737,
61,
17,
1343,
357,
34453,
13,
85,
532,
53,
1069,
529,
3163,
81,
737,
61,
17,
8,
198,
220,
220,
220,
906,
9139,
81,
796,
1540,
13,
79,
532,
350,
1069,
529,
3163,
81,
628,
220,
220,
220,
1303,
24061,
7455,
2593,
198,
220,
220,
220,
406,
16,
85,
220,
220,
796,
20021,
35393,
7,
76,
5069,
13,
5431,
11,
76,
5069,
13,
11215,
11,
626,
9139,
81,
26,
27237,
2389,
2625,
16,
4943,
198,
220,
220,
220,
406,
17,
85,
220,
220,
796,
20021,
35393,
7,
76,
5069,
13,
5431,
11,
76,
5069,
13,
11215,
11,
626,
9139,
81,
26,
27237,
2389,
2625,
17,
4943,
198,
220,
220,
220,
5164,
69,
85,
796,
20021,
35393,
7,
76,
5069,
13,
5431,
11,
76,
5069,
13,
11215,
11,
626,
9139,
81,
26,
27237,
2389,
2625,
18943,
4943,
198,
220,
220,
220,
406,
16,
79,
220,
220,
796,
20021,
35393,
7,
76,
5069,
13,
87,
4464,
11,
76,
5069,
13,
48991,
11,
18302,
9139,
81,
26,
27237,
2389,
2625,
16,
4943,
198,
220,
220,
220,
406,
17,
79,
220,
220,
796,
20021,
35393,
7,
76,
5069,
13,
87,
4464,
11,
76,
5069,
13,
48991,
11,
18302,
9139,
81,
26,
27237,
2389,
2625,
17,
4943,
198,
220,
220,
220,
5164,
46428,
796,
20021,
35393,
7,
76,
5069,
13,
87,
4464,
11,
76,
5069,
13,
48991,
11,
18302,
9139,
81,
26,
27237,
2389,
2625,
18943,
4943,
628,
220,
220,
220,
1303,
7110,
4610,
198,
220,
220,
220,
264,
35,
796,
34529,
283,
6601,
7,
34453,
13,
79,
11,
17394,
16,
3258,
11,
17394,
17,
3258,
11,
17394,
18,
3258,
8,
198,
220,
220,
220,
264,
45,
796,
34529,
283,
36690,
7203,
36151,
2430,
26591,
62,
16,
2430,
26591,
62,
17,
2430,
26591,
62,
18,
4943,
198,
220,
220,
220,
410,
35,
796,
20650,
6601,
26933,
34453,
13,
84,
11,
34453,
13,
85,
12962,
198,
220,
220,
220,
410,
45,
796,
20650,
36690,
7203,
626,
11683,
4943,
198,
220,
220,
220,
24714,
796,
10644,
7203,
82,
2122,
62,
7785,
4943,
198,
220,
220,
220,
410,
83,
591,
1015,
7,
76,
5069,
11,
82,
35,
11,
82,
45,
11,
85,
35,
11,
85,
45,
11,
22184,
8,
628,
220,
220,
220,
1303,
7110,
4610,
198,
220,
220,
220,
264,
35,
796,
34529,
283,
6601,
7,
47,
1069,
529,
3163,
81,
8,
198,
220,
220,
220,
264,
45,
796,
34529,
283,
36690,
7203,
36151,
4943,
198,
220,
220,
220,
410,
35,
796,
20650,
6601,
26933,
52,
1069,
529,
3163,
81,
11,
53,
1069,
529,
3163,
81,
12962,
198,
220,
220,
220,
410,
45,
796,
20650,
36690,
7203,
626,
11683,
4943,
198,
220,
220,
220,
24714,
796,
10644,
7203,
1069,
529,
62,
7785,
4943,
198,
220,
220,
220,
410,
83,
591,
1015,
7,
76,
5069,
11,
82,
35,
11,
82,
45,
11,
85,
35,
11,
85,
45,
11,
22184,
8,
628,
220,
220,
220,
1441,
7377,
118,
11,
71,
11,
43,
16,
85,
11,
43,
17,
85,
11,
43,
10745,
85,
11,
43,
16,
79,
11,
43,
17,
79,
11,
43,
10745,
79,
11,
417,
28361,
198,
220,
886,
628,
220,
28390,
220,
220,
220,
220,
796,
685,
19,
11,
19,
11,
23,
11,
1433,
11,
2624,
11,
2414,
60,
2,
11,
4846,
60,
198,
220,
399,
220,
220,
220,
220,
220,
220,
220,
796,
4129,
7,
45750,
8,
198,
220,
289,
3258,
220,
220,
220,
220,
796,
1976,
27498,
7,
45,
8,
198,
220,
406,
16,
3258,
53,
220,
220,
796,
1976,
27498,
7,
45,
8,
198,
220,
406,
17,
3258,
53,
220,
220,
796,
1976,
27498,
7,
45,
8,
198,
220,
406,
18943,
3258,
53,
796,
1976,
27498,
7,
45,
8,
198,
220,
406,
16,
3258,
47,
220,
220,
796,
1976,
27498,
7,
45,
8,
198,
220,
406,
17,
3258,
47,
220,
220,
796,
1976,
27498,
7,
45,
8,
198,
220,
406,
18943,
3258,
47,
796,
1976,
27498,
7,
45,
8,
198,
220,
4628,
451,
81,
220,
796,
1976,
27498,
7,
45,
8,
198,
220,
7377,
118,
3258,
220,
220,
220,
220,
796,
1976,
27498,
7,
45,
8,
628,
220,
329,
1312,
28,
16,
25,
45,
198,
220,
220,
220,
299,
796,
28390,
58,
72,
60,
198,
220,
220,
220,
7377,
118,
3258,
58,
72,
4357,
71,
3258,
58,
72,
4357,
43,
16,
3258,
53,
58,
72,
4357,
43,
17,
3258,
53,
58,
72,
4357,
43,
18943,
3258,
53,
58,
72,
4357,
198,
220,
220,
220,
220,
220,
406,
16,
3258,
47,
58,
72,
4357,
43,
17,
3258,
47,
58,
72,
4357,
43,
18943,
3258,
47,
58,
72,
4357,
16514,
451,
81,
58,
72,
60,
796,
198,
220,
220,
220,
220,
220,
24061,
35393,
82,
7,
77,
8,
198,
220,
220,
220,
220,
220,
44872,
7203,
785,
16838,
399,
43641,
7,
77,
8,
4943,
198,
220,
886,
628,
220,
7377,
118,
3258,
220,
220,
220,
220,
796,
7377,
118,
3258,
58,
17,
25,
437,
60,
198,
220,
289,
3258,
220,
220,
220,
220,
796,
289,
3258,
58,
17,
25,
437,
60,
198,
220,
406,
16,
3258,
53,
220,
220,
796,
406,
16,
3258,
53,
58,
17,
25,
437,
60,
198,
220,
406,
17,
3258,
53,
220,
220,
796,
406,
17,
3258,
53,
58,
17,
25,
437,
60,
198,
220,
406,
18943,
3258,
53,
796,
406,
18943,
3258,
53,
58,
17,
25,
437,
60,
198,
220,
406,
16,
3258,
47,
220,
220,
796,
406,
16,
3258,
47,
58,
17,
25,
437,
60,
198,
220,
406,
17,
3258,
47,
220,
220,
796,
406,
17,
3258,
47,
58,
17,
25,
437,
60,
198,
220,
406,
18943,
3258,
47,
796,
406,
18943,
3258,
47,
58,
17,
25,
437,
60,
198,
220,
4628,
451,
81,
220,
796,
4628,
451,
81,
58,
17,
25,
437,
60,
628,
220,
1303,
10784,
5072,
284,
46866,
73,
335,
2393,
198,
220,
1057,
7,
63,
28015,
15908,
532,
79,
1366,
63,
8,
628,
220,
3613,
7203,
7890,
14,
51,
39494,
62,
3149,
65,
17,
35,
62,
12102,
341,
13,
73,
335,
1600,
366,
71,
3258,
1600,
71,
3258,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
366,
47468,
16,
3258,
1600,
406,
16,
3258,
53,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
366,
47468,
17,
3258,
1600,
406,
17,
3258,
53,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
366,
47468,
18943,
3258,
1600,
43,
18943,
3258,
53,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
366,
6489,
16,
3258,
1600,
406,
16,
3258,
47,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
366,
6489,
17,
3258,
1600,
406,
17,
3258,
47,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
366,
6489,
18943,
3258,
1600,
43,
18943,
3258,
47,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
366,
16514,
451,
81,
1600,
16514,
451,
81,
11,
198,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
220,
366,
43000,
3258,
1600,
43000,
3258,
8,
628,
198,
220,
2147,
198,
437,
198,
198,
8818,
10631,
4241,
1870,
3041,
2673,
7571,
41829,
605,
14402,
32103,
7,
79,
3712,
3866,
66,
541,
22973,
8,
198,
220,
19781,
11,
19609,
11,
1540,
77,
11,
40379,
10875,
11,
1861,
796,
41216,
6601,
7,
79,
8,
628,
220,
18074,
230,
2969,
41158,
796,
7695,
30927,
22973,
7,
79,
13,
43000,
32,
8,
198,
220,
18074,
230,
33,
22973,
796,
7695,
30927,
22973,
7,
79,
13,
43000,
33,
8,
198,
220,
18074,
230,
8697,
41158,
796,
7695,
30927,
22973,
7,
79,
13,
43000,
34,
8,
628,
220,
337,
796,
7716,
20273,
46912,
7,
76,
5069,
13,
82,
37031,
8,
628,
220,
520,
733,
32,
796,
2980,
378,
11964,
7,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
32,
11,
139,
230,
2969,
41158,
8,
198,
220,
27967,
2749,
0,
7,
1273,
733,
32,
11,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
32,
11,
139,
230,
2969,
41158,
11,
1676,
65,
13,
139,
230,
32,
13,
18843,
1352,
6030,
8,
628,
220,
520,
733,
33,
796,
2980,
378,
11964,
7,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
33,
11,
139,
230,
33,
22973,
8,
198,
220,
27967,
2749,
0,
7,
1273,
733,
33,
11,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
33,
11,
139,
230,
33,
22973,
11,
1676,
65,
13,
139,
230,
33,
13,
18843,
1352,
6030,
8,
628,
220,
520,
733,
34,
796,
2980,
378,
11964,
7,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
34,
11,
139,
230,
8697,
41158,
8,
198,
220,
27967,
2749,
0,
7,
1273,
733,
34,
11,
76,
5069,
13,
82,
37031,
11,
1676,
65,
13,
139,
230,
34,
11,
139,
230,
8697,
41158,
11,
1676,
65,
13,
139,
230,
34,
13,
18843,
1352,
6030,
8,
628,
220,
493,
498,
1096,
7575,
7447,
2105,
48801,
0,
7,
45016,
8,
198,
220,
466,
18557,
278,
0,
7,
45016,
11,
79,
11,
76,
5069,
11,
82,
10875,
8,
198,
220,
981,
19781,
13,
14323,
1741,
7575,
1279,
19781,
13,
20311,
7575,
198,
220,
220,
220,
44872,
7203,
72,
16,
28,
1600,
45016,
13,
9662,
15732,
553,
33172,
5589,
1133,
14957,
20273,
7,
79,
11,
76,
5069,
13,
82,
37031,
11,
82,
10875,
4008,
198,
220,
220,
220,
611,
19781,
13,
9662,
15732,
1279,
642,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
32,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
32,
11,
912,
10875,
13,
139,
230,
32,
13,
84,
11,
79,
26,
82,
14375,
28,
25,
1891,
904,
68,
18173,
8,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
33,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
33,
11,
912,
10875,
13,
139,
230,
33,
13,
84,
11,
79,
26,
82,
14375,
28,
25,
1891,
904,
68,
18173,
8,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
34,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
34,
11,
912,
10875,
13,
139,
230,
34,
13,
84,
11,
79,
26,
82,
14375,
28,
25,
1891,
904,
68,
18173,
8,
198,
220,
220,
220,
2073,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
32,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
32,
11,
912,
10875,
13,
139,
230,
32,
13,
84,
11,
79,
26,
82,
14375,
28,
79,
13,
18908,
12392,
8,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
33,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
33,
11,
912,
10875,
13,
139,
230,
33,
13,
84,
11,
79,
26,
82,
14375,
28,
79,
13,
18908,
12392,
8,
198,
220,
220,
220,
220,
220,
1540,
77,
13,
139,
230,
34,
13,
84,
796,
4296,
41829,
605,
7,
44,
11,
1273,
733,
34,
11,
912,
10875,
13,
139,
230,
34,
13,
84,
11,
79,
26,
82,
14375,
28,
79,
13,
18908,
12392,
8,
198,
220,
220,
220,
886,
198,
220,
220,
220,
44872,
7203,
72,
17,
28,
1600,
45016,
13,
9662,
15732,
553,
33172,
5589,
1133,
14957,
20273,
7,
79,
11,
76,
5069,
13,
82,
37031,
11,
82,
10875,
4008,
198,
220,
220,
220,
24061,
3041,
2673,
0,
7,
79,
11,
82,
10875,
8,
198,
220,
220,
220,
44872,
7203,
72,
18,
28,
1600,
45016,
13,
9662,
15732,
553,
33172,
5589,
1133,
14957,
20273,
7,
79,
11,
76,
5069,
13,
82,
37031,
11,
82,
10875,
4008,
198,
220,
220,
220,
44872,
3419,
628,
220,
220,
220,
40379,
10875,
796,
2769,
30073,
7,
82,
10875,
8,
198,
220,
220,
220,
611,
318,
18557,
15732,
7,
45016,
8,
198,
220,
220,
220,
220,
220,
466,
18557,
278,
0,
7,
45016,
11,
79,
11,
76,
5069,
11,
82,
10875,
8,
198,
220,
220,
220,
886,
198,
220,
220,
220,
4296,
8890,
1741,
7575,
0,
7,
45016,
8,
198,
220,
220,
220,
4296,
8600,
15732,
0,
7,
45016,
8,
198,
220,
886,
628,
220,
3601,
8890,
1741,
18467,
1348,
12837,
7,
45016,
8,
628,
220,
2147,
198,
437,
198,
198,
8818,
5899,
3041,
2673,
14402,
32103,
7,
79,
3712,
3866,
66,
541,
22973,
8,
198,
220,
19781,
11,
19609,
11,
1540,
77,
11,
40379,
10875,
11,
1861,
796,
41216,
6601,
7,
79,
8,
628,
220,
4738,
1096,
3351,
282,
283,
50,
14191,
0,
7,
82,
10875,
8,
628,
220,
493,
498,
1096,
7575,
7447,
2105,
48801,
0,
7,
45016,
8,
198,
220,
466,
18557,
278,
0,
7,
45016,
11,
79,
11,
76,
5069,
11,
82,
10875,
8,
198,
220,
981,
19781,
13,
14323,
1741,
7575,
1279,
19781,
13,
20311,
7575,
198,
220,
220,
220,
24061,
3041,
2673,
0,
7,
79,
11,
82,
10875,
8,
628,
220,
220,
220,
611,
318,
18557,
15732,
7,
45016,
8,
198,
220,
220,
220,
220,
220,
466,
18557,
278,
0,
7,
45016,
11,
79,
11,
76,
5069,
11,
82,
10875,
8,
198,
220,
220,
220,
886,
628,
220,
220,
220,
40379,
10875,
796,
2769,
30073,
7,
82,
10875,
8,
628,
220,
220,
220,
1303,
2239,
640,
198,
220,
220,
220,
4296,
8890,
1741,
7575,
0,
7,
45016,
8,
198,
220,
220,
220,
4296,
8600,
15732,
0,
7,
45016,
8,
198,
220,
886,
628,
220,
3601,
8890,
1741,
18467,
1348,
12837,
7,
45016,
8,
628,
220,
2147,
198,
437,
198,
198,
8818,
41216,
6601,
7,
79,
3712,
3866,
66,
541,
22973,
8,
198,
220,
19781,
796,
41216,
48801,
7,
79,
8,
198,
220,
19609,
796,
41216,
44,
274,
956,
7,
79,
8,
198,
220,
1540,
77,
796,
41216,
46344,
7,
79,
8,
198,
220,
40379,
10875,
796,
41216,
46344,
7,
79,
8,
198,
220,
1861,
796,
8160,
2964,
22143,
7,
79,
11,
76,
5069,
8,
628,
220,
1441,
19781,
11,
19609,
11,
1540,
77,
11,
40379,
10875,
11,
1861,
198,
437,
198,
198,
8818,
29034,
65,
37,
46214,
7,
138,
116,
69,
3712,
38469,
90,
51,
30072,
810,
309,
27,
25,
15633,
198,
220,
399,
796,
4129,
7,
138,
116,
69,
8,
198,
220,
23822,
796,
1976,
27498,
7,
45,
8,
628,
220,
509,
28,
15,
13,
20,
198,
220,
299,
28,
17,
198,
220,
7377,
122,
7364,
796,
1542,
13,
15,
198,
220,
7377,
116,
7364,
796,
657,
13,
20,
198,
220,
289,
796,
8576,
13,
15,
2,
5589,
1133,
39,
7,
138,
122,
7364,
11,
138,
116,
7364,
11,
42,
11,
77,
8,
628,
220,
329,
1312,
28,
16,
25,
45,
198,
220,
220,
220,
23822,
58,
72,
60,
796,
289,
9,
69,
46214,
42,
7948,
7,
138,
116,
69,
58,
72,
4357,
42,
11,
77,
8,
198,
220,
886,
628,
220,
1441,
23822,
198,
437,
198,
198,
8818,
23822,
42,
7948,
7,
138,
116,
69,
11,
42,
11,
77,
8,
198,
220,
7377,
116,
82,
796,
357,
16,
13,
15,
12,
138,
116,
69,
8,
198,
220,
1441,
7377,
116,
82,
61,
77,
29006,
42,
61,
77,
1343,
7377,
116,
82,
61,
77,
8,
198,
437,
198,
198,
8818,
24061,
39,
7,
138,
122,
7364,
11,
138,
116,
7364,
11,
42,
11,
77,
8,
198,
220,
1441,
7377,
122,
7364,
14,
69,
46214,
42,
7948,
7,
138,
116,
7364,
11,
42,
11,
77,
8,
198,
437,
198
] | 1.887396 | 6,847 |
using Maker
using Base.Test
using Glob
x = [ 3.14159 6.28319 9.42478
12.5664 15.708 18.8496
21.9911 25.1327 28.2743 ]
writecsv("in1.csv", x)
writecsv("in2.csv", 3x)
inputs = glob("in*.csv")
outputs = ["$(splitext(f)[1])-out.csv" for f in inputs]
for i in eachindex(inputs)
inp = inputs[i]
Maker.file(inp)
dest = outputs[i]
Maker.file(dest, inp) do
out = 2 * readcsv(inp, skipstart = 1)
writecsv(dest, out)
end
end
Maker.task("default", outputs)
Maker.clean(outputs)
Maker.task("clean2") do # another way to clean
println("CLEAN2")
for fn in glob("in*-out.csv")
Maker.rm(fn)
end
end
Maker.task("cleanall") do # another way to clean
for fn in glob("in*.csv")
Maker.rm(fn)
end
end
make()
@test isfile(outputs[1])
@test isfile(outputs[2])
make("clean")
@test !isfile(outputs[1])
@test !isfile(outputs[2])
make([]) # the [] are to test this call method
@test isfile(outputs[1])
@test isfile(outputs[2])
make("clean2")
@test !isfile(outputs[1])
@test !isfile(outputs[2])
make("cleanall")
| [
198,
3500,
21521,
198,
3500,
7308,
13,
14402,
198,
3500,
40713,
198,
198,
87,
796,
685,
513,
13,
1415,
19707,
220,
220,
718,
13,
30290,
1129,
220,
220,
860,
13,
40090,
3695,
198,
220,
220,
220,
220,
220,
1105,
13,
3980,
2414,
220,
220,
1315,
13,
32583,
220,
220,
220,
1248,
13,
23,
37747,
198,
220,
220,
220,
220,
220,
2310,
13,
2079,
1157,
220,
220,
1679,
13,
1485,
1983,
220,
220,
2579,
13,
1983,
3559,
2361,
198,
13564,
40664,
7203,
259,
16,
13,
40664,
1600,
2124,
8,
220,
220,
220,
220,
220,
220,
198,
13564,
40664,
7203,
259,
17,
13,
40664,
1600,
513,
87,
8,
220,
220,
220,
220,
220,
220,
198,
198,
15414,
82,
796,
15095,
7203,
259,
24620,
40664,
4943,
198,
22915,
82,
796,
14631,
3,
7,
22018,
578,
742,
7,
69,
38381,
16,
12962,
12,
448,
13,
40664,
1,
329,
277,
287,
17311,
60,
198,
198,
1640,
1312,
287,
1123,
9630,
7,
15414,
82,
8,
198,
220,
220,
220,
287,
79,
796,
17311,
58,
72,
60,
198,
220,
220,
220,
21521,
13,
7753,
7,
259,
79,
8,
198,
220,
220,
220,
2244,
796,
23862,
58,
72,
60,
198,
220,
220,
220,
21521,
13,
7753,
7,
16520,
11,
287,
79,
8,
466,
198,
220,
220,
220,
220,
220,
220,
220,
503,
796,
362,
1635,
1100,
40664,
7,
259,
79,
11,
14267,
9688,
796,
352,
8,
198,
220,
220,
220,
220,
220,
220,
220,
3551,
40664,
7,
16520,
11,
503,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
48890,
13,
35943,
7203,
12286,
1600,
23862,
8,
198,
198,
48890,
13,
27773,
7,
22915,
82,
8,
198,
198,
48890,
13,
35943,
7203,
27773,
17,
4943,
466,
220,
220,
1303,
1194,
835,
284,
3424,
198,
220,
220,
220,
44872,
7203,
29931,
1565,
17,
4943,
198,
220,
220,
220,
329,
24714,
287,
15095,
7203,
259,
9,
12,
448,
13,
40664,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
21521,
13,
26224,
7,
22184,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
48890,
13,
35943,
7203,
27773,
439,
4943,
466,
220,
220,
1303,
1194,
835,
284,
3424,
198,
220,
220,
220,
329,
24714,
287,
15095,
7203,
259,
24620,
40664,
4943,
198,
220,
220,
220,
220,
220,
220,
220,
21521,
13,
26224,
7,
22184,
8,
198,
220,
220,
220,
886,
198,
437,
198,
198,
15883,
3419,
198,
198,
31,
9288,
318,
7753,
7,
22915,
82,
58,
16,
12962,
198,
31,
9288,
318,
7753,
7,
22915,
82,
58,
17,
12962,
198,
198,
15883,
7203,
27773,
4943,
220,
198,
198,
31,
9288,
5145,
4468,
576,
7,
22915,
82,
58,
16,
12962,
198,
31,
9288,
5145,
4468,
576,
7,
22915,
82,
58,
17,
12962,
198,
198,
15883,
26933,
12962,
1303,
262,
17635,
389,
284,
1332,
428,
869,
2446,
198,
198,
31,
9288,
318,
7753,
7,
22915,
82,
58,
16,
12962,
198,
31,
9288,
318,
7753,
7,
22915,
82,
58,
17,
12962,
198,
198,
15883,
7203,
27773,
17,
4943,
220,
198,
198,
31,
9288,
5145,
4468,
576,
7,
22915,
82,
58,
16,
12962,
198,
31,
9288,
5145,
4468,
576,
7,
22915,
82,
58,
17,
12962,
198,
198,
15883,
7203,
27773,
439,
4943,
220,
198
] | 2.136015 | 522 |
@safetestset gray_code_symmetry = "Gray code symmetry" begin
using BijectiveHilbert
# for i in 0:10
# println(lpad(i, 3, " "), " ", lpad(string(BijectiveHilbert.brgc(i), base = 2), 8, "0"))
# end
# Here's a test of the gray code.
n = 5
for i in 0x0:(0x1 << n - 0x1)
# println(BijectiveHilbert.brgc(1<<n - 1 - i), " ", BijectiveHilbert.brgc(i) ⊻ (1 << (n-1)))
@test(BijectiveHilbert.brgc(1<<n - 1 - i) == BijectiveHilbert.brgc(i) ⊻ (1 << (n - 1)))
end
end
@safetestset gray_code_single = "Gray code changes one bit" begin
using BijectiveHilbert: brgc, is_power_of_two
for i in 0x1:0x1000
@test is_power_of_two(brgc(i) ⊻ brgc(i + 1))
end
end
@safetestset brgc_own_inverse = "Gray code is own inverse" begin
using BijectiveHilbert
for i in 0x0:0x1000
@test(BijectiveHilbert.brgc_inv(BijectiveHilbert.brgc(i)) == i)
end
end
@safetestset brgc_equals_naive = "Gray code matches paper description" begin
using BijectiveHilbert: brgc_inv
using Random
rng = MersenneTwister(9719742)
for T in [UInt8, UInt16, UInt32, UInt64]
for trial in 1:10000
v = rand(rng, T)
n = brgc_inv(Int128(v)) # The paper version is used for integers.
i = brgc_inv(v)
@test n == i
end
end
end
@safetestset brgc_ranks_equal = "the rank calculation is the same as the paper" begin
using BijectiveHilbert: brgc_rank, brgc_rank2
using Random
rng = MersenneTwister(974073242)
for trial in 1:1000
n = rand(rng, 2:7)
w = UInt8(rand(rng, 0:(1<<n - 1)))
mask = UInt8(rand(rng, 0:(1<<n - 1)))
a = brgc_rank(mask, w, n)
b = brgc_rank2(mask, w, n)
@test a == b
end
end
| [
31,
49585,
316,
395,
2617,
12768,
62,
8189,
62,
1837,
3020,
11973,
796,
366,
46130,
2438,
40686,
1,
2221,
198,
3500,
8436,
752,
425,
39,
346,
4835,
198,
2,
329,
1312,
287,
657,
25,
940,
198,
2,
220,
220,
220,
220,
44872,
7,
75,
15636,
7,
72,
11,
513,
11,
366,
366,
828,
366,
33172,
300,
15636,
7,
8841,
7,
23286,
752,
425,
39,
346,
4835,
13,
1671,
36484,
7,
72,
828,
2779,
796,
362,
828,
807,
11,
366,
15,
48774,
198,
2,
886,
198,
2,
3423,
338,
257,
1332,
286,
262,
12768,
2438,
13,
198,
77,
796,
642,
198,
1640,
1312,
287,
657,
87,
15,
37498,
15,
87,
16,
9959,
299,
532,
657,
87,
16,
8,
198,
220,
220,
220,
1303,
44872,
7,
23286,
752,
425,
39,
346,
4835,
13,
1671,
36484,
7,
16,
16791,
77,
532,
352,
532,
1312,
828,
366,
33172,
8436,
752,
425,
39,
346,
4835,
13,
1671,
36484,
7,
72,
8,
2343,
232,
119,
357,
16,
9959,
357,
77,
12,
16,
22305,
198,
220,
220,
220,
2488,
9288,
7,
23286,
752,
425,
39,
346,
4835,
13,
1671,
36484,
7,
16,
16791,
77,
532,
352,
532,
1312,
8,
6624,
8436,
752,
425,
39,
346,
4835,
13,
1671,
36484,
7,
72,
8,
2343,
232,
119,
357,
16,
9959,
357,
77,
532,
352,
22305,
198,
437,
198,
437,
198,
198,
31,
49585,
316,
395,
2617,
12768,
62,
8189,
62,
29762,
796,
366,
46130,
2438,
2458,
530,
1643,
1,
2221,
198,
3500,
8436,
752,
425,
39,
346,
4835,
25,
865,
36484,
11,
318,
62,
6477,
62,
1659,
62,
11545,
198,
1640,
1312,
287,
657,
87,
16,
25,
15,
87,
12825,
198,
220,
220,
220,
2488,
9288,
318,
62,
6477,
62,
1659,
62,
11545,
7,
1671,
36484,
7,
72,
8,
2343,
232,
119,
865,
36484,
7,
72,
1343,
352,
4008,
198,
437,
198,
437,
628,
198,
31,
49585,
316,
395,
2617,
865,
36484,
62,
593,
62,
259,
4399,
796,
366,
46130,
2438,
318,
898,
34062,
1,
2221,
198,
3500,
8436,
752,
425,
39,
346,
4835,
198,
1640,
1312,
287,
657,
87,
15,
25,
15,
87,
12825,
198,
220,
220,
220,
2488,
9288,
7,
23286,
752,
425,
39,
346,
4835,
13,
1671,
36484,
62,
16340,
7,
23286,
752,
425,
39,
346,
4835,
13,
1671,
36484,
7,
72,
4008,
6624,
1312,
8,
198,
437,
198,
437,
628,
198,
31,
49585,
316,
395,
2617,
865,
36484,
62,
4853,
874,
62,
2616,
425,
796,
366,
46130,
2438,
7466,
3348,
6764,
1,
2221,
198,
3500,
8436,
752,
425,
39,
346,
4835,
25,
865,
36484,
62,
16340,
198,
3500,
14534,
198,
81,
782,
796,
337,
364,
29727,
5080,
1694,
7,
5607,
24991,
3682,
8,
198,
1640,
309,
287,
685,
52,
5317,
23,
11,
471,
5317,
1433,
11,
471,
5317,
2624,
11,
471,
5317,
2414,
60,
198,
220,
220,
220,
329,
4473,
287,
352,
25,
49388,
198,
220,
220,
220,
220,
220,
220,
220,
410,
796,
43720,
7,
81,
782,
11,
309,
8,
198,
220,
220,
220,
220,
220,
220,
220,
299,
796,
865,
36484,
62,
16340,
7,
5317,
12762,
7,
85,
4008,
220,
1303,
383,
3348,
2196,
318,
973,
329,
37014,
13,
198,
220,
220,
220,
220,
220,
220,
220,
1312,
796,
865,
36484,
62,
16340,
7,
85,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
299,
6624,
1312,
198,
220,
220,
220,
886,
198,
437,
198,
437,
628,
198,
31,
49585,
316,
395,
2617,
865,
36484,
62,
81,
2283,
62,
40496,
796,
366,
1169,
4279,
17952,
318,
262,
976,
355,
262,
3348,
1,
2221,
198,
220,
220,
220,
1262,
8436,
752,
425,
39,
346,
4835,
25,
865,
36484,
62,
43027,
11,
865,
36484,
62,
43027,
17,
198,
220,
220,
220,
1262,
14534,
198,
220,
220,
220,
374,
782,
796,
337,
364,
29727,
5080,
1694,
7,
5607,
1821,
4790,
27877,
8,
198,
220,
220,
220,
329,
4473,
287,
352,
25,
12825,
198,
220,
220,
220,
220,
220,
220,
220,
299,
796,
43720,
7,
81,
782,
11,
362,
25,
22,
8,
198,
220,
220,
220,
220,
220,
220,
220,
266,
796,
471,
5317,
23,
7,
25192,
7,
81,
782,
11,
657,
37498,
16,
16791,
77,
532,
352,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
9335,
796,
471,
5317,
23,
7,
25192,
7,
81,
782,
11,
657,
37498,
16,
16791,
77,
532,
352,
22305,
198,
220,
220,
220,
220,
220,
220,
220,
257,
796,
865,
36484,
62,
43027,
7,
27932,
11,
266,
11,
299,
8,
198,
220,
220,
220,
220,
220,
220,
220,
275,
796,
865,
36484,
62,
43027,
17,
7,
27932,
11,
266,
11,
299,
8,
198,
220,
220,
220,
220,
220,
220,
220,
2488,
9288,
257,
6624,
275,
198,
220,
220,
220,
886,
198,
437,
198
] | 2.141935 | 775 |
# TemplateName
isNull(x::TemplateName) = clang_TemplateName_isNull(x)
getKind(x::TemplateName) = clang_TemplateName_getKind(x)
getUnderlying(x::TemplateName) = TemplateName(clang_TemplateName_getUnderlying(x))
getNameToSubstitute(x::TemplateName) = TemplateName(clang_TemplateName_getNameToSubstitute(x))
isDependent(x::TemplateName) = clang_TemplateName_isDependent(x)
isInstantiationDependent(x::TemplateName) = clang_TemplateName_isInstantiationDependent(x)
containsUnexpandedParameterPack(x::TemplateName) = clang_TemplateName_containsUnexpandedParameterPack(x)
dump(x::TemplateName) = clang_TemplateName_dump(x)
function getTemplateName(x::TemplateSpecializationType)
return TemplateName(clang_TemplateSpecializationType_getTemplateName(get_type_ptr(x)))
end
| [
2,
37350,
5376,
198,
271,
35067,
7,
87,
3712,
30800,
5376,
8,
796,
537,
648,
62,
30800,
5376,
62,
271,
35067,
7,
87,
8,
198,
198,
1136,
35854,
7,
87,
3712,
30800,
5376,
8,
796,
537,
648,
62,
30800,
5376,
62,
1136,
35854,
7,
87,
8,
198,
198,
1136,
9203,
3157,
7,
87,
3712,
30800,
5376,
8,
796,
37350,
5376,
7,
565,
648,
62,
30800,
5376,
62,
1136,
9203,
3157,
7,
87,
4008,
198,
198,
1136,
5376,
2514,
7004,
301,
3678,
7,
87,
3712,
30800,
5376,
8,
796,
37350,
5376,
7,
565,
648,
62,
30800,
5376,
62,
1136,
5376,
2514,
7004,
301,
3678,
7,
87,
4008,
198,
198,
271,
35,
8682,
7,
87,
3712,
30800,
5376,
8,
796,
537,
648,
62,
30800,
5376,
62,
271,
35,
8682,
7,
87,
8,
198,
198,
271,
49933,
3920,
35,
8682,
7,
87,
3712,
30800,
5376,
8,
796,
537,
648,
62,
30800,
5376,
62,
271,
49933,
3920,
35,
8682,
7,
87,
8,
198,
198,
3642,
1299,
52,
12413,
79,
12249,
36301,
11869,
7,
87,
3712,
30800,
5376,
8,
796,
537,
648,
62,
30800,
5376,
62,
3642,
1299,
52,
12413,
79,
12249,
36301,
11869,
7,
87,
8,
198,
198,
39455,
7,
87,
3712,
30800,
5376,
8,
796,
537,
648,
62,
30800,
5376,
62,
39455,
7,
87,
8,
198,
198,
8818,
651,
30800,
5376,
7,
87,
3712,
30800,
13409,
1634,
6030,
8,
198,
220,
220,
220,
1441,
37350,
5376,
7,
565,
648,
62,
30800,
13409,
1634,
6030,
62,
1136,
30800,
5376,
7,
1136,
62,
4906,
62,
20692,
7,
87,
22305,
198,
437,
198
] | 3.019455 | 257 |
{"score": 7.12, "timestamp": 1578181700.0, "score_count": 44451}
{"score": 7.14, "timestamp": 1565539880.0, "score_count": 41791}
{"score": 7.14, "timestamp": 1562142700.0, "score_count": 41108}
{"score": 7.15, "timestamp": 1555037594.0, "score_count": 39540}
{"score": 7.17, "timestamp": 1547868691.0, "score_count": 37409}
{"score": 7.17, "timestamp": 1546128647.0, "score_count": 36649}
{"score": 7.21, "timestamp": 1530985596.0, "score_count": 31208}
{"score": 7.41, "timestamp": 1518033556.0, "score_count": 7794}
{"score": 7.43, "timestamp": 1516714701.0, "score_count": 5608}
{"score": 7.47, "timestamp": 1516241558.0, "score_count": 4575}
{"score": 7.59, "timestamp": 1515634250.0, "score_count": 2726}
{"score": 7.17, "timestamp": 1547899211.0, "score_count": 37409}
{"score": 7.17, "timestamp": 1546133359.0, "score_count": 36649}
{"score": 7.4, "timestamp": 1519505464.0, "score_count": 9468}
| [
4895,
26675,
1298,
767,
13,
1065,
11,
366,
16514,
27823,
1298,
1315,
3695,
1507,
1558,
405,
13,
15,
11,
366,
26675,
62,
9127,
1298,
5846,
36330,
92,
198,
4895,
26675,
1298,
767,
13,
1415,
11,
366,
16514,
27823,
1298,
23871,
2816,
31952,
1795,
13,
15,
11,
366,
26675,
62,
9127,
1298,
47580,
6420,
92,
198,
4895,
26675,
1298,
767,
13,
1415,
11,
366,
16514,
27823,
1298,
1315,
5237,
1415,
1983,
405,
13,
15,
11,
366,
26675,
62,
9127,
1298,
6073,
15711,
92,
198,
4895,
26675,
1298,
767,
13,
1314,
11,
366,
16514,
27823,
1298,
20708,
1120,
22318,
5824,
13,
15,
11,
366,
26675,
62,
9127,
1298,
42321,
1821,
92,
198,
4895,
26675,
1298,
767,
13,
1558,
11,
366,
16514,
27823,
1298,
1315,
29059,
3104,
49541,
13,
15,
11,
366,
26675,
62,
9127,
1298,
5214,
29416,
92,
198,
4895,
26675,
1298,
767,
13,
1558,
11,
366,
16514,
27823,
1298,
1315,
3510,
12762,
33981,
13,
15,
11,
366,
26675,
62,
9127,
1298,
4570,
33300,
92,
198,
4895,
26675,
1298,
767,
13,
2481,
11,
366,
16514,
27823,
1298,
1315,
1270,
4089,
2816,
4846,
13,
15,
11,
366,
26675,
62,
9127,
1298,
34465,
2919,
92,
198,
4895,
26675,
1298,
767,
13,
3901,
11,
366,
16514,
27823,
1298,
1315,
15259,
2091,
37864,
13,
15,
11,
366,
26675,
62,
9127,
1298,
767,
50242,
92,
198,
4895,
26675,
1298,
767,
13,
3559,
11,
366,
16514,
27823,
1298,
1315,
21940,
20198,
486,
13,
15,
11,
366,
26675,
62,
9127,
1298,
642,
28688,
92,
198,
4895,
26675,
1298,
767,
13,
2857,
11,
366,
16514,
27823,
1298,
1315,
1433,
1731,
1314,
3365,
13,
15,
11,
366,
26675,
62,
9127,
1298,
4153,
2425,
92,
198,
4895,
26675,
1298,
767,
13,
3270,
11,
366,
16514,
27823,
1298,
1315,
21599,
2682,
9031,
13,
15,
11,
366,
26675,
62,
9127,
1298,
2681,
2075,
92,
198,
4895,
26675,
1298,
767,
13,
1558,
11,
366,
16514,
27823,
1298,
1315,
29059,
2079,
21895,
13,
15,
11,
366,
26675,
62,
9127,
1298,
5214,
29416,
92,
198,
4895,
26675,
1298,
767,
13,
1558,
11,
366,
16514,
27823,
1298,
1315,
3510,
1485,
2091,
3270,
13,
15,
11,
366,
26675,
62,
9127,
1298,
4570,
33300,
92,
198,
4895,
26675,
1298,
767,
13,
19,
11,
366,
16514,
27823,
1298,
1315,
42751,
4051,
2414,
13,
15,
11,
366,
26675,
62,
9127,
1298,
10048,
3104,
92,
198
] | 2.360313 | 383 |
import ..UncertainValues.TheoreticalDistributionScalarValue
import ..UncertainValues.UncertainScalarBinomialDistributed
import ..UncertainValues.UncertainScalarBetaBinomialDistributed
import ..UncertainValues: AbstractUncertainValue
import Distributions.pdf
import ..SamplingConstraints:
SamplingConstraint,
constrain
function get_density(uv::AbstractUncertainValue)
some_sample = resample(uv, 10000)
xmin = minimum(some_sample) * 0.97
xmax = maximum(some_sample) * 1.03
step = (xmax-xmin)/300
xvals = xmin:step:xmax+step
density = pdf.(uv.distribution, xvals)
xvals, density ./ sum(density)
end
function get_density(uv::UncertainScalarBinomialDistributed)
some_sample = resample(uv, 10000)
xmin = minimum(some_sample)
xmax = maximum(some_sample)
xvals = xmin:1:xmax
density = pdf.(uv.distribution, xvals)
xvals, density ./ sum(density)
end
function get_density(uv::UncertainScalarBetaBinomialDistributed)
some_sample = resample(uv, 10000)
xmin = minimum(some_sample)
xmax = maximum(some_sample)
xvals = xmin:1:xmax
density = pdf.(uv.distribution, xvals)
xvals, density ./ sum(density)
end
@recipe function plot_theoretical(uv::TheoreticalDistributionScalarValue,
density = true, n_samples = 1000)
if density
@series begin
get_density(uv)
end
else
@series begin
label --> ""
resample(uv, n_samples)
end
end
end
@recipe function plot_theoretical(uv::TheoreticalDistributionScalarValue,
constraint::SamplingConstraint, density = true, n_samples = 1000)
cuv = constrain(uv, constraint)
if density
@series begin
get_density(cuv)
end
else
@series begin
label --> ""
resample(cuv, n_samples)
end
end
end
| [
11748,
11485,
3118,
39239,
40161,
13,
464,
9997,
605,
20344,
3890,
3351,
282,
283,
11395,
198,
11748,
11485,
3118,
39239,
40161,
13,
3118,
39239,
3351,
282,
283,
33,
259,
49070,
20344,
6169,
198,
11748,
11485,
3118,
39239,
40161,
13,
3118,
39239,
3351,
282,
283,
43303,
33,
259,
49070,
20344,
6169,
198,
11748,
11485,
3118,
39239,
40161,
25,
27741,
3118,
39239,
11395,
198,
198,
11748,
46567,
507,
13,
12315,
198,
198,
11748,
11485,
16305,
11347,
3103,
2536,
6003,
25,
220,
198,
220,
220,
220,
3409,
11347,
3103,
2536,
2913,
11,
198,
197,
1102,
2536,
391,
198,
197,
198,
198,
8818,
651,
62,
43337,
7,
14795,
3712,
23839,
3118,
39239,
11395,
8,
198,
197,
11246,
62,
39873,
796,
581,
1403,
7,
14795,
11,
33028,
8,
198,
197,
87,
1084,
796,
5288,
7,
11246,
62,
39873,
8,
1635,
657,
13,
5607,
198,
197,
87,
9806,
796,
5415,
7,
11246,
62,
39873,
8,
1635,
352,
13,
3070,
198,
197,
9662,
796,
357,
87,
9806,
12,
87,
1084,
20679,
6200,
198,
197,
87,
12786,
796,
2124,
1084,
25,
9662,
25,
87,
9806,
10,
9662,
198,
197,
43337,
796,
37124,
12195,
14795,
13,
17080,
3890,
11,
2124,
12786,
8,
628,
197,
87,
12786,
11,
12109,
24457,
2160,
7,
43337,
8,
198,
437,
198,
198,
8818,
651,
62,
43337,
7,
14795,
3712,
3118,
39239,
3351,
282,
283,
33,
259,
49070,
20344,
6169,
8,
198,
197,
11246,
62,
39873,
796,
581,
1403,
7,
14795,
11,
33028,
8,
198,
197,
87,
1084,
796,
5288,
7,
11246,
62,
39873,
8,
198,
197,
87,
9806,
796,
5415,
7,
11246,
62,
39873,
8,
628,
197,
87,
12786,
796,
2124,
1084,
25,
16,
25,
87,
9806,
198,
197,
43337,
796,
37124,
12195,
14795,
13,
17080,
3890,
11,
2124,
12786,
8,
628,
197,
87,
12786,
11,
12109,
24457,
2160,
7,
43337,
8,
198,
437,
198,
198,
8818,
651,
62,
43337,
7,
14795,
3712,
3118,
39239,
3351,
282,
283,
43303,
33,
259,
49070,
20344,
6169,
8,
198,
197,
11246,
62,
39873,
796,
581,
1403,
7,
14795,
11,
33028,
8,
198,
197,
87,
1084,
796,
5288,
7,
11246,
62,
39873,
8,
198,
197,
87,
9806,
796,
5415,
7,
11246,
62,
39873,
8,
628,
197,
87,
12786,
796,
2124,
1084,
25,
16,
25,
87,
9806,
198,
197,
43337,
796,
37124,
12195,
14795,
13,
17080,
3890,
11,
2124,
12786,
8,
628,
197,
87,
12786,
11,
12109,
24457,
2160,
7,
43337,
8,
198,
437,
628,
198,
31,
29102,
431,
2163,
7110,
62,
1169,
9997,
605,
7,
14795,
3712,
464,
9997,
605,
20344,
3890,
3351,
282,
283,
11395,
11,
198,
197,
197,
43337,
796,
2081,
11,
299,
62,
82,
12629,
796,
8576,
8,
628,
197,
361,
12109,
198,
197,
197,
31,
25076,
2221,
198,
197,
197,
197,
1136,
62,
43337,
7,
14795,
8,
198,
197,
197,
437,
198,
197,
17772,
198,
197,
197,
31,
25076,
2221,
198,
197,
197,
197,
18242,
14610,
13538,
198,
197,
197,
197,
411,
1403,
7,
14795,
11,
299,
62,
82,
12629,
8,
198,
197,
197,
437,
198,
197,
437,
198,
437,
628,
198,
31,
29102,
431,
2163,
7110,
62,
1169,
9997,
605,
7,
14795,
3712,
464,
9997,
605,
20344,
3890,
3351,
282,
283,
11395,
11,
220,
198,
197,
1102,
2536,
2913,
3712,
16305,
11347,
3103,
2536,
2913,
11,
12109,
796,
2081,
11,
299,
62,
82,
12629,
796,
8576,
8,
198,
197,
66,
14795,
796,
1500,
3201,
7,
14795,
11,
32315,
8,
628,
197,
361,
12109,
198,
197,
197,
31,
25076,
2221,
198,
197,
197,
197,
1136,
62,
43337,
7,
66,
14795,
8,
198,
197,
197,
437,
198,
197,
17772,
198,
197,
197,
31,
25076,
2221,
198,
197,
197,
197,
18242,
14610,
13538,
198,
197,
197,
197,
411,
1403,
7,
66,
14795,
11,
299,
62,
82,
12629,
8,
198,
197,
197,
437,
198,
197,
437,
198,
437,
198
] | 2.710611 | 622 |